|
| AbstractConcreteMatrixAdapter (RCP< matrix_t > m) |
|
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 |
|
global_size_t | getGlobalNNZ_impl () const |
|
size_t | getLocalNNZ_impl () const |
|
size_t | getMaxRowNNZ_impl () const |
|
size_t | getMaxColNNZ_impl () 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 | getGlobalNumRows_impl () const |
|
global_size_t | getGlobalNumCols_impl () const |
|
const RCP< const Tpetra::Map< local_ordinal_t, global_ordinal_t, node_t > > | getRowMap_impl () const |
|
const RCP< const Tpetra::Map< local_ordinal_t, global_ordinal_t, node_t > > | getColMap_impl () const |
|
const RCP< const Teuchos::Comm< int > > | getComm_impl () const |
|
bool | isLocallyIndexed_impl () const |
|
bool | isGloballyIndexed_impl () const |
|
RCP< const super_t > | get_impl (const Teuchos::Ptr< const Tpetra::Map< local_ordinal_t, global_ordinal_t, node_t > > map) const |
|
void | getCrs (const Teuchos::ArrayView< scalar_t > nzval, const Teuchos::ArrayView< global_ordinal_t > colind, const Teuchos::ArrayView< global_size_t > rowptr, global_size_t &nnz, const Teuchos::Ptr< const Tpetra::Map< local_ordinal_t, global_ordinal_t, node_t > > rowmap, EStorage_Ordering ordering=ARBITRARY) const |
| Gets a compressed-row storage summary of this . More...
|
|
void | getCrs (const Teuchos::ArrayView< scalar_t > nzval, const Teuchos::ArrayView< global_ordinal_t > colind, const Teuchos::ArrayView< global_size_t > rowptr, global_size_t &nnz, EDistribution distribution, EStorage_Ordering ordering=ARBITRARY) const |
|
void | getCcs (const Teuchos::ArrayView< scalar_t > nzval, const Teuchos::ArrayView< global_ordinal_t > rowind, const Teuchos::ArrayView< global_size_t > colptr, global_size_t &nnz, const Teuchos::Ptr< const Tpetra::Map< local_ordinal_t, global_ordinal_t, node_t > > colmap, EStorage_Ordering ordering=ARBITRARY) const |
| Gets a compressed-column storage summary of this . More...
|
|
void | getCcs (const Teuchos::ArrayView< scalar_t > nzval, const Teuchos::ArrayView< global_ordinal_t > rowind, const Teuchos::ArrayView< global_size_t > colptr, global_size_t &nnz, EDistribution distribution, EStorage_Ordering ordering=ARBITRARY) 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 | getRowIndexBase () const |
| Get the indexbase for the row map.
|
|
global_size_t | getColumnIndexBase () const |
| Get the indexbase for the column map.
|
|
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 > > | 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) 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.
|
|
template<typename Scalar, typename LocalOrdinal, typename GlobalOrdinal, typename Node, class DerivedMat>
class Amesos2::AbstractConcreteMatrixAdapter< Tpetra::RowMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >, DerivedMat >
Amesos2::MatrixAdapter definitions for objects deriving from Tpetra::RowMatrix.
This class provides definitions for classes that derive from/implement the Tpetra::RowMatrix interface. Most methods required for compliance with the Amesos2::MatrixAdapter interface are defined here. The only method that derived class must define is the get() method, which relies on each derived object knowing how to construct an instance of itself (something which the abstract base class cannot know).