|
|
bool | isLocallyIndexed () const |
| | Checks whether this multi-vector is local to the calling node.
|
| |
|
bool | isGloballyIndexed () const |
| |
|
Teuchos::RCP< Epetra_MultiVector > | clone () const |
| |
| Teuchos::RCP< const Tpetra::Map< local_ordinal_t, global_ordinal_t, node_t > > | getMap () const |
| | Get a Tpetra::Map that describes this MultiVector.
|
| |
|
const Teuchos::RCP< const Teuchos::Comm< int > > | getComm () const |
| | Returns the Teuchos::Comm object associated with this multi-vector.
|
| |
|
size_t | getLocalLength () const |
| | Get the length of vectors local to the calling node.
|
| |
|
size_t | getLocalNumVectors () const |
| | Get the number of vectors on this node.
|
| |
|
global_size_t | getGlobalLength () const |
| | Get the length of vectors in the global space.
|
| |
|
size_t | getGlobalNumVectors () const |
| | Get the number of global vectors.
|
| |
|
size_t | getStride () const |
| | Return the stride between vectors on this node.
|
| |
|
bool | isConstantStride () const |
| | Return true if this MV has constant stride between vectors on this node.
|
| |
|
Teuchos::RCP< const Tpetra::Vector< scalar_t, local_ordinal_t, global_ordinal_t, node_t > > | getVector (size_t j) const |
| | Const vector access.
|
| |
| Teuchos::RCP< Tpetra::Vector< scalar_t, local_ordinal_t, global_ordinal_t, node_t > > | getVectorNonConst (size_t j) |
| | Nonconst vector access.
|
| |
|
double * | getMVPointer_impl () const |
| | Return pointer to vector when number of vectors == 1 and num procs == 1.
|
| |
| void | get1dCopy (const Teuchos::ArrayView< scalar_t > &A, size_t lda, Teuchos::Ptr< const Tpetra::Map< local_ordinal_t, global_ordinal_t, node_t > > distribution_map, EDistribution distribution) const |
| | Copies the multi-vector's data into the user-provided vector.
|
| |
|
template<typename KV > |
| bool | get1dCopy_kokkos_view (bool bInitialize, KV &A, size_t lda, Teuchos::Ptr< const Tpetra::Map< local_ordinal_t, global_ordinal_t, node_t > > distribution_map, EDistribution distribution) const |
| |
|
void | get1dCopy_kokkos_view_host (Kokkos::View< scalar_t **, Kokkos::LayoutLeft, Kokkos::HostSpace > &new_data, size_t lda, Teuchos::Ptr< const Tpetra::Map< local_ordinal_t, global_ordinal_t, node_t > > distribution_map, EDistribution) const |
| |
| Teuchos::ArrayRCP< scalar_t > | get1dViewNonConst (bool local=false) |
| | Extracts a 1 dimensional view of this multi-vector's data.
|
| |
| void | put1dData (const Teuchos::ArrayView< const scalar_t > &new_data, size_t lda, Teuchos::Ptr< const Tpetra::Map< local_ordinal_t, global_ordinal_t, node_t > > source_map, EDistribution distribution) |
| | Export newVals into the global MultiVector space.
|
| |
|
template<typename KV > |
| void | put1dData_kokkos_view (KV &new_data, size_t lda, Teuchos::Ptr< const Tpetra::Map< local_ordinal_t, global_ordinal_t, node_t > > source_map, EDistribution distribution) |
| |
|
void | put1dData_kokkos_view_host (Kokkos::View< scalar_t **, Kokkos::LayoutLeft, Kokkos::HostSpace > &new_data, size_t lda, Teuchos::Ptr< const Tpetra::Map< local_ordinal_t, global_ordinal_t, node_t > > source_map, EDistribution distribution) |
| |
|
template<typename KV , typename host_ordinal_type_array > |
| int | gather (KV &kokkos_new_view, host_ordinal_type_array &perm_g2l, host_ordinal_type_array &recvCountRows, host_ordinal_type_array &recvDisplRows, EDistribution distribution) const |
| |
|
template<typename KV , typename host_ordinal_type_array > |
| int | scatter (KV &kokkos_new_view, host_ordinal_type_array &perm_g2l, host_ordinal_type_array &sendCountRows, host_ordinal_type_array &sendDisplRows, EDistribution distribution) const |
| |
|
std::string | description () const |
| | Get a short description of this adapter class.
|
| |
|
void | describe (Teuchos::FancyOStream &os, const Teuchos::EVerbosityLevel verbLevel=Teuchos::Describable::verbLevel_default) const |
| | Print a description of this adapter to the Fancy Output Stream.
|
| |
Amesos2 adapter for the Epetra_MultiVector class.