39 #ifndef AMESOS_TAUCS_H
40 #define AMESOS_TAUCS_H
69 #ifndef DOXYGEN_SHOULD_SKIP_THIS
int NumSymbolicFact_
Number of symbolic factorization phases.
int NumNumericFact() const
Returns the number of numeric factorizations performed by this object.
Amesos_Control: Container for some control variables.
Epetra_Import & Importer()
Returns a reference to the already allocated Importer.
const Epetra_RowMatrix & Matrix() const
Returns a reference to the linear system matrix.
virtual const Epetra_Map & RowMatrixRowMap() const =0
int NumSolve() const
Returns the number of solves performed by this object.
bool UseTranspose() const
Returns the current UseTranspose setting.
int PerformSymbolicFactorization()
Performs the symbolic factorization.
int Solve()
Solves A X = B (or AT x = B)
int SetParameters(Teuchos::ParameterList &ParameterList)
Updates internal variables.
int MtxConvTime_
Quick accessor pointer to internal timing data.
int NumNumericFact_
Number of numeric factorization phases.
bool MatrixShapeOK() const
Returns true if the solver can handle this matrix shape.
int NumSolve_
Number of solves.
const Epetra_LinearProblem * GetProblem() const
Returns the Epetra_LinearProblem.
Amesos_Taucs(const Epetra_LinearProblem &LinearProblem)
Default constructor.
Teuchos::RCP< Epetra_Import > Importer_
int ConvertToSerial()
Constructs a matrix with all rows on processor 0.
int SymbolicFactorization()
Performs SymbolicFactorization on the matrix A.
bool UseTranspose_
If true, the transpose of A is used.
void GetTiming(Teuchos::ParameterList &list) const
Load up the current timing information into the parameter list.
Epetra_CrsMatrix & SerialCrsMatrix()
Returns a reference to the already SerialMatrix as Crs (if allocated).
~Amesos_Taucs(void)
Default destructor.
const Epetra_LinearProblem * Problem_
Pointer to the linear system problem.
void PrintTiming() const
Prints timing information.
Amesos_Status: Container for some status variables.
int PerformNumericFactorization()
Performs the numeric factorization.
const Epetra_RowMatrix * Matrix_
Amesos_Time: Container for timing information.
void PrintStatus() const
Prints status information.
Epetra_Map & SerialMap()
Returns a reference to the already allocated SerialMap.
int SetUseTranspose(bool UseTranspose)
Amesos_Taucs supports only symmetric matrices, hence transpose is irrelevant, but harmless...
int ConvertToTaucs()
Converts the Epetra_RowMatrix into TAUCS format.
Teuchos::RCP< Amesos_Taucs_Pimpl > PrivateTaucsData_
Teuchos::RCP< Epetra_Map > SerialMap_
void GetTiming(Teuchos::ParameterList &TimingParameterList) const
Extracts timing information from the current solver and places it in the parameter list...
int NumSymbolicFact() const
Returns the number of symbolic factorizations performed by this object.
const Epetra_Map & Map() const
Returns a reference to the RowMatrixRowMap().
int NumericFactorization()
Performs NumericFactorization on the matrix A.
const Epetra_Comm & Comm() const
Returns a pointer to the Epetra_Comm communicator associated with this operator.
Epetra_RowMatrix & SerialMatrix()
Returns a reference to the SerialMatrix.
Teuchos::RCP< Epetra_RowMatrix > SerialMatrix_
Amesos_BaseSolver: A pure virtual class for direct solution of real-valued double-precision operators...
Amesos_NoCopiable: Simple class to prevent the usage of copy constructor and operator =...
Teuchos::RCP< Epetra_CrsMatrix > SerialCrsMatrix_
Amesos_Taucs: An interface to the TAUCS package.
Amesos_Utils: Collections of basic utilities.