Ifpack Package Browser (Single Doxygen Collection)  Development
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
Public Member Functions | Private Member Functions | Private Attributes | List of all members
Ifpack_OverlappingRowMatrix Class Reference

Ifpack_OverlappingRowMatrix: matrix with ghost rows, based on Epetra_RowMatrix. More...

#include <Ifpack_OverlappingRowMatrix.h>

Inheritance diagram for Ifpack_OverlappingRowMatrix:
Inheritance graph
[legend]

Public Member Functions

int SetOwnership (bool)
 Sets ownership. More...
 
int SetUseTranspose (bool UseTranspose_in)
 Sets use transpose (not implemented). More...
 
bool UseTranspose () const
 Returns the current UseTranspose setting. More...
 
bool HasNormInf () const
 Returns true if the this object can provide an approximate Inf-norm, false otherwise. More...
 
const Epetra_CommComm () const
 Returns a pointer to the Epetra_Comm communicator associated with this operator. More...
 
const Epetra_MapOperatorDomainMap () const
 Returns the Epetra_Map object associated with the domain of this operator. More...
 
const Epetra_MapOperatorRangeMap () const
 Returns the Epetra_Map object associated with the range of this operator. More...
 
const Epetra_BlockMapMap () const
 
const char * Label () const
 
int OverlapLevel () const
 
int ImportMultiVector (const Epetra_MultiVector &X, Epetra_MultiVector &OvX, Epetra_CombineMode CM=Insert)
 
int ExportMultiVector (const Epetra_MultiVector &OvX, Epetra_MultiVector &X, Epetra_CombineMode CM=Add)
 

Private Member Functions

const Epetra_RowMatrixA () const
 
Epetra_RowMatrixB () const
 
template<typename int_type >
void BuildMap (int OverlapLevel_in)
 

Private Attributes

int NumMyRows_
 
int NumMyCols_
 
int NumMyDiagonals_
 
int NumMyNonzeros_
 
long long NumGlobalNonzeros_
 
int MaxNumEntries_
 
int NumMyRowsA_
 
int NumMyRowsB_
 
bool UseTranspose_
 
Teuchos::RefCountPtr< const
Epetra_Map
Map_
 
Teuchos::RefCountPtr< const
Epetra_Import
Importer_
 
Teuchos::RefCountPtr< const
Epetra_RowMatrix
Matrix_
 
Teuchos::RefCountPtr
< Epetra_CrsMatrix
ExtMatrix_
 
Teuchos::RefCountPtr< Epetra_MapExtMap_
 
Teuchos::RefCountPtr
< Epetra_Import
ExtImporter_
 
int OverlapLevel_
 
std::string Label_
 
 Ifpack_OverlappingRowMatrix (const Teuchos::RefCountPtr< const Epetra_RowMatrix > &Matrix_in, int OverlapLevel_in)
 
 ~Ifpack_OverlappingRowMatrix ()
 
virtual int NumMyRowEntries (int MyRow, int &NumEntries) const
 Returns the number of nonzero entries in MyRow. More...
 
virtual int MaxNumEntries () const
 Returns the maximum of NumMyRowEntries() over all rows. More...
 
virtual 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...
 
virtual int ExtractDiagonalCopy (Epetra_Vector &Diagonal) const
 Returns a copy of the main diagonal in a user-provided vector. More...
 
virtual int Multiply (bool TransA, const Epetra_MultiVector &X, Epetra_MultiVector &Y) const
 Returns the result of a Epetra_RowMatrix multiplied by a Epetra_MultiVector X in Y. More...
 
virtual int Solve (bool, bool, bool, const Epetra_MultiVector &, Epetra_MultiVector &) const
 Returns result of a local-only solve using a triangular Epetra_RowMatrix with Epetra_MultiVectors X and Y (NOT IMPLEMENTED). More...
 
virtual int Apply (const Epetra_MultiVector &X, Epetra_MultiVector &Y) const
 
virtual int ApplyInverse (const Epetra_MultiVector &X, Epetra_MultiVector &Y) const
 
virtual int InvRowSums (Epetra_Vector &) const
 Computes the sum of absolute values of the rows of the Epetra_RowMatrix, results returned in x (NOT IMPLEMENTED). More...
 
virtual int LeftScale (const Epetra_Vector &)
 Scales the Epetra_RowMatrix on the left with a Epetra_Vector x (NOT IMPLEMENTED). More...
 
virtual int InvColSums (Epetra_Vector &) const
 Computes the sum of absolute values of the columns of the Epetra_RowMatrix, results returned in x (NOT IMPLEMENTED). More...
 
virtual int RightScale (const Epetra_Vector &)
 Scales the Epetra_RowMatrix on the right with a Epetra_Vector x (NOT IMPLEMENTED). More...
 
virtual bool Filled () const
 If FillComplete() has been called, this query returns true, otherwise it returns false. More...
 
virtual double NormInf () const
 Returns the infinity norm of the global matrix. More...
 
virtual double NormOne () const
 Returns the one norm of the global matrix. More...
 
virtual int NumGlobalNonzeros () const
 Returns the number of nonzero entries in the global matrix. More...
 
virtual int NumGlobalRows () const
 Returns the number of global matrix rows. More...
 
virtual int NumGlobalCols () const
 Returns the number of global matrix columns. More...
 
virtual int NumGlobalDiagonals () const
 Returns the number of global nonzero diagonal entries, based on global row/column index comparisons. More...
 
virtual long long NumGlobalNonzeros64 () const
 Returns the number of nonzero entries in the global matrix. More...
 
virtual long long NumGlobalRows64 () const
 Returns the number of global matrix rows. More...
 
virtual long long NumGlobalCols64 () const
 Returns the number of global matrix columns. More...
 
virtual long long NumGlobalDiagonals64 () const
 Returns the number of global nonzero diagonal entries, based on global row/column index comparisons. More...
 
virtual int NumMyNonzeros () const
 Returns the number of nonzero entries in the calling processor's portion of the matrix. More...
 
virtual int NumMyRows () const
 Returns the number of matrix rows owned by the calling processor. More...
 
virtual int NumMyCols () const
 Returns the number of matrix columns owned by the calling processor. More...
 
virtual int NumMyDiagonals () const
 Returns the number of local nonzero diagonal entries, based on global row/column index comparisons. More...
 
virtual bool LowerTriangular () const
 If matrix is lower triangular in local index space, this query returns true, otherwise it returns false. More...
 
virtual bool UpperTriangular () const
 If matrix is upper triangular in local index space, this query returns true, otherwise it returns false. More...
 
virtual const Epetra_MapRowMatrixRowMap () const
 Returns the Epetra_Map object associated with the rows of this matrix. More...
 
virtual const Epetra_MapRowMatrixColMap () const
 Returns the Epetra_Map object associated with the columns of this matrix. More...
 
virtual const Epetra_ImportRowMatrixImporter () const
 Returns the Epetra_Import object that contains the import operations for distributed operations. More...
 

Detailed Description

Ifpack_OverlappingRowMatrix: matrix with ghost rows, based on Epetra_RowMatrix.

Definition at line 68 of file Ifpack_OverlappingRowMatrix.h.

Constructor & Destructor Documentation

Ifpack_OverlappingRowMatrix::Ifpack_OverlappingRowMatrix ( const Teuchos::RefCountPtr< const Epetra_RowMatrix > &  Matrix_in,
int  OverlapLevel_in 
)

Definition at line 165 of file Ifpack_OverlappingRowMatrix.cpp.

Ifpack_OverlappingRowMatrix::~Ifpack_OverlappingRowMatrix ( )
inline

Definition at line 91 of file Ifpack_OverlappingRowMatrix.h.

Member Function Documentation

int Ifpack_OverlappingRowMatrix::NumMyRowEntries ( int  MyRow,
int &  NumEntries 
) const
virtual

Returns the number of nonzero entries in MyRow.

Parameters
MyRow- (In) Local row.
NumEntries- (Out) Number of nonzero values present.
Returns
Integer error code, set to 0 if successful.

Implements Epetra_RowMatrix.

Definition at line 1602 of file Ifpack_OverlappingRowMatrix.cpp.

virtual int Ifpack_OverlappingRowMatrix::MaxNumEntries ( ) const
inlinevirtual

Returns the maximum of NumMyRowEntries() over all rows.

