Amesos_Pardiso: Interface to the PARDISO package.
More...
#include <Amesos_Pardiso.h>
|
| Amesos_Pardiso (const Epetra_LinearProblem &LinearProblem) |
| Constructor.
|
|
| ~Amesos_Pardiso () |
| Destructor.
|
|
int | SymbolicFactorization () |
| Performs SymbolicFactorization on the matrix A.
|
|
int | NumericFactorization () |
| Performs NumericFactorization on the matrix A.
|
|
int | Solve () |
| Solves A X = B (or AT X = B)
|
|
const Epetra_LinearProblem * | GetProblem () const |
| Get a pointer to the Problem.
|
|
bool | MatrixShapeOK () const |
| Returns true if PARDISO can handle this matrix shape.
|
|
int | SetUseTranspose (bool UseTranspose) |
| SetUseTranpose()
|
|
bool | UseTranspose () const |
| Returns the current UseTranspose setting.
|
|
const Epetra_Comm & | Comm () const |
| Returns a pointer to the Epetra_Comm communicator associated with this matrix.
|
|
int | SetParameters (Teuchos::ParameterList &ParameterList) |
| Set parameters from the input parameters list, returns 0 if successful.
|
|
int | NumSymbolicFact () const |
| Returns the number of symbolic factorizations performed by this object.
|
|
int | NumNumericFact () const |
| Returns the number of numeric factorizations performed by this object.
|
|
int | NumSolve () const |
| Returns the number of solves performed by this object.
|
|
void | PrintTiming () const |
| Prints timing information.
|
|
void | PrintStatus () const |
| Prints information about the factorization and solution phases.
|
|
void | GetTiming (Teuchos::ParameterList &TimingParameterList) const |
| Extracts timing information from the current solver and places it in the parameter list.
|
|
virtual | ~Amesos_BaseSolver () |
| Destructor.
|
|
virtual void | setParameterList (Teuchos::RCP< Teuchos::ParameterList > const ¶mList) |
| Redefined from Teuchos::ParameterListAcceptor (Does Not Work)
|
|
virtual Teuchos::RCP< Teuchos::ParameterList > | getNonconstParameterList () |
| This is an empty stub.
|
|
virtual Teuchos::RCP< Teuchos::ParameterList > | unsetParameterList () |
| This is an empty stub.
|
|
|
int | CheckError (const int error) const |
|
const Epetra_Map & | Map () const |
|
const Epetra_RowMatrix & | Matrix () const |
|
Epetra_Map & | SerialMap () |
|
Epetra_RowMatrix & | SerialMatrix () |
|
Epetra_CrsMatrix & | SerialCrsMatrix () |
|
Epetra_Import & | Importer () |
|
int | ConvertToSerial () |
|
int | ConvertToPardiso () |
|
int | PerformSymbolicFactorization () |
|
int | PerformNumericFactorization () |
|
| Amesos_Time () |
| Default constructor to create size timers.
|
|
virtual | ~Amesos_Time () |
| Default destructor.
|
|
void | CreateTimer (const Epetra_Comm &Comm, int size=1) |
| Initializes the Time object.
|
|
void | ResetTimer (const int timerID=0) |
| Resets the internally stored time object.
|
|
int | AddTime (const std::string what, int dataID, const int timerID=0) |
| Adds to field what the time elapsed since last call to ResetTimer().
|
|
double | GetTime (const std::string what) const |
| Gets the cumulative time using the string.
|
|
double | GetTime (const int dataID) const |
| Gets the cumulative time using the dataID.
|
|
void | GetTiming (Teuchos::ParameterList &list) const |
| Load up the current timing information into the parameter list.
|
|
| Amesos_NoCopiable () |
| Default constructor.
|
|
| ~Amesos_NoCopiable () |
| Default destructor.
|
|
| Amesos_Utils () |
| Default constructor.
|
|
| ~Amesos_Utils () |
| Default destructor.
|
|
void | ComputeTrueResidual (const Epetra_RowMatrix &Matrix, const Epetra_MultiVector &X, const Epetra_MultiVector &B, const bool UseTranspose, const std::string prefix) const |
| Computes the true residual, B - Matrix * X, and prints the results.
|
|
void | ComputeVectorNorms (const Epetra_MultiVector &X, const Epetra_MultiVector &B, const std::string prefix) const |
| Computes the norms of X and B and print the results.
|
|
void | PrintLine () const |
| Prints line on std::cout.
|
|
void | SetMaxProcesses (int &MaxProcesses, const Epetra_RowMatrix &A) |
|
| Amesos_Control () |
| Default constructor.
|
|
| ~Amesos_Control () |
| Default destructor.
|
|
void | SetControlParameters (const Teuchos::ParameterList &ParameterList) |
|
| Amesos_Status () |
| Default constructor.
|
|
| ~Amesos_Status () |
| Default destructor.
|
|
void | SetStatusParameters (const Teuchos::ParameterList &ParameterList) |
|
Amesos_Pardiso: Interface to the PARDISO package.
- Author
- Marzio Sala, SNL 9214
- Date
- Last updated on June 2005
Definition at line 57 of file Amesos_Pardiso.h.
◆ Amesos_Pardiso()
Amesos_Pardiso::Amesos_Pardiso |
( |
const Epetra_LinearProblem & | LinearProblem | ) |
|
◆ ~Amesos_Pardiso()
Amesos_Pardiso::~Amesos_Pardiso |
( |
| ) |
|
◆ SymbolicFactorization()
int Amesos_Pardiso::SymbolicFactorization |
( |
| ) |
|
|
virtual |
◆ NumericFactorization()
int Amesos_Pardiso::NumericFactorization |
( |
| ) |
|
|
virtual |
◆ Solve()
int Amesos_Pardiso::Solve |
( |
| ) |
|
|
virtual |
◆ GetProblem()
const Epetra_LinearProblem * Amesos_Pardiso::GetProblem |
( |
| ) |
const |
|
inlinevirtual |
◆ MatrixShapeOK()
bool Amesos_Pardiso::MatrixShapeOK |
( |
| ) |
const |
|
virtual |
Returns true if PARDISO can handle this matrix shape.
Returns true if the matrix shape is one that PARDISO can handle. PARDISO only works with square matrices.
Implements Amesos_BaseSolver.
Definition at line 360 of file Amesos_Pardiso.cpp.
◆ SetUseTranspose()
int Amesos_Pardiso::SetUseTranspose |
( |
bool | UseTranspose | ) |
|
|
inlinevirtual |
◆ UseTranspose()
bool Amesos_Pardiso::UseTranspose |
( |
| ) |
const |
|
inlinevirtual |
◆ Comm()
const Epetra_Comm & Amesos_Pardiso::Comm |
( |
| ) |
const |
|
inlinevirtual |
◆ SetParameters()
int Amesos_Pardiso::SetParameters |
( |
Teuchos::ParameterList & | ParameterList | ) |
|
|
virtual |
◆ NumSymbolicFact()
int Amesos_Pardiso::NumSymbolicFact |
( |
| ) |
const |
|
inlinevirtual |
◆ NumNumericFact()
int Amesos_Pardiso::NumNumericFact |
( |
| ) |
const |
|
inlinevirtual |
◆ NumSolve()
int Amesos_Pardiso::NumSolve |
( |
| ) |
const |
|
inlinevirtual |
◆ PrintTiming()
void Amesos_Pardiso::PrintTiming |
( |
| ) |
const |
|
virtual |
◆ PrintStatus()
void Amesos_Pardiso::PrintStatus |
( |
| ) |
const |
|
virtual |
◆ GetTiming()
void Amesos_Pardiso::GetTiming |
( |
Teuchos::ParameterList & | TimingParameterList | ) |
const |
|
inlinevirtual |
◆ CheckError()
int Amesos_Pardiso::CheckError |
( |
const int | error | ) |
const |
|
private |
◆ Map()
const Epetra_Map & Amesos_Pardiso::Map |
( |
| ) |
const |
|
inlineprivate |
◆ Matrix()
const Epetra_RowMatrix & Amesos_Pardiso::Matrix |
( |
| ) |
const |
|
inlineprivate |
◆ SerialMap()
Epetra_Map & Amesos_Pardiso::SerialMap |
( |
| ) |
|
|
inlineprivate |
◆ SerialMatrix()
Epetra_RowMatrix & Amesos_Pardiso::SerialMatrix |
( |
| ) |
|
|
inlineprivate |
◆ SerialCrsMatrix()
Epetra_CrsMatrix & Amesos_Pardiso::SerialCrsMatrix |
( |
| ) |
|
|
inlineprivate |
◆ Importer()
Epetra_Import & Amesos_Pardiso::Importer |
( |
| ) |
|
|
inlineprivate |
◆ ConvertToSerial()
int Amesos_Pardiso::ConvertToSerial |
( |
| ) |
|
|
private |
◆ ConvertToPardiso()
int Amesos_Pardiso::ConvertToPardiso |
( |
| ) |
|
|
private |
◆ PerformSymbolicFactorization()
int Amesos_Pardiso::PerformSymbolicFactorization |
( |
| ) |
|
|
private |
◆ PerformNumericFactorization()
int Amesos_Pardiso::PerformNumericFactorization |
( |
| ) |
|
|
private |
◆ SerialMap_
Teuchos::RCP<Epetra_Map> Amesos_Pardiso::SerialMap_ |
|
private |
◆ SerialCrsMatrix_
Teuchos::RCP<Epetra_CrsMatrix> Amesos_Pardiso::SerialCrsMatrix_ |
|
private |
◆ SerialMatrix_
Teuchos::RCP<Epetra_RowMatrix> Amesos_Pardiso::SerialMatrix_ |
|
private |
◆ Importer_
Teuchos::RCP<Epetra_Import> Amesos_Pardiso::Importer_ |
|
private |
◆ Map_
const Epetra_Map* Amesos_Pardiso::Map_ |
|
private |
◆ Matrix_
const Epetra_RowMatrix* Amesos_Pardiso::Matrix_ |
|
private |
◆ UseTranspose_
bool Amesos_Pardiso::UseTranspose_ |
|
private |
◆ Problem_
const Epetra_LinearProblem* Amesos_Pardiso::Problem_ |
|
private |
◆ MtxConvTime_
int Amesos_Pardiso::MtxConvTime_ |
|
private |
Quick access pointers to the internal timing data.
Definition at line 186 of file Amesos_Pardiso.h.
◆ MtxRedistTime_
int Amesos_Pardiso::MtxRedistTime_ |
|
private |
◆ VecRedistTime_
int Amesos_Pardiso::VecRedistTime_ |
|
private |
◆ SymFactTime_
int Amesos_Pardiso::SymFactTime_ |
|
private |
◆ NumFactTime_
int Amesos_Pardiso::NumFactTime_ |
|
private |
◆ SolveTime_
int Amesos_Pardiso::SolveTime_ |
|
private |
◆ aa_
std::vector<double> Amesos_Pardiso::aa_ |
|
private |
◆ ia_
std::vector<int> Amesos_Pardiso::ia_ |
|
private |
◆ ja_
std::vector<int> Amesos_Pardiso::ja_ |
|
private |
◆ pardiso_initialized_
bool Amesos_Pardiso::pardiso_initialized_ |
|
private |
◆ mtype_
int Amesos_Pardiso::mtype_ |
|
private |
◆ pt_
void* Amesos_Pardiso::pt_[64] |
|
private |
◆ iparm_
int Amesos_Pardiso::iparm_[64] |
|
private |
◆ dparm_
double Amesos_Pardiso::dparm_[64] |
|
private |
◆ maxfct_
int Amesos_Pardiso::maxfct_ |
|
private |
◆ mnum_
int Amesos_Pardiso::mnum_ |
|
private |
◆ msglvl_
int Amesos_Pardiso::msglvl_ |
|
private |
◆ nrhs_
int Amesos_Pardiso::nrhs_ |
|
private |
◆ param_
Teuchos::ParameterList Amesos_Pardiso::param_ |
|
private |
The documentation for this class was generated from the following files: