| 
|   | Epetra_FECrsMatrix (Epetra_DataAccess CV, const Epetra_Map &RowMap, int *NumEntriesPerRow, bool ignoreNonLocalEntries=false) | 
|   | 
|   | Epetra_FECrsMatrix (Epetra_DataAccess CV, const Epetra_Map &RowMap, int NumEntriesPerRow, bool ignoreNonLocalEntries=false) | 
|   | 
|   | Epetra_FECrsMatrix (Epetra_DataAccess CV, const Epetra_Map &RowMap, const Epetra_Map &ColMap, int *NumEntriesPerRow, bool ignoreNonLocalEntries=false) | 
|   | 
|   | Epetra_FECrsMatrix (Epetra_DataAccess CV, const Epetra_Map &RowMap, const Epetra_Map &ColMap, int NumEntriesPerRow, bool ignoreNonLocalEntries=false) | 
|   | 
|   | Epetra_FECrsMatrix (Epetra_DataAccess CV, const Epetra_CrsGraph &Graph, bool ignoreNonLocalEntries=false) | 
|   | 
|   | Epetra_FECrsMatrix (Epetra_DataAccess CV, const Epetra_FECrsGraph &Graph, bool ignoreNonLocalEntries=false) | 
|   | 
|   | Epetra_FECrsMatrix (const Epetra_FECrsMatrix &src) | 
|   | 
| virtual  | ~Epetra_FECrsMatrix () | 
|   | 
| Epetra_FECrsMatrix &  | operator= (const Epetra_FECrsMatrix &src) | 
|   | 
| 
void  | Print (std::ostream &os) const  | 
|   | Print method. 
  | 
|   | 
| int  | SumIntoGlobalValues (int GlobalRow, int NumEntries, const double *Values, const int *Indices) | 
|   | 
| 
int  | SumIntoGlobalValues (long long GlobalRow, int NumEntries, const double *Values, const long long *Indices) | 
|   | 
| int  | InsertGlobalValues (int GlobalRow, int NumEntries, const double *Values, const int *Indices) | 
|   | 
| 
int  | InsertGlobalValues (long long GlobalRow, int NumEntries, const double *Values, const long long *Indices) | 
|   | 
| int  | InsertGlobalValues (int GlobalRow, int NumEntries, double *Values, int *Indices) | 
|   | 
| 
int  | InsertGlobalValues (long long GlobalRow, int NumEntries, double *Values, long long *Indices) | 
|   | 
| int  | ReplaceGlobalValues (int GlobalRow, int NumEntries, const double *Values, const int *Indices) | 
|   | 
| 
int  | ReplaceGlobalValues (long long GlobalRow, int NumEntries, const double *Values, const long long *Indices) | 
|   | 
| int  | SumIntoGlobalValues (int numIndices, const int *indices, const double *values, int format=Epetra_FECrsMatrix::COLUMN_MAJOR) | 
|   | 
| 
int  | SumIntoGlobalValues (int numIndices, const long long *indices, const double *values, int format=Epetra_FECrsMatrix::COLUMN_MAJOR) | 
|   | 
| int  | SumIntoGlobalValues (int numRows, const int *rows, int numCols, const int *cols, const double *values, int format=Epetra_FECrsMatrix::COLUMN_MAJOR) | 
|   | 
| 
int  | SumIntoGlobalValues (int numRows, const long long *rows, int numCols, const long long *cols, const double *values, int format=Epetra_FECrsMatrix::COLUMN_MAJOR) | 
|   | 
| int  | SumIntoGlobalValues (int numIndices, const int *indices, const double *const *values, int format=Epetra_FECrsMatrix::ROW_MAJOR) | 
|   | 
| 
int  | SumIntoGlobalValues (int numIndices, const long long *indices, const double *const *values, int format=Epetra_FECrsMatrix::ROW_MAJOR) | 
|   | 
| int  | SumIntoGlobalValues (int numRows, const int *rows, int numCols, const int *cols, const double *const *values, int format=Epetra_FECrsMatrix::ROW_MAJOR) | 
|   | 
| 
int  | SumIntoGlobalValues (int numRows, const long long *rows, int numCols, const long long *cols, const double *const *values, int format=Epetra_FECrsMatrix::ROW_MAJOR) | 
|   | 
| int  | InsertGlobalValues (int numIndices, const int *indices, const double *values, int format=Epetra_FECrsMatrix::COLUMN_MAJOR) | 
|   | 
| 
int  | InsertGlobalValues (int numIndices, const long long *indices, const double *values, int format=Epetra_FECrsMatrix::COLUMN_MAJOR) | 
|   | 
| int  | InsertGlobalValues (int numRows, const int *rows, int numCols, const int *cols, const double *values, int format=Epetra_FECrsMatrix::COLUMN_MAJOR) | 
|   | 
| 
int  | InsertGlobalValues (int numRows, const long long *rows, int numCols, const long long *cols, const double *values, int format=Epetra_FECrsMatrix::COLUMN_MAJOR) | 
|   | 
| int  | InsertGlobalValues (int numIndices, const int *indices, const double *const *values, int format=Epetra_FECrsMatrix::ROW_MAJOR) | 
|   | 
| 
int  | InsertGlobalValues (int numIndices, const long long *indices, const double *const *values, int format=Epetra_FECrsMatrix::ROW_MAJOR) | 
|   | 
| int  | InsertGlobalValues (int numRows, const int *rows, int numCols, const int *cols, const double *const *values, int format=Epetra_FECrsMatrix::ROW_MAJOR) | 
|   | 
| 
int  | InsertGlobalValues (int numRows, const long long *rows, int numCols, const long long *cols, const double *const *values, int format=Epetra_FECrsMatrix::ROW_MAJOR) | 
|   | 
| int  | ReplaceGlobalValues (int numIndices, const int *indices, const double *values, int format=Epetra_FECrsMatrix::COLUMN_MAJOR) | 
|   | 
| 
int  | ReplaceGlobalValues (int numIndices, const long long *indices, const double *values, int format=Epetra_FECrsMatrix::COLUMN_MAJOR) | 
|   | 
| int  | ReplaceGlobalValues (int numRows, const int *rows, int numCols, const int *cols, const double *values, int format=Epetra_FECrsMatrix::COLUMN_MAJOR) | 
|   | 
| 
int  | ReplaceGlobalValues (int numRows, const long long *rows, int numCols, const long long *cols, const double *values, int format=Epetra_FECrsMatrix::COLUMN_MAJOR) | 
|   | 
| int  | ReplaceGlobalValues (int numIndices, const int *indices, const double *const *values, int format=Epetra_FECrsMatrix::ROW_MAJOR) | 
|   | 
| 
int  | ReplaceGlobalValues (int numIndices, const long long *indices, const double *const *values, int format=Epetra_FECrsMatrix::ROW_MAJOR) | 
|   | 
| int  | ReplaceGlobalValues (int numRows, const int *rows, int numCols, const int *cols, const double *const *values, int format=Epetra_FECrsMatrix::ROW_MAJOR) | 
|   | 
| 
int  | ReplaceGlobalValues (int numRows, const long long *rows, int numCols, const long long *cols, const double *const *values, int format=Epetra_FECrsMatrix::ROW_MAJOR) | 
|   | 
| int  | SumIntoGlobalValues (const Epetra_IntSerialDenseVector &indices, const Epetra_SerialDenseMatrix &values, int format=Epetra_FECrsMatrix::COLUMN_MAJOR) | 
|   | 
| 
int  | SumIntoGlobalValues (const Epetra_LongLongSerialDenseVector &indices, const Epetra_SerialDenseMatrix &values, int format=Epetra_FECrsMatrix::COLUMN_MAJOR) | 
|   | 
| int  | SumIntoGlobalValues (const Epetra_IntSerialDenseVector &rows, const Epetra_IntSerialDenseVector &cols, const Epetra_SerialDenseMatrix &values, int format=Epetra_FECrsMatrix::COLUMN_MAJOR) | 
|   | 
| 
int  | SumIntoGlobalValues (const Epetra_LongLongSerialDenseVector &rows, const Epetra_LongLongSerialDenseVector &cols, const Epetra_SerialDenseMatrix &values, int format=Epetra_FECrsMatrix::COLUMN_MAJOR) | 
|   | 
| int  | InsertGlobalValues (const Epetra_IntSerialDenseVector &indices, const Epetra_SerialDenseMatrix &values, int format=Epetra_FECrsMatrix::COLUMN_MAJOR) | 
|   | 
| 
int  | InsertGlobalValues (const Epetra_LongLongSerialDenseVector &indices, const Epetra_SerialDenseMatrix &values, int format=Epetra_FECrsMatrix::COLUMN_MAJOR) | 
|   | 
| int  | InsertGlobalValues (const Epetra_IntSerialDenseVector &rows, const Epetra_IntSerialDenseVector &cols, const Epetra_SerialDenseMatrix &values, int format=Epetra_FECrsMatrix::COLUMN_MAJOR) | 
|   | 
| 
int  | InsertGlobalValues (const Epetra_LongLongSerialDenseVector &rows, const Epetra_LongLongSerialDenseVector &cols, const Epetra_SerialDenseMatrix &values, int format=Epetra_FECrsMatrix::COLUMN_MAJOR) | 
|   | 
| int  | ReplaceGlobalValues (const Epetra_IntSerialDenseVector &indices, const Epetra_SerialDenseMatrix &values, int format=Epetra_FECrsMatrix::COLUMN_MAJOR) | 
|   | 
| 
int  | ReplaceGlobalValues (const Epetra_LongLongSerialDenseVector &indices, const Epetra_SerialDenseMatrix &values, int format=Epetra_FECrsMatrix::COLUMN_MAJOR) | 
|   | 
| int  | ReplaceGlobalValues (const Epetra_IntSerialDenseVector &rows, const Epetra_IntSerialDenseVector &cols, const Epetra_SerialDenseMatrix &values, int format=Epetra_FECrsMatrix::COLUMN_MAJOR) | 
|   | 
| 
int  | ReplaceGlobalValues (const Epetra_LongLongSerialDenseVector &rows, const Epetra_LongLongSerialDenseVector &cols, const Epetra_SerialDenseMatrix &values, int format=Epetra_FECrsMatrix::COLUMN_MAJOR) | 
|   | 
| int  | GlobalAssemble (bool callFillComplete=true, Epetra_CombineMode combineMode=Add, bool save_off_and_reuse_map_exporter=false) | 
|   | 
| int  | GlobalAssemble (const Epetra_Map &domain_map, const Epetra_Map &range_map, bool callFillComplete=true, Epetra_CombineMode combineMode=Add, bool save_off_and_reuse_map_exporter=false) | 
|   | 
| void  | setIgnoreNonLocalEntries (bool flag) | 
|   | 
| 
void  | FusedImport (const Epetra_CrsMatrix &SourceMatrix, const Epetra_Import &RowImporter, const Epetra_Map *DomainMap, const Epetra_Map *RangeMap, bool RestrictCommunicator) | 
|   | 
| 
void  | FusedExport (const Epetra_CrsMatrix &SourceMatrix, const Epetra_Export &RowExporter, const Epetra_Map *DomainMap, const Epetra_Map *RangeMap, bool RestrictCommunicator) | 
|   | 
| 
void  | FusedImport (const Epetra_CrsMatrix &SourceMatrix, const Epetra_Import &RowImporter, const Epetra_Import *DomainImporter, const Epetra_Map *DomainMap, const Epetra_Map *RangeMap, bool RestrictCommunicator) | 
|   | 
| 
void  | FusedExport (const Epetra_CrsMatrix &SourceMatrix, const Epetra_Export &RowExporter, const Epetra_Export *DomainExporter, const Epetra_Map *DomainMap, const Epetra_Map *RangeMap, bool RestrictCommunicator) | 
|   | 
|   | Epetra_CrsMatrix (Epetra_DataAccess CV, const Epetra_Map &RowMap, const int *NumEntriesPerRow, bool StaticProfile=false) | 
|   | Epetra_CrsMatrix constructor with variable number of indices per row.  More...
  | 
|   | 
|   | Epetra_CrsMatrix (Epetra_DataAccess CV, const Epetra_Map &RowMap, int NumEntriesPerRow, bool StaticProfile=false) | 
|   | Epetra_CrsMatrix constructor with fixed number of indices per row.  More...
  | 
|   | 
|   | Epetra_CrsMatrix (Epetra_DataAccess CV, const Epetra_Map &RowMap, const Epetra_Map &ColMap, const int *NumEntriesPerRow, bool StaticProfile=false) | 
|   | Epetra_CrsMatrix constructor with variable number of indices per row.  More...
  | 
|   | 
|   | Epetra_CrsMatrix (Epetra_DataAccess CV, const Epetra_Map &RowMap, const Epetra_Map &ColMap, int NumEntriesPerRow, bool StaticProfile=false) | 
|   | Epetra_CrsMatrix constuctor with fixed number of indices per row.  More...
  | 
|   | 
|   | Epetra_CrsMatrix (Epetra_DataAccess CV, const Epetra_CrsGraph &Graph) | 
|   | Construct a matrix using an existing Epetra_CrsGraph object.  More...
  | 
|   | 
|   | Epetra_CrsMatrix (const Epetra_CrsMatrix &SourceMatrix, const Epetra_Import &RowImporter, const Epetra_Map *DomainMap=0, const Epetra_Map *RangeMap=0, bool RestrictCommunicator=false) | 
|   | Epetra CrsMatrix constructor that also fuses Import and FillComplete().  More...
  | 
|   | 
|   | Epetra_CrsMatrix (const Epetra_CrsMatrix &SourceMatrix, const Epetra_Import &RowImporter, const Epetra_Import *DomainImporter, const Epetra_Map *DomainMap, const Epetra_Map *RangeMap, bool RestrictCommunicator) | 
|   | Epetra CrsMatrix constructor that also fuses Import and FillComplete().  More...
  | 
|   | 
|   | Epetra_CrsMatrix (const Epetra_CrsMatrix &SourceMatrix, const Epetra_Export &RowExporter, const Epetra_Map *DomainMap=0, const Epetra_Map *RangeMap=0, bool RestrictCommunicator=false) | 
|   | Epetra CrsMatrix constructor that also fuses Ex[prt and FillComplete().  More...
  | 
|   | 
|   | Epetra_CrsMatrix (const Epetra_CrsMatrix &SourceMatrix, const Epetra_Export &RowExporter, const Epetra_Export *DomainExporter, const Epetra_Map *DomainMap, const Epetra_Map *RangeMap, bool RestrictCommunicator) | 
|   | Epetra CrsMatrix constructor that also fuses Ex[prt and FillComplete().  More...
  | 
|   | 
| 
  | Epetra_CrsMatrix (const Epetra_CrsMatrix &Matrix) | 
|   | Copy constructor. 
  | 
|   | 
| 
virtual  | ~Epetra_CrsMatrix () | 
|   | Epetra_CrsMatrix Destructor. 
  | 
|   | 
| 
Epetra_CrsMatrix &  | operator= (const Epetra_CrsMatrix &src) | 
|   | Assignment operator. 
  | 
|   | 
| int  | PutScalar (double ScalarConstant) | 
|   | Initialize all values in the matrix with constant value.  More...
  | 
|   | 
| int  | Scale (double ScalarConstant) | 
|   | Multiply all values in the matrix by a constant value (in place: A <- ScalarConstant * A).  More...
  | 
|   | 
| int  | InsertMyValues (int MyRow, int NumEntries, const double *Values, const int *Indices) | 
|   | Insert a list of elements in a given local row of the matrix.  More...
  | 
|   | 
| int  | InsertMyValues (int MyRow, int NumEntries, double *Values, int *Indices) | 
|   | Insert a list of elements in a given local row of the matrix.  More...
  | 
|   | 
| int  | ReplaceMyValues (int MyRow, int NumEntries, const double *Values, const int *Indices) | 
|   | Replace current values with this list of entries for a given local row of the matrix.  More...
  | 
|   | 
| int  | SumIntoMyValues (int MyRow, int NumEntries, const double *Values, const int *Indices) | 
|   | Add this list of entries to existing values for a given local row of the matrix.  More...
  | 
|   | 
| int  | ReplaceDiagonalValues (const Epetra_Vector &Diagonal) | 
|   | Replaces diagonal values of the matrix with those in the user-provided vector.  More...
  | 
|   | 
| 
int  | FillComplete (bool OptimizeDataStorage=true) | 
|   | Signal that data entry is complete. Perform transformations to local index space. 
  | 
|   | 
| 
int  | FillComplete (const Epetra_Map &DomainMap, const Epetra_Map &RangeMap, bool OptimizeDataStorage=true) | 
|   | Signal that data entry is complete. Perform transformations to local index space. 
  | 
|   | 
| int  | OptimizeStorage () | 
|   | Make consecutive row index sections contiguous, minimize internal storage used for constructing graph.  More...
  | 
|   | 
| 
int  | MakeDataContiguous () | 
|   | Eliminates memory that is used for construction. Make consecutive row index sections contiguous. 
  | 
|   | 
| int  | ExtractGlobalRowCopy (int GlobalRow, int Length, int &NumEntries, double *Values, int *Indices) const  | 
|   | Returns a copy of the specified global row in user-provided arrays.  More...
  | 
|   | 
| 
int  | ExtractGlobalRowCopy (long long GlobalRow, int Length, int &NumEntries, double *Values, long long *Indices) const  | 
|   | 
| int  | ExtractMyRowCopy (int MyRow, int Length, int &NumEntries, double *Values, int *Indices) const  | 
|   | Returns a copy of the specified local row in user-provided arrays.  More...
  | 
|   | 
| int  | ExtractGlobalRowCopy (int GlobalRow, int Length, int &NumEntries, double *Values) const  | 
|   | Returns a copy of the specified global row values in user-provided array.  More...
  | 
|   | 
| 
int  | ExtractGlobalRowCopy (long long GlobalRow, int Length, int &NumEntries, double *Values) const  | 
|   | 
| int  | ExtractMyRowCopy (int MyRow, int Length, int &NumEntries, double *Values) const  | 
|   | Returns a copy of the specified local row values in user-provided array.  More...
  | 
|   | 
| int  | ExtractDiagonalCopy (Epetra_Vector &Diagonal) const  | 
|   | Returns a copy of the main diagonal in a user-provided vector.  More...
  | 
|   | 
| int  | ExtractGlobalRowView (int GlobalRow, int &NumEntries, double *&Values, int *&Indices) const  | 
|   | Returns a view of the specified global row values via pointers to internal data.  More...
  | 
|   | 
| 
int  | ExtractGlobalRowView (long long GlobalRow, int &NumEntries, double *&Values, long long *&Indices) const  | 
|   | 
| int  | ExtractMyRowView (int MyRow, int &NumEntries, double *&Values, int *&Indices) const  | 
|   | Returns a view of the specified local row values via pointers to internal data.  More...
  | 
|   | 
| int  | ExtractGlobalRowView (int GlobalRow, int &NumEntries, double *&Values) const  | 
|   | Returns a view of the specified global row values via pointers to internal data.  More...
  | 
|   | 
| 
int  | ExtractGlobalRowView (long long GlobalRow, int &NumEntries, double *&Values) const  | 
|   | 
| int  | ExtractMyRowView (int MyRow, int &NumEntries, double *&Values) const  | 
|   | Returns a view of the specified local row values via pointers to internal data.  More...
  | 
|   | 
| int  | Multiply (bool TransA, const Epetra_Vector &x, Epetra_Vector &y) const  | 
|   | Returns the result of a Epetra_CrsMatrix multiplied by a Epetra_Vector x in y.  More...
  | 
|   | 
| 
int  | Multiply1 (bool TransA, const Epetra_Vector &x, Epetra_Vector &y) const  | 
|   | 
| int  | Multiply (bool TransA, const Epetra_MultiVector &X, Epetra_MultiVector &Y) const  | 
|   | Returns the result of a Epetra_CrsMatrix multiplied by a Epetra_MultiVector X in Y.  More...
  | 
|   | 
| 
int  | Multiply1 (bool TransA, const Epetra_MultiVector &X, Epetra_MultiVector &Y) const  | 
|   | 
| int  | Solve (bool Upper, bool Trans, bool UnitDiagonal, const Epetra_Vector &x, Epetra_Vector &y) const  | 
|   | Returns the result of a local solve using the Epetra_CrsMatrix on a Epetra_Vector x in y.  More...
  | 
|   | 
| int  | Solve (bool Upper, bool Trans, bool UnitDiagonal, const Epetra_MultiVector &X, Epetra_MultiVector &Y) const  | 
|   | Returns the result of a local solve using the Epetra_CrsMatrix a Epetra_MultiVector X in Y.  More...
  | 
|   | 
| int  | InvRowSums (Epetra_Vector &x) const  | 
|   | Computes the inverse of the sum of absolute values of the rows of the Epetra_CrsMatrix, results returned in x.  More...
  | 
|   | 
| int  | InvRowMaxs (Epetra_Vector &x) const  | 
|   | Computes the inverse of the max of absolute values of the rows of the Epetra_CrsMatrix, results returned in x.  More...
  | 
|   | 
| int  | LeftScale (const Epetra_Vector &x) | 
|   | Scales the Epetra_CrsMatrix on the left with a Epetra_Vector x.  More...
  | 
|   | 
| int  | InvColSums (Epetra_Vector &x) const  | 
|   | Computes the inverse of the sum of absolute values of the columns of the Epetra_CrsMatrix, results returned in x.  More...
  | 
|   | 
| int  | InvColMaxs (Epetra_Vector &x) const  | 
|   | Computes the max of absolute values of the columns of the Epetra_CrsMatrix, results returned in x.  More...
  | 
|   | 
| int  | RightScale (const Epetra_Vector &x) | 
|   | Scales the Epetra_CrsMatrix on the right with a Epetra_Vector x.  More...
  | 
|   | 
| 
bool  | Filled () const  | 
|   | If FillComplete() has been called, this query returns true, otherwise it returns false. 
  | 
|   | 
| 
bool  | StorageOptimized () const  | 
|   | If OptimizeStorage() has been called, this query returns true, otherwise it returns false. 
  | 
|   | 
| 
bool  | IndicesAreGlobal () const  | 
|   | If matrix indices has not been transformed to local, this query returns true, otherwise it returns false. 
  | 
|   | 
| 
bool  | IndicesAreLocal () const  | 
|   | If matrix indices has been transformed to local, this query returns true, otherwise it returns false. 
  | 
|   | 
| 
bool  | IndicesAreContiguous () const  | 
|   | If matrix indices are packed into single array (done in OptimizeStorage()) return true, otherwise false. 
  | 
|   | 
| 
bool  | LowerTriangular () const  | 
|   | If matrix is lower triangular in local index space, this query returns true, otherwise it returns false. 
  | 
|   | 
| 
bool  | UpperTriangular () const  | 
|   | If matrix is upper triangular in local index space, this query returns true, otherwise it returns false. 
  | 
|   | 
| 
bool  | NoDiagonal () const  | 
|   | If matrix has no diagonal entries in global index space, this query returns true, otherwise it returns false. 
  | 
|   | 
| 
double  | NormInf () const  | 
|   | Returns the infinity norm of the global matrix. 
  | 
|   | 
| 
double  | NormOne () const  | 
|   | Returns the one norm of the global matrix. 
  | 
|   | 
| 
double  | NormFrobenius () const  | 
|   | Returns the frobenius norm of the global matrix. 
  | 
|   | 
| 
int  | NumGlobalNonzeros () const  | 
|   | Returns the number of nonzero entries in the global matrix. 
  | 
|   | 
| 
long long  | NumGlobalNonzeros64 () const  | 
|   | 
| 
int  | NumGlobalRows () const  | 
|   | Returns the number of global matrix rows. 
  | 
|   | 
| 
long long  | NumGlobalRows64 () const  | 
|   | 
| 
int  | NumGlobalCols () const  | 
|   | Returns the number of global matrix columns. 
  | 
|   | 
| 
long long  | NumGlobalCols64 () const  | 
|   | 
| 
int  | NumGlobalDiagonals () const  | 
|   | Returns the number of global nonzero diagonal entries, based on global row/column index comparisons. 
  | 
|   | 
| 
long long  | NumGlobalDiagonals64 () const  | 
|   | 
| 
int  | NumMyNonzeros () const  | 
|   | Returns the number of nonzero entries in the calling processor's portion of the matrix. 
  | 
|   | 
| 
int  | NumMyRows () const  | 
|   | Returns the number of matrix rows owned by the calling processor. 
  | 
|   | 
| int  | NumMyCols () const  | 
|   | Returns the number of entries in the set of column-indices that appear on this processor.  More...
  | 
|   | 
| int  | NumMyDiagonals () const  | 
|   | Returns the number of local nonzero diagonal entries, based on global row/column index comparisons.  More...
  | 
|   | 
| 
int  | NumGlobalEntries (long long Row) const  | 
|   | Returns the current number of nonzero entries in specified global row on this processor. 
  | 
|   | 
| 
int  | NumAllocatedGlobalEntries (int Row) const  | 
|   | Returns the allocated number of nonzero entries in specified global row on this processor. 
  | 
|   | 
| int  | MaxNumEntries () const  | 
|   | Returns the maximum number of nonzero entries across all rows on this processor.  More...
  | 
|   | 
| int  | GlobalMaxNumEntries () const  | 
|   | Returns the maximum number of nonzero entries across all rows on all processors.  More...
  | 
|   | 
| 
int  | NumMyEntries (int Row) const  | 
|   | Returns the current number of nonzero entries in specified local row on this processor. 
  | 
|   | 
| 
int  | NumAllocatedMyEntries (int Row) const  | 
|   | Returns the allocated number of nonzero entries in specified local row on this processor. 
  | 
|   | 
| int  | IndexBase () const  | 
|   | Returns the index base for row and column indices for this graph.  More...
  | 
|   | 
| 
long long  | IndexBase64 () const  | 
|   | 
| 
bool  | StaticGraph () | 
|   | Returns true if the graph associated with this matrix was pre-constructed and therefore not changeable. 
  | 
|   | 
| 
const Epetra_CrsGraph &  | Graph () const  | 
|   | Returns a reference to the Epetra_CrsGraph object associated with this matrix. 
  | 
|   | 
| 
const Epetra_Map &  | RowMap () const  | 
|   | Returns the Epetra_Map object associated with the rows of this matrix. 
  | 
|   | 
| int  | ReplaceRowMap (const Epetra_BlockMap &newmap) | 
|   | Replaces the current RowMap with the user-specified map object.  More...
  | 
|   | 
| bool  | HaveColMap () const  | 
|   | Returns true if we have a well-defined ColMap, and returns false otherwise.  More...
  | 
|   | 
| int  | ReplaceColMap (const Epetra_BlockMap &newmap) | 
|   | Replaces the current ColMap with the user-specified map object.  More...
  | 
|   | 
| int  | ReplaceDomainMapAndImporter (const Epetra_Map &NewDomainMap, const Epetra_Import *NewImporter) | 
|   | Replaces the current DomainMap & Importer with the user-specified map object.  More...
  | 
|   | 
| int  | RemoveEmptyProcessesInPlace (const Epetra_BlockMap *NewMap) | 
|   | Remove processes owning zero rows from the Maps and their communicator.  More...
  | 
|   | 
| const Epetra_Map &  | ColMap () const  | 
|   | Returns the Epetra_Map object that describes the set of column-indices that appear in each processor's locally owned matrix rows.  More...
  | 
|   | 
| const Epetra_Map &  | DomainMap () const  | 
|   | Returns the Epetra_Map object associated with the domain of this matrix operator.  More...
  | 
|   | 
| const Epetra_Map &  | RangeMap () const  | 
|   | Returns the Epetra_Map object associated with the range of this matrix operator.  More...
  | 
|   | 
| 
const Epetra_Import *  | Importer () const  | 
|   | Returns the Epetra_Import object that contains the import operations for distributed operations. 
  | 
|   | 
| 
const Epetra_Export *  | Exporter () const  | 
|   | Returns the Epetra_Export object that contains the export operations for distributed operations. 
  | 
|   | 
| 
const Epetra_Comm &  | Comm () const  | 
|   | Returns a pointer to the Epetra_Comm communicator associated with this matrix. 
  | 
|   | 
| 
int  | LRID (int GRID_in) const  | 
|   | Returns the local row index for given global row index, returns -1 if no local row for this global row. 
  | 
|   | 
| 
int  | LRID (long long GRID_in) const  | 
|   | 
| 
int  | GRID (int LRID_in) const  | 
|   | Returns the global row index for give local row index, returns IndexBase-1 if we don't have this local row. 
  | 
|   | 
| 
long long  | GRID64 (int LRID_in) const  | 
|   | 
| int  | LCID (int GCID_in) const  | 
|   | Returns the local column index for given global column index, returns -1 if no local column for this global column.  More...
  | 
|   | 
| 
int  | LCID (long long GCID_in) const  | 
|   | 
| int  | GCID (int LCID_in) const  | 
|   | Returns the global column index for give local column index, returns IndexBase-1 if we don't have this local column.  More...
  | 
|   | 
| 
long long  | GCID64 (int LCID_in) const  | 
|   | 
| 
bool  | MyGRID (int GRID_in) const  | 
|   | Returns true if the GRID passed in belongs to the calling processor in this map, otherwise returns false. 
  | 
|   | 
| 
bool  | MyGRID (long long GRID_in) const  | 
|   | 
| 
bool  | MyLRID (int LRID_in) const  | 
|   | Returns true if the LRID passed in belongs to the calling processor in this map, otherwise returns false. 
  | 
|   | 
| bool  | MyGCID (int GCID_in) const  | 
|   | Returns true if the GCID passed in belongs to the calling processor in this map, otherwise returns false.  More...
  | 
|   | 
| 
bool  | MyGCID (long long GCID_in) const  | 
|   | 
| bool  | MyLCID (int LCID_in) const  | 
|   | Returns true if the LRID passed in belongs to the calling processor in this map, otherwise returns false.  More...
  | 
|   | 
| 
bool  | MyGlobalRow (int GID) const  | 
|   | Returns true of GID is owned by the calling processor, otherwise it returns false. 
  | 
|   | 
| 
bool  | MyGlobalRow (long long GID) const  | 
|   | 
| 
const char *  | Label () const  | 
|   | Returns a character string describing the operator. 
  | 
|   | 
| int  | SetUseTranspose (bool UseTranspose_in) | 
|   | If set true, transpose of this operator will be applied.  More...
  | 
|   | 
| int  | Apply (const Epetra_MultiVector &X, Epetra_MultiVector &Y) const  | 
|   | Returns the result of a Epetra_Operator applied to a Epetra_MultiVector X in Y.  More...
  | 
|   | 
| int  | ApplyInverse (const Epetra_MultiVector &X, Epetra_MultiVector &Y) const  | 
|   | Returns the result of a Epetra_Operator inverse applied to an Epetra_MultiVector X in Y.  More...
  | 
|   | 
| 
bool  | HasNormInf () const  | 
|   | Returns true because this class can compute an Inf-norm. 
  | 
|   | 
| 
bool  | UseTranspose () const  | 
|   | Returns the current UseTranspose setting. 
  | 
|   | 
| 
const Epetra_Map &  | OperatorDomainMap () const  | 
|   | Returns the Epetra_Map object associated with the domain of this matrix operator. 
  | 
|   | 
| 
const Epetra_Map &  | OperatorRangeMap () const  | 
|   | Returns the Epetra_Map object associated with the range of this matrix operator. 
  | 
|   | 
| int  | NumMyRowEntries (int MyRow, int &NumEntries) const  | 
|   | Return the current number of values stored for the specified local row.  More...
  | 
|   | 
| 
const Epetra_BlockMap &  | Map () const  | 
|   | Map() method inherited from Epetra_DistObject. 
  | 
|   | 
| 
const Epetra_Map &  | RowMatrixRowMap () const  | 
|   | Returns the Epetra_Map object associated with the rows of this matrix. 
  | 
|   | 
| 
const Epetra_Map &  | RowMatrixColMap () const  | 
|   | Returns the Epetra_Map object associated with columns of this matrix. 
  | 
|   | 
| 
const Epetra_Import *  | RowMatrixImporter () const  | 
|   | Returns the Epetra_Import object that contains the import operations for distributed operations. 
  | 
|   | 
| double *  | operator[] (int Loc) | 
|   | Inlined bracket operator for fast access to data. (Const and Non-const versions)  More...
  | 
|   | 
| 
double *  | operator[] (int Loc) const  | 
|   | 
| int  | ExtractCrsDataPointers (int *&IndexOffset, int *&Indices, double *&Values_in) const  | 
|   | Returns internal data pointers associated with Crs matrix format.  More...
  | 
|   | 
| Epetra_IntSerialDenseVector &  | ExpertExtractIndexOffset () | 
|   | Returns a reference to the Epetra_IntSerialDenseVector used to hold the local IndexOffsets (CRS rowptr)  More...
  | 
|   | 
| Epetra_IntSerialDenseVector &  | ExpertExtractIndices () | 
|   | Returns a reference to the Epetra_IntSerialDenseVector used to hold the local All_Indices (CRS colind)  More...
  | 
|   | 
| double *&  | ExpertExtractValues () | 
|   | Returns a reference to the double* used to hold the values array.  More...
  | 
|   | 
| int  | ExpertStaticFillComplete (const Epetra_Map &DomainMap, const Epetra_Map &RangeMap, const Epetra_Import *Importer=0, const Epetra_Export *Exporter=0, int NumMyDiagonals=-1) | 
|   | Performs a FillComplete on an object that aready has filled CRS data.  More...
  | 
|   | 
| int  | ExpertMakeUniqueCrsGraphData () | 
|   | Makes sure this matrix has a unique CrsGraphData object.  More...
  | 
|   | 
| int  | SortGhostsAssociatedWithEachProcessor (bool Flag) | 
|   | Forces FillComplete() to locally order ghostnodes associated with each remote processor in ascending order.  More...
  | 
|   | 
| 
const Epetra_Map &  | ImportMap () const  | 
|   | Use ColMap() instead. 
  | 
|   | 
| 
int  | TransformToLocal () | 
|   | Use FillComplete() instead. 
  | 
|   | 
| 
int  | TransformToLocal (const Epetra_Map *DomainMap, const Epetra_Map *RangeMap) | 
|   | Use FillComplete(const Epetra_Map& DomainMap, const Epetra_Map& RangeMap) instead. 
  | 
|   | 
|   | Epetra_DistObject (const Epetra_BlockMap &Map) | 
|   | Basic Epetra_DistObject constuctor.  More...
  | 
|   | 
|   | Epetra_DistObject (const Epetra_BlockMap &Map, const char *const Label) | 
|   | 
| 
  | Epetra_DistObject (const Epetra_DistObject &Source) | 
|   | Epetra_DistObject copy constructor. 
  | 
|   | 
| 
virtual  | ~Epetra_DistObject () | 
|   | Epetra_DistObject destructor. 
  | 
|   | 
| int  | Import (const Epetra_SrcDistObject &A, const Epetra_Import &Importer, Epetra_CombineMode CombineMode, const Epetra_OffsetIndex *Indexor=0) | 
|   | Imports an Epetra_DistObject using the Epetra_Import object.  More...
  | 
|   | 
| int  | Import (const Epetra_SrcDistObject &A, const Epetra_Export &Exporter, Epetra_CombineMode CombineMode, const Epetra_OffsetIndex *Indexor=0) | 
|   | Imports an Epetra_DistObject using the Epetra_Export object.  More...
  | 
|   | 
| int  | Export (const Epetra_SrcDistObject &A, const Epetra_Import &Importer, Epetra_CombineMode CombineMode, const Epetra_OffsetIndex *Indexor=0) | 
|   | Exports an Epetra_DistObject using the Epetra_Import object.  More...
  | 
|   | 
| int  | Export (const Epetra_SrcDistObject &A, const Epetra_Export &Exporter, Epetra_CombineMode CombineMode, const Epetra_OffsetIndex *Indexor=0) | 
|   | Exports an Epetra_DistObject using the Epetra_Export object.  More...
  | 
|   | 
| 
const Epetra_BlockMap &  | Map () const  | 
|   | Returns the address of the Epetra_BlockMap for this multi-vector. 
  | 
|   | 
| 
const Epetra_Comm &  | Comm () const  | 
|   | Returns the address of the Epetra_Comm for this multi-vector. 
  | 
|   | 
| 
bool  | DistributedGlobal () const  | 
|   | Returns true if this multi-vector is distributed global, i.e., not local replicated. 
  | 
|   | 
|   | 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 int  | ReportError (const std::string Message, int ErrorCode) const  | 
|   | Error reporting method. 
  | 
|   | 
| virtual void  | SetLabel (const char *const Label) | 
|   | Epetra_Object Label definition using char *.  More...
  | 
|   | 
| 
virtual  | ~Epetra_SrcDistObject () | 
|   | Epetra_SrcDistObject destructor. 
  | 
|   | 
| 
Epetra_CompObject &  | operator= (const Epetra_CompObject &src) | 
|   | 
| 
  | Epetra_CompObject () | 
|   | Basic Epetra_CompObject constuctor. 
  | 
|   | 
| 
  | Epetra_CompObject (const Epetra_CompObject &Source) | 
|   | Epetra_CompObject copy constructor. 
  | 
|   | 
| 
virtual  | ~Epetra_CompObject () | 
|   | Epetra_CompObject destructor. 
  | 
|   | 
| 
void  | SetFlopCounter (const Epetra_Flops &FlopCounter_in) | 
|   | Set the internal Epetra_Flops() pointer. 
  | 
|   | 
| 
void  | SetFlopCounter (const Epetra_CompObject &CompObject) | 
|   | Set the internal Epetra_Flops() pointer to the flop counter of another Epetra_CompObject. 
  | 
|   | 
| 
void  | UnsetFlopCounter () | 
|   | Set the internal Epetra_Flops() pointer to 0 (no flops counted). 
  | 
|   | 
| 
Epetra_Flops *  | GetFlopCounter () const  | 
|   | Get the pointer to the Epetra_Flops() object associated with this object, returns 0 if none. 
  | 
|   | 
| 
void  | ResetFlops () const  | 
|   | Resets the number of floating point operations to zero for this multi-vector. 
  | 
|   | 
| 
double  | Flops () const  | 
|   | Returns the number of floating point operations with this multi-vector. 
  | 
|   | 
| 
void  | UpdateFlops (int Flops_in) const  | 
|   | Increment Flop count for this object. 
  | 
|   | 
| 
void  | UpdateFlops (long int Flops_in) const  | 
|   | Increment Flop count for this object. 
  | 
|   | 
| 
void  | UpdateFlops (long long Flops_in) const  | 
|   | Increment Flop count for this object. 
  | 
|   | 
| 
void  | UpdateFlops (double Flops_in) const  | 
|   | Increment Flop count for this object. 
  | 
|   | 
| 
void  | UpdateFlops (float Flops_in) const  | 
|   | Increment Flop count for this object. 
  | 
|   | 
|   | Epetra_BLAS (void) | 
|   | Epetra_BLAS Constructor.  More...
  | 
|   | 
|   | Epetra_BLAS (const Epetra_BLAS &BLAS) | 
|   | Epetra_BLAS Copy Constructor.  More...
  | 
|   | 
| 
virtual  | ~Epetra_BLAS (void) | 
|   | Epetra_BLAS Destructor. 
  | 
|   | 
| 
float  | ASUM (const int N, const float *X, const int INCX=1) const  | 
|   | Epetra_BLAS one norm function (SASUM). 
  | 
|   | 
| 
double  | ASUM (const int N, const double *X, const int INCX=1) const  | 
|   | Epetra_BLAS one norm function (DASUM). 
  | 
|   | 
| 
float  | DOT (const int N, const float *X, const float *Y, const int INCX=1, const int INCY=1) const  | 
|   | Epetra_BLAS dot product function (SDOT). 
  | 
|   | 
| 
double  | DOT (const int N, const double *X, const double *Y, const int INCX=1, const int INCY=1) const  | 
|   | Epetra_BLAS dot product function (DDOT). 
  | 
|   | 
| 
float  | NRM2 (const int N, const float *X, const int INCX=1) const  | 
|   | Epetra_BLAS norm function (SNRM2). 
  | 
|   | 
| 
double  | NRM2 (const int N, const double *X, const int INCX=1) const  | 
|   | Epetra_BLAS norm function (DNRM2). 
  | 
|   | 
| 
void  | SCAL (const int N, const float ALPHA, float *X, const int INCX=1) const  | 
|   | Epetra_BLAS vector scale function (SSCAL) 
  | 
|   | 
| 
void  | SCAL (const int N, const double ALPHA, double *X, const int INCX=1) const  | 
|   | Epetra_BLAS vector scale function (DSCAL) 
  | 
|   | 
| 
void  | COPY (const int N, const float *X, float *Y, const int INCX=1, const int INCY=1) const  | 
|   | Epetra_BLAS vector copy function (SCOPY) 
  | 
|   | 
| 
void  | COPY (const int N, const double *X, double *Y, const int INCX=1, const int INCY=1) const  | 
|   | Epetra_BLAS vector scale function (DCOPY) 
  | 
|   | 
| 
int  | IAMAX (const int N, const float *X, const int INCX=1) const  | 
|   | Epetra_BLAS arg maximum of absolute value function (ISAMAX) 
  | 
|   | 
| 
int  | IAMAX (const int N, const double *X, const int INCX=1) const  | 
|   | Epetra_BLAS arg maximum of absolute value function (IDAMAX) 
  | 
|   | 
| 
void  | AXPY (const int N, const float ALPHA, const float *X, float *Y, const int INCX=1, const int INCY=1) const  | 
|   | Epetra_BLAS vector update function (SAXPY) 
  | 
|   | 
| 
void  | AXPY (const int N, const double ALPHA, const double *X, double *Y, const int INCX=1, const int INCY=1) const  | 
|   | Epetra_BLAS vector update function (DAXPY) 
  | 
|   | 
| 
void  | GEMV (const char TRANS, const int M, const int N, const float ALPHA, const float *A, const int LDA, const float *X, const float BETA, float *Y, const int INCX=1, const int INCY=1) const  | 
|   | Epetra_BLAS matrix-vector multiply function (SGEMV) 
  | 
|   | 
| 
void  | GEMV (const char TRANS, const int M, const int N, const double ALPHA, const double *A, const int LDA, const double *X, const double BETA, double *Y, const int INCX=1, const int INCY=1) const  | 
|   | Epetra_BLAS matrix-vector multiply function (DGEMV) 
  | 
|   | 
| 
void  | GEMM (const char TRANSA, const char TRANSB, const int M, const int N, const int K, const float ALPHA, const float *A, const int LDA, const float *B, const int LDB, const float BETA, float *C, const int LDC) const  | 
|   | Epetra_BLAS matrix-matrix multiply function (SGEMM) 
  | 
|   | 
| 
void  | GEMM (const char TRANSA, const char TRANSB, const int M, const int N, const int K, const double ALPHA, const double *A, const int LDA, const double *B, const int LDB, const double BETA, double *C, const int LDC) const  | 
|   | Epetra_BLAS matrix-matrix multiply function (DGEMM) 
  | 
|   | 
| 
void  | SYMM (const char SIDE, const char UPLO, const int M, const int N, const float ALPHA, const float *A, const int LDA, const float *B, const int LDB, const float BETA, float *C, const int LDC) const  | 
|   | Epetra_BLAS symmetric matrix-matrix multiply function (SSYMM) 
  | 
|   | 
| 
void  | SYMM (const char SIDE, const char UPLO, const int M, const int N, const double ALPHA, const double *A, const int LDA, const double *B, const int LDB, const double BETA, double *C, const int LDC) const  | 
|   | Epetra_BLAS matrix-matrix multiply function (DSYMM) 
  | 
|   | 
| 
void  | TRMM (const char SIDE, const char UPLO, const char TRANSA, const char DIAG, const int M, const int N, const float ALPHA, const float *A, const int LDA, float *B, const int LDB) const  | 
|   | Epetra_BLAS triangular matrix-matrix multiply function (STRMM) 
  | 
|   | 
| 
void  | TRMM (const char SIDE, const char UPLO, const char TRANSA, const char DIAG, const int M, const int N, const double ALPHA, const double *A, const int LDA, double *B, const int LDB) const  | 
|   | Epetra_BLAS triangular matrix-matrix multiply function (DTRMM) 
  | 
|   | 
| 
void  | SYRK (const char UPLO, const char TRANS, const int N, const int K, const float ALPHA, const float *A, const int LDA, const float BETA, float *C, const int LDC) const  | 
|   | Eperta_BLAS symetric rank k funtion (ssyrk) 
  | 
|   | 
| 
void  | SYRK (const char UPLO, const char TRANS, const int N, const int K, const double ALPHA, const double *A, const int LDA, const double BETA, double *C, const int LDC) const  | 
|   | Eperta_BLAS symetric rank k funtion (dsyrk) 
  | 
|   | 
| 
virtual  | ~Epetra_RowMatrix () | 
|   | Destructor. 
  | 
|   | 
| 
virtual  | ~Epetra_Operator () | 
|   | Destructor. 
  | 
|   |