29 #ifndef AMESOS_PARDISO_H 
   30 #define AMESOS_PARDISO_H 
const Epetra_LinearProblem * Problem_
Pointer to the linear system problem. 
 
int NumSymbolicFact_
Number of symbolic factorization phases. 
 
Teuchos::RCP< Epetra_RowMatrix > SerialMatrix_
 
const Epetra_LinearProblem * GetProblem() const 
Get a pointer to the Problem. 
 
Amesos_Control: Container for some control variables. 
 
const Epetra_RowMatrix & Matrix() const 
 
Epetra_Import & Importer()
 
virtual const Epetra_Map & RowMatrixRowMap() const =0
 
int PerformNumericFactorization()
 
int NumNumericFact() const 
Returns the number of numeric factorizations performed by this object. 
 
Amesos_Pardiso(const Epetra_LinearProblem &LinearProblem)
Constructor. 
 
void PrintStatus() const 
Prints information about the factorization and solution phases. 
 
int SetUseTranspose(bool UseTranspose)
SetUseTranpose() 
 
Epetra_CrsMatrix & SerialCrsMatrix()
 
void PrintTiming() const 
Prints timing information. 
 
Teuchos::RCP< Epetra_CrsMatrix > SerialCrsMatrix_
 
int SymbolicFactorization()
Performs SymbolicFactorization on the matrix A. 
 
int NumSolve() const 
Returns the number of solves performed by this object. 
 
Amesos_Pardiso: Interface to the PARDISO package. 
 
void GetTiming(Teuchos::ParameterList &TimingParameterList) const 
Extracts timing information from the current solver and places it in the parameter list...
 
int NumNumericFact_
Number of numeric factorization phases. 
 
const Epetra_Comm & Comm() const 
Returns a pointer to the Epetra_Comm communicator associated with this matrix. 
 
int msglvl_
Actual matrix for solution phase (always 1) 
 
int NumSymbolicFact() const 
Returns the number of symbolic factorizations performed by this object. 
 
int NumSolve_
Number of solves. 
 
std::vector< double > aa_
 
int CheckError(const int error) const 
 
bool UseTranspose() const 
Returns the current UseTranspose setting. 
 
int SetParameters(Teuchos::ParameterList &ParameterList)
Set parameters from the input parameters list, returns 0 if successful. 
 
const Epetra_RowMatrix * Matrix_
 
void GetTiming(Teuchos::ParameterList &list) const 
Load up the current timing information into the parameter list. 
 
const Epetra_Map & Map() const 
 
int MtxConvTime_
Quick access pointers to the internal timing data. 
 
Amesos_Status: Container for some status variables. 
 
int NumericFactorization()
Performs NumericFactorization on the matrix A. 
 
Amesos_Time: Container for timing information. 
 
int PerformSymbolicFactorization()
 
~Amesos_Pardiso()
Destructor. 
 
Epetra_RowMatrix & SerialMatrix()
 
bool pardiso_initialized_
 
Teuchos::RCP< Epetra_Map > SerialMap_
 
Teuchos::RCP< Epetra_Import > Importer_
 
Amesos_BaseSolver: A pure virtual class for direct solution of real-valued double-precision operators...
 
int Solve()
Solves A X = B (or AT X = B) 
 
bool UseTranspose_
If true, the transpose of A is used. 
 
Amesos_NoCopiable: Simple class to prevent the usage of copy constructor and operator =...
 
bool MatrixShapeOK() const 
Returns true if PARDISO can handle this matrix shape. 
 
Teuchos::ParameterList param_
 
Amesos_Utils: Collections of basic utilities.