Amesos Package Browser (Single Doxygen Collection)  Development
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
Private Attributes | List of all members
Amesos_Taucs Class Reference

Amesos_Taucs: An interface to the TAUCS package. More...

#include <Amesos_Taucs.h>

Inheritance diagram for Amesos_Taucs:
Inheritance graph
[legend]

Private Attributes

bool UseTranspose_
 If true, the transpose of A is used. More...
 
Teuchos::RCP< Epetra_MapSerialMap_
 
Teuchos::RCP< Epetra_CrsMatrixSerialCrsMatrix_
 
Teuchos::RCP< Epetra_RowMatrixSerialMatrix_
 
Teuchos::RCP< Epetra_ImportImporter_
 
const Epetra_MapMap_
 
const Epetra_RowMatrixMatrix_
 
const Epetra_LinearProblemProblem_
 Pointer to the linear system problem. More...
 
int MtxConvTime_
 Quick accessor pointer to internal timing data. More...
 
int MtxRedistTime_
 
int VecRedistTime_
 
int SymFactTime_
 
int NumFactTime_
 
int SolveTime_
 
Teuchos::RCP< Amesos_Taucs_PimplPrivateTaucsData_
 
- Private Attributes inherited from Amesos_Control
double AddToDiag_
 Add this value to the diagonal. More...
 
bool refactorize_
 
double rcond_threshold_
 If error is greater than this value, perform symbolic and numeric factorization with full partial pivoting. More...
 
int ScaleMethod_
 
bool AddZeroToDiag_
 Adds zero to diagonal of redistributed matrix (some solvers choke on a matrix with a partly empty diag) More...
 
int MatrixProperty_
 Set the matrix property. More...
 
int MaxProcesses_
 
bool Reindex_
 If true, the Amesos class should reindex the matrix to standard indexing (i.e. More...
 
- Private Attributes inherited from Amesos_Status
bool IsSymbolicFactorizationOK_
 If true, SymbolicFactorization() has been successfully called. More...
 
bool IsNumericFactorizationOK_
 If true, NumericFactorization() has been successfully called. More...
 
bool PrintTiming_
 If true, prints timing information in the destructor. More...
 
bool PrintStatus_
 If true, print additional information in the destructor. More...
 
bool ComputeVectorNorms_
 If true, prints the norms of X and B in Solve(). More...
 
bool ComputeTrueResidual_
 If true, computes the true residual in Solve(). More...
 
int verbose_
 Toggles the output level. More...
 
int debug_
 Sets the level of debug_ output. More...
 
int NumSymbolicFact_
 Number of symbolic factorization phases. More...
 
int NumNumericFact_
 Number of numeric factorization phases. More...
 
int NumSolve_
 Number of solves. More...
 
double Threshold_
 
int MyPID_
 
int NumProcs_
 
 Amesos_Taucs (const Epetra_LinearProblem &LinearProblem)
 Default constructor. More...
 
 ~Amesos_Taucs (void)
 Default destructor. More...
 
int SymbolicFactorization ()
 Performs SymbolicFactorization on the matrix A. More...
 
int NumericFactorization ()
 Performs NumericFactorization on the matrix A. More...
 
int Solve ()
 Solves A X = B (or AT x = B) More...
 
const Epetra_LinearProblemGetProblem () const
 Returns the Epetra_LinearProblem. More...
 
bool MatrixShapeOK () const
 Returns true if the solver can handle this matrix shape. More...
 
int SetUseTranspose (bool UseTranspose)
 Amesos_Taucs supports only symmetric matrices, hence transpose is irrelevant, but harmless. More...
 
bool UseTranspose () const
 Returns the current UseTranspose setting. More...
 
const Epetra_CommComm () const
 Returns a pointer to the Epetra_Comm communicator associated with this operator. More...
 
int SetParameters (Teuchos::ParameterList &ParameterList)
 Updates internal variables. More...
 
int NumSymbolicFact () const
 Returns the number of symbolic factorizations performed by this object. More...
 
int NumNumericFact () const
 Returns the number of numeric factorizations performed by this object. More...
 
int NumSolve () const
 Returns the number of solves performed by this object. More...
 
void PrintTiming () const
 Prints timing information. More...
 
void PrintStatus () const
 Prints status information. More...
 
void GetTiming (Teuchos::ParameterList &TimingParameterList) const
 Extracts timing information from the current solver and places it in the parameter list. More...
 
const Epetra_MapMap () const
 Returns a reference to the RowMatrixRowMap(). More...
 
const Epetra_RowMatrixMatrix () const
 Returns a reference to the linear system matrix. More...
 
Epetra_MapSerialMap ()
 Returns a reference to the already allocated SerialMap. More...
 
Epetra_RowMatrixSerialMatrix ()
 Returns a reference to the SerialMatrix. More...
 
Epetra_CrsMatrixSerialCrsMatrix ()
 Returns a reference to the already SerialMatrix as Crs (if allocated). More...
 
Epetra_ImportImporter ()
 Returns a reference to the already allocated Importer. More...
 
int ConvertToSerial ()
 Constructs a matrix with all rows on processor 0. More...
 
int ConvertToTaucs ()
 Converts the Epetra_RowMatrix into TAUCS format. More...
 
int PerformSymbolicFactorization ()
 Performs the symbolic factorization. More...
 
int PerformNumericFactorization ()
 Performs the numeric factorization. More...
 

Additional Inherited Members

- Public Member Functions inherited from Amesos_BaseSolver
virtual ~Amesos_BaseSolver ()
 Destructor. More...
 
virtual void setParameterList (Teuchos::RCP< Teuchos::ParameterList > const &paramList)
 Redefined from Teuchos::ParameterListAcceptor (Does Not Work) More...
 
virtual Teuchos::RCP
< Teuchos::ParameterList
getNonconstParameterList ()
 This is an empty stub. More...
 
virtual Teuchos::RCP
< Teuchos::ParameterList
unsetParameterList ()
 This is an empty stub. More...
 
- Public Member Functions inherited from Teuchos::ParameterListAcceptor
virtual RCP< const ParameterListgetParameterList () const
 
virtual RCP< const ParameterListgetValidParameters () const
 
- Private Member Functions inherited from Amesos_Time
 Amesos_Time ()
 Default constructor to create size timers. More...
 
virtual ~Amesos_Time ()
 Default destructor. More...
 
void CreateTimer (const Epetra_Comm &Comm, int size=1)
 Initializes the Time object. More...
 
void ResetTimer (const int timerID=0)
 Resets the internally stored time object. More...
 
int AddTime (const std::string what, int dataID, const int timerID=0)
 Adds to field what the time elapsed since last call to ResetTimer(). More...
 
double GetTime (const std::string what) const
 Gets the cumulative time using the string. More...
 
double GetTime (const int dataID) const
 Gets the cumulative time using the dataID. More...
 
void GetTiming (Teuchos::ParameterList &list) const
 Load up the current timing information into the parameter list. More...
 
- Private Member Functions inherited from Amesos_NoCopiable
 Amesos_NoCopiable ()
 Default constructor. More...
 
 ~Amesos_NoCopiable ()
 Default destructor. More...
 
- Private Member Functions inherited from Amesos_Utils
 Amesos_Utils ()
 Default constructor. More...
 
 ~Amesos_Utils ()
 Default destructor. More...
 
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. More...
 
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. More...
 
void PrintLine () const
 Prints line on std::cout. More...
 
void SetMaxProcesses (int &MaxProcesses, const Epetra_RowMatrix &A)
 
- Private Member Functions inherited from Amesos_Control
 Amesos_Control ()
 Default constructor. More...
 
 ~Amesos_Control ()
 Default destructor. More...
 
void SetControlParameters (const Teuchos::ParameterList &ParameterList)
 
- Private Member Functions inherited from Amesos_Status
 Amesos_Status ()
 Default constructor. More...
 
 ~Amesos_Status ()
 Default destructor. More...
 
void SetStatusParameters (const Teuchos::ParameterList &ParameterList)
 

Detailed Description

Amesos_Taucs: An interface to the TAUCS package.

Interface to TAUCS.

Author
Marzio Sala, SNL 9214
Date
Last updated on June 2005
Last updated on 24-May-05.

Definition at line 73 of file Amesos_Taucs.h.

Constructor & Destructor Documentation

Amesos_Taucs::Amesos_Taucs ( const Epetra_LinearProblem LinearProblem)

Default constructor.

Definition at line 88 of file Amesos_Taucs.cpp.

Amesos_Taucs::~Amesos_Taucs ( void  )

Default destructor.

Definition at line 101 of file Amesos_Taucs.cpp.

Member Function Documentation

int Amesos_Taucs::SymbolicFactorization ( )
virtual

Performs SymbolicFactorization on the matrix A.

In addition to performing symbolic factorization on the matrix A, the call to SymbolicFactorization() implies that no change will be made to the non-zero structure of the underlying matrix without a subsequent call to SymbolicFactorization().

<br >Preconditions:

<br >Postconditions:

Returns
Integer error code, set to 0 if successful.

Implements Amesos_BaseSolver.

Definition at line 307 of file Amesos_Taucs.cpp.

int Amesos_Taucs::NumericFactorization ( )
virtual

Performs NumericFactorization on the matrix A.

In addition to performing numeric factorization on the matrix A, the call to NumericFactorization() implies that no change will be made to the underlying matrix without a subsequent call to NumericFactorization().

<br >Preconditions:

  • GetProblem().GetOperator() != 0 (return -1)
  • MatrixShapeOk(GetProblem().GetOperator()) == true (return -6)
  • The non-zero structure of the matrix should not have changed since the last call to SymbolicFactorization(). (return -2 if the number of non-zeros changes) Other changes can have arbitrary consequences.
  • The distribution of the matrix should not have changed since the last call to SymbolicFactorization()
  • The matrix should be indexed from 0 to n-1, unless the parameter "Reindex" was set to "true" prior to the call to SymbolicFactorization(). (return -3 - if caught)
  • The paremeter "Reindex" should not be set to "true" except on CrsMatrices. (return -4)
  • The paremeter "Reindex" should not be set to "true" unless Amesos was built with EpetraExt, i.e. with –enable-epetraext on the configure line. (return -4)
  • Internal errors retur -5.

<br >Postconditions:

  • Numeric Factorization will be performed (or marked to be performed) allowing Solve() to be performed correctly despite a potential change in in the matrix values (though not in the non-zero structure).
Returns
Integer error code, set to 0 if successful.

Implements Amesos_BaseSolver.

Definition at line 351 of file Amesos_Taucs.cpp.

int Amesos_Taucs::Solve ( )
virtual

Solves A X = B (or AT x = B)

<br >Preconditions:

<br >Postconditions:

  • X will be set such that A X = B (or AT X = B), within the limits of the accuracy of the underlying solver.
Returns
Integer error code, set to 0 if successful.

Implements Amesos_BaseSolver.

Definition at line 375 of file Amesos_Taucs.cpp.

const Epetra_LinearProblem* Amesos_Taucs::GetProblem ( ) const
inlinevirtual

Returns the Epetra_LinearProblem.

Warning! Do not call return->SetOperator(...) to attempt to change the Epetra_Operator object (even if the new matrix has the same structure). This new operator matrix will be ignored!

Implements Amesos_BaseSolver.

Definition at line 102 of file Amesos_Taucs.h.

bool Amesos_Taucs::MatrixShapeOK ( ) const
virtual

Returns true if the solver can handle this matrix shape.

Returns true if the matrix shape is one that the underlying sparse direct solver can handle. Classes that work only on square matrices should return false for rectangular matrices. Classes that work only on symmetric matrices whould return false for non-symmetric matrices.

Implements Amesos_BaseSolver.

Definition at line 294 of file Amesos_Taucs.cpp.

int Amesos_Taucs::SetUseTranspose ( bool  UseTranspose)
inlinevirtual

Amesos_Taucs supports only symmetric matrices, hence transpose is irrelevant, but harmless.

Implements Amesos_BaseSolver.

Definition at line 112 of file Amesos_Taucs.h.

bool Amesos_Taucs::UseTranspose ( ) const
inlinevirtual

Returns the current UseTranspose setting.

Implements Amesos_BaseSolver.

Definition at line 114 of file Amesos_Taucs.h.

const Epetra_Comm& Amesos_Taucs::Comm ( ) const
inlinevirtual

Returns a pointer to the Epetra_Comm communicator associated with this operator.

Implements Amesos_BaseSolver.

Definition at line 116 of file Amesos_Taucs.h.

int Amesos_Taucs::SetParameters ( Teuchos::ParameterList ParameterList)
virtual

Updates internal variables.

  <br \>Preconditions:<ul>
  <li>None.</li>
  </ul>

  <br \>Postconditions:<ul> 
  <li>Internal variables controlling the factorization and solve will
  be updated and take effect on all subseuent calls to NumericFactorization() 
  and Solve().</li>
  <li>All parameters whose value are to differ from the default values must 

be included in ParameterList. Parameters not specified in ParameterList revert to their default values.

Returns
Integer error code, set to 0 if successful.

Implements Amesos_BaseSolver.

Definition at line 230 of file Amesos_Taucs.cpp.

int Amesos_Taucs::NumSymbolicFact ( ) const
inlinevirtual

Returns the number of symbolic factorizations performed by this object.

Implements Amesos_BaseSolver.

Definition at line 121 of file Amesos_Taucs.h.

int Amesos_Taucs::NumNumericFact ( ) const
inlinevirtual

Returns the number of numeric factorizations performed by this object.

Implements Amesos_BaseSolver.

Definition at line 124 of file Amesos_Taucs.h.

int Amesos_Taucs::NumSolve ( ) const
inlinevirtual

Returns the number of solves performed by this object.

Implements Amesos_BaseSolver.

Definition at line 127 of file Amesos_Taucs.h.

void Amesos_Taucs::PrintTiming ( ) const
virtual

Prints timing information.

Implements Amesos_BaseSolver.

Definition at line 492 of file Amesos_Taucs.cpp.

void Amesos_Taucs::PrintStatus ( ) const
virtual

Prints status information.

Implements Amesos_BaseSolver.

Definition at line 463 of file Amesos_Taucs.cpp.

void Amesos_Taucs::GetTiming ( Teuchos::ParameterList TimingParameterList) const
inlinevirtual

Extracts timing information from the current solver and places it in the parameter list.

Reimplemented from Amesos_BaseSolver.

Definition at line 136 of file Amesos_Taucs.h.

const Epetra_Map& Amesos_Taucs::Map ( ) const
inlineprivate

Returns a reference to the RowMatrixRowMap().

Definition at line 144 of file Amesos_Taucs.h.

const Epetra_RowMatrix& Amesos_Taucs::Matrix ( ) const
inlineprivate

Returns a reference to the linear system matrix.

Definition at line 150 of file Amesos_Taucs.h.

Epetra_Map& Amesos_Taucs::SerialMap ( )
inlineprivate

Returns a reference to the already allocated SerialMap.

Definition at line 156 of file Amesos_Taucs.h.

Epetra_RowMatrix& Amesos_Taucs::SerialMatrix ( )
inlineprivate

Returns a reference to the SerialMatrix.

Definition at line 162 of file Amesos_Taucs.h.

Epetra_CrsMatrix& Amesos_Taucs::SerialCrsMatrix ( )
inlineprivate

Returns a reference to the already SerialMatrix as Crs (if allocated).

Definition at line 168 of file Amesos_Taucs.h.

Epetra_Import& Amesos_Taucs::Importer ( )
inlineprivate

Returns a reference to the already allocated Importer.

Definition at line 174 of file Amesos_Taucs.h.

int Amesos_Taucs::ConvertToSerial ( )
private

Constructs a matrix with all rows on processor 0.

Definition at line 124 of file Amesos_Taucs.cpp.

int Amesos_Taucs::ConvertToTaucs ( )
private

Converts the Epetra_RowMatrix into TAUCS format.

Definition at line 159 of file Amesos_Taucs.cpp.

int Amesos_Taucs::PerformSymbolicFactorization ( )
private

Performs the symbolic factorization.

Definition at line 242 of file Amesos_Taucs.cpp.

int Amesos_Taucs::PerformNumericFactorization ( )
private

Performs the numeric factorization.

Definition at line 270 of file Amesos_Taucs.cpp.

Member Data Documentation

bool Amesos_Taucs::UseTranspose_
private

If true, the transpose of A is used.

Definition at line 194 of file Amesos_Taucs.h.

Teuchos::RCP<Epetra_Map> Amesos_Taucs::SerialMap_
private

Definition at line 196 of file Amesos_Taucs.h.

Teuchos::RCP<Epetra_CrsMatrix> Amesos_Taucs::SerialCrsMatrix_
private

Definition at line 197 of file Amesos_Taucs.h.

Teuchos::RCP<Epetra_RowMatrix> Amesos_Taucs::SerialMatrix_
private

Definition at line 198 of file Amesos_Taucs.h.

Teuchos::RCP<Epetra_Import> Amesos_Taucs::Importer_
private

Definition at line 199 of file Amesos_Taucs.h.

const Epetra_Map* Amesos_Taucs::Map_
private

Definition at line 201 of file Amesos_Taucs.h.

const Epetra_RowMatrix* Amesos_Taucs::Matrix_
private

Definition at line 202 of file Amesos_Taucs.h.

const Epetra_LinearProblem* Amesos_Taucs::Problem_
private

Pointer to the linear system problem.

Definition at line 205 of file Amesos_Taucs.h.

int Amesos_Taucs::MtxConvTime_
private

Quick accessor pointer to internal timing data.

Definition at line 208 of file Amesos_Taucs.h.

int Amesos_Taucs::MtxRedistTime_
private

Definition at line 208 of file Amesos_Taucs.h.

int Amesos_Taucs::VecRedistTime_
private

Definition at line 208 of file Amesos_Taucs.h.

int Amesos_Taucs::SymFactTime_
private

Definition at line 209 of file Amesos_Taucs.h.

int Amesos_Taucs::NumFactTime_
private

Definition at line 209 of file Amesos_Taucs.h.

int Amesos_Taucs::SolveTime_
private

Definition at line 209 of file Amesos_Taucs.h.

Teuchos::RCP<Amesos_Taucs_Pimpl> Amesos_Taucs::PrivateTaucsData_
private

Definition at line 215 of file Amesos_Taucs.h.


The documentation for this class was generated from the following files: