Epetra Package Browser (Single Doxygen Collection)  Development
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
List of all members
Epetra_LAPACK Class Reference

Epetra_LAPACK: The Epetra LAPACK Wrapper Class. More...

#include <Epetra_LAPACK.h>

Inheritance diagram for Epetra_LAPACK:
Inheritance graph
[legend]

Constructors/destructors

 Epetra_LAPACK (void)
 Epetra_LAPACK Constructor. More...
 
 Epetra_LAPACK (const Epetra_LAPACK &LAPACK)
 Epetra_LAPACK Copy Constructor. More...
 
virtual ~Epetra_LAPACK (void)
 Epetra_LAPACK Destructor. More...
 

Symmetric Positive Definite linear system routines

void POTRF (const char UPLO, const int N, float *A, const int LDA, int *INFO) const
 Epetra_LAPACK factorization for positive definite matrix (SPOTRF) More...
 
void POTRF (const char UPLO, const int N, double *A, const int LDA, int *INFO) const
 Epetra_LAPACK factorization for positive definite matrix (DPOTRF) More...
 
void POTRS (const char UPLO, const int N, const int NRHS, const float *A, const int LDA, float *X, const int LDX, int *INFO) const
 Epetra_LAPACK solve (after factorization) for positive definite matrix (SPOTRS) More...
 
void POTRS (const char UPLO, const int N, const int NRHS, const double *A, const int LDA, double *X, const int LDX, int *INFO) const
 Epetra_LAPACK solve (after factorization) for positive definite matrix (DPOTRS) More...
 
void POTRI (const char UPLO, const int N, float *A, const int LDA, int *INFO) const
 Epetra_LAPACK inversion for positive definite matrix (SPOTRI) More...
 
void POTRI (const char UPLO, const int N, double *A, const int LDA, int *INFO) const
 Epetra_LAPACK inversion for positive definite matrix (DPOTRI) More...
 
void POCON (const char UPLO, const int N, const float *A, const int LDA, const float ANORM, float *RCOND, float *WORK, int *IWORK, int *INFO) const
 Epetra_LAPACK condition number estimator for positive definite matrix (SPOCON) More...
 
void POCON (const char UPLO, const int N, const double *A, const int LDA, const double ANORM, double *RCOND, double *WORK, int *IWORK, int *INFO) const
 Epetra_LAPACK condition number estimator for positive definite matrix (DPOCON) More...
 
void POSV (const char UPLO, const int N, const int NRHS, float *A, const int LDA, float *X, const int LDX, int *INFO) const
 Epetra_LAPACK factor and solve for positive definite matrix (SPOSV) More...
 
void POSV (const char UPLO, const int N, const int NRHS, double *A, const int LDA, double *X, const int LDX, int *INFO) const
 Epetra_LAPACK factor and solve for positive definite matrix (DPOSV) More...
 
void POEQU (const int N, const float *A, const int LDA, float *S, float *SCOND, float *AMAX, int *INFO) const
 Epetra_LAPACK equilibration for positive definite matrix (SPOEQU) More...
 
void POEQU (const int N, const double *A, const int LDA, double *S, double *SCOND, double *AMAX, int *INFO) const
 Epetra_LAPACK equilibration for positive definite matrix (DPOEQU) More...
 
void PORFS (const char UPLO, const int N, const int NRHS, const float *A, const int LDA, const float *AF, const int LDAF, const float *B, const int LDB, float *X, const int LDX, float *FERR, float *BERR, float *WORK, int *IWORK, int *INFO) const
 Epetra_LAPACK solve driver for positive definite matrix (SPOSVX) More...
 
void PORFS (const char UPLO, const int N, const int NRHS, const double *A, const int LDA, const double *AF, const int LDAF, const double *B, const int LDB, double *X, const int LDX, double *FERR, double *BERR, double *WORK, int *IWORK, int *INFO) const
 Epetra_LAPACK solve driver for positive definite matrix (DPOSVX) More...
 
void POSVX (const char FACT, const char UPLO, const int N, const int NRHS, float *A, const int LDA, float *AF, const int LDAF, const char EQUED, float *S, float *B, const int LDB, float *X, const int LDX, float *RCOND, float *FERR, float *BERR, float *WORK, int *IWORK, int *INFO) const
 Epetra_LAPACK solve driver for positive definite matrix (SPOSVX) More...
 
void POSVX (const char FACT, const char UPLO, const int N, const int NRHS, double *A, const int LDA, double *AF, const int LDAF, const char EQUED, double *S, double *B, const int LDB, double *X, const int LDX, double *RCOND, double *FERR, double *BERR, double *WORK, int *IWORK, int *INFO) const
 Epetra_LAPACK solve driver for positive definite matrix (DPOSVX) More...
 

General linear system routines

void GELS (const char TRANS, const int M, const int N, const int NRHS, double *A, const int LDA, double *B, const int LDB, double *WORK, const int LWORK, int *INFO) const
 Epetra_LAPACK simple driver to solve least-squares systems. More...
 
void GETRF (const int M, const int N, float *A, const int LDA, int *IPIV, int *INFO) const
 Epetra_LAPACK factorization for general matrix (SGETRF) More...
 
void GETRF (const int M, const int N, double *A, const int LDA, int *IPIV, int *INFO) const
 Epetra_LAPACK factorization for general matrix (DGETRF) More...
 
void GEQRF (const int M, const int N, float *A, const int LDA, float *TAU, float *WORK, const int lwork, int *INFO) const
 Epetra_LAPACK QR factorization for general matrix (SGEQRF) More...
 
void GEQRF (const int M, const int N, double *A, const int LDA, double *TAU, double *WORK, const int lwork, int *INFO) const
 Epetra_LAPACK factorization for general matrix (DGEQRF) More...
 
void GETRS (const char TRANS, const int N, const int NRHS, const float *A, const int LDA, const int *IPIV, float *X, const int LDX, int *INFO) const
 Epetra_LAPACK solve (after factorization) for general matrix (SGETRS) More...
 
void GETRS (const char TRANS, const int N, const int NRHS, const double *A, const int LDA, const int *IPIV, double *X, const int LDX, int *INFO) const
 Epetra_LAPACK solve (after factorization) for general matrix (DGETRS) More...
 
void GETRI (const int N, float *A, const int LDA, int *IPIV, float *WORK, const int *LWORK, int *INFO) const
 Epetra_LAPACK inversion for general matrix (SGETRI) More...
 
void GETRI (const int N, double *A, const int LDA, int *IPIV, double *WORK, const int *LWORK, int *INFO) const
 Epetra_LAPACK inversion for general matrix (DGETRI) More...
 
void GECON (const char NORM, const int N, const float *A, const int LDA, const float ANORM, float *RCOND, float *WORK, int *IWORK, int *INFO) const
 Epetra_LAPACK condition number estimator for general matrix (SGECON) More...
 
void GECON (const char NORM, const int N, const double *A, const int LDA, const double ANORM, double *RCOND, double *WORK, int *IWORK, int *INFO) const
 Epetra_LAPACK condition number estimator for general matrix (DGECON) More...
 
void GESV (const int N, const int NRHS, float *A, const int LDA, int *IPIV, float *X, const int LDX, int *INFO) const
 Epetra_LAPACK factor and solve for general matrix (SGESV) More...
 
void GESV (const int N, const int NRHS, double *A, const int LDA, int *IPIV, double *X, const int LDX, int *INFO) const
 Epetra_LAPACK factor and solve for general matrix (DGESV) More...
 
void GEEQU (const int M, const int N, const float *A, const int LDA, float *R, float *C, float *ROWCND, float *COLCND, float *AMAX, int *INFO) const
 Epetra_LAPACK equilibration for general matrix (SGEEQU) More...
 
void GEEQU (const int M, const int N, const double *A, const int LDA, double *R, double *C, double *ROWCND, double *COLCND, double *AMAX, int *INFO) const
 Epetra_LAPACK equilibration for general matrix (DGEEQU) More...
 