Implements Epetra_RowMatrix.

Definition at line 110 of file Ifpack_OverlappingRowMatrix.h.

int Ifpack_OverlappingRowMatrix::ExtractMyRowCopy ( int  MyRow,
int  Length,
int &  NumEntries,
double *  Values,
int *  Indices 
) const
virtual

Returns a copy of the specified local row in user-provided arrays.

Parameters
MyRow- (In) Local row to extract.
Length- (In) Length of Values and Indices.
NumEntries- (Out) Number of nonzero entries extracted.
Values- (Out) Extracted values for this row.
Indices- (Out) Extracted global column indices for the corresponding values.
Returns
Integer error code, set to 0 if successful.

Implements Epetra_RowMatrix.

Definition at line 1711 of file Ifpack_OverlappingRowMatrix.cpp.

int Ifpack_OverlappingRowMatrix::ExtractDiagonalCopy ( Epetra_Vector Diagonal) const
virtual

Returns a copy of the main diagonal in a user-provided vector.

Parameters
Diagonal- (Out) Extracted main diagonal.
Returns
Integer error code, set to 0 if successful.

Implements Epetra_RowMatrix.

Definition at line 1728 of file Ifpack_OverlappingRowMatrix.cpp.

int Ifpack_OverlappingRowMatrix::Multiply ( bool  TransA,
const Epetra_MultiVector X,
Epetra_MultiVector Y 
) const
virtual

Returns the result of a Epetra_RowMatrix multiplied by a Epetra_MultiVector X in Y.

Parameters
TransA-(In) If true, multiply by the transpose of matrix, otherwise just use matrix.
X- (In) A Epetra_MultiVector of dimension NumVectors to multiply with matrix.
Y-(Out) A Epetra_MultiVector of dimension NumVectorscontaining result.
Returns
Integer error code, set to 0 if successful.

Implements Epetra_RowMatrix.

Definition at line 1736 of file Ifpack_OverlappingRowMatrix.cpp.

virtual int Ifpack_OverlappingRowMatrix::Solve ( bool  ,
bool  ,
bool  ,
const Epetra_MultiVector ,
Epetra_MultiVector  
) const
inlinevirtual

Returns result of a local-only solve using a triangular Epetra_RowMatrix with Epetra_MultiVectors X and Y (NOT IMPLEMENTED).

Implements Epetra_RowMatrix.

Definition at line 165 of file Ifpack_OverlappingRowMatrix.h.

int Ifpack_OverlappingRowMatrix::Apply ( const Epetra_MultiVector X,
Epetra_MultiVector Y 
) const
virtual

Implements Epetra_Operator.

Definition at line 1772 of file Ifpack_OverlappingRowMatrix.cpp.

int Ifpack_OverlappingRowMatrix::ApplyInverse ( const Epetra_MultiVector X,
Epetra_MultiVector Y 
) const
virtual

Implements Epetra_Operator.

Definition at line 1780 of file Ifpack_OverlappingRowMatrix.cpp.

virtual int Ifpack_OverlappingRowMatrix::InvRowSums ( Epetra_Vector ) const
inlinevirtual

Computes the sum of absolute values of the rows of the Epetra_RowMatrix, results returned in x (NOT IMPLEMENTED).

Implements Epetra_RowMatrix.

Definition at line 177 of file Ifpack_OverlappingRowMatrix.h.

virtual int Ifpack_OverlappingRowMatrix::LeftScale ( const Epetra_Vector )
inlinevirtual

Scales the Epetra_RowMatrix on the left with a Epetra_Vector x (NOT IMPLEMENTED).

Implements Epetra_RowMatrix.

Definition at line 183 of file Ifpack_OverlappingRowMatrix.h.

virtual int Ifpack_OverlappingRowMatrix::InvColSums ( Epetra_Vector ) const
inlinevirtual

Computes the sum of absolute values of the columns of the Epetra_RowMatrix, results returned in x (NOT IMPLEMENTED).

Implements Epetra_RowMatrix.

Definition at line 189 of file Ifpack_OverlappingRowMatrix.h.

virtual int Ifpack_OverlappingRowMatrix::RightScale ( const Epetra_Vector )
inlinevirtual

Scales the Epetra_RowMatrix on the right with a Epetra_Vector x (NOT IMPLEMENTED).

