Ifpack Package Browser (Single Doxygen Collection)
Development
|
Ifpack_ReorderFilter: a class for light-weight reorder of local rows and columns of an Epetra_RowMatrix. More...
#include <Ifpack_ReorderFilter.h>
Public Member Functions | |
Ifpack_ReorderFilter (const Teuchos::RefCountPtr< Epetra_RowMatrix > &Matrix_in, const Teuchos::RefCountPtr< Ifpack_Reordering > &Reordering_in) | |
Ifpack_ReorderFilter (const Ifpack_ReorderFilter &RHS) | |
Copy constructor. More... | |
virtual | ~Ifpack_ReorderFilter () |
Destructor. More... | |
Ifpack_ReorderFilter & | operator= (const Ifpack_ReorderFilter &RHS) |
Operator assignment. More... | |
virtual int | NumMyRowEntries (int MyRow, int &NumEntries) const |
Returns the number of local row entries. More... | |
virtual int | MaxNumEntries () const |
Returns maximum num entries. More... | |
virtual int | ExtractMyRowCopy (int MyRow, int Length, int &NumEntries, double *Values, int *Indices) const |
virtual int | ExtractDiagonalCopy (Epetra_Vector &Diagonal) const |
Extracts a copy of the diagonal of the reordered matrix. More... | |
virtual int | Multiply (bool TransA, const Epetra_MultiVector &X, Epetra_MultiVector &Y) const |
Multiplies multi-vector X with the reordered matrix, returns result in Y. More... | |
virtual int | Solve (bool Upper, bool Trans, bool UnitDiagonal, const Epetra_MultiVector &X, Epetra_MultiVector &Y) const |
Solve, not implemented. More... | |
virtual int | Apply (const Epetra_MultiVector &X, Epetra_MultiVector &Y) const |
Applies the reordered matrix to multi-vector X, returns the result in Y. More... | |
virtual int | ApplyInverse (const Epetra_MultiVector &, Epetra_MultiVector &) const |
Applies the inverse of this operator (not implemented). More... | |
virtual int | InvRowSums (Epetra_Vector &) const |
Inverse of row sums (not implemented). More... | |
virtual int | LeftScale (const Epetra_Vector &) |
Left scale of the matrix (not implemented). More... | |
virtual int | InvColSums (Epetra_Vector &) const |
Inverse of column sums (not implemented). More... | |
virtual int | RightScale (const Epetra_Vector &) |
Right scale of the matrix (not implemented). More... | |
virtual bool | Filled () const |
Returns true is the matrix called FillComplete(). More... | |
virtual double | NormInf () const |
Returns the infinite-norm. More... | |
virtual double | NormOne () const |
Returns the 1-norm. More... | |
virtual int | NumGlobalNonzeros () const |
Returns the number of global nonzero elements. More... | |
virtual int | NumGlobalRows () const |
Returns the number of global rows. More... | |
virtual int | NumGlobalCols () const |
Returns the number of global columns. More... | |
virtual int | NumGlobalDiagonals () const |
Returns the number of global diagonals. More... | |
virtual long long | NumGlobalNonzeros64 () const |
Returns the number of global nonzero elements. More... | |
virtual long long | NumGlobalRows64 () const |
Returns the number of global rows. More... | |
virtual long long | NumGlobalCols64 () const |
Returns the number of global columns. More... | |
virtual long long | NumGlobalDiagonals64 () const |
Returns the number of global diagonals. More... | |
virtual int | NumMyNonzeros () const |
Returns the number of local nonzero elements. More... | |
virtual int | NumMyRows () const |
Returns the number of local rows. More... | |
virtual int | NumMyCols () const |
Returns the number of local columns. More... | |
virtual int | NumMyDiagonals () const |
Returns the number of local diagonals. More... | |
virtual bool | LowerTriangular () const |
Returns true is the reordered matrix is lower triangular. More... | |
virtual bool | UpperTriangular () const |
Returns true is the reordered matrix is upper triangular. More... | |
virtual const Epetra_Map & | RowMatrixRowMap () const |
Returns the row matrix of the non-reordered matrix. More... | |
virtual const Epetra_Map & | RowMatrixColMap () const |
Returns the column matrix of the non-reordered matrix. More... | |
virtual const Epetra_Import * | RowMatrixImporter () const |
Returns the importer of the non-reordered matrix. More... | |
int | SetUseTranspose (bool UseTranspose_in) |
Sets the use of the transpose. More... | |
bool | UseTranspose () const |
Returns true if the transpose of this matrix is used. More... | |
bool | HasNormInf () const |
Returns true if this matrix has the infinite norm. More... | |
const Epetra_Comm & | Comm () const |
Returns the communicator. More... | |
const Epetra_Map & | OperatorDomainMap () const |
Returns the operator domain map of the non-reordered matrix. More... | |
const Epetra_Map & | OperatorRangeMap () const |
Returns the operator domain range of the non-reordered matrix. More... | |
const Epetra_BlockMap & | Map () const |
Returns the map of the non-reordered matrix. More... | |
const char * | Label () const |
Returns the label of this object. More... | |
Teuchos::RefCountPtr < Epetra_RowMatrix > | Matrix () const |
Returns a reference-counted pointer to the internally stored pointer to Epetra_RowMatrix. More... | |
Teuchos::RefCountPtr < Ifpack_Reordering > | Reordering () const |
Returns a reference-counted pointer to the internally stored pointer to Ifpack_Reordering.. More... | |
Private Attributes | |
Teuchos::RefCountPtr < Epetra_RowMatrix > | A_ |
Pointer to the matrix to be preconditioned. More... | |
Teuchos::RefCountPtr < Ifpack_Reordering > | Reordering_ |
Pointer to the reordering to be used (already constructed). More... | |
int | NumMyRows_ |
Number of local rows of A_. More... | |
int | MaxNumEntries_ |
Maximum number of entries in A_. More... | |
char | Label_ [80] |
Label for this object. More... | |
Ifpack_ReorderFilter: a class for light-weight reorder of local rows and columns of an Epetra_RowMatrix.
Class Ifpack_ReorderFilter enables a light-weight construction of reordered matrices.
This class is used in Ifpack_AdditiveSchwarz to reorder (if required by the user) the localized matrix. As the localized matrix is defined on a serial communicator only, all maps are trivial (as all elements reside on the same process). This class does not attemp to define properly reordered maps, hence it should not be used for distributed matrices.
To improve the performances of Ifpack_AdditiveSchwarz, some operations are not performed in the construction phase (like for instance the computation of the 1-norm and infinite-norm, of check whether the reordered matrix is lower/upper triangular or not).
Definition at line 81 of file Ifpack_ReorderFilter.h.
Ifpack_ReorderFilter::Ifpack_ReorderFilter | ( | const Teuchos::RefCountPtr< Epetra_RowMatrix > & | Matrix_in, |
const Teuchos::RefCountPtr< Ifpack_Reordering > & | Reordering_in | ||
) |
Definition at line 54 of file Ifpack_ReorderFilter.cpp.
Ifpack_ReorderFilter::Ifpack_ReorderFilter | ( | const Ifpack_ReorderFilter & | RHS | ) |
Copy constructor.
Definition at line 64 of file Ifpack_ReorderFilter.cpp.
|
inlinevirtual |
Destructor.
Definition at line 92 of file Ifpack_ReorderFilter.h.
Ifpack_ReorderFilter & Ifpack_ReorderFilter::operator= | ( | const Ifpack_ReorderFilter & | RHS | ) |
Operator assignment.
Definition at line 75 of file Ifpack_ReorderFilter.cpp.
|
inlinevirtual |
Returns the number of local row entries.
Implements Epetra_RowMatrix.
Definition at line 98 of file Ifpack_ReorderFilter.h.
|
inlinevirtual |
Returns maximum num entries.
Implements Epetra_RowMatrix.
Definition at line 104 of file Ifpack_ReorderFilter.h.
|
virtual |
Implements Epetra_RowMatrix.
Definition at line 92 of file Ifpack_ReorderFilter.cpp.
|
virtual |
Extracts a copy of the diagonal of the reordered matrix.
Implements Epetra_RowMatrix.
Definition at line 111 of file Ifpack_ReorderFilter.cpp.
|
virtual |
Multiplies multi-vector X with the reordered matrix, returns result in Y.
Implements Epetra_RowMatrix.
Definition at line 121 of file Ifpack_ReorderFilter.cpp.
|
virtual |
Solve, not implemented.
Implements Epetra_RowMatrix.
Definition at line 140 of file Ifpack_ReorderFilter.cpp.
|
virtual |
Applies the reordered matrix to multi-vector X, returns the result in Y.
Implements Epetra_Operator.
Definition at line 148 of file Ifpack_ReorderFilter.cpp.
|
inlinevirtual |
Applies the inverse of this
operator (not implemented).
Implements Epetra_Operator.
Definition at line 129 of file Ifpack_ReorderFilter.h.
|
inlinevirtual |
Inverse of row sums (not implemented).
Implements Epetra_RowMatrix.
Definition at line 136 of file Ifpack_ReorderFilter.h.
|
inlinevirtual |
Left scale of the matrix (not implemented).
Implements Epetra_RowMatrix.
Definition at line 142 of file Ifpack_ReorderFilter.h.
|
inlinevirtual |
Inverse of column sums (not implemented).
Implements Epetra_RowMatrix.
Definition at line 148 of file Ifpack_ReorderFilter.h.
|
inlinevirtual |
Right scale of the matrix (not implemented).
Implements Epetra_RowMatrix.
Definition at line 154 of file Ifpack_ReorderFilter.h.
|
inlinevirtual |
Returns true
is the matrix called FillComplete().
Implements Epetra_RowMatrix.
Definition at line 160 of file Ifpack_ReorderFilter.h.
|
inlinevirtual |
Returns the infinite-norm.
Implements Epetra_RowMatrix.
Definition at line 166 of file Ifpack_ReorderFilter.h.
|
inlinevirtual |
Returns the 1-norm.
Implements Epetra_RowMatrix.
Definition at line 172 of file Ifpack_ReorderFilter.h.
|
inlinevirtual |
Returns the number of global nonzero elements.
Implements Epetra_RowMatrix.
Definition at line 180 of file Ifpack_ReorderFilter.h.
|
inlinevirtual |
Returns the number of global rows.
Implements Epetra_RowMatrix.
Definition at line 186 of file Ifpack_ReorderFilter.h.
|
inlinevirtual |
Returns the number of global columns.
Implements Epetra_RowMatrix.
Definition at line 192 of file Ifpack_ReorderFilter.h.
|
inlinevirtual |
Returns the number of global diagonals.
Implements Epetra_RowMatrix.
Definition at line 198 of file Ifpack_ReorderFilter.h.
|
inlinevirtual |
Returns the number of global nonzero elements.
Implements Epetra_RowMatrix.
Definition at line 205 of file Ifpack_ReorderFilter.h.
|
inlinevirtual |
Returns the number of global rows.
Implements Epetra_RowMatrix.
Definition at line 211 of file Ifpack_ReorderFilter.h.
|
inlinevirtual |
Returns the number of global columns.
Implements Epetra_RowMatrix.
Definition at line 217 of file Ifpack_ReorderFilter.h.
|
inlinevirtual |
Returns the number of global diagonals.
Implements Epetra_RowMatrix.
Definition at line 223 of file Ifpack_ReorderFilter.h.
|
inlinevirtual |
Returns the number of local nonzero elements.
Implements Epetra_RowMatrix.
Definition at line 229 of file Ifpack_ReorderFilter.h.
|
inlinevirtual |
Returns the number of local rows.
Implements Epetra_RowMatrix.
Definition at line 235 of file Ifpack_ReorderFilter.h.
|
inlinevirtual |
Returns the number of local columns.
Implements Epetra_RowMatrix.
Definition at line 241 of file Ifpack_ReorderFilter.h.
|
inlinevirtual |
Returns the number of local diagonals.
Implements Epetra_RowMatrix.
Definition at line 247 of file Ifpack_ReorderFilter.h.
|
inlinevirtual |
Returns true
is the reordered matrix is lower triangular.
Implements Epetra_RowMatrix.
Definition at line 253 of file Ifpack_ReorderFilter.h.
|
inlinevirtual |
Returns true
is the reordered matrix is upper triangular.
Implements Epetra_RowMatrix.
Definition at line 259 of file Ifpack_ReorderFilter.h.
|
inlinevirtual |
Returns the row matrix of the non-reordered matrix.
Implements Epetra_RowMatrix.
Definition at line 265 of file Ifpack_ReorderFilter.h.
|
inlinevirtual |
Returns the column matrix of the non-reordered matrix.
Implements Epetra_RowMatrix.
Definition at line 271 of file Ifpack_ReorderFilter.h.
|
inlinevirtual |
Returns the importer of the non-reordered matrix.
Implements Epetra_RowMatrix.
Definition at line 277 of file Ifpack_ReorderFilter.h.
|
inlinevirtual |
Sets the use of the transpose.
Implements Epetra_Operator.
Definition at line 283 of file Ifpack_ReorderFilter.h.
|
inlinevirtual |
Returns true
if the transpose of this
matrix is used.
Implements Epetra_Operator.
Definition at line 289 of file Ifpack_ReorderFilter.h.
|
inlinevirtual |
Returns true
if this
matrix has the infinite norm.
Implements Epetra_Operator.
Definition at line 295 of file Ifpack_ReorderFilter.h.
|
inlinevirtual |
Returns the communicator.
Implements Epetra_Operator.
Definition at line 301 of file Ifpack_ReorderFilter.h.
|
inlinevirtual |
Returns the operator domain map of the non-reordered matrix.
Implements Epetra_Operator.
Definition at line 307 of file Ifpack_ReorderFilter.h.
|
inlinevirtual |
Returns the operator domain range of the non-reordered matrix.
Implements Epetra_Operator.
Definition at line 313 of file Ifpack_ReorderFilter.h.
|
inlinevirtual |
Returns the map of the non-reordered matrix.
Implements Epetra_SrcDistObject.
Definition at line 319 of file Ifpack_ReorderFilter.h.
|
inlinevirtual |
Returns the label of this
object.
Implements Epetra_Operator.
Definition at line 325 of file Ifpack_ReorderFilter.h.
|
inline |
Returns a reference-counted pointer to the internally stored pointer to Epetra_RowMatrix.
Definition at line 330 of file Ifpack_ReorderFilter.h.
|
inline |
Returns a reference-counted pointer to the internally stored pointer to Ifpack_Reordering..
Definition at line 335 of file Ifpack_ReorderFilter.h.
|
private |
Pointer to the matrix to be preconditioned.
Definition at line 342 of file Ifpack_ReorderFilter.h.
|
private |
Pointer to the reordering to be used (already constructed).
Definition at line 344 of file Ifpack_ReorderFilter.h.
|
private |
Number of local rows of A_.
Definition at line 347 of file Ifpack_ReorderFilter.h.
|
private |
Maximum number of entries in A_.
Definition at line 349 of file Ifpack_ReorderFilter.h.
|
private |
Label for this
object.
Definition at line 351 of file Ifpack_ReorderFilter.h.