40#ifndef TPETRA_BLOCKCRSMATRIX_DECL_HPP
41#define TPETRA_BLOCKCRSMATRIX_DECL_HPP
46#include "Tpetra_CrsGraph.hpp"
47#include "Tpetra_RowMatrix.hpp"
48#include "Tpetra_BlockMultiVector_decl.hpp"
51#include "KokkosSparse_BsrMatrix.hpp"
55template<
class BlockCrsMatrixType>
56Teuchos::RCP<BlockCrsMatrixType>
57importAndFillCompleteBlockCrsMatrix (
const Teuchos::RCP<const BlockCrsMatrixType>& sourceMatrix,
58 const Import<
typename BlockCrsMatrixType::local_ordinal_type,
59 typename BlockCrsMatrixType::global_ordinal_type,
60 typename BlockCrsMatrixType::node_type>& importer);
61template<
class BlockCrsMatrixType>
62Teuchos::RCP<BlockCrsMatrixType>
63exportAndFillCompleteBlockCrsMatrix (
const Teuchos::RCP<const BlockCrsMatrixType>& sourceMatrix,
64 const Export<
typename BlockCrsMatrixType::local_ordinal_type,
65 typename BlockCrsMatrixType::global_ordinal_type,
66 typename BlockCrsMatrixType::node_type>& exporter);
148#if defined(TPETRA_ENABLE_BLOCKCRS_LITTLEBLOCK_LAYOUTLEFT)
155template<
class Scalar,
166 using STS = Teuchos::ScalarTraits<Scalar>;
207 typedef ::Tpetra::MultiVector<Scalar, LO, GO, node_type>
mv_type;
215 Kokkos::MemoryTraits<Kokkos::Unmanaged> >
217 typedef typename little_block_type::HostMirror little_block_host_type;
223 Kokkos::MemoryTraits<Kokkos::Unmanaged> >
227 typedef typename BMV::little_host_vec_type little_host_vec_type;
231 typedef typename BMV::const_little_host_vec_type const_host_little_vec_type;
234 using local_inds_device_view_type =
235 typename row_matrix_type::local_inds_device_view_type;
236 using local_inds_host_view_type =
237 typename row_matrix_type::local_inds_host_view_type;
238 using nonconst_local_inds_host_view_type =
239 typename row_matrix_type::nonconst_local_inds_host_view_type;
241 using global_inds_device_view_type =
242 typename row_matrix_type::global_inds_device_view_type;
243 using global_inds_host_view_type =
244 typename row_matrix_type::global_inds_host_view_type;
245 using nonconst_global_inds_host_view_type =
246 typename row_matrix_type::nonconst_global_inds_host_view_type;
248 using values_device_view_type =
249 typename row_matrix_type::values_device_view_type;
250 using values_host_view_type =
251 typename row_matrix_type::values_host_view_type;
252 using nonconst_values_host_view_type =
253 typename row_matrix_type::nonconst_values_host_view_type;
257 using local_matrix_device_type =
262 typename local_graph_device_type::size_type>;
263 using local_matrix_host_type =
264 typename local_matrix_device_type::HostMirror;
285 const typename local_matrix_device_type::values_type& values,
308 Teuchos::RCP<const map_type>
getDomainMap ()
const override;
311 Teuchos::RCP<const map_type>
getRangeMap ()
const override;
314 Teuchos::RCP<const map_type>
getRowMap ()
const override;
317 Teuchos::RCP<const map_type>
getColMap ()
const override;
339 Teuchos::ETransp mode = Teuchos::NO_TRANS,
340 Scalar alpha = Teuchos::ScalarTraits<Scalar>::one (),
341 Scalar beta = Teuchos::ScalarTraits<Scalar>::zero ())
const override;
385 describe (Teuchos::FancyOStream& out,
386 const Teuchos::EVerbosityLevel verbLevel)
const override;
396 virtual Teuchos::RCP<const ::Tpetra::RowGraph<LO,GO,Node> >
getGraph ()
const override;
405 applyBlock (
const BlockMultiVector<Scalar, LO, GO, Node>& X,
406 BlockMultiVector<Scalar, LO, GO, Node>& Y,
407 Teuchos::ETransp mode = Teuchos::NO_TRANS,
408 const Scalar alpha = Teuchos::ScalarTraits<Scalar>::one (),
409 const Scalar beta = Teuchos::ScalarTraits<Scalar>::zero ());
415 const Import<LO, GO, Node>& importer)
const;
421 const Export<LO, GO, Node>& exporter)
const;
454 const LO numColInds)
const;
486 const LO numColInds)
const;
523 local_inds_host_view_type &indices,
524 values_host_view_type &values)
const override;
530 local_inds_host_view_type &indices,
531 nonconst_values_host_view_type &values)
const;
536 nonconst_local_inds_host_view_type &Indices,
537 nonconst_values_host_view_type &Values,
538 size_t& NumEntries)
const override;
540 getLocalBlockDeviceNonConst (
const LO localRowInd,
const LO localColInd)
const;
542 little_block_host_type
543 getLocalBlockHostNonConst (
const LO localRowInd,
const LO localColInd)
const;
573 const LO numColInds)
const;
582 const ptrdiff_t offsets[],
584 const LO numOffsets)
const;
587 absMaxLocalValuesByOffsets (
const LO localRowInd,
588 const ptrdiff_t offsets[],
590 const LO numOffsets)
const;
599 const ptrdiff_t offsets[],
601 const LO numOffsets)
const;
651 return (*errs_).is_null () ? std::string (
"") : (*errs_)->str ();
687 Kokkos::MemoryUnmanaged>& offsets)
const;
705 Kokkos::MemoryUnmanaged>& diag,
707 Kokkos::MemoryUnmanaged>& offsets)
const;
728 const LO numColInds)
const;
744 virtual bool checkSizes (const ::Tpetra::SrcDistObject& source)
override;
749 const size_t numSameIDs,
763 Kokkos::DualView<
size_t*,
765 size_t& constantNumPackets)
override;
773 Kokkos::DualView<
size_t*,
775 const size_t constantNumPackets,
782 Teuchos::RCP<crs_graph_type> graphRCP_;
822 using graph_row_offset_host_type =
typename crs_graph_type::local_graph_device_type::row_map_type::HostMirror;
823 graph_row_offset_host_type ptrHost_;
830 using graph_column_indices_host_type =
typename crs_graph_type::local_graph_device_type::entries_type::HostMirror;
831 graph_column_indices_host_type indHost_;
838 using impl_scalar_type_dualview = Kokkos::DualView<impl_scalar_type*, device_type>;
839 using impl_scalar_type_wrapped_dualview = Details::WrappedDualView<impl_scalar_type_dualview>;
840 mutable impl_scalar_type_wrapped_dualview val_;
863 Teuchos::RCP<Teuchos::RCP<BMV> > X_colMap_;
867 Teuchos::RCP<Teuchos::RCP<BMV> > Y_rowMap_;
876 Teuchos::RCP<Teuchos::RCP<typename crs_graph_type::import_type> > pointImporter_;
892 Teuchos::RCP<bool> localError_;
901 Teuchos::RCP<Teuchos::RCP<std::ostringstream> > errs_;
904 std::ostream& markLocalErrorAndGetStream ();
909 template<
class Device>
911#if defined(KOKKOS_ENABLE_CUDA)
917 static constexpr bool value =
918 std::is_same<typename Device::execution_space, Kokkos::Cuda>::value;
920#elif defined(KOKKOS_ENABLE_HIP)
921 static constexpr bool value =
922 std::is_same<typename Device::execution_space, Kokkos::Experimental::HIP>::value;
923#elif defined(KOKKOS_ENABLE_SYCL)
924 static constexpr bool value =
925 std::is_same<typename Device::execution_space, Kokkos::Experimental::SYCL>::value;
927 static constexpr bool value =
false;
932 typename impl_scalar_type_dualview::t_host::const_type
933 getValuesHost()
const;
935 typename impl_scalar_type_dualview::t_dev::const_type
936 getValuesDevice()
const;
956 typename impl_scalar_type_dualview::t_host
959 typename impl_scalar_type_dualview::t_dev
960 getValuesDeviceNonConst()
const;
963 typename impl_scalar_type_dualview::t_host::const_type
964 getValuesHost (
const LO& lclRow)
const;
967 typename impl_scalar_type_dualview::t_dev::const_type
968 getValuesDevice (
const LO& lclRow)
const;
971 typename impl_scalar_type_dualview::t_host
975 typename impl_scalar_type_dualview::t_dev
976 getValuesDeviceNonConst (
const LO& lclRow);
993 const Teuchos::ETransp mode,
1063 findRelOffsetOfColumnIndex (
const LO localRowIndex,
1064 const LO colIndexToFind,
1065 const LO hint = 0)
const;
1069 LO offsetPerBlock ()
const;
1072 getConstLocalBlockFromInput (
const impl_scalar_type* val,
const size_t pointOffset)
const;
1075 getNonConstLocalBlockFromInput (
impl_scalar_type* val,
const size_t pointOffset)
const;
1077 little_block_host_type
1078 getNonConstLocalBlockFromInputHost (
impl_scalar_type* val,
const size_t pointOffset)
const;
1085 virtual Teuchos::RCP<const Teuchos::Comm<int> >
getComm()
const override;
1116 virtual bool hasColMap ()
const override;
1173 nonconst_global_inds_host_view_type &Indices,
1174 nonconst_values_host_view_type &Values,
1175 size_t& NumEntries)
const override;
1202 global_inds_host_view_type & indices,
1203 values_host_view_type & values)
const override;
1227 virtual void leftScale (const ::Tpetra::Vector<Scalar, LO, GO, Node>& x)
override;
1234 virtual void rightScale (const ::Tpetra::Vector<Scalar, LO, GO, Node>& x)
override;
1244 virtual typename ::Tpetra::RowMatrix<Scalar, LO, GO, Node>::mag_type
1249 template<
class BlockCrsMatrixType>
1250 friend Teuchos::RCP<BlockCrsMatrixType>
1251 Tpetra::importAndFillCompleteBlockCrsMatrix (
const Teuchos::RCP<const BlockCrsMatrixType>& sourceMatrix,
1252 const Import<
typename BlockCrsMatrixType::local_ordinal_type,
1253 typename BlockCrsMatrixType::global_ordinal_type,
1254 typename BlockCrsMatrixType::node_type>& importer);
1256 template<
class BlockCrsMatrixType>
1257 friend Teuchos::RCP<BlockCrsMatrixType>
1258 Tpetra::exportAndFillCompleteBlockCrsMatrix (
const Teuchos::RCP<const BlockCrsMatrixType>& sourceMatrix,
1259 const Export<
typename BlockCrsMatrixType::local_ordinal_type,
1260 typename BlockCrsMatrixType::global_ordinal_type,
1261 typename BlockCrsMatrixType::node_type>& exporter);
1265template<
class BlockCrsMatrixType>
1266Teuchos::RCP<BlockCrsMatrixType>
1267importAndFillCompleteBlockCrsMatrix (
const Teuchos::RCP<const BlockCrsMatrixType>& sourceMatrix,
1268 const Import<
typename BlockCrsMatrixType::local_ordinal_type,
1269 typename BlockCrsMatrixType::global_ordinal_type,
1270 typename BlockCrsMatrixType::node_type>& importer)
1272 Teuchos::RCP<BlockCrsMatrixType> destMatrix;
1273 sourceMatrix->importAndFillComplete (destMatrix, importer);
1278template<
class BlockCrsMatrixType>
1279Teuchos::RCP<BlockCrsMatrixType>
1280exportAndFillCompleteBlockCrsMatrix (
const Teuchos::RCP<const BlockCrsMatrixType>& sourceMatrix,
1281 const Export<
typename BlockCrsMatrixType::local_ordinal_type,
1282 typename BlockCrsMatrixType::global_ordinal_type,
1283 typename BlockCrsMatrixType::node_type>& exporter)
1285 Teuchos::RCP<BlockCrsMatrixType> destMatrix;
1286 sourceMatrix->exportAndFillComplete (destMatrix, exporter);
Declaration of the Tpetra::CrsMatrix class.
Sparse matrix whose entries are small dense square blocks, all of the same dimensions.
LO sumIntoLocalValues(const LO localRowInd, const LO colInds[], const Scalar vals[], const LO numColInds) const
Sum into values at the given (mesh, i.e., block) column indices, in the given (mesh,...
virtual ~BlockCrsMatrix()
Destructor (declared virtual for memory safety).
void exportAndFillComplete(Teuchos::RCP< BlockCrsMatrix< Scalar, LO, GO, Node > > &destMatrix, const Export< LO, GO, Node > &exporter) const
Import from this to the given destination matrix, and make the result fill complete.
virtual bool isLocallyIndexed() const override
Whether matrix indices are locally indexed.
virtual bool isFillComplete() const override
Whether fillComplete() has been called.
virtual size_t getGlobalMaxNumRowEntries() const override
The maximum number of entries in any row over all processes in the matrix's communicator.
void applyBlock(const BlockMultiVector< Scalar, LO, GO, Node > &X, BlockMultiVector< Scalar, LO, GO, Node > &Y, Teuchos::ETransp mode=Teuchos::NO_TRANS, const Scalar alpha=Teuchos::ScalarTraits< Scalar >::one(), const Scalar beta=Teuchos::ScalarTraits< Scalar >::zero())
Version of apply() that takes BlockMultiVector input and output.
LO replaceLocalValuesByOffsets(const LO localRowInd, const ptrdiff_t offsets[], const Scalar vals[], const LO numOffsets) const
Like replaceLocalValues, but avoids computing row offsets.
virtual void getLocalRowCopy(LO LocalRow, nonconst_local_inds_host_view_type &Indices, nonconst_values_host_view_type &Values, size_t &NumEntries) const override
Not implemented.
std::string errorMessages() const
The current stream of error messages.
LO absMaxLocalValues(const LO localRowInd, const LO colInds[], const Scalar vals[], const LO numColInds) const
Variant of getLocalDiagCopy() that uses precomputed offsets and puts diagonal blocks in a 3-D Kokkos:...
Scalar scalar_type
The type of entries in the matrix (that is, of each entry in each block).
virtual void getGlobalRowView(GO GlobalRow, global_inds_host_view_type &indices, values_host_view_type &values) const override
Get a constant, nonpersisting, globally indexed view of the given row of the matrix.
void describe(Teuchos::FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel) const override
Print a description of this object to the given output stream.
size_t getLocalMaxNumRowEntries() const override
Maximum number of entries in any row of the matrix, on this process.
LO local_ordinal_type
The type of local indices.
virtual void getGlobalRowCopy(GO GlobalRow, nonconst_global_inds_host_view_type &Indices, nonconst_values_host_view_type &Values, size_t &NumEntries) const override
Get a copy of the given global row's entries.
LO getLocalRowOffsets(const LO localRowInd, ptrdiff_t offsets[], const LO colInds[], const LO numColInds) const
Get relative offsets corresponding to the given rows, given by local row index.
virtual size_t getLocalNumCols() const override
The number of columns needed to apply the forward operator on this node.
virtual void copyAndPermute(const SrcDistObject &sourceObj, const size_t numSameIDs, const Kokkos::DualView< const local_ordinal_type *, buffer_device_type > &permuteToLIDs, const Kokkos::DualView< const local_ordinal_type *, buffer_device_type > &permuteFromLIDs, const CombineMode CM) override
::Tpetra::MultiVector< Scalar, LO, GO, node_type > mv_type
The implementation of MultiVector that this class uses.
Teuchos::RCP< const map_type > getRangeMap() const override
Get the (point) range Map of this matrix.
LO sumIntoLocalValuesByOffsets(const LO localRowInd, const ptrdiff_t offsets[], const Scalar vals[], const LO numOffsets) const
Like sumIntoLocalValues, but avoids computing row offsets.
virtual bool hasColMap() const override
Whether this matrix has a well-defined column Map.
device_type::execution_space execution_space
The Kokkos execution space that this class uses.
size_t getLocalNumRows() const override
get the local number of block rows
virtual size_t getLocalNumEntries() const override
The local number of stored (structurally nonzero) entries.
bool hasTransposeApply() const override
Whether it is valid to apply the transpose or conjugate transpose of this matrix.
impl_scalar_type_dualview::t_host getValuesHostNonConst() const
Get the host or device View of the matrix's values (val_).
Kokkos::View< impl_scalar_type **, Impl::BlockCrsMatrixLittleBlockArrayLayout, device_type, Kokkos::MemoryTraits< Kokkos::Unmanaged > > little_block_type
The type used to access nonconst matrix blocks.
Teuchos::RCP< const map_type > getColMap() const override
get the (mesh) map for the columns of this block matrix.
virtual typename::Tpetra::RowMatrix< Scalar, LO, GO, Node >::mag_type getFrobeniusNorm() const override
The Frobenius norm of the matrix.
virtual Teuchos::RCP< const ::Tpetra::RowGraph< LO, GO, Node > > getGraph() const override
Get the (mesh) graph.
virtual void unpackAndCombine(const Kokkos::DualView< const local_ordinal_type *, buffer_device_type > &importLIDs, Kokkos::DualView< packet_type *, buffer_device_type > imports, Kokkos::DualView< size_t *, buffer_device_type > numPacketsPerLID, const size_t constantNumPackets, const CombineMode combineMode) override
local_matrix_device_type getLocalMatrixDevice() const
void apply(const mv_type &X, mv_type &Y, Teuchos::ETransp mode=Teuchos::NO_TRANS, Scalar alpha=Teuchos::ScalarTraits< Scalar >::one(), Scalar beta=Teuchos::ScalarTraits< Scalar >::zero()) const override
For this matrix A, compute Y := beta * Y + alpha * Op(A) * X.
virtual global_size_t getGlobalNumCols() const override
The global number of columns of this matrix.
void getLocalDiagOffsets(const Kokkos::View< size_t *, device_type, Kokkos::MemoryUnmanaged > &offsets) const
Get offsets of the diagonal entries in the matrix.
Teuchos::RCP< const map_type > getRowMap() const override
get the (mesh) map for the rows of this block matrix.
std::string description() const override
One-line description of this object.
void importAndFillComplete(Teuchos::RCP< BlockCrsMatrix< Scalar, LO, GO, Node > > &destMatrix, const Import< LO, GO, Node > &importer) const
Import from this to the given destination matrix, and make the result fill complete.
Node node_type
The Node type.
void getLocalRowView(LO LocalRow, local_inds_host_view_type &indices, values_host_view_type &values) const override
Get a view of the (mesh, i.e., block) row, using local (mesh, i.e., block) indices.
void getLocalDiagCopy(const Kokkos::View< impl_scalar_type ***, device_type, Kokkos::MemoryUnmanaged > &diag, const Kokkos::View< const size_t *, device_type, Kokkos::MemoryUnmanaged > &offsets) const
Variant of getLocalDiagCopy() that uses precomputed offsets and puts diagonal blocks in a 3-D Kokkos:...
GO global_ordinal_type
The type of global indices.
size_t getNumEntriesInLocalRow(const LO localRowInd) const override
Return the number of entries in the given row on the calling process.
virtual bool supportsRowViews() const override
Whether this object implements getLocalRowView() and getGlobalRowView().
LO replaceLocalValues(const LO localRowInd, const LO colInds[], const Scalar vals[], const LO numColInds) const
Replace values at the given (mesh, i.e., block) column indices, in the given (mesh,...
virtual size_t getNumEntriesInGlobalRow(GO globalRow) const override
The current number of entries on the calling process in the specified global row.
Node::device_type device_type
The Kokkos::Device specialization that this class uses.
BMV::little_vec_type little_vec_type
The type used to access nonconst vector blocks.
void setAllToScalar(const Scalar &alpha)
Set all matrix entries equal to alpha.
BMV::const_little_vec_type const_little_vec_type
The type used to access const vector blocks.
Kokkos::View< const impl_scalar_type **, Impl::BlockCrsMatrixLittleBlockArrayLayout, device_type, Kokkos::MemoryTraits< Kokkos::Unmanaged > > const_little_block_type
The type used to access const matrix blocks.
void getLocalRowViewNonConst(LO LocalRow, local_inds_host_view_type &indices, nonconst_values_host_view_type &values) const
char packet_type
Implementation detail; tells.
typename DistObject< Scalar, LO, GO, Node >::buffer_device_type buffer_device_type
Kokkos::Device specialization for communication buffers.
virtual void packAndPrepare(const SrcDistObject &sourceObj, const Kokkos::DualView< const local_ordinal_type *, buffer_device_type > &exportLIDs, Kokkos::DualView< packet_type *, buffer_device_type > &exports, Kokkos::DualView< size_t *, buffer_device_type > numPacketsPerLID, size_t &constantNumPackets) override
::Tpetra::Map< LO, GO, node_type > map_type
The implementation of Map that this class uses.
virtual void rightScale(const ::Tpetra::Vector< Scalar, LO, GO, Node > &x) override
Scale the RowMatrix on the right with the given Vector x.
virtual GO getIndexBase() const override
The index base for global indices in this matrix.
bool localError() const
Whether this object had an error on the calling process.
virtual global_size_t getGlobalNumEntries() const override
The global number of stored (structurally nonzero) entries.
typename BMV::impl_scalar_type impl_scalar_type
The implementation type of entries in the matrix.
virtual Teuchos::RCP< const Teuchos::Comm< int > > getComm() const override
The communicator over which this matrix is distributed.
::Tpetra::CrsGraph< LO, GO, node_type > crs_graph_type
The implementation of CrsGraph that this class uses.
device_type::memory_space memory_space
The Kokkos memory space that this class uses.
global_size_t getGlobalNumRows() const override
get the global number of block rows
virtual void leftScale(const ::Tpetra::Vector< Scalar, LO, GO, Node > &x) override
Scale the RowMatrix on the left with the given Vector x.
Teuchos::RCP< const map_type > getDomainMap() const override
Get the (point) domain Map of this matrix.
virtual bool isGloballyIndexed() const override
Whether matrix indices are globally indexed.
BlockCrsMatrix()
Default constructor: Makes an empty block matrix.
LO getBlockSize() const
The number of degrees of freedom per mesh point.
MultiVector for multiple degrees of freedom per mesh point.
typename mv_type::impl_scalar_type impl_scalar_type
The implementation type of entries in the object.
Kokkos::View< impl_scalar_type *, device_type > little_vec_type
"Block view" of all degrees of freedom at a mesh point, for a single column of the MultiVector.
Kokkos::View< const impl_scalar_type *, device_type > const_little_vec_type
"Const block view" of all degrees of freedom at a mesh point, for a single column of the MultiVector.
Kokkos::StaticCrsGraph< local_ordinal_type, Kokkos::LayoutLeft, device_type, void, size_t > local_graph_device_type
The type of the part of the sparse graph on each MPI process.
Base class for distributed Tpetra objects that support data redistribution.
Communication plan for data redistribution from a (possibly) multiply-owned to a uniquely-owned distr...
Communication plan for data redistribution from a uniquely-owned to a (possibly) multiply-owned distr...
A read-only, row-oriented interface to a sparse matrix.
Abstract base class for objects that can be the source of an Import or Export operation.
A distributed dense vector.
Kokkos::LayoutRight BlockCrsMatrixLittleBlockArrayLayout
give an option to use layoutleft
Namespace Tpetra contains the class and methods constituting the Tpetra library.
size_t global_size_t
Global size_t object.
CombineMode
Rule for combining data in an Import or Export.