ML  Version of the Day
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Groups Pages
Public Member Functions | List of all members
ML_Epetra::RowMatrix Class Reference

Basic wrapper from ML_Operator to Epetra_RowMatrix. More...

#include <ml_RowMatrix.h>

Inheritance diagram for ML_Epetra::RowMatrix:
Inheritance graph
[legend]
Collaboration diagram for ML_Epetra::RowMatrix:
Collaboration graph
[legend]

Public Member Functions

int SetOwnership (bool)
 Sets ownership.
 
int SetUseTranspose (bool)
 Sets use transpose (not implemented).
 
bool UseTranspose () const
 Returns the current UseTranspose setting.
 
bool HasNormInf () const
 Returns true if the this object can provide an approximate Inf-norm, false otherwise.
 
const Epetra_CommComm () const
 Returns a pointer to the Epetra_Comm communicator associated with this operator.
 
const Epetra_MapOperatorDomainMap () const
 Returns the Epetra_Map object associated with the domain of this operator.
 
const Epetra_MapOperatorRangeMap () const
 Returns the Epetra_Map object associated with the range of this operator.
 
void SetLabel (const char *label)
 
const char * Label () const
 
const Epetra_BlockMapMap () const
 Returns a reference to RowMatrix->Map().
 
int Print () const
 Print the global matrix. This uses a potentially artificial numbering.
 
 RowMatrix (ML_Operator *Op, const Epetra_Comm *Comm=0, const bool cheap=false, const USR_COMM=MPI_COMM_WORLD)
 Constructor, constructs Comm object if not provided.
 
virtual ~RowMatrix ()
 Destructor.
 
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.
 
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. More...
 
virtual int Apply (const Epetra_MultiVector &X, Epetra_MultiVector &Y) const
 
virtual int ApplyInverse (const Epetra_MultiVector &, Epetra_MultiVector &) const
 
virtual int InvRowSums (Epetra_Vector &) const
 Computes the sum of absolute values of the rows of the Epetra_RowMatrix, results returned in x. More...
 
virtual int LeftScale (const Epetra_Vector &)
 Scales the Epetra_RowMatrix on the left with a Epetra_Vector x. More...
 
virtual int InvColSums (Epetra_Vector &) const
 Computes the sum of absolute values of the columns of the Epetra_RowMatrix, results returned in x. More...
 
virtual int RightScale (const Epetra_Vector &)
 Scales the Epetra_RowMatrix on the right with a Epetra_Vector x. More...
 
virtual bool Filled () const
 If FillComplete() has been called, this query returns true, otherwise it returns false.
 
virtual double NormInf () const
 Returns the infinity norm of the global matrix.
 
virtual double NormOne () const
 Returns the one norm of the global matrix.
 
virtual int NumGlobalNonzeros () const
 Returns the number of nonzero entries in the global matrix.
 
virtual int NumGlobalRows () const
 Returns the number of global matrix rows.
 
virtual int NumGlobalCols () const
 Returns the number of global matrix columns.
 
virtual int NumGlobalDiagonals () const
 Returns the number of global nonzero diagonal entries, based on global row/column index comparisons.
 
virtual long long NumGlobalNonzeros64 () const
 Returns the number of nonzero entries in the global matrix.
 
virtual long long NumGlobalRows64 () const
 Returns the number of global matrix rows.
 
virtual long long NumGlobalCols64 () const
 Returns the number of global matrix columns.
 
virtual long long NumGlobalDiagonals64 () const
 Returns the number of global nonzero diagonal entries, based on global row/column index comparisons.
 
virtual int NumMyNonzeros () const
 Returns the number of nonzero entries in the calling processor's portion of the matrix.
 
virtual int NumMyRows () const
 Returns the number of matrix rows owned by the calling processor.
 
virtual int NumMyCols () const
 Returns the number of matrix columns owned by the calling processor.
 
virtual int NumMyDiagonals () const
 Returns the number of local nonzero diagonal entries, based on global row/column index comparisons.
 
