Epetra Package Browser (Single Doxygen Collection)
Development
|
Epetra_SerialDenseSVD: A class for SVDing dense linear problems. More...
#include <Epetra_SerialDenseSVD.h>
Public Member Functions | |
void | AllocateWORK () |
void | AllocateIWORK () |
void | InitPointers () |
void | DeleteArrays () |
void | ResetMatrix () |
void | ResetVectors () |
Public Member Functions inherited from Epetra_SerialDenseOperator | |
virtual | ~Epetra_SerialDenseOperator () |
Destructor. More... | |
Public Member Functions inherited from Epetra_CompObject | |
Epetra_CompObject & | operator= (const Epetra_CompObject &src) |
Epetra_CompObject () | |
Basic Epetra_CompObject constuctor. More... | |
Epetra_CompObject (const Epetra_CompObject &Source) | |
Epetra_CompObject copy constructor. More... | |
virtual | ~Epetra_CompObject () |
Epetra_CompObject destructor. More... | |
void | SetFlopCounter (const Epetra_Flops &FlopCounter_in) |
Set the internal Epetra_Flops() pointer. More... | |
void | SetFlopCounter (const Epetra_CompObject &CompObject) |
Set the internal Epetra_Flops() pointer to the flop counter of another Epetra_CompObject. More... | |
void | UnsetFlopCounter () |
Set the internal Epetra_Flops() pointer to 0 (no flops counted). More... | |
Epetra_Flops * | GetFlopCounter () const |
Get the pointer to the Epetra_Flops() object associated with this object, returns 0 if none. More... | |
void | ResetFlops () const |
Resets the number of floating point operations to zero for this multi-vector. More... | |
double | Flops () const |
Returns the number of floating point operations with this multi-vector. More... | |
void | UpdateFlops (int Flops_in) const |
Increment Flop count for this object. More... | |
void | UpdateFlops (long int Flops_in) const |
Increment Flop count for this object. More... | |
void | UpdateFlops (long long Flops_in) const |
Increment Flop count for this object. More... | |
void | UpdateFlops (double Flops_in) const |
Increment Flop count for this object. More... | |
void | UpdateFlops (float Flops_in) const |
Increment Flop count for this object. More... | |
Public Member Functions inherited from Epetra_Object | |
Epetra_Object (int TracebackModeIn=-1, bool set_label=true) | |
Epetra_Object Constructor. More... | |
Epetra_Object (const char *const Label, int TracebackModeIn=-1) | |
Epetra_Object Constructor. More... | |
Epetra_Object (const Epetra_Object &Object) | |
Epetra_Object Copy Constructor. More... | |
virtual | ~Epetra_Object () |
Epetra_Object Destructor. More... | |
virtual void | SetLabel (const char *const Label) |
Epetra_Object Label definition using char *. More... | |
virtual int | ReportError (const std::string Message, int ErrorCode) const |
Error reporting method. More... | |
Public Member Functions inherited from Epetra_BLAS | |
Epetra_BLAS (void) | |
Epetra_BLAS Constructor. More... | |
Epetra_BLAS (const Epetra_BLAS &BLAS) | |
Epetra_BLAS Copy Constructor. More... | |
virtual | ~Epetra_BLAS (void) |
Epetra_BLAS Destructor. More... | |
float | ASUM (const int N, const float *X, const int INCX=1) const |
Epetra_BLAS one norm function (SASUM). More... | |
double | ASUM (const int N, const double *X, const int INCX=1) const |
Epetra_BLAS one norm function (DASUM). More... | |
float | DOT (const int N, const float *X, const float *Y, const int INCX=1, const int INCY=1) const |
Epetra_BLAS dot product function (SDOT). More... | |
double | DOT (const int N, const double *X, const double *Y, const int INCX=1, const int INCY=1) const |
Epetra_BLAS dot product function (DDOT). More... | |
float | NRM2 (const int N, const float *X, const int INCX=1) const |
Epetra_BLAS norm function (SNRM2). More... | |
double | NRM2 (const int N, const double *X, const int INCX=1) const |
Epetra_BLAS norm function (DNRM2). More... | |
void | SCAL (const int N, const float ALPHA, float *X, const int INCX=1) const |
Epetra_BLAS vector scale function (SSCAL) More... | |
void | SCAL (const int N, const double ALPHA, double *X, const int INCX=1) const |
Epetra_BLAS vector scale function (DSCAL) More... | |
void | COPY (const int N, const float *X, float *Y, const int INCX=1, const int INCY=1) const |
Epetra_BLAS vector copy function (SCOPY) More... | |
void | COPY (const int N, const double *X, double *Y, const int INCX=1, const int INCY=1) const |
Epetra_BLAS vector scale function (DCOPY) More... | |
int | IAMAX (const int N, const float *X, const int INCX=1) const |
Epetra_BLAS arg maximum of absolute value function (ISAMAX) More... | |
int | IAMAX (const int N, const double *X, const int INCX=1) const |
Epetra_BLAS arg maximum of absolute value function (IDAMAX) More... | |
void | AXPY (const int N, const float ALPHA, const float *X, float *Y, const int INCX=1, const int INCY=1) const |
Epetra_BLAS vector update function (SAXPY) More... | |
void | AXPY (const int N, const double ALPHA, const double *X, double *Y, const int INCX=1, const int INCY=1) const |
Epetra_BLAS vector update function (DAXPY) More... | |
void | GEMV (const char TRANS, const int M, const int N, const float ALPHA, const float *A, const int LDA, const float *X, const float BETA, float *Y, const int INCX=1, const int INCY=1) const |
Epetra_BLAS matrix-vector multiply function (SGEMV) More... | |
void | GEMV (const char TRANS, const int M, const int N, const double ALPHA, const double *A, const int LDA, const double *X, const double BETA, double *Y, const int INCX=1, const int INCY=1) const |
Epetra_BLAS matrix-vector multiply function (DGEMV) More... | |
void | GEMM (const char TRANSA, const char TRANSB, const int M, const int N, const int K, const float ALPHA, const float *A, const int LDA, const float *B, const int LDB, const float BETA, float *C, const int LDC) const |
Epetra_BLAS matrix-matrix multiply function (SGEMM) More... | |
void | GEMM (const char TRANSA, const char TRANSB, const int M, const int N, const int K, const double ALPHA, const double *A, const int LDA, const double *B, const int LDB, const double BETA, double *C, const int LDC) const |
Epetra_BLAS matrix-matrix multiply function (DGEMM) More... | |
void | SYMM (const char SIDE, const char UPLO, const int M, const int N, const float ALPHA, const float *A, const int LDA, const float *B, const int LDB, const float BETA, float *C, const int LDC) const |
Epetra_BLAS symmetric matrix-matrix multiply function (SSYMM) More... | |
void | SYMM (const char SIDE, const char UPLO, const int M, const int N, const double ALPHA, const double *A, const int LDA, const double *B, const int LDB, const double BETA, double *C, const int LDC) const |
Epetra_BLAS matrix-matrix multiply function (DSYMM) More... | |
void | TRMM (const char SIDE, const char UPLO, const char TRANSA, const char DIAG, const int M, const int N, const float ALPHA, const float *A, const int LDA, float *B, const int LDB) const |
Epetra_BLAS triangular matrix-matrix multiply function (STRMM) More... | |
void | TRMM (const char SIDE, const char UPLO, const char TRANSA, const char DIAG, const int M, const int N, const double ALPHA, const double *A, const int LDA, double *B, const int LDB) const |
Epetra_BLAS triangular matrix-matrix multiply function (DTRMM) More... | |
void | SYRK (const char UPLO, const char TRANS, const int N, const int K, const float ALPHA, const float *A, const int LDA, const float BETA, float *C, const int LDC) const |
Eperta_BLAS symetric rank k funtion (ssyrk) More... | |
void | SYRK (const char UPLO, const char TRANS, const int N, const int K, const double ALPHA, const double *A, const int LDA, const double BETA, double *C, const int LDC) const |
Eperta_BLAS symetric rank k funtion (dsyrk) More... | |
Public Member Functions inherited from Epetra_LAPACK | |
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... | |
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... | |
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... | |
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... | |
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... | |
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... | |
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... | |
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... | |
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... | |
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... | |
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... | |
Public Attributes | |
bool | Transpose_ |
bool | Factored_ |
bool | Solved_ |
bool | Inverted_ |
char | TRANS_ |
int | M_ |
int | N_ |
int | Min_MN_ |
int | NRHS_ |
int | LDA_ |
int | LDAI_ |
int | LDB_ |
int | LDX_ |
int | INFO_ |
int | LWORK_ |
int * | IWORK_ |
double | ANORM_ |
Epetra_SerialDenseMatrix * | Matrix_ |
Epetra_SerialDenseMatrix * | LHS_ |
Epetra_SerialDenseMatrix * | RHS_ |
Epetra_SerialDenseMatrix * | Inverse_ |
double * | A_ |
double * | AI_ |
double * | WORK_ |
double * | U_ |
double * | S_ |
double * | Vt_ |
double * | B_ |
double * | X_ |
bool | UseTranspose_ |
Private Member Functions | |
Epetra_SerialDenseSVD (const Epetra_SerialDenseSVD &Source) | |
Epetra_SerialDenseSVD & | operator= (const Epetra_SerialDenseSVD &Source) |
Constructor/Destructor Methods | |
Epetra_SerialDenseSVD () | |
Default constructor; matrix should be set using SetMatrix(), LHS and RHS set with SetVectors(). More... | |
virtual | ~Epetra_SerialDenseSVD () |
Epetra_SerialDenseSVD destructor. More... | |
Set Methods | |
int | SetMatrix (Epetra_SerialDenseMatrix &A) |
Sets the pointers for coefficient matrix. More... | |
int | SetVectors (Epetra_SerialDenseMatrix &X, Epetra_SerialDenseMatrix &B) |
Sets the pointers for left and right hand side vector(s). More... | |
Strategy modifying Methods | |
void | SolveWithTranspose (bool Flag) |
Causes equilibration to be called just before the matrix factorization as part of the call to Factor. More... | |
Factor/Solve/Invert Methods | |
Causes all solves to compute solution to best ability using iterative refinement. | |
virtual int | Factor (void) |
virtual int | Solve (void) |
Computes the solution X to AX = B for the this matrix and the B provided to SetVectors().. More... | |
virtual int | Invert (double rthresh=0.0, double athresh=0.0) |
Inverts the this matrix. More... | |
Query methods | |
bool | Transpose () |
Returns true if transpose of this matrix has and will be used. More... | |
bool | Factored () |
Returns true if matrix is factored (factor available via AF() and LDAF()). More... | |
bool | Inverted () |
Returns true if matrix inverse has been computed (inverse available via AF() and LDAF()). More... | |
bool | Solved () |
Returns true if the current set of vectors has been solved. More... | |
Data Accessor methods | |
Epetra_SerialDenseMatrix * | Matrix () const |
Returns pointer to current matrix. More... | |
Epetra_SerialDenseMatrix * | InvertedMatrix () const |
Returns pointer to inverted matrix (assuming inverse has been performed). More... | |
Epetra_SerialDenseMatrix * | LHS () const |
Returns pointer to current LHS. More... | |
Epetra_SerialDenseMatrix * | RHS () const |
Returns pointer to current RHS. More... | |
int | M () const |
Returns row dimension of system. More... | |
int | N () const |
Returns column dimension of system. More... | |
double * | A () const |
Returns pointer to the this matrix. More... | |
int | LDA () const |
Returns the leading dimension of the this matrix. More... | |
double * | B () const |
Returns pointer to current RHS. More... | |
int | LDB () const |
Returns the leading dimension of the RHS. More... | |
int | NRHS () const |
Returns the number of current right hand sides and solution vectors. More... | |
double * | X () const |
Returns pointer to current solution. More... | |
int | LDX () const |
Returns the leading dimension of the solution. More... | |
double * | S () const |
double * | AI () const |
Returns pointer to the inverted matrix (may be the same as A() if factorization done in place). More... | |
int | LDAI () const |
Returns the leading dimension of the inverted matrix. More... | |
double | ANORM () const |
Returns the 1-Norm of the this matrix (returns -1 if not yet computed). More... | |
I/O methods | |
virtual void | Print (std::ostream &os) const |
Print service methods; defines behavior of ostream << operator. More... | |
Additional methods for support of Epetra_SerialDenseOperator interface | |
virtual int | SetUseTranspose (bool use_transpose) |
If set true, transpose of this operator will be applied. More... | |
virtual int | Apply (const Epetra_SerialDenseMatrix &Xmat, Epetra_SerialDenseMatrix &Ymat) |
Returns the result of a Epetra_SerialDenseOperator applied to a Epetra_SerialDenseMatrix X in Y. More... | |
virtual int | ApplyInverse (const Epetra_SerialDenseMatrix &Xmat, Epetra_SerialDenseMatrix &Ymat) |
Returns the result of a Epetra_SerialDenseOperator inverse applied to an Epetra_SerialDenseMatrix X in Y. More... | |
virtual double | NormInf () const |
Returns the infinity norm of the global matrix. More... | |
virtual const char * | Label () const |
Returns a character string describing the operator. More... | |
virtual bool | UseTranspose () const |
Returns the current UseTranspose setting. More... | |
virtual bool | HasNormInf () const |
Returns true if the this object can provide an approximate Inf-norm, false otherwise. More... | |
virtual int | RowDim () const |
Returns the row dimension of operator. More... | |
virtual int | ColDim () const |
Returns the column dimension of operator. More... | |
Additional Inherited Members | |
Static Public Member Functions inherited from Epetra_Object | |
static void | SetTracebackMode (int TracebackModeValue) |
Set the value of the Epetra_Object error traceback report mode. More... | |
static int | GetTracebackMode () |
Get the value of the Epetra_Object error report mode. More... | |
static std::ostream & | GetTracebackStream () |
Get the output stream for error reporting. More... | |
Static Public Attributes inherited from Epetra_Object | |
static int | TracebackMode |
Protected Member Functions inherited from Epetra_Object | |
std::string | toString (const int &x) const |
std::string | toString (const long long &x) const |
std::string | toString (const double &x) const |
Protected Attributes inherited from Epetra_CompObject | |
Epetra_Flops * | FlopCounter_ |
Epetra_SerialDenseSVD: A class for SVDing dense linear problems.
The Epetra_SerialDenseSVD class enables the definition, in terms of Epetra_SerialDenseMatrix and Epetra_SerialDenseVector objects, of a dense linear problem, followed by the solution of that problem via the most sophisticated techniques available in LAPACK.
The Epetra_SerialDenseSVD class is intended to provide full-featured support for solving linear problems for general dense rectangular (or square) matrices. It is written on top of BLAS and LAPACK and thus has excellent performance and numerical capabilities. Using this class, one can either perform simple factorizations and solves or apply all the tricks available in LAPACK to get the best possible solution for very ill-conditioned problems.
Epetra_SerialDenseSVD vs. Epetra_LAPACK
The Epetra_LAPACK class provides access to most of the same functionality as Epetra_SerialDenseSolver. The primary difference is that Epetra_LAPACK is a "thin" layer on top of LAPACK and Epetra_SerialDenseSolver attempts to provide easy access to the more sophisticated aspects of solving dense linear and eigensystems.
When you should use Epetra_SerialDenseSolver: If you want to (or potentially want to) solve ill-conditioned problems or want to work with a more object-oriented interface, you should probably use Epetra_SerialDenseSolver.
Constructing Epetra_SerialDenseSVD Objects
There is a single Epetra_SerialDenseSVD constructor. However, the matrix, right hand side and solution vectors must be set prior to executing most methods in this class.
Setting vectors used for linear solves
The matrix A, the left hand side X and the right hand side B (when solving AX = B, for X), can be set by appropriate set methods. Each of these three objects must be an Epetra_SerialDenseMatrix or and Epetra_SerialDenseVector object. The set methods are as follows:
Vector and Utility Functions
Once a Epetra_SerialDenseSVD is constructed, several mathematical functions can be applied to the object. Specifically:
Counting floating point operations The Epetra_SerialDenseSVD class has Epetra_CompObject as a base class. Thus, floating point operations are counted and accumulated in the Epetra_Flop object (if any) that was set using the SetFlopCounter() method in the Epetra_CompObject base class.
Examples using Epetra_SerialDenseSVD can be found in the Epetra test directories.
Definition at line 115 of file Epetra_SerialDenseSVD.h.
Epetra_SerialDenseSVD::Epetra_SerialDenseSVD | ( | ) |
Default constructor; matrix should be set using SetMatrix(), LHS and RHS set with SetVectors().
Definition at line 48 of file Epetra_SerialDenseSVD.cpp.
|
virtual |
Epetra_SerialDenseSVD destructor.
Definition at line 89 of file Epetra_SerialDenseSVD.cpp.
|
private |
int Epetra_SerialDenseSVD::SetMatrix | ( | Epetra_SerialDenseMatrix & | A | ) |
Sets the pointers for coefficient matrix.
Definition at line 164 of file Epetra_SerialDenseSVD.cpp.
int Epetra_SerialDenseSVD::SetVectors | ( | Epetra_SerialDenseMatrix & | X, |
Epetra_SerialDenseMatrix & | B | ||
) |
|
inline |
Causes equilibration to be called just before the matrix factorization as part of the call to Factor.
This function must be called before the factorization is performed.If Flag is true, causes all subsequent function calls to work with the transpose of this matrix, otherwise not.
Definition at line 149 of file Epetra_SerialDenseSVD.h.
|
virtual |
Definition at line 214 of file Epetra_SerialDenseSVD.cpp.
|
virtual |
Computes the solution X to AX = B for the this matrix and the B provided to SetVectors()..
Inverse of Matrix must be formed
Definition at line 261 of file Epetra_SerialDenseSVD.cpp.
|
virtual |
Inverts the this matrix.
Definition at line 480 of file Epetra_SerialDenseSVD.cpp.
|
inline |
Returns true if transpose of this matrix has and will be used.
Definition at line 236 of file Epetra_SerialDenseSVD.h.
|
inline |
Returns true if matrix is factored (factor available via AF() and LDAF()).
Definition at line 239 of file Epetra_SerialDenseSVD.h.
|
inline |
Returns true if matrix inverse has been computed (inverse available via AF() and LDAF()).
Definition at line 258 of file Epetra_SerialDenseSVD.h.
|
inline |
Returns true if the current set of vectors has been solved.
Definition at line 265 of file Epetra_SerialDenseSVD.h.
|
inline |
Returns pointer to current matrix.
Definition at line 276 of file Epetra_SerialDenseSVD.h.
|
inline |
Returns pointer to inverted matrix (assuming inverse has been performed).
Definition at line 283 of file Epetra_SerialDenseSVD.h.
|
inline |
Returns pointer to current LHS.
Definition at line 286 of file Epetra_SerialDenseSVD.h.
|
inline |
Returns pointer to current RHS.
Definition at line 289 of file Epetra_SerialDenseSVD.h.
|
inline |
Returns row dimension of system.
Definition at line 292 of file Epetra_SerialDenseSVD.h.
|
inline |
Returns column dimension of system.
Definition at line 295 of file Epetra_SerialDenseSVD.h.
|
inline |
Returns pointer to the this matrix.
Definition at line 298 of file Epetra_SerialDenseSVD.h.
|
inline |
Returns the leading dimension of the this matrix.
Definition at line 301 of file Epetra_SerialDenseSVD.h.
|
inline |
Returns pointer to current RHS.
Definition at line 304 of file Epetra_SerialDenseSVD.h.
|
inline |
Returns the leading dimension of the RHS.
Definition at line 307 of file Epetra_SerialDenseSVD.h.
|
inline |
Returns the number of current right hand sides and solution vectors.
Definition at line 310 of file Epetra_SerialDenseSVD.h.
|
inline |
Returns pointer to current solution.
Definition at line 313 of file Epetra_SerialDenseSVD.h.
|
inline |
Returns the leading dimension of the solution.
Definition at line 316 of file Epetra_SerialDenseSVD.h.
|
inline |
Definition at line 318 of file Epetra_SerialDenseSVD.h.
|
inline |
Returns pointer to the inverted matrix (may be the same as A() if factorization done in place).
Definition at line 329 of file Epetra_SerialDenseSVD.h.
|
inline |
Returns the leading dimension of the inverted matrix.
Definition at line 332 of file Epetra_SerialDenseSVD.h.
|
inline |
Returns the 1-Norm of the this matrix (returns -1 if not yet computed).
Definition at line 339 of file Epetra_SerialDenseSVD.h.
|
virtual |
Print service methods; defines behavior of ostream << operator.
Reimplemented from Epetra_Object.
Definition at line 560 of file Epetra_SerialDenseSVD.cpp.
|
inlinevirtual |
If set true, transpose of this operator will be applied.
This flag allows the transpose of the given operator to be used implicitly. Setting this flag affects only the Apply() and ApplyInverse() methods. If the implementation of this interface
does not support transpose use, this method should return a value of -1.
In | use_transpose -If true, multiply by the transpose of operator, otherwise just use operator. |
Implements Epetra_SerialDenseOperator.
Definition at line 397 of file Epetra_SerialDenseSVD.h.
|
inlinevirtual |
Returns the result of a Epetra_SerialDenseOperator applied to a Epetra_SerialDenseMatrix X in Y.
In | X - A Epetra_SerialDenseMatrix to multiply with operator. |
Out | Y -A Epetra_SerialDenseMatrix containing result. |
Implements Epetra_SerialDenseOperator.
Definition at line 408 of file Epetra_SerialDenseSVD.h.
|
inlinevirtual |
Returns the result of a Epetra_SerialDenseOperator inverse applied to an Epetra_SerialDenseMatrix X in Y.
In | X - A Epetra_SerialDenseMatrix to solve for. |
Out | Y -A Epetra_SerialDenseMatrix containing result. |
Implements Epetra_SerialDenseOperator.
Definition at line 421 of file Epetra_SerialDenseSVD.h.
|
inlinevirtual |
Returns the infinity norm of the global matrix.
Implements Epetra_SerialDenseOperator.
Definition at line 432 of file Epetra_SerialDenseSVD.h.
|
inlinevirtual |
Returns a character string describing the operator.
Reimplemented from Epetra_Object.
Definition at line 435 of file Epetra_SerialDenseSVD.h.
|
inlinevirtual |
Returns the current UseTranspose setting.
Implements Epetra_SerialDenseOperator.
Definition at line 438 of file Epetra_SerialDenseSVD.h.
|
inlinevirtual |
Returns true if the this object can provide an approximate Inf-norm, false otherwise.
Implements Epetra_SerialDenseOperator.
Definition at line 441 of file Epetra_SerialDenseSVD.h.
|
inlinevirtual |
Returns the row dimension of operator.
Implements Epetra_SerialDenseOperator.
Definition at line 444 of file Epetra_SerialDenseSVD.h.
|
inlinevirtual |
Returns the column dimension of operator.
Implements Epetra_SerialDenseOperator.
Definition at line 447 of file Epetra_SerialDenseSVD.h.
|
inline |
Definition at line 451 of file Epetra_SerialDenseSVD.h.
|
inline |
Definition at line 452 of file Epetra_SerialDenseSVD.h.
void Epetra_SerialDenseSVD::InitPointers | ( | ) |
Definition at line 94 of file Epetra_SerialDenseSVD.cpp.
void Epetra_SerialDenseSVD::DeleteArrays | ( | ) |
Definition at line 114 of file Epetra_SerialDenseSVD.cpp.
void Epetra_SerialDenseSVD::ResetMatrix | ( | ) |
Definition at line 136 of file Epetra_SerialDenseSVD.cpp.
void Epetra_SerialDenseSVD::ResetVectors | ( | ) |
Definition at line 178 of file Epetra_SerialDenseSVD.cpp.
|
private |
bool Epetra_SerialDenseSVD::Transpose_ |
Definition at line 463 of file Epetra_SerialDenseSVD.h.
bool Epetra_SerialDenseSVD::Factored_ |
Definition at line 464 of file Epetra_SerialDenseSVD.h.
bool Epetra_SerialDenseSVD::Solved_ |
Definition at line 467 of file Epetra_SerialDenseSVD.h.
bool Epetra_SerialDenseSVD::Inverted_ |
Definition at line 468 of file Epetra_SerialDenseSVD.h.
char Epetra_SerialDenseSVD::TRANS_ |
Definition at line 473 of file Epetra_SerialDenseSVD.h.
int Epetra_SerialDenseSVD::M_ |
Definition at line 475 of file Epetra_SerialDenseSVD.h.
int Epetra_SerialDenseSVD::N_ |
Definition at line 476 of file Epetra_SerialDenseSVD.h.
int Epetra_SerialDenseSVD::Min_MN_ |
Definition at line 477 of file Epetra_SerialDenseSVD.h.
int Epetra_SerialDenseSVD::NRHS_ |
Definition at line 478 of file Epetra_SerialDenseSVD.h.
int Epetra_SerialDenseSVD::LDA_ |
Definition at line 479 of file Epetra_SerialDenseSVD.h.
int Epetra_SerialDenseSVD::LDAI_ |
Definition at line 481 of file Epetra_SerialDenseSVD.h.
int Epetra_SerialDenseSVD::LDB_ |
Definition at line 482 of file Epetra_SerialDenseSVD.h.
int Epetra_SerialDenseSVD::LDX_ |
Definition at line 483 of file Epetra_SerialDenseSVD.h.
int Epetra_SerialDenseSVD::INFO_ |
Definition at line 484 of file Epetra_SerialDenseSVD.h.
int Epetra_SerialDenseSVD::LWORK_ |
Definition at line 485 of file Epetra_SerialDenseSVD.h.
int* Epetra_SerialDenseSVD::IWORK_ |
Definition at line 488 of file Epetra_SerialDenseSVD.h.
double Epetra_SerialDenseSVD::ANORM_ |
Definition at line 490 of file Epetra_SerialDenseSVD.h.
Epetra_SerialDenseMatrix* Epetra_SerialDenseSVD::Matrix_ |
Definition at line 496 of file Epetra_SerialDenseSVD.h.
Epetra_SerialDenseMatrix* Epetra_SerialDenseSVD::LHS_ |
Definition at line 497 of file Epetra_SerialDenseSVD.h.
Epetra_SerialDenseMatrix* Epetra_SerialDenseSVD::RHS_ |
Definition at line 498 of file Epetra_SerialDenseSVD.h.
Epetra_SerialDenseMatrix* Epetra_SerialDenseSVD::Inverse_ |
Definition at line 500 of file Epetra_SerialDenseSVD.h.
double* Epetra_SerialDenseSVD::A_ |
Definition at line 502 of file Epetra_SerialDenseSVD.h.
double* Epetra_SerialDenseSVD::AI_ |
Definition at line 506 of file Epetra_SerialDenseSVD.h.
double* Epetra_SerialDenseSVD::WORK_ |
Definition at line 507 of file Epetra_SerialDenseSVD.h.
double* Epetra_SerialDenseSVD::U_ |
Definition at line 510 of file Epetra_SerialDenseSVD.h.
double* Epetra_SerialDenseSVD::S_ |
Definition at line 511 of file Epetra_SerialDenseSVD.h.
double* Epetra_SerialDenseSVD::Vt_ |
Definition at line 512 of file Epetra_SerialDenseSVD.h.
double* Epetra_SerialDenseSVD::B_ |
Definition at line 514 of file Epetra_SerialDenseSVD.h.
double* Epetra_SerialDenseSVD::X_ |
Definition at line 515 of file Epetra_SerialDenseSVD.h.
bool Epetra_SerialDenseSVD::UseTranspose_ |
Definition at line 517 of file Epetra_SerialDenseSVD.h.