| Amesos2 - Direct Sparse Solver Interfaces
    Version of the Day
    | 
A Matrix adapter interface for Amesos2. More...
#include <Amesos2_MatrixAdapter_decl.hpp>

| Public Types | |
| typedef MatrixTraits< Matrix > ::scalar_t | scalar_t | 
| typedef MatrixTraits< Matrix > ::local_ordinal_t | local_ordinal_t | 
| typedef MatrixTraits< Matrix > ::global_ordinal_t | global_ordinal_t | 
| typedef MatrixTraits< Matrix > ::node_t | node_t | 
| typedef Tpetra::global_size_t | global_size_t | 
| typedef Matrix | matrix_t | 
| typedef MatrixAdapter< Matrix > | type | 
| typedef ConcreteMatrixAdapter < Matrix > | adapter_t | 
| typedef Tpetra::Map < local_ordinal_t, global_ordinal_t, node_t > | map_t | 
| typedef MatrixTraits< Matrix > ::global_host_idx_type | global_host_idx_t | 
| typedef MatrixTraits< Matrix > ::global_host_val_type | global_host_val_t | 
| Public Member Functions | |
| MatrixAdapter (Teuchos::RCP< Matrix > m) | |
| template<typename KV_S , typename KV_GO , typename KV_GS > | |
| void | getCrs_kokkos_view (KV_S &nzval, KV_GO &colind, KV_GS &rowptr, global_size_t &nnz, const Teuchos::Ptr< const map_t > rowmap, EStorage_Ordering ordering=ARBITRARY, EDistribution distribution=ROOTED) const | 
| Gets a compressed-row storage summary of this.  More... | |
| template<typename KV_S , typename KV_GO , typename KV_GS > | |
| 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 | 
| template<typename KV_S , typename KV_GO , typename KV_GS > | |
| void | getCcs_kokkos_view (KV_S &nzval, KV_GO &rowind, KV_GS &colptr, global_size_t &nnz, const Teuchos::Ptr< const map_t > colmap, EStorage_Ordering ordering=ARBITRARY, EDistribution distribution=ROOTED) const | 
| Gets a compressed-column storage summary of this.  More... | |
| template<typename KV_S , typename KV_GO , typename KV_GS > | |
| 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 | 
| 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 map_t > | getMap () const | 
| Teuchos::RCP< const map_t > | getRowMap () const | 
| Teuchos::RCP< const map_t > | getColMap () const | 
| Teuchos::RCP< const type > | get (const Teuchos::Ptr< const map_t > map, EDistribution distribution=ROOTED) const | 
| Teuchos::RCP< const type > | reindex (Teuchos::RCP< const map_t > &contigRowMap, Teuchos::RCP< const map_t > &contigColMap, const EPhase current_phase) const | 
| template<typename KV_S , typename KV_GO , typename KV_GS , typename host_ordinal_type_array , typename host_scalar_type_array > | |
| local_ordinal_t | gather (KV_S &nzvals, KV_GO &indices, KV_GS &pointers, host_ordinal_type_array &perm_g2l, host_ordinal_type_array &recvCountRows, host_ordinal_type_array &recvDisplRows, host_ordinal_type_array &recvCounts, host_ordinal_type_array &recvDispls, host_ordinal_type_array &transpose_map, host_scalar_type_array &nzvals_t, bool column_major, EPhase current_phase) const | 
| Gather matrix to MPI-0. | |
| 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 KV > | |
| void | returnRowPtr_kokkos_view (KV &view) const | 
| Return kokkos view of CRS row pointer of matrixA_. | |
| template<typename KV > | |
| void | returnColInd_kokkos_view (KV &view) const | 
| Return kokkos view of CRS column indices of matrixA_. | |
| template<typename KV > | |
| void | returnValues_kokkos_view (KV &view) const | 
| Return kokkos view of CRS values of matrixA_. | |
| template<typename KV_S , typename KV_GO , typename KV_GS > | |
| void | getCrs_kokkos_view (KV_S &nzval, KV_GO &colind, KV_GS &rowptr, typename MatrixAdapter< Matrix >::global_size_t &nnz, const Teuchos::Ptr< const map_t > rowmap, EStorage_Ordering ordering, EDistribution distribution) const | 
| template<typename KV_S , typename KV_GO , typename KV_GS > | |
| void | getCrs_kokkos_view (KV_S &nzval, KV_GO &colind, KV_GS &rowptr, typename MatrixAdapter< Matrix >::global_size_t &nnz, EDistribution distribution, EStorage_Ordering ordering) const | 
| template<typename KV_S , typename KV_GO , typename KV_GS > | |
| void | getCcs_kokkos_view (KV_S &nzval, KV_GO &rowind, KV_GS &colptr, typename MatrixAdapter< Matrix >::global_size_t &nnz, const Teuchos::Ptr< const map_t > colmap, EStorage_Ordering ordering, EDistribution distribution) const | 
| template<typename KV_S , typename KV_GO , typename KV_GS > | |
| void | getCcs_kokkos_view (KV_S &nzval, KV_GO &rowind, KV_GS &colptr, typename MatrixAdapter< Matrix >::global_size_t &nnz, EDistribution distribution, EStorage_Ordering ordering) const | 
| template<typename KV_S , typename KV_GO , typename KV_GS > | |
| void | help_getCrs_kokkos_view (KV_S &nzval, KV_GO &colind, KV_GS &rowptr, typename MatrixAdapter< Matrix >::global_size_t &nnz, const Teuchos::Ptr< const map_t > rowmap, EDistribution distribution, EStorage_Ordering ordering, no_special_impl nsi) const | 
| template<typename KV_S , typename KV_GO , typename KV_GS > | |
| void | do_getCrs_kokkos_view (KV_S &nzval, KV_GO &colind, KV_GS &rowptr, typename MatrixAdapter< Matrix >::global_size_t &nnz, const Teuchos::Ptr< const map_t > rowmap, EDistribution distribution, EStorage_Ordering ordering, row_access ra) const | 
| template<typename KV_S , typename KV_GO , typename KV_GS > | |
| void | help_getCcs_kokkos_view (KV_S &nzval, KV_GO &rowind, KV_GS &colptr, typename MatrixAdapter< Matrix >::global_size_t &nnz, const Teuchos::Ptr< const map_t > colmap, EDistribution distribution, EStorage_Ordering ordering, no_special_impl nsi) const | 
| template<typename KV_S , typename KV_GO , typename KV_GS > | |
| void | do_getCcs_kokkos_view (KV_S &nzval, KV_GO &rowind, KV_GS &colptr, typename MatrixAdapter< Matrix >::global_size_t &nnz, const Teuchos::Ptr< const map_t > colmap, EDistribution distribution, EStorage_Ordering ordering, row_access ra) const | 
| template<typename KV_S , typename KV_GO , typename KV_GS , typename host_ordinal_type_array , typename host_scalar_type_array > | |
| MatrixAdapter< Matrix > ::local_ordinal_t | gather (KV_S &nzvals, KV_GO &indices, KV_GS &pointers, host_ordinal_type_array &perm_g2l, host_ordinal_type_array &recvCountRows, host_ordinal_type_array &recvDisplRows, host_ordinal_type_array &recvCounts, host_ordinal_type_array &recvDispls, host_ordinal_type_array &transpose_map, host_scalar_type_array &nzvals_t, bool column_major, EPhase current_phase) const | 
| Protected Member Functions | |
| template<typename KV_GO , typename KV_S > | |
| void | getGlobalRowCopy_kokkos_view (global_ordinal_t row, KV_GO &indices, KV_S &vals, size_t &nnz) const | 
| size_t | getMaxRowNNZ () const | 
| size_t | getMaxColNNZ () const | 
| size_t | getGlobalRowNNZ (global_ordinal_t row) const | 
| size_t | getLocalRowNNZ (local_ordinal_t row) const | 
| size_t | getGlobalColNNZ (global_ordinal_t col) const | 
| size_t | getLocalColNNZ (local_ordinal_t col) const | 
| bool | isLocallyIndexed () const | 
| bool | isGloballyIndexed () const | 
| Private Member Functions | |
| template<typename KV_S , typename KV_GO , typename KV_GS > | |
| void | help_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, EDistribution distribution, EStorage_Ordering ordering, no_special_impl nsi) const | 
| template<typename KV_S , typename KV_GO , typename KV_GS > | |
| void | do_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, EDistribution distribution, EStorage_Ordering ordering, row_access ra) const | 
| template<typename KV_S , typename KV_GO , typename KV_GS > | |
| void | help_getCcs_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, EDistribution distribution, EStorage_Ordering ordering, no_special_impl nsi) const | 
| template<typename KV_S , typename KV_GO , typename KV_GS > | |
| void | do_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 > > rowmap, EDistribution distribution, EStorage_Ordering ordering, row_access ra) const | 
A Matrix adapter interface for Amesos2.
All Amesos2 solver interfaces are expected to use this matrix adapter interface to make their lives easier. The methods have been chosen to cater to a wide variety of third-party direct sparse solvers' needs.
| void Amesos2::MatrixAdapter< Matrix >::getCrs_kokkos_view | ( | KV_S & | nzval, | 
| KV_GO & | colind, | ||
| KV_GS & | rowptr, | ||
| global_size_t & | nnz, | ||
| const Teuchos::Ptr< const map_t > | rowmap, | ||
| EStorage_Ordering | ordering = ARBITRARY, | ||
| EDistribution | distribution = ROOTED | ||
| ) | const | 
Gets a compressed-row storage summary of this. 
Extracts a compressed-row storage format of the matrix and stores the information in the user-supplied containers.
| [out] | nzval | will hold the values of the nonzero entries of this | 
| [out] | colind | will hold the column indices of thisfor each row. | 
| [out] | rowptr | is of size nrow + 1androwptr[j]stores the location innzvalandcolindwhich starts rowjofthis.rowptr[nrow] = nnz, wherenrowis the number of rows in this matrix. | 
| [out] | nnz | is the local number of nonzero entries in the representation of this matrix. For example, if this processor has 12 of the 23 nzvals in its rows, then nnzwill be 12 on exit. | 
| [in] | rowmap | A Tpetra::Map describing the desired distribution of the rows of the CRS representation on the calling processors. | 
| [in] | ordering | |
| [in] | distribution | (optional: default = ROOTED 
 | 
| std::length_error | Thrown if nzvalorcolindis not large enough to hold the global number of nonzero values. | 
| std::length_error | Thrown if rowptris not at leastnrow + 1in size, the required size. | 
| std::runtime_error | Thrown if there is an error while extracting row values from the underlying matrix. | 
| void Amesos2::MatrixAdapter< Matrix >::getCrs_kokkos_view | ( | KV_S & | nzval, | 
| KV_GO & | colind, | ||
| KV_GS & | rowptr, | ||
| global_size_t & | nnz, | ||
| EDistribution | distribution = ROOTED, | ||
| EStorage_Ordering | ordering = ARBITRARY | ||
| ) | const | 
Convenience overload for the getCrs function that uses an enum to describe some of the most basic distributions that could be desired.
| void Amesos2::MatrixAdapter< Matrix >::getCcs_kokkos_view | ( | KV_S & | nzval, | 
| KV_GO & | rowind, | ||
| KV_GS & | colptr, | ||
| global_size_t & | nnz, | ||
| const Teuchos::Ptr< const map_t > | colmap, | ||
| EStorage_Ordering | ordering = ARBITRARY, | ||
| EDistribution | distribution = ROOTED | ||
| ) | const | 
Gets a compressed-column storage summary of this. 
Extracts a compressed-column storage format of the matrix and stores the information in the user-supplied containers.
| [out] | nzval | will hold the values of the nonzero entries of this | 
| [out] | rowind | will hold the row indices of thisfor each column. | 
| [out] | colptr | is of size ncol + 1andcolptr[j]stores the location innzvalandrowindwhich starts columnjofthis.colptr[ncol] = nnz, wherencolis the number of columns in this matrix. | 
| [out] | nnz | is the number of nonzero entries in this matrix. | 
| [in] | colmap | A Tpetra::Map describing the desired distribution of the columns of the CCS representation on the calling processors. | 
| [in] | ordering | |
| [in] | distribution | (optional: default = ROOTED 
 | 
| std::length_error | Thrown if nzvalorrowindis not large enough to hold the global number of nonzero values. | 
| std::length_error | Thrown if colptris not at leastncol + 1in size, the required size. | 
| std::runtime_error | Thrown if there is an error while extracting row values from the underlying matrix. | 
| void Amesos2::MatrixAdapter< Matrix >::getCcs_kokkos_view | ( | KV_S & | nzval, | 
| KV_GO & | rowind, | ||
| KV_GS & | colptr, | ||
| global_size_t & | nnz, | ||
| EDistribution | distribution = ROOTED, | ||
| EStorage_Ordering | ordering = ARBITRARY | ||
| ) | const | 
Convenience overload for the getCcs function that uses an enum to describe some of the most basic distributions that could be desired.
| Teuchos::RCP< const MatrixAdapter< Matrix > > Amesos2::MatrixAdapter< Matrix >::reindex | ( | Teuchos::RCP< const map_t > & | contigRowMap, | 
| Teuchos::RCP< const map_t > & | contigColMap, | ||
| const EPhase | current_phase | ||
| ) | const | 
Reindex the GIDs such that they are contiguous without gaps (0, .., n-1) This is called in loadA for the matrix with (DISTRIBUTED_NO_OVERLAP && !is_contiguous_)
| 
 | protected | 
| [out] | row | the global matrix row | 
| [out] | indices | global column indices | 
| [out] | vals | the non-zero values in row row | 
| [out] | nnz | the number of nonzeros extracted from row row | 
 1.8.5
 1.8.5