Epetra_PETScAIJMatrix: A class for constructing and using real-valued sparse compressed row matrices.
More...
#include <EpetraExt_PETScAIJMatrix.h>
Inherits Epetra_Object, Epetra_CompObject, and Epetra_RowMatrix.
|
int | ExtractMyRowCopy (int MyRow, int Length, int &NumEntries, double *Values, int *Indices) const |
| Returns a copy of the specified local row in user-provided arrays. More...
|
|
int | ExtractDiagonalCopy (Epetra_Vector &Diagonal) const |
| Returns a copy of the main diagonal in a user-provided vector. More...
|
|
|
bool | Filled () const |
| If FillComplete() has been called, this query returns true, otherwise it returns false. More...
|
|
bool | LowerTriangular () const |
| If matrix is lower triangular, this query returns true, otherwise it returns false. More...
|
|
bool | UpperTriangular () const |
| If matrix is upper triangular, this query returns true, otherwise it returns false. More...
|
|
|
Mat | Amat () const |
| Returns a pointer to the PETSc matrix used to create this object. More...
|
|
double | NormInf () const |
| Returns the infinity norm of the global matrix. More...
|
|
double | NormOne () const |
| Returns the one norm of the global matrix. More...
|
|
int | NumGlobalNonzeros () const |
| Returns the number of nonzero entries in the global matrix. More...
|
|
int | NumGlobalRows () const |
| Returns the number of global matrix rows. More...
|
|
int | NumGlobalCols () const |
| Returns the number of global matrix columns. More...
|
|
int | NumGlobalDiagonals () const |
| Returns the number of global nonzero diagonal entries. More...
|
|
long long | NumGlobalNonzeros64 () const |
| Returns the number of nonzero entries in the global matrix. More...
|
|
long long | NumGlobalRows64 () const |
| Returns the number of global matrix rows. More...
|
|
long long | NumGlobalCols64 () const |
| Returns the number of global matrix columns. More...
|
|
long long | NumGlobalDiagonals64 () const |
| Returns the number of global nonzero diagonal entries. More...
|
|
int | NumMyNonzeros () const |
| Returns the number of nonzero entries in the calling processor's portion of the matrix. More...
|
|
int | NumMyRows () const |
| Returns the number of matrix rows owned by the calling processor. More...
|
|
int | NumMyCols () const |
| Returns the number of matrix columns owned by the calling processor. More...
|
|
int | NumMyDiagonals () const |
| Returns the number of local nonzero diagonal entries. More...
|
|
const Epetra_Map & | OperatorDomainMap () const |
| Returns the Epetra_Map object associated with the domain of this operator. More...
|
|
const Epetra_Map & | OperatorRangeMap () const |
| Returns the Epetra_Map object associated with the range of this operator (same as domain). More...
|
|
const Epetra_BlockMap & | Map () const |
| Implement the Epetra_SrcDistObjec::Map() function. More...
|
|
const Epetra_Map & | RowMatrixRowMap () const |
| Returns the Row Map object needed for implementing Epetra_RowMatrix. More...
|
|
const Epetra_Map & | RowMatrixColMap () const |
| Returns the Column Map object needed for implementing Epetra_RowMatrix. More...
|
|
virtual const Epetra_Import * | RowMatrixImporter () const |
| Returns the Epetra_Import object that contains the import operations for distributed operations. More...
|
|
const Epetra_Comm & | Comm () const |
| Returns a pointer to the Epetra_Comm communicator associated with this matrix. More...
|
|
|
virtual void | Print (std::ostream &os) const |
| Print method. More...
|
|
|
const char * | Label () const |
| Returns a character string describing the operator. More...
|
|
int | SetUseTranspose (bool UseTranspose) |
| If set true, transpose of this operator will be applied. More...
|
|
int | Apply (const Epetra_MultiVector &X, Epetra_MultiVector &Y) const |
| Returns the result of a Epetra_Operator applied to a Epetra_MultiVector X in Y. More...
|
|
int | ApplyInverse (const Epetra_MultiVector &X, Epetra_MultiVector &Y) const |
| Returns the result of a Epetra_Operator inverse applied to an Epetra_MultiVector X in Y. More...
|
|
virtual bool | HasNormInf () const |
| Returns true because this class can compute an Inf-norm. More...
|
|
virtual bool | UseTranspose () const |
| Returns the current UseTranspose setting. More...
|
|
Epetra_PETScAIJMatrix: A class for constructing and using real-valued sparse compressed row matrices.
The Epetra_PETScAIJMatrix is a wrapper class for PETSc sequential or parallel AIJ matrices. It is derived from the Epetra_RowMatrix class, and so provides PETSc users access to Trilinos preconditioners. This class is lightweight, i.e., there are no deep copies of matrix data. Whenever possible, class methods utilize callbacks to native PETSc functions. Currently, only sequential and parallel point AIJ PETSc matrix types are supported.
Definition at line 81 of file EpetraExt_PETScAIJMatrix.h.
◆ Epetra_PETScAIJMatrix()
Epetra_PETScAIJMatrix::Epetra_PETScAIJMatrix |
( |
Mat |
Amat | ) |
|
◆ ~Epetra_PETScAIJMatrix()
virtual Epetra_PETScAIJMatrix::~Epetra_PETScAIJMatrix |
( |
| ) |
|
|
virtual |
◆ ExtractMyRowCopy()
int Epetra_PETScAIJMatrix::ExtractMyRowCopy |
( |
int |
MyRow, |
|
|
int |
Length, |
|
|
int & |
NumEntries, |
|
|
double * |
Values, |
|
|
int * |
Indices |
|
) |
| const |
Returns a copy of the specified local row in user-provided arrays.
- Parameters
-
In | MyRow - Local row to extract. |
In | Length - Length of Values and Indices. |
Out | NumEntries - Number of nonzero entries extracted. |
Out | Values - Extracted values for this row. |
Out | Indices - Extracted local column indices for the corresponding values. |
- Returns
- Integer error code, set to 0 if successful.
◆ ExtractDiagonalCopy()
int Epetra_PETScAIJMatrix::ExtractDiagonalCopy |
( |
Epetra_Vector & |
Diagonal | ) |
const |
Returns a copy of the main diagonal in a user-provided vector.
- Parameters
-
Out | Diagonal - Extracted main diagonal. |
- Returns
- Integer error code, set to 0 if successful.
◆ Multiply()
int Epetra_PETScAIJMatrix::Multiply |
( |
bool |
TransA, |
|
|
const Epetra_MultiVector & |
X, |
|
|
Epetra_MultiVector & |
Y |
|
) |
| const |
Returns the result of a Epetra_PETScAIJMatrix multiplied by a Epetra_MultiVector X in Y.
- Parameters
-
In | TransA -If true, multiply by the transpose of matrix, otherwise just use matrix. |
In | X - A Epetra_MultiVector of dimension NumVectors to multiply with matrix. |
Out | Y -A Epetra_MultiVector of dimension NumVectorscontaining result. |
- Returns
- Integer error code, set to 0 if successful.
◆ Solve()
int Epetra_PETScAIJMatrix::Solve |
( |
bool |
Upper, |
|
|
bool |
Trans, |
|
|
bool |
UnitDiagonal, |
|
|
const Epetra_MultiVector & |
X, |
|
|
Epetra_MultiVector & |
Y |
|
) |
| const |
Returns the result of a Epetra_PETScAIJMatrix multiplied by a Epetra_MultiVector X in Y.
- Parameters
-
In | Upper -If true, solve Ux = y, otherwise solve Lx = y. |
In | Trans -If true, solve transpose problem. |
In | UnitDiagonal -If true, assume diagonal is unit (whether it's stored or not). |
In | X - A Epetra_MultiVector of dimension NumVectors to solve for. |
Out | Y -A Epetra_MultiVector of dimension NumVectors containing result. |
- Returns
- Integer error code, set to 0 if successful.
◆ InvRowSums()
int Epetra_PETScAIJMatrix::InvRowSums |
( |
Epetra_Vector & |
x | ) |
const |
Computes the sum of absolute values of the rows of the Epetra_PETScAIJMatrix, results returned in x.
The vector x will return such that x[i] will contain the inverse of sum of the absolute values of the this matrix will be scaled such that A(i,j) = x(i)*A(i,j) where i denotes the global row number of A and j denotes the global column number of A. Using the resulting vector from this function as input to LeftScale() will make the infinity norm of the resulting matrix exactly 1.
- Parameters
-
Out | x -A Epetra_Vector containing the row sums of the this matrix. |
- Warning
- It is assumed that the distribution of x is the same as the rows of this.
- Returns
- Integer error code, set to 0 if successful.
◆ LeftScale()
int Epetra_PETScAIJMatrix::LeftScale |
( |
const Epetra_Vector & |
x | ) |
|
Scales the Epetra_PETScAIJMatrix on the left with a Epetra_Vector x.
The this matrix will be scaled such that A(i,j) = x(i)*A(i,j) where i denotes the row number of A and j denotes the column number of A.
- Parameters
-
In | x -A Epetra_Vector to solve for. |
- Returns
- Integer error code, set to 0 if successful.
◆ InvColSums()
int Epetra_PETScAIJMatrix::InvColSums |
( |
Epetra_Vector & |
x | ) |
const |
Computes the sum of absolute values of the columns of the Epetra_PETScAIJMatrix, results returned in x.
The vector x will return such that x[j] will contain the inverse of sum of the absolute values of the this matrix will be sca such that A(i,j) = x(j)*A(i,j) where i denotes the global row number of A and j denotes the global column number of A. Using the resulting vector from this function as input to RighttScale() will make the one norm of the resulting matrix exactly 1.
- Parameters
-
Out | x -A Epetra_Vector containing the column sums of the this matrix. |
- Warning
- It is assumed that the distribution of x is the same as the rows of this.
- Returns
- Integer error code, set to 0 if successful.
◆ RightScale()
int Epetra_PETScAIJMatrix::RightScale |
( |
const Epetra_Vector & |
x | ) |
|
Scales the Epetra_PETScAIJMatrix on the right with a Epetra_Vector x.
The this matrix will be scaled such that A(i,j) = x(j)*A(i,j) where i denotes the global row number of A and j denotes the global column number of A.
- Parameters
-
In | x -The Epetra_Vector used for scaling this. |
- Returns
- Integer error code, set to 0 if successful.
◆ Filled()
bool Epetra_PETScAIJMatrix::Filled |
( |
| ) |
const |
|
inline |
If FillComplete() has been called, this query returns true, otherwise it returns false.
Definition at line 214 of file EpetraExt_PETScAIJMatrix.h.
◆ LowerTriangular()
bool Epetra_PETScAIJMatrix::LowerTriangular |
( |
| ) |
const |
|
inline |
◆ UpperTriangular()
bool Epetra_PETScAIJMatrix::UpperTriangular |
( |
| ) |
const |
|
inline |
◆ Amat()
Mat Epetra_PETScAIJMatrix::Amat |
( |
| ) |
const |
|
inline |
◆ NormInf()
double Epetra_PETScAIJMatrix::NormInf |
( |
| ) |
const |
Returns the infinity norm of the global matrix.
◆ NormOne()
double Epetra_PETScAIJMatrix::NormOne |
( |
| ) |
const |
Returns the one norm of the global matrix.
◆ NumGlobalNonzeros()
int Epetra_PETScAIJMatrix::NumGlobalNonzeros |
( |
| ) |
const |
|
inline |
◆ NumGlobalRows()
int Epetra_PETScAIJMatrix::NumGlobalRows |
( |
| ) |
const |
|
inline |
◆ NumGlobalCols()
int Epetra_PETScAIJMatrix::NumGlobalCols |
( |
| ) |
const |
|
inline |
◆ NumGlobalDiagonals()
int Epetra_PETScAIJMatrix::NumGlobalDiagonals |
( |
| ) |
const |
|
inline |
◆ NumGlobalNonzeros64()
long long Epetra_PETScAIJMatrix::NumGlobalNonzeros64 |
( |
| ) |
const |
|
inline |
◆ NumGlobalRows64()
long long Epetra_PETScAIJMatrix::NumGlobalRows64 |
( |
| ) |
const |
|
inline |
◆ NumGlobalCols64()
long long Epetra_PETScAIJMatrix::NumGlobalCols64 |
( |
| ) |
const |
|
inline |
◆ NumGlobalDiagonals64()
long long Epetra_PETScAIJMatrix::NumGlobalDiagonals64 |
( |
| ) |
const |
|
inline |
◆ NumMyNonzeros()
int Epetra_PETScAIJMatrix::NumMyNonzeros |
( |
| ) |
const |
|
inline |
Returns the number of nonzero entries in the calling processor's portion of the matrix.
Definition at line 268 of file EpetraExt_PETScAIJMatrix.h.
◆ NumMyRows()
int Epetra_PETScAIJMatrix::NumMyRows |
( |
| ) |
const |
|
inline |
◆ NumMyCols()
int Epetra_PETScAIJMatrix::NumMyCols |
( |
| ) |
const |
|
inline |
◆ NumMyDiagonals()
int Epetra_PETScAIJMatrix::NumMyDiagonals |
( |
| ) |
const |
|
inline |
◆ OperatorDomainMap()
const Epetra_Map& Epetra_PETScAIJMatrix::OperatorDomainMap |
( |
| ) |
const |
|
inline |
◆ OperatorRangeMap()
const Epetra_Map& Epetra_PETScAIJMatrix::OperatorRangeMap |
( |
| ) |
const |
|
inline |
Returns the Epetra_Map object associated with the range of this operator (same as domain).
Definition at line 283 of file EpetraExt_PETScAIJMatrix.h.
◆ Map()
const Epetra_BlockMap& Epetra_PETScAIJMatrix::Map |
( |
| ) |
const |
|
inline |
◆ RowMatrixRowMap()
const Epetra_Map& Epetra_PETScAIJMatrix::RowMatrixRowMap |
( |
| ) |
const |
|
inline |
◆ RowMatrixColMap()
const Epetra_Map& Epetra_PETScAIJMatrix::RowMatrixColMap |
( |
| ) |
const |
|
inline |
◆ RowMatrixImporter()
virtual const Epetra_Import* Epetra_PETScAIJMatrix::RowMatrixImporter |
( |
| ) |
const |
|
inlinevirtual |
Returns the Epetra_Import object that contains the import operations for distributed operations.
Definition at line 295 of file EpetraExt_PETScAIJMatrix.h.
◆ Comm()
const Epetra_Comm& Epetra_PETScAIJMatrix::Comm |
( |
| ) |
const |
|
inline |
◆ Print()
virtual void Epetra_PETScAIJMatrix::Print |
( |
std::ostream & |
os | ) |
const |
|
virtual |
◆ Label()
const char* Epetra_PETScAIJMatrix::Label |
( |
| ) |
const |
|
inline |
◆ SetUseTranspose()
int Epetra_PETScAIJMatrix::SetUseTranspose |
( |
bool |
UseTranspose | ) |
|
|
inline |
If set true, transpose of this operator will be applied.
This flag allows the transpose of the given operator to be used implicitly. Setting this flag affects only the Apply() and ApplyInverse() methods. If the implementation of this interface does not support transpose use, this method should return a value of -1.
- Parameters
-
In | UseTranspose -If true, multiply by the transpose of operator, otherwise just use operator. |
- Returns
- Always returns 0.
Definition at line 325 of file EpetraExt_PETScAIJMatrix.h.
◆ Apply()
int Epetra_PETScAIJMatrix::Apply |
( |
const Epetra_MultiVector & |
X, |
|
|
Epetra_MultiVector & |
Y |
|
) |
| const |
|
inline |
Returns the result of a Epetra_Operator applied to a Epetra_MultiVector X in Y.
- Parameters
-
In | X - A Epetra_MultiVector of dimension NumVectors to multiply with matrix. |
Out | Y -A Epetra_MultiVector of dimension NumVectors containing result. |
- Returns
- Integer error code, set to 0 if successful.
Definition at line 337 of file EpetraExt_PETScAIJMatrix.h.
◆ ApplyInverse()
int Epetra_PETScAIJMatrix::ApplyInverse |
( |
const Epetra_MultiVector & |
X, |
|
|
Epetra_MultiVector & |
Y |
|
) |
| const |
|
inline |
Returns the result of a Epetra_Operator inverse applied to an Epetra_MultiVector X in Y.
In this implementation, we use several existing attributes to determine how virtual method ApplyInverse() should call the concrete method Solve(). We pass in the UpperTriangular(), the Epetra_PETScAIJMatrix::UseTranspose(), and NoDiagonal() methods. The most notable warning is that if a matrix has no diagonal values we assume that there is an implicit unit diagonal that should be accounted for when doing a triangular solve.
- Parameters
-
In | X - A Epetra_MultiVector of dimension NumVectors to solve for. |
Out | Y -A Epetra_MultiVector of dimension NumVectors containing result. |
- Returns
- Integer error code, set to 0 if successful.
Definition at line 354 of file EpetraExt_PETScAIJMatrix.h.
◆ HasNormInf()
virtual bool Epetra_PETScAIJMatrix::HasNormInf |
( |
| ) |
const |
|
inlinevirtual |
◆ UseTranspose()
virtual bool Epetra_PETScAIJMatrix::UseTranspose |
( |
| ) |
const |
|
inlinevirtual |
◆ NumMyRowEntries()
int Epetra_PETScAIJMatrix::NumMyRowEntries |
( |
int |
MyRow, |
|
|
int & |
NumEntries |
|
) |
| const |
Return the current number of values stored for the specified local row.
Similar to NumMyEntries() except NumEntries is returned as an argument and error checking is done on the input value MyRow.
- Parameters
-
In | MyRow - Local row. |
Out | NumEntries - Number of nonzero values. |
- Returns
- Integer error code, set to 0 if successful.
◆ MaxNumEntries()
int Epetra_PETScAIJMatrix::MaxNumEntries |
( |
| ) |
const |
The documentation for this class was generated from the following file: