| 
    Amesos Development
    
   | 
 
Amesos_Btf: Factors and solves a matrix after converting it to block triangular form. More...
#include <Amesos_BTF.h>


Public Member Functions | |
| Amesos_Btf (const Epetra_LinearProblem &LinearProblem) | |
| Amesos_Btf Constructor.   | |
| ~Amesos_Btf (void) | |
| Amesos_Btf 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 BTF can handle this matrix shape.   | |
| int | SetUseTranspose (bool UseTranspose) | 
| SetUseTranpose(true) causes Solve() To compute A^T X = B.   | |
| 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) | 
| Updates internal variables.   | |
| 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 () | 
| Print timing information.  | |
| void | PrintStatus () | 
| Print information about the factorization and solution phases.  | |
  Public Member Functions inherited from Amesos_BaseSolver | |
| virtual | ~Amesos_BaseSolver () | 
| Destructor.  | |
| virtual void | PrintStatus () const =0 | 
| Prints status information about the current solver.   | |
| virtual void | PrintTiming () const =0 | 
| Prints timing information about the current solver.   | |
| 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.   | |
| virtual void | GetTiming (Teuchos::ParameterList &TimingParameterList) const | 
| Extracts timing information from the current solver and places it in the parameter list. (Does Not Work)   | |
Amesos_Btf: Factors and solves a matrix after converting it to block triangular form.
Amesos_Btf:
| Amesos_Btf::Amesos_Btf | ( | const Epetra_LinearProblem & | LinearProblem | ) | 
Amesos_Btf Constructor.
Creates an Amesos_Btf instance, using an Epetra_LinearProblem, passing in an already-defined Epetra_LinearProblem object.
Note: The operator in LinearProblem must be an Epetra_RowMatrix.
| Amesos_Btf::~Amesos_Btf | ( | void | ) | 
Amesos_Btf Destructor.
Completely deletes an Amesos_Btf object. 
 
      
  | 
  inlinevirtual | 
Returns a pointer to the Epetra_Comm communicator associated with this matrix.
Implements Amesos_BaseSolver.
References Comm(), and GetProblem().
Referenced by Comm().
      
  | 
  inlinevirtual | 
      
  | 
  virtual | 
Returns true if BTF can handle this matrix shape.
Returns true if the matrix shape is one that BTF can handle. BTF only works with square matrices. 
 
Implements Amesos_BaseSolver.
      
  | 
  virtual | 
Performs NumericFactorization on the matrix A.
\return Integer error code, set to 0 if successful.
Implements Amesos_BaseSolver.
      
  | 
  inlinevirtual | 
Returns the number of numeric factorizations performed by this object.
Implements Amesos_BaseSolver.
      
  | 
  inlinevirtual | 
Returns the number of solves performed by this object.
Implements Amesos_BaseSolver.
      
  | 
  inlinevirtual | 
Returns the number of symbolic factorizations performed by this object.
Implements Amesos_BaseSolver.
      
  | 
  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 subsequent 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.
Implements Amesos_BaseSolver.
      
  | 
  inlinevirtual | 
SetUseTranpose(true) causes Solve() To compute A^T X = B.
AT X = B
is computed
A X = B
is computed
Implements Amesos_BaseSolver.
References UseTranspose().
      
  | 
  virtual | 
Solves A X = B (or AT X = B)
\return Integer error code, set to 0 if successful.
Implements Amesos_BaseSolver.
      
  | 
  virtual | 
Performs SymbolicFactorization on the matrix A.
\return Integer error code, set to 0 if successful.
Implements Amesos_BaseSolver.
      
  | 
  inlinevirtual | 
Returns the current UseTranspose setting.
Implements Amesos_BaseSolver.
Referenced by SetUseTranspose().