IFPACK  Development
 All Classes Namespaces Files Functions Variables Enumerations Friends Pages
Protected Member Functions | Protected Attributes | List of all members
Ifpack_SupportGraph< T > Class Template Reference
Inheritance diagram for Ifpack_SupportGraph< T >:
Inheritance graph
[legend]
Collaboration diagram for Ifpack_SupportGraph< T >:
Collaboration graph
[legend]

Public Member Functions

 Ifpack_SupportGraph (Epetra_RowMatrix *Matrix_in)
 Constructor.
 
virtual int SetUseTranspose (bool UseTranspose_in)
 If set true, transpose of this operator will be applied (not implemented). More...
 
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
 Returns a character string describing the operator.
 
virtual bool UseTranspose () const
 Returns the current UseTranspose setting.
 
virtual bool HasNormInf () const
 Returns true if this object can provide an approximate Inf-norm, false otherwise.
 
virtual const Epetra_CommComm () const
 Returns a pointer to the Epetra_Comm communicator associated with this operator.
 
virtual const Epetra_MapOperatorDomainMap () const
 Returns the Epetra_Map object associated with the domain of this operator.
 
virtual const Epetra_MapOperatorRangeMap () const
 Returns the Epetra_Map object associated with the range of this operator.
 
virtual bool IsInitialized () const
 Returns true if the preconditioner has been successfully initialized.
 
virtual bool IsComputed () const
 Returns true if the preconditioner has been successfully computed.
 
virtual int SetParameters (Teuchos::ParameterList &List)
 Sets all the parameters for the preconditioner. More...
 
virtual int Initialize ()
 Initialize the preconditioner. More...
 
virtual int Compute ()
 Computes the preconditioners. More...
 
virtual double Condest (const Ifpack_CondestType CT=Ifpack_Cheap, const int MaxIters=1550, const double Tol=1e-9, Epetra_RowMatrix *Matrix_in=0)
 Returns the estimated conditioner number, computes it if necessary. More...
 
virtual double Condest () const
 Returns the computed condition number.
 
virtual const Epetra_RowMatrixMatrix () const
 Returns a const reference to the internally stored matrix.
 
virtual std::ostream & Print (std::ostream &) const
 Prints on ostream basic information about this object.
 
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 total time spent in Initialize().
 
virtual double ComputeTime () const
 Returns the total time spent in Compute().
 
virtual double ApplyInverseTime () const
 Returns the total time spent in ApplyInverse().
 
virtual double InitializeFlops () const
 Returns the number of flops in the initialization phase.
 
virtual double ComputeFlops () const
 Returns the total number of flops to compute the preconditioner.
 
virtual double ApplyInverseFlops () const
 Returns the total number of flops to apply the preconditioner.
 

Protected Member Functions

int FindSupport ()
 Compute the support graph.
 

Protected Attributes

Teuchos::RefCountPtr< const
Epetra_RowMatrix
Matrix_
 Pointers to the matrix to be preconditioned.
 
Teuchos::RefCountPtr
< Epetra_CrsMatrix
Support_
 Pointers to the matrix of the support graph.
 
std::string Label_
 Contains the label of this object.
 
bool IsInitialized_
 If true, the preconditioner has been successfully initialized.
 
bool IsComputed_
 If true, the preconditioner has been successfully computed.
 
bool UseTranspose_
 If true, solve with the transpose (not supported by all solvers).
 
Teuchos::ParameterList List_
 Stores a copy of the list given in SetParameters()
 
double Condest_
 Contains the estimated condition number.
 
int NumInitialize_
 Contains the number of successful calls to Initialize().
 
int NumCompute_
 Contains the number of successful call to Compute().
 
int NumApplyInverse_
 Contains the number of successful call to ApplyInverse().
 
double InitializeTime_
 Contains the time for all successful calls to Initialize().
 
double ComputeTime_
 Contains the time for all successful calls to Compute().
 
double ApplyInverseTime_
 Contains the time for all successful calls to ApplyInverse().
 
double InitializeFlops_
 Contains the number of flops for Initialize().
 
double ComputeFlops_
 Contains the number of flops for Compute().
 
double ApplyInverseFlops_
 Contain sthe number of flops for ApplyInverse().
 
