|
| DistributedMatrix (const Space &RowSpace, const Space &ColSpace) |
|
virtual int | NumMyRowEntries (int MyRow, int &NumEntries) const |
|
virtual int | MaxNumEntries () const |
|
virtual int | ExtractMyRowCopy (int MyRow, int Length, int &NumEntries, double *Values, int *Indices) const |
|
virtual int | ExtractDiagonalCopy (Epetra_Vector &Diagonal) const |
|
virtual int | Multiply (bool TransA, const Epetra_MultiVector &X, Epetra_MultiVector &Y) const |
|
virtual int | Solve (bool Upper, bool Trans, bool UnitDiagonal, const Epetra_MultiVector &X, Epetra_MultiVector &Y) const |
|
virtual int | InvRowSums (Epetra_Vector &x) const |
|
virtual int | LeftScale (const Epetra_Vector &x) |
|
virtual int | InvColSums (Epetra_Vector &x) const |
|
virtual int | RightScale (const Epetra_Vector &x) |
|
virtual bool | Filled () const |
|
virtual double | NormInf () const |
|
virtual double | NormOne () const |
|
virtual int | NumGlobalNonzeros () const |
|
virtual int | NumGlobalRows () const |
|
virtual int | NumGlobalCols () const |
|
virtual int | NumGlobalDiagonals () const |
|
virtual long long | NumGlobalNonzeros64 () const |
|
virtual long long | NumGlobalRows64 () const |
|
virtual long long | NumGlobalCols64 () const |
|
virtual long long | NumGlobalDiagonals64 () const |
|
virtual int | NumMyNonzeros () const |
|
virtual int | NumMyRows () const |
|
virtual int | NumMyCols () const |
|
virtual int | NumMyDiagonals () const |
|
virtual bool | LowerTriangular () const |
|
virtual bool | UpperTriangular () const |
|
virtual const Epetra_Map & | RowMatrixRowMap () const |
|
virtual const Epetra_Map & | RowMatrixColMap () const |
|
virtual const Epetra_Import * | RowMatrixImporter () const |
|
virtual const Epetra_Map & | OperatorDomainMap () const |
|
virtual const Epetra_Map & | OperatorRangeMap () const |
|
virtual const Epetra_Map & | Map () const |
|
virtual int | SetUseTranspose (bool what) |
|
int | Apply (const MultiVector &X, MultiVector &Y) const |
| Applies the operator to X , using Y as starting solution. Returns the solution in Y .
|
|
virtual int | Apply (const Epetra_MultiVector &X, Epetra_MultiVector &Y) const |
|
virtual int | ApplyInverse (const Epetra_MultiVector &X, Epetra_MultiVector &Y) const |
|
virtual const char * | Label () const |
|
virtual bool | UseTranspose () const |
|
virtual bool | HasNormInf () const |
|
virtual const Epetra_Comm & | Comm () const |
|
std::ostream & | Print (std::ostream &os, const bool verbose=true) const |
| Prints information on stream.
|
|
Space | GetDomainSpace () const |
|
Space | GetRangeSpace () const |
|
double & | operator() (const int GRID, const int GCID) |
|
void | ReplaceElement (const int GRID, const int GCID, const double value) |
|
void | FillComplete () |
|
bool | IsFillCompleted () const |
|
virtual int | NumMyRowEntries (int MyRow, int &NumEntries) const=0 |
|
virtual int | MaxNumEntries () const=0 |
|
virtual int | ExtractMyRowCopy (int MyRow, int Length, int &NumEntries, double *Values, int *Indices) const=0 |
|
virtual int | ExtractDiagonalCopy (Epetra_Vector &Diagonal) const=0 |
|
virtual int | Multiply (bool TransA, const Epetra_MultiVector &X, Epetra_MultiVector &Y) const=0 |
|
virtual int | Solve (bool Upper, bool Trans, bool UnitDiagonal, const Epetra_MultiVector &X, Epetra_MultiVector &Y) const=0 |
|
virtual int | InvRowSums (Epetra_Vector &x) const=0 |
|
virtual int | LeftScale (const Epetra_Vector &x)=0 |
|
virtual int | InvColSums (Epetra_Vector &x) const=0 |
|
virtual int | RightScale (const Epetra_Vector &x)=0 |
|
virtual bool | Filled () const=0 |
|
virtual double | NormInf () const=0 |
|
virtual double | NormOne () const=0 |
|
virtual int | NumGlobalNonzeros () const=0 |
|
virtual int | NumGlobalRows () const=0 |
|
virtual int | NumGlobalCols () const=0 |
|
virtual int | NumGlobalDiagonals () const=0 |
|
virtual int | NumMyNonzeros () const=0 |
|
virtual int | NumMyRows () const=0 |
|
virtual int | NumMyCols () const=0 |
|
virtual int | NumMyDiagonals () const=0 |
|
virtual bool | LowerTriangular () const=0 |
|
virtual bool | UpperTriangular () const=0 |
|
virtual const Epetra_Map & | RowMatrixRowMap () const=0 |
|
virtual const Epetra_Map & | RowMatrixColMap () const=0 |
|
virtual const Epetra_Import * | RowMatrixImporter () const=0 |
|
virtual int | NumMyRowEntries (int MyRow, int &NumEntries) const=0 |
|
virtual int | MaxNumEntries () const=0 |
|
virtual int | ExtractMyRowCopy (int MyRow, int Length, int &NumEntries, double *Values, int *Indices) const=0 |
|
virtual int | ExtractDiagonalCopy (Epetra_Vector &Diagonal) const=0 |
|
virtual int | Multiply (bool TransA, const Epetra_MultiVector &X, Epetra_MultiVector &Y) const=0 |
|
virtual int | Solve (bool Upper, bool Trans, bool UnitDiagonal, const Epetra_MultiVector &X, Epetra_MultiVector &Y) const=0 |
|
virtual int | InvRowSums (Epetra_Vector &x) const=0 |
|
virtual int | LeftScale (const Epetra_Vector &x)=0 |
|
virtual int | InvColSums (Epetra_Vector &x) const=0 |
|
virtual int | RightScale (const Epetra_Vector &x)=0 |
|
virtual bool | Filled () const=0 |
|
virtual double | NormInf () const=0 |
|
virtual double | NormOne () const=0 |
|
virtual int | NumGlobalNonzeros () const=0 |
|
virtual int | NumGlobalRows () const=0 |
|
virtual int | NumGlobalCols () const=0 |
|
virtual int | NumGlobalDiagonals () const=0 |
|
virtual int | NumMyNonzeros () const=0 |
|
virtual int | NumMyRows () const=0 |
|
virtual int | NumMyCols () const=0 |
|
virtual int | NumMyDiagonals () const=0 |
|
virtual bool | LowerTriangular () const=0 |
|
virtual bool | UpperTriangular () const=0 |
|
virtual const Epetra_Map & | RowMatrixRowMap () const=0 |
|
virtual const Epetra_Map & | RowMatrixColMap () const=0 |
|
virtual const Epetra_Import * | RowMatrixImporter () const=0 |
|
virtual int | SetUseTranspose (bool UseTranspose)=0 |
|
virtual int | Apply (const Epetra_MultiVector &X, Epetra_MultiVector &Y) const=0 |
|
virtual int | ApplyInverse (const Epetra_MultiVector &X, Epetra_MultiVector &Y) const=0 |
|
virtual double | NormInf () const=0 |
|
virtual const char * | Label () const=0 |
|
virtual bool | UseTranspose () const=0 |
|
virtual bool | HasNormInf () const=0 |
|
virtual const Epetra_Comm & | Comm () const=0 |
|
virtual const Epetra_Map & | OperatorDomainMap () const=0 |
|
virtual const Epetra_Map & | OperatorRangeMap () const=0 |
|
virtual int | SetUseTranspose (bool UseTranspose)=0 |
|
virtual int | Apply (const Epetra_MultiVector &X, Epetra_MultiVector &Y) const=0 |
|
virtual int | ApplyInverse (const Epetra_MultiVector &X, Epetra_MultiVector &Y) const=0 |
|
virtual double | NormInf () const=0 |
|
virtual const char * | Label () const=0 |
|
virtual bool | UseTranspose () const=0 |
|
virtual bool | HasNormInf () const=0 |
|
virtual const Epetra_Comm & | Comm () const=0 |
|
virtual const Epetra_Map & | OperatorDomainMap () const=0 |
|
virtual const Epetra_Map & | OperatorRangeMap () const=0 |
|
virtual const Epetra_BlockMap & | Map () const=0 |
|
virtual const Epetra_BlockMap & | Map () const=0 |
|
| Operator () |
| Default constructor.
|
|
| Operator (const Space &DomainSpace, const Space &RangeSpace, ML_Operator *Op, bool Ownership=true, Teuchos::RefCountPtr< ML_Operator_Box > AuxOp=Teuchos::null) |
| Constructor with given already computed ML_Operator pointer.
|
|
| Operator (const Space &DomainSpace, const Space &RangeSpace, Epetra_RowMatrix *Matrix, bool Ownership=true, Teuchos::RefCountPtr< ML_Operator_Box > AuxOp=Teuchos::null) |
| Constructor with given already FillComplete()'d object.
|
|
| Operator (const Operator &RHS) |
| Copy constructor.
|
|
| ~Operator () |
| Destructor.
|
|
void | Reshape () |
| Resets this object.
|
|
void | Reshape (const Space &DomainSpace, const Space &RangeSpace, ML_Operator *Op, bool Ownership=true, Teuchos::RefCountPtr< ML_Operator_Box > AuxOp=Teuchos::null) |
| Reshape with given already computed ML_Operator pointer.
|
|
void | Reshape (const Space &DomainSpace, const Space &RangeSpace, Epetra_RowMatrix *Matrix, bool Ownership=true, Teuchos::RefCountPtr< ML_Operator_Box > AuxOp=Teuchos::null) |
| Reshape with given already FillComplete()'d object.
|
|
Operator & | operator= (const Operator &RHS) |
| Makes this object equivalent to RHS .
|
|
Operator & | operator= (const std::string &Label) |
| Sets the label of this object.
|
|
const Space | GetOperatorDomainSpace () const |
| Returns a reference to the internally stored domain space.
|
|
const Space | GetOperatorRangeSpace () const |
| Returns a reference to the internally stored range space.
|
|
const Space | GetDomainSpace () const |
| Returns a reference to the internally stored domain space.
|
|
const Space | GetRangeSpace () const |
| Returns a reference to the internally stored range space.
|
|
const Space | GetColumnSpace () const |
| Returns a reference to the internally stored column space.
|
|
int | GetNumGlobalRows () const |
| Returns the number of global rows.
|
|
int | GetNumMyRows () const |
| Returns the number of local rows.
|
|
int | GetNumGlobalCols () const |
| Returns the number of global columns.
|
|
int | GetNumMyCols () const |
| Returns the number of local columns.
|
|
int | GetNumGlobalNonzeros () const |
| Returns the global number of nonzeros.
|
|
int | GetNumMyNonzeros () const |
| Returns the local number of nonzeros.
|
|
const Epetra_RowMatrix * | GetRowMatrix () const |
| Returns the RefCountPtr of OperatorBox_.
|
|
ML_Operator * | GetML_Operator () const |
| Returns the RefCountPtr of OperatorBox_.
|
|
const Teuchos::RefCountPtr< ML_Operator_Box > & | GetRCPOperatorBox () const |
| Returns the RefCountPtr of OperatorBox_.
|
|
const Teuchos::RefCountPtr< ML_Operator_Box > & | GetRCPAuxOperatorBox () const |
| Returns the RefCountPtr of AuxOperatorBox_.
|
|
const Teuchos::RefCountPtr< Epetra_RowMatrix > & | GetRCPRowMatrix () const |
| Returns the RefCountPtr of RowMatrix_.
|
|
int | GetGRID (const int LRID) const |
| Returns the global ID of local row ID LRID .
|
|
int | GetGCID (const int LCID) const |
| Returns the global ID of local column ID LCID .
|
|
int | Apply (const MultiVector &X, MultiVector &Y) const |
| Applies this operator to LHS, returns the result in RHS .
|
|
std::ostream & | Print (std::ostream &os, const bool verbose=true) const |
| Prints basic information about this object.
|
|
void | BuildColumnSpace () |
| Build the column space, by computing the GID of all local columns.
|
|
virtual | ~BaseOperator () |
| Virtual destructor.
|
|
virtual int | Apply (const MultiVector &LHS, MultiVector &RHS) const =0 |
| Applies the operator to X , using Y as starting solution. Returns the solution in Y .
|
|
virtual const Space | GetOperatorDomainSpace () const =0 |
| Returns a copy of the domain space of this object.
|
|
virtual const Space | GetOperatorRangeSpace () const =0 |
| Returns a copy of the range space of this object.
|
|
| BaseObject () |
| Constructor with empty label.
|
|
| BaseObject (const std::string &Label) |
| Constructor with given Label.
|
|
virtual | ~BaseObject () |
| Destructor.
|
|
void | SetLabel (const std::string &Label) |
| Sets the Label of this object to Label .
|
|
const std::string & | GetLabel () const |
| Returns the Label of this object.
|
|
virtual std::ostream & | Print (std::ostream &os, const bool Verbose=true) const =0 |
| Prints information on stream.
|
|
| CompObject () |
| Constructor, set counter to 0.0.
|
|
| ~CompObject () |
| Destructor.
|
|
double | GetFlops () const |
| Returns the internal counter of flops.
|
|
void | SetFlops (double Flops) const |
| Sets internal counter to Flops .
|
|
void | UpdateFlops (double Flops) const |
| Updates internal counter by summing Flops .
|
|
| TimeObject () |
| Constructor, set counter to 0.0.
|
|
| ~TimeObject () |
| Destructor.
|
|
void | ResetTimer () const |
| Resets the internal timer.
|
|
void | UpdateTime () const |
| Updates the internal timer with the time spent since the last call to ResetTimer().
|
|
void | UpdateTime (double t) const |
| Updates the internal timer with input value t .
|
|
double | GetTime () const |
| Returns the internally stored counter.
|
|