Epetra Package Browser (Single Doxygen Collection)
Development
|
Epetra Finite-Element CrsMatrix. More...
#include <Epetra_FECrsMatrix.h>
Public Types | |
enum | { ROW_MAJOR = 0, COLUMN_MAJOR = 3 } |
Public Member Functions | |
Epetra_FECrsMatrix (Epetra_DataAccess CV, const Epetra_Map &RowMap, int *NumEntriesPerRow, bool ignoreNonLocalEntries=false) | |
Constructor. More... | |
Epetra_FECrsMatrix (Epetra_DataAccess CV, const Epetra_Map &RowMap, int NumEntriesPerRow, bool ignoreNonLocalEntries=false) | |
Constructor. More... | |
Epetra_FECrsMatrix (Epetra_DataAccess CV, const Epetra_Map &RowMap, const Epetra_Map &ColMap, int *NumEntriesPerRow, bool ignoreNonLocalEntries=false) | |
Constructor. More... | |
Epetra_FECrsMatrix (Epetra_DataAccess CV, const Epetra_Map &RowMap, const Epetra_Map &ColMap, int NumEntriesPerRow, bool ignoreNonLocalEntries=false) | |
Constructor. More... | |
Epetra_FECrsMatrix (Epetra_DataAccess CV, const Epetra_CrsGraph &Graph, bool ignoreNonLocalEntries=false) | |
Constructor. More... | |
Epetra_FECrsMatrix (Epetra_DataAccess CV, const Epetra_FECrsGraph &Graph, bool ignoreNonLocalEntries=false) | |
Constructor. More... | |
Epetra_FECrsMatrix (const Epetra_FECrsMatrix &src) | |
Copy Constructor. More... | |
virtual | ~Epetra_FECrsMatrix () |
Destructor. More... | |
Epetra_FECrsMatrix & | operator= (const Epetra_FECrsMatrix &src) |
Assignment operator. More... | |
int | SumIntoGlobalValues (int GlobalRow, int NumEntries, const double *Values, const int *Indices) |
override base-class Epetra_CrsMatrix::SumIntoGlobalValues method More... | |
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) |
override base-class Epetra_CrsMatrix::InsertGlobalValues method More... | |
int | InsertGlobalValues (long long GlobalRow, int NumEntries, const double *Values, const long long *Indices) |
int | InsertGlobalValues (int GlobalRow, int NumEntries, double *Values, int *Indices) |
override base-class Epetra_CrsMatrix::InsertGlobalValues method More... | |
int | InsertGlobalValues (long long GlobalRow, int NumEntries, double *Values, long long *Indices) |
int | ReplaceGlobalValues (int GlobalRow, int NumEntries, const double *Values, const int *Indices) |
override base-class Epetra_CrsMatrix::ReplaceGlobalValues method More... | |
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) |
Sum a Fortran-style table (single-dimensional packed-list) of coefficients into the matrix, adding them to any coefficients that may already exist at the specified row/column locations. More... | |
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) |
Sum a Fortran-style table (single-dimensional packed-list) of coefficients into the matrix, adding them to any coefficients that may already exist at the specified row/column locations. More... | |
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) |
Sum C-style table (double-pointer, or list of lists) of coefficients into the matrix, adding them to any coefficients that may already exist at the specified row/column locations. More... | |
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) |
Sum C-style table (double-pointer, or list of lists) of coefficients into the matrix, adding them to any coefficients that may already exist at the specified row/column locations. More... | |
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) |
Insert a Fortran-style table (single-dimensional packed-list) of coefficients into the matrix. More... | |
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) |
Insert a Fortran-style table (single-dimensional packed-list) of coefficients into the matrix. More... | |
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) |
Insert a C-style table (double-pointer, or list of lists) of coefficients into the matrix. More... | |
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) |
Insert a C-style table (double-pointer, or list of lists) of coefficients into the matrix. More... | |
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) |
Copy a Fortran-style table (single-dimensional packed-list) of coefficients into the matrix, replacing any coefficients that may already exist at the specified row/column locations. More... | |
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) |
Copy Fortran-style table (single-dimensional packed-list) of coefficients into the matrix, replacing any coefficients that may already exist at the specified row/column locations. More... | |
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) |
Copy C-style table (double-pointer, or list of lists) of coefficients into the matrix, replacing any coefficients that may already exist at the specified row/column locations. More... | |
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) |
Copy C-style table (double-pointer, or list of lists) of coefficients into the matrix, replacing any coefficients that may already exist at the specified row/column locations. More... | |
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) |
Sum a square structurally-symmetric sub-matrix into the global matrix. More... | |
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) |
Sum a general sub-matrix into the global matrix. More... | |
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) |
Insert a square structurally-symmetric sub-matrix into the global matrix. More... | |
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) |
Insert a general sub-matrix into the global matrix. More... | |
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) |
Use a square structurally-symmetric sub-matrix to replace existing values in the global matrix. More... | |
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) |
Use a general sub-matrix to replace existing values. More... | |
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) |
Gather any overlapping/shared data into the non-overlapping partitioning defined by the Map that was passed to this matrix at construction time. More... | |
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) |
Gather any overlapping/shared data into the non-overlapping partitioning defined by the Map that was passed to this matrix at construction time. More... | |
void | setIgnoreNonLocalEntries (bool flag) |
Set whether or not non-local data values should be ignored. More... | |
Public Member Functions inherited from Epetra_CrsMatrix | |
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. More... | |
virtual | ~Epetra_CrsMatrix () |
Epetra_CrsMatrix Destructor. More... | |
Epetra_CrsMatrix & | operator= (const Epetra_CrsMatrix &src) |
Assignment operator. More... | |
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. More... | |
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. More... | |
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. More... | |
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. More... | |
bool | StorageOptimized () const |
If OptimizeStorage() has been called, this query returns true, otherwise it returns false. More... | |
bool | IndicesAreGlobal () const |
If matrix indices has not been transformed to local, this query returns true, otherwise it returns false. More... | |
bool | IndicesAreLocal () const |
If matrix indices has been transformed to local, this query returns true, otherwise it returns false. More... | |
bool | IndicesAreContiguous () const |
If matrix indices are packed into single array (done in OptimizeStorage()) return true, otherwise false. More... | |
bool | LowerTriangular () const |
If matrix is lower triangular in local index space, this query returns true, otherwise it returns false. More... | |
bool | UpperTriangular () const |
If matrix is upper triangular in local index space, this query returns true, otherwise it returns false. More... | |
bool | NoDiagonal () const |
If matrix has no diagonal entries in global index space, this query returns true, otherwise it returns false. More... | |
double | NormInf () const |
Returns the infinity norm of the global matrix. More... | |
double | NormOne () const |
Returns the one norm of the global matrix. More... | |
double | NormFrobenius () const |
Returns the frobenius norm of the global matrix. More... | |
int | NumGlobalNonzeros () const |
Returns the number of nonzero entries in the global matrix. More... | |
long long | NumGlobalNonzeros64 () const |
int | NumGlobalRows () const |
Returns the number of global matrix rows. More... | |
long long | NumGlobalRows64 () const |
int | NumGlobalCols () const |
Returns the number of global matrix columns. More... | |
long long | NumGlobalCols64 () const |
int | NumGlobalDiagonals () const |
Returns the number of global nonzero diagonal entries, based on global row/column index comparisons. More... | |
long long | NumGlobalDiagonals64 () const |
int | NumMyNonzeros () const |
Returns the number of nonzero entries in the calling processor's portion of the matrix. More... | |
int | NumMyRows () const |
Returns the number of matrix rows owned by the calling processor. More... | |
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. More... | |
int | NumAllocatedGlobalEntries (int Row) const |
Returns the allocated number of nonzero entries in specified global row on this processor. More... | |
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. More... | |
int | NumAllocatedMyEntries (int Row) const |
Returns the allocated number of nonzero entries in specified local row on this processor. More... | |
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. More... | |
const Epetra_CrsGraph & | Graph () const |
Returns a reference to the Epetra_CrsGraph object associated with this matrix. More... | |
const Epetra_Map & | RowMap () const |
Returns the Epetra_Map object associated with the rows of this matrix. More... | |
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. More... | |
const Epetra_Export * | Exporter () const |
Returns the Epetra_Export object that contains the export operations for distributed operations. More... | |
const Epetra_Comm & | Comm () const |
Returns a pointer to the Epetra_Comm communicator associated with this matrix. More... | |
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. More... | |
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. More... | |
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. More... | |
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. More... | |
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. More... | |
bool | MyGlobalRow (long long GID) const |
virtual void | Print (std::ostream &os) const |
Print method. More... | |
const char * | Label () const |
Returns a character string describing the operator. More... | |
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. More... | |
bool | UseTranspose () const |
Returns the current UseTranspose setting. More... | |
const Epetra_Map & | OperatorDomainMap () const |
Returns the Epetra_Map object associated with the domain of this matrix operator. More... | |
const Epetra_Map & | OperatorRangeMap () const |
Returns the Epetra_Map object associated with the range of this matrix operator. More... | |
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. More... | |
const Epetra_Map & | RowMatrixRowMap () const |
Returns the Epetra_Map object associated with the rows of this matrix. More... | |
const Epetra_Map & | RowMatrixColMap () const |
Returns the Epetra_Map object associated with columns of this matrix. More... | |
const Epetra_Import * | RowMatrixImporter () const |
Returns the Epetra_Import object that contains the import operations for distributed operations. More... | |
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. More... | |
int | TransformToLocal () |
Use FillComplete() instead. More... | |
int | TransformToLocal (const Epetra_Map *DomainMap, const Epetra_Map *RangeMap) |
Use FillComplete(const Epetra_Map& DomainMap, const Epetra_Map& RangeMap) instead. More... | |
Public Member Functions inherited from Epetra_DistObject | |
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. More... | |
virtual | ~Epetra_DistObject () |
Epetra_DistObject destructor. More... | |
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. More... | |
const Epetra_Comm & | Comm () const |
Returns the address of the Epetra_Comm for this multi-vector. More... | |
bool | DistributedGlobal () const |
Returns true if this multi-vector is distributed global, i.e., not local replicated. More... | |
Public Member Functions inherited from Epetra_Object | |
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... | |
Public Member Functions inherited from Epetra_SrcDistObject | |
virtual | ~Epetra_SrcDistObject () |
Epetra_SrcDistObject destructor. More... | |
Public Member Functions inherited from Epetra_CompObject | |
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... | |
Public Member Functions inherited from Epetra_BLAS | |
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. More... | |
float | ASUM (const int N, const float *X, const int INCX=1) const |
Epetra_BLAS one norm function (SASUM). More... | |
double | ASUM (const int N, const double *X, const int INCX=1) const |
Epetra_BLAS one norm function (DASUM). More... | |
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). More... | |
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). More... | |
float | NRM2 (const int N, const float *X, const int INCX=1) const |
Epetra_BLAS norm function (SNRM2). More... | |
double | NRM2 (const int N, const double *X, const int INCX=1) const |
Epetra_BLAS norm function (DNRM2). More... | |
void | SCAL (const int N, const float ALPHA, float *X, const int INCX=1) const |
Epetra_BLAS vector scale function (SSCAL) More... | |
void | SCAL (const int N, const double ALPHA, double *X, const int INCX=1) const |
Epetra_BLAS vector scale function (DSCAL) More... | |
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) More... | |
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) More... | |
int | IAMAX (const int N, const float *X, const int INCX=1) const |
Epetra_BLAS arg maximum of absolute value function (ISAMAX) More... | |
int | IAMAX (const int N, const double *X, const int INCX=1) const |
Epetra_BLAS arg maximum of absolute value function (IDAMAX) More... | |
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) More... | |
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) More... | |
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) More... | |
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) More... | |
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) More... | |
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) More... | |
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) More... | |
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) More... | |
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) More... | |
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) More... | |
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) More... | |
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) More... | |
Public Member Functions inherited from Epetra_RowMatrix | |
virtual | ~Epetra_RowMatrix () |
Destructor. More... | |
Public Member Functions inherited from Epetra_Operator | |
virtual | ~Epetra_Operator () |
Destructor. More... | |
Private Types | |
enum | { SUMINTO = 0, REPLACE = 1, INSERT = 2 } |
Private Member Functions | |
void | DeleteMemory () |
template<typename int_type > | |
int | InputGlobalValues (int numRows, const int_type *rows, int numCols, const int_type *cols, const double *const *values, int format, int mode) |
template<typename int_type > | |
int | InputGlobalValues (int numRows, const int_type *rows, int numCols, const int_type *cols, const double *values, int format, int mode) |
template<typename int_type > | |
int | InputNonlocalGlobalValues (int_type row, int numCols, const int_type *cols, const double *values, int mode) |
template<typename int_type > | |
int | InputGlobalValues_RowMajor (int numRows, const int_type *rows, int numCols, const int_type *cols, const double *values, int mode) |
template<typename int_type > | |
int | InsertNonlocalRow (int_type row, typename std::vector< int_type >::iterator offset) |
template<typename int_type > | |
int | InputNonlocalValue (int rowoffset, int_type col, double value, int mode) |
template<typename int_type > | |
std::vector< int_type > & | nonlocalRows () |
template<typename int_type > | |
std::vector< std::vector < int_type > > & | nonlocalCols () |
template<typename int_type > | |
int | SumIntoGlobalValues (int_type GlobalRow, int NumEntries, const double *values, const int_type *Indices) |
template<typename int_type > | |
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) |
template<> | |
std::vector< int > & | nonlocalRows () |
template<> | |
std::vector< long long > & | nonlocalRows () |
template<> | |
std::vector< std::vector< int > > & | nonlocalCols () |
template<> | |
std::vector< std::vector< long long > > & | nonlocalCols () |
Private Attributes | |
long long | myFirstRow_ |
int | myNumRows_ |
bool | ignoreNonLocalEntries_ |
std::vector< int > | nonlocalRows_int_ |
std::vector< std::vector< int > > | nonlocalCols_int_ |
std::vector< long long > | nonlocalRows_LL_ |
std::vector< std::vector< long long > > | nonlocalCols_LL_ |
std::vector< std::vector < double > > | nonlocalCoefs_ |
std::vector< double > | workData_ |
std::vector< const double * > | workData2d_ |
int | workDataLength_ |
bool | useNonlocalMatrix_ |
Epetra_CrsMatrix * | nonlocalMatrix_ |
Epetra_Map * | sourceMap_ |
Epetra_Map * | colMap_ |
Epetra_Export * | exporter_ |
Epetra_CrsMatrix * | tempMat_ |
Additional Inherited Members | |
Static Public Member Functions inherited from Epetra_Object | |
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 Public Attributes inherited from Epetra_Object | |
static int | TracebackMode |
Protected Member Functions inherited from Epetra_CrsMatrix | |
bool | Allocated () const |
int | SetAllocated (bool Flag) |
double ** | Values () const |
double * | All_Values () const |
double * | Values (int LocalRow) const |
void | InitializeDefaults () |
int | Allocate () |
int | InsertValues (int LocalRow, int NumEntries, double *Values, int *Indices) |
int | InsertValues (int LocalRow, int NumEntries, const double *Values, const int *Indices) |
int | InsertValues (int LocalRow, int NumEntries, double *Values, long long *Indices) |
int | InsertValues (int LocalRow, int NumEntries, const double *Values, const long long *Indices) |
int | InsertOffsetValues (long long GlobalRow, int NumEntries, double *Values, int *Indices) |
int | InsertOffsetValues (long long GlobalRow, int NumEntries, const double *Values, const int *Indices) |
int | ReplaceOffsetValues (long long GlobalRow, int NumEntries, const double *Values, const int *Indices) |
int | SumIntoOffsetValues (long long GlobalRow, int NumEntries, const double *Values, const int *Indices) |
void | UpdateImportVector (int NumVectors) const |
void | UpdateExportVector (int NumVectors) const |
void | GeneralMV (double *x, double *y) const |
void | GeneralMTV (double *x, double *y) const |
void | GeneralMM (double **X, int LDX, double **Y, int LDY, int NumVectors) const |
void | GeneralMTM (double **X, int LDX, double **Y, int LDY, int NumVectors) const |
void | GeneralSV (bool Upper, bool Trans, bool UnitDiagonal, double *x, double *y) const |
void | GeneralSM (bool Upper, bool Trans, bool UnitDiagonal, double **X, int LDX, double **Y, int LDY, int NumVectors) const |
void | SetStaticGraph (bool Flag) |
int | CheckSizes (const Epetra_SrcDistObject &A) |
Allows the source and target (this) objects to be compared for compatibility, return nonzero if not. More... | |
int | CopyAndPermute (const Epetra_SrcDistObject &Source, int NumSameIDs, int NumPermuteIDs, int *PermuteToLIDs, int *PermuteFromLIDs, const Epetra_OffsetIndex *Indexor, Epetra_CombineMode CombineMode=Zero) |
Perform ID copies and permutations that are on processor. More... | |
int | CopyAndPermuteCrsMatrix (const Epetra_CrsMatrix &A, int NumSameIDs, int NumPermuteIDs, int *PermuteToLIDs, int *PermuteFromLIDs, const Epetra_OffsetIndex *Indexor, Epetra_CombineMode CombineMode) |
int | CopyAndPermuteRowMatrix (const Epetra_RowMatrix &A, int NumSameIDs, int NumPermuteIDs, int *PermuteToLIDs, int *PermuteFromLIDs, const Epetra_OffsetIndex *Indexor, Epetra_CombineMode CombineMode) |
int | PackAndPrepare (const Epetra_SrcDistObject &Source, int NumExportIDs, int *ExportLIDs, int &LenExports, char *&Exports, int &SizeOfPacket, int *Sizes, bool &VarSizes, Epetra_Distributor &Distor) |
Perform any packing or preparation required for call to DoTransfer(). More... | |
int | UnpackAndCombine (const Epetra_SrcDistObject &Source, int NumImportIDs, int *ImportLIDs, int LenImports, char *Imports, int &SizeOfPacket, Epetra_Distributor &Distor, Epetra_CombineMode CombineMode, const Epetra_OffsetIndex *Indexor) |
Perform any unpacking and combining after call to DoTransfer(). More... | |
int | SortEntries () |
Sort column entries, row-by-row, in ascending order. More... | |
bool | Sorted () const |
If SortEntries() has been called, this query returns true, otherwise it returns false. More... | |
int | MergeRedundantEntries () |
Add entries that have the same column index. Remove redundant entries from list. More... | |
bool | NoRedundancies () const |
If MergeRedundantEntries() has been called, this query returns true, otherwise it returns false. More... | |
void | DeleteMemory () |
Protected Member Functions inherited from Epetra_DistObject | |
virtual int | DoTransfer (const Epetra_SrcDistObject &A, Epetra_CombineMode CombineMode, int NumSameIDs, int NumPermuteIDs, int NumRemoteIDs, int NumExportIDs, int *PermuteToLIDs, int *PermuteFromLIDs, int *RemoteLIDs, int *ExportLIDs, int &LenExports, char *&Exports, int &LenImports, char *&Imports, Epetra_Distributor &Distor, bool DoReverse, const Epetra_OffsetIndex *Indexor) |
Perform actual transfer (redistribution) of data across memory images, using Epetra_Distributor object. More... | |
Protected Member Functions inherited from Epetra_Object | |
std::string | toString (const int &x) const |
std::string | toString (const long long &x) const |
std::string | toString (const double &x) const |
Protected Attributes inherited from Epetra_CrsMatrix | |
Epetra_CrsGraph | Graph_ |
bool | Allocated_ |
bool | StaticGraph_ |
bool | UseTranspose_ |
bool | constructedWithFilledGraph_ |
bool | matrixFillCompleteCalled_ |
bool | StorageOptimized_ |
double ** | Values_ |
int * | Values_alloc_lengths_ |
double * | All_Values_ |
double | NormInf_ |
double | NormOne_ |
double | NormFrob_ |
int | NumMyRows_ |
Epetra_MultiVector * | ImportVector_ |
Epetra_MultiVector * | ExportVector_ |
Epetra_DataAccess | CV_ |
bool | squareFillCompleteCalled_ |
Protected Attributes inherited from Epetra_DistObject | |
Epetra_BlockMap | Map_ |
const Epetra_Comm * | Comm_ |
char * | Exports_ |
char * | Imports_ |
int | LenExports_ |
int | LenImports_ |
int * | Sizes_ |
Protected Attributes inherited from Epetra_CompObject | |
Epetra_Flops * | FlopCounter_ |
Epetra Finite-Element CrsMatrix.
This class provides the ability to input finite-element style sub-matrix data, including sub-matrices with non-local rows (which could correspond to shared finite-element nodes for example). This class inherits Epetra_CrsMatrix, and so all Epetra_CrsMatrix functionality is also available.
It is intended that this class will be used as follows:
Sub-matrix data, which is assumed to be a rectangular 'table' of coefficients accompanied by 'scatter-indices', can be provided in three forms:
In all cases, a "format" parameter specifies whether the data is laid out in row-major or column-major order (i.e., whether coefficients for a row lie contiguously or whether coefficients for a column lie contiguously). See the documentation for the methods SumIntoGlobalValues() and ReplaceGlobalValues().
Important notes:
Definition at line 120 of file Epetra_FECrsMatrix.h.
anonymous enum |
Enumerator | |
---|---|
ROW_MAJOR | |
COLUMN_MAJOR |
Definition at line 167 of file Epetra_FECrsMatrix.h.
|
private |
Enumerator | |
---|---|
SUMINTO | |
REPLACE | |
INSERT |
Definition at line 747 of file Epetra_FECrsMatrix.h.
Epetra_FECrsMatrix::Epetra_FECrsMatrix | ( | Epetra_DataAccess | CV, |
const Epetra_Map & | RowMap, | ||
int * | NumEntriesPerRow, | ||
bool | ignoreNonLocalEntries = false |
||
) |
Constructor.
Definition at line 54 of file Epetra_FECrsMatrix.cpp.
Epetra_FECrsMatrix::Epetra_FECrsMatrix | ( | Epetra_DataAccess | CV, |
const Epetra_Map & | RowMap, | ||
int | NumEntriesPerRow, | ||
bool | ignoreNonLocalEntries = false |
||
) |
Constructor.
Definition at line 84 of file Epetra_FECrsMatrix.cpp.
Epetra_FECrsMatrix::Epetra_FECrsMatrix | ( | Epetra_DataAccess | CV, |
const Epetra_Map & | RowMap, | ||
const Epetra_Map & | ColMap, | ||
int * | NumEntriesPerRow, | ||
bool | ignoreNonLocalEntries = false |
||
) |
Constructor.
Definition at line 114 of file Epetra_FECrsMatrix.cpp.
Epetra_FECrsMatrix::Epetra_FECrsMatrix | ( | Epetra_DataAccess | CV, |
const Epetra_Map & | RowMap, | ||
const Epetra_Map & | ColMap, | ||
int | NumEntriesPerRow, | ||
bool | ignoreNonLocalEntries = false |
||
) |
Constructor.
Definition at line 145 of file Epetra_FECrsMatrix.cpp.
Epetra_FECrsMatrix::Epetra_FECrsMatrix | ( | Epetra_DataAccess | CV, |
const Epetra_CrsGraph & | Graph, | ||
bool | ignoreNonLocalEntries = false |
||
) |
Constructor.
Definition at line 176 of file Epetra_FECrsMatrix.cpp.
Epetra_FECrsMatrix::Epetra_FECrsMatrix | ( | Epetra_DataAccess | CV, |
const Epetra_FECrsGraph & | Graph, | ||
bool | ignoreNonLocalEntries = false |
||
) |
Constructor.
Definition at line 205 of file Epetra_FECrsMatrix.cpp.
Epetra_FECrsMatrix::Epetra_FECrsMatrix | ( | const Epetra_FECrsMatrix & | src | ) |
Copy Constructor.
Definition at line 235 of file Epetra_FECrsMatrix.cpp.
|
virtual |
Destructor.
Definition at line 313 of file Epetra_FECrsMatrix.cpp.
Epetra_FECrsMatrix & Epetra_FECrsMatrix::operator= | ( | const Epetra_FECrsMatrix & | src | ) |
Assignment operator.
Definition at line 260 of file Epetra_FECrsMatrix.cpp.
|
virtual |
override base-class Epetra_CrsMatrix::SumIntoGlobalValues method
Reimplemented from Epetra_CrsMatrix.
Definition at line 724 of file Epetra_FECrsMatrix.cpp.
|
virtual |
Reimplemented from Epetra_CrsMatrix.
Definition at line 736 of file Epetra_FECrsMatrix.cpp.
|
virtual |
override base-class Epetra_CrsMatrix::InsertGlobalValues method
Reimplemented from Epetra_CrsMatrix.
Definition at line 747 of file Epetra_FECrsMatrix.cpp.
|
virtual |
Reimplemented from Epetra_CrsMatrix.
Definition at line 757 of file Epetra_FECrsMatrix.cpp.
|
virtual |
override base-class Epetra_CrsMatrix::InsertGlobalValues method
Reimplemented from Epetra_CrsMatrix.
Definition at line 767 of file Epetra_FECrsMatrix.cpp.
|
virtual |
Reimplemented from Epetra_CrsMatrix.
Definition at line 776 of file Epetra_FECrsMatrix.cpp.
|
virtual |
override base-class Epetra_CrsMatrix::ReplaceGlobalValues method
Reimplemented from Epetra_CrsMatrix.
Definition at line 786 of file Epetra_FECrsMatrix.cpp.
|
virtual |
Reimplemented from Epetra_CrsMatrix.
Definition at line 795 of file Epetra_FECrsMatrix.cpp.
int Epetra_FECrsMatrix::SumIntoGlobalValues | ( | int | numIndices, |
const int * | indices, | ||
const double * | values, | ||
int | format = Epetra_FECrsMatrix::COLUMN_MAJOR |
||
) |
Sum a Fortran-style table (single-dimensional packed-list) of coefficients into the matrix, adding them to any coefficients that may already exist at the specified row/column locations.
numIndices | Number of rows (and columns) in the sub-matrix. |
indices | List of scatter-indices (rows and columns) for the sub-matrix. |
values | List, length numIndices*numIndices. Square sub-matrix of coefficients, packed in a 1-D array. Data is packed either contiguously by row or by column, specified by the final parameter 'format'. |
format | Specifies whether the data in 'values' is packed in column-major or row-major order. Valid values are Epetra_FECrsMatrix::ROW_MAJOR or Epetra_FECrsMatrix::COLUMN_MAJOR. This is an optional parameter, default value is COLUMN_MAJOR. |
Definition at line 397 of file Epetra_FECrsMatrix.cpp.
int Epetra_FECrsMatrix::SumIntoGlobalValues | ( | int | numIndices, |
const long long * | indices, | ||
const double * | values, | ||
int | format = Epetra_FECrsMatrix::COLUMN_MAJOR |
||
) |
Definition at line 407 of file Epetra_FECrsMatrix.cpp.
int Epetra_FECrsMatrix::SumIntoGlobalValues | ( | int | numRows, |
const int * | rows, | ||
int | numCols, | ||
const int * | cols, | ||
const double * | values, | ||
int | format = Epetra_FECrsMatrix::COLUMN_MAJOR |
||
) |
Sum a Fortran-style table (single-dimensional packed-list) of coefficients into the matrix, adding them to any coefficients that may already exist at the specified row/column locations.
numRows | Number of rows in the sub-matrix. |
rows | List of row-numbers (scatter-indices) for the sub-matrix. |
numCols | Number of columns in the sub-matrix. |
cols | List of column-numbers (scatter-indices) for the sub-matrix. |
values | List, length numRows*numCols. Rectangular sub-matrix of coefficients, packed in a 1-D array. Data is packed either contiguously by row or by column, specified by the final parameter 'format'. |
format | Specifies whether the data in 'values' is packed in column-major or row-major order. Valid values are Epetra_FECrsMatrix::ROW_MAJOR or Epetra_FECrsMatrix::COLUMN_MAJOR. This is an optional parameter, default value is COLUMN_MAJOR. |
Definition at line 418 of file Epetra_FECrsMatrix.cpp.
int Epetra_FECrsMatrix::SumIntoGlobalValues | ( | int | numRows, |
const long long * | rows, | ||
int | numCols, | ||
const long long * | cols, | ||
const double * | values, | ||
int | format = Epetra_FECrsMatrix::COLUMN_MAJOR |
||
) |
Definition at line 430 of file Epetra_FECrsMatrix.cpp.
int Epetra_FECrsMatrix::SumIntoGlobalValues | ( | int | numIndices, |
const int * | indices, | ||
const double *const * | values, | ||
int | format = Epetra_FECrsMatrix::ROW_MAJOR |
||
) |
Sum C-style table (double-pointer, or list of lists) of coefficients into the matrix, adding them to any coefficients that may already exist at the specified row/column locations.
numIndices | Number of rows (and columns) in the sub-matrix. |
indices | List of scatter-indices (rows and columns) for the sub-matrix. |
values | Square sub-matrix of coefficients, provided in a 2-D array, or double-pointer. |
format | Specifies whether the data in 'values' is packed in column-major or row-major order. Valid values are Epetra_FECrsMatrix::ROW_MAJOR or Epetra_FECrsMatrix::COLUMN_MAJOR. This is an optional parameter, default value is ROW_MAJOR. |
Definition at line 353 of file Epetra_FECrsMatrix.cpp.
int Epetra_FECrsMatrix::SumIntoGlobalValues | ( | int | numIndices, |
const long long * | indices, | ||
const double *const * | values, | ||
int | format = Epetra_FECrsMatrix::ROW_MAJOR |
||
) |
Definition at line 363 of file Epetra_FECrsMatrix.cpp.
int Epetra_FECrsMatrix::SumIntoGlobalValues | ( | int | numRows, |
const int * | rows, | ||
int | numCols, | ||
const int * | cols, | ||
const double *const * | values, | ||
int | format = Epetra_FECrsMatrix::ROW_MAJOR |
||
) |
Sum C-style table (double-pointer, or list of lists) of coefficients into the matrix, adding them to any coefficients that may already exist at the specified row/column locations.
numRows | Number of rows in the sub-matrix. |
rows | List of row-numbers (scatter-indices) for the sub-matrix. |
numCols | Number of columns in the sub-matrix. |
cols | List of column-numbers (scatter-indices) for the sub-matrix. |
values | Rectangular sub-matrix of coefficients, provided in a 2-D array, or double-pointer. |
format | Specifies whether the data in 'values' is packed in column-major or row-major order. Valid values are Epetra_FECrsMatrix::ROW_MAJOR or Epetra_FECrsMatrix::COLUMN_MAJOR. This is an optional parameter, default value is ROW_MAJOR. |
Definition at line 374 of file Epetra_FECrsMatrix.cpp.
int Epetra_FECrsMatrix::SumIntoGlobalValues | ( | int | numRows, |
const long long * | rows, | ||
int | numCols, | ||
const long long * | cols, | ||
const double *const * | values, | ||
int | format = Epetra_FECrsMatrix::ROW_MAJOR |
||
) |
Definition at line 385 of file Epetra_FECrsMatrix.cpp.
int Epetra_FECrsMatrix::InsertGlobalValues | ( | int | numIndices, |
const int * | indices, | ||
const double * | values, | ||
int | format = Epetra_FECrsMatrix::COLUMN_MAJOR |
||
) |
Insert a Fortran-style table (single-dimensional packed-list) of coefficients into the matrix.
numIndices | Number of rows (and columns) in the sub-matrix. |
indices | List of scatter-indices (rows and columns) for the sub-matrix. |
values | List, length numIndices*numIndices. Square sub-matrix of coefficients, packed in a 1-D array. Data is packed either contiguously by row or by column, specified by the final parameter 'format'. |
format | Specifies whether the data in 'values' is packed in column-major or row-major order. Valid values are Epetra_FECrsMatrix::ROW_MAJOR or Epetra_FECrsMatrix::COLUMN_MAJOR. This is an optional parameter, default value is COLUMN_MAJOR. |
Definition at line 664 of file Epetra_FECrsMatrix.cpp.
int Epetra_FECrsMatrix::InsertGlobalValues | ( | int | numIndices, |
const long long * | indices, | ||
const double * | values, | ||
int | format = Epetra_FECrsMatrix::COLUMN_MAJOR |
||
) |
Definition at line 675 of file Epetra_FECrsMatrix.cpp.
int Epetra_FECrsMatrix::InsertGlobalValues | ( | int | numRows, |
const int * | rows, | ||
int | numCols, | ||
const int * | cols, | ||
const double * | values, | ||
int | format = Epetra_FECrsMatrix::COLUMN_MAJOR |
||
) |
Insert a Fortran-style table (single-dimensional packed-list) of coefficients into the matrix.
numRows | Number of rows in the sub-matrix. |
rows | List of row-numbers (scatter-indices) for the sub-matrix. |
numCols | Number of columns in the sub-matrix. |
cols | List of column-numbers (scatter-indices) for the sub-matrix. |
values | List, length numRows*numCols. Rectangular sub-matrix of coefficients, packed in a 1-D array. Data is packed either contiguously by row or by column, specified by the final parameter 'format'. |
format | Specifies whether the data in 'values' is packed in column-major or row-major order. Valid values are Epetra_FECrsMatrix::ROW_MAJOR or Epetra_FECrsMatrix::COLUMN_MAJOR. This is an optional parameter, default value is COLUMN_MAJOR. |
Definition at line 686 of file Epetra_FECrsMatrix.cpp.
int Epetra_FECrsMatrix::InsertGlobalValues | ( | int | numRows, |
const long long * | rows, | ||
int | numCols, | ||
const long long * | cols, | ||
const double * | values, | ||
int | format = Epetra_FECrsMatrix::COLUMN_MAJOR |
||
) |
Definition at line 698 of file Epetra_FECrsMatrix.cpp.
int Epetra_FECrsMatrix::InsertGlobalValues | ( | int | numIndices, |
const int * | indices, | ||
const double *const * | values, | ||
int | format = Epetra_FECrsMatrix::ROW_MAJOR |
||
) |
Insert a C-style table (double-pointer, or list of lists) of coefficients into the matrix.
numIndices | Number of rows (and columns) in the sub-matrix. |
indices | List of scatter-indices (rows and columns) for the sub-matrix. |
values | Square sub-matrix of coefficients, provided in a 2-D array, or double-pointer. |
format | Specifies whether the data in 'values' is packed in column-major or row-major order. Valid values are Epetra_FECrsMatrix::ROW_MAJOR or Epetra_FECrsMatrix::COLUMN_MAJOR. This is an optional parameter, default value is ROW_MAJOR. |
Definition at line 618 of file Epetra_FECrsMatrix.cpp.
int Epetra_FECrsMatrix::InsertGlobalValues | ( | int | numIndices, |
const long long * | indices, | ||
const double *const * | values, | ||
int | format = Epetra_FECrsMatrix::ROW_MAJOR |
||
) |
Definition at line 629 of file Epetra_FECrsMatrix.cpp.
int Epetra_FECrsMatrix::InsertGlobalValues | ( | int | numRows, |
const int * | rows, | ||
int | numCols, | ||
const int * | cols, | ||
const double *const * | values, | ||
int | format = Epetra_FECrsMatrix::ROW_MAJOR |
||
) |
Insert a C-style table (double-pointer, or list of lists) of coefficients into the matrix.
numRows | Number of rows in the sub-matrix. |
rows | List of row-numbers (scatter-indices) for the sub-matrix. |
numCols | Number of columns in the sub-matrix. |
cols | List of column-numbers (scatter-indices) for the sub-matrix. |
values | Rectangular sub-matrix of coefficients, provided in a 2-D array, or double-pointer. |
format | Specifies whether the data in 'values' is packed in column-major or row-major order. Valid values are Epetra_FECrsMatrix::ROW_MAJOR or Epetra_FECrsMatrix::COLUMN_MAJOR. This is an optional parameter, default value is ROW_MAJOR. |
Definition at line 640 of file Epetra_FECrsMatrix.cpp.
int Epetra_FECrsMatrix::InsertGlobalValues | ( | int | numRows, |
const long long * | rows, | ||
int | numCols, | ||
const long long * | cols, | ||
const double *const * | values, | ||
int | format = Epetra_FECrsMatrix::ROW_MAJOR |
||
) |
Definition at line 652 of file Epetra_FECrsMatrix.cpp.
int Epetra_FECrsMatrix::ReplaceGlobalValues | ( | int | numIndices, |
const int * | indices, | ||
const double * | values, | ||
int | format = Epetra_FECrsMatrix::COLUMN_MAJOR |
||
) |
Copy a Fortran-style table (single-dimensional packed-list) of coefficients into the matrix, replacing any coefficients that may already exist at the specified row/column locations.
numIndices | Number of rows (and columns) in the sub-matrix. |
indices | List of scatter-indices (rows and columns) for the sub-matrix. |
values | List, length numIndices*numIndices. Square sub-matrix of coefficients, packed in a 1-D array. Data is packed either contiguously by row or by column, specified by the final parameter 'format'. |
format | Specifies whether the data in 'values' is packed in column-major or row-major order. Valid values are Epetra_FECrsMatrix::ROW_MAJOR or Epetra_FECrsMatrix::COLUMN_MAJOR. This is an optional parameter, default value is COLUMN_MAJOR. |
Definition at line 849 of file Epetra_FECrsMatrix.cpp.
int Epetra_FECrsMatrix::ReplaceGlobalValues | ( | int | numIndices, |
const long long * | indices, | ||
const double * | values, | ||
int | format = Epetra_FECrsMatrix::COLUMN_MAJOR |
||
) |
Definition at line 859 of file Epetra_FECrsMatrix.cpp.
int Epetra_FECrsMatrix::ReplaceGlobalValues | ( | int | numRows, |
const int * | rows, | ||
int | numCols, | ||
const int * | cols, | ||
const double * | values, | ||
int | format = Epetra_FECrsMatrix::COLUMN_MAJOR |
||
) |
Copy Fortran-style table (single-dimensional packed-list) of coefficients into the matrix, replacing any coefficients that may already exist at the specified row/column locations.
numRows | Number of rows in the sub-matrix. |
rows | List of row-numbers (scatter-indices) for the sub-matrix. |
numCols | Number of columns in the sub-matrix. |
cols | List, of column-numbers (scatter-indices) for the sub-matrix. |
values | List, length numRows*numCols. Rectangular sub-matrix of coefficients, packed in a 1-D array. Data is packed either contiguously by row or by column, specified by the final parameter 'format'. |
format | Specifies whether the data in 'values' is packed in column-major or row-major order. Valid values are Epetra_FECrsMatrix::ROW_MAJOR or Epetra_FECrsMatrix::COLUMN_MAJOR. This is an optional parameter, default value is COLUMN_MAJOR. |
Definition at line 870 of file Epetra_FECrsMatrix.cpp.
int Epetra_FECrsMatrix::ReplaceGlobalValues | ( | int | numRows, |
const long long * | rows, | ||
int | numCols, | ||
const long long * | cols, | ||
const double * | values, | ||
int | format = Epetra_FECrsMatrix::COLUMN_MAJOR |
||
) |
Definition at line 881 of file Epetra_FECrsMatrix.cpp.
int Epetra_FECrsMatrix::ReplaceGlobalValues | ( | int | numIndices, |
const int * | indices, | ||
const double *const * | values, | ||
int | format = Epetra_FECrsMatrix::ROW_MAJOR |
||
) |
Copy C-style table (double-pointer, or list of lists) of coefficients into the matrix, replacing any coefficients that may already exist at the specified row/column locations.
numIndices | Number of rows (and columns) in the sub-matrix. |
indices | List of scatter-indices (rows and columns) for the sub-matrix. |
values | Square sub-matrix of coefficients, provided in a 2-D array, or double-pointer. |
format | Specifies whether the data in 'values' is packed in column-major or row-major order. Valid values are Epetra_FECrsMatrix::ROW_MAJOR or Epetra_FECrsMatrix::COLUMN_MAJOR. This is an optional parameter, default value is ROW_MAJOR. |
Definition at line 805 of file Epetra_FECrsMatrix.cpp.
int Epetra_FECrsMatrix::ReplaceGlobalValues | ( | int | numIndices, |
const long long * | indices, | ||
const double *const * | values, | ||
int | format = Epetra_FECrsMatrix::ROW_MAJOR |
||
) |
Definition at line 815 of file Epetra_FECrsMatrix.cpp.
int Epetra_FECrsMatrix::ReplaceGlobalValues | ( | int | numRows, |
const int * | rows, | ||
int | numCols, | ||
const int * | cols, | ||
const double *const * | values, | ||
int | format = Epetra_FECrsMatrix::ROW_MAJOR |
||
) |
Copy C-style table (double-pointer, or list of lists) of coefficients into the matrix, replacing any coefficients that may already exist at the specified row/column locations.
numRows | Number of rows in the sub-matrix. |
rows | List of row-numbers (scatter-indices) for the sub-matrix. |
numCols | Number of columns in the sub-matrix. |
cols | List of column-numbers (scatter-indices) for the sub-matrix. |
values | Rectangular sub-matrix of coefficients, provided in a 2-D array, or double-pointer. |
format | Specifies whether the data in 'values' is packed in column-major or row-major order. Valid values are Epetra_FECrsMatrix::ROW_MAJOR or Epetra_FECrsMatrix::COLUMN_MAJOR. This is an optional parameter, default value is ROW_MAJOR. |
Definition at line 826 of file Epetra_FECrsMatrix.cpp.
int Epetra_FECrsMatrix::ReplaceGlobalValues | ( | int | numRows, |
const long long * | rows, | ||
int | numCols, | ||
const long long * | cols, | ||
const double *const * | values, | ||
int | format = Epetra_FECrsMatrix::ROW_MAJOR |
||
) |
Definition at line 837 of file Epetra_FECrsMatrix.cpp.
int Epetra_FECrsMatrix::SumIntoGlobalValues | ( | const Epetra_IntSerialDenseVector & | indices, |
const Epetra_SerialDenseMatrix & | values, | ||
int | format = Epetra_FECrsMatrix::COLUMN_MAJOR |
||
) |
Sum a square structurally-symmetric sub-matrix into the global matrix.
For non-square sub-matrices, see the other overloading of this method.
indices | List of scatter-indices. indices.Length() must be the same as values.M() and values.N(). |
values | Sub-matrix of coefficients. Must be square. |
format | Optional format specifier, defaults to COLUMN_MAJOR. |
Definition at line 442 of file Epetra_FECrsMatrix.cpp.
int Epetra_FECrsMatrix::SumIntoGlobalValues | ( | const Epetra_LongLongSerialDenseVector & | indices, |
const Epetra_SerialDenseMatrix & | values, | ||
int | format = Epetra_FECrsMatrix::COLUMN_MAJOR |
||
) |
Definition at line 456 of file Epetra_FECrsMatrix.cpp.
int Epetra_FECrsMatrix::SumIntoGlobalValues | ( | const Epetra_IntSerialDenseVector & | rows, |
const Epetra_IntSerialDenseVector & | cols, | ||
const Epetra_SerialDenseMatrix & | values, | ||
int | format = Epetra_FECrsMatrix::COLUMN_MAJOR |
||
) |
Sum a general sub-matrix into the global matrix.
For square structurally-symmetric sub-matrices, see the other overloading of this method.
rows | List of row-indices. rows.Length() must be the same as values.M(). |
cols | List of column-indices. cols.Length() must be the same as values.N(). |
values | Sub-matrix of coefficients. |
format | Optional format specifier, defaults to COLUMN_MAJOR. |
Definition at line 524 of file Epetra_FECrsMatrix.cpp.
int Epetra_FECrsMatrix::SumIntoGlobalValues | ( | const Epetra_LongLongSerialDenseVector & | rows, |
const Epetra_LongLongSerialDenseVector & | cols, | ||
const Epetra_SerialDenseMatrix & | values, | ||
int | format = Epetra_FECrsMatrix::COLUMN_MAJOR |
||
) |
Definition at line 539 of file Epetra_FECrsMatrix.cpp.
int Epetra_FECrsMatrix::InsertGlobalValues | ( | const Epetra_IntSerialDenseVector & | indices, |
const Epetra_SerialDenseMatrix & | values, | ||
int | format = Epetra_FECrsMatrix::COLUMN_MAJOR |
||
) |
Insert a square structurally-symmetric sub-matrix into the global matrix.
For non-square sub-matrices, see the other overloading of this method.
indices | List of scatter-indices. indices.Length() must be the same as values.M() and values.N(). |
values | Sub-matrix of coefficients. Must be square. |
format | Optional format specifier, defaults to COLUMN_MAJOR. |
Definition at line 470 of file Epetra_FECrsMatrix.cpp.
int Epetra_FECrsMatrix::InsertGlobalValues | ( | const Epetra_LongLongSerialDenseVector & | indices, |
const Epetra_SerialDenseMatrix & | values, | ||
int | format = Epetra_FECrsMatrix::COLUMN_MAJOR |
||
) |
Definition at line 483 of file Epetra_FECrsMatrix.cpp.
int Epetra_FECrsMatrix::InsertGlobalValues | ( | const Epetra_IntSerialDenseVector & | rows, |
const Epetra_IntSerialDenseVector & | cols, | ||
const Epetra_SerialDenseMatrix & | values, | ||
int | format = Epetra_FECrsMatrix::COLUMN_MAJOR |
||
) |
Insert a general sub-matrix into the global matrix.
For square structurally-symmetric sub-matrices, see the other overloading of this method.
rows | List of row-indices. rows.Length() must be the same as values.M(). |
cols | List of column-indices. cols.Length() must be the same as values.N(). |
values | Sub-matrix of coefficients. |
format | Optional format specifier, defaults to COLUMN_MAJOR. |
Definition at line 555 of file Epetra_FECrsMatrix.cpp.
int Epetra_FECrsMatrix::InsertGlobalValues | ( | const Epetra_LongLongSerialDenseVector & | rows, |
const Epetra_LongLongSerialDenseVector & | cols, | ||
const Epetra_SerialDenseMatrix & | values, | ||
int | format = Epetra_FECrsMatrix::COLUMN_MAJOR |
||
) |
Definition at line 570 of file Epetra_FECrsMatrix.cpp.
int Epetra_FECrsMatrix::ReplaceGlobalValues | ( | const Epetra_IntSerialDenseVector & | indices, |
const Epetra_SerialDenseMatrix & | values, | ||
int | format = Epetra_FECrsMatrix::COLUMN_MAJOR |
||
) |
Use a square structurally-symmetric sub-matrix to replace existing values in the global matrix.
For non-square sub-matrices, see the other overloading of this method.
indices | List of scatter-indices. indices.Length() must be the same as values.M() and values.N(). |
values | Sub-matrix of coefficients. Must be square. |
format | Optional format specifier, defaults to COLUMN_MAJOR. |
Definition at line 497 of file Epetra_FECrsMatrix.cpp.
int Epetra_FECrsMatrix::ReplaceGlobalValues | ( | const Epetra_LongLongSerialDenseVector & | indices, |
const Epetra_SerialDenseMatrix & | values, | ||
int | format = Epetra_FECrsMatrix::COLUMN_MAJOR |
||
) |
Definition at line 510 of file Epetra_FECrsMatrix.cpp.
int Epetra_FECrsMatrix::ReplaceGlobalValues | ( | const Epetra_IntSerialDenseVector & | rows, |
const Epetra_IntSerialDenseVector & | cols, | ||
const Epetra_SerialDenseMatrix & | values, | ||
int | format = Epetra_FECrsMatrix::COLUMN_MAJOR |
||
) |
Use a general sub-matrix to replace existing values.
For square structurally-symmetric sub-matrices, see the other overloading of this method.
rows | List of row-indices. rows.Length() must be the same as values.M(). |
cols | List of column-indices. cols.Length() must be the same as values.N(). |
values | Sub-matrix of coefficients. |
format | Optional format specifier, defaults to COLUMN_MAJOR. |
Definition at line 586 of file Epetra_FECrsMatrix.cpp.
int Epetra_FECrsMatrix::ReplaceGlobalValues | ( | const Epetra_LongLongSerialDenseVector & | rows, |
const Epetra_LongLongSerialDenseVector & | cols, | ||
const Epetra_SerialDenseMatrix & | values, | ||
int | format = Epetra_FECrsMatrix::COLUMN_MAJOR |
||
) |
Definition at line 602 of file Epetra_FECrsMatrix.cpp.
int Epetra_FECrsMatrix::GlobalAssemble | ( | bool | callFillComplete = true , |
Epetra_CombineMode | combineMode = Add , |
||
bool | save_off_and_reuse_map_exporter = false |
||
) |
Gather any overlapping/shared data into the non-overlapping partitioning defined by the Map that was passed to this matrix at construction time.
Data imported from other processors is stored on the owning processor with a "sumInto" or accumulate operation. This is a collective method – every processor must enter it before any will complete it.
NOTE***: When GlobalAssemble() calls FillComplete(), it passes the arguments 'DomainMap()' and 'RangeMap()', which are the map attributes held by the base-class CrsMatrix and its graph. If a rectangular matrix is being assembled, the domain-map and range-map must be specified by calling the other overloading of this method. Otherwise, GlobalAssemble() has no way of knowing what these maps should really be.
callFillComplete | option argument, defaults to true. Determines whether GlobalAssemble() internally calls the FillComplete() method on this matrix. |
Definition at line 892 of file Epetra_FECrsMatrix.cpp.
int Epetra_FECrsMatrix::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 |
||
) |
Gather any overlapping/shared data into the non-overlapping partitioning defined by the Map that was passed to this matrix at construction time.
Data imported from other processors is stored on the owning processor with a "sumInto" or accumulate operation. This is a collective method – every processor must enter it before any will complete it.
NOTE***: When GlobalAssemble() (the other overloading of this method) calls FillComplete(), it passes the arguments 'DomainMap()' and 'RangeMap()', which are the map attributes already held by the base-class CrsMatrix and its graph. If a rectangular matrix is being assembled, the domain-map and range-map must be specified. Otherwise, GlobalAssemble() has no way of knowing what these maps should really be.
domain_map | user-supplied domain map for this matrix |
range_map | user-supplied range map for this matrix |
callFillComplete | option argument, defaults to true. Determines whether GlobalAssemble() internally calls the FillComplete() method on this matrix. |
Definition at line 900 of file Epetra_FECrsMatrix.cpp.
|
inline |
Set whether or not non-local data values should be ignored.
By default, non-local data values are NOT ignored.
Definition at line 740 of file Epetra_FECrsMatrix.h.
|
private |
Definition at line 319 of file Epetra_FECrsMatrix.cpp.
|
private |
Definition at line 1141 of file Epetra_FECrsMatrix.cpp.
|
private |
Definition at line 1191 of file Epetra_FECrsMatrix.cpp.
|
private |
Definition at line 1222 of file Epetra_FECrsMatrix.cpp.
|
private |
Definition at line 1077 of file Epetra_FECrsMatrix.cpp.
|
private |
Definition at line 1289 of file Epetra_FECrsMatrix.cpp.
|
private |
Definition at line 1309 of file Epetra_FECrsMatrix.cpp.
|
private |
|
private |
|
private |
Definition at line 710 of file Epetra_FECrsMatrix.cpp.
|
private |
|
inlineprivate |
Definition at line 830 of file Epetra_FECrsMatrix.h.
|
inlineprivate |
Definition at line 837 of file Epetra_FECrsMatrix.h.
|
inlineprivate |
Definition at line 844 of file Epetra_FECrsMatrix.h.
|
inlineprivate |
Definition at line 851 of file Epetra_FECrsMatrix.h.
|
private |
Definition at line 784 of file Epetra_FECrsMatrix.h.
|
private |
Definition at line 785 of file Epetra_FECrsMatrix.h.
|
private |
Definition at line 787 of file Epetra_FECrsMatrix.h.
|
private |
Definition at line 790 of file Epetra_FECrsMatrix.h.
|
private |
Definition at line 791 of file Epetra_FECrsMatrix.h.
|
private |
Definition at line 794 of file Epetra_FECrsMatrix.h.
|
private |
Definition at line 795 of file Epetra_FECrsMatrix.h.
|
private |
Definition at line 801 of file Epetra_FECrsMatrix.h.
|
private |
Definition at line 805 of file Epetra_FECrsMatrix.h.
|
private |
Definition at line 806 of file Epetra_FECrsMatrix.h.
|
private |
Definition at line 807 of file Epetra_FECrsMatrix.h.
|
private |
Definition at line 809 of file Epetra_FECrsMatrix.h.
|
private |
Definition at line 810 of file Epetra_FECrsMatrix.h.
|
private |
Definition at line 812 of file Epetra_FECrsMatrix.h.
|
private |
Definition at line 813 of file Epetra_FECrsMatrix.h.
|
private |
Definition at line 814 of file Epetra_FECrsMatrix.h.
|
private |
Definition at line 815 of file Epetra_FECrsMatrix.h.