void GERFS (const char TRANS, const int N, const int NRHS, const float *A, const int LDA, const float *AF, const int LDAF, const int *IPIV, const float *B, const int LDB, float *X, const int LDX, float *FERR, float *BERR, float *WORK, int *IWORK, int *INFO) const
 Epetra_LAPACK Refine solution (GERFS) More...
 
void GERFS (const char TRANS, const int N, const int NRHS, const double *A, const int LDA, const double *AF, const int LDAF, const int *IPIV, const double *B, const int LDB, double *X, const int LDX, double *FERR, double *BERR, double *WORK, int *IWORK, int *INFO) const
 Epetra_LAPACK Refine solution (GERFS) More...
 
void GESVX (const char FACT, const char TRANS, const int N, const int NRHS, float *A, const int LDA, float *AF, const int LDAF, int *IPIV, const char EQUED, float *R, float *C, float *B, const int LDB, float *X, const int LDX, float *RCOND, float *FERR, float *BERR, float *WORK, int *IWORK, int *INFO) const
 Epetra_LAPACK solve driver for general matrix (SGESVX) More...
 
void GESVX (const char FACT, const char TRANS, const int N, const int NRHS, double *A, const int LDA, double *AF, const int LDAF, int *IPIV, const char EQUED, double *R, double *C, double *B, const int LDB, double *X, const int LDX, double *RCOND, double *FERR, double *BERR, double *WORK, int *IWORK, int *INFO) const
 Epetra_LAPACK solve driver for general matrix (DGESVX) More...
 
void GEHRD (const int N, const int ILO, const int IHI, float *A, const int LDA, float *TAU, float *WORK, const int LWORK, int *INFO) const
 Epetra_LAPACK wrapper for reduction to Hessenberg form (SGEHRD) More...
 
void GEHRD (const int N, const int ILO, const int IHI, double *A, const int LDA, double *TAU, double *WORK, const int LWORK, int *INFO) const
 Epetra_LAPACK wrapper for reduction to Hessenberg form (DGEHRD) More...
 

Hessenberg routines

void HSEQR (const char JOB, const char COMPZ, const int N, const int ILO, const int IHI, float *H, const int LDH, float *WR, float *WI, float *Z, const int LDZ, float *WORK, const int LWORK, int *INFO) const
 Epetra_LAPACK wrapper for computing the eigenvalues of a real upper Hessenberg matrix (SHSEQR) More...
 
void HSEQR (const char JOB, const char COMPZ, const int N, const int ILO, const int IHI, double *H, const int LDH, double *WR, double *WI, double *Z, const int LDZ, double *WORK, const int LWORK, int *INFO) const
 Epetra_LAPACK wrapper for computing the eigenvalues of a real upper Hessenberg matrix (DHSEQR) More...
 

Orthogonal matrix routines

void ORGQR (const int M, const int N, const int K, float *A, const int LDA, float *TAU, float *WORK, const int LWORK, int *INFO) const
 Epetra_LAPACK wrapper for generating a m x n real matrix Q with orthonormal columns, defined as the product of k elementary reflectors. (SORGQR) More...
 
void ORGQR (const int M, const int N, const int K, double *A, const int LDA, double *TAU, double *WORK, const int LWORK, int *INFO) const
 Epetra_LAPACK wrapper for generating a m x n real matrix Q with orthonormal columns, defined as the product of k elementary reflectors. (DORGQR) More...
 
void ORGHR (const int N, const int ILO, const int IHI, float *A, const int LDA, float *TAU, float *WORK, const int LWORK, int *INFO) const
 Epetra_LAPACK wrapper for generating a real orthogonal matrix Q defined by elementary reflectors. (SORGHR) More...
 
void ORGHR (const int N, const int ILO, const int IHI, double *A, const int LDA, double *TAU, double *WORK, const int LWORK, int *INFO) const
 Epetra_LAPACK wrapper for generating a real orthogonal matrix Q defined by elementary reflectors. (DORGHR) More...
 
void ORMHR (const char SIDE, const char TRANS, const int M, const int N, const int ILO, const int IHI, const float *A, const int LDA, const float *TAU, float *C, const int LDC, float *WORK, const int LWORK, int *INFO) const
 Epetra_LAPACK wrapper for applying an orthogonal matrix in-place (SORMHR) More...
 
void ORMHR (const char SIDE, const char TRANS, const int M, const int N, const int ILO, const int IHI, const double *A, const int LDA, const double *TAU, double *C, const int LDC, double *WORK, const int LWORK, int *INFO) const
 Epetra_LAPACK wrapper for applying an orthogonal matrix in-place (DORMHR) More...
 
void LARFT (const char DIRECT, const char STOREV, const int N, const int K, double *V, const int LDV, double *TAU, double *T, const int LDT) const
 Epetra_LAPACK for forming the triangular factor of a product of elementary Householder reflectors (SLARFT). More...
 
void LARFT (const char DIRECT, const char STOREV, const int N, const int K, float *V, const int LDV, float *TAU, float *T, const int LDT) const
 Epetra_LAPACK for forming the triangular factor of a product of elementary Householder reflectors (DLARFT). More...
 

Triangular matrix routines

void TREVC (const char SIDE, const char HOWMNY, int *SELECT, const int N, const float *T, const int LDT, float *VL, const int LDVL, float *VR, const int LDVR, const int MM, int *M, float *WORK, int *INFO) const
 Epetra_LAPACK wrapper for computing eigenvectors of a quasi-triangular/triagnular matrix (STREVC) More...
 
void TREVC (const char SIDE, const char HOWMNY, int *SELECT, const int N, const double *T, const int LDT, double *VL, const int LDVL, double *VR, const int LDVR, const int MM, int *M, double *WORK, int *INFO) const
 Epetra_LAPACK wrapper for computing eigenvectors of a quasi-triangular/triagnular matrix (DTREVC) More...
 
void TREXC (const char COMPQ, const int N, float *T, const int LDT, float *Q, const int LDQ, int IFST, int ILST, float *WORK, int *INFO) const
 Epetra_LAPACK wrapper for reordering the real-Schur/Schur factorization of a matrix (STREXC) More...
 
void TREXC (const char COMPQ, const int N, double *T, const int LDT, double *Q, const int LDQ, int IFST, int ILST, double *WORK, int *INFO) const
 Epetra_LAPACK wrapper for reordering the real-Schur/Schur factorization of a matrix (DTREXC) More...
 

Singular Value Decomposition matrix routines

void GESVD (const char JOBU, const char JOBVT, const int M, const int N, float *A, const int LDA, float *S, float *U, const int LDU, float *VT, const int LDVT, float *WORK, const int *LWORK, int *INFO) const
 Epetra_LAPACK wrapper for computing the singular value decomposition (SGESVD) More...
 
void GESVD (const char JOBU, const char JOBVT, const int M, const int N, double *A, const int LDA, double *S, double *U, const int LDU, double *VT, const int LDVT, double *WORK, const int *LWORK, int *INFO) const
 Epetra_LAPACK wrapper for computing the singular value decomposition (DGESVD) More...
 
void GGSVD (const char JOBU, const char JOBV, const char JOBQ, const int M, const int N, const int P, int *K, int *L, double *A, const int LDA, double *B, const int LDB, double *ALPHA, double *BETA, double *U, const int LDU, double *V, const int LDV, double *Q, const int LDQ, double *WORK, int *IWORK, int *INFO) const
 Epetra_LAPACK wrapper to compute the generalized singular value decomposition (GSVD) of an M-by-N real matrix A and P-by-N real matrix B. More...
 
void GGSVD (const char JOBU, const char JOBV, const char JOBQ, const int M, const int N, const int P, int *K, int *L, float *A, const int LDA, float *B, const int LDB, float *ALPHA, float *BETA, float *U, const int LDU, float *V, const int LDV, float *Q, const int LDQ, float *WORK, int *IWORK, int *INFO) const
 Epetra_LAPACK wrapper to compute the generalized singular value decomposition (GSVD) of an M-by-N real matrix A and P-by-N real matrix B. More...
 

