|
virtual bool | isDiagonal () const |
|
virtual size_t | Rows () const |
| number of row blocks
|
|
virtual size_t | Cols () const |
| number of column blocks
|
|
Teuchos::RCP< Matrix > | getCrsMatrix () const |
| return unwrap 1x1 blocked operators
|
|
Teuchos::RCP< Matrix > | getInnermostCrsMatrix () |
| helper routine recursively returns the first inner-most non-null matrix block from a (nested) blocked operator
|
|
Teuchos::RCP< Matrix > | getMatrix (size_t r, size_t c) const |
| return block (r,c)
|
|
void | setMatrix (size_t r, size_t c, Teuchos::RCP< Matrix > mat) |
| set matrix block
|
|
Teuchos::RCP< Matrix > | Merge () const |
| merge BlockedCrsMatrix blocks in a CrsMatrix
|
|
local_matrix_type | getLocalMatrixDevice () const |
| Access the underlying local Kokkos::CrsMatrix object.
|
|
local_matrix_type::HostMirror | getLocalMatrixHost () const |
| Access the underlying local Kokkos::CrsMatrix object.
|
|
LocalOrdinal | GetStorageBlockSize () const |
| Returns the block size of the storage mechanism.
|
|
void | residual (const MultiVector &X, const MultiVector &B, MultiVector &R) const |
| Compute a residual R = B - (*this) * X.
|
|
| BlockedCrsMatrix (const Teuchos::RCP< const BlockedMap > &rangeMaps, const Teuchos::RCP< const BlockedMap > &domainMaps, size_t numEntriesPerRow) |
| Constructor.
|
|
| BlockedCrsMatrix (Teuchos::RCP< const MapExtractor > &rangeMapExtractor, Teuchos::RCP< const MapExtractor > &domainMapExtractor, size_t numEntriesPerRow) |
| Constructor.
|
|
virtual | ~BlockedCrsMatrix () |
| Destructor.
|
|
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 | removeEmptyProcessesInPlace (const Teuchos::RCP< const Map > &newMap) |
|
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.
|
|
virtual void | setAllToScalar (const Scalar &alpha) |
| Set all matrix entries equal to scalar.
|
|
void | scale (const Scalar &alpha) |
| Scale the current values of a matrix, this = alpha*this.
|
|
void | resumeFill (const RCP< ParameterList > ¶ms=null) |
|
void | fillComplete (const RCP< const Map > &domainMap, const RCP< const Map > &rangeMap, const RCP< ParameterList > ¶ms=null) |
| Signal that data entry is complete.
|
|
void | fillComplete (const RCP< ParameterList > ¶ms=null) |
| Signal that data entry is complete.
|
|
global_size_t | getGlobalNumRows () const |
| Returns the number of global rows.
|
|
global_size_t | getGlobalNumCols () const |
| Returns the number of global columns in the matrix.
|
|
size_t | getLocalNumRows () const |
| Returns the number of matrix rows owned on the calling node.
|
|
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 specified (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 of all matrix blocks 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 fillComplete() has been called and the matrix is in compute mode.
|
|
virtual 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 | 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.
|
|
void | getLocalDiagCopy (Vector &diag) const |
| Get a copy of the diagonal entries owned by this node, with local row indices.
|
|
void | leftScale (const Vector &x) |
| Left scale matrix using the given vector entries.
|
|
void | rightScale (const Vector &x) |
| Right scale matrix using the given vector entries.
|
|
virtual ScalarTraits< Scalar >::magnitudeType | getFrobeniusNorm () const |
| Get Frobenius norm of the matrix.
|
|
virtual bool | haveGlobalConstants () const |
| Returns true if globalConstants have been computed; false otherwise.
|
|
RCP< const Map > | getFullDomainMap () const |
| Returns the Map associated with the full domain of this operator.
|
|
RCP< const BlockedMap > | getBlockedDomainMap () const |
| Returns the BlockedMap associated with the domain of this operator.
|
|
RCP< const Map > | getDomainMap () const |
| Returns the Map associated with the domain of this operator.
|
|
RCP< const Map > | getDomainMap (size_t i) const |
| Returns the Map associated with the i'th block domain of this operator.
|
|
RCP< const Map > | getDomainMap (size_t i, bool bThyraMode) const |
| Returns the Map associated with the i'th block domain of this operator.
|
|
RCP< const Map > | getFullRangeMap () const |
| Returns the Map associated with the full range of this operator.
|
|
RCP< const BlockedMap > | getBlockedRangeMap () const |
| Returns the BlockedMap associated with the range of this operator.
|
|
RCP< const Map > | getRangeMap () const |
| Returns the Map associated with the range of this operator.
|
|
RCP< const Map > | getRangeMap (size_t i) const |
| Returns the Map associated with the i'th block range of this operator.
|
|
RCP< const Map > | getRangeMap (size_t i, bool bThyraMode) const |
| Returns the Map associated with the i'th block range of this operator.
|
|
RCP< const MapExtractor > | getRangeMapExtractor () const |
| Returns map extractor class for range map.
|
|
RCP< const MapExtractor > | getDomainMapExtractor () const |
| Returns map extractor for domain map.
|
|
virtual void | bgs_apply (const MultiVector &X, MultiVector &Y, size_t row, Teuchos::ETransp mode=Teuchos::NO_TRANS, Scalar alpha=ScalarTraits< Scalar >::one(), Scalar beta=ScalarTraits< Scalar >::zero()) const |
| Special multiplication routine (for BGS/Jacobi smoother)
|
|
const Teuchos::RCP< const Map > | getMap () const |
| Implements DistObject interface.
|
|
void | doImport (const Matrix &source, const Import &importer, CombineMode CM) |
| Import.
|
|
void | doExport (const Matrix &dest, const Import &importer, CombineMode CM) |
| Export.
|
|
void | doImport (const Matrix &source, const Export &exporter, CombineMode CM) |
| Import (using an Exporter).
|
|
void | doExport (const Matrix &dest, const Export &exporter, CombineMode CM) |
| Export (using an Importer).
|
|
void | setObjectLabel (const std::string &objectLabel) |
|
bool | hasCrsGraph () const |
| Supports the getCrsGraph() call.
|
|
RCP< const CrsGraph > | getCrsGraph () const |
| Returns the CrsGraph associated with this matrix.
|
|
void | SetFixedBlockSize (LocalOrdinal blksize, GlobalOrdinal offset=0) |
|
LocalOrdinal | GetFixedBlockSize () const |
|
bool | IsFixedBlockSizeSet () const |
| Returns true, if SetFixedBlockSize has been called before.
|
|
virtual void | SetMaxEigenvalueEstimate (Scalar const &sigma) |
|
virtual Scalar | GetMaxEigenvalueEstimate () const |
|
| Matrix () |
|
virtual | ~Matrix () |
| Destructor.
|
|
void | CreateView (viewLabel_t viewLabel, const RCP< const Map > &rowMap, const RCP< const Map > &colMap) |
|
void | CreateView (const viewLabel_t viewLabel, const RCP< const Matrix > &A, bool transposeA=false, const RCP< const Matrix > &B=Teuchos::null, bool transposeB=false) |
|
void | PrintViews (Teuchos::FancyOStream &out) const |
| Print all of the views associated with the Matrix.
|
|
void | RemoveView (const viewLabel_t viewLabel) |
|
const viewLabel_t | SwitchToView (const viewLabel_t viewLabel) |
|
bool | IsView (const viewLabel_t viewLabel) const |
|
const viewLabel_t | SwitchToDefaultView () |
|
const viewLabel_t & | GetDefaultViewLabel () const |
|
const viewLabel_t & | GetCurrentViewLabel () const |
|
virtual const RCP< const Map > & | getRowMap () const |
| Returns the Map that describes the row distribution in this matrix.
|
|
virtual const RCP< const Map > & | getRowMap (viewLabel_t viewLabel) const |
| Returns the Map that describes the row distribution in this matrix.
|
|
virtual const RCP< const Map > & | getColMap () const |
| Returns the Map that describes the column distribution in this matrix. This might be null until fillComplete() is called.
|
|
virtual const RCP< const Map > & | getColMap (viewLabel_t viewLabel) const |
| Returns the Map that describes the column distribution in this matrix.
|
|
virtual | ~Operator () |
|
virtual bool | hasTransposeApply () const |
| Whether this operator supports applying the transpose or conjugate transpose.
|
|
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) |
|
void | describe (std::ostream &out, const EVerbosityLevel verbLevel=verbLevel_default) const |
|
virtual | ~Describable () |
|
| LabeledObject () |
|
virtual | ~LabeledObject () |
|
virtual std::string | getObjectLabel () const |
|
static const EVerbosityLevel | verbLevel_default |
|
Teuchos::Hashtable< viewLabel_t, RCP< MatrixView > > | operatorViewTable_ |
|
viewLabel_t | defaultViewLabel_ |
|
viewLabel_t | currentViewLabel_ |
|
template<class Scalar, class LocalOrdinal, class GlobalOrdinal, class Node = KokkosClassic::DefaultNode::DefaultNodeType>
class Xpetra::ReorderedBlockedCrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >
Definition at line 74 of file Xpetra_ReorderedBlockedCrsMatrix.hpp.