|
void | GeneralMV (bool TransA, double *x, double *y) const |
|
void | GeneralMM (bool TransA, double **X, int LDX, double **Y, int LDY, int NumVectors) const |
|
void | GeneralMM3RHS (bool TransA, double **X, int LDX, double **Y, int LDY, int NumVectors) const |
|
void | GeneralMM2RHS (bool TransA, double *x, int ldx, double *y, int ldy) const |
|
void | Allocate (const Epetra_RowMatrix &Matrix) |
|
void | Setup () |
|
void | UpdateImportVector (int NumVectors) const |
|
void | UpdateExportVector (int NumVectors) const |
|
void | SetImportExport () |
|
virtual void | ComputeStructureConstants () const |
| Update the constants associated with the structure of the matrix: Call only if structure changes from the initial RowMatrix. More...
|
|
virtual void | ComputeNumericConstants () const |
| Update the constants associated with the values of the matrix: Call only if values changes from the initial RowMatrix. More...
|
|
std::string | toString (const int &x) const |
|
std::string | toString (const long long &x) const |
|
std::string | toString (const double &x) const |
|
|
| Epetra_BasicRowMatrix (const Epetra_Comm &Comm) |
| Epetra_BasicRowMatrix constructor. More...
|
|
virtual | ~Epetra_BasicRowMatrix () |
| Epetra_BasicRowMatrix Destructor. More...
|
|
void | SetMaps (const Epetra_Map &RowMap, const Epetra_Map &ColMap) |
| Set maps (Version 1); call this function or the next, but not both. More...
|
|
void | SetMaps (const Epetra_Map &RowMap, const Epetra_Map &ColMap, const Epetra_Map &DomainMap, const Epetra_Map &RangeMap) |
| Set maps (Version 2); call this function or the previous, but not both. More...
|
|
virtual int | ExtractDiagonalCopy (Epetra_Vector &Diagonal) const |
| Returns a copy of the main diagonal in a user-provided vector. More...
|
|
virtual int | InvRowSums (Epetra_Vector &x) const |
| Computes the sum of absolute values of the rows of the Epetra_BasicRowMatrix, results returned in x. More...
|
|
virtual int | LeftScale (const Epetra_Vector &x) |
| Scales the Epetra_BasicRowMatrix on the left with a Epetra_Vector x. More...
|
|
virtual int | InvColSums (Epetra_Vector &x) const |
| Computes the sum of absolute values of the columns of the Epetra_BasicRowMatrix, results returned in x. More...
|
|
virtual int | RightScale (const Epetra_Vector &x) |
| Scales the Epetra_BasicRowMatrix on the right with a Epetra_Vector x. More...
|
|
virtual bool | Filled () const |
| If FillComplete() has been called, this query returns true, otherwise it returns false, presently always returns true. More...
|
|
bool | LowerTriangular () const |
| If matrix is lower triangular, this query returns true, otherwise it returns false. More...
|
|
virtual bool | UpperTriangular () const |
| If matrix is upper triangular, this query returns true, otherwise it returns false. More...
|
|
virtual double | NormInf () const |
| Returns the infinity norm of the global matrix. More...
|
|
virtual double | NormOne () const |
| Returns the one norm of the global matrix. More...
|
|
virtual int | NumGlobalNonzeros () const |
| Returns the number of nonzero entries in the global matrix. More...
|
|
virtual long long | NumGlobalNonzeros64 () const |
|
virtual int | NumGlobalRows () const |
| Returns the number of global matrix rows. More...
|
|
virtual long long | NumGlobalRows64 () const |
|
virtual int | NumGlobalCols () const |
| Returns the number of global matrix columns. More...
|
|
virtual long long | NumGlobalCols64 () const |
|
virtual int | NumGlobalDiagonals () const |
| Returns the number of global nonzero diagonal entries. More...
|
|
virtual long long | NumGlobalDiagonals64 () const |
|
virtual int | NumMyNonzeros () const |
| Returns the number of nonzero entries in the calling processor's portion of the matrix. More...
|
|
virtual int | NumMyRows () const |
| Returns the number of matrix rows owned by the calling processor. More...
|
|
virtual int | NumMyCols () const |
| Returns the number of matrix columns owned by the calling processor. More...
|
|
virtual int | NumMyDiagonals () const |
| Returns the number of local nonzero diagonal entries. More...
|
|
virtual int | MaxNumEntries () const |
| Returns the maximum number of nonzero entries across all rows on this processor. 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 (same as domain). More...
|
|
virtual const Epetra_BlockMap & | Map () const |
| Implement the Epetra_SrcDistObjec::Map() function. More...
|
|
virtual const Epetra_Map & | RowMatrixRowMap () const |
| Returns the Row Map object needed for implementing Epetra_RowMatrix. More...
|
|
virtual const Epetra_Map & | RowMatrixColMap () const |
| Returns the Column Map object needed for implementing Epetra_RowMatrix. More...
|
|
virtual const Epetra_Import * | RowMatrixImporter () const |
| Returns the Epetra_Import object that contains the import operations for distributed operations. More...
|
|
virtual const Epetra_Comm & | Comm () const |
| Returns a pointer to the Epetra_Comm communicator associated with this matrix. More...
|
|
virtual void | Print (std::ostream &os) const |
| Print method. More...
|
|
virtual int | SetUseTranspose (bool use_transpose) |
| If set true, transpose of this operator will be applied. More...
|
|
virtual const char * | Label () const |
| Returns a character string describing the operator. More...
|
|
virtual int | Apply (const Epetra_MultiVector &X, Epetra_MultiVector &Y) const |
| Returns the result of a Epetra_RowMatrix applied to a Epetra_MultiVector X in Y. More...
|
|
virtual int | ApplyInverse (const Epetra_MultiVector &X, Epetra_MultiVector &Y) const |
| Returns the result of a Epetra_RowMatrix inverse applied to an Epetra_MultiVector X in Y. More...
|
|
bool | HasNormInf () const |
| Returns true because this class can compute an Inf-norm. More...
|
|
virtual bool | UseTranspose () const |
| Returns the current UseTranspose setting. More...
|
|
virtual const Epetra_Import * | Importer () const |
| Returns the Epetra_Import object that contains the import operations for distributed operations, returns zero if none. More...
|
|
virtual const Epetra_Export * | Exporter () const |
| Returns the Epetra_Export object that contains the export operations for distributed operations, returns zero if none. More...
|
|
Epetra_CompObject & | operator= (const Epetra_CompObject &src) |
|
| Epetra_CompObject () |
| Basic Epetra_CompObject constuctor. More...
|
|
| Epetra_CompObject (const Epetra_CompObject &Source) |
| Epetra_CompObject copy constructor. More...
|
|
virtual | ~Epetra_CompObject () |
| Epetra_CompObject destructor. More...
|
|
void | SetFlopCounter (const Epetra_Flops &FlopCounter_in) |
| Set the internal Epetra_Flops() pointer. More...
|
|
void | SetFlopCounter (const Epetra_CompObject &CompObject) |
| Set the internal Epetra_Flops() pointer to the flop counter of another Epetra_CompObject. More...
|
|
void | UnsetFlopCounter () |
| Set the internal Epetra_Flops() pointer to 0 (no flops counted). More...
|
|
Epetra_Flops * | GetFlopCounter () const |
| Get the pointer to the Epetra_Flops() object associated with this object, returns 0 if none. More...
|
|
void | ResetFlops () const |
| Resets the number of floating point operations to zero for this multi-vector. More...
|
|
double | Flops () const |
| Returns the number of floating point operations with this multi-vector. More...
|
|
void | UpdateFlops (int Flops_in) const |
| Increment Flop count for this object. More...
|
|
void | UpdateFlops (long int Flops_in) const |
| Increment Flop count for this object. More...
|
|
void | UpdateFlops (long long Flops_in) const |
| Increment Flop count for this object. More...
|
|
void | UpdateFlops (double Flops_in) const |
| Increment Flop count for this object. More...
|
|
void | UpdateFlops (float Flops_in) const |
| Increment Flop count for this object. More...
|
|
| Epetra_Object (int TracebackModeIn=-1, bool set_label=true) |
| Epetra_Object Constructor. More...
|
|
| Epetra_Object (const char *const Label, int TracebackModeIn=-1) |
| Epetra_Object Constructor. More...
|
|
| Epetra_Object (const Epetra_Object &Object) |
| Epetra_Object Copy Constructor. More...
|
|
virtual | ~Epetra_Object () |
| Epetra_Object Destructor. More...
|
|
virtual void | SetLabel (const char *const Label) |
| Epetra_Object Label definition using char *. More...
|
|
virtual int | ReportError (const std::string Message, int ErrorCode) const |
| Error reporting method. More...
|
|
virtual | ~Epetra_RowMatrix () |
| Destructor. More...
|
|
virtual | ~Epetra_Operator () |
| Destructor. More...
|
|
virtual | ~Epetra_SrcDistObject () |
| Epetra_SrcDistObject destructor. More...
|
|
static void | SetTracebackMode (int TracebackModeValue) |
| Set the value of the Epetra_Object error traceback report mode. More...
|
|
static int | GetTracebackMode () |
| Get the value of the Epetra_Object error report mode. More...
|
|
static std::ostream & | GetTracebackStream () |
| Get the output stream for error reporting. More...
|
|
static int | TracebackMode |
|
Epetra_JadMatrix: A class for constructing matrix objects optimized for common kernels.
The Epetra_JadMatrix class takes an existing Epetra_RowMatrix ojbect, analyzes it and builds a jagged diagonal equivalent of it. Once constructed, it is also possible to update the values of the matrix with values from another Epetra_RowMatrix that has the identical structure.
Definition at line 68 of file Epetra_JadMatrix.h.