Implements Epetra_RowMatrix.

Definition at line 196 of file Ifpack_OverlappingRowMatrix.h.

virtual bool Ifpack_OverlappingRowMatrix::Filled ( ) const
inlinevirtual

If FillComplete() has been called, this query returns true, otherwise it returns false.

Implements Epetra_RowMatrix.

Definition at line 206 of file Ifpack_OverlappingRowMatrix.h.

virtual double Ifpack_OverlappingRowMatrix::NormInf ( ) const
inlinevirtual

Returns the infinity norm of the global matrix.

Implements Epetra_RowMatrix.

Definition at line 215 of file Ifpack_OverlappingRowMatrix.h.

virtual double Ifpack_OverlappingRowMatrix::NormOne ( ) const
inlinevirtual

Returns the one norm of the global matrix.

Implements Epetra_RowMatrix.

Definition at line 224 of file Ifpack_OverlappingRowMatrix.h.

virtual int Ifpack_OverlappingRowMatrix::NumGlobalNonzeros ( ) const
inlinevirtual

Returns the number of nonzero entries in the global matrix.

Implements Epetra_RowMatrix.

Definition at line 231 of file Ifpack_OverlappingRowMatrix.h.

virtual int Ifpack_OverlappingRowMatrix::NumGlobalRows ( ) const
inlinevirtual

Returns the number of global matrix rows.

Implements Epetra_RowMatrix.

Definition at line 240 of file Ifpack_OverlappingRowMatrix.h.

virtual int Ifpack_OverlappingRowMatrix::NumGlobalCols ( ) const
inlinevirtual

Returns the number of global matrix columns.

Implements Epetra_RowMatrix.

Definition at line 246 of file Ifpack_OverlappingRowMatrix.h.

virtual int Ifpack_OverlappingRowMatrix::NumGlobalDiagonals ( ) const
inlinevirtual

Returns the number of global nonzero diagonal entries, based on global row/column index comparisons.

Implements Epetra_RowMatrix.

Definition at line 252 of file Ifpack_OverlappingRowMatrix.h.

virtual long long Ifpack_OverlappingRowMatrix::NumGlobalNonzeros64 ( ) const
inlinevirtual

Returns the number of nonzero entries in the global matrix.

Implements Epetra_RowMatrix.

Definition at line 258 of file Ifpack_OverlappingRowMatrix.h.

virtual long long Ifpack_OverlappingRowMatrix::NumGlobalRows64 ( ) const
inlinevirtual

Returns the number of global matrix rows.

Implements Epetra_RowMatrix.

Definition at line 264 of file Ifpack_OverlappingRowMatrix.h.

virtual long long Ifpack_OverlappingRowMatrix::NumGlobalCols64 ( ) const
inlinevirtual

Returns the number of global matrix columns.

Implements Epetra_RowMatrix.

Definition at line 270 of file Ifpack_OverlappingRowMatrix.h.

virtual long long Ifpack_OverlappingRowMatrix::NumGlobalDiagonals64 ( ) const
inlinevirtual

Returns the number of global nonzero diagonal entries, based on global row/column index comparisons.

Implements Epetra_RowMatrix.

Definition at line 276 of file Ifpack_OverlappingRowMatrix.h.

virtual int Ifpack_OverlappingRowMatrix::NumMyNonzeros ( ) const
inlinevirtual

Returns the number of nonzero entries in the calling processor's portion of the matrix.

Implements Epetra_RowMatrix.

Definition at line 282 of file Ifpack_OverlappingRowMatrix.h.

virtual int Ifpack_OverlappingRowMatrix::NumMyRows ( ) const
inlinevirtual

Returns the number of matrix rows owned by the calling processor.

Implements Epetra_RowMatrix.

Definition at line 288 of file Ifpack_OverlappingRowMatrix.h.

virtual int Ifpack_OverlappingRowMatrix::NumMyCols ( ) const
inlinevirtual

Returns the number of matrix columns owned by the calling processor.

Implements Epetra_RowMatrix.

Definition at line 294 of file Ifpack_OverlappingRowMatrix.h.

virtual int Ifpack_OverlappingRowMatrix::NumMyDiagonals ( ) const
inlinevirtual

