IFPACK  Development
 All Classes Namespaces Files Functions Variables Enumerations Friends Pages
Protected Member Functions | List of all members
Ifpack_OverlapSolveObject Class Referenceabstract

Ifpack_OverlapSolveObject: Provides Overlapped Forward/back solve services for Ifpack. More...

#include <Ifpack_OverlapSolveObject.h>

Inheritance diagram for Ifpack_OverlapSolveObject:
Inheritance graph
[legend]
Collaboration diagram for Ifpack_OverlapSolveObject:
Collaboration graph
[legend]

Public Member Functions

 Ifpack_OverlapSolveObject (char *Label, const Epetra_Comm &Comm)
 Constructor.
 
 Ifpack_OverlapSolveObject (const Ifpack_OverlapSolveObject &Source)
 Copy constructor.
 
virtual ~Ifpack_OverlapSolveObject ()
 Ifpack_OverlapSolveObject Destructor.
 
void SetOverlapMode (Epetra_CombineMode OverlapMode)
 Generate Ifpack_OverlapGraph object using current settings.
 
int SetLowerOperator (Epetra_CrsMatrix *L, bool UseLTrans)
 Define the operator to be used for the lower triangle.
 
int SetDiagonal (Epetra_Vector *D, bool UseDInv)
 Define the vector to be used for the diagonal.
 
int SetUpperOperator (Epetra_CrsMatrix *U, bool UseUTrans)
 Define the operator to be used for the upper triangle.
 
int Solve (bool Trans, const Epetra_MultiVector &X, Epetra_MultiVector &Y) const
 Returns the result of a Ifpack_CrsIlut forward/back solve on a Epetra_MultiVector X in Y (works for Epetra_Vectors also). More...
 
int Multiply (bool Trans, const Epetra_MultiVector &X, Epetra_MultiVector &Y) const
 Returns the result of multiplying U, D and L in that order on an Epetra_MultiVector X in Y. More...
 
int Condest (bool Trans, double &ConditionNumberEstimate) const
 Returns the maximum over all the condition number estimate for each local ILU set of factors. More...
 
Epetra_CombineMode OverlapMode () const
 Returns the overlap mode used to combine terms that are redundantly computed. More...
 
int NumGlobalNonzeros () const
 Returns the number of nonzero entries in the global graph.
 
int NumMyNonzeros () const
 Returns the number of nonzero entries in the local graph.
 
const Epetra_CrsMatrixL () const
 Returns the address of the L factor associated with this factored matrix.
 
const Epetra_VectorD () const
 Returns the address of the D factor associated with this factored matrix.
 
const Epetra_CrsMatrixU () const
 Returns the address of the L factor associated with this factored matrix.
 
const char * Label () const
 Returns a character string describing the operator.
 
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...
 
double NormInf () const
 Returns 0.0 because this class cannot compute Inf-norm.
 
bool HasNormInf () const
 Returns false because this class cannot compute an Inf-norm.
 
bool UseTranspose () const
 Returns the current UseTranspose setting.
 
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.
 
const Epetra_CommComm () const
 Returns the Epetra_BlockMap object associated with the range of this matrix operator.
 

Protected Member Functions

virtual int SetupXY (bool Trans, const Epetra_MultiVector &Xin, const Epetra_MultiVector &Yin, Epetra_MultiVector *&Xout, Epetra_MultiVector *&Yout) const =0
 

Detailed Description

Ifpack_OverlapSolveObject: Provides Overlapped Forward/back solve services for Ifpack.

Definition at line 54 of file Ifpack_OverlapSolveObject.h.

Member Function Documentation

int Ifpack_OverlapSolveObject::Apply ( const Epetra_MultiVector X,
Epetra_MultiVector Y 
) const
inlinevirtual

Returns the result of a Epetra_Operator applied to a Epetra_MultiVector X in Y.

