ShyLU  Version of the Day
List of all members
AmesosSchurOperator Class Reference
Inheritance diagram for AmesosSchurOperator:
Inheritance graph
[legend]
Collaboration diagram for AmesosSchurOperator:
Collaboration graph
[legend]

Public Member Functions

 AmesosSchurOperator (Epetra_CrsMatrix *A)
 Constructor. More...
 
 ~AmesosSchurOperator ()
 Destructor. More...
 
int Initialize ()
 Initialize the preconditioner, does not touch matrix values. More...
 
bool IsInitialized () const
 Returns true if the preconditioner has been successfully initialized. More...
 
int Compute ()
 Compute ILU factors L and U using the specified parameters. More...
 
bool IsComputed () const
 If factor is completed, this query returns true, otherwise it returns false. More...
 
int SetParameters (Teuchos::ParameterList &parameterlist)
 Set parameters using a Teuchos::ParameterList object. More...
 
int SetUseTranspose (bool UseTranspose_in)
 
bool UseTranspose () const
 Returns the current UseTranspose setting. More...
 
int Apply (const Epetra_MultiVector &X, Epetra_MultiVector &Y) const
 
int Multiply (bool Trans, const Epetra_MultiVector &X, Epetra_MultiVector &Y) const
 
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 Condest () const
 Returns the computed estimated condition number, or -1.0 if not computed. More...
 
const char * Label () const
 Returns a character string describing the operator. More...
 
int SetLabel (const char *Label_in)
 Sets label for this object. More...
 
double NormInf () const
 Returns 0.0 because this class cannot compute Inf-norm. More...
 
bool HasNormInf () const
 Returns false because this class cannot compute an Inf-norm. 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. More...
 
const Epetra_Comm & Comm () const
 Returns the Epetra_BlockMap object associated with the range of this matrix operator. More...
 
const Epetra_RowMatrix & Matrix () const
 Returns a reference to the matrix to be preconditioned. More...
 
virtual ostream & Print (ostream &os) const
 Prints on stream basic information about this object. More...
 
virtual int NumInitialize () const
 Returns the number of calls to Initialize(). More...
 
virtual int NumCompute () const
 Returns the number of calls to Compute(). More...
 
virtual int NumApplyInverse () const
 Returns the number of calls to ApplyInverse(). More...
 
virtual double InitializeTime () const
 Returns the time spent in Initialize(). More...
 
virtual double ComputeTime () const
 Returns the time spent in Compute(). More...
 
virtual double ApplyInverseTime () const
 Returns the time spent in ApplyInverse(). More...
 
virtual double InitializeFlops () const
 Returns the number of flops in the initialization phase. More...
 
virtual double ComputeFlops () const
 
virtual double ApplyInverseFlops () const
 

Detailed Description

Definition at line 77 of file shylu_amesos_schur_operator.h.

Constructor & Destructor Documentation

AmesosSchurOperator::AmesosSchurOperator ( Epetra_CrsMatrix *  A)

Constructor.

Definition at line 53 of file shylu_amesos_schur_operator.cpp.

AmesosSchurOperator::~AmesosSchurOperator ( )
inline

Destructor.

Definition at line 85 of file shylu_amesos_schur_operator.h.

Member Function Documentation

int AmesosSchurOperator::Initialize ( )

Initialize the preconditioner, does not touch matrix values.

Definition at line 74 of file shylu_amesos_schur_operator.cpp.

References Comm().

bool AmesosSchurOperator::IsInitialized ( ) const
inline

Returns true if the preconditioner has been successfully initialized.

Definition at line 97 of file shylu_amesos_schur_operator.h.

int AmesosSchurOperator::Compute ( )

Compute ILU factors L and U using the specified parameters.

Definition at line 119 of file shylu_amesos_schur_operator.cpp.

bool AmesosSchurOperator::IsComputed ( ) const
inline

If factor is completed, this query returns true, otherwise it returns false.

Definition at line 106 of file shylu_amesos_schur_operator.h.

