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