ML  Version of the Day
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Groups Pages
Public Member Functions | List of all members
MLAPI::DistributedMatrix Class Reference
Inheritance diagram for MLAPI::DistributedMatrix:
Inheritance graph
[legend]
Collaboration diagram for MLAPI::DistributedMatrix:
Collaboration graph
[legend]

Public Member Functions

 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_MapRowMatrixRowMap () const
 
virtual const Epetra_MapRowMatrixColMap () const
 
virtual const Epetra_ImportRowMatrixImporter () const
 
virtual const Epetra_MapOperatorDomainMap () const
 
virtual const Epetra_MapOperatorRangeMap () const
 
virtual const Epetra_MapMap () 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_CommComm () 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
 
- Public Member Functions inherited from MLAPI::Operator
 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.
 
Operatoroperator= (const Operator &RHS)
 Makes this object equivalent to RHS.
 
Operatoroperator= (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_RowMatrixGetRowMatrix () const
 Returns the RefCountPtr of OperatorBox_.
 
ML_OperatorGetML_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.
 
- Public Member Functions inherited from MLAPI::BaseOperator
virtual ~BaseOperator ()
 Virtual destructor.
 
- Public Member Functions inherited from MLAPI::BaseObject
 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.
 
- Public Member Functions inherited from MLAPI::CompObject
 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.
 
- Public Member Functions inherited from MLAPI::TimeObject
 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.
 

Additional Inherited Members

- Protected Attributes inherited from MLAPI::TimeObject
Epetra_Time Time_
 Object used to track time.
 
double TotalTime_
 Internal counter.
 

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