int AmesosSchurOperator::SetParameters ( Teuchos::ParameterList &  parameterlist)

Set parameters using a Teuchos::ParameterList object.

Definition at line 113 of file shylu_amesos_schur_operator.cpp.

bool AmesosSchurOperator::UseTranspose ( ) const
inline

Returns the current UseTranspose setting.

Definition at line 127 of file shylu_amesos_schur_operator.h.

int AmesosSchurOperator::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.

Parameters
X- (In) A Epetra_MultiVector of dimension NumVectors to solve for.
OutY - (Out) A Epetra_MultiVector of dimension NumVectors containing result.
Returns
Integer error code, set to 0 if successful.

Definition at line 126 of file shylu_amesos_schur_operator.cpp.

double AmesosSchurOperator::Condest ( ) const
inline

Returns the computed estimated condition number, or -1.0 if not computed.

Definition at line 157 of file shylu_amesos_schur_operator.h.

const char* AmesosSchurOperator::Label ( ) const
inline

Returns a character string describing the operator.

Definition at line 166 of file shylu_amesos_schur_operator.h.

int AmesosSchurOperator::SetLabel ( const char *  Label_in)
inline

Sets label for this object.

Definition at line 169 of file shylu_amesos_schur_operator.h.

double AmesosSchurOperator::NormInf ( ) const
inline

Returns 0.0 because this class cannot compute Inf-norm.

Definition at line 177 of file shylu_amesos_schur_operator.h.

bool AmesosSchurOperator::HasNormInf ( ) const
inline

Returns false because this class cannot compute an Inf-norm.

Definition at line 180 of file shylu_amesos_schur_operator.h.

const Epetra_Map& AmesosSchurOperator::OperatorDomainMap ( ) const
inline

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

Definition at line 183 of file shylu_amesos_schur_operator.h.

const Epetra_Map& AmesosSchurOperator::OperatorRangeMap ( ) const
inline

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

Definition at line 186 of file shylu_amesos_schur_operator.h.

const Epetra_Comm& AmesosSchurOperator::Comm ( ) const
inline

Returns the Epetra_BlockMap object associated with the range of this matrix operator.

Definition at line 189 of file shylu_amesos_schur_operator.h.

Referenced by Initialize(), and InitializeFlops().

const Epetra_RowMatrix& AmesosSchurOperator::Matrix ( ) const
inline

Returns a reference to the matrix to be preconditioned.

Definition at line 192 of file shylu_amesos_schur_operator.h.

ostream & AmesosSchurOperator::Print ( ostream &  os) const
virtual

Prints on stream basic information about this object.

Definition at line 137 of file shylu_amesos_schur_operator.cpp.

virtual int AmesosSchurOperator::NumInitialize ( ) const
inlinevirtual

Returns the number of calls to Initialize().

Definition at line 201 of file shylu_amesos_schur_operator.h.

virtual int AmesosSchurOperator::NumCompute ( ) const
inlinevirtual

Returns the number of calls to Compute().

Definition at line 207 of file shylu_amesos_schur_operator.h.

virtual int AmesosSchurOperator::NumApplyInverse ( ) const
inlinevirtual

Returns the number of calls to ApplyInverse().

Definition at line 213 of file shylu_amesos_schur_operator.h.

virtual double AmesosSchurOperator::InitializeTime ( ) const
inlinevirtual

Returns the time spent in Initialize().

Definition at line 219 of file shylu_amesos_schur_operator.h.

virtual double AmesosSchurOperator::ComputeTime ( ) const
inlinevirtual

Returns the time spent in Compute().

Definition at line 225 of file shylu_amesos_schur_operator.h.

virtual double AmesosSchurOperator::ApplyInverseTime ( ) const
inlinevirtual

Returns the time spent in ApplyInverse().

Definition at line 231 of file shylu_amesos_schur_operator.h.

virtual double AmesosSchurOperator::InitializeFlops ( ) const
inlinevirtual

Returns the number of flops in the initialization phase.

Definition at line 237 of file shylu_amesos_schur_operator.h.

References Comm().


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