Ifpack Package Browser (Single Doxygen Collection)
Development
|
#include <Ifpack_SupportGraph.h>
Protected Member Functions | |
int | FindSupport () |
Compute the support graph. More... | |
Protected Attributes | |
Teuchos::RefCountPtr< const Epetra_RowMatrix > | Matrix_ |
Pointers to the matrix to be preconditioned. More... | |
Teuchos::RefCountPtr < Epetra_CrsMatrix > | Support_ |
Pointers to the matrix of the support graph. More... | |
std::string | Label_ |
Contains the label of this object. More... | |
bool | IsInitialized_ |
If true, the preconditioner has been successfully initialized. More... | |
bool | IsComputed_ |
If true, the preconditioner has been successfully computed. More... | |
bool | UseTranspose_ |
If true , solve with the transpose (not supported by all solvers). More... | |
Teuchos::ParameterList | List_ |
Stores a copy of the list given in SetParameters() More... | |
double | Condest_ |
Contains the estimated condition number. More... | |
int | NumInitialize_ |
Contains the number of successful calls to Initialize(). More... | |
int | NumCompute_ |
Contains the number of successful call to Compute(). More... | |
int | NumApplyInverse_ |
Contains the number of successful call to ApplyInverse(). More... | |
double | InitializeTime_ |
Contains the time for all successful calls to Initialize(). More... | |
double | ComputeTime_ |
Contains the time for all successful calls to Compute(). More... | |
double | ApplyInverseTime_ |
Contains the time for all successful calls to ApplyInverse(). More... | |
double | InitializeFlops_ |
Contains the number of flops for Initialize(). More... | |
double | ComputeFlops_ |
Contains the number of flops for Compute(). More... | |
double | ApplyInverseFlops_ |
Contain sthe number of flops for ApplyInverse(). More... | |
Teuchos::RefCountPtr< Epetra_Time > | Time_ |
Object used for timing purposes. More... | |
Teuchos::RefCountPtr< T > | Inverse_ |
Pointer to the local solver. More... | |
int | NumForests_ |
Contains the number of forests in the support graph. More... | |
double | DiagPertRel_ |
Relative diagonal pertubation. More... | |
double | DiagPertAbs_ |
Absolute diagonal pertubation. More... | |
double | KeepDiag_ |
Contains the option to keep the diagonal of original matrix, or weighted average. More... | |
int | Randomize_ |
Option to add random pertubation to edge weights, to get random spanning trees. More... | |
Ifpack_SupportGraph (Epetra_RowMatrix *Matrix_in) | |
Constructor. More... | |
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) More... | |
virtual const char * | Label () const |
Returns a character string describing the operator. More... | |
virtual bool | UseTranspose () const |
Returns the current UseTranspose setting. More... | |
virtual bool | HasNormInf () const |
Returns true if this object can provide an approximate Inf-norm, false otherwise. More... | |
virtual const Epetra_Comm & | Comm () const |
Returns a pointer to the Epetra_Comm communicator associated with this operator. More... | |
virtual const Epetra_Map & | OperatorDomainMap () const |
Returns the Epetra_Map object associated with the domain of this operator. More... | |
virtual const Epetra_Map & | OperatorRangeMap () const |
Returns the Epetra_Map object associated with the range of this operator. More... | |
virtual bool | IsInitialized () const |
Returns true if the preconditioner has been successfully initialized. More... | |
virtual bool | IsComputed () const |
Returns true if the preconditioner has been successfully computed. More... | |
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. More... | |
virtual const Epetra_RowMatrix & | Matrix () const |
Returns a const reference to the internally stored matrix. More... | |
virtual std::ostream & | Print (std::ostream &) const |
Prints on ostream 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 total time spent in Initialize(). More... | |
virtual double | ComputeTime () const |
Returns the total time spent in Compute(). More... | |
virtual double | ApplyInverseTime () const |
Returns the total time spent in ApplyInverse(). More... | |
virtual double | InitializeFlops () const |
Returns the number of flops in the initialization phase. More... | |
virtual double | ComputeFlops () const |
Returns the total number of flops to compute the preconditioner. More... | |
virtual double | ApplyInverseFlops () const |
Returns the total number of flops to apply the preconditioner. More... | |
Additional Inherited Members |
Definition at line 80 of file Ifpack_SupportGraph.h.
Ifpack_SupportGraph< T >::Ifpack_SupportGraph | ( | Epetra_RowMatrix * | Matrix_in | ) |
Constructor.
Definition at line 376 of file Ifpack_SupportGraph.h.
|
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.
UseTranspose_in | - (In) If true, multiply by the transpose of operator, otherwise just use operator. |
Implements Epetra_Operator.
Definition at line 692 of file Ifpack_SupportGraph.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 707 of file Ifpack_SupportGraph.h.
|
virtual |
Applies the preconditioner to X, returns the result in Y.
X | - (In) A Epetra_MultiVector of dimension NumVectors to be preconditioned. |
Y | - (Out) A Epetra_MultiVector of dimension NumVectors containing result. |
Implements Ifpack_Preconditioner.
Definition at line 721 of file Ifpack_SupportGraph.h.
|
inlinevirtual |
Returns the infinity norm of the global matrix (not implemented)
Implements Epetra_Operator.
Definition at line 138 of file Ifpack_SupportGraph.h.
|
virtual |
Returns a character string describing the operator.
Implements Epetra_Operator.
Definition at line 714 of file Ifpack_SupportGraph.h.
|
inlinevirtual |
Returns the current UseTranspose setting.
Implements Epetra_Operator.
Definition at line 149 of file Ifpack_SupportGraph.h.
|
inlinevirtual |
Returns true if this object can provide an approximate Inf-norm, false otherwise.
Implements Epetra_Operator.
Definition at line 152 of file Ifpack_SupportGraph.h.
|
inlinevirtual |
Returns a pointer to the Epetra_Comm communicator associated with this operator.
Implements Epetra_Operator.
Definition at line 155 of file Ifpack_SupportGraph.h.
|
inlinevirtual |
Returns the Epetra_Map object associated with the domain of this operator.
Implements Epetra_Operator.
Definition at line 158 of file Ifpack_SupportGraph.h.
|
inlinevirtual |
Returns the Epetra_Map object associated with the range of this operator.
Implements Epetra_Operator.
Definition at line 161 of file Ifpack_SupportGraph.h.
|
inlinevirtual |
Returns true
if the preconditioner has been successfully initialized.
Implements Ifpack_Preconditioner.
Definition at line 169 of file Ifpack_SupportGraph.h.
|
inlinevirtual |
Returns true
if the preconditioner has been successfully computed.
Implements Ifpack_Preconditioner.
Definition at line 175 of file Ifpack_SupportGraph.h.
|
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.
|
virtual |
Initialize the preconditioner.
Implements Ifpack_Preconditioner.
Definition at line 643 of file Ifpack_SupportGraph.h.
|
virtual |
Computes the preconditioners.
Implements Ifpack_Preconditioner.
Definition at line 672 of file Ifpack_SupportGraph.h.
|
virtual |
Returns the estimated conditioner number, computes it if necessary.
not implemented
Implements Ifpack_Preconditioner.
Definition at line 779 of file Ifpack_SupportGraph.h.
|
inlinevirtual |
Returns the computed condition number.
Implements Ifpack_Preconditioner.
Definition at line 222 of file Ifpack_SupportGraph.h.
|
inlinevirtual |
Returns a const reference to the internally stored matrix.
Implements Ifpack_Preconditioner.
Definition at line 228 of file Ifpack_SupportGraph.h.
|
virtual |
Prints on ostream basic information about this
object.
Implements Ifpack_Preconditioner.
Definition at line 739 of file Ifpack_SupportGraph.h.
|
inlinevirtual |
Returns the number of calls to Initialize().
Implements Ifpack_Preconditioner.
Definition at line 237 of file Ifpack_SupportGraph.h.
|
inlinevirtual |
Returns the number of calls to Compute().
Implements Ifpack_Preconditioner.
Definition at line 243 of file Ifpack_SupportGraph.h.
|
inlinevirtual |
Returns the number of calls to ApplyInverse().
Implements Ifpack_Preconditioner.
Definition at line 249 of file Ifpack_SupportGraph.h.
|
inlinevirtual |
Returns the total time spent in Initialize().
Implements Ifpack_Preconditioner.
Definition at line 255 of file Ifpack_SupportGraph.h.
|
inlinevirtual |
Returns the total time spent in Compute().
Implements Ifpack_Preconditioner.
Definition at line 261 of file Ifpack_SupportGraph.h.
|
inlinevirtual |
Returns the total time spent in ApplyInverse().
Implements Ifpack_Preconditioner.
Definition at line 267 of file Ifpack_SupportGraph.h.
|
inlinevirtual |
Returns the number of flops in the initialization phase.
Implements Ifpack_Preconditioner.
Definition at line 273 of file Ifpack_SupportGraph.h.
|
inlinevirtual |
Returns the total number of flops to compute the preconditioner.
Implements Ifpack_Preconditioner.
Definition at line 279 of file Ifpack_SupportGraph.h.
|
inlinevirtual |
Returns the total number of flops to apply the preconditioner.
Implements Ifpack_Preconditioner.
Definition at line 285 of file Ifpack_SupportGraph.h.
|
protected |
Compute the support graph.
Definition at line 403 of file Ifpack_SupportGraph.h.
|
protected |
Pointers to the matrix to be preconditioned.
Definition at line 299 of file Ifpack_SupportGraph.h.
|
protected |
Pointers to the matrix of the support graph.
Definition at line 302 of file Ifpack_SupportGraph.h.
|
protected |
Contains the label of this
object.
Definition at line 305 of file Ifpack_SupportGraph.h.
|
protected |
If true, the preconditioner has been successfully initialized.
Definition at line 308 of file Ifpack_SupportGraph.h.
|
protected |
If true, the preconditioner has been successfully computed.
Definition at line 311 of file Ifpack_SupportGraph.h.
|
protected |
If true
, solve with the transpose (not supported by all solvers).
Definition at line 314 of file Ifpack_SupportGraph.h.
|
protected |
Stores a copy of the list given in SetParameters()
Definition at line 317 of file Ifpack_SupportGraph.h.
|
protected |
Contains the estimated condition number.
Definition at line 320 of file Ifpack_SupportGraph.h.
|
protected |
Contains the number of successful calls to Initialize().
Definition at line 323 of file Ifpack_SupportGraph.h.
|
protected |
Contains the number of successful call to Compute().
Definition at line 326 of file Ifpack_SupportGraph.h.
|
mutableprotected |
Contains the number of successful call to ApplyInverse().
Definition at line 329 of file Ifpack_SupportGraph.h.
|
protected |
Contains the time for all successful calls to Initialize().
Definition at line 332 of file Ifpack_SupportGraph.h.
|
protected |
Contains the time for all successful calls to Compute().
Definition at line 335 of file Ifpack_SupportGraph.h.
|
mutableprotected |
Contains the time for all successful calls to ApplyInverse().
Definition at line 338 of file Ifpack_SupportGraph.h.
|
protected |
Contains the number of flops for Initialize().
Definition at line 341 of file Ifpack_SupportGraph.h.
|
protected |
Contains the number of flops for Compute().
Definition at line 344 of file Ifpack_SupportGraph.h.
|
mutableprotected |
Contain sthe number of flops for ApplyInverse().
Definition at line 347 of file Ifpack_SupportGraph.h.
|
protected |
Object used for timing purposes.
Definition at line 350 of file Ifpack_SupportGraph.h.
|
protected |
Pointer to the local solver.
Definition at line 353 of file Ifpack_SupportGraph.h.
|
protected |
Contains the number of forests in the support graph.
Definition at line 356 of file Ifpack_SupportGraph.h.
|
protected |
Relative diagonal pertubation.
Definition at line 359 of file Ifpack_SupportGraph.h.
|
protected |
Absolute diagonal pertubation.
Definition at line 362 of file Ifpack_SupportGraph.h.
|
protected |
Contains the option to keep the diagonal of original matrix, or weighted average.
Definition at line 365 of file Ifpack_SupportGraph.h.
|
protected |
Option to add random pertubation to edge weights, to get random spanning trees.
Definition at line 368 of file Ifpack_SupportGraph.h.