39 #ifndef AMESOS_PARAKLETE_H
40 #define AMESOS_PARAKLETE_H
42 #if defined(Amesos_SHOW_DEPRECATED_WARNINGS)
44 #warning "The Amesos package is deprecated"
65 #ifdef HAVE_AMESOS_EPETRAEXT
95 #ifndef DOXYGEN_SHOULD_SKIP_THIS
262 std::vector <long>
Ap;
263 std::vector <long>
Ai;
283 #ifdef HAVE_AMESOS_EPETRAEXT
int NumSymbolicFact_
Number of symbolic factorization phases.
int MtxConvTime_
Quick access pointers to internal timing information.
Amesos_Control: Container for some control variables.
int SymbolicFactorization()
Performs SymbolicFactorization on the matrix A.
Teuchos::RCP< Epetra_Import > ImportToSerial_
Importer to process 0.
~Amesos_Paraklete(void)
Amesos_Paraklete Destructor.
Amesos_Paraklete: A serial, unblocked code ideal for getting started and for very sparse matrices...
Epetra_MultiVector * SerialB_
Serial versions of the LHS and RHS (may point to the original vector if serial)
int NumSymbolicFact() const
Returns the number of symbolic factorizations performed by this object.
std::vector< double > RowValuesV_
Only used for RowMatrices to extract copies.
Epetra_RowMatrix * StdIndexMatrix_
Points to a Contiguous Copy of A.
int numentries_
Number of non-zero entries in Problem_->GetOperator()
Teuchos::RCP< Epetra_MultiVector > SerialBextract_
void GetTiming(Teuchos::ParameterList &TimingParameterList) const
Extracts timing information from the current solver and places it in the parameter list...
Amesos_Paraklete(const Epetra_LinearProblem &LinearProblem)
Amesos_Paraklete Constructor.
std::vector< int > ColIndicesV_
Only used for RowMatrices to extract copies.
Epetra_MultiVector * StdIndexRangeVector_
int NumNumericFact_
Number of numeric factorization phases.
bool UseTranspose_
If true, the transpose of A is used.
Epetra_MultiVector * SerialX_
int NumSolve() const
Returns the number of solves performed by this object.
const Epetra_Comm & Comm() const
Returns a pointer to the Epetra_Comm communicator associated with this operator.
Teuchos::RCP< Epetra_CrsMatrix > SerialCrsMatrixA_
Points to a Serial Copy of A (unused if UseDataInPlace_==1)
int NumSolve_
Number of solves.
Epetra_MultiVector * StdIndexDomainVector_
Teuchos::RCP< Epetra_Import > ImportDomainToSerial_
int SetUseTranspose(bool UseTranspose_in)
SetUseTranpose()
Teuchos::RCP< Epetra_Map > SerialMap_
Points to a Serial Map (unused if UseDataInPlace_ == 1 )
int NumNumericFact() const
Returns the number of numeric factorizations performed by this object.
int NumGlobalElements_
Number of rows and columns in the Problem_->GetOperator()
const Epetra_LinearProblem * GetProblem() const
Get a pointer to the Problem.
Epetra_RowMatrix * RowMatrixA_
Operator converted to a RowMatrix.
void GetTiming(Teuchos::ParameterList &list) const
Load up the current timing information into the parameter list.
void PrintStatus() const
Prints information about the factorization and solution phases.
Teuchos::RCP< Amesos_Paraklete_Pimpl > PrivateParakleteData_
Epetra_CrsMatrix * CrsMatrixA_
Operator converted to a CrsMatrix.
Amesos_Status: Container for some status variables.
int NumVectors_
Number of vectors in RHS and LHS.
Teuchos::RCP< Amesos_StandardIndex > StdIndexDomain_
int ConvertToParakleteCRS(bool firsttime)
Amesos_Time: Container for timing information.
int Solve()
Solves A X = B (or AT x = B)
void PrintTiming() const
Prints timing information.
int PerformNumericFactorization()
int NumericFactorization()
Performs NumericFactorization on the matrix A.
int SetParameters(Teuchos::ParameterList &ParameterList)
Updates internal variables.
Teuchos::RCP< Amesos_StandardIndex > StdIndexRange_
int CreateLocalMatrixAndExporters()
bool MatrixShapeOK() const
Returns true if PARAKLETE can handle this matrix shape.
int UseDataInPlace_
1 if Problem_->GetOperator() is stored entirely on process 0
Epetra_RowMatrix * SerialMatrix_
Points to a Serial Copy of A.
Teuchos::RCP< Epetra_MultiVector > SerialXextract_
Serial versions of the LHS and RHS (if necessary)
bool TrustMe_
If true, no checks are made and the matrix is assume to be distributed.
const Epetra_LinearProblem * Problem_
Pointer to the linear system problem.
int PerformSymbolicFactorization()
Teuchos::RCP< Epetra_Import > ImportRangeToSerial_
Amesos_BaseSolver: A pure virtual class for direct solution of real-valued double-precision operators...
double * SerialXBvalues_
Pointer to the actual values in the serial version of X and B.
Amesos_NoCopiable: Simple class to prevent the usage of copy constructor and operator =...
std::vector< long > Ap
Ap, Ai, Aval form the compressed row storage used by Paraklete Ai and Aval can point directly into a ...
std::vector< double > VecAval
Amesos_Utils: Collections of basic utilities.
bool UseTranspose() const
Returns the current UseTranspose setting.
Teuchos::RCP< Amesos_StandardIndex > StdIndex_