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

Epetra_SerialDenseSolver: A class for solving dense linear problems. More...

#include <Epetra_SerialDenseSolver.h>

Inheritance diagram for Epetra_SerialDenseSolver:
Inheritance graph
[legend]

Protected Member Functions

void AllocateWORK ()
 
void AllocateIWORK ()
 
void InitPointers ()
 
void DeleteArrays ()
 
void ResetMatrix ()
 
void ResetVectors ()
 
- 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

bool Equilibrate_
 
bool ShouldEquilibrate_
 
bool A_Equilibrated_
 
bool B_Equilibrated_
 
bool Transpose_
 
bool Factored_
 
bool EstimateSolutionErrors_
 
bool SolutionErrorsEstimated_
 
bool Solved_
 
bool Inverted_
 
bool ReciprocalConditionEstimated_
 
bool RefineSolution_
 
bool SolutionRefined_
 
char TRANS_
 
int M_
 
int N_
 
int Min_MN_
 
int NRHS_
 
int LDA_
 
int LDAF_
 
int LDB_
 
int LDX_
 
int INFO_
 
int LWORK_
 
int * IPIV_
 
int * IWORK_
 
double ANORM_
 
double RCOND_
 
double ROWCND_
 
double COLCND_
 
double AMAX_
 
Epetra_SerialDenseMatrixMatrix_
 
Epetra_SerialDenseMatrixLHS_
 
Epetra_SerialDenseMatrixRHS_
 
Epetra_SerialDenseMatrixFactor_
 
double * A_
 
double * FERR_
 
double * BERR_
 
double * AF_
 
double * WORK_
 
double * R_
 
double * C_
 
double * B_
 
double * X_
 
- Protected Attributes inherited from Epetra_CompObject
Epetra_FlopsFlopCounter_
 

Private Member Functions

 Epetra_SerialDenseSolver (const Epetra_SerialDenseSolver &Source)
 
Epetra_SerialDenseSolveroperator= (const Epetra_SerialDenseSolver &Source)
 

Constructor/Destructor Methods

 Epetra_SerialDenseSolver ()
 Default constructor; matrix should be set using SetMatrix(), LHS and RHS set with SetVectors(). More...
 
virtual ~Epetra_SerialDenseSolver ()
 Epetra_SerialDenseSolver 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 FactorWithEquilibration (bool Flag)
 Causes equilibration to be called just before the matrix factorization as part of the call to Factor. More...
 
void SolveWithTranspose (bool Flag)
 If Flag is true, causes all subsequent function calls to work with the transpose of this matrix, otherwise not. More...
 
void SolveToRefinedSolution (bool Flag)
 Causes all solves to compute solution to best ability using iterative refinement. More...
 
void EstimateSolutionErrors (bool Flag)
 Causes all solves to estimate the forward and backward solution error. More...
 

Factor/Solve/Invert Methods

virtual int Factor (void)
 Computes the in-place LU factorization of the matrix using the LAPACK routine DGETRF. More...
 
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 (void)
 Inverts the this matrix. More...
 
virtual int ComputeEquilibrateScaling (void)
 Computes the scaling vector S(i) = 1/sqrt(A(i,i)) of the this matrix. More...
 
virtual int EquilibrateMatrix (void)
 Equilibrates the this matrix. More...
 
int EquilibrateRHS (void)
 Equilibrates the current RHS. More...
 
virtual int ApplyRefinement (void)
 Apply Iterative Refinement. More...
 
int UnequilibrateLHS (void)
 Unscales the solution vectors if equilibration was used to solve the system. More...
 
virtual int ReciprocalConditionEstimate (double &Value)
 Returns the reciprocal of the 1-norm condition number of 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 A_Equilibrated ()
 Returns true if factor is equilibrated (factor available via AF() and LDAF()). More...
 
bool B_Equilibrated ()
 Returns true if RHS is equilibrated (RHS available via B() and LDB()). More...
 
virtual bool ShouldEquilibrate ()
 Returns true if the LAPACK general rules for equilibration suggest you should equilibrate the system. More...
 
bool SolutionErrorsEstimated ()
 Returns true if forward and backward error estimated have been computed (available via FERR() and BERR()). More...
 
bool Inverted ()
 Returns true if matrix inverse has been computed (inverse available via AF() and LDAF()). More...
 
bool ReciprocalConditionEstimated ()
 Returns true if the condition number of the this matrix has been computed (value available via ReciprocalConditionEstimate()). More...
 
bool Solved ()
 Returns true if the current set of vectors has been solved. More...
 
bool SolutionRefined ()
 Returns true if the current set of vectors has been refined. More...
 

Data Accessor methods

Epetra_SerialDenseMatrixMatrix () const
 Returns pointer to current matrix. More...
 
Epetra_SerialDenseMatrixFactoredMatrix () const
 Returns pointer to factored matrix (assuming factorization has been performed). More...
 
Epetra_SerialDenseMatrixLHS () const
 Returns pointer to current LHS. More...
 
Epetra_SerialDenseMatrixRHS () 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 * AF () const
 Returns pointer to the factored matrix (may be the same as A() if factorization done in place). More...
 
int LDAF () const
 Returns the leading dimension of the factored matrix. More...
 
int * IPIV () const
 Returns pointer to pivot vector (if factorization has been computed), zero otherwise. More...
 
double ANORM () const
 Returns the 1-Norm of the this matrix (returns -1 if not yet computed). More...
 
double RCOND () const
 Returns the reciprocal of the condition number of the this matrix (returns -1 if not yet computed). More...
 
double ROWCND () const
 Ratio of smallest to largest row scale factors for the this matrix (returns -1 if not yet computed). More...
 
double COLCND () const
 Ratio of smallest to largest column scale factors for the this matrix (returns -1 if not yet computed). More...
 
double AMAX () const
 Returns the absolute value of the largest entry of the this matrix (returns -1 if not yet computed). More...
 
double * FERR () const
 Returns a pointer to the forward error estimates computed by LAPACK. More...
 
double * BERR () const
 Returns a pointer to the backward error estimates computed by LAPACK. More...
 
double * R () const
 Returns a pointer to the row scaling vector used for equilibration. More...
 
double * C () const
 Returns a pointer to the column scale vector used for equilibration. More...
 

I/O methods

virtual void Print (std::ostream &os) const
 Print service methods; defines behavior of ostream << operator. More...
 

Additional Inherited Members