Eigenvalue/Eigenvector routines

void GEEV (const char JOBVL, const char JOBVR, const int N, double *A, const int LDA, double *WR, double *WI, double *VL, const int LDVL, double *VR, const int LDVR, double *WORK, const int LWORK, int *INFO) const
 Epetra_LAPACK wrapper to compute for an N-by-N real nonsymmetric matrix A, the eigenvalues and, optionally, the left and/or right eigenvectors. More...
 
void GEEV (const char JOBVL, const char JOBVR, const int N, float *A, const int LDA, float *WR, float *WI, float *VL, const int LDVL, float *VR, const int LDVR, float *WORK, const int LWORK, int *INFO) const
 Epetra_LAPACK wrapper to compute for an N-by-N real nonsymmetric matrix A, the eigenvalues and, optionally, the left and/or right eigenvectors. More...
 
void SPEV (const char JOBZ, const char UPLO, const int N, double *AP, double *W, double *Z, int LDZ, double *WORK, int *INFO) const
 Epetra_LAPACK wrapper to compute all the eigenvalues and, optionally, eigenvectors of a real symmetric matrix A in packed storage. More...
 
void SPEV (const char JOBZ, const char UPLO, const int N, float *AP, float *W, float *Z, int LDZ, float *WORK, int *INFO) const
 Epetra_LAPACK wrapper to compute all the eigenvalues and, optionally, eigenvectors of a real symmetric matrix A in packed storage. More...
 
void SPGV (const int ITYPE, const char JOBZ, const char UPLO, const int N, double *AP, double *BP, double *W, double *Z, const int LDZ, double *WORK, int *INFO) const
 Epetra_LAPACK wrapper to compute all the eigenvalues and, optionally, the eigenvectors of a real generalized symmetric-definite eigenproblem, of the form A*x=(lambda)*B*x, A*Bx=(lambda)*x, or B*A*x=(lambda)*x. More...
 
void SPGV (const int ITYPE, const char JOBZ, const char UPLO, const int N, float *AP, float *BP, float *W, float *Z, const int LDZ, float *WORK, int *INFO) const
 Epetra_LAPACK wrapper to compute all the eigenvalues and, optionally, the eigenvectors of a real generalized symmetric-definite eigenproblem, of the form A*x=(lambda)*B*x, A*Bx=(lambda)*x, or B*A*x=(lambda)*x. More...
 
void SYEV (const char JOBZ, const char UPLO, const int N, double *A, const int LDA, double *W, double *WORK, const int LWORK, int *INFO) const
 Epetra_LAPACK wrapper to compute all eigenvalues and, optionally, eigenvectors of a real symmetric matrix A. More...
 
void SYEV (const char JOBZ, const char UPLO, const int N, float *A, const int LDA, float *W, float *WORK, const int LWORK, int *INFO) const
 Epetra_LAPACK wrapper to compute all eigenvalues and, optionally, eigenvectors of a real symmetric matrix A. More...
 
void SYEVD (const char JOBZ, const char UPLO, const int N, double *A, const int LDA, double *W, double *WORK, const int LWORK, int *IWORK, const int LIWORK, int *INFO) const
 Epetra_LAPACK wrapper to compute all eigenvalues and, optionally, eigenvectors of a real symmetric matrix A. More...
 
void SYEVD (const char JOBZ, const char UPLO, const int N, float *A, const int LDA, float *W, float *WORK, const int LWORK, int *IWORK, const int LIWORK, int *INFO) const
 Epetra_LAPACK wrapper to compute all eigenvalues and, optionally, eigenvectors of a real symmetric matrix A. More...
 
void SYEVX (const char JOBZ, const char RANGE, const char UPLO, const int N, double *A, const int LDA, const double *VL, const double *VU, const int *IL, const int *IU, const double ABSTOL, int *M, double *W, double *Z, const int LDZ, double *WORK, const int LWORK, int *IWORK, int *IFAIL, int *INFO) const
 Epetra_LAPACK wrapper to compute selected eigenvalues and, optionally, eigenvectors of a real symmetric matrix A. More...
 
void SYEVX (const char JOBZ, const char RANGE, const char UPLO, const int N, float *A, const int LDA, const float *VL, const float *VU, const int *IL, const int *IU, const float ABSTOL, int *M, float *W, float *Z, const int LDZ, float *WORK, const int LWORK, int *IWORK, int *IFAIL, int *INFO) const
 Epetra_LAPACK wrapper to compute selected eigenvalues and, optionally, eigenvectors of a real symmetric matrix A. More...
 
void SYGV (const int ITYPE, const char JOBZ, const char UPLO, const int N, double *A, const int LDA, double *B, const int LDB, double *W, double *WORK, const int LWORK, int *INFO) const
 Epetra_LAPACK wrapper to compute all the eigenvalues, and optionally, the eigenvectors of a real generalized symmetric-definite eigenproblem, of the form A*x=(lambda)*B*x, A*Bx=(lambda)*x, or B*A*x=(lambda)*x. More...
 
void SYGV (const int ITYPE, const char JOBZ, const char UPLO, const int N, float *A, const int LDA, float *B, const int LDB, float *W, float *WORK, const int LWORK, int *INFO) const
 Epetra_LAPACK wrapper to compute all the eigenvalues, and optionally, the eigenvectors of a real generalized symmetric-definite eigenproblem, of the form A*x=(lambda)*B*x, A*Bx=(lambda)*x, or B*A*x=(lambda)*x. More...
 
void SYGVX (const int ITYPE, const char JOBZ, const char RANGE, const char UPLO, const int N, double *A, const int LDA, double *B, const int LDB, const double *VL, const double *VU, const int *IL, const int *IU, const double ABSTOL, int *M, double *W, double *Z, const int LDZ, double *WORK, const int LWORK, int *IWORK, int *IFAIL, int *INFO) const
 Epetra_LAPACK wrapper to compute selected eigenvalues, and optionally, eigenvectors of a real generalized symmetric-definite eigenproblem, of the form A*x=(lambda)*B*x, A*Bx=(lambda)*x, or B*A*x=(lambda)*x. More...
 
void SYGVX (const int ITYPE, const char JOBZ, const char RANGE, const char UPLO, const int N, float *A, const int LDA, float *B, const int LDB, const float *VL, const float *VU, const int *IL, const int *IU, const float ABSTOL, int *M, float *W, float *Z, const int LDZ, float *WORK, const int LWORK, int *IWORK, int *IFAIL, int *INFO) const
 Epetra_LAPACK wrapper to compute selected eigenvalues, and optionally, eigenvectors of a real generalized symmetric-definite eigenproblem, of the form A*x=(lambda)*B*x, A*Bx=(lambda)*x, or B*A*x=(lambda)*x. More...
 
void SYEVR (const char JOBZ, const char RANGE, const char UPLO, const int N, double *A, const int LDA, const double *VL, const double *VU, const int *IL, const int *IU, const double ABSTOL, int *M, double *W, double *Z, const int LDZ, int *ISUPPZ, double *WORK, const int LWORK, int *IWORK, const int LIWORK, int *INFO) const
 Epetra_LAPACK wrapper to compute selected eigenvalues and, optionally, eigenvectors of a real symmetric matrix T. More...
 
void SYEVR (const char JOBZ, const char RANGE, const char UPLO, const int N, float *A, const int LDA, const float *VL, const float *VU, const int *IL, const int *IU, const float ABSTOL, int *M, float *W, float *Z, const int LDZ, int *ISUPPZ, float *WORK, const int LWORK, int *IWORK, const int LIWORK, int *INFO) const
 Epetra_LAPACK wrapper to compute selected eigenvalues and, optionally, eigenvectors of a real symmetric matrix T. More...
 
