Amesos Package Browser (Single Doxygen Collection)
Development
|
Amesos_Lapack: an interface to LAPACK. More...
#include <Amesos_Lapack.h>
Protected Member Functions | |
const Epetra_RowMatrix * | Matrix () const |
Returns a pointer to the linear system matrix. More... | |
int | NumGlobalRows () const |
Returns the number of global rows, or -1 if Matrix() returns 0. More... | |
long long | NumGlobalRows64 () const |
int | NumMyRows () const |
Returns the number of local rows, or -1 if Matrix() returns 0. More... | |
const Epetra_Map & | SerialMap () |
Returns a reference to serial map (that with all elements on process 0). More... | |
Epetra_RowMatrix & | SerialMatrix () |
Returns a reference to serial matrix (that with all rows on process 0). More... | |
Epetra_CrsMatrix & | SerialCrsMatrix () |
const Epetra_Import & | MatrixImporter () |
Returns a reference to the matrix importer (from row map to serial map). More... | |
const Epetra_Export & | RhsExporter () |
Returns a reference to the rhs exporter (from range map to serial map). More... | |
const Epetra_Import & | SolutionImporter () |
Returns a reference to the solution importer (to domain map from serial map). More... | |
int | SolveSerial (Epetra_MultiVector &X, const Epetra_MultiVector &B) |
Solves the linear system, when only one process is used. More... | |
int | SolveDistributed (Epetra_MultiVector &X, const Epetra_MultiVector &B) |
Solves the linear system, when more than one process is used. More... | |
int | DistributedToSerial () |
Converts a distributed matrix to serial matrix. More... | |
int | SerialToDense () |
Converts a serial matrix to dense format. More... | |
int | DenseToFactored () |
Factors the matrix using LAPACK. More... | |
Protected Attributes | |
Teuchos::RCP < Teuchos::ParameterList > | pl_ |
Teuchos::RCP< Epetra_RowMatrix > | SerialMatrix_ |
Teuchos::RCP< Epetra_CrsMatrix > | SerialCrsMatrix_ |
Teuchos::RCP< Epetra_Map > | SerialMap_ |
Teuchos::RCP< Epetra_Import > | MatrixImporter_ |
Teuchos::RCP< Epetra_Export > | RhsExporter_ |
Teuchos::RCP< Epetra_Import > | SolutionImporter_ |
Epetra_SerialDenseMatrix | DenseMatrix_ |
Dense matrix. More... | |
Epetra_SerialDenseMatrix | DenseLHS_ |
Dense LHS. More... | |
Epetra_SerialDenseMatrix | DenseRHS_ |
Dense RHS. More... | |
Epetra_SerialDenseSolver | DenseSolver_ |
Linear problem for dense matrix and vectors. More... | |
bool | UseTranspose_ |
If true , the linear system with the transpose will be solved. More... | |
const Epetra_LinearProblem * | Problem_ |
Pointer to the linear problem. More... | |
int | MtxRedistTime_ |
Quick access ids for the individual timings. More... | |
int | MtxConvTime_ |
int | VecRedistTime_ |
int | SymFactTime_ |
int | NumFactTime_ |
int | SolveTime_ |
long long | NumGlobalRows_ |
long long | NumGlobalNonzeros_ |
Teuchos::RCP < Teuchos::ParameterList > | ParameterList_ |
Amesos_Lapack (const Epetra_LinearProblem &LinearProblem) | |
Amesos_Lapack Constructor. More... | |
~Amesos_Lapack (void) | |
Amesos_Lapack Destructor. More... | |
int | SymbolicFactorization () |
Performs SymbolicFactorization on the matrix A. More... | |
int | NumericFactorization () |
Performs NumericFactorization on the matrix A. More... | |
int | Solve () |
Solves A X = B (or AT x = B) More... | |
const Epetra_LinearProblem * | GetProblem () const |
Returns the Epetra_LinearProblem. More... | |
bool | MatrixShapeOK () const |
Returns true if the solver can handle this matrix shape. More... | |
int | SetUseTranspose (bool UseTranspose_in) |
If set true, X will be set to the solution of AT X = B (not A X = B) More... | |
bool | UseTranspose () const |
Returns the current UseTranspose setting. More... | |
const Epetra_Comm & | Comm () const |
Returns a pointer to the Epetra_Comm communicator associated with this operator. More... | |
void | setParameterList (Teuchos::RCP< Teuchos::ParameterList > const ¶mList) |
Use this parameter list to read values from. More... | |
Teuchos::RCP < Teuchos::ParameterList > | unsetParameterList () |
This is an empty stub. More... | |
int | SetParameters (Teuchos::ParameterList &ParameterList) |
Deprecated - Sets parameters. More... | |
int | GEEV (Epetra_Vector &Er, Epetra_Vector &Ei) |
Computes the eigenvalues of the linear system matrix using DGEEV. More... | |
int | NumSymbolicFact () const |
Returns the number of symbolic factorizations performed by this object. More... | |
int | NumNumericFact () const |
Returns the number of numeric factorizations performed by this object. More... | |
int | NumSolve () const |
Returns the number of solves performed by this object. More... | |
void | PrintTiming () const |
Print timing information. More... | |
void | PrintStatus () const |
Print information about the factorization and solution phases. More... | |
void | GetTiming (Teuchos::ParameterList &TimingParameterList) const |
Extracts timing information from the current solver and places it in the parameter list. More... | |
Additional Inherited Members | |
Public Member Functions inherited from Amesos_BaseSolver | |
virtual | ~Amesos_BaseSolver () |
Destructor. More... | |
virtual Teuchos::RCP < Teuchos::ParameterList > | getNonconstParameterList () |
This is an empty stub. More... | |
Public Member Functions inherited from Teuchos::ParameterListAcceptor | |
virtual RCP< const ParameterList > | getParameterList () const |
virtual RCP< const ParameterList > | getValidParameters () const |
Private Member Functions inherited from Amesos_Time | |
Amesos_Time () | |
Default constructor to create size timers. More... | |
virtual | ~Amesos_Time () |
Default destructor. More... | |
void | CreateTimer (const Epetra_Comm &Comm, int size=1) |
Initializes the Time object. More... | |
void | ResetTimer (const int timerID=0) |
Resets the internally stored time object. More... | |
int | AddTime (const std::string what, int dataID, const int timerID=0) |
Adds to field what the time elapsed since last call to ResetTimer(). More... | |
double | GetTime (const std::string what) const |
Gets the cumulative time using the string. More... | |
double | GetTime (const int dataID) const |
Gets the cumulative time using the dataID. More... | |
void | GetTiming (Teuchos::ParameterList &list) const |
Load up the current timing information into the parameter list. More... | |
Private Member Functions inherited from Amesos_NoCopiable | |
Amesos_NoCopiable () | |
Default constructor. More... | |
~Amesos_NoCopiable () | |
Default destructor. More... | |
Private Member Functions inherited from Amesos_Utils | |
Amesos_Utils () | |
Default constructor. More... | |
~Amesos_Utils () | |
Default destructor. More... | |
void | ComputeTrueResidual (const Epetra_RowMatrix &Matrix, const Epetra_MultiVector &X, const Epetra_MultiVector &B, const bool UseTranspose, const std::string prefix) const |
Computes the true residual, B - Matrix * X, and prints the results. More... | |
void | ComputeVectorNorms (const Epetra_MultiVector &X, const Epetra_MultiVector &B, const std::string prefix) const |
Computes the norms of X and B and print the results. More... | |
void | PrintLine () const |
Prints line on std::cout. More... | |
void | SetMaxProcesses (int &MaxProcesses, const Epetra_RowMatrix &A) |
Private Member Functions inherited from Amesos_Control | |
Amesos_Control () | |
Default constructor. More... | |
~Amesos_Control () | |
Default destructor. More... | |
void | SetControlParameters (const Teuchos::ParameterList &ParameterList) |
Private Member Functions inherited from Amesos_Status | |
Amesos_Status () | |
Default constructor. More... | |
~Amesos_Status () | |
Default destructor. More... | |
void | SetStatusParameters (const Teuchos::ParameterList &ParameterList) |
Private Attributes inherited from Amesos_Control | |
double | AddToDiag_ |
Add this value to the diagonal. More... | |
bool | refactorize_ |
double | rcond_threshold_ |
If error is greater than this value, perform symbolic and numeric factorization with full partial pivoting. More... | |
int | ScaleMethod_ |
bool | AddZeroToDiag_ |
Adds zero to diagonal of redistributed matrix (some solvers choke on a matrix with a partly empty diag) More... | |
int | MatrixProperty_ |
Set the matrix property. More... | |
int | MaxProcesses_ |
bool | Reindex_ |
If true, the Amesos class should reindex the matrix to standard indexing (i.e. More... | |
Private Attributes inherited from Amesos_Status | |
bool | IsSymbolicFactorizationOK_ |
If true , SymbolicFactorization() has been successfully called. More... | |
bool | IsNumericFactorizationOK_ |
If true , NumericFactorization() has been successfully called. More... | |
bool | PrintTiming_ |
If true , prints timing information in the destructor. More... | |
bool | PrintStatus_ |
If true , print additional information in the destructor. More... | |
bool | ComputeVectorNorms_ |
If true , prints the norms of X and B in Solve(). More... | |
bool | ComputeTrueResidual_ |
If true , computes the true residual in Solve(). More... | |
int | verbose_ |
Toggles the output level. More... | |
int | debug_ |
Sets the level of debug_ output. More... | |
int | NumSymbolicFact_ |
Number of symbolic factorization phases. More... | |
int | NumNumericFact_ |
Number of numeric factorization phases. More... | |
int | NumSolve_ |
Number of solves. More... | |
double | Threshold_ |
int | MyPID_ |
int | NumProcs_ |
Amesos_Lapack: an interface to LAPACK.
Class Amesos_Lapack enables the solution of the distributed linear system, defined by an Epetra_LinearProblem, using LAPACK.
Amesos_Lapack stores the lineaar system matrix as an Epetra_SerialDensMatrix. The linear problem is an Epetra_SerialDenseProblem. Amesos_Lapack factorizes the matrix using DGETRF().
Definition at line 65 of file Amesos_Lapack.h.
Amesos_Lapack::Amesos_Lapack | ( | const Epetra_LinearProblem & | LinearProblem | ) |
Amesos_Lapack Constructor.
Creates an Amesos_Lapack instance, using an Epetra_LinearProblem, passing in an already-defined Epetra_LinearProblem object.
Note: The operator in LinearProblem must be an Epetra_RowMatrix.
Definition at line 39 of file Amesos_Lapack.cpp.
Amesos_Lapack::~Amesos_Lapack | ( | void | ) |
Amesos_Lapack Destructor.
Completely deletes an Amesos_Lapack object.
Definition at line 74 of file Amesos_Lapack.cpp.
|
virtual |
Performs SymbolicFactorization on the matrix A.
In addition to performing symbolic factorization on the matrix A, the call to SymbolicFactorization() implies that no change will be made to the non-zero structure of the underlying matrix without a subsequent call to SymbolicFactorization().
<br >Preconditions:
<br >Postconditions:
Implements Amesos_BaseSolver.
Definition at line 127 of file Amesos_Lapack.cpp.
|
virtual |
Performs NumericFactorization on the matrix A.
In addition to performing numeric factorization on the matrix A, the call to NumericFactorization() implies that no change will be made to the underlying matrix without a subsequent call to NumericFactorization().
<br >Preconditions:
<br >Postconditions:
Implements Amesos_BaseSolver.
Definition at line 183 of file Amesos_Lapack.cpp.
|
virtual |
<br >Preconditions:
<br >Postconditions:
Implements Amesos_BaseSolver.
Definition at line 206 of file Amesos_Lapack.cpp.
|
inlinevirtual |
Returns the Epetra_LinearProblem.
Warning! Do not call return->SetOperator(...)
to attempt to change the Epetra_Operator
object (even if the new matrix has the same structure). This new operator matrix will be ignored!
Implements Amesos_BaseSolver.
Definition at line 102 of file Amesos_Lapack.h.
|
virtual |
Returns true if the solver can handle this matrix shape.
Returns true if the matrix shape is one that the underlying sparse direct solver can handle. Classes that work only on square matrices should return false for rectangular matrices. Classes that work only on symmetric matrices whould return false for non-symmetric matrices.
Implements Amesos_BaseSolver.
Definition at line 104 of file Amesos_Lapack.cpp.
|
inlinevirtual |
If set true, X will be set to the solution of AT X = B (not A X = B)
If the implementation of this interface does not support transpose use, this method should return a value of -1.
<br >Preconditions:
<br >Postconditions:
Implements Amesos_BaseSolver.
Definition at line 106 of file Amesos_Lapack.h.
|
inlinevirtual |
Returns the current UseTranspose setting.
Implements Amesos_BaseSolver.
Definition at line 111 of file Amesos_Lapack.h.
|
inlinevirtual |
Returns a pointer to the Epetra_Comm communicator associated with this operator.
Implements Amesos_BaseSolver.
Definition at line 113 of file Amesos_Lapack.h.
|
virtual |
Use this parameter list to read values from.
Redefined from Teuchos::ParameterListAcceptor
Reimplemented from Amesos_BaseSolver.
Definition at line 60 of file Amesos_Lapack.cpp.
|
virtual |
This is an empty stub.
Reimplemented from Amesos_BaseSolver.
Definition at line 53 of file Amesos_Lapack.cpp.
|
virtual |
Deprecated - Sets parameters.
Implements Amesos_BaseSolver.
Definition at line 85 of file Amesos_Lapack.cpp.
int Amesos_Lapack::GEEV | ( | Epetra_Vector & | Er, |
Epetra_Vector & | Ei | ||
) |
Computes the eigenvalues of the linear system matrix using DGEEV.
Er | - (Out) On processor zero only, it will contain the real component of the eigenvalues. |
Ei | - (Out) On processor zero only, it will contain the imaginary component of the eigenvalues. |
Definition at line 372 of file Amesos_Lapack.cpp.
|
inlinevirtual |
Returns the number of symbolic factorizations performed by this object.
Implements Amesos_BaseSolver.
Definition at line 142 of file Amesos_Lapack.h.
|
inlinevirtual |
Returns the number of numeric factorizations performed by this object.
Implements Amesos_BaseSolver.
Definition at line 145 of file Amesos_Lapack.h.
|
inlinevirtual |
Returns the number of solves performed by this object.
Implements Amesos_BaseSolver.
Definition at line 148 of file Amesos_Lapack.h.
|
virtual |
Print timing information.
Implements Amesos_BaseSolver.
Definition at line 488 of file Amesos_Lapack.cpp.
|
virtual |
Print information about the factorization and solution phases.
Implements Amesos_BaseSolver.
Definition at line 460 of file Amesos_Lapack.cpp.
|
inlinevirtual |
Extracts timing information from the current solver and places it in the parameter list.
Reimplemented from Amesos_BaseSolver.
Definition at line 157 of file Amesos_Lapack.h.
|
inlineprotected |
Returns a pointer to the linear system matrix.
Definition at line 164 of file Amesos_Lapack.h.
|
inlineprotected |
Returns the number of global rows, or -1 if Matrix() returns 0.
Definition at line 171 of file Amesos_Lapack.h.
|
inlineprotected |
Definition at line 177 of file Amesos_Lapack.h.
|
inlineprotected |
Returns the number of local rows, or -1 if Matrix() returns 0.
Definition at line 183 of file Amesos_Lapack.h.
|
inlineprotected |
Returns a reference to serial map (that with all elements on process 0).
Definition at line 189 of file Amesos_Lapack.h.
|
inlineprotected |
Returns a reference to serial matrix (that with all rows on process 0).
Definition at line 195 of file Amesos_Lapack.h.
|
inlineprotected |
Definition at line 200 of file Amesos_Lapack.h.
|
inlineprotected |
Returns a reference to the matrix importer (from row map to serial map).
Definition at line 206 of file Amesos_Lapack.h.
|
inlineprotected |
Returns a reference to the rhs exporter (from range map to serial map).
Definition at line 212 of file Amesos_Lapack.h.
|
inlineprotected |
Returns a reference to the solution importer (to domain map from serial map).
Definition at line 218 of file Amesos_Lapack.h.
|
protected |
Solves the linear system, when only one process is used.
Definition at line 230 of file Amesos_Lapack.cpp.
|
protected |
Solves the linear system, when more than one process is used.
Definition at line 259 of file Amesos_Lapack.cpp.
|
protected |
Converts a distributed matrix to serial matrix.
Definition at line 352 of file Amesos_Lapack.cpp.
|
protected |
Converts a serial matrix to dense format.
Definition at line 304 of file Amesos_Lapack.cpp.
|
protected |
Factors the matrix using LAPACK.
Definition at line 445 of file Amesos_Lapack.cpp.
|
protected |
Definition at line 223 of file Amesos_Lapack.h.
|
protected |
Definition at line 242 of file Amesos_Lapack.h.
|
protected |
Definition at line 243 of file Amesos_Lapack.h.
|
protected |
Definition at line 244 of file Amesos_Lapack.h.
|
protected |
Definition at line 245 of file Amesos_Lapack.h.
|
protected |
Definition at line 246 of file Amesos_Lapack.h.
|
protected |
Definition at line 247 of file Amesos_Lapack.h.
|
protected |
Dense matrix.
Definition at line 250 of file Amesos_Lapack.h.
|
protected |
Dense LHS.
Definition at line 252 of file Amesos_Lapack.h.
|
protected |
Dense RHS.
Definition at line 254 of file Amesos_Lapack.h.
|
protected |
Linear problem for dense matrix and vectors.
Definition at line 256 of file Amesos_Lapack.h.
|
protected |
If true
, the linear system with the transpose will be solved.
Definition at line 259 of file Amesos_Lapack.h.
|
protected |
Pointer to the linear problem.
Definition at line 261 of file Amesos_Lapack.h.
|
protected |
Quick access ids for the individual timings.
Definition at line 264 of file Amesos_Lapack.h.
|
protected |
Definition at line 264 of file Amesos_Lapack.h.
|
protected |
Definition at line 264 of file Amesos_Lapack.h.
|
protected |
Definition at line 264 of file Amesos_Lapack.h.
|
protected |
Definition at line 264 of file Amesos_Lapack.h.
|
protected |
Definition at line 264 of file Amesos_Lapack.h.
|
protected |
Definition at line 266 of file Amesos_Lapack.h.
|
protected |
Definition at line 267 of file Amesos_Lapack.h.
|
protected |
Definition at line 269 of file Amesos_Lapack.h.