MueLu Version of the Day
|
#include <MueLu_TpetraOperatorAsRowMatrix.hpp>
Public Types | |
using | op_type = Tpetra::Operator<Scalar, LocalOrdinal, GlobalOrdinal, Node> |
using | vec_type = Tpetra::Vector<Scalar, LocalOrdinal, GlobalOrdinal, Node> |
using | row_matrix_type = Tpetra::RowMatrix<Scalar, LocalOrdinal, GlobalOrdinal, Node> |
The RowMatrix representing the base class of CrsMatrix. | |
using | impl_scalar_type = typename row_matrix_type::impl_scalar_type |
using | mag_type = typename Kokkos::ArithTraits<impl_scalar_type>::mag_type |
using | local_inds_device_view_type |
using | local_inds_host_view_type |
using | nonconst_local_inds_host_view_type |
using | global_inds_device_view_type |
using | global_inds_host_view_type |
using | nonconst_global_inds_host_view_type |
using | values_device_view_type |
using | values_host_view_type |
using | nonconst_values_host_view_type |
Constructor/Destructor | |
RCP< op_type > | op_ |
RCP< vec_type > | diag_ |
TpetraOperatorAsRowMatrix (const RCP< op_type > &op) | |
Constructor. | |
TpetraOperatorAsRowMatrix (const RCP< op_type > &op, const RCP< vec_type > &diag) | |
Teuchos::RCP< const Tpetra::Map< LocalOrdinal, GlobalOrdinal, Node > > | getDomainMap () const |
Returns the Tpetra::Map object associated with the domain of this operator. | |
Teuchos::RCP< const Tpetra::Map< LocalOrdinal, GlobalOrdinal, Node > > | getRangeMap () const |
Returns the Tpetra::Map object associated with the range of this operator. | |
void | apply (const Tpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &X, Tpetra::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 |
Returns in Y the result of a Tpetra::Operator applied to a Tpetra::MultiVector X. | |
Teuchos::RCP< const Tpetra::Map< LocalOrdinal, GlobalOrdinal, Node > > | getRowMap () const |
Teuchos::RCP< const Tpetra::Map< LocalOrdinal, GlobalOrdinal, Node > > | getColMap () const |
Teuchos::RCP< const Teuchos::Comm< int > > | getComm () const |
Teuchos::RCP< const Tpetra::RowGraph< LocalOrdinal, GlobalOrdinal, Node > > | getGraph () const |
Tpetra::global_size_t | getGlobalNumRows () const |
Tpetra::global_size_t | getGlobalNumCols () const |
size_t | getLocalNumRows () const |
size_t | getLocalNumCols () const |
GlobalOrdinal | getIndexBase () const |
Tpetra::global_size_t | getGlobalNumEntries () const |
size_t | getLocalNumEntries () const |
size_t | getNumEntriesInGlobalRow (GlobalOrdinal globalRow) const |
size_t | getNumEntriesInLocalRow (LocalOrdinal localRow) const |
size_t | getGlobalMaxNumRowEntries () const |
size_t | getLocalMaxNumRowEntries () const |
bool | hasColMap () const |
bool | isLocallyIndexed () const |
bool | isGloballyIndexed () const |
bool | isFillComplete () const |
bool | supportsRowViews () const |
void | getGlobalRowCopy (GlobalOrdinal GlobalRow, nonconst_global_inds_host_view_type &Indices, nonconst_values_host_view_type &Values, size_t &NumEntries) const |
void | getLocalRowCopy (LocalOrdinal LocalRow, nonconst_local_inds_host_view_type &Indices, nonconst_values_host_view_type &Values, size_t &NumEntries) const |
void | getGlobalRowView (GlobalOrdinal GlobalRow, global_inds_host_view_type &indices, values_host_view_type &values) const |
void | getLocalRowView (LocalOrdinal LocalRow, local_inds_host_view_type &indices, values_host_view_type &values) const |
void | getLocalDiagCopy (Tpetra::Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &diag) const |
void | leftScale (const Tpetra::Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &x) |
void | rightScale (const Tpetra::Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &x) |
mag_type | getFrobeniusNorm () const |
Definition at line 53 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
using MueLu::TpetraOperatorAsRowMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::op_type = Tpetra::Operator<Scalar, LocalOrdinal, GlobalOrdinal, Node> |
Definition at line 56 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
using MueLu::TpetraOperatorAsRowMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::vec_type = Tpetra::Vector<Scalar, LocalOrdinal, GlobalOrdinal, Node> |
Definition at line 57 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
using MueLu::TpetraOperatorAsRowMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::row_matrix_type = Tpetra::RowMatrix<Scalar, LocalOrdinal, GlobalOrdinal, Node> |
The RowMatrix representing the base class of CrsMatrix.
Definition at line 60 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
using MueLu::TpetraOperatorAsRowMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::impl_scalar_type = typename row_matrix_type::impl_scalar_type |
Definition at line 62 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
using MueLu::TpetraOperatorAsRowMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::mag_type = typename Kokkos::ArithTraits<impl_scalar_type>::mag_type |
Definition at line 63 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
using MueLu::TpetraOperatorAsRowMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::local_inds_device_view_type |
Definition at line 65 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
using MueLu::TpetraOperatorAsRowMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::local_inds_host_view_type |
Definition at line 67 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
using MueLu::TpetraOperatorAsRowMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::nonconst_local_inds_host_view_type |
Definition at line 69 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
using MueLu::TpetraOperatorAsRowMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::global_inds_device_view_type |
Definition at line 72 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
using MueLu::TpetraOperatorAsRowMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::global_inds_host_view_type |
Definition at line 74 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
using MueLu::TpetraOperatorAsRowMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::nonconst_global_inds_host_view_type |
Definition at line 76 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
using MueLu::TpetraOperatorAsRowMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::values_device_view_type |
Definition at line 79 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
using MueLu::TpetraOperatorAsRowMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::values_host_view_type |
Definition at line 81 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
using MueLu::TpetraOperatorAsRowMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >::nonconst_values_host_view_type |
Definition at line 83 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
|
inline |
Constructor.
Definition at line 90 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
|
inline |
Definition at line 96 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
|
inline |
Returns the Tpetra::Map object associated with the domain of this operator.
Definition at line 104 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
|
inline |
Returns the Tpetra::Map object associated with the range of this operator.
Definition at line 109 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
|
inline |
Returns in Y the result of a Tpetra::Operator applied to a Tpetra::MultiVector X.
[in] | X | - Tpetra::MultiVector of dimension NumVectors to multiply with matrix. |
[out] | Y | -Tpetra::MultiVector of dimension NumVectors containing result. |
Definition at line 118 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
|
inline |
Definition at line 127 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
|
inline |
Definition at line 131 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
|
inline |
Definition at line 135 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
|
inline |
Definition at line 139 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
|
inline |
Definition at line 143 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
|
inline |
Definition at line 147 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
|
inline |
Definition at line 151 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
|
inline |
Definition at line 155 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
|
inline |
Definition at line 159 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
|
inline |
Definition at line 163 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
|
inline |
Definition at line 167 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
|
inline |
Definition at line 171 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
|
inline |
Definition at line 175 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
|
inline |
Definition at line 179 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
|
inline |
Definition at line 183 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
|
inline |
Definition at line 187 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
|
inline |
Definition at line 191 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
|
inline |
Definition at line 195 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
|
inline |
Definition at line 199 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
|
inline |
Definition at line 203 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
|
inline |
Definition at line 208 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
|
inline |
Definition at line 216 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
|
inline |
Definition at line 224 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
|
inline |
Definition at line 231 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
|
inline |
Definition at line 237 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
|
inline |
Definition at line 244 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
|
inline |
Definition at line 248 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
|
inline |
Definition at line 252 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
|
private |
Definition at line 279 of file MueLu_TpetraOperatorAsRowMatrix.hpp.
|
private |
Definition at line 280 of file MueLu_TpetraOperatorAsRowMatrix.hpp.