void GEEVX (const char BALANC, const char JOBVL, const char JOBVR, const char SENSE, const int N, double *A, const int LDA, double *WR, double *WI, double *VL, const int LDVL, double *VR, const int LDVR, int *ILO, int *IHI, double *SCALE, double *ABNRM, double *RCONDE, double *RCONDV, double *WORK, const int LWORK, int *IWORK, int *INFO) const
 Epetra_LAPACK wrapper to compute for an N-by-N real nonsymmetric matrix A, the eigenvalues and, optionally, the left and/or right eigenvectors. More...
 
void GEEVX (const char BALANC, const char JOBVL, const char JOBVR, const char SENSE, const int N, float *A, const int LDA, float *WR, float *WI, float *VL, const int LDVL, float *VR, const int LDVR, int *ILO, int *IHI, float *SCALE, float *ABNRM, float *RCONDE, float *RCONDV, float *WORK, const int LWORK, int *IWORK, int *INFO) const
 Epetra_LAPACK wrapper to compute for an N-by-N real nonsymmetric matrix A, the eigenvalues and, optionally, the left and/or right eigenvectors. More...
 
void GESDD (const char JOBZ, const int M, const int N, double *A, const int LDA, double *S, double *U, const int LDU, double *VT, const int LDVT, double *WORK, const int LWORK, int *IWORK, int *INFO) const
 Epetra_LAPACK wrapper to compute the singular value decomposition (SVD) of a real M-by-N matrix A, optionally computing the left and right singular vectors. More...
 
void GESDD (const char JOBZ, const int M, const int N, float *A, const int LDA, float *S, float *U, const int LDU, float *VT, const int LDVT, float *WORK, const int LWORK, int *IWORK, int *INFO) const
 Epetra_LAPACK wrapper to. More...
 
void GGEV (const char JOBVL, const char JOBVR, const int N, double *A, const int LDA, double *B, const int LDB, double *ALPHAR, double *ALPHAI, double *BETA, double *VL, const int LDVL, double *VR, const int LDVR, double *WORK, const int LWORK, int *INFO) const
 Epetra_LAPACK wrapper to compute for a pair of N-by-N real nonsymmetric matrices (A,B) the generalized eigenvalues, and optionally, the left and/or right generalized eigenvectors. More...
 
void GGEV (const char JOBVL, const char JOBVR, const int N, float *A, const int LDA, float *B, const int LDB, float *ALPHAR, float *ALPHAI, float *BETA, float *VL, const int LDVL, float *VR, const int LDVR, float *WORK, const int LWORK, int *INFO) const
 Epetra_LAPACK wrapper to compute for a pair of N-by-N real nonsymmetric matrices (A,B) the generalized eigenvalues, and optionally, the left and/or right generalized eigenvectors. More...
 

Linear Least Squares

void GGLSE (const int M, const int N, const int P, double *A, const int LDA, double *B, const int LDB, double *C, double *D, double *X, double *WORK, const int LWORK, int *INFO) const
 Epetra_LAPACK wrapper to solve the linear equality-constrained least squares (LSE) problem. More...
 
void GGLSE (const int M, const int N, const int P, float *A, const int LDA, float *B, const int LDB, float *C, float *D, float *X, float *WORK, const int LWORK, int *INFO) const
 Epetra_LAPACK wrapper to solve the linear equality-constrained least squares (LSE) problem. More...
 

Machine characteristics routines

void LAMCH (const char CMACH, float &T) const
 Epetra_LAPACK wrapper for DLAMCH routine. On out, T holds machine double precision floating point characteristics. This information is returned by the Lapack routine. More...
 
void LAMCH (const char CMACH, double &T) const
 Epetra_LAPACK wrapper for SLAMCH routine. On out, T holds machine single precision floating point characteristics. This information is returned by the Lapack routine. More...
 

Triangular solve

void TRTRS (const char UPLO, const char TRANS, const char DIAG, const int N, const int NRHS, const float *A, const int LDA, float *B, const int LDB, int *INFO) const
 Epetra_LAPACK wrapper for TRTRS routine. More...
 
void TRTRS (const char UPLO, const char TRANS, const char DIAG, const int N, const int NRHS, const double *A, const int LDA, double *B, const int LDB, int *INFO) const
 Epetra_LAPACK wrapper for TRTRS routine. More...
 

Detailed Description

Epetra_LAPACK: The Epetra LAPACK Wrapper Class.

The Epetra_LAPACK class is a wrapper that encapsulates LAPACK (Linear Algebra Package). LAPACK provides portable, high- performance implementations of linear, eigen, SVD, etc solvers.

The standard LAPACK interface is Fortran-specific. Unfortunately, the interface between C++ and Fortran is not standard across all computer platforms. The Epetra_LAPACK class provides C++ wrappers for the LAPACK kernels in order to insulate the rest of Epetra from the details of C++ to Fortran translation. A Epetra_LAPACK object is essentially nothing, but allows access to the LAPACK wrapper functions.

Epetra_LAPACK is a serial interface only. This is appropriate since the standard LAPACK are only specified for serial execution (or shared memory parallel).

Definition at line 67 of file Epetra_LAPACK.h.

Constructor & Destructor Documentation

Epetra_LAPACK::Epetra_LAPACK ( void  )
inline

Epetra_LAPACK Constructor.

Builds an instance of a serial LAPACK object.

Definition at line 425 of file Epetra_LAPACK.h.

Epetra_LAPACK::Epetra_LAPACK ( const Epetra_LAPACK LAPACK)
inline

Epetra_LAPACK Copy Constructor.

Makes an exact copy of an existing Epetra_LAPACK instance.

Definition at line 427 of file Epetra_LAPACK.h.

Epetra_LAPACK::~Epetra_LAPACK ( void  )
inlinevirtual

Epetra_LAPACK Destructor.

Definition at line 429 of file Epetra_LAPACK.h.

Member Function Documentation

void Epetra_LAPACK::POTRF ( const char  UPLO,
const int  N,
float *  A,
const int  LDA,
int *  INFO 
) const

Epetra_LAPACK factorization for positive definite matrix (SPOTRF)

Definition at line 59 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::POTRF ( const char  UPLO,
const int  N,
double *  A,
const int  LDA,
int *  INFO 
) const

Epetra_LAPACK factorization for positive definite matrix (DPOTRF)

Definition at line 63 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::POTRS ( const char  UPLO,
const int  N,
const int  NRHS,
const float *  A,
const int  LDA,
float *  X,
const int  LDX,
int *  INFO 
) const

Epetra_LAPACK solve (after factorization) for positive definite matrix (SPOTRS)

Definition at line 67 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::POTRS ( const char  UPLO,
const int  N,
const int  NRHS,
const double *  A,
const int  LDA,
double *  X,
const int  LDX,
int *  INFO 
) const

Epetra_LAPACK solve (after factorization) for positive definite matrix (DPOTRS)

Definition at line 72 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::POTRI ( const char  UPLO,
const int  N,
float *  A,
const int  LDA,
int *  INFO 
) const

Epetra_LAPACK inversion for positive definite matrix (SPOTRI)

Definition at line 77 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::POTRI ( const char  UPLO,
const int  N,
double *  A,
const int  LDA,
int *  INFO 
) const

Epetra_LAPACK inversion for positive definite matrix (DPOTRI)

Definition at line 81 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::POCON ( const char  UPLO,
const int  N,
const float *  A,
const int  LDA,
const float  ANORM,
float *  RCOND,
float *  WORK,
int *  IWORK,
int *  INFO 
) const

Epetra_LAPACK condition number estimator for positive definite matrix (SPOCON)

Definition at line 85 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::POCON ( const char  UPLO,
const int  N,
const double *  A,
const int  LDA,
const double  ANORM,
double *  RCOND,
double *  WORK,
int *  IWORK,
int *  INFO 
) const

Epetra_LAPACK condition number estimator for positive definite matrix (DPOCON)

