亚洲欧美第一页_禁久久精品乱码_粉嫩av一区二区三区免费野_久草精品视频

? 歡迎來(lái)到蟲蟲下載站! | ?? 資源下載 ?? 資源專輯 ?? 關(guān)于我們
? 蟲蟲下載站

?? ssyevx.c

?? NIST Handwriting OCR Testbed
?? C
字號(hào):
/** ======================================================================* NIST Guide to Available Math Software.* Fullsource for module SSYEVX.C from package CLAPACK.* Retrieved from NETLIB on Fri Mar 10 14:23:44 2000.* ======================================================================*/#include <f2c.h>/* Subroutine */ int ssyevx_(char *jobz, char *range, char *uplo, integer *n, 	real *a, integer *lda, real *vl, real *vu, integer *il, integer *iu, 	real *abstol, integer *m, real *w, real *z, integer *ldz, real *work, 	integer *lwork, integer *iwork, integer *ifail, integer *info){/*  -- LAPACK driver routine (version 2.0) --          Univ. of Tennessee, Univ. of California Berkeley, NAG Ltd.,          Courant Institute, Argonne National Lab, and Rice University          September 30, 1994       Purpose       =======       SSYEVX computes selected eigenvalues and, optionally, eigenvectors       of a real symmetric matrix A.  Eigenvalues and eigenvectors can be       selected by specifying either a range of values or a range of indices       for the desired eigenvalues.       Arguments       =========       JOBZ    (input) CHARACTER*1               = 'N':  Compute eigenvalues only;               = 'V':  Compute eigenvalues and eigenvectors.       RANGE   (input) CHARACTER*1               = 'A': all eigenvalues will be found.               = 'V': all eigenvalues in the half-open interval (VL,VU]                      will be found.               = 'I': the IL-th through IU-th eigenvalues will be found.       UPLO    (input) CHARACTER*1               = 'U':  Upper triangle of A is stored;               = 'L':  Lower triangle of A is stored.       N       (input) INTEGER               The order of the matrix A.  N >= 0.       A       (input/output) REAL array, dimension (LDA, N)               On entry, the symmetric matrix A.  If UPLO = 'U', the               leading N-by-N upper triangular part of A contains the               upper triangular part of the matrix A.  If UPLO = 'L',               the leading N-by-N lower triangular part of A contains               the lower triangular part of the matrix A.               On exit, the lower triangle (if UPLO='L') or the upper               triangle (if UPLO='U') of A, including the diagonal, is               destroyed.       LDA     (input) INTEGER               The leading dimension of the array A.  LDA >= max(1,N).       VL      (input) REAL       VU      (input) REAL               If RANGE='V', the lower and upper bounds of the interval to               be searched for eigenvalues. VL < VU.               Not referenced if RANGE = 'A' or 'I'.       IL      (input) INTEGER       IU      (input) INTEGER               If RANGE='I', the indices (in ascending order) of the               smallest and largest eigenvalues to be returned.               1 <= IL <= IU <= N, if N > 0; IL = 1 and IU = 0 if N = 0.               Not referenced if RANGE = 'A' or 'V'.       ABSTOL  (input) REAL               The absolute error tolerance for the eigenvalues.               An approximate eigenvalue is accepted as converged               when it is determined to lie in an interval [a,b]               of width less than or equal to                       ABSTOL + EPS *   max( |a|,|b| ) ,               where EPS is the machine precision.  If ABSTOL is less than               or equal to zero, then  EPS*|T|  will be used in its place,               where |T| is the 1-norm of the tridiagonal matrix obtained               by reducing A to tridiagonal form.               Eigenvalues will be computed most accurately when ABSTOL is               set to twice the underflow threshold 2*SLAMCH('S'), not zero.               If this routine returns with INFO>0, indicating that some               eigenvectors did not converge, try setting ABSTOL to               2*SLAMCH('S').               See "Computing Small Singular Values of Bidiagonal Matrices               with Guaranteed High Relative Accuracy," by Demmel and               Kahan, LAPACK Working Note #3.       M       (output) INTEGER               The total number of eigenvalues found.  0 <= M <= N.               If RANGE = 'A', M = N, and if RANGE = 'I', M = IU-IL+1.       W       (output) REAL array, dimension (N)               On normal exit, the first M elements contain the selected               eigenvalues in ascending order.       Z       (output) REAL array, dimension (LDZ, max(1,M))               If JOBZ = 'V', then if INFO = 0, the first M columns of Z               contain the orthonormal eigenvectors of the matrix A               corresponding to the selected eigenvalues, with the i-th               column of Z holding the eigenvector associated with W(i).               If an eigenvector fails to converge, then that column of Z               contains the latest approximation to the eigenvector, and the               index of the eigenvector is returned in IFAIL.               If JOBZ = 'N', then Z is not referenced.               Note: the user must ensure that at least max(1,M) columns are               supplied in the array Z; if RANGE = 'V', the exact value of M               is not known in advance and an upper bound must be used.       LDZ     (input) INTEGER               The leading dimension of the array Z.  LDZ >= 1, and if               JOBZ = 'V', LDZ >= max(1,N).       WORK    (workspace/output) REAL array, dimension (LWORK)               On exit, if INFO = 0, WORK(1) returns the optimal LWORK.       LWORK   (input) INTEGER               The length of the array WORK.  LWORK >= max(1,8*N).               For optimal efficiency, LWORK >= (NB+3)*N,               where NB is the blocksize for SSYTRD returned by ILAENV.       IWORK   (workspace) INTEGER array, dimension (5*N)       IFAIL   (output) INTEGER array, dimension (N)               If JOBZ = 'V', then if INFO = 0, the first M elements of               IFAIL are zero.  If INFO > 0, then IFAIL contains the               indices of the eigenvectors that failed to converge.               If JOBZ = 'N', then IFAIL is not referenced.       INFO    (output) INTEGER               = 0:  successful exit               < 0:  if INFO = -i, the i-th argument had an illegal value               > 0:  if INFO = i, then i eigenvectors failed to converge.                     Their indices are stored in array IFAIL.      =====================================================================          Test the input parameters.          Parameter adjustments          Function Body */    /* Table of constant values */    static integer c__1 = 1;        /* System generated locals */    integer a_dim1, a_offset, z_dim1, z_offset, i__1, i__2;    real r__1, r__2;    /* Builtin functions */    double sqrt(doublereal);    /* Local variables */    static integer indd, inde;    static real anrm;    static integer imax;    static real rmin, rmax;    static integer lopt, itmp1, i, j, indee;    static real sigma;    extern logical lsame_(char *, char *);    static integer iinfo;    extern /* Subroutine */ int sscal_(integer *, real *, real *, integer *);    static char order[1];    static logical lower;    extern /* Subroutine */ int scopy_(integer *, real *, integer *, real *, 	    integer *), sswap_(integer *, real *, integer *, real *, integer *	    );    static logical wantz;    static integer jj;    static logical alleig, indeig;    static integer iscale, indibl;    static logical valeig;    extern doublereal slamch_(char *);    static real safmin;    extern /* Subroutine */ int xerbla_(char *, integer *);    static real abstll, bignum;    static integer indtau, indisp, indiwo, indwkn;    extern /* Subroutine */ int slacpy_(char *, integer *, integer *, real *, 	    integer *, real *, integer *);    static integer indwrk;    extern /* Subroutine */ int sstein_(integer *, real *, real *, integer *, 	    real *, integer *, integer *, real *, integer *, real *, integer *	    , integer *, integer *), ssterf_(integer *, real *, real *, 	    integer *);    static integer llwrkn, llwork, nsplit;    static real smlnum;    extern doublereal slansy_(char *, char *, integer *, real *, integer *, 	    real *);    extern /* Subroutine */ int sstebz_(char *, char *, integer *, real *, 	    real *, integer *, integer *, real *, real *, real *, integer *, 	    integer *, real *, integer *, integer *, real *, integer *, 	    integer *), sorgtr_(char *, integer *, real *, 	    integer *, real *, real *, integer *, integer *), ssteqr_(	    char *, integer *, real *, real *, real *, integer *, real *, 	    integer *), sormtr_(char *, char *, char *, integer *, 	    integer *, real *, integer *, real *, real *, integer *, real *, 	    integer *, integer *), ssytrd_(char *, 	    integer *, real *, integer *, real *, real *, real *, real *, 	    integer *, integer *);    static real eps, vll, vuu, tmp1;#define W(I) w[(I)-1]#define WORK(I) work[(I)-1]#define IWORK(I) iwork[(I)-1]#define IFAIL(I) ifail[(I)-1]#define A(I,J) a[(I)-1 + ((J)-1)* ( *lda)]#define Z(I,J) z[(I)-1 + ((J)-1)* ( *ldz)]    lower = lsame_(uplo, "L");    wantz = lsame_(jobz, "V");    alleig = lsame_(range, "A");    valeig = lsame_(range, "V");    indeig = lsame_(range, "I");    *info = 0;    if (! (wantz || lsame_(jobz, "N"))) {	*info = -1;    } else if (! (alleig || valeig || indeig)) {	*info = -2;    } else if (! (lower || lsame_(uplo, "U"))) {	*info = -3;    } else if (*n < 0) {	*info = -4;    } else if (*lda < max(1,*n)) {	*info = -6;    } else if (valeig && *n > 0 && *vu <= *vl) {	*info = -8;    } else if (indeig && *il < 1) {	*info = -9;    } else if (indeig && (*iu < min(*n,*il) || *iu > *n)) {	*info = -10;    } else if (*ldz < 1 || wantz && *ldz < *n) {	*info = -15;    } else /* if(complicated condition) */ {/* Computing MAX */	i__1 = 1, i__2 = *n << 3;	if (*lwork < max(i__1,i__2)) {	    *info = -17;	}    }    if (*info != 0) {	i__1 = -(*info);	xerbla_("SSYEVX", &i__1);	return 0;    }/*     Quick return if possible */    *m = 0;    if (*n == 0) {	WORK(1) = 1.f;	return 0;    }    if (*n == 1) {	WORK(1) = 7.f;	if (alleig || indeig) {	    *m = 1;	    W(1) = A(1,1);	} else {	    if (*vl < A(1,1) && *vu >= A(1,1)) {		*m = 1;		W(1) = A(1,1);	    }	}	if (wantz) {	    Z(1,1) = 1.f;	}	return 0;    }/*     Get machine constants. */    safmin = slamch_("Safe minimum");    eps = slamch_("Precision");    smlnum = safmin / eps;    bignum = 1.f / smlnum;    rmin = sqrt(smlnum);/* Computing MIN */    r__1 = sqrt(bignum), r__2 = 1.f / sqrt(sqrt(safmin));    rmax = dmin(r__1,r__2);/*     Scale matrix to allowable range, if necessary. */    iscale = 0;    abstll = *abstol;    if (valeig) {	vll = *vl;	vuu = *vu;    }    anrm = slansy_("M", uplo, n, &A(1,1), lda, &WORK(1));    if (anrm > 0.f && anrm < rmin) {	iscale = 1;	sigma = rmin / anrm;    } else if (anrm > rmax) {	iscale = 1;	sigma = rmax / anrm;    }    if (iscale == 1) {	if (lower) {	    i__1 = *n;	    for (j = 1; j <= *n; ++j) {		i__2 = *n - j + 1;		sscal_(&i__2, &sigma, &A(j,j), &c__1);/* L10: */	    }	} else {	    i__1 = *n;	    for (j = 1; j <= *n; ++j) {		sscal_(&j, &sigma, &A(1,j), &c__1);/* L20: */	    }	}	if (*abstol > 0.f) {	    abstll = *abstol * sigma;	}	if (valeig) {	    vll = *vl * sigma;	    vuu = *vu * sigma;	}    }/*     Call SSYTRD to reduce symmetric matrix to tridiagonal form. */    indtau = 1;    inde = indtau + *n;    indd = inde + *n;    indwrk = indd + *n;    llwork = *lwork - indwrk + 1;    ssytrd_(uplo, n, &A(1,1), lda, &WORK(indd), &WORK(inde), &WORK(	    indtau), &WORK(indwrk), &llwork, &iinfo);    lopt = *n * 3 + WORK(indwrk);/*     If all eigenvalues are desired and ABSTOL is less than or equal to          zero, then call SSTERF or SORGTR and SSTEQR.  If this fails for          some eigenvalue, then try SSTEBZ. */    if ((alleig || indeig && *il == 1 && *iu == *n) && *abstol <= 0.f) {	scopy_(n, &WORK(indd), &c__1, &W(1), &c__1);	indee = indwrk + (*n << 1);	if (! wantz) {	    i__1 = *n - 1;	    scopy_(&i__1, &WORK(inde), &c__1, &WORK(indee), &c__1);	    ssterf_(n, &W(1), &WORK(indee), info);	} else {	    slacpy_("A", n, n, &A(1,1), lda, &Z(1,1), ldz);	    sorgtr_(uplo, n, &Z(1,1), ldz, &WORK(indtau), &WORK(indwrk), 		    &llwork, &iinfo);	    i__1 = *n - 1;	    scopy_(&i__1, &WORK(inde), &c__1, &WORK(indee), &c__1);	    ssteqr_(jobz, n, &W(1), &WORK(indee), &Z(1,1), ldz, &WORK(		    indwrk), info);	    if (*info == 0) {		i__1 = *n;		for (i = 1; i <= *n; ++i) {		    IFAIL(i) = 0;/* L30: */		}	    }	}	if (*info == 0) {	    *m = *n;	    goto L40;	}	*info = 0;    }/*     Otherwise, call SSTEBZ and, if eigenvectors are desired, SSTEIN. */    if (wantz) {	*(unsigned char *)order = 'B';    } else {	*(unsigned char *)order = 'E';    }    indibl = 1;    indisp = indibl + *n;    indiwo = indisp + *n;    sstebz_(range, order, n, &vll, &vuu, il, iu, &abstll, &WORK(indd), &WORK(	    inde), m, &nsplit, &W(1), &IWORK(indibl), &IWORK(indisp), &WORK(	    indwrk), &IWORK(indiwo), info);    if (wantz) {	sstein_(n, &WORK(indd), &WORK(inde), m, &W(1), &IWORK(indibl), &IWORK(		indisp), &Z(1,1), ldz, &WORK(indwrk), &IWORK(indiwo), &		IFAIL(1), info);/*        Apply orthogonal matrix used in reduction to tridiagonal             form to eigenvectors returned by SSTEIN. */	indwkn = inde;	llwrkn = *lwork - indwkn + 1;	sormtr_("L", uplo, "N", n, m, &A(1,1), lda, &WORK(indtau), &Z(1,1), ldz, &WORK(indwkn), &llwrkn, &iinfo);    }/*     If matrix was scaled, then rescale eigenvalues appropriately. */L40:    if (iscale == 1) {	if (*info == 0) {	    imax = *m;	} else {	    imax = *info - 1;	}	r__1 = 1.f / sigma;	sscal_(&imax, &r__1, &W(1), &c__1);    }/*     If eigenvalues are not in order, then sort them, along with          eigenvectors. */    if (wantz) {	i__1 = *m - 1;	for (j = 1; j <= *m-1; ++j) {	    i = 0;	    tmp1 = W(j);	    i__2 = *m;	    for (jj = j + 1; jj <= *m; ++jj) {		if (W(jj) < tmp1) {		    i = jj;		    tmp1 = W(jj);		}/* L50: */	    }	    if (i != 0) {		itmp1 = IWORK(indibl + i - 1);		W(i) = W(j);		IWORK(indibl + i - 1) = IWORK(indibl + j - 1);		W(j) = tmp1;		IWORK(indibl + j - 1) = itmp1;		sswap_(n, &Z(1,i), &c__1, &Z(1,j), &			c__1);		if (*info != 0) {		    itmp1 = IFAIL(i);		    IFAIL(i) = IFAIL(j);		    IFAIL(j) = itmp1;		}	    }/* L60: */	}    }/*     Set WORK(1) to optimal workspace size.      Computing MAX */    i__1 = *n * 7;    WORK(1) = (real) max(i__1,lopt);    return 0;/*     End of SSYEVX */} /* ssyevx_ */

?? 快捷鍵說(shuō)明

復(fù)制代碼 Ctrl + C
搜索代碼 Ctrl + F
全屏模式 F11
切換主題 Ctrl + Shift + D
顯示快捷鍵 ?
增大字號(hào) Ctrl + =
減小字號(hào) Ctrl + -
亚洲欧美第一页_禁久久精品乱码_粉嫩av一区二区三区免费野_久草精品视频
欧美一区2区视频在线观看| 性欧美大战久久久久久久久| 黄一区二区三区| 欧美r级在线观看| 经典三级视频一区| 中文无字幕一区二区三区| aaa欧美大片| 性欧美大战久久久久久久久| 日韩欧美国产小视频| 岛国一区二区在线观看| 国产精品传媒在线| 欧美亚洲国产bt| 麻豆国产一区二区| 17c精品麻豆一区二区免费| 欧美日本乱大交xxxxx| 麻豆精品在线看| 中文字幕中文字幕一区二区| 精品视频1区2区| 久久国产精品色婷婷| 国产精品伦理在线| 欧美偷拍一区二区| 国产在线视频一区二区| 中文字幕日本不卡| 欧美大片在线观看一区二区| 成人免费观看视频| 视频一区中文字幕国产| 国产精品卡一卡二卡三| 91精品在线麻豆| 成人一道本在线| 琪琪一区二区三区| 亚洲精品视频免费看| 日韩精品一区二区三区在线| 91网站在线播放| 国产尤物一区二区| 五月综合激情婷婷六月色窝| 国产欧美一区二区精品婷婷 | 欧美日韩dvd在线观看| 国产制服丝袜一区| 日韩精品免费专区| 亚洲桃色在线一区| 精品国产伦一区二区三区免费| 94-欧美-setu| 国产酒店精品激情| 蜜臀av一区二区在线免费观看| 中文字幕一区二区三| 337p日本欧洲亚洲大胆色噜噜| 欧美专区日韩专区| 97国产一区二区| 国产不卡视频在线观看| 久久精品国产精品亚洲精品| 香蕉久久夜色精品国产使用方法| 亚洲视频在线观看三级| 国产欧美精品区一区二区三区 | 欧美日精品一区视频| 国产精品一区二区久久不卡| 日韩黄色一级片| 亚洲国产欧美另类丝袜| 亚洲欧美一区二区三区久本道91 | 欧美精品一二三四| 在线一区二区三区四区| a美女胸又www黄视频久久| 韩国一区二区视频| 久久99精品久久久久| 青娱乐精品视频在线| 午夜激情一区二区三区| 亚洲国产日产av| 亚洲成av人综合在线观看| 亚洲乱码国产乱码精品精可以看| 国产精品私房写真福利视频| 国产日韩欧美一区二区三区乱码| 久久综合五月天婷婷伊人| 日韩一区二区中文字幕| 欧美一二三区在线| 欧美www视频| 2023国产一二三区日本精品2022| 日韩欧美国产系列| 久久中文字幕电影| 国产亚洲人成网站| 中文字幕精品三区| 自拍偷在线精品自拍偷无码专区| 国产精品日韩精品欧美在线| 中文字幕在线一区| 亚洲精品免费在线| 亚洲va韩国va欧美va| 亚洲成va人在线观看| 奇米888四色在线精品| 韩国精品免费视频| 成人性生交大片免费看视频在线 | 成人黄色免费短视频| 成人av电影在线| 日本久久一区二区| 欧美日本免费一区二区三区| 91精品国产综合久久久久久久| 精品理论电影在线| 中文字幕乱码亚洲精品一区| 亚洲黄色在线视频| 日本午夜精品视频在线观看| 国产乱人伦偷精品视频不卡| 91在线视频免费91| 欧美日韩一级黄| 精品免费视频一区二区| 欧美va日韩va| 国产精品色在线| 亚洲成a人在线观看| 精品一区二区在线看| 成人黄色大片在线观看| 欧美专区日韩专区| 26uuu欧美| 最近中文字幕一区二区三区| 天堂精品中文字幕在线| 丰满白嫩尤物一区二区| 欧美日韩一卡二卡三卡 | 99久久亚洲一区二区三区青草 | 日韩一区二区三区av| 久久久欧美精品sm网站| 亚洲女与黑人做爰| 极品少妇xxxx精品少妇偷拍| 色婷婷亚洲一区二区三区| 精品国产伦一区二区三区观看方式| 国产精品嫩草影院com| 日韩高清在线一区| a亚洲天堂av| 欧美精品一区二| 亚洲第一av色| 成+人+亚洲+综合天堂| 欧美一二区视频| 一区二区在线观看av| 国产精品一区二区果冻传媒| 欧美日韩亚洲综合| 最新国产精品久久精品| 久久99这里只有精品| 欧美日韩综合一区| 中文字幕一区二区在线播放| 六月丁香婷婷久久| 欧美无乱码久久久免费午夜一区 | 成人午夜视频福利| 日韩欧美色综合网站| 一区二区三国产精华液| 粉嫩绯色av一区二区在线观看| 91精品一区二区三区在线观看| 亚洲欧美欧美一区二区三区| 成人午夜免费电影| 精品国产乱码久久久久久影片| 亚洲国产一区视频| 色婷婷综合中文久久一本| 欧美国产激情二区三区| 国产一区二区三区四区五区入口| 欧美高清视频在线高清观看mv色露露十八 | 国产精品大尺度| 国产黄色精品视频| 欧美成人乱码一区二区三区| 亚欧色一区w666天堂| 在线观看欧美黄色| 亚洲影院免费观看| 91久久奴性调教| 亚洲免费在线观看视频| 99久久99精品久久久久久| 亚洲国产精品成人久久综合一区| 国产一区二区电影| 久久精品一区四区| 国产高清不卡二三区| 国产日韩欧美a| 国产精品亚洲第一| 中国色在线观看另类| 成人av网在线| 亚洲欧美偷拍卡通变态| 色婷婷av一区二区三区大白胸| 亚洲乱码日产精品bd| 色国产精品一区在线观看| 亚洲欧美日韩精品久久久久| 色天天综合久久久久综合片| 一区二区高清免费观看影视大全| 一本久久a久久免费精品不卡| 一区二区免费在线播放| 欧美三区在线视频| 蜜桃精品视频在线观看| 2020国产精品自拍| 成人性生交大片免费| 亚洲精品视频在线| 欧美一卡2卡3卡4卡| 激情亚洲综合在线| 亚洲国产精华液网站w| 色综合久久88色综合天天免费| 亚洲另类春色国产| 5月丁香婷婷综合| 国模大尺度一区二区三区| 国产精品乱人伦中文| 欧美亚洲高清一区二区三区不卡| 丝袜诱惑亚洲看片| 久久久99免费| 色婷婷激情一区二区三区| 天堂一区二区在线| 国产欧美精品一区二区色综合| 一本大道久久a久久综合婷婷| 日韩黄色在线观看| 国产精品女主播在线观看| 欧美视频你懂的| 国产一区二区精品在线观看| 亚洲欧美日韩在线| 欧美一区二区三区啪啪|