Note that this implementation of Apply does NOT perform a forward back solve with
the LDU factorization.  Instead it applies these operators via multiplication with 

U, D and L respectively. The ApplyInverse() method performs a solve.

Parameters
InX - A Epetra_MultiVector of dimension NumVectors to multiply with matrix.
OutY -A Epetra_MultiVector of dimension NumVectors containing result.
Returns
Integer error code, set to 0 if successful.

Implements Epetra_Operator.

Definition at line 179 of file Ifpack_OverlapSolveObject.h.

References Multiply(), and UseTranspose().

int Ifpack_OverlapSolveObject::ApplyInverse ( const Epetra_MultiVector X,
Epetra_MultiVector Y 
) const
inlinevirtual

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_CrsMatrix::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
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_Operator.

Definition at line 196 of file Ifpack_OverlapSolveObject.h.

References Solve(), and UseTranspose().

int Ifpack_OverlapSolveObject::Condest ( bool  Trans,
double &  ConditionNumberEstimate 
) const

Returns the maximum over all the condition number estimate for each local ILU set of factors.

This functions computes a local condition number estimate on each processor and return the maximum over all processor of the estimate.

Parameters
InTrans -If true, solve transpose problem.
OutConditionNumberEstimate - The maximum across all processors of the infinity-norm estimate of the condition number of the inverse of LDU.

Definition at line 165 of file Ifpack_OverlapSolveObject.cpp.

References Epetra_CrsMatrix::DomainMap(), Epetra_CrsMatrix::RangeMap(), and Solve().

int Ifpack_OverlapSolveObject::Multiply ( bool  Trans,
const Epetra_MultiVector X,
Epetra_MultiVector Y 
) const

Returns the result of multiplying U, D and L in that order on an Epetra_MultiVector X in Y.

Parameters
InTrans -If true, multiply by L^T, D and U^T in that order.
InX - A Epetra_MultiVector of dimension NumVectors to solve for.
OutY -A Epetra_MultiVector of dimension NumVectorscontaining result.
Returns
Integer error code, set to 0 if successful.

Definition at line 118 of file Ifpack_OverlapSolveObject.cpp.

References Epetra_CrsMatrix::Exporter(), and Epetra_CrsMatrix::Multiply().

Referenced by Apply().

Epetra_CombineMode Ifpack_OverlapSolveObject::OverlapMode ( ) const
inline

Returns the overlap mode used to combine terms that are redundantly computed.

Since rows of the graph, and any related matrices are multiply owned, some values in the subdomain solves will be computed on multiple processors. The overlap mode is used to determine how the redundant values that come in from other processors will be handled.

Definition at line 132 of file Ifpack_OverlapSolveObject.h.

Referenced by SetOverlapMode().

int Ifpack_OverlapSolveObject::SetUseTranspose ( bool  UseTranspose)
inlinevirtual

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
InUseTranspose -If true, multiply by the transpose of operator, otherwise just use operator.
Returns
Always returns 0.

Implements Epetra_Operator.

Definition at line 165 of file Ifpack_OverlapSolveObject.h.

References UseTranspose().

int Ifpack_OverlapSolveObject::Solve ( bool  Trans,
const Epetra_MultiVector X,
Epetra_MultiVector Y 
) const

Returns the result of a Ifpack_CrsIlut forward/back solve on a Epetra_MultiVector X in Y (works for Epetra_Vectors also).

Parameters
InTrans -If true, solve transpose problem.
InX - A Epetra_MultiVector of dimension NumVectors to solve for.
OutY -A Epetra_MultiVector of dimension NumVectorscontaining result.
Returns
Integer error code, set to 0 if successful.

Definition at line 86 of file Ifpack_OverlapSolveObject.cpp.

References Epetra_CrsMatrix::Exporter(), Epetra_CrsMatrix::Importer(), and Epetra_CrsMatrix::Solve().

Referenced by ApplyInverse(), and Condest().


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