|
| ConcreteMatrixAdapter (Teuchos::RCP< matrix_t > m) |
|
Teuchos::RCP< const MatrixAdapter< matrix_t > > | get_impl (const Teuchos::Ptr< const Tpetra::Map< local_ordinal_t, global_ordinal_t, node_t > > map, EDistribution distribution=ROOTED) const |
|
const Teuchos::RCP< const Teuchos::Comm< int > > | getComm_impl () const |
|
global_size_t | getGlobalNumRows_impl () const |
|
global_size_t | getGlobalNumCols_impl () const |
|
global_size_t | getGlobalNNZ_impl () const |
|
template<class KV > |
void | getSparseRowPtr_kokkos_view (KV &view) const |
|
template<class KV > |
void | getSparseColInd_kokkos_view (KV &view) const |
|
template<class KV > |
void | getSparseValues_kokkos_view (KV &view) const |
|
size_t | getGlobalRowNNZ_impl (global_ordinal_t row) const |
|
size_t | getLocalRowNNZ_impl (local_ordinal_t row) const |
|
size_t | getGlobalColNNZ_impl (global_ordinal_t col) const |
|
size_t | getLocalColNNZ_impl (local_ordinal_t col) const |
|
global_size_t | getRowIndexBase () const |
|
global_size_t | getColumnIndexBase () const |
|
const Teuchos::RCP< const Tpetra::Map< local_ordinal_t, global_ordinal_t, node_t > > | getMap_impl () const |
|
const Teuchos::RCP< const Tpetra::Map< local_ordinal_t, global_ordinal_t, node_t > > | getRowMap_impl () const |
|
const Teuchos::RCP< const Tpetra::Map< local_ordinal_t, global_ordinal_t, node_t > > | getColMap_impl () const |
|
void | getGlobalRowCopy_impl (global_ordinal_t row, const Teuchos::ArrayView< global_ordinal_t > &indices, const Teuchos::ArrayView< scalar_t > &vals, size_t &nnz) const |
|
void | getGlobalColCopy_impl (global_ordinal_t col, const Teuchos::ArrayView< global_ordinal_t > &indices, const Teuchos::ArrayView< scalar_t > &vals, size_t &nnz) const |
|
template<typename KV_GO , typename KV_S > |
void | getGlobalRowCopy_kokkos_view_impl (global_ordinal_t row, KV_GO &indices, KV_S &vals, size_t &nnz) const |
|
void | getCrs_kokkos_view (KV_S &nzval, KV_GO &colind, KV_GS &rowptr, global_size_t &nnz, const Teuchos::Ptr< const Tpetra::Map< local_ordinal_t, global_ordinal_t, node_t > > rowmap, EStorage_Ordering ordering=ARBITRARY, EDistribution distribution=ROOTED) const |
| Gets a compressed-row storage summary of this . More...
|
|
void | getCrs_kokkos_view (KV_S &nzval, KV_GO &colind, KV_GS &rowptr, global_size_t &nnz, EDistribution distribution=ROOTED, EStorage_Ordering ordering=ARBITRARY) const |
|
void | getCrs_kokkos_view (KV_S &nzval, KV_GO &colind, KV_GS &rowptr, typename MatrixAdapter< KokkosSparse::CrsMatrix< Scalar, LocalOrdinal, ExecutionSpace > >::global_size_t &nnz, const Teuchos::Ptr< const Tpetra::Map< local_ordinal_t, global_ordinal_t, node_t > > rowmap, EStorage_Ordering ordering, EDistribution distribution) const |
|
void | getCrs_kokkos_view (KV_S &nzval, KV_GO &colind, KV_GS &rowptr, typename MatrixAdapter< KokkosSparse::CrsMatrix< Scalar, LocalOrdinal, ExecutionSpace > >::global_size_t &nnz, EDistribution distribution, EStorage_Ordering ordering) const |
|
void | getCcs_kokkos_view (KV_S &nzval, KV_GO &rowind, KV_GS &colptr, global_size_t &nnz, const Teuchos::Ptr< const Tpetra::Map< local_ordinal_t, global_ordinal_t, node_t > > colmap, EStorage_Ordering ordering=ARBITRARY, EDistribution distribution=ROOTED) const |
| Gets a compressed-column storage summary of this . More...
|
|
void | getCcs_kokkos_view (KV_S &nzval, KV_GO &rowind, KV_GS &colptr, global_size_t &nnz, EDistribution distribution=ROOTED, EStorage_Ordering ordering=ARBITRARY) const |
|
void | getCcs_kokkos_view (KV_S &nzval, KV_GO &rowind, KV_GS &colptr, typename MatrixAdapter< KokkosSparse::CrsMatrix< Scalar, LocalOrdinal, ExecutionSpace > >::global_size_t &nnz, const Teuchos::Ptr< const Tpetra::Map< local_ordinal_t, global_ordinal_t, node_t > > colmap, EStorage_Ordering ordering, EDistribution distribution) const |
|
void | getCcs_kokkos_view (KV_S &nzval, KV_GO &rowind, KV_GS &colptr, typename MatrixAdapter< KokkosSparse::CrsMatrix< Scalar, LocalOrdinal, ExecutionSpace > >::global_size_t &nnz, EDistribution distribution, EStorage_Ordering ordering) const |
|
const Teuchos::RCP< const Teuchos::Comm< int > > | getComm () const |
| Returns the Teuchos::Comm object associated with this matrix.
|
|
global_size_t | getGlobalNumRows () const |
| Get the number of rows in this matrix.
|
|
global_size_t | getGlobalNumCols () const |
| Get the number of columns in this matrix.
|
|
global_size_t | getGlobalNNZ () const |
| Get the global number of non-zeros in this sparse matrix.
|
|
size_t | getLocalNumRows () const |
| Get the number of rows local to the calling process.
|
|
size_t | getLocalNumCols () const |
| Get the number of columns local to the calling process.
|
|
size_t | getLocalNNZ () const |
| Get the local number of non-zeros on this processor.
|
|
Teuchos::RCP< const Tpetra::Map< local_ordinal_t, global_ordinal_t, node_t > > | getMap () const |
|
Teuchos::RCP< const Tpetra::Map< local_ordinal_t, global_ordinal_t, node_t > > | getRowMap () const |
|
Teuchos::RCP< const Tpetra::Map< local_ordinal_t, global_ordinal_t, node_t > > | getColMap () const |
|
Teuchos::RCP< const type > | get (const Teuchos::Ptr< const Tpetra::Map< local_ordinal_t, global_ordinal_t, node_t > > map, EDistribution distribution=ROOTED) const |
|
std::string | description () const |
| Returns a short description of this Solver.
|
|
void | describe (Teuchos::FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel=Teuchos::Describable::verbLevel_default) const |
| Describes of this matrix adapter with some level of verbosity.
|
|
void | returnRowPtr_kokkos_view (KV &view) const |
| Return kokkos view of CRS row pointer of matrixA_.
|
|
void | returnColInd_kokkos_view (KV &view) const |
| Return kokkos view of CRS column indices of matrixA_.
|
|
void | returnValues_kokkos_view (KV &view) const |
| Return kokkos view of CRS values of matrixA_.
|
|
void | help_getCrs_kokkos_view (KV_S &nzval, KV_GO &colind, KV_GS &rowptr, typename MatrixAdapter< KokkosSparse::CrsMatrix< Scalar, LocalOrdinal, ExecutionSpace > >::global_size_t &nnz, const Teuchos::Ptr< const Tpetra::Map< local_ordinal_t, global_ordinal_t, node_t > > rowmap, EDistribution distribution, EStorage_Ordering ordering, no_special_impl nsi) const |
|
void | do_getCrs_kokkos_view (KV_S &nzval, KV_GO &colind, KV_GS &rowptr, typename MatrixAdapter< KokkosSparse::CrsMatrix< Scalar, LocalOrdinal, ExecutionSpace > >::global_size_t &nnz, const Teuchos::Ptr< const Tpetra::Map< local_ordinal_t, global_ordinal_t, node_t > > rowmap, EDistribution distribution, EStorage_Ordering ordering, row_access ra) const |
|
void | help_getCcs_kokkos_view (KV_S &nzval, KV_GO &rowind, KV_GS &colptr, typename MatrixAdapter< KokkosSparse::CrsMatrix< Scalar, LocalOrdinal, ExecutionSpace > >::global_size_t &nnz, const Teuchos::Ptr< const Tpetra::Map< local_ordinal_t, global_ordinal_t, node_t > > colmap, EDistribution distribution, EStorage_Ordering ordering, no_special_impl nsi) const |
|
void | do_getCcs_kokkos_view (KV_S &nzval, KV_GO &rowind, KV_GS &colptr, typename MatrixAdapter< KokkosSparse::CrsMatrix< Scalar, LocalOrdinal, ExecutionSpace > >::global_size_t &nnz, const Teuchos::Ptr< const Tpetra::Map< local_ordinal_t, global_ordinal_t, node_t > > colmap, EDistribution distribution, EStorage_Ordering ordering, row_access ra) const |
|
template<typename Scalar, typename LocalOrdinal, typename ExecutionSpace>
class Amesos2::ConcreteMatrixAdapter< KokkosSparse::CrsMatrix< Scalar, LocalOrdinal, ExecutionSpace > >
MatrixAdapter definitions for KokkosSparse::CrsMatrix objects.
All other significant functionality is inherited from this class's superclass.