#include <Xpetra_TpetraBlockCrsMatrix.hpp>
Public Member Functions | |
void | getLocalDiagCopy (Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &diag) const |
Deep copy constructor. More... | |
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 |
Get a copy of the diagonal entries owned by this node, with local row indices. More... | |
void | replaceDiag (const Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &diag) |
Replace the diagonal entries of the matrix. More... | |
void | leftScale (const Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &x) |
Left scale operator with given vector values. More... | |
void | rightScale (const Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &x) |
Right scale operator with given vector values. More... | |
Teuchos::RCP< const Map < LocalOrdinal, GlobalOrdinal, Node > > | getMap () const |
Implements DistObject interface. More... | |
void | doImport (const DistObject< char, LocalOrdinal, GlobalOrdinal, Node > &source, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, CombineMode CM) |
Import. More... | |
void | doExport (const DistObject< char, LocalOrdinal, GlobalOrdinal, Node > &dest, const Import< LocalOrdinal, GlobalOrdinal, Node > &importer, CombineMode CM) |
Export. More... | |
void | doImport (const DistObject< char, LocalOrdinal, GlobalOrdinal, Node > &source, const Export< LocalOrdinal, GlobalOrdinal, Node > &exporter, CombineMode CM) |
Import (using an Exporter). More... | |
void | doExport (const DistObject< char, LocalOrdinal, GlobalOrdinal, Node > &dest, const Export< LocalOrdinal, GlobalOrdinal, Node > &exporter, CombineMode CM) |
Export (using an Importer). More... | |
void | removeEmptyProcessesInPlace (const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &newMap) |
Public Member Functions inherited from Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > | |
virtual | ~CrsMatrix () |
Destructor. More... | |
Public Member Functions inherited from Xpetra::RowMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > | |
virtual | ~RowMatrix () |
Destructor. More... | |
Public Member Functions inherited from Xpetra::DistObject< char, LocalOrdinal, GlobalOrdinal, Node > | |
virtual | ~DistObject () |
Destructor. More... | |
Public Member Functions inherited from Teuchos::Describable | |
void | describe (std::ostream &out, const EVerbosityLevel verbLevel=verbLevel_default) const |
virtual | ~Describable () |
LabeledObject () | |
virtual | ~LabeledObject () |
virtual std::string | getObjectLabel () const |
DescribableStreamManipulatorState | describe (const Describable &describable, const EVerbosityLevel verbLevel=Describable::verbLevel_default) |
std::ostream & | operator<< (std::ostream &os, const DescribableStreamManipulatorState &d) |
Private Types | |
typedef TpetraBlockCrsMatrix < Scalar, LocalOrdinal, GlobalOrdinal, Node > | TpetraBlockCrsMatrixClass |
typedef TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > | TpetraVectorClass |
typedef TpetraImport < LocalOrdinal, GlobalOrdinal, Node > | TpetraImportClass |
typedef TpetraExport < LocalOrdinal, GlobalOrdinal, Node > | TpetraExportClass |
Private Attributes | |
RCP < Tpetra::Experimental::BlockCrsMatrix < Scalar, LocalOrdinal, GlobalOrdinal, Node > > | mtx_ |
Constructor/Destructor Methods | |
TpetraBlockCrsMatrix (const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &rowMap, size_t maxNumEntriesPerRow, ProfileType pftype=DynamicProfile, const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) | |
Constructor specifying fixed number of entries for each row (not implemented) More... | |
TpetraBlockCrsMatrix (const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &rowMap, const ArrayRCP< const size_t > &NumEntriesPerRowToAlloc, ProfileType pftype=DynamicProfile, const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) | |
Constructor specifying (possibly different) number of entries in each row (not implemented) More... | |
TpetraBlockCrsMatrix (const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &rowMap, const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &colMap, size_t maxNumEntriesPerRow, ProfileType pftype=DynamicProfile, const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) | |
Constructor specifying column Map and fixed number of entries for each row (not implemented) More... | |
TpetraBlockCrsMatrix (const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &rowMap, const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &colMap, const ArrayRCP< const size_t > &NumEntriesPerRowToAlloc, ProfileType pftype=DynamicProfile, const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) | |
Constructor specifying column Map and number of entries in each row (not implemented) More... | |
TpetraBlockCrsMatrix (const Teuchos::RCP< const CrsGraph< LocalOrdinal, GlobalOrdinal, Node > > &graph, const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) | |
Constructor specifying a previously constructed graph ( not implemented ) More... | |
TpetraBlockCrsMatrix (const Teuchos::RCP< const CrsGraph< LocalOrdinal, GlobalOrdinal, Node > > &graph, const LocalOrdinal blockSize) | |
Constructor specifying a previously constructed graph & blocksize. More... | |
TpetraBlockCrsMatrix (const Teuchos::RCP< const Tpetra::Experimental::BlockCrsMatrix< 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) | |
Constructor for a fused import ( not implemented ) More... | |
TpetraBlockCrsMatrix (const Teuchos::RCP< const Tpetra::Experimental::BlockCrsMatrix< 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) | |
Constructor for a fused export (not implemented(. More... | |
TpetraBlockCrsMatrix (const Teuchos::RCP< const Tpetra::Experimental::BlockCrsMatrix< 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) | |
Constructor for a fused import ( not implemented ) More... | |
TpetraBlockCrsMatrix (const Teuchos::RCP< const Tpetra::Experimental::BlockCrsMatrix< 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) | |
Constructor for a fused export (not implemented(. More... | |
virtual | ~TpetraBlockCrsMatrix () |
Destructor. More... | |
Insertion/Removal Methods | |
void | insertGlobalValues (GlobalOrdinal globalRow, const ArrayView< const GlobalOrdinal > &cols, const ArrayView< const Scalar > &vals) |
Insert matrix entries, using global IDs (not implemented) More... | |
void | insertLocalValues (LocalOrdinal localRow, const ArrayView< const LocalOrdinal > &cols, const ArrayView< const Scalar > &vals) |
Insert matrix entries, using local IDs (not implemented) More... | |
void | replaceGlobalValues (GlobalOrdinal globalRow, const ArrayView< const GlobalOrdinal > &cols, const ArrayView< const Scalar > &vals) |
Replace matrix entries, using global IDs (not implemented) More... | |
void | replaceLocalValues (LocalOrdinal localRow, const ArrayView< const LocalOrdinal > &cols, const ArrayView< const Scalar > &vals) |
Replace matrix entries, using local IDs. More... | |
void | setAllToScalar (const Scalar &alpha) |
Set all matrix entries equal to scalarThis. More... | |
void | scale (const Scalar &alpha) |
Scale the current values of a matrix, this = alpha*this (not implemented) More... | |
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. More... | |
void | setAllValues (const ArrayRCP< size_t > &rowptr, const ArrayRCP< LocalOrdinal > &colind, const ArrayRCP< Scalar > &values) |
Sets the 1D pointer arrays of the graph (not impelmented) More... | |
void | getAllValues (ArrayRCP< const size_t > &rowptr, ArrayRCP< const LocalOrdinal > &colind, ArrayRCP< const Scalar > &values) const |
Gets the 1D pointer arrays of the graph (not implemented) More... | |
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. More... | |
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) |
Replaces the current domainMap and importer with the user-specified objects. 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) |
Expert static fill complete. More... | |
Methods implementing RowMatrix | |
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 columns connected to the locally owned rows of this matrix. 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 |
Returns the current number of entries on this node in the specified local 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 |
Extract a list of entries in a specified local row of the matrix. Put into storage allocated by calling routine. More... | |
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. More... | |
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. More... | |
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. More... | |
virtual bool | haveGlobalConstants () const |
Returns true if globalConstants have been computed; false otherwise. More... | |
Methods implementing Operator | |
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 |
Computes the sparse matrix-multivector multiplication. More... | |
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... | |
Overridden from Teuchos::Describable | |
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... | |
Overridden from Teuchos::LabeledObject | |
void | setObjectLabel (const std::string &objectLabel) |
Xpetra specific | |
bool | hasMatrix () const |
Does this have an underlying matrix. More... | |
TpetraBlockCrsMatrix (const Teuchos::RCP< Tpetra::Experimental::BlockCrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &mtx) | |
TpetraBlockCrsMatrix constructor to wrap a Tpetra::BlockCrsMatrix object. More... | |
RCP< const Tpetra::Experimental::BlockCrsMatrix < Scalar, LocalOrdinal, GlobalOrdinal, Node > > | getTpetra_BlockCrsMatrix () const |
Get the underlying Tpetra matrix. More... | |
RCP < Tpetra::Experimental::BlockCrsMatrix < Scalar, LocalOrdinal, GlobalOrdinal, Node > > | getTpetra_BlockCrsMatrixNonConst () const |
Get the underlying Tpetra matrix. More... | |
Additional Inherited Members | |
Public Types inherited from Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > | |
typedef Scalar | scalar_type |
typedef LocalOrdinal | local_ordinal_type |
typedef GlobalOrdinal | global_ordinal_type |
typedef Node | node_type |
Public Types inherited from Xpetra::RowMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > | |
typedef Scalar | scalar_type |
typedef LocalOrdinal | local_ordinal_type |
typedef GlobalOrdinal | global_ordinal_type |
typedef Node | node_type |
Static Public Attributes inherited from Teuchos::Describable | |
static const EVerbosityLevel | verbLevel_default |
Definition at line 68 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
private |
Definition at line 73 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
private |
Definition at line 74 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
private |
Definition at line 75 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
private |
Definition at line 76 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inline |
Constructor specifying fixed number of entries for each row (not implemented)
Definition at line 84 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inline |
Constructor specifying (possibly different) number of entries in each row (not implemented)
Definition at line 88 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inline |
Constructor specifying column Map and fixed number of entries for each row (not implemented)
Definition at line 92 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inline |
Constructor specifying column Map and number of entries in each row (not implemented)
Definition at line 96 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inline |
Constructor specifying a previously constructed graph ( not implemented )
Definition at line 100 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inline |
Constructor specifying a previously constructed graph & blocksize.
Definition at line 105 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inline |
Constructor for a fused import ( not implemented )
Definition at line 112 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inline |
Constructor for a fused export (not implemented(.
Definition at line 120 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inline |
Constructor for a fused import ( not implemented )
Definition at line 128 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inline |
Constructor for a fused export (not implemented(.
Definition at line 137 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Destructor.
Definition at line 146 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inline |
TpetraBlockCrsMatrix constructor to wrap a Tpetra::BlockCrsMatrix object.
Definition at line 442 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Insert matrix entries, using global IDs (not implemented)
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 154 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Insert matrix entries, using local IDs (not implemented)
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 158 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Replace matrix entries, using global IDs (not implemented)
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 162 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Replace matrix entries, using local IDs.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 166 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Set all matrix entries equal to scalarThis.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 173 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Scale the current values of a matrix, this = alpha*this (not implemented)
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 176 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Allocates and returns ArrayRCPs of the Crs arrays — This is an Xpetra-only routine.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 181 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Sets the 1D pointer arrays of the graph (not impelmented)
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 185 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Gets the 1D pointer arrays of the graph (not implemented)
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 189 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 198 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Signal that data entry is complete, specifying domain and range maps.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 201 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Signal that data entry is complete.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 204 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Replaces the current domainMap and importer with the user-specified objects.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 208 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Expert static fill complete.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 212 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Returns the Map that describes the row distribution in this matrix.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 225 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Returns the Map that describes the column distribution in this matrix.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 228 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Returns the CrsGraph associated with this matrix.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 231 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Number of global elements in the row map of this matrix.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 235 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Number of global columns in the matrix.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 238 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Returns the number of matrix rows owned on the calling node.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 241 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Returns the number of columns connected to the locally owned rows of this matrix.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 244 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Returns the global number of entries in this matrix.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 247 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Returns the local number of entries in this matrix.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 250 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Returns the current number of entries on this node in the specified local row.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 253 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Returns the maximum number of entries across all rows/columns on all nodes.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 256 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Returns the maximum number of entries across all rows/columns on this node.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 259 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
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 262 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
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 265 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
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 268 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Returns true if the matrix is in edit mode.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 271 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Returns the Frobenius norm of the matrix.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 274 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Returns true if getLocalRowView() and getGlobalRowView() are valid for this class.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 277 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
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 280 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
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 283 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
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 286 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
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 289 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Returns true if globalConstants have been computed; false otherwise.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 292 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Computes the sparse matrix-multivector multiplication.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 301 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
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 304 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
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 307 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
A simple one-line description of this object.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 315 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Print the object with some verbosity level to an FancyOStream object.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 318 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 324 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Deep copy constructor.
Get a copy of the diagonal entries owned by this node, with local row idices {
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 338 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Get offsets of the diagonal entries in the matrix.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 346 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
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 380 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Replace the diagonal entries of the matrix.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 383 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Left scale operator with given vector values.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 388 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Right scale operator with given vector values.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 393 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Implements DistObject interface.
Access function for the Tpetra::Map this DistObject was constructed with.
Implements Xpetra::DistObject< char, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 401 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Implements Xpetra::DistObject< char, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 404 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Implements Xpetra::DistObject< char, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 409 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Import (using an Exporter).
Implements Xpetra::DistObject< char, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 414 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Export (using an Importer).
Implements Xpetra::DistObject< char, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 419 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 423 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inlinevirtual |
Does this have an underlying matrix.
Implements Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >.
Definition at line 439 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inline |
Get the underlying Tpetra matrix.
Definition at line 445 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
inline |
Get the underlying Tpetra matrix.
Definition at line 448 of file Xpetra_TpetraBlockCrsMatrix.hpp.
|
private |
Definition at line 474 of file Xpetra_TpetraBlockCrsMatrix.hpp.