Definition at line 91 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::POSV ( const char  UPLO,
const int  N,
const int  NRHS,
float *  A,
const int  LDA,
float *  X,
const int  LDX,
int *  INFO 
) const

Epetra_LAPACK factor and solve for positive definite matrix (SPOSV)

Definition at line 97 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::POSV ( const char  UPLO,
const int  N,
const int  NRHS,
double *  A,
const int  LDA,
double *  X,
const int  LDX,
int *  INFO 
) const

Epetra_LAPACK factor and solve for positive definite matrix (DPOSV)

Definition at line 102 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::POEQU ( const int  N,
const float *  A,
const int  LDA,
float *  S,
float *  SCOND,
float *  AMAX,
int *  INFO 
) const

Epetra_LAPACK equilibration for positive definite matrix (SPOEQU)

Definition at line 107 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::POEQU ( const int  N,
const double *  A,
const int  LDA,
double *  S,
double *  SCOND,
double *  AMAX,
int *  INFO 
) const

Epetra_LAPACK equilibration for positive definite matrix (DPOEQU)

Definition at line 112 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::PORFS ( const char  UPLO,
const int  N,
const int  NRHS,
const float *  A,
const int  LDA,
const float *  AF,
const int  LDAF,
const float *  B,
const int  LDB,
float *  X,
const int  LDX,
float *  FERR,
float *  BERR,
float *  WORK,
int *  IWORK,
int *  INFO 
) const

Epetra_LAPACK solve driver for positive definite matrix (SPOSVX)

Definition at line 117 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::PORFS ( const char  UPLO,
const int  N,
const int  NRHS,
const double *  A,
const int  LDA,
const double *  AF,
const int  LDAF,
const double *  B,
const int  LDB,
double *  X,
const int  LDX,
double *  FERR,
double *  BERR,
double *  WORK,
int *  IWORK,
int *  INFO 
) const

Epetra_LAPACK solve driver for positive definite matrix (DPOSVX)

Definition at line 124 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::POSVX ( const char  FACT,
const char  UPLO,
const int  N,
const int  NRHS,
float *  A,
const int  LDA,
float *  AF,
const int  LDAF,
const char  EQUED,
float *  S,
float *  B,
const int  LDB,
float *  X,
const int  LDX,
float *  RCOND,
float *  FERR,
float *  BERR,
float *  WORK,
int *  IWORK,
int *  INFO 
) const

Epetra_LAPACK solve driver for positive definite matrix (SPOSVX)

Definition at line 131 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::POSVX ( const char  FACT,
const char  UPLO,
const int  N,
const int  NRHS,
double *  A,
const int  LDA,
double *  AF,
const int  LDAF,
const char  EQUED,
double *  S,
double *  B,
const int  LDB,
double *  X,
const int  LDX,
double *  RCOND,
double *  FERR,
double *  BERR,
double *  WORK,
int *  IWORK,
int *  INFO 
) const

Epetra_LAPACK solve driver for positive definite matrix (DPOSVX)

Definition at line 138 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::GELS ( const char  TRANS,
const int  M,
const int  N,
const int  NRHS,
double *  A,
const int  LDA,
double *  B,
const int  LDB,
double *  WORK,
const int  LWORK,
int *  INFO 
) const

Epetra_LAPACK simple driver to solve least-squares systems.

Definition at line 147 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::GETRF ( const int  M,
const int  N,
float *  A,
const int  LDA,
int *  IPIV,
int *  INFO 
) const

Epetra_LAPACK factorization for general matrix (SGETRF)

Definition at line 154 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::GETRF ( const int  M,
const int  N,
double *  A,
const int  LDA,
int *  IPIV,
int *  INFO 
) const

Epetra_LAPACK factorization for general matrix (DGETRF)

Definition at line 158 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::GEQRF ( const int  M,
const int  N,
float *  A,
const int  LDA,
float *  TAU,
float *  WORK,
const int  lwork,
int *  INFO 
) const

Epetra_LAPACK QR factorization for general matrix (SGEQRF)

Definition at line 162 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::GEQRF ( const int  M,
const int  N,
double *  A,
const int  LDA,
double *  TAU,
double *  WORK,
const int  lwork,
int *  INFO 
) const

Epetra_LAPACK factorization for general matrix (DGEQRF)

Definition at line 166 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::GETRS ( const char  TRANS,
const int  N,
const int  NRHS,
const float *  A,
const int  LDA,
const int *  IPIV,
float *  X,
const int  LDX,
int *  INFO 
) const

Epetra_LAPACK solve (after factorization) for general matrix (SGETRS)

Definition at line 186 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::GETRS ( const char  TRANS,
const int  N,
const int  NRHS,
const double *  A,
const int  LDA,
const int *  IPIV,
double *  X,
const int  LDX,
int *  INFO 
) const

Epetra_LAPACK solve (after factorization) for general matrix (DGETRS)

Definition at line 191 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::GETRI ( const int  N,
float *  A,
const int  LDA,
int *  IPIV,
float *  WORK,
const int *  LWORK,
int *  INFO 
) const

Epetra_LAPACK inversion for general matrix (SGETRI)

Definition at line 196 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::GETRI ( const int  N,
double *  A,
const int  LDA,
int *  IPIV,
double *  WORK,
const int *  LWORK,
int *  INFO 
) const

Epetra_LAPACK inversion for general matrix (DGETRI)

Definition at line 201 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::GECON ( const char  NORM,
const int  N,
const float *  A,
const int  LDA,
const float  ANORM,
float *  RCOND,
float *  WORK,
int *  IWORK,
int *  INFO 
) const

Epetra_LAPACK condition number estimator for general matrix (SGECON)

Definition at line 206 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::GECON ( const char  NORM,
const int  N,
const double *  A,
const int  LDA,
const double  ANORM,
double *  RCOND,
double *  WORK,
int *  IWORK,
int *  INFO 
) const

Epetra_LAPACK condition number estimator for general matrix (DGECON)

Definition at line 212 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::GESV ( const int  N,
const int  NRHS,
float *  A,
const int  LDA,
int *  IPIV,
float *  X,
const int  LDX,
int *  INFO 
) const

Epetra_LAPACK factor and solve for general matrix (SGESV)

Definition at line 218 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::GESV ( const int  N,
const int  NRHS,
double *  A,
const int  LDA,
int *  IPIV,
double *  X,
const int  LDX,
int *  INFO 
) const

Epetra_LAPACK factor and solve for general matrix (DGESV)

Definition at line 223 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::GEEQU ( const int  M,
const int  N,
const float *  A,
const int  LDA,
float *  R,
float *  C,
float *  ROWCND,
float *  COLCND,
float *  AMAX,
int *  INFO 
) const

Epetra_LAPACK equilibration for general matrix (SGEEQU)

Definition at line 228 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::GEEQU ( const int  M,
const int  N,
const double *  A,
const int  LDA,
double *  R,
double *  C,
double *  ROWCND,
double *  COLCND,
double *  AMAX,
int *  INFO 
) const

Epetra_LAPACK equilibration for general matrix (DGEEQU)

Definition at line 233 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::GERFS ( const char  TRANS,
const int  N,
const int  NRHS,
const float *  A,
const int  LDA,
const float *  AF,
const int  LDAF,
const int *  IPIV,
const float *  B,
const int  LDB,
float *  X,
const int  LDX,
float *  FERR,
float *  BERR,
float *  WORK,
int *  IWORK,
int *  INFO 
) const

Epetra_LAPACK Refine solution (GERFS)

Definition at line 238 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::GERFS ( const char  TRANS,
const int  N,
const int  NRHS,
const double *  A,
const int  LDA,
const double *  AF,
const int  LDAF,
const int *  IPIV,
const double *  B,
const int  LDB,
double *  X,
const int  LDX,
double *  FERR,
double *  BERR,
double *  WORK,
int *  IWORK,
int *  INFO 
) const

Epetra_LAPACK Refine solution (GERFS)

