[ English | Japanese ]

LAPACK

Introduction

LAPACK (Linear Algebra PACKage) provides routines for solving systems of simultaneous linear equations, least-squares solutions of linear systems of equations, eigenvalue problems, and singular value problems. The associated matrix factorizations (LU, Cholesky, QR, SVD, Schur, generalized Schur) are also provided, as are related computations such as reordering of the Schur factorizations and estimating condition numbers. Dense and banded matrices are handled, but not general sparse matrices. In all areas, similar functionality is provided for real and complex matrices, in both single and double precision.

LAPACK supersedes LINPACK and EISPACK. The algorithms in LINPACK and EISPACK operate on rows and columns of matrices, and data reuse is low. This makes them inefficient, spending too much time moving data instead of doing useful floating-point calculations. LAPACK addresses this problem by reorganizing the algorithms to use block matrix operations, such as matrix multiplication, in the innermost loops. Whenever possible, LAPACK calls BLAS (usually Level 2 & Level 3) for maximum data reuse.

How to use LAPACK

Parallelism

Shared memory parallelism can be obtained on Vector Engine by linking to the OpenMP version of BLAS.

LAPACK Routine List

Simple Driver and Divide and Conquer Driver Subprograms

 ? indicates prefix which must be filled with a combination of:
S = REAL(kind=4), D = REAL(kind=8), C = COMPLEX(kind=4), Z = COMPLEX(kind=8)
NamePrefixes Description
S D C Z DS ZC Solves a general system of linear equations AX=B.
S D C Z Solves a general banded system of linear equations AX=B.
S D C Z Solves a general tridiagonal system of linear equations AX=B.
S D C Z DS ZC Solves a symmetric/Hermitian positive definite system of linear equations AX=B.
S D C Z Solves a symmetric/Hermitian positive definite system of linear equations AX=B, where A is held in packed storage.
S D C Z Solves a symmetric/Hermitian positive definite banded system of linear equations AX=B.
S D C Z Solves a symmetric/Hermitian positive definite tridiagonal system of linear equations AX=B.
S D C Z Solves a symmetric indefinite system of linear equations AX=B.
S D C Z Solves a symmetric indefinite system of linear equations AX=B, where A is held in packed storage.
S D C Z Computes the least squares solution to an over-determined system of linear equations, AX=B or AHX=B, or the minimum norm solution of an under-determined system, where A is a general rectangular matrix of full rank, using a QR or LQ factorization of A.
S D C Z Computes the least squares solution to an over-determined system of linear equations, AX=B or AHX=B, or the minimum norm solution of an under-determined system, using a divide and conquer method, where A is a general rectangular matrix of full rank, using a QR or LQ factorization of A.
S D C Z Solves the LSE (Constrained Linear Least Squares Problem) using the GRQ (Generalized RQ) factorization.
S D C Z Solves the GLM (Generalized Linear Regression Model) using the GQR (Generalized QR) factorization.
?SYEV
S D Computes all eigenvalues, and optionally, eigenvectors of a real symmetric matrix.
?SYEVD
S D Computes all eigenvalues, and optionally, eigenvectors of a real symmetric matrix. If eigenvectors are desired, it uses a divide and conquer algorithm.
?SPEV
S D Computes all eigenvalues, and optionally, eigenvectors of a real symmetric matrix in packed storage.
?SPEVD
S D Computes all eigenvalues, and optionally, eigenvectors of a real symmetric matrix in packed storage. If eigenvectors are desired, it uses a divide and conquer algorithm.
?SBEV
S D Computes all eigenvalues, and optionally, eigenvectors of a real symmetric band matrix.
?SBEVD
S D Computes all eigenvalues, and optionally, eigenvectors of a real symmetric band matrix. If eigenvectors are desired, it uses a divide and conquer algorithm.
?STEV
S D Computes all eigenvalues, and optionally, eigenvectors of a real symmetric tridiagonal matrix.
?STEVD
S D Computes all eigenvalues, and optionally, eigenvectors of a real symmetric tridiagonal matrix. If eigenvectors are desired, it uses a divide and conquer algorithm.
S D C Z Computes the eigenvalues and Schur factorization of a general matrix, and orders the factorization so that selected eigenvalues are at the top left of the Schur form.
S D C Z Computes the eigenvalues and left and right eigenvectors of a general matrix.
S D C Z Computes the singular value decomposition (SVD) of a general rectangular matrix.
S D C Z Computes the singular value decomposition (SVD) of a general rectangular matrix using divide-and-conquer.
S D C Z Computes an LU factorization of a general tridiagonal matrix, using partial pivoting with row interchanges.
?SYGV
S D Computes all eigenvalues and the eigenvectors of a generalized symmetric-definite generalized eigenproblem, Ax = λBx, ABx = λx, or BAx = λx.
?SYGVD
S D Computes all eigenvalues and the eigenvectors of a generalized symmetric-definite generalized eigenproblem, Ax=λBx, ABx=λx, or BAx=λx. If eigenvectors are desired, it uses a divide and conquer algorithm.
?SPGV
S D Computes all eigenvalues and eigenvectors of a generalized symmetric-definite generalized eigenproblem, Ax=λBx, ABx=λx, or BAx=λx, where A and B are in packed storage.
?SPGVD
S D Computes all eigenvalues and eigenvectors of a generalized symmetric-definite generalized eigenproblem, Ax=λBx, ABx=λx, or BAx=λx, where A and B are in packed storage. If eigenvectors are desired, it uses a divide and conquer algorithm.
?SBGV
S D Computes all the eigenvalues, and optionally, the eigenvectors of a real generalized symmetric-definite banded eigenproblem, of the form Ax=λBx. A and B are assumed to be symmetric and banded, and B is also positive definite.
?SBGVD
S D Computes all the eigenvalues and optionally, the eigenvectors of a real generalized symmetric-definite banded eigenproblem, of the form Ax=λBx. A and B are assumed to be symmetric and banded, and B is also positive definite. If eigenvectors are desired, it uses a divide and conquer algorithm.
S D C Z Computes the generalized eigenvalues, Schur form, and left and/or right Schur vectors for a pair of non-symmetric matrices.
S D C Z Computes the generalized eigenvalues, Schur form, and left and/or right Schur vectors for a pair of non-symmetric matrices.
S D C Z Computes the generalized eigenvalues, and left and/or right generalized eigenvectors for a pair of non-symmetric matrices.
S D C Z Computes the generalized eigenvalues, and left and/or right generalized eigenvectors for a pair of non-symmetric matrices.
S D C Z Computes the Generalized Singular Value Decomposition.
?HESV
C Z Solves a Hermitian indefinite system of linear equations AX=B.
?HPSV
C Z Solves a Hermitian indefinite system of linear equations AX=B, where A is held in packed storage.
?HEEV
C Z Computes all eigenvalues and, optionally, eigenvectors of a Hermitian matrix.
?HEEVD
C Z Computes all eigenvalues and, optionally, eigenvectors of a Hermitian matrix. If eigenvectors are desired, it uses a divide and conquer algorithm.
?HPEV
C Z Computes all eigenvalues and, optionally, eigenvectors of a Hermitian matrix in packed storage.
?HPEVD
C Z Computes all eigenvalues and, optionally, eigenvectors of a Hermitian matrix in packed storage. If eigenvectors are desired, it uses a divide and conquer algorithm.
?HBEV
C Z Computes all eigenvalues and, optionally, eigenvectors of a Hermitian band matrix.
?HBEVD
C Z Computes all eigenvalues and, optionally, eigenvectors of a Hermitian band matrix. If eigenvectors are desired, it uses a divide and conquer algorithm.
?HEGV
C Z Computes all eigenvalues and the eigenvectors of a generalized Hermitian-definite generalized eigenproblem, Ax=λBx, ABx=λx, or BAx=λx.
?HEGVD
C Z Computes all eigenvalues and the eigenvectors of a generalized Hermitian-definite generalized eigenproblem, Ax=λBx, ABx=λx, or BAx=λx. If eigenvectors are desired, it uses a divide and conquer algorithm.
?HPGV
C Z Computes all eigenvalues and eigenvectors of a generalized Hermitian-definite generalized eigenproblem, Ax=λBx, ABx=λx, or BAx=λx, where A and B are in packed storage.
?HPGVD
C Z Computes all eigenvalues and eigenvectors of a generalized Hermitian-definite generalized eigenproblem, Ax=λBx, ABx=λx, or BAx=λx, where A and B are in packed storage. If eigenvectors are desired, it uses a divide and conquer algorithm.
?HBGV
C Z Computes all the eigenvalues, and optionally, the eigenvectors of a complex generalized Hermitian-definite banded eigenproblem, of the form Ax=λBx. A and B are assumed to be Hermitian and banded, and B is also positive definite.
?HBGVD
C Z Computes all the eigenvalues, and optionally, the eigenvectors of a complex generalized Hermitian-definite banded eigenproblem, of the form Ax=λBx. A and B are assumed to be Hermitian and banded, and B is also positive definite. If eigenvectors are desired, it uses a divide and conquer algorithm.A

Expert Driver and RRR Driver Subprograms

 ? indicates prefix which must be filled with a combination of:
S = REAL(kind=4), D = REAL(kind=8), C = COMPLEX(kind=4), Z = COMPLEX(kind=8)
NamePrefixes Description
S D C Z Solves a general system of linear equations AX=B, ATX=B or AHX=B, and provides an estimate of the condition number and error bounds on the solution.
S D C Z Solves a general banded system of linear equations AX=B, ATX=B or AHX=B, and provides an estimate of the condition number and error bounds on the solution.
S D C Z Solves a general tridiagonal system of linear equations AX=B, ATX=B or AHX=B, and provides an estimate of the condition number and error bounds on the solution.
S D C Z Solves a symmetric/Hermitian positive definite system of linear equations AX=B, and provides an estimate of the condition number and error bounds on the solution.
S D C Z Solves a symmetric/Hermitian positive definite system of linear equations AX=B, where A is held in packed storage, and provides an estimate of the condition number and error bounds on the solution.
S D C Z Solves a symmetric/Hermitian positive definite banded system of linear equations AX=B, and provides an estimate of the condition number and error bounds on the solution.
S D C Z Solves a symmetric/Hermitian positive definite tridiagonal system of linear equations AX=B, and provides an estimate of the condition number and error bounds on the solution.
S D C Z Solves a symmetric indefinite system of linear equations AX=B, and provides an estimate of the condition number and error bounds on the solution.
S D C Z Solves a symmetric indefinite system of linear equations AX=B, where A is held in packed storage, and provides an estimate of the condition number and error bounds on the solution.
S D C Z Computes the minimum norm least squares solution to an over- or under-determined system of linear equations AX=B, using a complete orthogonal factorization of A.
S D C Z Computes the minimum norm least squares solution to an over- or under-determined system of linear equations AX=B, using a complete orthogonal factorization of A.
S D C Z Computes the minimum norm least squares solution to an over- or under-determined system of linear equations AX=B, using the singular value decomposition of A.
?SYEVX
S D Computes selected eigenvalues and eigenvectors of a symmetric matrix.
?SYEVR
S D Computes selected eigenvalues, and optionally, eigenvectors of a real symmetric matrix. Eigenvalues are computed by the dqds algorithm, and eigenvectors are computed from various "good" LDLT, representations (also known as Relatively Robust Representations).
?SYGVX
S D Computes selected eigenvalues, and optionally, the eigenvectors of a generalized symmetric-definite generalized eigenproblem, Ax=λBx, ABx=λx, or BAx=λx.
?SPEVX
S D Computes selected eigenvalues and eigenvectors of a symmetric matrix in packed storage.
?SPGVX
S D Computes selected eigenvalues, and optionally, eigenvectors of a generalized symmetric-definite generalized eigenproblem, Ax=λBx, ABx=λx, or BAx=λx, where A and B are in packed storage.
?SBEVX
S D Computes selected eigenvalues and eigenvectors of a symmetric band matrix.
?SBGVX
S D Computes selected eigenvalues, and optionally, the eigenvectors of a real generalized symmetric-definite banded eigenproblem, of, the form Ax=λBx. A and B are assumed to be symmetric and banded, and B is also positive definite.
?STEVX
S D Computes selected eigenvalues and eigenvectors of a real symmetric tridiagonal matrix.
?STEVR
S D Computes selected eigenvalues, and optionally, eigenvectors of a real symmetric tridiagonal matrix. Eigenvalues are computed by the dqds algorithm, and eigenvectors are computed from various "good" LDLT representations (also known as Relatively Robust Representations).
S D C Z Computes the eigenvalues and Schur factorization of a general matrix, orders the factorization so that selected eigenvalues are at the top left of the Schur form, and computes reciprocal condition numbers for the average of the selected eigenvalues, and for the associated right invariant subspace.
S D C Z Computes the generalized eigenvalues, the real Schur form, and, optionally, the left and/or right matrices of Schur vectors.
S D C Z Computes the eigenvalues and left and right eigenvectors of a general matrix, with preliminary balancing of the matrix, and computes reciprocal condition numbers for the eigenvalues and right eigenvectors.
S D C Z Computes the generalized eigenvalues, and optionally, the left and/or right generalized eigenvectors.
?HESVX
C Z Solves a Hermitian indefinite system of linear equations AX=B, and provides an estimate of the condition number and error bounds on the solution.
?HPSVX
C Z Solves a Hermitian indefinite system of linear equations AX=B, where A is held in packed storage, and provides an estimate of the condition number and error bounds on the solution.
?HEEVX
C Z Computes selected eigenvalues and eigenvectors of a Hermitian matrix.
?HEEVR
C Z Computes selected eigenvalues, and optionally, eigenvectors of a Hermitian matrix. Eigenvalues are computed by the dqds algorithm, and eigenvectors are computed from various "good" LDLT representations (also known as Relatively Robust Representations).
?HEGVX
C Z Computes selected eigenvalues, and optionally, the eigenvectors of a generalized Hermitian-definite generalized eigenproblem, Ax=λBx, ABx=λx, or BAx=λx.
?HPEVX
C Z Computes selected eigenvalues and eigenvectors of a Hermitian matrix in packed storage.
?HPGVX
C Z Computes selected eigenvalues, and optionally, the eigenvectors of a generalized Hermitian-definite generalized eigenproblem, Ax=λBx, ABx=λx, or BAx=λx, where A and B are in packed storage.
?HBEVX
C Z Computes selected eigenvalues and eigenvectors of a Hermitian band matrix.
?HBGVX
C Z Computes selected eigenvalues, and optionally, the eigenvectors of a complex generalized Hermitian-definite banded eigenproblem, of the form Ax=λBx. A and B are assumed to be Hermitian and banded, and B is also positive definite.

Computational Subprograms

 ? indicates prefix which must be filled with a combination of:
S = REAL(kind=4), D = REAL(kind=8), C = COMPLEX(kind=4), Z = COMPLEX(kind=8)
NamePrefixes Description
S D C Z Computes the CS decomposition of a orthogonal/unitary matrix in bidiagonal-block form.
?BDSDC
S D Computes the singular value decomposition (SVD) of a real bidiagonal matrix, using a divide and conquer method.
S D C Z Computes the singular value decomposition (SVD) of a real bidiagonal matrix, using the bidiagonal QR algorithm.
?DISNA
S D Computes the reciprocal condition numbers for the eigenvectors of a real symmetric or Hermitian matrix or for the left or right singular vectors of a general matrix.
S D C Z Reduces a general band matrix to real upper bidiagonal form by an orthogonal/unitary transformation.
S D C Z Estimates the reciprocal of the condition number of a general band matrix, in either the 1-norm or the Infinity-norm, using the LU factorization computed by ?GBTRF.
S D C Z Computes row and column scalings to equilibrate a general band matrix and reduce its condition number.
S D C Z Computes row and column scalings intended to equilibrate an M-by-N matrix A and reduce its condition number.
S D C Z Improves the computed solution to a general banded system of linear equations AX=B, ATX=B or AHX=B, and provides forward and backward error bounds for the solution.
S D C Z Computes an LU factorization of a general m-by-n band matrix A using partial pivoting with row interchanges.
S D C Z Computes an LU factorization of a general band matrix, using partial pivoting with row interchanges.
S D C Z Solves a general banded system of linear equations AX=B, ATX=B or AHX=B, using the LU factorization computed by ?GBTRF.
S D C Z Transforms eigenvectors of a balanced matrix to those of the original matrix supplied to ?GEBAL.
S D C Z Balances a general matrix in order to improve the accuracy of computed eigenvalues.
S D C Z Reduces a general m by n matrix A to upper or lower bidiagonal form B by a orthogonal/unitary transformation: QHAP=B.
S D C Z Reduces a general rectangular matrix to real bidiagonal form by an orthogonal/unitary transformation.
S D C Z Estimates the reciprocal of the condition number of a general matrix, in either the 1-norm or the Infinity-norm, using the LU factorization computed by ?GETRF.
S D C Z Computes row and column scalings to equilibrate a general rectangular matrix and reduce its condition number.
S D C Z Computes row and column scalings intended to equilibrate an M-by-N matrix A and reduce its condition number.
S D C Z Reduces a general matrix A to upper Hessenberg form H by a orthogonal/unitary similarity transformation: QHAQ=H .
S D C Z Reduces a general matrix to upper Hessenberg form by an orthogonal/unitary similarity transformation.
?GEJSV
S D Computes the singular value decomposition (SVD) of a real M-by-N matrix A, where M>=N.
S D C Z Computes an LQ factorization of a general m by n matrix A: A=LQ.
S D C Z Computes an LQ factorization of a general rectangular matrix.
S D C Z Overwrites the general M-by-N matrix C with QC, CQ, QHC, CQH where Q is a orthogonal matrix defined as the product of K elementary reflectors: Q=H(1) H(2) ...H(K)=I-VTVH generated using the compact WY representation as returned by ?GEQRT.
S D C Z Computes a QL factorization of a general m by n matrix A: A=QL.
S D C Z Computes a QL factorization of a general rectangular matrix.
S D C Z Computes a QR factorization with column pivoting of a general rectangular matrix using Level 3 BLAS.
S D C Z Computes a QR factorization with column pivoting of a general rectangular matrix.
S D C Z Computes a QR factorization of a general m by n matrix A: A=QR.
S D C Z Computes a QR factorization of a general m by n matrix A: A=QR.
S D C Z Computes a QR factorization of a general rectangular matrix.
S D C Z Computes a QR factorization of a general M-by-N matrix A: A=QR.
S D C Z Computes a blocked QR factorization of a general M-by-N matrix A using the compact WY representation of Q.
S D C Z Computes a QR factorization of a general M-by-N matrix A, using the compact WY representation of Q.
S D C Z Computes a QR factorization of a general M-by-N matrix A recursively, using the compact WY representation of Q.
S D C Z Improves the computed solution to a general system of linear equations AX=B, ATX=B or AHX=B, and provides forward and backward error bounds for the solution.
S D C Z Computes an RQ factorization of a general m by n matrix A: A=RQ.
S D C Z Computes an RQ factorization of a general rectangular matrix.
?GESVJ
S D Computes the singular value decomposition (SVD) of a real M-by-N matrix A, where M>=N.
S D C Z Computes an LU factorization of a general m-by-n matrix A using partial pivoting with row interchanges.
S D C Z Computes the inverse of a general matrix, using the LU factorization computed by ?GETRF.
S D C Z Solves a general system of linear equations AX=B, ATX=B or AHX=B, using the LU factorization computed by ?GETRF.
S D C Z Forms the right or left eigenvectors of the generalized eigenvalue problem by backward transformation on the computed eigenvectors of the balanced pair of matrices output by ?GGBAL.
S D C Z Balances a pair of general matrices for the generalized eigenvalue problem Ax=λBx.
S D C Z Reduces a pair of matrices to generalized upper Hessenberg form using orthogonal/unitary similarity transformations.
S D C Z Computes a generalized QR factorization of a pair of matrices.
S D C Z Computes a generalized RQ factorization of a pair of matrices.
S D C Z Computes orthogonal/unitary matrices as a preprocessing step for computing the generalized singular value decomposition.
?GSVJ0
S D Applies Jacobi rotations in the same way as [DS]GESVJ does, but it does not check convergence (stopping criterion).
?GSVJ1
S D Applies Jacobi rotations in the same way as [DS]GESVJ does, but it targets only particular pivots and it does not check convergence (stopping criterion).
S D C Z Estimates the reciprocal of the condition number of a general tridiagonal matrix, in either the 1-norm or the Infinity-norm, using the LU factorization computed by ?GTTRF.
S D C Z Improves the computed solution to a general tridiagonal system of linear equations AX=B, ATX=B or AHX=B, and provides forward and backward error bounds for the solution.
S D C Z Computes an LU factorization of a general tridiagonal matrix, using partial pivoting with row interchanges.
S D C Z Solves a general tridiagonal system of linear equations AX=B, ATX=B or AHX=B, using the LU factorization computed by ?GTTRF.
S D C Z Solves one of the systems of equations AX=B, ATX=B, or AHX=B, with a tridiagonal matrix A using the LU factorization computed by ?GTTRF.
?HBGST
C Z Reduces a Hermitian-definite banded generalized eigenproblem Ax=λBx to standard form, where B has been factorized by ?PBSTF (Crawford's algorithm).
?HBTRD
C Z Reduces a Hermitian band matrix to real symmetric tridiagonal form by a unitary similarity transformation.
?HECON
C Z Estimates the reciprocal of the condition number of a Hermitian indefinite matrix, using the factorization computed by ?HETRF.
?HEEQUB
C Z Computes row and column scalings intended to equilibrate a Hermitian matrix A and reduce its condition number (with respect to the two-norm).
?HEGS2
C Z Reduces a complex Hermitian-definite generalized eigenproblem to standard form.
?HEGST
C Z Reduces a Hermitian-definite generalized eigenproblem Ax=λBx, ABx=λx, or BAx=λx, to standard form, where B has been factorized by ?POTRF.
?HERFS
C Z Improves the computed solution to a Hermitian indefinite system of linear equations AX=B, and provides forward and backward error bounds for the solution.
?HETD2
C Z Reduces a complex Hermitian matrix A to real symmetric tridiagonal form T by a unitary similarity transformation: QHAQ=T.
?HETF2
C Z Computes the factorization of a complex Hermitian matrix A using the Bunch-Kaufman diagonal pivoting method: A=UDUH or A=LDLH where U (or L) is a product of permutation and unit upper (lower) triangular matrices, UH is the conjugate transpose of U, and D is Hermitian and block diagonal with 1-by-1 and 2-by-2 diagonal blocks.
?HETRD
C Z Reduces a Hermitian matrix to real symmetric tridiagonal form by an orthogonal/unitary similarity transformation.
?HETRF
C Z Computes the factorization of a Hermitian-indefinite matrix, using the diagonal pivoting method.
?HETRI
C Z Computes the inverse of a Hermitian indefinite matrix, using the factorization computed by ?HETRF.
?HETRI2
C Z Computes the inverse of a complex hermitian indefinite matrix A using the factorization A=UDUT or A=LDLT computed by ?HETRF.
?HETRI2X
C Z Computes the inverse of a complex Hermitian indefinite matrix A using the factorization A=UDUH or A=LDLH computed by ?HETRF.
?HETRS
C Z Solves a Hermitian indefinite system of linear equations AX=B, using the factorization computed by ?HPTRF.
?HETRS2
C Z Solves a system of linear equations AX=B with a complex Hermitian matrix A using the factorization A=UDUH or A=LDLH computed by ?HETRF and converted by ?SYCONV.
?HFRK
C Z Performs one of the Hermitian rank--k operations C:=αAAH+βC, or C:=αAHA+βC, where α and β are real scalars, C is an n--by--n Hermitian matrix and A is an n--by--k matrix in the first case and a k--by--n matrix in the second case.
S D C Z Implements a single/double-shift version of the QZ method for finding the generalized eigenvalues of the equation det(A - w(i) B) = 0.
?HPCON
C Z Estimates the reciprocal of the condition number of a Hermitian indefinite matrix in packed storage, using the factorization computed by ?HPTRF.
?HPGST
C Z Reduces a Hermitian-definite generalized eigenproblem Ax=λBx, ABx=λx, or BAx=λx, to standard form, where A and B are held in packed storage, and B has been factorized by ?PPTRF.
?HPRFS
C Z Improves the computed solution to a Hermitian indefinite system of linear equations AX=B, where A is held in packed storage, and provides forward and backward error bounds for the solution.
?HPTRD
C Z Reduces a Hermitian matrix in packed storage to real symmetric tridiagonal form by a unitary similarity transformation.
?HPTRF
C Z Computes the factorization of a Hermitian-indefinite matrix in packed storage, using the diagonal pivoting method.
?HPTRI
C Z Computes the inverse of a Hermitian indefinite matrix in packed storage, using the factorization computed by ?HPTRF.
?HPTRS
C Z Solves a Hermitian indefinite system of linear equations AX=B, where A is held in packed storage, using the factorization computed by ?HPTRF.
S D C Z Computes specified right and/or left eigenvectors of an upper Hessenberg matrix by inverse iteration.
S D C Z Computes the eigenvalues and Schur factorization of an upper Hessenberg matrix, using the multishift QR algorithm.
S D C Z Computes all eigenvalues and corresponding eigenvectors of a symmetric tridiagonal matrix using the divide and conquer method.
?LAED1
S D Computes the updated eigensystem of a diagonal matrix after modification by a rank-one symmetric matrix.
?LAED2
S D Merges the two sets of eigenvalues together into a single sorted set.
?LAED3
S D Finds the roots of the secular equation, as defined by the values in D, W, and ρ, between 1 and K.
?LAED4
S D Computes the I-th updated eigenvalue of a symmetric rank-one modification to a diagonal matrix whose elements are given in the array D, and that D(i)<D(j) for i<j and that ρ>0.
?LAED5
S D Computes the I-th eigenvalue of a symmetric rank-one modification of a 2-by-2 diagonal matrix.
?LAED6
S D Computes the positive or negative root (closest to the origin) of the secular equation, as defined by the values in D, Z, and ρ.
S D C Z Computes the updated eigensystem of a diagonal matrix after modification by a rank-one symmetric matrix.
S D C Z Merges the two sets of eigenvalues together into a single sorted set.
?LAED9
S D Finds the roots of the secular equation, as defined by the values in D, Z, and ρ, between KSTART and KSTOP.
?LAEDA
S D Computes the Z vector corresponding to the merge step in the CURLVLth step of the merge process with TLVLS steps for the CURPBMth problem.
?LAGTF
S D Factorizes the matrix (T-λI), where T is an n by n tridiagonal matrix and λ is a scalar, as T-λI=PLU, where P is a permutation matrix, L is a unit lower tridiagonal matrix with at most one non-zero sub-diagonal elements per column and U is an upper triangular matrix with at most two non-zero super-diagonal elements per column.
?LAHEF
C Z Computes a partial factorization of a complex Hermitian matrix A using the Bunch-Kaufman diagonal pivoting method.
S D C Z Applies back the multiplying factors of either the left or the right singular vector matrix of a bidiagonal matrix appended by a row to the right hand side matrix B in solving the least squares problem using the divide-and-conquer SVD approach.
S D C Z Applies the singular vector matrix of an upper bidiagonal matrix or its inverse matrix to the right hand side.
S D C Z Uses the singular value decomposition of A to solve the least squares problem of finding X to minimize the Euclidean norm of each column of AX-B, where A is N-by-N upper bidiagonal, and X and B are N-by-NRHS.
?LAMRG
S D Creates a permutation list which merge the elements of A (which is composed of two independently sorted sets) into a single set which is sorted in ascending order.
?LANHF
C Z Returns the value of the one norm, or the Frobenius norm, or the infinity norm, or the element of largest absolute value of a complex Hermitian matrix A in RFP format.
?LANSF
S D Returns the value of the one norm, or the Frobenius norm, or the infinity norm, or the element of largest absolute value of a real symmetric matrix A in RFP format.
?LARTGS
S D Generates a plane rotation designed to introduce a bulge in Golub-Reinsch-style implicit QR iteration for the bidiagonal SVD problem.
S D C Z Applies a general elementary reflector H to a general M-by-N matrix C, from either the left or the right.
S D C Z Applies a general block reflector H or its transpose HH to a general distributed M-by-N C from the left or the right.
S D C Z Forms the triangular factor T of a general block reflector H of order>n, which is defined as a product of k elementary reflectors.
?LASQ1
S D Computes the singular values of a real N-by-N bidiagonal matrix with diagonal D and off-diagonal E.
?LASQ2
S D Computes all the eigenvalues of the symmetric positive definite tridiagonal matrix associated with the qd array Z to high relative accuracy are computed to high relative accuracy, in the absence of denormalization, underflow and overflow.
?LASQ3
S D Checks for deflation, computes a shift (TAU) and calls dqds.
?LASQ4
S D Computes an approximation TAU to the smallest eigenvalue using values of d from the previous transform.
?LASQ5
S D Computes one dqds transform, one version for IEEE machines another for non IEEE machines.
?LASQ6
S D Computes one dqd (shift equal to zero) transform in ping-pong form, with protection against underflow and overflow.
?LASRT
S D Sort the numbers in D in increasing order (if ID='I') or in decreasing order (if ID='D' ).
S D C Z Computes a partial factorization of a general symmetric matrix A using the Bunch-Kaufman diagonal pivoting method.
S D C Z Factors the M-by-(M+L) general upper trapezoidal matrix
[A1 A2]=[A(1:M,1:M) A(1:M,N-L+1:N)]
as ( R 0 )*Z by means of orthogonal/unitary transformations, where Z is an (M+L)-by-(M+L) orthogonal/unitary matrix and, R and A1 are M-by-M upper triangular matrices.
S D C Z Applies a Householder matrix generated by ?TZRQF to a matrix. This routine is deprecated and has been replaced by routine [DS]ORMRZ/[ZC]UNMRZ.
?OPGTR
S D Generates the orthogonal transformation matrix from a reduction to tridiagonal form determined by ?SPTRD.
?OPMTR
S D Multiplies a general matrix by the orthogonal transformation matrix from a reduction to tridiagonal form, determined by ?SPTRD.
?ORBDB
S D Simultaneously bidiagonalizes the blocks of an M-by-M partitioned orthogonal matrix X.
?ORCSD
S D Computes the CS decomposition of an M-by-M partitioned orthogonal matrix X.
?ORG2L
S D Generates an m by n real matrix Q with orthonormal columns, which is defined as the last n columns of a product of k elementary reflectors of order m Q=H(k) ...H(2) H(1) as returned by ?GEQLF.
?ORG2R
S D Generates an m by n real matrix Q with orthonormal columns, which is defined as the first n columns of a product of k elementary reflectors of order m Q=H(1) H(2) ...H(k) as returned by ?GEQRF.
?ORGBR
S D Generates the orthogonal transformation matrices from a reduction to bidiagonal form determined by ?GEBRD.
?ORGHR
S D Generates the orthogonal transformation matrix from a reduction to Hessenberg form determined by ?GEHRD.
?ORGL2
S D Generates an m by n real matrix Q with orthonormal rows, which is defined as the first m rows of a product of k elementary reflectors of order n Q=H(k) ...H(2) H(1) as returned by ?GELQF.
?ORGLQ
S D Generates all or part of the orthogonal matrix Q from an LQ factorization determined by ?GELQF.
?ORGQL
S D Generates all or part of the orthogonal matrix Q from a QL factorization determined by ?GEQLF.
?ORGQR
S D Generates all or part of the orthogonal matrix Q from a QR factorization determined by ?GEQRF.
?ORGR2
S D Generates an m by n real matrix Q with orthonormal rows, which is defined as the last m rows of a product of k elementary reflectors of order n Q=H(1) H(2) ...H(k) as returned by ?GERQF.
?ORGRQ
S D Generates all or part of the orthogonal matrix Q from an RQ factorization determined by ?GERQF.
?ORGTR
S D Generates the orthogonal transformation matrix from a reduction to tridiagonal form determined by ?SYTRD.
?ORM2L
S D Overwrites the general real m by n matrix C with QC, QTC, CQ, CQT, where Q is a real orthogonal matrix defined as the product of k elementary reflectors Q=H(k) ...H(2) H(1) as returned by ?GEQLF.
?ORM2R
S D Overwrites the general real m by n matrix C with QC, QTC, CQ, CQT, where Q is a real orthogonal matrix defined as the product of k elementary reflectors Q=H(1) H(2) ...H(k) as returned by ?GEQRF.
?ORMBR
S D Multiplies a general matrix by one of the orthogonal transformation matrices from a reduction to bidiagonal form determined by ?GEBRD.
?ORMHR
S D Multiplies a general matrix by the orthogonal transformation matrix from a reduction to Hessenberg form determined by ?GEHRD.
?ORML2
S D Overwrites the general real m by n matrix C with QC, QTC, CQ, CQT, where Q is a real orthogonal matrix defined as the product of k elementary reflectors Q=H(k) ...H(2) H(1) as returned by ?GELQF.
?ORMLQ
S D Multiplies a general matrix by the orthogonal matrix from an LQ factorization determined by ?GELQF.
?ORMQL
S D Multiplies a general matrix by the orthogonal matrix from a QL factorization determined by ?GEQLF.
?ORMQR
S D Multiplies a general matrix by the orthogonal matrix from a QR factorization determined by ?GEQRF.
?ORMR2
S D Overwrites the general real m by n matrix C with QC, QTC, CQ,CQT, where Q is a real orthogonal matrix defined as the product of k elementary reflectors Q=H(1) H(2) ...H(k) as returned by ?GERQF.
?ORMR3
S D Multiples a general matrix by the orthogonal matrix from an RZ factorization determined by ?TZRZF.
?ORMRQ
S D Multiplies a general matrix by the orthogonal matrix from an RQ factorization determined by ?GERQF.
?ORMRZ
S D Multiples a general matrix by the orthogonal matrix from an RZ factorization determined by ?TZRZF.
?ORMTR
S D Multiplies a general matrix by the orthogonal transformation matrix from a reduction to tridiagonal form determined by ?SYTRD.
S D C Z Estimates the reciprocal of the condition number of a symmetric/Hermitian positive definite band matrix, using the Cholesky factorization computed by ?PBTRF.
S D C Z Computes row and column scalings to equilibrate a symmetric/Hermitian positive definite band matrix and reduce its condition number.
S D C Z Improves the computed solution to a symmetric/Hermitian positive definite banded system of linear equations AX=B, and provides forward and backward error bounds for the solution.
S D C Z Computes a split Cholesky factorization of a symmetric/Hermitian positive definite band matrix.
S D C Z Computes the Cholesky factorization of a symmetric/Hermitian positive definite band matrix A.
S D C Z Computes the Cholesky factorization of a symmetric/Hermitian positive definite band matrix.
S D C Z Solves a symmetric/Hermitian positive definite banded system of linear equations AX=B, using the Cholesky factorization computed by ?PBTRF.
S D C Z Computes the Cholesky factorization of a symmetric/Hermitian positive definite matrix A.
S D C Z Computes the inverse of a symmetric/Hermitian positive definite matrix A using the Cholesky factorization A=UHU or A=LLH computed by ?PFTRF.
S D C Z Solves a system of linear equations AX=B with a symmetric/Hermitian positive definite matrix A using the Cholesky factorization A=UHU or A=LLH computed by ?PFTRF.
S D C Z Estimates the reciprocal of the condition number of a symmetric/Hermitian positive definite matrix, using the Cholesky factorization computed by ?POTRF.
S D C Z Computes row and column scalings to equilibrate a symmetric/Hermitian positive definite matrix and reduce its condition number.
S D C Z Computes row and column scalings intended to equilibrate a symmetric positive definite matrix A and reduce its condition number (with respect to the two-norm).
S D C Z Improves the computed solution to a symmetric/Hermitian positive definite system of linear equations AX=B, and provides forward and backward error bounds for the solution.
S D C Z Computes the Cholesky factorization of a symmetric/Hermitian positive definite matrix A.
S D C Z Computes the Cholesky factorization of a symmetric/Hermitian positive definite matrix.
S D C Z Computes the inverse of a symmetric/Hermitian positive definite matrix, using the Cholesky factorization computed by ?POTRF.
S D C Z Solves a symmetric/Hermitian positive definite system of linear equations AX=B, using the Cholesky factorization computed by ?POTRF.
S D C Z Estimates the reciprocal of the condition number of a symmetric/Hermitian positive definite matrix in packed storage, using the Cholesky factorization computed by ?PPTRF.
S D C Z Computes row and column scalings to equilibrate a symmetric/Hermitian positive definite matrix in packed storage and reduce its condition number.
S D C Z Improves the computed solution to a symmetric/Hermitian positive definite system of linear equations AX=B, where A is held in packed storage, and provides forward and backward error bounds for the solution.
S D C Z Computes the Cholesky factorization of a symmetric/Hermitian positive definite matrix in packed storage.
S D C Z Computes the inverse of a symmetric/Hermitian positive definite matrix in packed storage, using the Cholesky factorization computed by ?PPTRF.
S D C Z Solves a symmetric/Hermitian positive definite system of linear equations AX=B, where A is held in packed storage, using the Cholesky factorization computed by ?PPTRF.
S D C Z Computes the Cholesky factorization with complete pivoting of a symmetric/Hermitian positive semidefinite matrix A.
S D C Z Computes the Cholesky factorization with complete pivoting of a symmetric/Hermitian positive semidefinite matrix A.
S D C Z Computes the reciprocal of the condition number of a symmetric/Hermitian positive definite tridiagonal matrix, using the LDLH factorization computed by ?PTTRF.
S D C Z Computes all eigenvalues and eigenvectors of a symmetric positive definite tridiagonal matrix, by computing the SVD of its bidiagonal Cholesky factor.
S D C Z Improves the computed solution to a symmetric/Hermitian positive definite tridiagonal system of linear equations AX=B, and provides forward and backward error bounds for the solution.
S D C Z Computes the LDLH factorization of a symmetric/Hermitian positive definite tridiagonal matrix.
S D C Z Solves a symmetric/Hermitian positive definite tridiagonal system of linear equations, using the LDLH factorization computed by ?PTTRF.
S D C Z Solves a tridiagonal system of the form AX=B using the factorization A=UHDU or A=LDLH computed by ?PTTRF.
?SBGST
S D Reduces a real symmetric-definite banded generalized eigenproblem Ax=λBx to standard form, where B has been factorized by ?PBSTF (Crawford's algorithm).
?SBTRD
S D Reduces a symmetric band matrix to real symmetric tridiagonal form by an orthogonal similarity transformation.
?SFRK
S D Performs one of the symmetric rank--k operations C:=αAAT+βC, or C:=αATA+βC, where alpha and beta are real scalars, C is an n--by--n symmetric matrix and A is an n--by--k matrix in the first case and a k--by--n matrix in the second case.
S D C Z Estimates the reciprocal of the condition number of a symmetric indefinite matrix in packed storage, using the factorization computed by ?SPTRF.
?SPGST
S D Reduces a symmetric-definite generalized eigenproblem Ax=λBx, ABx=λx, or BAx=λx, to standard form, where A and B are held in packed storage, and B has been factorized by ?PPTRF.
S D C Z Improves the computed solution to a symmetric indefinite system of linear equations AX=B, where A is held in packed storage, and provides forward and backward error bounds for the solution.
?SPTRD
S D Reduces a symmetric matrix in packed storage to real symmetric tridiagonal form by an orthogonal similarity transformation.
S D C Z Computes the factorization of a symmetric-indefinite matrix in packed storage, using the diagonal pivoting method.
S D C Z Computes the inverse of a symmetric indefinite matrix in packed storage, using the factorization computed by ?SPTRF.
S D C Z Solves a symmetric indefinite system of linear equations AX=B, where A is held in packed storage, using the factorization computed by ?SPTRF.
?STEBZ
S D Computes selected eigenvalues of a real symmetric tridiagonal matrix by bisection.
S D C Z Computes all eigenvalues and, optionally, eigenvectors of a symmetric tridiagonal matrix using the divide and conquer algorithm.
S D C Z Computes selected eigenvalues and, optionally, eigenvectors of a symmetric tridiagonal matrix. The eigenvalues are computed by the dqds algorithm, while eigenvectors are computed from various "good" LDLT representations (also known as Relatively Robust Representations).
S D C Z Computes selected eigenvectors of a real symmetric tridiagonal matrix by inverse iteration.
S D C Z Computes selected eigenvalues and, optionally, eigenvectors of a real symmetric tridiagonal matrix T.
S D C Z Computes all eigenvalues and eigenvectors of a real symmetric tridiagonal matrix, using the implicit QL or QR algorithm.
?STERF
S D Computes all eigenvalues of a real symmetric tridiagonal matrix, using a root-free variant of the QL or QR algorithm.
S D C Z Estimates the reciprocal of the condition number of a symmetric indefinite matrix, using the factorization computed by ?SYTRF.
S D C Z Converts A given by [DS]SYTRF/[ZC]HETRF into L and D and vice-versa.
S D C Z Computes row and column scalings intended to equilibrate a symmetric matrix A and reduce its condition number (with respect to the two-norm).
?SYGS2
S D Reduces a real symmetric-definite generalized eigenproblem to standard form.
?SYGST
S D Reduces a symmetric-definite generalized eigenproblem Ax=λBx, ABx=λx, or BAx=λx, to standard form, where B has been factorized by ?POTRF.
S D C Z Improves the computed solution to a symmetric indefinite system of linear equations AX=B, and provides forward and backward error bounds for the solution.
?SYTD2
S D Reduces a real symmetric matrix A to symmetric tridiagonal form T by an orthogonal similarity transformation: QTAQ=T.
S D C Z Computes the factorization of a general symmetric matrix A using the Bunch-Kaufman diagonal pivoting method: A=UDUT or A=LDLT where U (or L) is a product of permutation and unit upper (lower) triangular matrices, UT is the transpose of U, and D is symmetric and block diagonal with 1-by-1 and 2-by-2 diagonal blocks.
?SYTRD
S D Reduces a symmetric matrix to real symmetric tridiagonal form by an orthogonal similarity transformation.
S D C Z Computes the factorization of a symmetric-indefinite matrix, using the diagonal pivoting method.
S D C Z Computes the inverse of a symmetric indefinite matrix, using the factorization computed by ?SYTRF.
S D C Z Computes the inverse of a general symmetric indefinite matrix A using the factorization A=UDUT or A=LDLT computed by ?SYTRF.
S D C Z Computes the inverse of a general symmetric indefinite matrix A using the factorization A=UDUT or A=LDLT computed by ?SYTRF.
S D C Z Solves a symmetric indefinite system of linear equations AX=B, using the factorization computed by ?SPTRF.
S D C Z Solves a system of linear equations AX=B with a general symmetric matrix A using the factorization A=UDUT or A=LDLT computed by ?SYTRF and converted by ?SYCONV.
S D C Z Estimates the reciprocal of the condition number of a triangular band matrix, in either the 1-norm or the Infinity-norm.
S D C Z Provides forward and backward error bounds for the solution of a triangular banded system of linear equations AX=B, ATX=B or AHX=B.
S D C Z Solves a triangular banded system of linear equations AX=B, ATX=B or AHX=B.
S D C Z Solves the matrix equation op(A)*X=αB or X*op(A)=βB where α is a scalar, X and B are m by n matrices, A is a unit, or non-unit, upper or lower triangular matrix and op( A ) is one of op(A)=A or op(A)=AH.
S D C Z Computes the inverse of a triangular matrix A stored in RFP format.
S D C Z Copies a triangular matrix A from rectangular full packed format (TF) to standard packed format (TP).
S D C Z Copies a triangular matrix A from rectangular full packed format (TF) to standard full format (TR).
S D C Z Computes some or all of the right and/or left generalized eigenvectors of a pair of upper triangular matrices.
S D C Z Reorders the generalized Schur decomposition of a matrix pair (A,B) using an orthogonal/unitary equivalence transformation so that the diagonal block of (A,B) with row index IFST is moved to row ILST.
S D C Z Reorders the generalized Schur decomposition of a matrix pair (A,B) so that a selected cluster of eigenvalues appears in the leading diagonal blocks of the pair (A,B).
S D C Z Computes the generalized singular value decomposition of two upper triangular (or trapezoidal) matrices as output by ?GGSVP.
S D C Z Estimates reciprocal condition numbers for specified eigenvalues and/or eigenvectors of a matrix pair (A,B) in generalized Schur canonical form, as returned by ?GGES.
S D C Z Solves the generalized Sylvester equation.
S D C Z Estimates the reciprocal of the condition number of a triangular matrix in packed storage, in either the 1-norm or the Infinity-norm.
S D C Z Applies a general orthogonal matrix Q obtained from a "triangular-pentagonal" general block reflector H to a general general matrix C, which consists of two blocks A and B.
S D C Z Computes a blocked QR factorization of a general "triangular-pentagonal" matrix C, which is composed of a triangular block A and pentagonal block B, using the compact WY representation for Q.
S D C Z Computes a QR factorization of a general "triangular-pentagonal" matrix C, which is composed of a triangular block A and pentagonal block B, using the compact WY representation for Q.
S D C Z Provides forward and backward error bounds for the solution of a triangular system of linear equations AX=B, ATX=B or AHX=B, where A is held in packed storage.
S D C Z Computes the inverse of a triangular matrix in packed storage.
S D C Z Solves a triangular system of linear equations AX=B, ATX=B or AHX=B, where A is held in packed storage.
S D C Z Copies a triangular matrix A from standard packed format (TP) to rectangular full packed format (TF).
S D C Z Copies a triangular matrix A from standard packed format (TP) to standard full format (TR).
S D C Z Estimates the reciprocal of the condition number of a triangular matrix, in either the 1-norm or the Infinity-norm.
S D C Z Computes left and right eigenvectors of an upper quasi-triangular/triangular matrix.
S D C Z Reorders the Schur factorization of a matrix by an orthogonal/unitary similarity transformation.
S D C Z Provides forward and backward error bounds for the solution of a triangular system of linear equations AX=B, ATX=B or AHX=B.
S D C Z Reorders the Schur factorization of a matrix in order to find an orthonormal basis of a right invariant subspace corresponding to selected eigenvalues, and returns reciprocal condition numbers (sensitivities) of the average of the cluster of eigenvalues and of the invariant subspace.
S D C Z Estimates the reciprocal condition numbers (sensitivities) of selected eigenvalues and eigenvectors of an upper quasi-triangular/triangular matrix.
S D C Z Solves the Sylvester matrix equation AX ± XB=C, where A and B are upper quasi-triangular/triangular, and may be transposed.
S D C Z Computes the inverse of a general upper or lower triangular matrix.
S D C Z Computes the inverse of a triangular matrix.
S D C Z Solves a triangular system of linear equations AX=B, ATX=B or AHX=B.
S D C Z Copies a triangular matrix A from standard full format (TR) to rectangular full packed format (TF) .
S D C Z Copies a triangular matrix A from full format (TR) to standard packed format (TP).
S D C Z Computes an RQ factorization of an upper trapezoidal matrix.
S D C Z Computes an RZ factorization of an upper trapezoidal matrix (blocked version of ?TZRQF).
?UNBDB
C Z Simultaneously bidiagonalizes the blocks of an M-by-M partitioned unitary matrix X.
?UNCSD
C Z Computes the CS decomposition of an M-by-M partitioned unitary matrix X.
?UNG2L
C Z Generates an m by n complex matrix Q with orthonormal columns, which is defined as the last n columns of a product of k elementary reflectors of order m Q=H(k) ...H(2) H(1) as returned by ?GEQLF.
?UNG2R
C Z Generates an m by n complex matrix Q with orthonormal columns, which is defined as the first n columns of a product of k elementary reflectors of order m Q=H(1) H(2) ...H(k) as returned by ?GEQRF.
?UNGBR
C Z Generates the unitary transformation matrices from a reduction to bidiagonal form determined by ?GEBRD.
?UNGHR
C Z Generates the unitary transformation matrix from a reduction to Hessenberg form determined by ?GEHRD.
?UNGL2
C Z Generates an m-by-n complex matrix Q with orthonormal rows, which is defined as the first m rows of a product of k elementary reflectors of order n Q=H(k)H ...H(2)H H(1)H as returned by ?GELQF.
?UNGLQ
C Z Generates all or part of the unitary matrix Q from an LQ factorization determined by ?GELQF.
?UNGQL
C Z Generates all or part of the unitary matrix Q from a QL factorization determined by ?GEQLF.
?UNGQR
C Z Generates all or part of the unitary matrix Q from a QR factorization determined by ?GEQRF.
?UNGR2
C Z Generates an m by n complex matrix Q with orthonormal rows, which is defined as the last m rows of a product of k elementary reflectors of order n Q=H(1)H H(2)H ...H(k)H as returned by ?GERQF.
?UNGRQ
C Z Generates all or part of the unitary matrix Q from an RQ factorization determined by ?GERQF.
?UNGTR
C Z Generates the unitary transformation matrix from a reduction to tridiagonal form determined by ?HETRD.
?UNM2L
C Z Overwrites the general complex m-by-n matrix C with QC, QHC, CQ , CQH, where Q is a complex unitary matrix defined as the product of k elementary reflectors Q=H(k) ...H(2) H(1) as returned by ?GEQLF.
?UNM2R
C Z Overwrites the general complex m-by-n matrix C with QC, QHC,CQ, CQH, where Q is a complex unitary matrix defined as the product of k elementary reflectors Q=H(1) H(2) ...H(k) as returned by ?GEQRF.
?UNMBR
C Z Multiplies a general matrix by one of the unitary transformation matrices from a reduction to bidiagonal form determined by ?GEBRD.
?UNMHR
C Z Multiplies a general matrix by the unitary transformation matrix from a reduction to Hessenberg form determined by ?GEHRD.
?UNML2
C Z Overwrites the general complex m-by-n matrix C with QC, QHC, CQ, CQH, where Q is a complex unitary matrix defined as the product of k elementary reflectors Q=H(k)H ...H(2)H H(1)H as returned by ?GELQF.
?UNMLQ
C Z Multiplies a general matrix by the unitary matrix from an LQ factorization determined by ?GELQF.
?UNMQL
C Z Multiplies a general matrix by the unitary matrix from a QL factorization determined by ?GEQLF.
?UNMQR
C Z Multiplies a general matrix by the unitary matrix from a QR factorization determined by ?GEQRF.
?UNMR2
C Z Overwrites the general complex m-by-n matrix C with QC, QHC, CQ, CQH, where Q is a complex unitary matrix defined as the product of k elementary reflectors Q=H(1)H H(2)H ...H(k)H as returned by ?GERQF.
?UNMR3
C Z Multiples a general matrix by the unitary matrix from an RZ factorization determined by ?TZRZF.
?UNMRQ
C Z Multiplies a general matrix by the unitary matrix from an RQ factorization determined by ?GERQF.
?UNMRZ
C Z Multiples a general matrix by the unitary matrix from an RZ factorization determined by ?TZRZF.
?UNMTR
C Z Multiplies a general matrix by the unitary transformation matrix from a reduction to tridiagonal form determined by ?HETRD.
?UPGTR
C Z Generates the unitary transformation matrix from a reduction to tridiagonal form determined by ?HPTRD.
?UPMTR
C Z Multiplies a general matrix by the unitary transformation matrix from a reduction to tridiagonal form determined by ?HPTRD.
Translates from a BLAST-specified integer constant to the character string specifying a transposition operation.
Translated from a character string specifying if a matrix has unit diagonal or not to the relevant BLAST-specified integer constant.
Translated from a character string specifying an intermediate precision to the relevant BLAST-specified integer constant.
Translates from a character string specifying a transposition operation to the relevant BLAST-specified integer constant.
Translated from a character string specifying a upper-or lower-triangular matrix to the relevant BLAST-specified integer constant.
Returns the LAPACK version.

Auxiliary Subprograms

 ? indicates prefix which must be filled with a combination of:
S = REAL(kind=4), D = REAL(kind=8), C = COMPLEX(kind=4), Z = COMPLEX(kind=8)
Prefixes Routine
S D C Z
S D CS ZD
S D
?ISNAN
?LABAD
?LAE2
?LAEBZ
?LAEXC
?LAG2
?LAGTS
?LAGV2
?LAISNAN
?LALN2
?LAMCH
?LANEG
?LANST
?LANV2
?LAPY2
?LAPY3
?LAQTR
?LARRA
?LARRB
?LARRC
?LARRD
?LARRE
?LARRF
?LARRJ
?LARRK
?LARRR
?LARTGP
?LARUV
?LAS2
?LASD0
?LASD1
?LASD2
?LASD3
?LASD4
?LASD5
?LASD6
?LASD7
?LASD8
?LASDA
?LASDQ
?LASDT
?LASV2
?LASY2
C Z
?HESWAPR
?LACGV
?LACP2
?LACRM
?LACRT
?LAESY
?LANHB
?LANHE
?LANHP
?LANHT
?LAQHB
?LAQHE
?LAQHP
?LARCM
?SPMV
?SPR
?SYR
I?MAX1
SC DZ
?SUM1
n/a

External Links

  1. LAPACK User's Guide
  2. A Quick Reference guide for LAPACK (downloading a PostScript format file)
  3. A hardcopy LAPACK User's Guide may be ordered from SIAM.

Version Information

  • This manual page version: 2.2.0-181019