Teuchos::RefCountPtr< Epetra_TimeTime_
 Object used for timing purposes.
 
Teuchos::RefCountPtr< T > Inverse_
 Pointer to the local solver.
 
int NumForests_
 Contains the number of forests in the support graph.
 
double DiagPertRel_
 Relative diagonal pertubation.
 
double DiagPertAbs_
 Absolute diagonal pertubation.
 
double KeepDiag_
 Contains the option to keep the diagonal of original matrix, or weighted average.
 
int Randomize_
 Option to add random pertubation to edge weights, to get random spanning trees.
 

Detailed Description

template<typename T = Ifpack_Amesos>
class Ifpack_SupportGraph< T >

Definition at line 80 of file Ifpack_SupportGraph.h.

Member Function Documentation

template<typename T >
int Ifpack_SupportGraph< T >::Apply ( const Epetra_MultiVector X,
Epetra_MultiVector Y 
) const
virtual

Applies the matrix to an Epetra_MultiVector.

Parameters
X- (In) A Epetra_MultiVector of dimension NumVectors to multiply with matrix.
Y- (Out) A Epetra_MultiVector of dimension NumVectors containing the result.
Returns
Integer error code, set to 0 if successful.

Implements Epetra_Operator.

Definition at line 707 of file Ifpack_SupportGraph.h.

template<typename T >
int Ifpack_SupportGraph< T >::ApplyInverse ( const Epetra_MultiVector X,
Epetra_MultiVector Y 
) const
virtual

Applies the preconditioner to X, returns the result in Y.

Parameters
X- (In) A Epetra_MultiVector of dimension NumVectors to be preconditioned.
Y- (Out) A Epetra_MultiVector of dimension NumVectors containing result.
Returns
Integer error code, set to 0 if successful.
Warning
In order to work with AztecOO, any implementation of this method must support the case where X and Y are the same object.

Implements Ifpack_Preconditioner.

Definition at line 721 of file Ifpack_SupportGraph.h.

template<typename T >
int Ifpack_SupportGraph< T >::Compute ( )
virtual

Computes the preconditioners.

Returns
0 if successful, 1 if problems occurred.

Implements Ifpack_Preconditioner.

Definition at line 672 of file Ifpack_SupportGraph.h.

template<typename T >
double Ifpack_SupportGraph< T >::Condest ( const Ifpack_CondestType  CT = Ifpack_Cheap,
const int  MaxIters = 1550,
const double  Tol = 1e-9,
Epetra_RowMatrix Matrix_in = 0 
)
virtual

Returns the estimated conditioner number, computes it if necessary.

not implemented

Implements Ifpack_Preconditioner.

Definition at line 779 of file Ifpack_SupportGraph.h.

template<typename T >
int Ifpack_SupportGraph< T >::Initialize ( )
virtual

Initialize the preconditioner.

Returns
0 if successful, 1 if problems occured.

Implements Ifpack_Preconditioner.

Definition at line 643 of file Ifpack_SupportGraph.h.

template<typename T >
int Ifpack_SupportGraph< T >::SetParameters ( Teuchos::ParameterList &  List)
virtual

Sets all the parameters for the preconditioner.

Parameters currently supported: The input list will be copied, then passed to the underlying preconditioner

  • "MST: forest number" : Specified the number of times Kruskal's algorithm adds another forest to the preconditioner
  • "MST: diagonal offset" : Specify the offset to add to the diagonal elements of the support graph matrix

Implements Ifpack_Preconditioner.

Definition at line 629 of file Ifpack_SupportGraph.h.

Referenced by Ifpack_SupportGraph< T >::Ifpack_SupportGraph().

template<typename T >
int Ifpack_SupportGraph< T >::SetUseTranspose ( bool  UseTranspose_in)
virtual

If set true, transpose of this operator will be applied (not implemented).

This flag allows the transpose of the given operator to be used implicitly.

Parameters
UseTranspose_in- (In) If true, multiply by the transpose of operator, otherwise just use operator.
Returns
Integer error code, set to 0 if successful. Set to -1 if this implementation does

Implements Epetra_Operator.

Definition at line 692 of file Ifpack_SupportGraph.h.


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