Definition at line 245 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::GESVX ( const char  FACT,
const char  TRANS,
const int  N,
const int  NRHS,
float *  A,
const int  LDA,
float *  AF,
const int  LDAF,
int *  IPIV,
const char  EQUED,
float *  R,
float *  C,
float *  B,
const int  LDB,
float *  X,
const int  LDX,
float *  RCOND,
float *  FERR,
float *  BERR,
float *  WORK,
int *  IWORK,
int *  INFO 
) const

Epetra_LAPACK solve driver for general matrix (SGESVX)

Definition at line 252 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::GESVX ( const char  FACT,
const char  TRANS,
const int  N,
const int  NRHS,
double *  A,
const int  LDA,
double *  AF,
const int  LDAF,
int *  IPIV,
const char  EQUED,
double *  R,
double *  C,
double *  B,
const int  LDB,
double *  X,
const int  LDX,
double *  RCOND,
double *  FERR,
double *  BERR,
double *  WORK,
int *  IWORK,
int *  INFO 
) const

Epetra_LAPACK solve driver for general matrix (DGESVX)

Definition at line 259 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::GEHRD ( const int  N,
const int  ILO,
const int  IHI,
float *  A,
const int  LDA,
float *  TAU,
float *  WORK,
const int  LWORK,
int *  INFO 
) const

Epetra_LAPACK wrapper for reduction to Hessenberg form (SGEHRD)

Definition at line 270 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::GEHRD ( const int  N,
const int  ILO,
const int  IHI,
double *  A,
const int  LDA,
double *  TAU,
double *  WORK,
const int  LWORK,
int *  INFO 
) const

Epetra_LAPACK wrapper for reduction to Hessenberg form (DGEHRD)

Definition at line 275 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::HSEQR ( const char  JOB,
const char  COMPZ,
const int  N,
const int  ILO,
const int  IHI,
float *  H,
const int  LDH,
float *  WR,
float *  WI,
float *  Z,
const int  LDZ,
float *  WORK,
const int  LWORK,
int *  INFO 
) const

Epetra_LAPACK wrapper for computing the eigenvalues of a real upper Hessenberg matrix (SHSEQR)

Definition at line 280 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::HSEQR ( const char  JOB,
const char  COMPZ,
const int  N,
const int  ILO,
const int  IHI,
double *  H,
const int  LDH,
double *  WR,
double *  WI,
double *  Z,
const int  LDZ,
double *  WORK,
const int  LWORK,
int *  INFO 
) const

Epetra_LAPACK wrapper for computing the eigenvalues of a real upper Hessenberg matrix (DHSEQR)

Definition at line 286 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::ORGQR ( const int  M,
const int  N,
const int  K,
float *  A,
const int  LDA,
float *  TAU,
float *  WORK,
const int  LWORK,
int *  INFO 
) const

Epetra_LAPACK wrapper for generating a m x n real matrix Q with orthonormal columns, defined as the product of k elementary reflectors. (SORGQR)

Definition at line 292 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::ORGQR ( const int  M,
const int  N,
const int  K,
double *  A,
const int  LDA,
double *  TAU,
double *  WORK,
const int  LWORK,
int *  INFO 
) const

Epetra_LAPACK wrapper for generating a m x n real matrix Q with orthonormal columns, defined as the product of k elementary reflectors. (DORGQR)

Definition at line 297 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::ORGHR ( const int  N,
const int  ILO,
const int  IHI,
float *  A,
const int  LDA,
float *  TAU,
float *  WORK,
const int  LWORK,
int *  INFO 
) const

Epetra_LAPACK wrapper for generating a real orthogonal matrix Q defined by elementary reflectors. (SORGHR)

Definition at line 302 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::ORGHR ( const int  N,
const int  ILO,
const int  IHI,
double *  A,
const int  LDA,
double *  TAU,
double *  WORK,
const int  LWORK,
int *  INFO 
) const

Epetra_LAPACK wrapper for generating a real orthogonal matrix Q defined by elementary reflectors. (DORGHR)

Definition at line 307 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::ORMHR ( const char  SIDE,
const char  TRANS,
const int  M,
const int  N,
const int  ILO,
const int  IHI,
const float *  A,
const int  LDA,
const float *  TAU,
float *  C,
const int  LDC,
float *  WORK,
const int  LWORK,
int *  INFO 
) const

Epetra_LAPACK wrapper for applying an orthogonal matrix in-place (SORMHR)

Definition at line 312 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::ORMHR ( const char  SIDE,
const char  TRANS,
const int  M,
const int  N,
const int  ILO,
const int  IHI,
const double *  A,
const int  LDA,
const double *  TAU,
double *  C,
const int  LDC,
double *  WORK,
const int  LWORK,
int *  INFO 
) const

Epetra_LAPACK wrapper for applying an orthogonal matrix in-place (DORMHR)

Definition at line 317 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::LARFT ( const char  DIRECT,
const char  STOREV,
const int  N,
const int  K,
double *  V,
const int  LDV,
double *  TAU,
double *  T,
const int  LDT 
) const

Epetra_LAPACK for forming the triangular factor of a product of elementary Householder reflectors (SLARFT).

Definition at line 326 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::LARFT ( const char  DIRECT,
const char  STOREV,
const int  N,
const int  K,
float *  V,
const int  LDV,
float *  TAU,
float *  T,
const int  LDT 
) const

Epetra_LAPACK for forming the triangular factor of a product of elementary Householder reflectors (DLARFT).

Definition at line 322 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::TREVC ( const char  SIDE,
const char  HOWMNY,
int *  SELECT,
const int  N,
const float *  T,
const int  LDT,
float *  VL,
const int  LDVL,
float *  VR,
const int  LDVR,
const int  MM,
int *  M,
float *  WORK,
int *  INFO 
) const

Epetra_LAPACK wrapper for computing eigenvectors of a quasi-triangular/triagnular matrix (STREVC)

Warning
HOWMNY = 'S" is not supported.

Definition at line 330 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::TREVC ( const char  SIDE,
const char  HOWMNY,
int *  SELECT,
const int  N,
const double *  T,
const int  LDT,
double *  VL,
const int  LDVL,
double *  VR,
const int  LDVR,
const int  MM,
int *  M,
double *  WORK,
int *  INFO 
) const

Epetra_LAPACK wrapper for computing eigenvectors of a quasi-triangular/triagnular matrix (DTREVC)

Warning
HOWMNY = 'S" is not supported.

Definition at line 338 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::TREXC ( const char  COMPQ,
const int  N,
float *  T,
const int  LDT,
float *  Q,
const int  LDQ,
int  IFST,
int  ILST,
float *  WORK,
int *  INFO 
) const

Epetra_LAPACK wrapper for reordering the real-Schur/Schur factorization of a matrix (STREXC)

Definition at line 346 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::TREXC ( const char  COMPQ,
const int  N,
double *  T,
const int  LDT,
double *  Q,
const int  LDQ,
int  IFST,
int  ILST,
double *  WORK,
int *  INFO 
) const

Epetra_LAPACK wrapper for reordering the real-Schur/Schur factorization of a matrix (DTREXC)

Definition at line 351 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::GESVD ( const char  JOBU,
const char  JOBVT,
const int  M,
const int  N,
float *  A,
const int  LDA,
float *  S,
float *  U,
const int  LDU,
float *  VT,
const int  LDVT,
float *  WORK,
const int *  LWORK,
int *  INFO 
) const

Epetra_LAPACK wrapper for computing the singular value decomposition (SGESVD)

Definition at line 170 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::GESVD ( const char  JOBU,
const char  JOBVT,
const int  M,
const int  N,
double *  A,
const int  LDA,
double *  S,
double *  U,
const int  LDU,
double *  VT,
const int  LDVT,
double *  WORK,
const int *  LWORK,
int *  INFO 
) const

Epetra_LAPACK wrapper for computing the singular value decomposition (DGESVD)