Returns the number of local nonzero diagonal entries, based on global row/column index comparisons.

Implements Epetra_RowMatrix.

Definition at line 300 of file Ifpack_OverlappingRowMatrix.h.

virtual bool Ifpack_OverlappingRowMatrix::LowerTriangular ( ) const
inlinevirtual

If matrix is lower triangular in local index space, this query returns true, otherwise it returns false.

Implements Epetra_RowMatrix.

Definition at line 306 of file Ifpack_OverlappingRowMatrix.h.

virtual bool Ifpack_OverlappingRowMatrix::UpperTriangular ( ) const
inlinevirtual

If matrix is upper triangular in local index space, this query returns true, otherwise it returns false.

Implements Epetra_RowMatrix.

Definition at line 312 of file Ifpack_OverlappingRowMatrix.h.

virtual const Epetra_Map& Ifpack_OverlappingRowMatrix::RowMatrixRowMap ( ) const
inlinevirtual

Returns the Epetra_Map object associated with the rows of this matrix.

Implements Epetra_RowMatrix.

Definition at line 318 of file Ifpack_OverlappingRowMatrix.h.

virtual const Epetra_Map& Ifpack_OverlappingRowMatrix::RowMatrixColMap ( ) const
inlinevirtual

Returns the Epetra_Map object associated with the columns of this matrix.

Implements Epetra_RowMatrix.

Definition at line 324 of file Ifpack_OverlappingRowMatrix.h.

virtual const Epetra_Import* Ifpack_OverlappingRowMatrix::RowMatrixImporter ( ) const
inlinevirtual

Returns the Epetra_Import object that contains the import operations for distributed operations.

Implements Epetra_RowMatrix.

Definition at line 338 of file Ifpack_OverlappingRowMatrix.h.

int Ifpack_OverlappingRowMatrix::SetOwnership ( bool  )
inline

Sets ownership.

Definition at line 347 of file Ifpack_OverlappingRowMatrix.h.

int Ifpack_OverlappingRowMatrix::SetUseTranspose ( bool  UseTranspose_in)
inlinevirtual

Sets use transpose (not implemented).

Implements Epetra_Operator.

Definition at line 353 of file Ifpack_OverlappingRowMatrix.h.

bool Ifpack_OverlappingRowMatrix::UseTranspose ( ) const
inlinevirtual

Returns the current UseTranspose setting.

Implements Epetra_Operator.

Definition at line 360 of file Ifpack_OverlappingRowMatrix.h.

bool Ifpack_OverlappingRowMatrix::HasNormInf ( ) const
inlinevirtual

Returns true if the this object can provide an approximate Inf-norm, false otherwise.

Implements Epetra_Operator.

Definition at line 366 of file Ifpack_OverlappingRowMatrix.h.

const Epetra_Comm& Ifpack_OverlappingRowMatrix::Comm ( ) const
inlinevirtual

Returns a pointer to the Epetra_Comm communicator associated with this operator.

Implements Epetra_Operator.

Definition at line 372 of file Ifpack_OverlappingRowMatrix.h.

const Epetra_Map& Ifpack_OverlappingRowMatrix::OperatorDomainMap ( ) const
inlinevirtual

Returns the Epetra_Map object associated with the domain of this operator.

Implements Epetra_Operator.

Definition at line 378 of file Ifpack_OverlappingRowMatrix.h.

const Epetra_Map& Ifpack_OverlappingRowMatrix::OperatorRangeMap ( ) const
inlinevirtual

Returns the Epetra_Map object associated with the range of this operator.

Implements Epetra_Operator.

Definition at line 384 of file Ifpack_OverlappingRowMatrix.h.

const Epetra_BlockMap & Ifpack_OverlappingRowMatrix::Map ( ) const
virtual

Implements Epetra_SrcDistObject.

Definition at line 1795 of file Ifpack_OverlappingRowMatrix.cpp.

const char* Ifpack_OverlappingRowMatrix::Label ( ) const
inlinevirtual

Implements Epetra_Operator.

Definition at line 392 of file Ifpack_OverlappingRowMatrix.h.

int Ifpack_OverlappingRowMatrix::OverlapLevel ( ) const
inline

Definition at line 396 of file Ifpack_OverlappingRowMatrix.h.

int Ifpack_OverlappingRowMatrix::ImportMultiVector ( const Epetra_MultiVector X,
Epetra_MultiVector OvX,
Epetra_CombineMode  CM = Insert 
)

Definition at line 1802 of file Ifpack_OverlappingRowMatrix.cpp.

int Ifpack_OverlappingRowMatrix::ExportMultiVector ( const Epetra_MultiVector OvX,
Epetra_MultiVector X,
Epetra_CombineMode  CM = Add 
)

Definition at line 1811 of file Ifpack_OverlappingRowMatrix.cpp.

const Epetra_RowMatrix& Ifpack_OverlappingRowMatrix::A ( ) const
inlineprivate

Definition at line 435 of file Ifpack_OverlappingRowMatrix.h.

Epetra_RowMatrix & Ifpack_OverlappingRowMatrix::B ( ) const
inlineprivate

Definition at line 1788 of file Ifpack_OverlappingRowMatrix.cpp.

template<typename int_type >
void Ifpack_OverlappingRowMatrix::BuildMap ( int  OverlapLevel_in)
private

Definition at line 76 of file Ifpack_OverlappingRowMatrix.cpp.

Member Data Documentation

int Ifpack_OverlappingRowMatrix::NumMyRows_
private

Definition at line 444 of file Ifpack_OverlappingRowMatrix.h.

int Ifpack_OverlappingRowMatrix::NumMyCols_
private

Definition at line 445 of file Ifpack_OverlappingRowMatrix.h.

int Ifpack_OverlappingRowMatrix::NumMyDiagonals_
private

Definition at line 446 of file Ifpack_OverlappingRowMatrix.h.

int Ifpack_OverlappingRowMatrix::NumMyNonzeros_
private

Definition at line 447 of file Ifpack_OverlappingRowMatrix.h.

long long Ifpack_OverlappingRowMatrix::NumGlobalNonzeros_
private

Definition at line 449 of file Ifpack_OverlappingRowMatrix.h.

int Ifpack_OverlappingRowMatrix::MaxNumEntries_
private

Definition at line 450 of file Ifpack_OverlappingRowMatrix.h.

int Ifpack_OverlappingRowMatrix::NumMyRowsA_
private

Definition at line 452 of file Ifpack_OverlappingRowMatrix.h.

int Ifpack_OverlappingRowMatrix::NumMyRowsB_
private

Definition at line 453 of file Ifpack_OverlappingRowMatrix.h.

bool Ifpack_OverlappingRowMatrix::UseTranspose_
private

Definition at line 455 of file Ifpack_OverlappingRowMatrix.h.

Teuchos::RefCountPtr<const Epetra_Map> Ifpack_OverlappingRowMatrix::Map_
private

Definition at line 457 of file Ifpack_OverlappingRowMatrix.h.

Teuchos::RefCountPtr<const Epetra_Import> Ifpack_OverlappingRowMatrix::Importer_
private

Definition at line 465 of file Ifpack_OverlappingRowMatrix.h.

Teuchos::RefCountPtr<const Epetra_RowMatrix> Ifpack_OverlappingRowMatrix::Matrix_
private

Definition at line 467 of file Ifpack_OverlappingRowMatrix.h.

Teuchos::RefCountPtr<Epetra_CrsMatrix> Ifpack_OverlappingRowMatrix::ExtMatrix_
private

Definition at line 468 of file Ifpack_OverlappingRowMatrix.h.

Teuchos::RefCountPtr<Epetra_Map> Ifpack_OverlappingRowMatrix::ExtMap_
private

Definition at line 469 of file Ifpack_OverlappingRowMatrix.h.

Teuchos::RefCountPtr<Epetra_Import> Ifpack_OverlappingRowMatrix::ExtImporter_
private

Definition at line 470 of file Ifpack_OverlappingRowMatrix.h.

int Ifpack_OverlappingRowMatrix::OverlapLevel_
private

Definition at line 472 of file Ifpack_OverlappingRowMatrix.h.

std::string Ifpack_OverlappingRowMatrix::Label_
private

Definition at line 473 of file Ifpack_OverlappingRowMatrix.h.


The documentation for this class was generated from the following files: