 |
LAPACK
3.9.0
LAPACK: Linear Algebra PACKage
|
|
subroutine | cgebak (JOB, SIDE, N, ILO, IHI, SCALE, M, V, LDV, INFO) |
| CGEBAK More...
|
|
subroutine | cgebal (JOB, N, A, LDA, ILO, IHI, SCALE, INFO) |
| CGEBAL More...
|
|
subroutine | cgebd2 (M, N, A, LDA, D, E, TAUQ, TAUP, WORK, INFO) |
| CGEBD2 reduces a general matrix to bidiagonal form using an unblocked algorithm. More...
|
|
subroutine | cgebrd (M, N, A, LDA, D, E, TAUQ, TAUP, WORK, LWORK, INFO) |
| CGEBRD More...
|
|
subroutine | cgecon (NORM, N, A, LDA, ANORM, RCOND, WORK, RWORK, INFO) |
| CGECON More...
|
|
subroutine | cgeequ (M, N, A, LDA, R, C, ROWCND, COLCND, AMAX, INFO) |
| CGEEQU More...
|
|
subroutine | cgeequb (M, N, A, LDA, R, C, ROWCND, COLCND, AMAX, INFO) |
| CGEEQUB More...
|
|
subroutine | cgehd2 (N, ILO, IHI, A, LDA, TAU, WORK, INFO) |
| CGEHD2 reduces a general square matrix to upper Hessenberg form using an unblocked algorithm. More...
|
|
subroutine | cgehrd (N, ILO, IHI, A, LDA, TAU, WORK, LWORK, INFO) |
| CGEHRD More...
|
|
subroutine | cgelq2 (M, N, A, LDA, TAU, WORK, INFO) |
| CGELQ2 computes the LQ factorization of a general rectangular matrix using an unblocked algorithm. More...
|
|
subroutine | cgelqf (M, N, A, LDA, TAU, WORK, LWORK, INFO) |
| CGELQF More...
|
|
subroutine | cgemqrt (SIDE, TRANS, M, N, K, NB, V, LDV, T, LDT, C, LDC, WORK, INFO) |
| CGEMQRT More...
|
|
subroutine | cgeql2 (M, N, A, LDA, TAU, WORK, INFO) |
| CGEQL2 computes the QL factorization of a general rectangular matrix using an unblocked algorithm. More...
|
|
subroutine | cgeqlf (M, N, A, LDA, TAU, WORK, LWORK, INFO) |
| CGEQLF More...
|
|
subroutine | cgeqp3 (M, N, A, LDA, JPVT, TAU, WORK, LWORK, RWORK, INFO) |
| CGEQP3 More...
|
|
subroutine | cgeqr2 (M, N, A, LDA, TAU, WORK, INFO) |
| CGEQR2 computes the QR factorization of a general rectangular matrix using an unblocked algorithm. More...
|
|
subroutine | cgeqr2p (M, N, A, LDA, TAU, WORK, INFO) |
| CGEQR2P computes the QR factorization of a general rectangular matrix with non-negative diagonal elements using an unblocked algorithm. More...
|
|
subroutine | cgeqrf (M, N, A, LDA, TAU, WORK, LWORK, INFO) |
| CGEQRF More...
|
|
subroutine | cgeqrfp (M, N, A, LDA, TAU, WORK, LWORK, INFO) |
| CGEQRFP More...
|
|
subroutine | cgeqrt (M, N, NB, A, LDA, T, LDT, WORK, INFO) |
| CGEQRT More...
|
|
subroutine | cgeqrt2 (M, N, A, LDA, T, LDT, INFO) |
| CGEQRT2 computes a QR factorization of a general real or complex matrix using the compact WY representation of Q. More...
|
|
recursive subroutine | cgeqrt3 (M, N, A, LDA, T, LDT, INFO) |
| CGEQRT3 recursively computes a QR factorization of a general real or complex matrix using the compact WY representation of Q. More...
|
|
subroutine | cgerfs (TRANS, N, NRHS, A, LDA, AF, LDAF, IPIV, B, LDB, X, LDX, FERR, BERR, WORK, RWORK, INFO) |
| CGERFS More...
|
|
subroutine | cgerfsx (TRANS, EQUED, N, NRHS, A, LDA, AF, LDAF, IPIV, R, C, B, LDB, X, LDX, RCOND, BERR, N_ERR_BNDS, ERR_BNDS_NORM, ERR_BNDS_COMP, NPARAMS, PARAMS, WORK, RWORK, INFO) |
| CGERFSX More...
|
|
subroutine | cgerq2 (M, N, A, LDA, TAU, WORK, INFO) |
| CGERQ2 computes the RQ factorization of a general rectangular matrix using an unblocked algorithm. More...
|
|
subroutine | cgerqf (M, N, A, LDA, TAU, WORK, LWORK, INFO) |
| CGERQF More...
|
|
subroutine | cgesvj (JOBA, JOBU, JOBV, M, N, A, LDA, SVA, MV, V, LDV, CWORK, LWORK, RWORK, LRWORK, INFO) |
| CGESVJ More...
|
|
subroutine | cgetf2 (M, N, A, LDA, IPIV, INFO) |
| CGETF2 computes the LU factorization of a general m-by-n matrix using partial pivoting with row interchanges (unblocked algorithm). More...
|
|
subroutine | cgetrf (M, N, A, LDA, IPIV, INFO) |
| CGETRF More...
|
|
recursive subroutine | cgetrf2 (M, N, A, LDA, IPIV, INFO) |
| CGETRF2 More...
|
|
subroutine | cgetri (N, A, LDA, IPIV, WORK, LWORK, INFO) |
| CGETRI More...
|
|
subroutine | cgetrs (TRANS, N, NRHS, A, LDA, IPIV, B, LDB, INFO) |
| CGETRS More...
|
|
subroutine | chgeqz (JOB, COMPQ, COMPZ, N, ILO, IHI, H, LDH, T, LDT, ALPHA, BETA, Q, LDQ, Z, LDZ, WORK, LWORK, RWORK, INFO) |
| CHGEQZ More...
|
|
subroutine | cla_geamv (TRANS, M, N, ALPHA, A, LDA, X, INCX, BETA, Y, INCY) |
| CLA_GEAMV computes a matrix-vector product using a general matrix to calculate error bounds. More...
|
|
real function | cla_gercond_c (TRANS, N, A, LDA, AF, LDAF, IPIV, C, CAPPLY, INFO, WORK, RWORK) |
| CLA_GERCOND_C computes the infinity norm condition number of op(A)*inv(diag(c)) for general matrices. More...
|
|
real function | cla_gercond_x (TRANS, N, A, LDA, AF, LDAF, IPIV, X, INFO, WORK, RWORK) |
| CLA_GERCOND_X computes the infinity norm condition number of op(A)*diag(x) for general matrices. More...
|
|
subroutine | cla_gerfsx_extended (PREC_TYPE, TRANS_TYPE, N, NRHS, A, LDA, AF, LDAF, IPIV, COLEQU, C, B, LDB, Y, LDY, BERR_OUT, N_NORMS, ERRS_N, ERRS_C, RES, AYB, DY, Y_TAIL, RCOND, ITHRESH, RTHRESH, DZ_UB, IGNORE_CWISE, INFO) |
| CLA_GERFSX_EXTENDED More...
|
|
real function | cla_gerpvgrw (N, NCOLS, A, LDA, AF, LDAF) |
| CLA_GERPVGRW multiplies a square real matrix by a complex matrix. More...
|
|
subroutine | claunhr_col_getrfnp (M, N, A, LDA, D, INFO) |
| CLAUNHR_COL_GETRFNP More...
|
|
recursive subroutine | claunhr_col_getrfnp2 (M, N, A, LDA, D, INFO) |
| CLAUNHR_COL_GETRFNP2 More...
|
|
subroutine | ctgevc (SIDE, HOWMNY, SELECT, N, S, LDS, P, LDP, VL, LDVL, VR, LDVR, MM, M, WORK, RWORK, INFO) |
| CTGEVC More...
|
|
subroutine | ctgexc (WANTQ, WANTZ, N, A, LDA, B, LDB, Q, LDQ, Z, LDZ, IFST, ILST, INFO) |
| CTGEXC More...
|
|
subroutine | cgeqpf (M, N, A, LDA, JPVT, TAU, WORK, RWORK, INFO) |
| CGEQPF More...
|
|
This is the group of complex computational functions for GE matrices
subroutine cgsvj0(JOBV, M, N, A, LDA, D, SVA, MV, V, LDV, EPS, SFMIN, TOL, NSWEEP, WORK, LWORK, INFO)
CGSVJ0 pre-processor for the routine cgesvj.
real function clanhs(NORM, N, A, LDA, WORK)
CLANHS returns the value of the 1-norm, Frobenius norm, infinity-norm, or the largest absolute value ...
real function clange(NORM, M, N, A, LDA, WORK)
CLANGE returns the value of the 1-norm, Frobenius norm, infinity-norm, or the largest absolute value ...
subroutine slabad(SMALL, LARGE)
SLABAD
subroutine clarfg(N, ALPHA, X, INCX, TAU)
CLARFG generates an elementary reflector (Householder matrix).
subroutine cgemm(TRANSA, TRANSB, M, N, K, ALPHA, A, LDA, B, LDB, BETA, C, LDC)
CGEMM
subroutine cgecon(NORM, N, A, LDA, ANORM, RCOND, WORK, RWORK, INFO)
CGECON
subroutine csscal(N, SA, CX, INCX)
CSSCAL
integer function ilaprec(PREC)
ILAPREC
subroutine cgeqrt2(M, N, A, LDA, T, LDT, INFO)
CGEQRT2 computes a QR factorization of a general real or complex matrix using the compact WY represen...
subroutine cla_geamv(TRANS, M, N, ALPHA, A, LDA, X, INCX, BETA, Y, INCY)
CLA_GEAMV computes a matrix-vector product using a general matrix to calculate error bounds.
subroutine ctrtri(UPLO, DIAG, N, A, LDA, INFO)
CTRTRI
subroutine ctgex2(WANTQ, WANTZ, N, A, LDA, B, LDB, Q, LDQ, Z, LDZ, J1, INFO)
CTGEX2 swaps adjacent diagonal blocks in an upper (quasi) triangular matrix pair by an unitary equiva...
recursive subroutine cgeqrt3(M, N, A, LDA, T, LDT, INFO)
CGEQRT3 recursively computes a QR factorization of a general real or complex matrix using the compact...
subroutine cgsvj1(JOBV, M, N, N1, A, LDA, D, SVA, MV, V, LDV, EPS, SFMIN, TOL, NSWEEP, WORK, LWORK, INFO)
CGSVJ1 pre-processor for the routine cgesvj, applies Jacobi rotations targeting only particular pivot...
subroutine cgerq2(M, N, A, LDA, TAU, WORK, INFO)
CGERQ2 computes the RQ factorization of a general rectangular matrix using an unblocked algorithm.
subroutine cunmqr(SIDE, TRANS, M, N, K, A, LDA, TAU, C, LDC, WORK, LWORK, INFO)
CUNMQR
subroutine cla_gerfsx_extended(PREC_TYPE, TRANS_TYPE, N, NRHS, A, LDA, AF, LDAF, IPIV, COLEQU, C, B, LDB, Y, LDY, BERR_OUT, N_NORMS, ERRS_N, ERRS_C, RES, AYB, DY, Y_TAIL, RCOND, ITHRESH, RTHRESH, DZ_UB, IGNORE_CWISE, INFO)
CLA_GERFSX_EXTENDED
real function scnrm2(N, X, INCX)
SCNRM2
subroutine cla_lin_berr(N, NZ, NRHS, RES, AYB, BERR)
CLA_LIN_BERR computes a component-wise relative backward error.
subroutine cgemv(TRANS, M, N, ALPHA, A, LDA, X, INCX, BETA, Y, INCY)
CGEMV
subroutine cgerc(M, N, ALPHA, X, INCX, Y, INCY, A, LDA)
CGERC
real function cla_gerpvgrw(N, NCOLS, A, LDA, AF, LDAF)
CLA_GERPVGRW multiplies a square real matrix by a complex matrix.
subroutine clarf(SIDE, M, N, V, INCV, TAU, C, LDC, WORK)
CLARF applies an elementary reflector to a general rectangular matrix.
subroutine ctrsm(SIDE, UPLO, TRANSA, DIAG, M, N, ALPHA, A, LDA, B, LDB)
CTRSM
subroutine claqps(M, N, OFFSET, NB, KB, A, LDA, JPVT, TAU, VN1, VN2, AUXV, F, LDF)
CLAQPS computes a step of QR factorization with column pivoting of a real m-by-n matrix A by using BL...
subroutine cgeql2(M, N, A, LDA, TAU, WORK, INFO)
CGEQL2 computes the QL factorization of a general rectangular matrix using an unblocked algorithm.
subroutine clacgv(N, X, INCX)
CLACGV conjugates a complex vector.
subroutine claswp(N, A, LDA, K1, K2, IPIV, INCX)
CLASWP performs a series of row interchanges on a general rectangular matrix.
subroutine classq(N, X, INCX, SCALE, SUMSQ)
CLASSQ updates a sum of squares represented in scaled form.
subroutine cgebd2(M, N, A, LDA, D, E, TAUQ, TAUP, WORK, INFO)
CGEBD2 reduces a general matrix to bidiagonal form using an unblocked algorithm.
integer function isamax(N, SX, INCX)
ISAMAX
integer function ilatrans(TRANS)
ILATRANS
subroutine cgehd2(N, ILO, IHI, A, LDA, TAU, WORK, INFO)
CGEHD2 reduces a general square matrix to upper Hessenberg form using an unblocked algorithm.
subroutine slascl(TYPE, KL, KU, CFROM, CTO, M, N, A, LDA, INFO)
SLASCL multiplies a general rectangular matrix by a real scalar defined as cto/cfrom.
complex function cdotc(N, CX, INCX, CY, INCY)
CDOTC
logical function sisnan(SIN)
SISNAN tests input for NaN.
subroutine clarfgp(N, ALPHA, X, INCX, TAU)
CLARFGP generates an elementary reflector (Householder matrix) with non-negative beta.
subroutine crot(N, CX, INCX, CY, INCY, C, S)
CROT applies a plane rotation with real cosine and complex sine to a pair of complex vectors.
subroutine clacn2(N, V, X, EST, KASE, ISAVE)
CLACN2 estimates the 1-norm of a square matrix, using reverse communication for evaluating matrix-vec...
subroutine csrscl(N, SA, SX, INCX)
CSRSCL multiplies a vector by the reciprocal of a real scalar.
subroutine cgetrs(TRANS, N, NRHS, A, LDA, IPIV, B, LDB, INFO)
CGETRS
subroutine claqp2(M, N, OFFSET, A, LDA, JPVT, TAU, VN1, VN2, WORK)
CLAQP2 computes a QR factorization with column pivoting of the matrix block.
subroutine ctrmv(UPLO, TRANS, DIAG, N, A, LDA, X, INCX)
CTRMV
subroutine cscal(N, CA, CX, INCX)
CSCAL
subroutine cgeqr2p(M, N, A, LDA, TAU, WORK, INFO)
CGEQR2P computes the QR factorization of a general rectangular matrix with non-negative diagonal elem...
recursive subroutine cgetrf2(M, N, A, LDA, IPIV, INFO)
CGETRF2
subroutine xerbla(SRNAME, INFO)
XERBLA
subroutine cswap(N, CX, INCX, CY, INCY)
CSWAP
logical function lsame(CA, CB)
LSAME
subroutine clarft(DIRECT, STOREV, N, K, V, LDV, TAU, T, LDT)
CLARFT forms the triangular factor T of a block reflector H = I - vtvH
subroutine claset(UPLO, M, N, ALPHA, BETA, A, LDA)
CLASET initializes the off-diagonal elements and the diagonal elements of a matrix to given values.
real function cla_gercond_c(TRANS, N, A, LDA, AF, LDAF, IPIV, C, CAPPLY, INFO, WORK, RWORK)
CLA_GERCOND_C computes the infinity norm condition number of op(A)*inv(diag(c)) for general matrices.
real function slamch(CMACH)
SLAMCH
subroutine cgelq2(M, N, A, LDA, TAU, WORK, INFO)
CGELQ2 computes the LQ factorization of a general rectangular matrix using an unblocked algorithm.
subroutine clarfb(SIDE, TRANS, DIRECT, STOREV, M, N, K, V, LDV, T, LDT, C, LDC, WORK, LDWORK)
CLARFB applies a block reflector or its conjugate-transpose to a general rectangular matrix.
subroutine cgeqr2(M, N, A, LDA, TAU, WORK, INFO)
CGEQR2 computes the QR factorization of a general rectangular matrix using an unblocked algorithm.
subroutine cgeqrf(M, N, A, LDA, TAU, WORK, LWORK, INFO)
CGEQRF
subroutine cunm2r(SIDE, TRANS, M, N, K, A, LDA, TAU, C, LDC, WORK, INFO)
CUNM2R multiplies a general matrix by the unitary matrix from a QR factorization determined by cgeqrf...
subroutine ctrmm(SIDE, UPLO, TRANSA, DIAG, M, N, ALPHA, A, LDA, B, LDB)
CTRMM
subroutine clabrd(M, N, NB, A, LDA, D, E, TAUQ, TAUP, X, LDX, Y, LDY)
CLABRD reduces the first nb rows and columns of a general matrix to a bidiagonal form.
subroutine ccopy(N, CX, INCX, CY, INCY)
CCOPY
subroutine clartg(F, G, CS, SN, R)
CLARTG generates a plane rotation with real cosine and complex sine.
integer function ilaenv(ISPEC, NAME, OPTS, N1, N2, N3, N4)
ILAENV
subroutine caxpy(N, CA, CX, INCX, CY, INCY)
CAXPY
subroutine clahr2(N, K, NB, A, LDA, TAU, T, LDT, Y, LDY)
CLAHR2 reduces the specified number of first columns of a general rectangular matrix A so that elemen...
recursive subroutine claunhr_col_getrfnp2(M, N, A, LDA, D, INFO)
CLAUNHR_COL_GETRFNP2
complex function cladiv(X, Y)
CLADIV performs complex division in real arithmetic, avoiding unnecessary overflow.
real function cla_gercond_x(TRANS, N, A, LDA, AF, LDAF, IPIV, X, INFO, WORK, RWORK)
CLA_GERCOND_X computes the infinity norm condition number of op(A)*diag(x) for general matrices.
subroutine cgeru(M, N, ALPHA, X, INCX, Y, INCY, A, LDA)
CGERU
subroutine clascl(TYPE, KL, KU, CFROM, CTO, M, N, A, LDA, INFO)
CLASCL multiplies a general rectangular matrix by a real scalar defined as cto/cfrom.
character *1 function chla_transtype(TRANS)
CHLA_TRANSTYPE
subroutine cla_wwaddw(N, X, Y, W)
CLA_WWADDW adds a vector into a doubled-single vector.
subroutine clatrs(UPLO, TRANS, DIAG, NORMIN, N, A, LDA, X, SCALE, CNORM, INFO)
CLATRS solves a triangular system of equations with the scale factor set to prevent overflow.
integer function icamax(N, CX, INCX)
ICAMAX