|
| EpetraCrsMatrixT (const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &rowMap, size_t maxNumEntriesPerRow, const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) |
|
| EpetraCrsMatrixT (const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &rowMap, const ArrayRCP< const size_t > &NumEntriesPerRowToAlloc, const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) |
|
| EpetraCrsMatrixT (const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &rowMap, const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &colMap, size_t maxNumEntriesPerRow, const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) |
|
| EpetraCrsMatrixT (const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &rowMap, const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &colMap, const ArrayRCP< const size_t > &NumEntriesPerRowToAlloc, const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) |
|
| EpetraCrsMatrixT (const Teuchos::RCP< const CrsGraph< LocalOrdinal, GlobalOrdinal, Node > > &graph, const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) |
|
| EpetraCrsMatrixT (const Teuchos::RCP< const CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &sourceMatrix, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &domainMap=Teuchos::null, const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &rangeMap=Teuchos::null, const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) |
|
| EpetraCrsMatrixT (const Teuchos::RCP< const CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &sourceMatrix, const Export< LocalOrdinal, GlobalOrdinal, Node > &exporter, const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &domainMap=Teuchos::null, const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &rangeMap=Teuchos::null, const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) |
|
| EpetraCrsMatrixT (const Teuchos::RCP< const CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &sourceMatrix, const Import< LocalOrdinal, GlobalOrdinal, Node > &RowImporter, const Teuchos::RCP< const Import< LocalOrdinal, GlobalOrdinal, Node > > DomainImporter, const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &domainMap, const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &rangeMap, const Teuchos::RCP< Teuchos::ParameterList > ¶ms) |
|
| EpetraCrsMatrixT (const Teuchos::RCP< const CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &sourceMatrix, const Export< LocalOrdinal, GlobalOrdinal, Node > &RowExporter, const Teuchos::RCP< const Export< LocalOrdinal, GlobalOrdinal, Node > > DomainExporter, const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &domainMap, const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &rangeMap, const Teuchos::RCP< Teuchos::ParameterList > ¶ms) |
|
virtual | ~EpetraCrsMatrixT () |
|
void | insertGlobalValues (GlobalOrdinal globalRow, const ArrayView< const GlobalOrdinal > &cols, const ArrayView< const Scalar > &vals) |
|
void | insertLocalValues (LocalOrdinal localRow, const ArrayView< const LocalOrdinal > &cols, const ArrayView< const Scalar > &vals) |
|
void | replaceGlobalValues (GlobalOrdinal globalRow, const ArrayView< const GlobalOrdinal > &cols, const ArrayView< const Scalar > &vals) |
|
void | replaceLocalValues (LocalOrdinal localRow, const ArrayView< const LocalOrdinal > &cols, const ArrayView< const Scalar > &vals) |
|
void | setAllToScalar (const Scalar &alpha) |
|
void | scale (const Scalar &alpha) |
|
void | allocateAllValues (size_t numNonZeros, ArrayRCP< size_t > &rowptr, ArrayRCP< LocalOrdinal > &colind, ArrayRCP< Scalar > &values) |
|
void | setAllValues (const ArrayRCP< size_t > &rowptr, const ArrayRCP< LocalOrdinal > &colind, const ArrayRCP< Scalar > &values) |
|
void | getAllValues (ArrayRCP< const size_t > &rowptr, ArrayRCP< const LocalOrdinal > &colind, ArrayRCP< const Scalar > &values) const |
|
bool | haveGlobalConstants () const |
| Returns true if globalConstants have been computed; false otherwise. More...
|
|
void | expertStaticFillComplete (const RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &domainMap, const RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &rangeMap, const RCP< const Import< LocalOrdinal, GlobalOrdinal, Node > > &importer=Teuchos::null, const RCP< const Export< LocalOrdinal, GlobalOrdinal, Node > > &exporter=Teuchos::null, const RCP< ParameterList > ¶ms=Teuchos::null) |
|
void | resumeFill (const RCP< ParameterList > ¶ms=null) |
|
void | fillComplete (const RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &domainMap, const RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &rangeMap, const RCP< ParameterList > ¶ms=null) |
|
void | fillComplete (const RCP< ParameterList > ¶ms=null) |
| Signal that data entry is complete. More...
|
|
void | replaceDomainMapAndImporter (const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &newDomainMap, Teuchos::RCP< const Import< LocalOrdinal, GlobalOrdinal, Node > > &newImporter) |
|
const RCP< const Comm< int > > | getComm () const |
|
const RCP< const Map
< LocalOrdinal, GlobalOrdinal,
Node > > | getRowMap () const |
| Returns the Map that describes the row distribution in this matrix. More...
|
|
const RCP< const Map
< LocalOrdinal, GlobalOrdinal,
Node > > | getColMap () const |
| Returns the Map that describes the column distribution in this matrix. More...
|
|
RCP< const CrsGraph
< LocalOrdinal, GlobalOrdinal,
Node > > | getCrsGraph () const |
| Returns the CrsGraph associated with this matrix. More...
|
|
global_size_t | getGlobalNumRows () const |
| Number of global elements in the row map of this matrix. More...
|
|
global_size_t | getGlobalNumCols () const |
| Number of global columns in the matrix. More...
|
|
size_t | getNodeNumRows () const |
| Returns the number of matrix rows owned on the calling node. More...
|
|
size_t | getNodeNumCols () const |
| Returns the number of matrix columns owned on the calling node. More...
|
|
global_size_t | getGlobalNumEntries () const |
| Returns the global number of entries in this matrix. More...
|
|
size_t | getNodeNumEntries () const |
| Returns the local number of entries in this matrix. More...
|
|
size_t | getNumEntriesInLocalRow (LocalOrdinal localRow) const |
|
size_t | getNumEntriesInGlobalRow (GlobalOrdinal globalRow) const |
| Returns the current number of entries in the specified global row. More...
|
|
size_t | getGlobalMaxNumRowEntries () const |
| Returns the maximum number of entries across all rows/columns on all nodes. More...
|
|
size_t | getNodeMaxNumRowEntries () const |
| Returns the maximum number of entries across all rows/columns on this node. More...
|
|
bool | isLocallyIndexed () const |
| If matrix indices are in the local range, this function returns true. Otherwise, this function returns false. More...
|
|
bool | isGloballyIndexed () const |
| If matrix indices are in the global range, this function returns true. Otherwise, this function returns false. More...
|
|
bool | isFillComplete () const |
| Returns true if the matrix is in compute mode, i.e. if fillComplete() has been called. More...
|
|
bool | isFillActive () const |
| Returns true if the matrix is in edit mode. More...
|
|
ScalarTraits< Scalar >
::magnitudeType | getFrobeniusNorm () const |
| Returns the Frobenius norm of the matrix. More...
|
|
bool | supportsRowViews () const |
| Returns true if getLocalRowView() and getGlobalRowView() are valid for this class. More...
|
|
void | getLocalRowCopy (LocalOrdinal LocalRow, const ArrayView< LocalOrdinal > &Indices, const ArrayView< Scalar > &Values, size_t &NumEntries) const |
|
void | getGlobalRowCopy (GlobalOrdinal GlobalRow, const ArrayView< GlobalOrdinal > &Indices, const ArrayView< Scalar > &Values, size_t &NumEntries) const |
|
void | getGlobalRowView (GlobalOrdinal GlobalRow, ArrayView< const GlobalOrdinal > &indices, ArrayView< const Scalar > &values) const |
|
void | getLocalRowView (LocalOrdinal LocalRow, ArrayView< const LocalOrdinal > &indices, ArrayView< const Scalar > &values) const |
|
void | getLocalDiagCopy (Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &diag) const |
|
void | getLocalDiagOffsets (Teuchos::ArrayRCP< size_t > &offsets) const |
| Get offsets of the diagonal entries in the matrix. More...
|
|
void | getLocalDiagCopy (Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &diag, const Teuchos::ArrayView< const size_t > &offsets) const |
|
void | replaceDiag (const Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &diag) |
|
void | leftScale (const Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &x) |
|
void | rightScale (const Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &x) |
|
void | apply (const MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &X, MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &Y, Teuchos::ETransp mode=Teuchos::NO_TRANS, Scalar alpha=ScalarTraits< Scalar >::one(), Scalar beta=ScalarTraits< Scalar >::zero()) const |
|
const RCP< const Map
< LocalOrdinal, GlobalOrdinal,
Node > > | getDomainMap () const |
| Returns the Map associated with the domain of this operator. This will be null until fillComplete() is called. More...
|
|
const RCP< const Map
< LocalOrdinal, GlobalOrdinal,
Node > > | getRangeMap () const |
| Returns the Map associated with the range of this operator, which must be compatible with Y.getMap(). More...
|
|
std::string | description () const |
| A simple one-line description of this object. More...
|
|
void | describe (Teuchos::FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel=Teuchos::Describable::verbLevel_default) const |
| Print the object with some verbosity level to an FancyOStream object. More...
|
|
void | setObjectLabel (const std::string &objectLabel) |
|
| EpetraCrsMatrixT (const EpetraCrsMatrixT &matrix) |
|
Teuchos::RCP< const Map
< LocalOrdinal, GlobalOrdinal,
Node > > | getMap () const |
| The Map describing the parallel distribution of this object. More...
|
|
void | doImport (const DistObject< char, LocalOrdinal, GlobalOrdinal, Node > &source, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, CombineMode CM) |
|
void | doExport (const DistObject< char, LocalOrdinal, GlobalOrdinal, Node > &dest, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, CombineMode CM) |
|
void | doImport (const DistObject< char, LocalOrdinal, GlobalOrdinal, Node > &source, const Export< LocalOrdinal, GlobalOrdinal, Node > &exporter, CombineMode CM) |
|
void | doExport (const DistObject< char, LocalOrdinal, GlobalOrdinal, Node > &dest, const Export< LocalOrdinal, GlobalOrdinal, Node > &exporter, CombineMode CM) |
|
void | removeEmptyProcessesInPlace (const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &newMap) |
|
bool | hasMatrix () const |
| Does this have an underlying matrix. More...
|
|
| EpetraCrsMatrixT (const Teuchos::RCP< Epetra_CrsMatrix > &mtx) |
|
RCP< const Epetra_CrsMatrix > | getEpetra_CrsMatrix () const |
|
RCP< Epetra_CrsMatrix > | getEpetra_CrsMatrixNonConst () const |
|
void | residual (const MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &X, const MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &B, MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &R) const |
|
virtual void | getLocalRowCopy (intLocalRow, const ArrayView< int > &Indices, const ArrayView< double > &Values, size_t &NumEntries) const =0 |
| Extract a list of entries in a specified local row of the matrix. Put into storage allocated by calling routine. More...
|
|
virtual void | residual (const MultiVector< double, int, EpetraGlobalOrdinal, Node > &X, const MultiVector< double, int, EpetraGlobalOrdinal, Node > &B, MultiVector< double, int, EpetraGlobalOrdinal, Node > &R) const =0 |
| Compute a residual R = B - (*this) * X. More...
|
|
virtual | ~CrsMatrix () |
| Destructor. More...
|
|
virtual void | insertGlobalValues (EpetraGlobalOrdinalglobalRow, const ArrayView< const EpetraGlobalOrdinal > &cols, const ArrayView< const double > &vals)=0 |
| Insert matrix entries, using global IDs. More...
|
|
virtual void | insertLocalValues (intlocalRow, const ArrayView< const int > &cols, const ArrayView< const double > &vals)=0 |
| Insert matrix entries, using local IDs. More...
|
|
virtual void | replaceGlobalValues (EpetraGlobalOrdinalglobalRow, const ArrayView< const EpetraGlobalOrdinal > &cols, const ArrayView< const double > &vals)=0 |
| Replace matrix entries, using global IDs. More...
|
|
virtual void | replaceLocalValues (intlocalRow, const ArrayView< const int > &cols, const ArrayView< const double > &vals)=0 |
| Replace matrix entries, using local IDs. More...
|
|
virtual void | setAllToScalar (const double &alpha)=0 |
| Set all matrix entries equal to scalarThis. More...
|
|
virtual void | scale (const double &alpha)=0 |
| Scale the current values of a matrix, this = alpha*this. More...
|
|
virtual void | allocateAllValues (size_t numNonZeros, ArrayRCP< size_t > &rowptr, ArrayRCP< int > &colind, ArrayRCP< double > &values)=0 |
| Allocates and returns ArrayRCPs of the Crs arrays — This is an Xpetra-only routine. More...
|
|
virtual void | setAllValues (const ArrayRCP< size_t > &rowptr, const ArrayRCP< int > &colind, const ArrayRCP< double > &values)=0 |
| Sets the 1D pointer arrays of the graph. More...
|
|
virtual void | getAllValues (ArrayRCP< const size_t > &rowptr, ArrayRCP< const int > &colind, ArrayRCP< const double > &values) const =0 |
| Gets the 1D pointer arrays of the graph. More...
|
|
virtual void | fillComplete (const RCP< const Map< int, EpetraGlobalOrdinal, Node > > &domainMap, const RCP< const Map< int, EpetraGlobalOrdinal, Node > > &rangeMap, const RCP< ParameterList > ¶ms=null)=0 |
| Signal that data entry is complete, specifying domain and range maps. More...
|
|
virtual void | replaceDomainMapAndImporter (const Teuchos::RCP< const Map< int, EpetraGlobalOrdinal, Node > > &newDomainMap, Teuchos::RCP< const Import< int, EpetraGlobalOrdinal, Node > > &newImporter)=0 |
| Replaces the current domainMap and importer with the user-specified objects. More...
|
|
virtual void | expertStaticFillComplete (const RCP< const Map< int, EpetraGlobalOrdinal, Node > > &domainMap, const RCP< const Map< int, EpetraGlobalOrdinal, Node > > &rangeMap, const RCP< const Import< int, EpetraGlobalOrdinal, Node > > &importer=Teuchos::null, const RCP< const Export< int, EpetraGlobalOrdinal, Node > > &exporter=Teuchos::null, const RCP< ParameterList > ¶ms=Teuchos::null)=0 |
| Expert static fill complete. More...
|
|
virtual size_t | getNumEntriesInLocalRow (intlocalRow) const =0 |
| Returns the current number of entries on this node in the specified local row. More...
|
|
virtual void | getGlobalRowView (EpetraGlobalOrdinalGlobalRow, ArrayView< const EpetraGlobalOrdinal > &indices, ArrayView< const double > &values) const =0 |
| Extract a const, non-persisting view of global indices in a specified row of the matrix. More...
|
|
virtual void | getGlobalRowCopy (EpetraGlobalOrdinalGlobalRow, const ArrayView< EpetraGlobalOrdinal > &indices, const ArrayView< double > &values, size_t &numEntries) const =0 |
| Extract a list of entries in a specified global row of this matrix. Put into pre-allocated storage. More...
|
|
virtual void | getLocalRowView (intLocalRow, ArrayView< const int > &indices, ArrayView< const double > &values) const =0 |
| Extract a const, non-persisting view of local indices in a specified row of the matrix. More...
|
|
virtual void | getLocalDiagCopy (Vector< double, int, EpetraGlobalOrdinal, Node > &diag) const =0 |
| Get a copy of the diagonal entries owned by this node, with local row indices. More...
|
|
virtual void | getLocalDiagCopy (Vector< double, int, EpetraGlobalOrdinal, Node > &diag, const Teuchos::ArrayView< const size_t > &offsets) const =0 |
| Get a copy of the diagonal entries owned by this node, with local row indices, using row offsets. More...
|
|
virtual void | replaceDiag (const Vector< double, int, EpetraGlobalOrdinal, Node > &diag)=0 |
| Replace the diagonal entries of the matrix. More...
|
|
virtual void | leftScale (const Vector< double, int, EpetraGlobalOrdinal, Node > &x)=0 |
| Left scale matrix using the given vector entries. More...
|
|
virtual void | rightScale (const Vector< double, int, EpetraGlobalOrdinal, Node > &x)=0 |
| Right scale matrix using the given vector entries. More...
|
|
virtual void | removeEmptyProcessesInPlace (const RCP< const Map< int, EpetraGlobalOrdinal, Node > > &newMap)=0 |
|
virtual void | apply (const MultiVector< double, int, EpetraGlobalOrdinal, Node > &X, MultiVector< double, int, EpetraGlobalOrdinal, Node > &Y, Teuchos::ETransp mode=Teuchos::NO_TRANS, doublealpha=ScalarTraits< double >::one(), doublebeta=ScalarTraits< double >::zero()) const =0 |
| Computes the sparse matrix-multivector multiplication. More...
|
|
virtual | ~RowMatrix () |
| Destructor. More...
|
|
virtual size_t | getNumEntriesInLocalRow (LocalOrdinal localRow) const =0 |
| Returns the current number of entries on this node in the specified local row. More...
|
|
virtual void | getLocalRowCopy (LocalOrdinal LocalRow, const Teuchos::ArrayView< LocalOrdinal > &Indices, const Teuchos::ArrayView< Scalar > &Values, size_t &NumEntries) const =0 |
| Extract a list of entries in a specified local row of the graph. Put into storage allocated by calling routine. More...
|
|
virtual void | getGlobalRowView (GlobalOrdinal GlobalRow, ArrayView< const GlobalOrdinal > &indices, ArrayView< const Scalar > &values) const =0 |
| Extract a const, non-persisting view of global indices in a specified row of the matrix. More...
|
|
virtual void | getLocalRowView (LocalOrdinal LocalRow, ArrayView< const LocalOrdinal > &indices, ArrayView< const Scalar > &values) const =0 |
| Extract a const, non-persisting view of local indices in a specified row of the matrix. More...
|
|
virtual void | getLocalDiagCopy (Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &diag) const =0 |
| Get a copy of the diagonal entries owned by this node, with local row indices. More...
|
|
virtual void | apply (const MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &X, MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &Y, Teuchos::ETransp mode=Teuchos::NO_TRANS, Scalar alpha=Teuchos::ScalarTraits< Scalar >::one(), Scalar beta=Teuchos::ScalarTraits< Scalar >::zero()) const =0 |
| Computes the operator-multivector application. More...
|
|
virtual | ~DistObject () |
| Destructor. More...
|
|
virtual void | doImport (const DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node > &source, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, CombineMode CM)=0 |
| Import data into this object using an Import object ("forward mode"). More...
|
|
virtual void | doExport (const DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node > &source, const Export< LocalOrdinal, GlobalOrdinal, Node > &exporter, CombineMode CM)=0 |
| Export data into this object using an Export object ("forward mode"). More...
|
|
virtual void | doImport (const DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node > &source, const Export< LocalOrdinal, GlobalOrdinal, Node > &exporter, CombineMode CM)=0 |
| Import data into this object using an Export object ("reverse mode"). More...
|
|
virtual void | doExport (const DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node > &source, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, CombineMode CM)=0 |
| Export data into this object using an Import object ("reverse mode"). More...
|
|