 |
LAPACK
3.9.0
LAPACK: Linear Algebra PACKage
|
|
subroutine | sgeqpf (M, N, A, LDA, JPVT, TAU, WORK, INFO) |
| SGEQPF More...
|
|
subroutine | sgebak (JOB, SIDE, N, ILO, IHI, SCALE, M, V, LDV, INFO) |
| SGEBAK More...
|
|
subroutine | sgebal (JOB, N, A, LDA, ILO, IHI, SCALE, INFO) |
| SGEBAL More...
|
|
subroutine | sgebd2 (M, N, A, LDA, D, E, TAUQ, TAUP, WORK, INFO) |
| SGEBD2 reduces a general matrix to bidiagonal form using an unblocked algorithm. More...
|
|
subroutine | sgebrd (M, N, A, LDA, D, E, TAUQ, TAUP, WORK, LWORK, INFO) |
| SGEBRD More...
|
|
subroutine | sgecon (NORM, N, A, LDA, ANORM, RCOND, WORK, IWORK, INFO) |
| SGECON More...
|
|
subroutine | sgeequ (M, N, A, LDA, R, C, ROWCND, COLCND, AMAX, INFO) |
| SGEEQU More...
|
|
subroutine | sgeequb (M, N, A, LDA, R, C, ROWCND, COLCND, AMAX, INFO) |
| SGEEQUB More...
|
|
subroutine | sgehd2 (N, ILO, IHI, A, LDA, TAU, WORK, INFO) |
| SGEHD2 reduces a general square matrix to upper Hessenberg form using an unblocked algorithm. More...
|
|
subroutine | sgehrd (N, ILO, IHI, A, LDA, TAU, WORK, LWORK, INFO) |
| SGEHRD More...
|
|
subroutine | sgelq2 (M, N, A, LDA, TAU, WORK, INFO) |
| SGELQ2 computes the LQ factorization of a general rectangular matrix using an unblocked algorithm. More...
|
|
subroutine | sgelqf (M, N, A, LDA, TAU, WORK, LWORK, INFO) |
| SGELQF More...
|
|
subroutine | sgemqrt (SIDE, TRANS, M, N, K, NB, V, LDV, T, LDT, C, LDC, WORK, INFO) |
| SGEMQRT More...
|
|
subroutine | sgeql2 (M, N, A, LDA, TAU, WORK, INFO) |
| SGEQL2 computes the QL factorization of a general rectangular matrix using an unblocked algorithm. More...
|
|
subroutine | sgeqlf (M, N, A, LDA, TAU, WORK, LWORK, INFO) |
| SGEQLF More...
|
|
subroutine | sgeqp3 (M, N, A, LDA, JPVT, TAU, WORK, LWORK, INFO) |
| SGEQP3 More...
|
|
subroutine | sgeqr2 (M, N, A, LDA, TAU, WORK, INFO) |
| SGEQR2 computes the QR factorization of a general rectangular matrix using an unblocked algorithm. More...
|
|
subroutine | sgeqr2p (M, N, A, LDA, TAU, WORK, INFO) |
| SGEQR2P computes the QR factorization of a general rectangular matrix with non-negative diagonal elements using an unblocked algorithm. More...
|
|
subroutine | sgeqrf (M, N, A, LDA, TAU, WORK, LWORK, INFO) |
| SGEQRF More...
|
|
subroutine | sgeqrfp (M, N, A, LDA, TAU, WORK, LWORK, INFO) |
| SGEQRFP More...
|
|
subroutine | sgeqrt (M, N, NB, A, LDA, T, LDT, WORK, INFO) |
| SGEQRT More...
|
|
subroutine | sgeqrt2 (M, N, A, LDA, T, LDT, INFO) |
| SGEQRT2 computes a QR factorization of a general real or complex matrix using the compact WY representation of Q. More...
|
|
recursive subroutine | sgeqrt3 (M, N, A, LDA, T, LDT, INFO) |
| SGEQRT3 recursively computes a QR factorization of a general real or complex matrix using the compact WY representation of Q. More...
|
|
subroutine | sgerfs (TRANS, N, NRHS, A, LDA, AF, LDAF, IPIV, B, LDB, X, LDX, FERR, BERR, WORK, IWORK, INFO) |
| SGERFS More...
|
|
subroutine | sgerfsx (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, IWORK, INFO) |
| SGERFSX More...
|
|
subroutine | sgerq2 (M, N, A, LDA, TAU, WORK, INFO) |
| SGERQ2 computes the RQ factorization of a general rectangular matrix using an unblocked algorithm. More...
|
|
subroutine | sgerqf (M, N, A, LDA, TAU, WORK, LWORK, INFO) |
| SGERQF More...
|
|
subroutine | sgesvj (JOBA, JOBU, JOBV, M, N, A, LDA, SVA, MV, V, LDV, WORK, LWORK, INFO) |
| SGESVJ More...
|
|
subroutine | sgetf2 (M, N, A, LDA, IPIV, INFO) |
| SGETF2 computes the LU factorization of a general m-by-n matrix using partial pivoting with row interchanges (unblocked algorithm). More...
|
|
subroutine | sgetrf (M, N, A, LDA, IPIV, INFO) |
| SGETRF More...
|
|
recursive subroutine | sgetrf2 (M, N, A, LDA, IPIV, INFO) |
| SGETRF2 More...
|
|
subroutine | sgetri (N, A, LDA, IPIV, WORK, LWORK, INFO) |
| SGETRI More...
|
|
subroutine | sgetrs (TRANS, N, NRHS, A, LDA, IPIV, B, LDB, INFO) |
| SGETRS More...
|
|
subroutine | shgeqz (JOB, COMPQ, COMPZ, N, ILO, IHI, H, LDH, T, LDT, ALPHAR, ALPHAI, BETA, Q, LDQ, Z, LDZ, WORK, LWORK, INFO) |
| SHGEQZ More...
|
|
subroutine | sla_geamv (TRANS, M, N, ALPHA, A, LDA, X, INCX, BETA, Y, INCY) |
| SLA_GEAMV computes a matrix-vector product using a general matrix to calculate error bounds. More...
|
|
real function | sla_gercond (TRANS, N, A, LDA, AF, LDAF, IPIV, CMODE, C, INFO, WORK, IWORK) |
| SLA_GERCOND estimates the Skeel condition number for a general matrix. More...
|
|
subroutine | sla_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) |
| SLA_GERFSX_EXTENDED improves the computed solution to a system of linear equations for general matrices by performing extra-precise iterative refinement and provides error bounds and backward error estimates for the solution. More...
|
|
real function | sla_gerpvgrw (N, NCOLS, A, LDA, AF, LDAF) |
| SLA_GERPVGRW More...
|
|
subroutine | slaorhr_col_getrfnp (M, N, A, LDA, D, INFO) |
| SLAORHR_COL_GETRFNP More...
|
|
recursive subroutine | slaorhr_col_getrfnp2 (M, N, A, LDA, D, INFO) |
| SLAORHR_COL_GETRFNP2 More...
|
|
subroutine | stgevc (SIDE, HOWMNY, SELECT, N, S, LDS, P, LDP, VL, LDVL, VR, LDVR, MM, M, WORK, INFO) |
| STGEVC More...
|
|
subroutine | stgexc (WANTQ, WANTZ, N, A, LDA, B, LDB, Q, LDQ, Z, LDZ, IFST, ILST, WORK, LWORK, INFO) |
| STGEXC More...
|
|
This is the group of real computational functions for GE matrices
subroutine slarfb(SIDE, TRANS, DIRECT, STOREV, M, N, K, V, LDV, T, LDT, C, LDC, WORK, LDWORK)
SLARFB applies a block reflector or its transpose to a general rectangular matrix.
real function snrm2(N, X, INCX)
SNRM2
subroutine strmm(SIDE, UPLO, TRANSA, DIAG, M, N, ALPHA, A, LDA, B, LDB)
STRMM
subroutine strmv(UPLO, TRANS, DIAG, N, A, LDA, X, INCX)
STRMV
subroutine slacn2(N, V, X, ISGN, EST, KASE, ISAVE)
SLACN2 estimates the 1-norm of a square matrix, using reverse communication for evaluating matrix-vec...
subroutine slaqps(M, N, OFFSET, NB, KB, A, LDA, JPVT, TAU, VN1, VN2, AUXV, F, LDF)
SLAQPS computes a step of QR factorization with column pivoting of a real m-by-n matrix A by using BL...
subroutine slabad(SMALL, LARGE)
SLABAD
real function sla_gercond(TRANS, N, A, LDA, AF, LDAF, IPIV, CMODE, C, INFO, WORK, IWORK)
SLA_GERCOND estimates the Skeel condition number for a general matrix.
subroutine slahr2(N, K, NB, A, LDA, TAU, T, LDT, Y, LDY)
SLAHR2 reduces the specified number of first columns of a general rectangular matrix A so that elemen...
integer function ilaprec(PREC)
ILAPREC
subroutine sgeqrt2(M, N, A, LDA, T, LDT, INFO)
SGEQRT2 computes a QR factorization of a general real or complex matrix using the compact WY represen...
subroutine slarft(DIRECT, STOREV, N, K, V, LDV, TAU, T, LDT)
SLARFT forms the triangular factor T of a block reflector H = I - vtvH
subroutine sgehd2(N, ILO, IHI, A, LDA, TAU, WORK, INFO)
SGEHD2 reduces a general square matrix to upper Hessenberg form using an unblocked algorithm.
subroutine sgetrs(TRANS, N, NRHS, A, LDA, IPIV, B, LDB, INFO)
SGETRS
subroutine srscl(N, SA, SX, INCX)
SRSCL multiplies a vector by the reciprocal of a real scalar.
subroutine sswap(N, SX, INCX, SY, INCY)
SSWAP
subroutine sgeqr2(M, N, A, LDA, TAU, WORK, INFO)
SGEQR2 computes the QR factorization of a general rectangular matrix using an unblocked algorithm.
subroutine sormqr(SIDE, TRANS, M, N, K, A, LDA, TAU, C, LDC, WORK, LWORK, INFO)
SORMQR
subroutine sla_geamv(TRANS, M, N, ALPHA, A, LDA, X, INCX, BETA, Y, INCY)
SLA_GEAMV computes a matrix-vector product using a general matrix to calculate error bounds.
real function slapy3(X, Y, Z)
SLAPY3 returns sqrt(x2+y2+z2).
subroutine srotm(N, SX, INCX, SY, INCY, SPARAM)
SROTM
subroutine slaqp2(M, N, OFFSET, A, LDA, JPVT, TAU, VN1, VN2, WORK)
SLAQP2 computes a QR factorization with column pivoting of the matrix block.
subroutine sgecon(NORM, N, A, LDA, ANORM, RCOND, WORK, IWORK, INFO)
SGECON
subroutine strtri(UPLO, DIAG, N, A, LDA, INFO)
STRTRI
subroutine stgex2(WANTQ, WANTZ, N, A, LDA, B, LDB, Q, LDQ, Z, LDZ, J1, N1, N2, WORK, LWORK, INFO)
STGEX2 swaps adjacent diagonal blocks in an upper (quasi) triangular matrix pair by an orthogonal equ...
subroutine slaln2(LTRANS, NA, NW, SMIN, CA, A, LDA, D1, D2, B, LDB, WR, WI, X, LDX, SCALE, XNORM, INFO)
SLALN2 solves a 1-by-1 or 2-by-2 linear system of equations of the specified form.
subroutine sgemm(TRANSA, TRANSB, M, N, K, ALPHA, A, LDA, B, LDB, BETA, C, LDC)
SGEMM
subroutine slabrd(M, N, NB, A, LDA, D, E, TAUQ, TAUP, X, LDX, Y, LDY)
SLABRD reduces the first nb rows and columns of a general matrix to a bidiagonal form.
integer function isamax(N, SX, INCX)
ISAMAX
subroutine sgeql2(M, N, A, LDA, TAU, WORK, INFO)
SGEQL2 computes the QL factorization of a general rectangular matrix using an unblocked algorithm.
integer function ilatrans(TRANS)
ILATRANS
subroutine srot(N, SX, INCX, SY, INCY, C, S)
SROT
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.
subroutine sgemv(TRANS, M, N, ALPHA, A, LDA, X, INCX, BETA, Y, INCY)
SGEMV
subroutine slacpy(UPLO, M, N, A, LDA, B, LDB)
SLACPY copies all or part of one two-dimensional array to another.
subroutine slassq(N, X, INCX, SCALE, SUMSQ)
SLASSQ updates a sum of squares represented in scaled form.
real function slange(NORM, M, N, A, LDA, WORK)
SLANGE returns the value of the 1-norm, Frobenius norm, infinity-norm, or the largest absolute value ...
logical function sisnan(SIN)
SISNAN tests input for NaN.
subroutine slarfg(N, ALPHA, X, INCX, TAU)
SLARFG generates an elementary reflector (Householder matrix).
recursive subroutine slaorhr_col_getrfnp2(M, N, A, LDA, D, INFO)
SLAORHR_COL_GETRFNP2
subroutine sgebd2(M, N, A, LDA, D, E, TAUQ, TAUP, WORK, INFO)
SGEBD2 reduces a general matrix to bidiagonal form using an unblocked algorithm.
subroutine scopy(N, SX, INCX, SY, INCY)
SCOPY
subroutine sla_wwaddw(N, X, Y, W)
SLA_WWADDW adds a vector into a doubled-single vector.
subroutine sgeqr2p(M, N, A, LDA, TAU, WORK, INFO)
SGEQR2P computes the QR factorization of a general rectangular matrix with non-negative diagonal elem...
subroutine sscal(N, SA, SX, INCX)
SSCAL
recursive subroutine sgeqrt3(M, N, A, LDA, T, LDT, INFO)
SGEQRT3 recursively computes a QR factorization of a general real or complex matrix using the compact...
subroutine slaswp(N, A, LDA, K1, K2, IPIV, INCX)
SLASWP performs a series of row interchanges on a general rectangular matrix.
subroutine xerbla(SRNAME, INFO)
XERBLA
real function sdot(N, SX, INCX, SY, INCY)
SDOT
subroutine sgeqrf(M, N, A, LDA, TAU, WORK, LWORK, INFO)
SGEQRF
subroutine strsm(SIDE, UPLO, TRANSA, DIAG, M, N, ALPHA, A, LDA, B, LDB)
STRSM
logical function lsame(CA, CB)
LSAME
real function slapy2(X, Y)
SLAPY2 returns sqrt(x2+y2).
recursive subroutine sgetrf2(M, N, A, LDA, IPIV, INFO)
SGETRF2
subroutine slaset(UPLO, M, N, ALPHA, BETA, A, LDA)
SLASET initializes the off-diagonal elements and the diagonal elements of a matrix to given values.
subroutine sgsvj1(JOBV, M, N, N1, A, LDA, D, SVA, MV, V, LDV, EPS, SFMIN, TOL, NSWEEP, WORK, LWORK, INFO)
SGSVJ1 pre-processor for the routine sgesvj, applies Jacobi rotations targeting only particular pivot...
subroutine slarfgp(N, ALPHA, X, INCX, TAU)
SLARFGP generates an elementary reflector (Householder matrix) with non-negative beta.
real function slamch(CMACH)
SLAMCH
subroutine slasv2(F, G, H, SSMIN, SSMAX, SNR, CSR, SNL, CSL)
SLASV2 computes the singular value decomposition of a 2-by-2 triangular matrix.
subroutine sorm2r(SIDE, TRANS, M, N, K, A, LDA, TAU, C, LDC, WORK, INFO)
SORM2R multiplies a general matrix by the orthogonal matrix from a QR factorization determined by sge...
subroutine slatrs(UPLO, TRANS, DIAG, NORMIN, N, A, LDA, X, SCALE, CNORM, INFO)
SLATRS solves a triangular system of equations with the scale factor set to prevent overflow.
subroutine sger(M, N, ALPHA, X, INCX, Y, INCY, A, LDA)
SGER
subroutine sla_lin_berr(N, NZ, NRHS, RES, AYB, BERR)
SLA_LIN_BERR computes a component-wise relative backward error.
subroutine sla_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)
SLA_GERFSX_EXTENDED improves the computed solution to a system of linear equations for general matric...
real function sla_gerpvgrw(N, NCOLS, A, LDA, AF, LDAF)
SLA_GERPVGRW
subroutine slarf(SIDE, M, N, V, INCV, TAU, C, LDC, WORK)
SLARF applies an elementary reflector to a general rectangular matrix.
subroutine slartg(F, G, CS, SN, R)
SLARTG generates a plane rotation with real cosine and real sine.
integer function ilaenv(ISPEC, NAME, OPTS, N1, N2, N3, N4)
ILAENV
subroutine slag2(A, LDA, B, LDB, SAFMIN, SCALE1, SCALE2, WR1, WR2, WI)
SLAG2 computes the eigenvalues of a 2-by-2 generalized eigenvalue problem, with scaling as necessary ...
subroutine sgelq2(M, N, A, LDA, TAU, WORK, INFO)
SGELQ2 computes the LQ factorization of a general rectangular matrix using an unblocked algorithm.
real function slanhs(NORM, N, A, LDA, WORK)
SLANHS returns the value of the 1-norm, Frobenius norm, infinity-norm, or the largest absolute value ...
subroutine sgsvj0(JOBV, M, N, A, LDA, D, SVA, MV, V, LDV, EPS, SFMIN, TOL, NSWEEP, WORK, LWORK, INFO)
SGSVJ0 pre-processor for the routine sgesvj.
subroutine sgerq2(M, N, A, LDA, TAU, WORK, INFO)
SGERQ2 computes the RQ factorization of a general rectangular matrix using an unblocked algorithm.
character *1 function chla_transtype(TRANS)
CHLA_TRANSTYPE
subroutine saxpy(N, SA, SX, INCX, SY, INCY)
SAXPY