Amesos Package Browser (Single Doxygen Collection)
Development
|
Amesos_Btf: Factors and solves a matrix after converting it to block triangular form. More...
#include <Amesos_BTF.h>
Private Attributes | |
bool | UseTranspose_ |
const Epetra_LinearProblem * | Problem_ |
bool | PrintTiming_ |
bool | PrintStatus_ |
bool | ComputeVectorNorms_ |
bool | ComputeTrueResidual_ |
int | verbose_ |
int | debug_ |
double | ConTime_ |
double | SymTime_ |
double | NumTime_ |
double | SolTime_ |
double | VecTime_ |
double | MatTime_ |
int | NumSymbolicFact_ |
int | NumNumericFact_ |
int | NumSolve_ |
Epetra_Time * | Time_ |
Amesos_Btf (const Epetra_LinearProblem &LinearProblem) | |
Amesos_Btf Constructor. More... | |
~Amesos_Btf (void) | |
Amesos_Btf 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_LinearProblem * | GetProblem () const |
Get a pointer to the Problem. More... | |
bool | MatrixShapeOK () const |
Returns true if BTF can handle this matrix shape. More... | |
int | SetUseTranspose (bool UseTranspose) |
SetUseTranpose(true) causes Solve() To compute A^T X = B. More... | |
bool | UseTranspose () const |
Returns the current UseTranspose setting. More... | |
const Epetra_Comm & | Comm () const |
Returns a pointer to the Epetra_Comm communicator associated with this matrix. 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 () |
Print timing information. More... | |
void | PrintStatus () |
Print information about the factorization and solution phases. More... | |
Additional Inherited Members | |
Public Member Functions inherited from Amesos_BaseSolver | |
virtual | ~Amesos_BaseSolver () |
Destructor. More... | |
virtual void | PrintStatus () const =0 |
Prints status information about the current solver. More... | |
virtual void | PrintTiming () const =0 |
Prints timing information about the current solver. More... | |
virtual void | setParameterList (Teuchos::RCP< Teuchos::ParameterList > const ¶mList) |
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... | |
virtual void | GetTiming (Teuchos::ParameterList &TimingParameterList) const |
Extracts timing information from the current solver and places it in the parameter list. (Does Not Work) More... | |
Public Member Functions inherited from Teuchos::ParameterListAcceptor | |
virtual RCP< const ParameterList > | getParameterList () const |
virtual RCP< const ParameterList > | getValidParameters () const |
Amesos_Btf: Factors and solves a matrix after converting it to block triangular form.
Amesos_Btf:
Definition at line 68 of file Amesos_BTF.h.
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.
|
virtual |
Performs SymbolicFactorization on the matrix A.
\return Integer error code, set to 0 if successful.
Implements Amesos_BaseSolver.
|
virtual |
Performs NumericFactorization on the matrix A.
\return Integer error code, set to 0 if successful.
Implements Amesos_BaseSolver.
|
virtual |
Foreach block i: For each block j Compute x_i -= A_{i,j} x_j Call Solve(x_i,b_i) Broadcast x_i
\return Integer error code, set to 0 if successful.
Implements Amesos_BaseSolver.
|
inlinevirtual |
Get a pointer to the Problem.
Implements Amesos_BaseSolver.
Definition at line 136 of file Amesos_BTF.h.
|
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.
|
inlinevirtual |
SetUseTranpose(true) causes Solve() To compute A^T X = B.
Implements Amesos_BaseSolver.
Definition at line 157 of file Amesos_BTF.h.
|
inlinevirtual |
Returns the current UseTranspose setting.
Implements Amesos_BaseSolver.
Definition at line 160 of file Amesos_BTF.h.
|
inlinevirtual |
Returns a pointer to the Epetra_Comm communicator associated with this matrix.
Implements Amesos_BaseSolver.
Definition at line 163 of file Amesos_BTF.h.
|
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 |
Returns the number of symbolic factorizations performed by this object.
Implements Amesos_BaseSolver.
Definition at line 185 of file Amesos_BTF.h.
|
inlinevirtual |
Returns the number of numeric factorizations performed by this object.
Implements Amesos_BaseSolver.
Definition at line 188 of file Amesos_BTF.h.
|
inlinevirtual |
Returns the number of solves performed by this object.
Implements Amesos_BaseSolver.
Definition at line 191 of file Amesos_BTF.h.
void Amesos_Btf::PrintTiming | ( | ) |
Print timing information.
void Amesos_Btf::PrintStatus | ( | ) |
Print information about the factorization and solution phases.
|
private |
Definition at line 202 of file Amesos_BTF.h.
|
private |
Definition at line 203 of file Amesos_BTF.h.
|
private |
Definition at line 205 of file Amesos_BTF.h.
|
private |
Definition at line 206 of file Amesos_BTF.h.
|
private |
Definition at line 207 of file Amesos_BTF.h.
|
private |
Definition at line 208 of file Amesos_BTF.h.
|
private |
Definition at line 210 of file Amesos_BTF.h.
|
private |
Definition at line 211 of file Amesos_BTF.h.
|
private |
Definition at line 214 of file Amesos_BTF.h.
|
private |
Definition at line 215 of file Amesos_BTF.h.
|
private |
Definition at line 216 of file Amesos_BTF.h.
|
private |
Definition at line 217 of file Amesos_BTF.h.
|
private |
Definition at line 218 of file Amesos_BTF.h.
|
private |
Definition at line 219 of file Amesos_BTF.h.
|
private |
Definition at line 221 of file Amesos_BTF.h.
|
private |
Definition at line 222 of file Amesos_BTF.h.
|
private |
Definition at line 223 of file Amesos_BTF.h.
|
private |
Definition at line 225 of file Amesos_BTF.h.