IFPACK Development
|
Ifpack_TriDiContainer: a class to define containers for dense matrices. More...
#include <Ifpack_TriDiContainer.h>
Public Member Functions | |
Ifpack_TriDiContainer (const int NumRows_in, const int NumVectors_in=1) | |
Default constructor. | |
Ifpack_TriDiContainer (const Ifpack_TriDiContainer &rhs) | |
Copy constructor. | |
virtual | ~Ifpack_TriDiContainer () |
Destructor. | |
Ifpack_TriDiContainer & | operator= (const Ifpack_TriDiContainer &rhs) |
Operator=. | |
virtual int | NumRows () const |
Returns the number of rows of the matrix and LHS/RHS. | |
virtual int | NumVectors () const |
Returns the number of vectors in LHS/RHS. | |
virtual int | SetNumVectors (const int NumVectors_in) |
Sets the number of vectors for LHS/RHS. | |
virtual double & | LHS (const int i, const int Vector=0) |
Returns the i-th component of the vector Vector of LHS. | |
virtual double & | RHS (const int i, const int Vector=0) |
Returns the i-th component of the vector Vector of RHS. | |
virtual int & | ID (const int i) |
Returns the ID associated to local row i. | |
virtual int | SetMatrixElement (const int row, const int col, const double value) |
Set the matrix element (row,col) to value . | |
virtual int | SetParameters (Teuchos::ParameterList &) |
Sets all necessary parameters. | |
virtual bool | IsInitialized () const |
Returns true is the container has been successfully initialized. | |
virtual bool | IsComputed () const |
Returns true is the container has been successfully computed. | |
virtual const char * | Label () const |
Returns the label of this container. | |
virtual int | SetKeepNonFactoredMatrix (const bool flag) |
If flag is true , keeps a copy of the non-factored matrix. | |
virtual bool | KeepNonFactoredMatrix () const |
Returns KeepNonFactoredMatrix_. | |
virtual const Epetra_SerialDenseMatrix & | LHS () const |
Returns the dense vector containing the LHS. | |
virtual const Epetra_SerialDenseMatrix & | RHS () const |
Returns the dense vector containing the RHS. | |
virtual const Ifpack_SerialTriDiMatrix & | Matrix () const |
Returns the dense matrix or its factors. | |
virtual const Ifpack_SerialTriDiMatrix & | NonFactoredMatrix () const |
Returns the non-factored dense matrix (only if stored). | |
virtual const Epetra_IntSerialDenseVector & | ID () const |
Returns the integer dense vector of IDs. | |
virtual int | Initialize () |
Initialize the container. | |
virtual int | Compute (const Epetra_RowMatrix &Matrix_in) |
Finalizes the linear system matrix and prepares for the application of the inverse. | |
virtual int | Apply () |
Apply the matrix to RHS, results are stored in LHS. | |
virtual int | ApplyInverse () |
Apply the inverse of the matrix to RHS, results are stored in LHS. | |
virtual double | InitializeFlops () const |
Returns the flops in Initialize(). | |
virtual double | ComputeFlops () const |
Returns the flops in Compute(). | |
virtual double | ApplyFlops () const |
Returns the flops in Apply(). | |
virtual double | ApplyInverseFlops () const |
Returns the flops in ApplyInverse(). | |
virtual std::ostream & | Print (std::ostream &os) const |
Prints basic information on iostream. This function is used by operator<<. | |
![]() | |
virtual | ~Ifpack_Container () |
Destructor. | |
Ifpack_TriDiContainer: a class to define containers for dense matrices.
To understand what an IFPACK container is, please refer to the documentation of the pure virtual class Ifpack_Container. Currently, containers are used by class Ifpack_BlockRelaxation.
Using block methods, one needs to store all diagonal blocks and to be also to apply the inverse of each diagonal block. Using class Ifpack_TriDiContainer, one can store the blocks as dense matrices, which can be advantageous when the blocks are small. Otherwise, class Ifpack_SparseContainer is probably more appropriate.
A typical use of a container is as follows:
A call to Compute() computes the LU factorization of the linear system matrix, using LAPACK (more precisely, by calling the corresponding routines in Ifpack_SerialTriDiSolver). The default behavior is to store the matrix factors by overwriting the linear system matrix itself. This way, method Apply() fails, as the original matrix does no longer exists. An alternative is to call KeepNonFactoredMatrix(true)
, which forces Ifpack_TriDiContainer to maintain in memory a copy of the non-factored matrix.
Definition at line 118 of file Ifpack_TriDiContainer.h.
|
inline |
Default constructor.
Definition at line 125 of file Ifpack_TriDiContainer.h.
|
inline |
Copy constructor.
Definition at line 137 of file Ifpack_TriDiContainer.h.
References ID(), LHS(), Matrix(), NonFactoredMatrix(), and RHS().
|
inlinevirtual |
Destructor.
Definition at line 153 of file Ifpack_TriDiContainer.h.
|
virtual |
Apply the matrix to RHS, results are stored in LHS.
Implements Ifpack_Container.
Definition at line 240 of file Ifpack_TriDiContainer.cpp.
|
inlinevirtual |
Returns the flops in Apply().
Implements Ifpack_Container.
Definition at line 330 of file Ifpack_TriDiContainer.h.
|
virtual |
Apply the inverse of the matrix to RHS, results are stored in LHS.
Implements Ifpack_Container.
Definition at line 128 of file Ifpack_TriDiContainer.cpp.
References IsComputed(), and Ifpack_SerialTriDiSolver::Solve().
|
inlinevirtual |
Returns the flops in ApplyInverse().
Implements Ifpack_Container.
Definition at line 335 of file Ifpack_TriDiContainer.h.
Referenced by Print().
|
virtual |
Finalizes the linear system matrix and prepares for the application of the inverse.
Implements Ifpack_Container.
Definition at line 208 of file Ifpack_TriDiContainer.cpp.
References Ifpack_SerialTriDiSolver::Factor(), Initialize(), and IsInitialized().
|
inlinevirtual |
Returns the flops in Compute().
Implements Ifpack_Container.
Definition at line 325 of file Ifpack_TriDiContainer.h.
Referenced by Print().
|
inlinevirtual |
Returns the integer dense vector of IDs.
Definition at line 298 of file Ifpack_TriDiContainer.h.
|
virtual |
Returns the ID associated to local row i.
The set of (local) rows assigned to this container is defined by calling ID(i) = j, where i (from 0 to NumRows()) indicates the container-row, and j indicates the local row in the calling process.
This is usually used to recorder the local row ID (on calling process) of the i-th row in the container.
Implements Ifpack_Container.
Definition at line 145 of file Ifpack_TriDiContainer.cpp.
Referenced by Ifpack_TriDiContainer(), and operator=().
|
virtual |
Initialize the container.
Implements Ifpack_Container.
Definition at line 54 of file Ifpack_TriDiContainer.cpp.
References Ifpack_SerialTriDiMatrix::A(), Epetra_IntSerialDenseMatrix::Reshape(), Epetra_SerialDenseMatrix::Reshape(), Ifpack_SerialTriDiSolver::SetMatrix(), Ifpack_SerialTriDiSolver::SetVectors(), and Ifpack_SerialTriDiMatrix::Shape().
Referenced by Compute(), and SetMatrixElement().
|
inlinevirtual |
Returns the flops in Initialize().
Implements Ifpack_Container.
Definition at line 320 of file Ifpack_TriDiContainer.h.
|
inlinevirtual |
Returns true
is the container has been successfully computed.
Implements Ifpack_Container.
Definition at line 249 of file Ifpack_TriDiContainer.h.
Referenced by ApplyInverse(), operator=(), and Print().
|
inlinevirtual |
Returns true
is the container has been successfully initialized.
Implements Ifpack_Container.
Definition at line 243 of file Ifpack_TriDiContainer.h.
Referenced by Compute(), Print(), and SetMatrixElement().
|
inlinevirtual |
Returns KeepNonFactoredMatrix_.
Definition at line 268 of file Ifpack_TriDiContainer.h.
Referenced by operator=().
|
inlinevirtual |
Returns the label of this container.
Implements Ifpack_Container.
Definition at line 255 of file Ifpack_TriDiContainer.h.
|
inlinevirtual |
Returns the dense vector containing the LHS.
Definition at line 274 of file Ifpack_TriDiContainer.h.
|
virtual |
Returns the i-th component of the vector Vector of LHS.
Implements Ifpack_Container.
Definition at line 95 of file Ifpack_TriDiContainer.cpp.
References Epetra_SerialDenseMatrix::A().
Referenced by Ifpack_TriDiContainer(), and operator=().
|
inlinevirtual |
Returns the dense matrix or its factors.
Definition at line 286 of file Ifpack_TriDiContainer.h.
Referenced by Ifpack_TriDiContainer(), and operator=().
|
inlinevirtual |
Returns the non-factored dense matrix (only if stored).
Definition at line 292 of file Ifpack_TriDiContainer.h.
Referenced by Ifpack_TriDiContainer(), and operator=().
|
virtual |
Returns the number of rows of the matrix and LHS/RHS.
Implements Ifpack_Container.
Definition at line 48 of file Ifpack_TriDiContainer.cpp.
Referenced by operator=(), Print(), and SetMatrixElement().
|
inlinevirtual |
Returns the number of vectors in LHS/RHS.
Implements Ifpack_Container.
Definition at line 187 of file Ifpack_TriDiContainer.h.
Referenced by operator=(), and Print().
|
inline |
Operator=.
Definition at line 160 of file Ifpack_TriDiContainer.h.
References ID(), IsComputed(), KeepNonFactoredMatrix(), LHS(), Matrix(), NonFactoredMatrix(), NumRows(), NumVectors(), and RHS().
|
virtual |
Prints basic information on iostream. This function is used by operator<<.
Implements Ifpack_Container.
Definition at line 259 of file Ifpack_TriDiContainer.cpp.
References ApplyInverseFlops(), ComputeFlops(), IsComputed(), IsInitialized(), NumRows(), and NumVectors().
|
inlinevirtual |
Returns the dense vector containing the RHS.
Definition at line 280 of file Ifpack_TriDiContainer.h.
|
virtual |
Returns the i-th component of the vector Vector of RHS.
Implements Ifpack_Container.
Definition at line 101 of file Ifpack_TriDiContainer.cpp.
References Epetra_SerialDenseMatrix::A().
Referenced by Ifpack_TriDiContainer(), and operator=().
|
inlinevirtual |
If flag
is true
, keeps a copy of the non-factored matrix.
Definition at line 261 of file Ifpack_TriDiContainer.h.
|
virtual |
Set the matrix element (row,col) to value
.
Implements Ifpack_Container.
Definition at line 107 of file Ifpack_TriDiContainer.cpp.
References Initialize(), IsInitialized(), and NumRows().
|
inlinevirtual |
Sets the number of vectors for LHS/RHS.
Implements Ifpack_Container.
Definition at line 193 of file Ifpack_TriDiContainer.h.
References Epetra_SerialDenseMatrix::Reshape(), and Ifpack_SerialTriDiSolver::SetVectors().
|
inlinevirtual |
Sets all necessary parameters.
Implements Ifpack_Container.
Definition at line 237 of file Ifpack_TriDiContainer.h.