29#ifndef AMESOS_DSCPACK_H
30#define AMESOS_DSCPACK_H
39#include "Epetra_LinearProblem.h"
40#include "Epetra_Comm.h"
41#include "Epetra_Import.h"
42#include "Teuchos_RCP.hpp"
48#ifndef DOXYGEN_SHOULD_SKIP_THIS
Amesos_BaseSolver: A pure virtual class for direct solution of real-valued double-precision operators...
Amesos_Control: Container for some control variables.
Amesos_Dscpack: An object-oriented wrapper for Dscpack.
int NumericFactorization()
Performs NumericFactorization on the matrix A.
int PerformSymbolicFactorization()
Performs the symbolic factorization.
int PerformNumericFactorization()
Performs the numeric factorization.
bool MatrixShapeOK() const
Returns true if DSCPACK can handle this matrix shape.
RCP< Epetra_Map > DscRowMap_
bool A_and_LU_built
Tells us whether to free them.
void PrintTiming() const
Prints timing information.
int NumSolve() const
Returns the number of solves performed by this object.
RCP< Epetra_Import > Importer_
const Epetra_Import & Importer() const
const Epetra_Map & DscColMap() const
Teuchos::RCP< Amesos_Dscpack_Pimpl > PrivateDscpackData_
int NumNumericFact() const
Returns the number of numeric factorizations performed by this object.
int NumSymbolicFact() const
Returns the number of symbolic factorizations performed by this object.
const Epetra_LinearProblem * GetProblem() const
Returns the Epetra_LinearProblem.
int Solve()
Solves A X = B (or AT x = B)
void PrintStatus() const
Prints information about the factorization and solution phases.
int SetParameters(Teuchos::ParameterList &ParameterList)
Updates internal variables.
RCP< Epetra_Map > DscColMap_
const Epetra_Comm & Comm() const
Returns a pointer to the Epetra_Comm communicator associated with this operator.
void GetTiming(Teuchos::ParameterList &TimingParameterList) const
Extracts timing information from the current solver and places it in the parameter list.
const Epetra_Map & DscRowMap() const
~Amesos_Dscpack(void)
Amesos_Dscpack Destructor.
int SymbolicFactorization()
Performs SymbolicFactorization on the matrix A.
bool UseTranspose() const
Returns the current UseTranspose setting.
const Epetra_LinearProblem * Problem_
Pointer to the linear problem.
int SetUseTranspose(bool UseTranspose)
If set true, X will be set to the solution of AT X = B (not A X = B)
int * GlobalStructNewColNum
Amesos_NoCopiable: Simple class to prevent the usage of copy constructor and operator =.
Amesos_Status: Container for some status variables.
int NumSymbolicFact_
Number of symbolic factorization phases.
int NumSolve_
Number of solves.
int NumNumericFact_
Number of numeric factorization phases.
Amesos_Time: Container for timing information.
void GetTiming(Teuchos::ParameterList &list) const
Load up the current timing information into the parameter list.
Amesos_Utils: Collections of basic utilities.