Ifpack_Krylov: class for smoothing with Krylov solvers in Ifpack. More...
#include <Ifpack_Krylov.h>


| Public Member Functions | |
| virtual int | SetUseTranspose (bool UseTranspose_in) | 
| Ifpack_Krylov (Epetra_Operator *Matrix) | |
| Ifpack_Krylov (Epetra_RowMatrix *Matrix) | |
| Ifpack_Krylov constructor with given Epetra_Operator/Epetra_RowMatrix. | |
| virtual | ~Ifpack_Krylov () | 
| Destructor. | |
| virtual int | Apply (const Epetra_MultiVector &X, Epetra_MultiVector &Y) const | 
| Applies the matrix to an Epetra_MultiVector.  More... | |
| virtual int | ApplyInverse (const Epetra_MultiVector &X, Epetra_MultiVector &Y) const | 
| Applies the preconditioner to X, returns the result in Y.  More... | |
| virtual double | NormInf () const | 
| Returns the infinity norm of the global matrix (not implemented) | |
| virtual const char * | Label () const | 
| virtual bool | UseTranspose () const | 
| Returns the current UseTranspose setting. | |
| virtual bool | HasNormInf () const | 
| Returns true if the this object can provide an approximate Inf-norm, false otherwise. | |
| virtual const Epetra_Comm & | Comm () const | 
| Returns a pointer to the Epetra_Comm communicator associated with this operator. | |
| virtual const Epetra_Map & | OperatorDomainMap () const | 
| Returns the Epetra_Map object associated with the domain of this operator. | |
| virtual const Epetra_Map & | OperatorRangeMap () const | 
| Returns the Epetra_Map object associated with the range of this operator. | |
| virtual int | Initialize () | 
| Computes all it is necessary to initialize the preconditioner. | |
| virtual bool | IsInitialized () const | 
| Returns true if the preconditioner has been successfully initialized, false otherwise. | |
| virtual bool | IsComputed () const | 
| Returns trueif the preconditioner has been successfully computed. | |
| virtual int | Compute () | 
| Computes the preconditioners. | |
| virtual const Epetra_RowMatrix & | Matrix () const | 
| Returns a pointer to the matrix to be preconditioned. | |
| virtual double | Condest (const Ifpack_CondestType CT=Ifpack_Cheap, const int MaxIters=1550, const double Tol=1e-9, Epetra_RowMatrix *Matrix_in=0) | 
| Computes the condition number estimates and returns the value. | |
| virtual double | Condest () const | 
| Returns the condition number estimate, or -1.0 if not computed. | |
| virtual int | SetParameters (Teuchos::ParameterList &List) | 
| Sets all the parameters for the preconditioner. | |
| virtual std::ostream & | Print (std::ostream &os) const | 
| Prints object to an output stream. | |
| virtual int | NumInitialize () const | 
| Returns the number of calls to Initialize(). | |
| virtual int | NumCompute () const | 
| Returns the number of calls to Compute(). | |
| virtual int | NumApplyInverse () const | 
| Returns the number of calls to ApplyInverse(). | |
| virtual double | InitializeTime () const | 
| Returns the time spent in Initialize(). | |
| virtual double | ComputeTime () const | 
| Returns the time spent in Compute(). | |
| virtual double | ApplyInverseTime () const | 
| Returns the time spent in ApplyInverse(). | |
| virtual double | InitializeFlops () const | 
| Returns the number of flops in the initialization phase. | |
| virtual double | ComputeFlops () const | 
| Returns the number of flops in the computation phase. | |
| virtual double | ApplyInverseFlops () const | 
| Returns the number of flops for the application of the preconditioner. | |
Ifpack_Krylov: class for smoothing with Krylov solvers in Ifpack.
Definition at line 87 of file Ifpack_Krylov.h.
| 
 | virtual | 
Applies the matrix to an Epetra_MultiVector.
| X | - (In) A Epetra_MultiVector of dimension NumVectors to multiply with matrix. | 
| Y | - (Out) A Epetra_MultiVector of dimension NumVectors containing the result. | 
Implements Epetra_Operator.
Definition at line 178 of file Ifpack_Krylov.cpp.
References IsComputed(), and UseTranspose().
| 
 | virtual | 
Applies the preconditioner to X, returns the result in Y.
| X | - (In) A Epetra_MultiVector of dimension NumVectors to be preconditioned. | 
| Y | - (InOut) A Epetra_MultiVector of dimension NumVectors containing result. | 
Implements Ifpack_Preconditioner.
Definition at line 380 of file Ifpack_Krylov.cpp.
References IsComputed().
| 
 | inlinevirtual | 
This flag can be used to apply the preconditioner to the transpose of the input operator.
Implements Epetra_Operator.
Definition at line 113 of file Ifpack_Krylov.h.
 1.8.5
 1.8.5