virtual bool LowerTriangular () const
 If matrix is lower triangular in local index space, this query returns true, otherwise it returns false.
 
virtual bool UpperTriangular () const
 If matrix is upper triangular in local index space, this query returns true, otherwise it returns false.
 
virtual const Epetra_MapRowMatrixRowMap () const
 Returns the Epetra_Map object associated with the rows of this matrix.
 
virtual const Epetra_MapRowMatrixColMap () const
 Returns the Epetra_Map object associated with the columns of this matrix.
 
virtual const Epetra_ImportRowMatrixImporter () const
 Returns the Epetra_Import object that contains the import operations for distributed operations.
 

Detailed Description

Basic wrapper from ML_Operator to Epetra_RowMatrix.

Author
Marzio Sala, SNL 9214.
Date
Last updated on 15-Mar-05.

Member Function Documentation

virtual int ML_Epetra::RowMatrix::ExtractDiagonalCopy ( Epetra_Vector Diagonal) const
virtual

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

Parameters
OutDiagonal - Extracted main diagonal.
Returns
Integer error code, set to 0 if successful.

Implements Epetra_RowMatrix.

virtual int ML_Epetra::RowMatrix::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
InMyRow - Local row to extract.
InLength - Length of Values and Indices.
OutNumEntries - Number of nonzero entries extracted.
OutValues - Extracted values for this row.
OutIndices - Extracted global column indices for the corresponding values.
Returns
Integer error code, set to 0 if successful.

Implements Epetra_RowMatrix.

virtual int ML_Epetra::RowMatrix::InvColSums ( Epetra_Vector ) const
inlinevirtual

Computes the sum of absolute values of the columns of the Epetra_RowMatrix, 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
\e 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
Outx -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.

Implements Epetra_RowMatrix.

virtual int ML_Epetra::RowMatrix::InvRowSums ( Epetra_Vector ) const
inlinevirtual

Computes the sum of absolute values of the rows of the Epetra_RowMatrix, 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
\e 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
Outx -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.

Implements Epetra_RowMatrix.

virtual int ML_Epetra::RowMatrix::LeftScale ( const Epetra_Vector )
inlinevirtual

Scales the Epetra_RowMatrix on the left with a Epetra_Vector x.

The \e 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
Inx -A Epetra_Vector to solve for.
Returns
Integer error code, set to 0 if successful.

Implements Epetra_RowMatrix.

virtual int ML_Epetra::RowMatrix::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
InTransA -If true, multiply by the transpose of matrix, otherwise just use matrix.
InX - A Epetra_MultiVector of dimension NumVectors to multiply with matrix.
OutY -A Epetra_MultiVector of dimension NumVectorscontaining result.
Returns
Integer error code, set to 0 if successful.

Implements Epetra_RowMatrix.

virtual int ML_Epetra::RowMatrix::NumMyRowEntries ( int  MyRow,
int &  NumEntries 
) const
virtual

Returns the number of nonzero entries in MyRow.

Parameters
InMyRow - Local row.
OutNumEntries - Number of nonzero values present.
Returns
Integer error code, set to 0 if successful.

Implements Epetra_RowMatrix.

virtual int ML_Epetra::RowMatrix::RightScale ( const Epetra_Vector )
inlinevirtual

Scales the Epetra_RowMatrix on the right with a Epetra_Vector x.

The \e 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
Inx -The Epetra_Vector used for scaling this.
Returns
Integer error code, set to 0 if successful.

Implements Epetra_RowMatrix.

virtual int ML_Epetra::RowMatrix::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.

This method will perform a triangular solve independently on each processor of the parallel machine.
No communication is performed.
Parameters
InUpper -If true, solve Ux = y, otherwise solve Lx = y.
InTrans -If true, solve transpose problem.
InUnitDiagonal -If true, assume diagonal is unit (whether it's stored or not).
InX - A Epetra_MultiVector of dimension NumVectors to solve for.
OutY -A Epetra_MultiVector of dimension NumVectors containing result.
Returns
Integer error code, set to 0 if successful.

Implements Epetra_RowMatrix.


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