Definition at line 178 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::GGSVD ( const char  JOBU,
const char  JOBV,
const char  JOBQ,
const int  M,
const int  N,
const int  P,
int *  K,
int *  L,
double *  A,
const int  LDA,
double *  B,
const int  LDB,
double *  ALPHA,
double *  BETA,
double *  U,
const int  LDU,
double *  V,
const int  LDV,
double *  Q,
const int  LDQ,
double *  WORK,
int *  IWORK,
int *  INFO 
) const

Epetra_LAPACK wrapper to compute the generalized singular value decomposition (GSVD) of an M-by-N real matrix A and P-by-N real matrix B.

Definition at line 364 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::GGSVD ( const char  JOBU,
const char  JOBV,
const char  JOBQ,
const int  M,
const int  N,
const int  P,
int *  K,
int *  L,
float *  A,
const int  LDA,
float *  B,
const int  LDB,
float *  ALPHA,
float *  BETA,
float *  U,
const int  LDU,
float *  V,
const int  LDV,
float *  Q,
const int  LDQ,
float *  WORK,
int *  IWORK,
int *  INFO 
) const

Epetra_LAPACK wrapper to compute the generalized singular value decomposition (GSVD) of an M-by-N real matrix A and P-by-N real matrix B.

Definition at line 380 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::GEEV ( const char  JOBVL,
const char  JOBVR,
const int  N,
double *  A,
const int  LDA,
double *  WR,
double *  WI,
double *  VL,
const int  LDVL,
double *  VR,
const int  LDVR,
double *  WORK,
const int  LWORK,
int *  INFO 
) const

Epetra_LAPACK wrapper to compute for an N-by-N real nonsymmetric matrix A, the eigenvalues and, optionally, the left and/or right eigenvectors.

Definition at line 396 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::GEEV ( const char  JOBVL,
const char  JOBVR,
const int  N,
float *  A,
const int  LDA,
float *  WR,
float *  WI,
float *  VL,
const int  LDVL,
float *  VR,
const int  LDVR,
float *  WORK,
const int  LWORK,
int *  INFO 
) const

Epetra_LAPACK wrapper to compute for an N-by-N real nonsymmetric matrix A, the eigenvalues and, optionally, the left and/or right eigenvectors.

Definition at line 403 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::SPEV ( const char  JOBZ,
const char  UPLO,
const int  N,
double *  AP,
double *  W,
double *  Z,
int  LDZ,
double *  WORK,
int *  INFO 
) const

Epetra_LAPACK wrapper to compute all the eigenvalues and, optionally, eigenvectors of a real symmetric matrix A in packed storage.

Definition at line 410 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::SPEV ( const char  JOBZ,
const char  UPLO,
const int  N,
float *  AP,
float *  W,
float *  Z,
int  LDZ,
float *  WORK,
int *  INFO 
) const

Epetra_LAPACK wrapper to compute all the eigenvalues and, optionally, eigenvectors of a real symmetric matrix A in packed storage.

Definition at line 415 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::SPGV ( const int  ITYPE,
const char  JOBZ,
const char  UPLO,
const int  N,
double *  AP,
double *  BP,
double *  W,
double *  Z,
const int  LDZ,
double *  WORK,
int *  INFO 
) const

Epetra_LAPACK wrapper to compute all the eigenvalues and, optionally, the eigenvectors of a real generalized symmetric-definite eigenproblem, of the form A*x=(lambda)*B*x, A*Bx=(lambda)*x, or B*A*x=(lambda)*x.

Definition at line 420 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::SPGV ( const int  ITYPE,
const char  JOBZ,
const char  UPLO,
const int  N,
float *  AP,
float *  BP,
float *  W,
float *  Z,
const int  LDZ,
float *  WORK,
int *  INFO 
) const

Epetra_LAPACK wrapper to compute all the eigenvalues and, optionally, the eigenvectors of a real generalized symmetric-definite eigenproblem, of the form A*x=(lambda)*B*x, A*Bx=(lambda)*x, or B*A*x=(lambda)*x.

Definition at line 425 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::SYEV ( const char  JOBZ,
const char  UPLO,
const int  N,
double *  A,
const int  LDA,
double *  W,
double *  WORK,
const int  LWORK,
int *  INFO 
) const

Epetra_LAPACK wrapper to compute all eigenvalues and, optionally, eigenvectors of a real symmetric matrix A.

Definition at line 430 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::SYEV ( const char  JOBZ,
const char  UPLO,
const int  N,
float *  A,
const int  LDA,
float *  W,
float *  WORK,
const int  LWORK,
int *  INFO 
) const

Epetra_LAPACK wrapper to compute all eigenvalues and, optionally, eigenvectors of a real symmetric matrix A.

Definition at line 436 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::SYEVD ( const char  JOBZ,
const char  UPLO,
const int  N,
double *  A,
const int  LDA,
double *  W,
double *  WORK,
const int  LWORK,
int *  IWORK,
const int  LIWORK,
int *  INFO 
) const

Epetra_LAPACK wrapper to compute all eigenvalues and, optionally, eigenvectors of a real symmetric matrix A.

Definition at line 442 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::SYEVD ( const char  JOBZ,
const char  UPLO,
const int  N,
float *  A,
const int  LDA,
float *  W,
float *  WORK,
const int  LWORK,
int *  IWORK,
const int  LIWORK,
int *  INFO 
) const

Epetra_LAPACK wrapper to compute all eigenvalues and, optionally, eigenvectors of a real symmetric matrix A.

Definition at line 448 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::SYEVX ( const char  JOBZ,
const char  RANGE,
const char  UPLO,
const int  N,
double *  A,
const int  LDA,
const double *  VL,
const double *  VU,
const int *  IL,
const int *  IU,
const double  ABSTOL,
int *  M,
double *  W,
double *  Z,
const int  LDZ,
double *  WORK,
const int  LWORK,
int *  IWORK,
int *  IFAIL,
int *  INFO 
) const

Epetra_LAPACK wrapper to compute selected eigenvalues and, optionally, eigenvectors of a real symmetric matrix A.

Definition at line 454 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::SYEVX ( const char  JOBZ,
const char  RANGE,
const char  UPLO,
const int  N,
float *  A,
const int  LDA,
const float *  VL,
const float *  VU,
const int *  IL,
const int *  IU,
const float  ABSTOL,
int *  M,
float *  W,
float *  Z,
const int  LDZ,
float *  WORK,
const int  LWORK,
int *  IWORK,
int *  IFAIL,
int *  INFO 
) const

Epetra_LAPACK wrapper to compute selected eigenvalues and, optionally, eigenvectors of a real symmetric matrix A.

Definition at line 464 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::SYGV ( const int  ITYPE,
const char  JOBZ,
const char  UPLO,
const int  N,
double *  A,
const int  LDA,
double *  B,
const int  LDB,
double *  W,
double *  WORK,
const int  LWORK,
int *  INFO 
) const

Epetra_LAPACK wrapper to compute all the eigenvalues, and optionally, the eigenvectors of a real generalized symmetric-definite eigenproblem, of the form A*x=(lambda)*B*x, A*Bx=(lambda)*x, or B*A*x=(lambda)*x.

Definition at line 474 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::SYGV ( const int  ITYPE,
const char  JOBZ,
const char  UPLO,
const int  N,
float *  A,
const int  LDA,
float *  B,
const int  LDB,
float *  W,
float *  WORK,
const int  LWORK,
int *  INFO 
) const

Epetra_LAPACK wrapper to compute all the eigenvalues, and optionally, the eigenvectors of a real generalized symmetric-definite eigenproblem, of the form A*x=(lambda)*B*x, A*Bx=(lambda)*x, or B*A*x=(lambda)*x.