- Public Member Functions inherited from Epetra_CompObject
Epetra_CompObjectoperator= (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_FlopsGetFlopCounter () 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_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 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 const char * Label () const
 Epetra_Object Label access funtion. More...
 
virtual int ReportError (const std::string Message, int ErrorCode) const
 Error reporting method. More...
 
- 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
 

Detailed Description

Epetra_SerialDenseSolver: A class for solving dense linear problems.

The Epetra_SerialDenseSolver 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_SerialDenseSolver 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_SerialDenseSolver 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.

Constructing Epetra_SerialDenseSolver Objects

There is a single Epetra_SerialDenseSolver 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_SerialDenseSolver is constructed, several mathematical functions can be applied to the object. Specifically:

Counting floating point operations The Epetra_SerialDenseSolver 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.

Strategies for Solving Linear Systems In many cases, linear systems can be accurately solved by simply computing the LU factorization of the matrix and then performing a forward back solve with a given set of right hand side vectors. However, in some instances, the factorization may be very poorly conditioned and this simple approach may not work. In these situations, equilibration and iterative refinement may improve the accuracy, or prevent a breakdown in the factorization.

Epetra_SerialDenseSolver will use equilibration with the factorization if, once the object is constructed and before it is factored, you call the function FactorWithEquilibration(true) to force equilibration to be used. If you are uncertain if equilibration should be used, you may call the function ShouldEquilibrate() which will return true if equilibration could possibly help. ShouldEquilibrate() uses guidelines specified in the LAPACK User Guide, namely if SCOND < 0.1 and AMAX < Underflow or AMAX > Overflow, to determine if equilibration might be useful.

Epetra_SerialDenseSolver will use iterative refinement after a forward/back solve if you call SolveToRefinedSolution(true). It will also compute forward and backward error estimates if you call EstimateSolutionErrors(true). Access to the forward (back) error estimates is available via FERR() (BERR()).

Examples using Epetra_SerialDenseSolver can be found in the Epetra test directories.

Definition at line 132 of file Epetra_SerialDenseSolver.h.

Constructor & Destructor Documentation

Epetra_SerialDenseSolver::Epetra_SerialDenseSolver ( )

Default constructor; matrix should be set using SetMatrix(), LHS and RHS set with SetVectors().

Definition at line 47 of file Epetra_SerialDenseSolver.cpp.

Epetra_SerialDenseSolver::~Epetra_SerialDenseSolver ( )
virtual

Epetra_SerialDenseSolver destructor.

Definition at line 101 of file Epetra_SerialDenseSolver.cpp.

Epetra_SerialDenseSolver::Epetra_SerialDenseSolver ( const Epetra_SerialDenseSolver Source)
private

Member Function Documentation

int Epetra_SerialDenseSolver::SetMatrix ( Epetra_SerialDenseMatrix A)

Sets the pointers for coefficient matrix.

Definition at line 162 of file Epetra_SerialDenseSolver.cpp.

int Epetra_SerialDenseSolver::SetVectors ( Epetra_SerialDenseMatrix X,
Epetra_SerialDenseMatrix B 
)

Sets the pointers for left and right hand side vector(s).

Row dimension of X must match column dimension of matrix A, row dimension of B must match row dimension of A. X and B must have the same dimensions.

Definition at line 192 of file Epetra_SerialDenseSolver.cpp.

void Epetra_SerialDenseSolver::FactorWithEquilibration ( bool  Flag)
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.

Definition at line 166 of file Epetra_SerialDenseSolver.h.

void Epetra_SerialDenseSolver::SolveWithTranspose ( bool  Flag)
inline

If Flag is true, causes all subsequent function calls to work with the transpose of this matrix, otherwise not.

Definition at line 169 of file Epetra_SerialDenseSolver.h.

void Epetra_SerialDenseSolver::SolveToRefinedSolution ( bool  Flag)
inline

Causes all solves to compute solution to best ability using iterative refinement.

Definition at line 172 of file Epetra_SerialDenseSolver.h.

void Epetra_SerialDenseSolver::EstimateSolutionErrors ( bool  Flag)

Causes all solves to estimate the forward and backward solution error.

Error estimates will be in the arrays FERR and BERR, resp, after the solve step is complete. These arrays are accessible via the FERR() and BERR() access functions.

Definition at line 212 of file Epetra_SerialDenseSolver.cpp.

int Epetra_SerialDenseSolver::Factor ( void  )
virtual

Computes the in-place LU factorization of the matrix using the LAPACK routine DGETRF.

Returns
Integer error code, set to 0 if successful.

Reimplemented in Epetra_SerialSpdDenseSolver.

Definition at line 219 of file Epetra_SerialDenseSolver.cpp.

int Epetra_SerialDenseSolver::Solve ( void  )
virtual

Computes the solution X to AX = B for the this matrix and the B provided to SetVectors()..

Returns
Integer error code, set to 0 if successful.

Reimplemented in Epetra_SerialSpdDenseSolver.

Definition at line 255 of file Epetra_SerialDenseSolver.cpp.

int Epetra_SerialDenseSolver::Invert ( void  )
virtual

Inverts the this matrix.

Returns
Integer error code, set to 0 if successful. Otherwise returns the LAPACK error code INFO.

Reimplemented in Epetra_SerialSpdDenseSolver.

Definition at line 468 of file Epetra_SerialDenseSolver.cpp.

int Epetra_SerialDenseSolver::ComputeEquilibrateScaling ( void  )
virtual

Computes the scaling vector S(i) = 1/sqrt(A(i,i)) of the this matrix.

Returns
Integer error code, set to 0 if successful. Otherwise returns the LAPACK error code INFO.

Reimplemented in Epetra_SerialSpdDenseSolver.

Definition at line 349 of file Epetra_SerialDenseSolver.cpp.

int Epetra_SerialDenseSolver::EquilibrateMatrix ( void  )
virtual

Equilibrates the this matrix.

Returns
Integer error code, set to 0 if successful. Otherwise returns the LAPACK error code INFO.

Reimplemented in Epetra_SerialSpdDenseSolver.

Definition at line 368 of file Epetra_SerialDenseSolver.cpp.

int Epetra_SerialDenseSolver::EquilibrateRHS ( void  )

Equilibrates the current RHS.

Returns
Integer error code, set to 0 if successful. Otherwise returns the LAPACK error code INFO.

Definition at line 414 of file Epetra_SerialDenseSolver.cpp.

int Epetra_SerialDenseSolver::ApplyRefinement ( void  )
virtual

Apply Iterative Refinement.

Returns
Integer error code, set to 0 if successful. Otherwise returns the LAPACK error code INFO.

Reimplemented in Epetra_SerialSpdDenseSolver.

Definition at line 318 of file Epetra_SerialDenseSolver.cpp.

int Epetra_SerialDenseSolver::UnequilibrateLHS ( void  )

Unscales the solution vectors if equilibration was used to solve the system.

Returns
Integer error code, set to 0 if successful. Otherwise returns the LAPACK error code INFO.

Definition at line 443 of file Epetra_SerialDenseSolver.cpp.

int Epetra_SerialDenseSolver::ReciprocalConditionEstimate ( double &  Value)
virtual

Returns the reciprocal of the 1-norm condition number of the this matrix.

Parameters
ValueOut On return contains the reciprocal of the 1-norm condition number of the this matrix.
Returns
Integer error code, set to 0 if successful. Otherwise returns the LAPACK error code INFO.

Reimplemented in Epetra_SerialSpdDenseSolver.

Definition at line 499 of file Epetra_SerialDenseSolver.cpp.

bool Epetra_SerialDenseSolver::Transpose ( )
inline

Returns true if transpose of this matrix has and will be used.

Definition at line 247 of file Epetra_SerialDenseSolver.h.

bool Epetra_SerialDenseSolver::Factored ( )
inline

Returns true if matrix is factored (factor available via AF() and LDAF()).

Definition at line 250 of file Epetra_SerialDenseSolver.h.

bool Epetra_SerialDenseSolver::A_Equilibrated ( )
inline

Returns true if factor is equilibrated (factor available via AF() and LDAF()).

Definition at line 253 of file Epetra_SerialDenseSolver.h.

bool Epetra_SerialDenseSolver::B_Equilibrated ( )
inline

Returns true if RHS is equilibrated (RHS available via B() and LDB()).

Definition at line 256 of file Epetra_SerialDenseSolver.h.

virtual bool Epetra_SerialDenseSolver::ShouldEquilibrate ( )
inlinevirtual

Returns true if the LAPACK general rules for equilibration suggest you should equilibrate the system.

Reimplemented in Epetra_SerialSpdDenseSolver.

Definition at line 259 of file Epetra_SerialDenseSolver.h.

bool Epetra_SerialDenseSolver::SolutionErrorsEstimated ( )
inline

Returns true if forward and backward error estimated have been computed (available via FERR() and BERR()).

Definition at line 262 of file Epetra_SerialDenseSolver.h.

bool Epetra_SerialDenseSolver::Inverted ( )
inline

Returns true if matrix inverse has been computed (inverse available via AF() and LDAF()).

Definition at line 265 of file Epetra_SerialDenseSolver.h.

bool Epetra_SerialDenseSolver::ReciprocalConditionEstimated ( )
inline

Returns true if the condition number of the this matrix has been computed (value available via ReciprocalConditionEstimate()).

Definition at line 268 of file Epetra_SerialDenseSolver.h.

bool Epetra_SerialDenseSolver::Solved ( )
inline

Returns true if the current set of vectors has been solved.

Definition at line 271 of file Epetra_SerialDenseSolver.h.

bool Epetra_SerialDenseSolver::SolutionRefined ( )
inline

Returns true if the current set of vectors has been refined.

Definition at line 274 of file Epetra_SerialDenseSolver.h.

Epetra_SerialDenseMatrix* Epetra_SerialDenseSolver::Matrix ( ) const
inline

Returns pointer to current matrix.

Definition at line 281 of file Epetra_SerialDenseSolver.h.

Epetra_SerialDenseMatrix* Epetra_SerialDenseSolver::FactoredMatrix ( ) const
inline

Returns pointer to factored matrix (assuming factorization has been performed).

Definition at line 284 of file Epetra_SerialDenseSolver.h.

Epetra_SerialDenseMatrix* Epetra_SerialDenseSolver::LHS ( ) const
inline

Returns pointer to current LHS.

Definition at line 287 of file Epetra_SerialDenseSolver.h.

Epetra_SerialDenseMatrix* Epetra_SerialDenseSolver::RHS ( ) const
inline

Returns pointer to current RHS.

Definition at line 290 of file Epetra_SerialDenseSolver.h.

int Epetra_SerialDenseSolver::M ( ) const
inline

Returns row dimension of system.

Definition at line 293 of file Epetra_SerialDenseSolver.h.

int Epetra_SerialDenseSolver::N ( ) const
inline

Returns column dimension of system.

Definition at line 296 of file Epetra_SerialDenseSolver.h.

double* Epetra_SerialDenseSolver::A ( ) const
inline

Returns pointer to the this matrix.

Definition at line 299 of file Epetra_SerialDenseSolver.h.

int Epetra_SerialDenseSolver::LDA ( ) const
inline

Returns the leading dimension of the this matrix.

Definition at line 302 of file Epetra_SerialDenseSolver.h.

double* Epetra_SerialDenseSolver::B ( ) const
inline

Returns pointer to current RHS.

Definition at line 305 of file Epetra_SerialDenseSolver.h.

int Epetra_SerialDenseSolver::LDB ( ) const
inline

Returns the leading dimension of the RHS.

Definition at line 308 of file Epetra_SerialDenseSolver.h.

int Epetra_SerialDenseSolver::NRHS ( ) const
inline

Returns the number of current right hand sides and solution vectors.

Definition at line 311 of file Epetra_SerialDenseSolver.h.

double* Epetra_SerialDenseSolver::X ( ) const
inline

Returns pointer to current solution.

Definition at line 314 of file Epetra_SerialDenseSolver.h.

int Epetra_SerialDenseSolver::LDX ( ) const
inline

Returns the leading dimension of the solution.

Definition at line 317 of file Epetra_SerialDenseSolver.h.

double* Epetra_SerialDenseSolver::AF ( ) const
inline

Returns pointer to the factored matrix (may be the same as A() if factorization done in place).

Definition at line 320 of file Epetra_SerialDenseSolver.h.

int Epetra_SerialDenseSolver::LDAF ( ) const
inline

Returns the leading dimension of the factored matrix.

Definition at line 323 of file Epetra_SerialDenseSolver.h.

int* Epetra_SerialDenseSolver::IPIV ( ) const
inline

Returns pointer to pivot vector (if factorization has been computed), zero otherwise.

Definition at line 326 of file Epetra_SerialDenseSolver.h.

double Epetra_SerialDenseSolver::ANORM ( ) const
inline

Returns the 1-Norm of the this matrix (returns -1 if not yet computed).

Definition at line 329 of file Epetra_SerialDenseSolver.h.

double Epetra_SerialDenseSolver::RCOND ( ) const
inline

Returns the reciprocal of the condition number of the this matrix (returns -1 if not yet computed).

Definition at line 332 of file Epetra_SerialDenseSolver.h.

double Epetra_SerialDenseSolver::ROWCND ( ) const
inline

Ratio of smallest to largest row scale factors for the this matrix (returns -1 if not yet computed).

If ROWCND() is >= 0.1 and AMAX() is not close to overflow or underflow, then equilibration is not needed.

Definition at line 337 of file Epetra_SerialDenseSolver.h.

double Epetra_SerialDenseSolver::COLCND ( ) const
inline

Ratio of smallest to largest column scale factors for the this matrix (returns -1 if not yet computed).

If COLCND() is >= 0.1 then equilibration is not needed.

Definition at line 342 of file Epetra_SerialDenseSolver.h.

double Epetra_SerialDenseSolver::AMAX ( ) const
inline

Returns the absolute value of the largest entry of the this matrix (returns -1 if not yet computed).

Definition at line 345 of file Epetra_SerialDenseSolver.h.

double* Epetra_SerialDenseSolver::FERR ( ) const
inline

Returns a pointer to the forward error estimates computed by LAPACK.

Definition at line 348 of file Epetra_SerialDenseSolver.h.

double* Epetra_SerialDenseSolver::BERR ( ) const
inline

Returns a pointer to the backward error estimates computed by LAPACK.

Definition at line 351 of file Epetra_SerialDenseSolver.h.

double* Epetra_SerialDenseSolver::R ( ) const
inline

Returns a pointer to the row scaling vector used for equilibration.

Definition at line 354 of file Epetra_SerialDenseSolver.h.

double* Epetra_SerialDenseSolver::C ( ) const
inline

Returns a pointer to the column scale vector used for equilibration.

Definition at line 357 of file Epetra_SerialDenseSolver.h.

void Epetra_SerialDenseSolver::Print ( std::ostream &  os) const
virtual

Print service methods; defines behavior of ostream << operator.

Reimplemented from Epetra_Object.

Definition at line 522 of file Epetra_SerialDenseSolver.cpp.

void Epetra_SerialDenseSolver::AllocateWORK ( )
inlineprotected

Definition at line 367 of file Epetra_SerialDenseSolver.h.

void Epetra_SerialDenseSolver::AllocateIWORK ( )
inlineprotected

Definition at line 368 of file Epetra_SerialDenseSolver.h.

void Epetra_SerialDenseSolver::InitPointers ( )
protected

Definition at line 106 of file Epetra_SerialDenseSolver.cpp.

void Epetra_SerialDenseSolver::DeleteArrays ( )
protected

Definition at line 122 of file Epetra_SerialDenseSolver.cpp.

void Epetra_SerialDenseSolver::ResetMatrix ( )
protected

Definition at line 139 of file Epetra_SerialDenseSolver.cpp.

void Epetra_SerialDenseSolver::ResetVectors ( )
protected

Definition at line 176 of file Epetra_SerialDenseSolver.cpp.

Epetra_SerialDenseSolver& Epetra_SerialDenseSolver::operator= ( const Epetra_SerialDenseSolver Source)
private

Member Data Documentation

bool Epetra_SerialDenseSolver::Equilibrate_
protected

Definition at line 375 of file Epetra_SerialDenseSolver.h.

bool Epetra_SerialDenseSolver::ShouldEquilibrate_
protected

Definition at line 376 of file Epetra_SerialDenseSolver.h.

bool Epetra_SerialDenseSolver::A_Equilibrated_
protected

Definition at line 377 of file Epetra_SerialDenseSolver.h.

bool Epetra_SerialDenseSolver::B_Equilibrated_
protected

Definition at line 378 of file Epetra_SerialDenseSolver.h.

bool Epetra_SerialDenseSolver::Transpose_
protected

Definition at line 379 of file Epetra_SerialDenseSolver.h.

bool Epetra_SerialDenseSolver::Factored_
protected

Definition at line 380 of file Epetra_SerialDenseSolver.h.

bool Epetra_SerialDenseSolver::EstimateSolutionErrors_
protected

Definition at line 381 of file Epetra_SerialDenseSolver.h.

bool Epetra_SerialDenseSolver::SolutionErrorsEstimated_
protected

Definition at line 382 of file Epetra_SerialDenseSolver.h.

bool Epetra_SerialDenseSolver::Solved_
protected

Definition at line 383 of file Epetra_SerialDenseSolver.h.

bool Epetra_SerialDenseSolver::Inverted_
protected

Definition at line 384 of file Epetra_SerialDenseSolver.h.

bool Epetra_SerialDenseSolver::ReciprocalConditionEstimated_
protected

Definition at line 385 of file Epetra_SerialDenseSolver.h.

bool Epetra_SerialDenseSolver::RefineSolution_
protected

Definition at line 386 of file Epetra_SerialDenseSolver.h.

bool Epetra_SerialDenseSolver::SolutionRefined_
protected

Definition at line 387 of file Epetra_SerialDenseSolver.h.

char Epetra_SerialDenseSolver::TRANS_
protected

Definition at line 389 of file Epetra_SerialDenseSolver.h.

int Epetra_SerialDenseSolver::M_
protected

Definition at line 391 of file Epetra_SerialDenseSolver.h.

int Epetra_SerialDenseSolver::N_
protected

Definition at line 392 of file Epetra_SerialDenseSolver.h.

int Epetra_SerialDenseSolver::Min_MN_
protected

Definition at line 393 of file Epetra_SerialDenseSolver.h.

int Epetra_SerialDenseSolver::NRHS_
protected

Definition at line 394 of file Epetra_SerialDenseSolver.h.

int Epetra_SerialDenseSolver::LDA_
protected

Definition at line 395 of file Epetra_SerialDenseSolver.h.

int Epetra_SerialDenseSolver::LDAF_
protected

Definition at line 396 of file Epetra_SerialDenseSolver.h.

int Epetra_SerialDenseSolver::LDB_
protected

Definition at line 397 of file Epetra_SerialDenseSolver.h.

int Epetra_SerialDenseSolver::LDX_
protected

Definition at line 398 of file Epetra_SerialDenseSolver.h.

int Epetra_SerialDenseSolver::INFO_
protected

Definition at line 399 of file Epetra_SerialDenseSolver.h.

int Epetra_SerialDenseSolver::LWORK_
protected

Definition at line 400 of file Epetra_SerialDenseSolver.h.

int* Epetra_SerialDenseSolver::IPIV_
protected

Definition at line 402 of file Epetra_SerialDenseSolver.h.

int* Epetra_SerialDenseSolver::IWORK_
protected

Definition at line 403 of file Epetra_SerialDenseSolver.h.

double Epetra_SerialDenseSolver::ANORM_
protected

Definition at line 405 of file Epetra_SerialDenseSolver.h.

double Epetra_SerialDenseSolver::RCOND_
protected

Definition at line 406 of file Epetra_SerialDenseSolver.h.

double Epetra_SerialDenseSolver::ROWCND_
protected

Definition at line 407 of file Epetra_SerialDenseSolver.h.

double Epetra_SerialDenseSolver::COLCND_
protected

Definition at line 408 of file Epetra_SerialDenseSolver.h.

double Epetra_SerialDenseSolver::AMAX_
protected

Definition at line 409 of file Epetra_SerialDenseSolver.h.

Epetra_SerialDenseMatrix* Epetra_SerialDenseSolver::Matrix_
protected

Definition at line 411 of file Epetra_SerialDenseSolver.h.

Epetra_SerialDenseMatrix* Epetra_SerialDenseSolver::LHS_
protected

Definition at line 412 of file Epetra_SerialDenseSolver.h.

Epetra_SerialDenseMatrix* Epetra_SerialDenseSolver::RHS_
protected

Definition at line 413 of file Epetra_SerialDenseSolver.h.

Epetra_SerialDenseMatrix* Epetra_SerialDenseSolver::Factor_
protected

Definition at line 414 of file Epetra_SerialDenseSolver.h.

double* Epetra_SerialDenseSolver::A_
protected

Definition at line 416 of file Epetra_SerialDenseSolver.h.

double* Epetra_SerialDenseSolver::FERR_
protected

Definition at line 417 of file Epetra_SerialDenseSolver.h.

double* Epetra_SerialDenseSolver::BERR_
protected

Definition at line 418 of file Epetra_SerialDenseSolver.h.

double* Epetra_SerialDenseSolver::AF_
protected

Definition at line 419 of file Epetra_SerialDenseSolver.h.

double* Epetra_SerialDenseSolver::WORK_
protected

Definition at line 420 of file Epetra_SerialDenseSolver.h.

double* Epetra_SerialDenseSolver::R_
protected

Definition at line 421 of file Epetra_SerialDenseSolver.h.

double* Epetra_SerialDenseSolver::C_
protected

Definition at line 422 of file Epetra_SerialDenseSolver.h.

double* Epetra_SerialDenseSolver::B_
protected

Definition at line 424 of file Epetra_SerialDenseSolver.h.

double* Epetra_SerialDenseSolver::X_
protected

Definition at line 425 of file Epetra_SerialDenseSolver.h.


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