29 #ifndef AMESOS_LAPACK_H 
   30 #define AMESOS_LAPACK_H 
  170 #ifndef EPETRA_NO_32BIT_GLOBAL_INDICES 
int NumSolve() const 
Returns the number of solves performed by this object. 
 
int NumSymbolicFact_
Number of symbolic factorization phases. 
 
Amesos_Lapack(const Epetra_LinearProblem &LinearProblem)
Amesos_Lapack Constructor. 
 
Amesos_Control: Container for some control variables. 
 
int SerialToDense()
Converts a serial matrix to dense format. 
 
Epetra_SerialDenseMatrix DenseRHS_
Dense RHS. 
 
Teuchos::RCP< Epetra_CrsMatrix > SerialCrsMatrix_
 
Epetra_SerialDenseMatrix DenseMatrix_
Dense matrix. 
 
Epetra_SerialDenseSolver DenseSolver_
Linear problem for dense matrix and vectors. 
 
void PrintStatus() const 
Print information about the factorization and solution phases. 
 
void setParameterList(Teuchos::RCP< Teuchos::ParameterList > const ¶mList)
Use this parameter list to read values from. 
 
long long NumGlobalNonzeros_
 
int SolveDistributed(Epetra_MultiVector &X, const Epetra_MultiVector &B)
Solves the linear system, when more than one process is used. 
 
const Epetra_Import & SolutionImporter()
Returns a reference to the solution importer (to domain map from serial map). 
 
Teuchos::RCP< Teuchos::ParameterList > pl_
 
int NumGlobalRows() const 
Returns the number of global rows, or -1 if Matrix() returns 0. 
 
int NumNumericFact() const 
Returns the number of numeric factorizations performed by this object. 
 
int DenseToFactored()
Factors the matrix using LAPACK. 
 
int NumNumericFact_
Number of numeric factorization phases. 
 
int NumMyRows() const 
Returns the number of local rows, or -1 if Matrix() returns 0. 
 
const Epetra_LinearProblem * GetProblem() const 
Returns the Epetra_LinearProblem. 
 
Teuchos::RCP< Teuchos::ParameterList > ParameterList_
 
int NumSolve_
Number of solves. 
 
int SymbolicFactorization()
Performs SymbolicFactorization on the matrix A. 
 
int GEEV(Epetra_Vector &Er, Epetra_Vector &Ei)
Computes the eigenvalues of the linear system matrix using DGEEV. 
 
Teuchos::RCP< Epetra_Export > RhsExporter_
 
int SetUseTranspose(bool UseTranspose_in)
If set true, X will be set to the solution of AT X = B (not A X = B) 
 
void GetTiming(Teuchos::ParameterList &list) const 
Load up the current timing information into the parameter list. 
 
bool UseTranspose_
If true, the linear system with the transpose will be solved. 
 
const Epetra_Comm & Comm() const 
Returns a pointer to the Epetra_Comm communicator associated with this operator. 
 
int NumSymbolicFact() const 
Returns the number of symbolic factorizations performed by this object. 
 
Amesos_Status: Container for some status variables. 
 
void GetTiming(Teuchos::ParameterList &TimingParameterList) const 
Extracts timing information from the current solver and places it in the parameter list...
 
Teuchos::RCP< Epetra_RowMatrix > SerialMatrix_
 
Epetra_SerialDenseMatrix DenseLHS_
Dense LHS. 
 
~Amesos_Lapack(void)
Amesos_Lapack Destructor. 
 
Amesos_Time: Container for timing information. 
 
const Epetra_Export & RhsExporter()
Returns a reference to the rhs exporter (from range map to serial map). 
 
Amesos_Lapack: an interface to LAPACK. 
 
const Epetra_Map & SerialMap()
Returns a reference to serial map (that with all elements on process 0). 
 
int MtxRedistTime_
Quick access ids for the individual timings. 
 
int SetParameters(Teuchos::ParameterList &ParameterList)
Deprecated - Sets parameters. 
 
Teuchos::RCP< Epetra_Map > SerialMap_
 
Epetra_RowMatrix * GetMatrix() const 
 
bool MatrixShapeOK() const 
Returns true if the solver can handle this matrix shape. 
 
Epetra_RowMatrix & SerialMatrix()
Returns a reference to serial matrix (that with all rows on process 0). 
 
Teuchos::RCP< Epetra_Import > MatrixImporter_
 
const Epetra_LinearProblem * Problem_
Pointer to the linear problem. 
 
int DistributedToSerial()
Converts a distributed matrix to serial matrix. 
 
Epetra_CrsMatrix & SerialCrsMatrix()
 
int NumericFactorization()
Performs NumericFactorization on the matrix A. 
 
long long NumGlobalRows64() const 
 
Amesos_BaseSolver: A pure virtual class for direct solution of real-valued double-precision operators...
 
Teuchos::RCP< Epetra_Import > SolutionImporter_
 
const Epetra_RowMatrix * Matrix() const 
Returns a pointer to the linear system matrix. 
 
int Solve()
Solves A X = B (or AT x = B) 
 
Teuchos::RCP< Teuchos::ParameterList > unsetParameterList()
This is an empty stub. 
 
Amesos_NoCopiable: Simple class to prevent the usage of copy constructor and operator =...
 
int SolveSerial(Epetra_MultiVector &X, const Epetra_MultiVector &B)
Solves the linear system, when only one process is used. 
 
void PrintTiming() const 
Print timing information. 
 
bool UseTranspose() const 
Returns the current UseTranspose setting. 
 
Amesos_Utils: Collections of basic utilities. 
 
const Epetra_Import & MatrixImporter()
Returns a reference to the matrix importer (from row map to serial map).