Definition at line 480 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::SYGVX ( const int  ITYPE,
const char  JOBZ,
const char  RANGE,
const char  UPLO,
const int  N,
double *  A,
const int  LDA,
double *  B,
const int  LDB,
const double *  VL,
const double *  VU,
const int *  IL,
const int *  IU,
const double  ABSTOL,
int *  M,
double *  W,
double *  Z,
const int  LDZ,
double *  WORK,
const int  LWORK,
int *  IWORK,
int *  IFAIL,
int *  INFO 
) const

Epetra_LAPACK wrapper to compute selected eigenvalues, and optionally, eigenvectors of a real generalized symmetric-definite eigenproblem, of the form A*x=(lambda)*B*x, A*Bx=(lambda)*x, or B*A*x=(lambda)*x.

Definition at line 486 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::SYGVX ( const int  ITYPE,
const char  JOBZ,
const char  RANGE,
const char  UPLO,
const int  N,
float *  A,
const int  LDA,
float *  B,
const int  LDB,
const float *  VL,
const float *  VU,
const int *  IL,
const int *  IU,
const float  ABSTOL,
int *  M,
float *  W,
float *  Z,
const int  LDZ,
float *  WORK,
const int  LWORK,
int *  IWORK,
int *  IFAIL,
int *  INFO 
) const

Epetra_LAPACK wrapper to compute selected eigenvalues, and optionally, eigenvectors of a real generalized symmetric-definite eigenproblem, of the form A*x=(lambda)*B*x, A*Bx=(lambda)*x, or B*A*x=(lambda)*x.

Definition at line 503 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::SYEVR ( const char  JOBZ,
const char  RANGE,
const char  UPLO,
const int  N,
double *  A,
const int  LDA,
const double *  VL,
const double *  VU,
const int *  IL,
const int *  IU,
const double  ABSTOL,
int *  M,
double *  W,
double *  Z,
const int  LDZ,
int *  ISUPPZ,
double *  WORK,
const int  LWORK,
int *  IWORK,
const int  LIWORK,
int *  INFO 
) const

Epetra_LAPACK wrapper to compute selected eigenvalues and, optionally, eigenvectors of a real symmetric matrix T.

Definition at line 520 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::SYEVR ( const char  JOBZ,
const char  RANGE,
const char  UPLO,
const int  N,
float *  A,
const int  LDA,
const float *  VL,
const float *  VU,
const int *  IL,
const int *  IU,
const float  ABSTOL,
int *  M,
float *  W,
float *  Z,
const int  LDZ,
int *  ISUPPZ,
float *  WORK,
const int  LWORK,
int *  IWORK,
const int  LIWORK,
int *  INFO 
) const

Epetra_LAPACK wrapper to compute selected eigenvalues and, optionally, eigenvectors of a real symmetric matrix T.

Definition at line 535 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::GEEVX ( const char  BALANC,
const char  JOBVL,
const char  JOBVR,
const char  SENSE,
const int  N,
double *  A,
const int  LDA,
double *  WR,
double *  WI,
double *  VL,
const int  LDVL,
double *  VR,
const int  LDVR,
int *  ILO,
int *  IHI,
double *  SCALE,
double *  ABNRM,
double *  RCONDE,
double *  RCONDV,
double *  WORK,
const int  LWORK,
int *  IWORK,
int *  INFO 
) const

Epetra_LAPACK wrapper to compute for an N-by-N real nonsymmetric matrix A, the eigenvalues and, optionally, the left and/or right eigenvectors.

Definition at line 550 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::GEEVX ( const char  BALANC,
const char  JOBVL,
const char  JOBVR,
const char  SENSE,
const int  N,
float *  A,
const int  LDA,
float *  WR,
float *  WI,
float *  VL,
const int  LDVL,
float *  VR,
const int  LDVR,
int *  ILO,
int *  IHI,
float *  SCALE,
float *  ABNRM,
float *  RCONDE,
float *  RCONDV,
float *  WORK,
const int  LWORK,
int *  IWORK,
int *  INFO 
) const

Epetra_LAPACK wrapper to compute for an N-by-N real nonsymmetric matrix A, the eigenvalues and, optionally, the left and/or right eigenvectors.

Definition at line 559 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::GESDD ( const char  JOBZ,
const int  M,
const int  N,
double *  A,
const int  LDA,
double *  S,
double *  U,
const int  LDU,
double *  VT,
const int  LDVT,
double *  WORK,
const int  LWORK,
int *  IWORK,
int *  INFO 
) const

Epetra_LAPACK wrapper to compute the singular value decomposition (SVD) of a real M-by-N matrix A, optionally computing the left and right singular vectors.

Definition at line 568 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::GESDD ( const char  JOBZ,
const int  M,
const int  N,
float *  A,
const int  LDA,
float *  S,
float *  U,
const int  LDU,
float *  VT,
const int  LDVT,
float *  WORK,
const int  LWORK,
int *  IWORK,
int *  INFO 
) const

Epetra_LAPACK wrapper to.

Definition at line 581 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::GGEV ( const char  JOBVL,
const char  JOBVR,
const int  N,
double *  A,
const int  LDA,
double *  B,
const int  LDB,
double *  ALPHAR,
double *  ALPHAI,
double *  BETA,
double *  VL,
const int  LDVL,
double *  VR,
const int  LDVR,
double *  WORK,
const int  LWORK,
int *  INFO 
) const

Epetra_LAPACK wrapper to compute for a pair of N-by-N real nonsymmetric matrices (A,B) the generalized eigenvalues, and optionally, the left and/or right generalized eigenvectors.

Definition at line 594 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::GGEV ( const char  JOBVL,
const char  JOBVR,
const int  N,
float *  A,
const int  LDA,
float *  B,
const int  LDB,
float *  ALPHAR,
float *  ALPHAI,
float *  BETA,
float *  VL,
const int  LDVL,
float *  VR,
const int  LDVR,
float *  WORK,
const int  LWORK,
int *  INFO 
) const

Epetra_LAPACK wrapper to compute for a pair of N-by-N real nonsymmetric matrices (A,B) the generalized eigenvalues, and optionally, the left and/or right generalized eigenvectors.

Definition at line 608 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::GGLSE ( const int  M,
const int  N,
const int  P,
double *  A,
const int  LDA,
double *  B,
const int  LDB,
double *  C,
double *  D,
double *  X,
double *  WORK,
const int  LWORK,
int *  INFO 
) const

Epetra_LAPACK wrapper to solve the linear equality-constrained least squares (LSE) problem.

Definition at line 622 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::GGLSE ( const int  M,
const int  N,
const int  P,
float *  A,
const int  LDA,
float *  B,
const int  LDB,
float *  C,
float *  D,
float *  X,
float *  WORK,
const int  LWORK,
int *  INFO 
) const

Epetra_LAPACK wrapper to solve the linear equality-constrained least squares (LSE) problem.

Definition at line 627 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::LAMCH ( const char  CMACH,
float &  T 
) const

Epetra_LAPACK wrapper for DLAMCH routine. On out, T holds machine double precision floating point characteristics. This information is returned by the Lapack routine.

Definition at line 356 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::LAMCH ( const char  CMACH,
double &  T 
) const

Epetra_LAPACK wrapper for SLAMCH routine. On out, T holds machine single precision floating point characteristics. This information is returned by the Lapack routine.

Definition at line 360 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::TRTRS ( const char  UPLO,
const char  TRANS,
const char  DIAG,
const int  N,
const int  NRHS,
const float *  A,
const int  LDA,
float *  B,
const int  LDB,
int *  INFO 
) const

Epetra_LAPACK wrapper for TRTRS routine.

Definition at line 632 of file Epetra_LAPACK.cpp.

void Epetra_LAPACK::TRTRS ( const char  UPLO,
const char  TRANS,
const char  DIAG,
const int  N,
const int  NRHS,
const double *  A,
const int  LDA,
double *  B,
const int  LDB,
int *  INFO 
) const

Epetra_LAPACK wrapper for TRTRS routine.

Definition at line 637 of file Epetra_LAPACK.cpp.


The documentation for this class was generated from the following files: