Xpetra Version of the Day
|
#include <Xpetra_TpetraCrsMatrix_decl.hpp>
Private Types | |
typedef TpetraCrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > | TpetraCrsMatrixClass |
typedef TpetraVector | TpetraVectorClass |
typedef TpetraImport< LocalOrdinal, GlobalOrdinal, Node > | TpetraImportClass |
typedef TpetraExport< LocalOrdinal, GlobalOrdinal, Node > | TpetraExportClass |
typedef Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::local_matrix_type | local_matrix_type |
Xpetra specific | |
RCP< Tpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > | mtx_ |
bool | hasMatrix () const |
Does this have an underlying matrix. | |
TpetraCrsMatrix (const Teuchos::RCP< Tpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &mtx) | |
TpetraCrsMatrix constructor to wrap a Tpetra::CrsMatrix object. | |
RCP< const Tpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > | getTpetra_CrsMatrix () const |
Get the underlying Tpetra matrix. | |
RCP< Tpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > | getTpetra_CrsMatrixNonConst () const |
Get the underlying Tpetra matrix. | |
local_matrix_type::HostMirror | getLocalMatrixHost () const |
Access the local Kokkos::CrsMatrix data. | |
local_matrix_type | getLocalMatrixDevice () const |
Access the local Kokkos::CrsMatrix data. | |
void | setAllValues (const typename local_matrix_type::row_map_type &ptr, const typename local_matrix_type::StaticCrsGraphType::entries_type::non_const_type &ind, const typename local_matrix_type::values_type &val) |
LocalOrdinal | GetStorageBlockSize () const |
Returns the block size of the storage mechanism, which is usually 1, except for Tpetra::BlockCrsMatrix. | |
void | residual (const MultiVector &X, const MultiVector &B, MultiVector &R) const |
Compute a residual R = B - (*this) * X. | |
Constructor/Destructor Methods | |
TpetraCrsMatrix (const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &rowMap, size_t maxNumEntriesPerRow, const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) | |
Constructor specifying fixed number of entries for each row. | |
TpetraCrsMatrix (const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &rowMap, const ArrayRCP< const size_t > &NumEntriesPerRowToAlloc, const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) | |
Constructor specifying (possibly different) number of entries in each row. | |
TpetraCrsMatrix (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) | |
Constructor specifying column Map and fixed number of entries for each row. | |
TpetraCrsMatrix (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) | |
Constructor specifying column Map and number of entries in each row. | |
TpetraCrsMatrix (const Teuchos::RCP< const CrsGraph< LocalOrdinal, GlobalOrdinal, Node > > &graph, const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) | |
Constructor specifying a previously constructed graph. | |
TpetraCrsMatrix (const Teuchos::RCP< const CrsMatrix > &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) | |
Constructor for a fused import. | |
TpetraCrsMatrix (const Teuchos::RCP< const CrsMatrix > &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) | |
Constructor for a fused export. | |
TpetraCrsMatrix (const Teuchos::RCP< const CrsMatrix > &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) | |
Constructor for a fused import. | |
TpetraCrsMatrix (const Teuchos::RCP< const CrsMatrix > &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) | |
Constructor for a fused export. | |
TpetraCrsMatrix (const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &rowMap, const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &colMap, const local_matrix_type &lclMatrix, const Teuchos::RCP< Teuchos::ParameterList > ¶ms=null) | |
Constructor specifying column Map and a local matrix, which the resulting CrsMatrix views. | |
TpetraCrsMatrix (const local_matrix_type &lclMatrix, const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &rowMap, const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &colMap, 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=null) | |
Constructor specifying local matrix and 4 maps. | |
TpetraCrsMatrix (const local_matrix_type &lclMatrix, const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &rowMap, const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &colMap, const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &domainMap, const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &rangeMap, const Teuchos::RCP< const Import< LocalOrdinal, GlobalOrdinal, Node > > &importer, const Teuchos::RCP< const Export< LocalOrdinal, GlobalOrdinal, Node > > &exporter, const Teuchos::RCP< Teuchos::ParameterList > ¶ms=null) | |
Constructor specifying local matrix, four maps, import and export objects. | |
virtual | ~TpetraCrsMatrix () |
Destructor. | |
Insertion/Removal Methods | |
void | insertGlobalValues (GlobalOrdinal globalRow, const ArrayView< const GlobalOrdinal > &cols, const ArrayView< const Scalar > &vals) |
Insert matrix entries, using global IDs. | |
void | insertLocalValues (LocalOrdinal localRow, const ArrayView< const LocalOrdinal > &cols, const ArrayView< const Scalar > &vals) |
Insert matrix entries, using local IDs. | |
void | replaceGlobalValues (GlobalOrdinal globalRow, const ArrayView< const GlobalOrdinal > &cols, const ArrayView< const Scalar > &vals) |
Replace matrix entries, using global IDs. | |
void | replaceLocalValues (LocalOrdinal localRow, const ArrayView< const LocalOrdinal > &cols, const ArrayView< const Scalar > &vals) |
Replace matrix entries, using local IDs. | |
void | setAllToScalar (const Scalar &alpha) |
Set all matrix entries equal to scalarThis. | |
void | scale (const Scalar &alpha) |
Scale the current values of a matrix, this = alpha*this. | |
void | allocateAllValues (size_t numNonZeros, ArrayRCP< size_t > &rowptr, ArrayRCP< LocalOrdinal > &colind, ArrayRCP< Scalar > &values) |
Allocates and returns ArrayRCPs of the Crs arrays — This is an Xpetra-only routine. | |
void | setAllValues (const ArrayRCP< size_t > &rowptr, const ArrayRCP< LocalOrdinal > &colind, const ArrayRCP< Scalar > &values) |
Sets the 1D pointer arrays of the graph. | |
void | getAllValues (ArrayRCP< const size_t > &rowptr, ArrayRCP< const LocalOrdinal > &colind, ArrayRCP< const Scalar > &values) const |
Gets the 1D pointer arrays of the graph. | |
void | getAllValues (ArrayRCP< Scalar > &values) |
Gets the 1D pointer arrays of the graph. | |
bool | haveGlobalConstants () const |
Returns true if globalConstants have been computed; false otherwise. | |
Transformational Methods | |
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) |
Signal that data entry is complete, specifying domain and range maps. | |
void | fillComplete (const RCP< ParameterList > ¶ms=null) |
Signal that data entry is complete. | |
void | replaceDomainMapAndImporter (const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &newDomainMap, Teuchos::RCP< const Import< LocalOrdinal, GlobalOrdinal, Node > > &newImporter) |
Replaces the current domainMap and importer with the user-specified objects. | |
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) |
Expert static fill complete. | |
Methods implementing RowMatrix | |
const RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > | getRowMap () const |
Returns the Map that describes the row distribution in this matrix. | |
const RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > | getColMap () const |
Returns the Map that describes the column distribution in this matrix. | |
RCP< const CrsGraph< LocalOrdinal, GlobalOrdinal, Node > > | getCrsGraph () const |
Returns the CrsGraph associated with this matrix. | |
global_size_t | getGlobalNumRows () const |
Number of global elements in the row map of this matrix. | |
global_size_t | getGlobalNumCols () const |
Number of global columns in the matrix. | |
size_t | getLocalNumRows () const |
Returns the number of matrix rows owned on the calling node. | |
size_t | getLocalNumCols () const |
Returns the number of columns connected to the locally owned rows of this matrix. | |
global_size_t | getGlobalNumEntries () const |
Returns the global number of entries in this matrix. | |
size_t | getLocalNumEntries () const |
Returns the local number of entries in this matrix. | |
size_t | getNumEntriesInLocalRow (LocalOrdinal localRow) const |
Returns the current number of entries on this node in the specified local row. | |
size_t | getNumEntriesInGlobalRow (GlobalOrdinal globalRow) const |
Returns the current number of entries in the (locally owned) global row. | |
size_t | getGlobalMaxNumRowEntries () const |
Returns the maximum number of entries across all rows/columns on all nodes. | |
size_t | getLocalMaxNumRowEntries () const |
Returns the maximum number of entries across all rows/columns on this node. | |
bool | isLocallyIndexed () const |
If matrix indices are in the local range, this function returns true. Otherwise, this function returns false. | |
bool | isGloballyIndexed () const |
If matrix indices are in the global range, this function returns true. Otherwise, this function returns false. | |
bool | isFillComplete () const |
Returns true if the matrix is in compute mode, i.e. if fillComplete() has been called. | |
bool | isFillActive () const |
Returns true if the matrix is in edit mode. | |
ScalarTraits< Scalar >::magnitudeType | getFrobeniusNorm () const |
Returns the Frobenius norm of the matrix. | |
bool | supportsRowViews () const |
Returns true if getLocalRowView() and getGlobalRowView() are valid for this class. | |
void | getLocalRowCopy (LocalOrdinal LocalRow, const ArrayView< LocalOrdinal > &Indices, const ArrayView< Scalar > &Values, size_t &NumEntries) const |
Extract a list of entries in a specified local row of the matrix. Put into storage allocated by calling routine. | |
void | getGlobalRowView (GlobalOrdinal GlobalRow, ArrayView< const GlobalOrdinal > &indices, ArrayView< const Scalar > &values) const |
Extract a const, non-persisting view of global indices in a specified row of the matrix. | |
void | getGlobalRowCopy (GlobalOrdinal GlobalRow, const ArrayView< GlobalOrdinal > &indices, const ArrayView< Scalar > &values, size_t &numEntries) const |
Extract a list of entries in a specified global row of this matrix. Put into pre-allocated storage. | |
void | getLocalRowView (LocalOrdinal LocalRow, ArrayView< const LocalOrdinal > &indices, ArrayView< const Scalar > &values) const |
Extract a const, non-persisting view of local indices in a specified row of the matrix. | |
Methods implementing Operator | |
void | apply (const MultiVector &X, MultiVector &Y, Teuchos::ETransp mode=Teuchos::NO_TRANS, Scalar alpha=ScalarTraits< Scalar >::one(), Scalar beta=ScalarTraits< Scalar >::zero()) const |
Computes the sparse matrix-multivector multiplication. | |
void | apply (const MultiVector &X, MultiVector &Y, Teuchos::ETransp mode, Scalar alpha, Scalar beta, bool sumInterfaceValues, const RCP< Xpetra::Import< LocalOrdinal, GlobalOrdinal, Node > > ®ionInterfaceImporter, const Teuchos::ArrayRCP< LocalOrdinal > ®ionInterfaceLIDs) const |
Computes the matrix-multivector multiplication for region layout matrices. | |
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. | |
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(). | |
Overridden from Teuchos::Describable | |
std::string | description () const |
A simple one-line description of this object. | |
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. | |
Overridden from Teuchos::LabeledObject | |
void | setObjectLabel (const std::string &objectLabel) |
TpetraCrsMatrix (const TpetraCrsMatrix &matrix) | |
Deep copy constructor. | |
void | getLocalDiagCopy (Vector &diag) const |
Get a copy of the diagonal entries owned by this node, with local row indices. | |
void | getLocalDiagOffsets (Teuchos::ArrayRCP< size_t > &offsets) const |
Get offsets of the diagonal entries in the matrix. | |
void | getLocalDiagCopy (Vector &diag, const Teuchos::ArrayView< const size_t > &offsets) const |
Get a copy of the diagonal entries owned by this node, with local row indices. | |
void | replaceDiag (const Vector &diag) |
Replace the diagonal entries of the matrix. | |
void | leftScale (const Vector &x) |
Left scale operator with given vector values. | |
void | rightScale (const Vector &x) |
Right scale operator with given vector values. | |
Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > | getMap () const |
Implements DistObject interface. | |
void | doImport (const DistObject< char, LocalOrdinal, GlobalOrdinal, Node > &source, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, CombineMode CM) |
Import. | |
void | doExport (const DistObject< char, LocalOrdinal, GlobalOrdinal, Node > &dest, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, CombineMode CM) |
Export. | |
void | doImport (const DistObject< char, LocalOrdinal, GlobalOrdinal, Node > &source, const Export< LocalOrdinal, GlobalOrdinal, Node > &exporter, CombineMode CM) |
Import (using an Exporter). | |
void | doExport (const DistObject< char, LocalOrdinal, GlobalOrdinal, Node > &dest, const Export< LocalOrdinal, GlobalOrdinal, Node > &exporter, CombineMode CM) |
Export (using an Importer). | |
void | removeEmptyProcessesInPlace (const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &newMap) |
Additional Inherited Members | |
![]() | |
typedef Scalar | scalar_type |
typedef LocalOrdinal | local_ordinal_type |
typedef GlobalOrdinal | global_ordinal_type |
typedef Node | node_type |
using | impl_scalar_type = typename Kokkos::Details::ArithTraits< Scalar >::val_type |
using | execution_space = typename node_type::device_type |
using | local_graph_type = Kokkos::StaticCrsGraph< LocalOrdinal, Kokkos::LayoutLeft, execution_space, void, size_t > |
using | local_matrix_type = KokkosSparse::CrsMatrix< impl_scalar_type, LocalOrdinal, execution_space, void, typename local_graph_type::size_type > |
The specialization of Kokkos::CrsMatrix that represents the part of the sparse matrix on each MPI process. The same as for Tpetra. | |
![]() | |
typedef Scalar | scalar_type |
typedef LocalOrdinal | local_ordinal_type |
typedef GlobalOrdinal | global_ordinal_type |
typedef Node | node_type |
![]() | |
virtual void | setAllValues (const typename local_matrix_type::row_map_type &ptr, const typename local_graph_type::entries_type::non_const_type &ind, const typename local_matrix_type::values_type &val)=0 |
virtual | ~CrsMatrix () |
Destructor. | |
![]() | |
virtual | ~RowMatrix () |
Destructor. | |
![]() | |
virtual | ~DistObject () |
Destructor. | |
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"). | |
virtual void | beginImport (const DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node > &source, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, CombineMode CM) |
Import data into this object using an Import object ("forward mode"). | |
virtual void | endImport (const DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node > &source, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, CombineMode CM) |
Import data into this object using an Import object ("forward mode"). | |
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"). | |
virtual void | beginExport (const DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node > &source, const Export< LocalOrdinal, GlobalOrdinal, Node > &exporter, CombineMode CM) |
Export data into this object using an Export object ("forward mode"). | |
virtual void | endExport (const DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node > &source, const Export< LocalOrdinal, GlobalOrdinal, Node > &exporter, CombineMode CM) |
Export data into this object using an Export object ("forward mode"). | |
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"). | |
virtual void | beginImport (const DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node > &source, const Export< LocalOrdinal, GlobalOrdinal, Node > &exporter, CombineMode CM) |
Import data into this object using an Export object ("reverse mode"). | |
virtual void | endImport (const DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node > &source, const Export< LocalOrdinal, GlobalOrdinal, Node > &exporter, CombineMode CM) |
Import data into this object using an Export object ("reverse mode"). | |
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"). | |
virtual void | beginExport (const DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node > &source, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, CombineMode CM) |
Export data into this object using an Import object ("reverse mode"). | |
virtual void | endExport (const DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node > &source, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, CombineMode CM) |
Export data into this object using an Import object ("reverse mode"). | |
![]() | |
virtual std::string | description () const |
virtual void | describe (FancyOStream &out, const EVerbosityLevel verbLevel=verbLevel_default) const |
void | describe (std::ostream &out, const EVerbosityLevel verbLevel=verbLevel_default) const |
virtual | ~Describable () |
DescribableStreamManipulatorState | describe (const Describable &describable, const EVerbosityLevel verbLevel=Describable::verbLevel_default) |
std::ostream & | operator<< (std::ostream &os, const DescribableStreamManipulatorState &d) |
virtual std::string | description () const |
virtual void | describe (FancyOStream &out, const EVerbosityLevel verbLevel=verbLevel_default) const |
void | describe (std::ostream &out, const EVerbosityLevel verbLevel=verbLevel_default) const |
virtual | ~Describable () |
![]() | |
LabeledObject () | |
virtual | ~LabeledObject () |
virtual void | setObjectLabel (const std::string &objectLabel) |
virtual std::string | getObjectLabel () const |
![]() | |
static const EVerbosityLevel | verbLevel_default |
Definition at line 75 of file Xpetra_TpetraCrsMatrix_decl.hpp.
|
private |
Definition at line 81 of file Xpetra_TpetraCrsMatrix_decl.hpp.
|
private |
Definition at line 82 of file Xpetra_TpetraCrsMatrix_decl.hpp.
|
private |
Definition at line 83 of file Xpetra_TpetraCrsMatrix_decl.hpp.
|
private |
Definition at line 84 of file Xpetra_TpetraCrsMatrix_decl.hpp.
|
private |
Definition at line 88 of file Xpetra_TpetraCrsMatrix_decl.hpp.
Xpetra::TpetraCrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::TpetraCrsMatrix | ( | const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > & | rowMap, |
size_t | maxNumEntriesPerRow, | ||
const Teuchos::RCP< Teuchos::ParameterList > & | params = Teuchos::null |
||
) |
Constructor specifying fixed number of entries for each row.
Definition at line 56 of file Xpetra_TpetraCrsMatrix_def.hpp.
Xpetra::TpetraCrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::TpetraCrsMatrix | ( | const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > & | rowMap, |
const ArrayRCP< const size_t > & | NumEntriesPerRowToAlloc, | ||
const Teuchos::RCP< Teuchos::ParameterList > & | params = Teuchos::null |
||
) |
Constructor specifying (possibly different) number of entries in each row.
Definition at line 60 of file Xpetra_TpetraCrsMatrix_def.hpp.
Xpetra::TpetraCrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::TpetraCrsMatrix | ( | 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 > & | params = Teuchos::null |
||
) |
Constructor specifying column Map and fixed number of entries for each row.
Definition at line 64 of file Xpetra_TpetraCrsMatrix_def.hpp.
Xpetra::TpetraCrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::TpetraCrsMatrix | ( | 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 > & | params = Teuchos::null |
||
) |
Constructor specifying column Map and number of entries in each row.
Definition at line 68 of file Xpetra_TpetraCrsMatrix_def.hpp.
Xpetra::TpetraCrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::TpetraCrsMatrix | ( | const Teuchos::RCP< const CrsGraph< LocalOrdinal, GlobalOrdinal, Node > > & | graph, |
const Teuchos::RCP< Teuchos::ParameterList > & | params = Teuchos::null |
||
) |
Constructor specifying a previously constructed graph.
Definition at line 72 of file Xpetra_TpetraCrsMatrix_def.hpp.
Xpetra::TpetraCrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::TpetraCrsMatrix | ( | const Teuchos::RCP< const CrsMatrix > & | 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 > & | params = Teuchos::null |
||
) |
Constructor for a fused import.
Definition at line 78 of file Xpetra_TpetraCrsMatrix_def.hpp.
Xpetra::TpetraCrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::TpetraCrsMatrix | ( | const Teuchos::RCP< const CrsMatrix > & | 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 > & | params = Teuchos::null |
||
) |
Constructor for a fused export.
Definition at line 98 of file Xpetra_TpetraCrsMatrix_def.hpp.
Xpetra::TpetraCrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::TpetraCrsMatrix | ( | const Teuchos::RCP< const CrsMatrix > & | 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 > & | params | ||
) |
Constructor for a fused import.
Definition at line 115 of file Xpetra_TpetraCrsMatrix_def.hpp.
Xpetra::TpetraCrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::TpetraCrsMatrix | ( | const Teuchos::RCP< const CrsMatrix > & | 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 > & | params | ||
) |
Constructor for a fused export.
Definition at line 136 of file Xpetra_TpetraCrsMatrix_def.hpp.
Xpetra::TpetraCrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::TpetraCrsMatrix | ( | const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > & | rowMap, |
const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > & | colMap, | ||
const local_matrix_type & | lclMatrix, | ||
const Teuchos::RCP< Teuchos::ParameterList > & | params = null |
||
) |
Constructor specifying column Map and a local matrix, which the resulting CrsMatrix views.
Unlike most other CrsMatrix constructors, successful completion of this constructor will result in a fill-complete matrix.
rowMap | [in] Distribution of rows of the matrix. |
colMap | [in] Distribution of columns of the matrix. |
lclMatrix | [in] A local CrsMatrix containing all local matrix values as well as a local graph. The graph's local row indices must come from the specified row Map, and its local column indices must come from the specified column Map. |
params | [in/out] Optional list of parameters. If not null, any missing parameters will be filled in with their default values. |
Definition at line 158 of file Xpetra_TpetraCrsMatrix_def.hpp.
Xpetra::TpetraCrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::TpetraCrsMatrix | ( | const local_matrix_type & | lclMatrix, |
const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > & | rowMap, | ||
const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > & | colMap, | ||
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 > & | params = null |
||
) |
Constructor specifying local matrix and 4 maps.
Definition at line 165 of file Xpetra_TpetraCrsMatrix_def.hpp.
Xpetra::TpetraCrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::TpetraCrsMatrix | ( | const local_matrix_type & | lclMatrix, |
const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > & | rowMap, | ||
const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > & | colMap, | ||
const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > & | domainMap, | ||
const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > & | rangeMap, | ||
const Teuchos::RCP< const Import< LocalOrdinal, GlobalOrdinal, Node > > & | importer, | ||
const Teuchos::RCP< const Export< LocalOrdinal, GlobalOrdinal, Node > > & | exporter, | ||
const Teuchos::RCP< Teuchos::ParameterList > & | params = null |
||
) |
Constructor specifying local matrix, four maps, import and export objects.
Definition at line 175 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Destructor.
Definition at line 188 of file Xpetra_TpetraCrsMatrix_def.hpp.
Xpetra::TpetraCrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::TpetraCrsMatrix | ( | const TpetraCrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > & | matrix | ) |
Deep copy constructor.
Definition at line 450 of file Xpetra_TpetraCrsMatrix_def.hpp.
Xpetra::TpetraCrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::TpetraCrsMatrix | ( | const Teuchos::RCP< Tpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > & | mtx | ) |
TpetraCrsMatrix constructor to wrap a Tpetra::CrsMatrix object.
Definition at line 550 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Insert matrix entries, using global IDs.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 191 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Insert matrix entries, using local IDs.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 194 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Replace matrix entries, using global IDs.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 197 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Replace matrix entries, using local IDs.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 201 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Set all matrix entries equal to scalarThis.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 216 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Scale the current values of a matrix, this = alpha*this.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 219 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Allocates and returns ArrayRCPs of the Crs arrays — This is an Xpetra-only routine.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 222 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Sets the 1D pointer arrays of the graph.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 226 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Gets the 1D pointer arrays of the graph.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 230 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Gets the 1D pointer arrays of the graph.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 243 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Returns true if globalConstants have been computed; false otherwise.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 253 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 257 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Signal that data entry is complete, specifying domain and range maps.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 260 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Signal that data entry is complete.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 263 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Replaces the current domainMap and importer with the user-specified objects.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 267 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Expert static fill complete.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 275 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Returns the Map that describes the row distribution in this matrix.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 297 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Returns the Map that describes the column distribution in this matrix.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 300 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Returns the CrsGraph associated with this matrix.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 303 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Number of global elements in the row map of this matrix.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 306 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Number of global columns in the matrix.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 309 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Returns the number of matrix rows owned on the calling node.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 312 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Returns the number of columns connected to the locally owned rows of this matrix.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 315 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Returns the global number of entries in this matrix.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 318 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Returns the local number of entries in this matrix.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 321 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Returns the current number of entries on this node in the specified local row.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 324 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Returns the current number of entries in the (locally owned) global row.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 327 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Returns the maximum number of entries across all rows/columns on all nodes.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 330 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Returns the maximum number of entries across all rows/columns on this node.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 333 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
If matrix indices are in the local range, this function returns true. Otherwise, this function returns false.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 336 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
If matrix indices are in the global range, this function returns true. Otherwise, this function returns false.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 339 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Returns true if the matrix is in compute mode, i.e. if fillComplete() has been called.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 342 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Returns true if the matrix is in edit mode.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 345 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Returns the Frobenius norm of the matrix.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 348 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Returns true if getLocalRowView() and getGlobalRowView() are valid for this class.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 351 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Extract a list of entries in a specified local row of the matrix. Put into storage allocated by calling routine.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 354 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Extract a const, non-persisting view of global indices in a specified row of the matrix.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 381 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Extract a list of entries in a specified global row of this matrix. Put into pre-allocated storage.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 367 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Extract a const, non-persisting view of local indices in a specified row of the matrix.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 392 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Computes the sparse matrix-multivector multiplication.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 403 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Computes the matrix-multivector multiplication for region layout matrices.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 406 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Returns the Map associated with the domain of this operator. This will be null until fillComplete() is called.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 429 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Returns the Map associated with the range of this operator, which must be compatible with Y.getMap().
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 432 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
A simple one-line description of this object.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 435 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Print the object with some verbosity level to an FancyOStream object.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 438 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 441 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Get a copy of the diagonal entries owned by this node, with local row indices.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 454 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Get offsets of the diagonal entries in the matrix.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 461 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Get a copy of the diagonal entries owned by this node, with local row indices.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 467 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Replace the diagonal entries of the matrix.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 473 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Left scale operator with given vector values.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 479 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Right scale operator with given vector values.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 485 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Implements DistObject interface.
Access function for the Tpetra::Map this DistObject was constructed with.
Implements Xpetra::DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 491 of file Xpetra_TpetraCrsMatrix_def.hpp.
void Xpetra::TpetraCrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::doImport | ( | const DistObject< char, LocalOrdinal, GlobalOrdinal, Node > & | source, |
const Import< LocalOrdinal, GlobalOrdinal, Node > & | importer, | ||
CombineMode | CM | ||
) |
Definition at line 494 of file Xpetra_TpetraCrsMatrix_def.hpp.
void Xpetra::TpetraCrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::doExport | ( | const DistObject< char, LocalOrdinal, GlobalOrdinal, Node > & | dest, |
const Import< LocalOrdinal, GlobalOrdinal, Node > & | importer, | ||
CombineMode | CM | ||
) |
Definition at line 506 of file Xpetra_TpetraCrsMatrix_def.hpp.
void Xpetra::TpetraCrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::doImport | ( | const DistObject< char, LocalOrdinal, GlobalOrdinal, Node > & | source, |
const Export< LocalOrdinal, GlobalOrdinal, Node > & | exporter, | ||
CombineMode | CM | ||
) |
Import (using an Exporter).
Definition at line 517 of file Xpetra_TpetraCrsMatrix_def.hpp.
void Xpetra::TpetraCrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::doExport | ( | const DistObject< char, LocalOrdinal, GlobalOrdinal, Node > & | dest, |
const Export< LocalOrdinal, GlobalOrdinal, Node > & | exporter, | ||
CombineMode | CM | ||
) |
Export (using an Importer).
Definition at line 528 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 539 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
virtual |
Does this have an underlying matrix.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 545 of file Xpetra_TpetraCrsMatrix_def.hpp.
RCP< const Tpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > Xpetra::TpetraCrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::getTpetra_CrsMatrix |
Get the underlying Tpetra matrix.
Definition at line 553 of file Xpetra_TpetraCrsMatrix_def.hpp.
RCP< Tpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > Xpetra::TpetraCrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::getTpetra_CrsMatrixNonConst |
Get the underlying Tpetra matrix.
Definition at line 557 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
inlinevirtual |
Access the local Kokkos::CrsMatrix data.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 435 of file Xpetra_TpetraCrsMatrix_decl.hpp.
|
inlinevirtual |
Access the local Kokkos::CrsMatrix data.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 439 of file Xpetra_TpetraCrsMatrix_decl.hpp.
|
inline |
Definition at line 443 of file Xpetra_TpetraCrsMatrix_decl.hpp.
|
inlinevirtual |
Returns the block size of the storage mechanism, which is usually 1, except for Tpetra::BlockCrsMatrix.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 451 of file Xpetra_TpetraCrsMatrix_decl.hpp.
|
virtual |
Compute a residual R = B - (*this) * X.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 561 of file Xpetra_TpetraCrsMatrix_def.hpp.
|
private |
Definition at line 461 of file Xpetra_TpetraCrsMatrix_decl.hpp.