11 #ifndef TPETRA_BLOCKCRSMATRIX_DECL_HPP
12 #define TPETRA_BLOCKCRSMATRIX_DECL_HPP
17 #include "Tpetra_CrsGraph.hpp"
18 #include "Tpetra_RowMatrix.hpp"
19 #include "Tpetra_BlockMultiVector_decl.hpp"
22 #include "KokkosSparse_BsrMatrix.hpp"
24 #if KOKKOSKERNELS_VERSION >= 40299
25 #include "Tpetra_Details_MatrixApplyHelper.hpp"
30 template<
class BlockCrsMatrixType>
31 Teuchos::RCP<BlockCrsMatrixType>
32 importAndFillCompleteBlockCrsMatrix (
const Teuchos::RCP<const BlockCrsMatrixType>& sourceMatrix,
33 const Import<
typename BlockCrsMatrixType::local_ordinal_type,
34 typename BlockCrsMatrixType::global_ordinal_type,
35 typename BlockCrsMatrixType::node_type>& importer);
36 template<
class BlockCrsMatrixType>
37 Teuchos::RCP<BlockCrsMatrixType>
38 exportAndFillCompleteBlockCrsMatrix (
const Teuchos::RCP<const BlockCrsMatrixType>& sourceMatrix,
39 const Export<
typename BlockCrsMatrixType::local_ordinal_type,
40 typename BlockCrsMatrixType::global_ordinal_type,
41 typename BlockCrsMatrixType::node_type>& exporter);
123 #if defined(TPETRA_ENABLE_BLOCKCRS_LITTLEBLOCK_LAYOUTLEFT)
130 template<
class Scalar,
141 using STS = Teuchos::ScalarTraits<Scalar>;
182 typedef ::Tpetra::MultiVector<Scalar, LO, GO, node_type>
mv_type;
190 Kokkos::MemoryTraits<Kokkos::Unmanaged> >
192 typedef typename little_block_type::HostMirror little_block_host_type;
198 Kokkos::MemoryTraits<Kokkos::Unmanaged> >
202 typedef typename BMV::little_host_vec_type little_host_vec_type;
206 typedef typename BMV::const_little_host_vec_type const_host_little_vec_type;
209 using local_inds_device_view_type =
210 typename row_matrix_type::local_inds_device_view_type;
211 using local_inds_host_view_type =
212 typename row_matrix_type::local_inds_host_view_type;
213 using nonconst_local_inds_host_view_type =
214 typename row_matrix_type::nonconst_local_inds_host_view_type;
216 using global_inds_device_view_type =
217 typename row_matrix_type::global_inds_device_view_type;
218 using global_inds_host_view_type =
219 typename row_matrix_type::global_inds_host_view_type;
220 using nonconst_global_inds_host_view_type =
221 typename row_matrix_type::nonconst_global_inds_host_view_type;
223 using values_device_view_type =
224 typename row_matrix_type::values_device_view_type;
225 using values_host_view_type =
226 typename row_matrix_type::values_host_view_type;
227 using nonconst_values_host_view_type =
228 typename row_matrix_type::nonconst_values_host_view_type;
232 using local_matrix_device_type =
237 typename local_graph_device_type::size_type>;
239 #if KOKKOSKERNELS_VERSION >= 40299
243 using local_matrix_int_rowptrs_device_type =
252 local_matrix_device_type,
253 local_matrix_int_rowptrs_device_type,
254 typename mv_type::device_view_type>;
263 mutable std::shared_ptr<ApplyHelper> applyHelper;
266 std::shared_ptr<ApplyHelper> getApplyHelper()
const {
269 applyHelper = std::make_shared<ApplyHelper>(A_lcl.nnz(), A_lcl.graph.row_map);
276 using local_matrix_host_type =
277 typename local_matrix_device_type::HostMirror;
298 const typename local_matrix_device_type::values_type& values,
321 Teuchos::RCP<const map_type>
getDomainMap ()
const override;
324 Teuchos::RCP<const map_type>
getRangeMap ()
const override;
327 Teuchos::RCP<const map_type>
getRowMap ()
const override;
330 Teuchos::RCP<const map_type>
getColMap ()
const override;
352 Teuchos::ETransp mode = Teuchos::NO_TRANS,
353 Scalar alpha = Teuchos::ScalarTraits<Scalar>::one (),
354 Scalar beta = Teuchos::ScalarTraits<Scalar>::zero ())
const override;
398 describe (Teuchos::FancyOStream& out,
399 const Teuchos::EVerbosityLevel verbLevel)
const override;
409 virtual Teuchos::RCP<const ::Tpetra::RowGraph<LO,GO,Node> >
getGraph ()
const override;
418 applyBlock (
const BlockMultiVector<Scalar, LO, GO, Node>& X,
419 BlockMultiVector<Scalar, LO, GO, Node>& Y,
420 Teuchos::ETransp mode = Teuchos::NO_TRANS,
421 const Scalar alpha = Teuchos::ScalarTraits<Scalar>::one (),
422 const Scalar beta = Teuchos::ScalarTraits<Scalar>::zero ());
428 const Import<LO, GO, Node>& importer)
const;
434 const Export<LO, GO, Node>& exporter)
const;
467 const LO numColInds)
const;
499 const LO numColInds)
const;
536 local_inds_host_view_type &indices,
537 values_host_view_type &values)
const override;
543 local_inds_host_view_type &indices,
544 nonconst_values_host_view_type &values)
const;
549 nonconst_local_inds_host_view_type &Indices,
550 nonconst_values_host_view_type &Values,
551 size_t& NumEntries)
const override;
553 getLocalBlockDeviceNonConst (
const LO localRowInd,
const LO localColInd)
const;
555 little_block_host_type
556 getLocalBlockHostNonConst (
const LO localRowInd,
const LO localColInd)
const;
586 const LO numColInds)
const;
595 const ptrdiff_t offsets[],
597 const LO numOffsets)
const;
600 absMaxLocalValuesByOffsets (
const LO localRowInd,
601 const ptrdiff_t offsets[],
603 const LO numOffsets)
const;
612 const ptrdiff_t offsets[],
614 const LO numOffsets)
const;
664 return (*errs_).is_null () ? std::string (
"") : (*errs_)->str ();
700 Kokkos::MemoryUnmanaged>& offsets)
const;
718 Kokkos::MemoryUnmanaged>& diag,
720 Kokkos::MemoryUnmanaged>& offsets)
const;
741 const LO numColInds)
const;
757 virtual bool checkSizes (const ::Tpetra::SrcDistObject& source)
override;
768 const size_t numSameIDs,
789 Kokkos::DualView<
size_t*,
791 size_t& constantNumPackets)
override;
806 Kokkos::DualView<
size_t*,
808 const size_t constantNumPackets,
815 Teuchos::RCP<crs_graph_type> graphRCP_;
855 using graph_row_offset_host_type =
typename crs_graph_type::local_graph_device_type::row_map_type::HostMirror;
856 graph_row_offset_host_type ptrHost_;
863 using graph_column_indices_host_type =
typename crs_graph_type::local_graph_device_type::entries_type::HostMirror;
864 graph_column_indices_host_type indHost_;
871 using impl_scalar_type_dualview = Kokkos::DualView<impl_scalar_type*, device_type>;
896 Teuchos::RCP<Teuchos::RCP<BMV> > X_colMap_;
900 Teuchos::RCP<Teuchos::RCP<BMV> > Y_rowMap_;
909 Teuchos::RCP<Teuchos::RCP<typename crs_graph_type::import_type> > pointImporter_;
925 Teuchos::RCP<bool> localError_;
934 Teuchos::RCP<Teuchos::RCP<std::ostringstream> > errs_;
937 std::ostream& markLocalErrorAndGetStream ();
942 template<
class Device>
944 #if defined(KOKKOS_ENABLE_CUDA)
950 static constexpr
bool value =
951 std::is_same<typename Device::execution_space, Kokkos::Cuda>::value;
953 #elif defined(KOKKOS_ENABLE_HIP)
954 static constexpr
bool value =
955 std::is_same<typename Device::execution_space, Kokkos::HIP>::value;
956 #elif defined(KOKKOS_ENABLE_SYCL)
957 static constexpr
bool value =
958 std::is_same<typename Device::execution_space, Kokkos::Experimental::SYCL>::value;
960 static constexpr
bool value =
false;
965 typename impl_scalar_type_dualview::t_host::const_type
966 getValuesHost()
const;
968 typename impl_scalar_type_dualview::t_dev::const_type
969 getValuesDevice()
const;
989 typename impl_scalar_type_dualview::t_host
992 typename impl_scalar_type_dualview::t_dev
993 getValuesDeviceNonConst()
const;
996 typename impl_scalar_type_dualview::t_host::const_type
997 getValuesHost (
const LO& lclRow)
const;
1000 typename impl_scalar_type_dualview::t_dev::const_type
1001 getValuesDevice (
const LO& lclRow)
const;
1004 typename impl_scalar_type_dualview::t_host
1008 typename impl_scalar_type_dualview::t_dev
1009 getValuesDeviceNonConst (
const LO& lclRow);
1026 const Teuchos::ETransp mode,
1096 findRelOffsetOfColumnIndex (
const LO localRowIndex,
1097 const LO colIndexToFind,
1098 const LO hint = 0)
const;
1102 LO offsetPerBlock ()
const;
1105 getConstLocalBlockFromInput (
const impl_scalar_type* val,
const size_t pointOffset)
const;
1108 getNonConstLocalBlockFromInput (
impl_scalar_type* val,
const size_t pointOffset)
const;
1110 little_block_host_type
1111 getNonConstLocalBlockFromInputHost (
impl_scalar_type* val,
const size_t pointOffset)
const;
1118 virtual Teuchos::RCP<const Teuchos::Comm<int> >
getComm()
const override;
1149 virtual bool hasColMap ()
const override;
1206 nonconst_global_inds_host_view_type &Indices,
1207 nonconst_values_host_view_type &Values,
1208 size_t& NumEntries)
const override;
1235 global_inds_host_view_type & indices,
1236 values_host_view_type & values)
const override;
1260 virtual void leftScale (const ::Tpetra::Vector<Scalar, LO, GO, Node>& x)
override;
1267 virtual void rightScale (const ::Tpetra::Vector<Scalar, LO, GO, Node>& x)
override;
1277 virtual typename ::Tpetra::RowMatrix<Scalar, LO, GO, Node>::mag_type
1282 template<
class BlockCrsMatrixType>
1283 friend Teuchos::RCP<BlockCrsMatrixType>
1284 Tpetra::importAndFillCompleteBlockCrsMatrix (
const Teuchos::RCP<const BlockCrsMatrixType>& sourceMatrix,
1285 const Import<
typename BlockCrsMatrixType::local_ordinal_type,
1286 typename BlockCrsMatrixType::global_ordinal_type,
1287 typename BlockCrsMatrixType::node_type>& importer);
1289 template<
class BlockCrsMatrixType>
1290 friend Teuchos::RCP<BlockCrsMatrixType>
1291 Tpetra::exportAndFillCompleteBlockCrsMatrix (
const Teuchos::RCP<const BlockCrsMatrixType>& sourceMatrix,
1292 const Export<
typename BlockCrsMatrixType::local_ordinal_type,
1293 typename BlockCrsMatrixType::global_ordinal_type,
1294 typename BlockCrsMatrixType::node_type>& exporter);
1298 template<
class BlockCrsMatrixType>
1299 Teuchos::RCP<BlockCrsMatrixType>
1300 importAndFillCompleteBlockCrsMatrix (
const Teuchos::RCP<const BlockCrsMatrixType>& sourceMatrix,
1301 const Import<
typename BlockCrsMatrixType::local_ordinal_type,
1302 typename BlockCrsMatrixType::global_ordinal_type,
1303 typename BlockCrsMatrixType::node_type>& importer)
1305 Teuchos::RCP<BlockCrsMatrixType> destMatrix;
1306 sourceMatrix->importAndFillComplete (destMatrix, importer);
1311 template<
class BlockCrsMatrixType>
1312 Teuchos::RCP<BlockCrsMatrixType>
1313 exportAndFillCompleteBlockCrsMatrix (
const Teuchos::RCP<const BlockCrsMatrixType>& sourceMatrix,
1314 const Export<
typename BlockCrsMatrixType::local_ordinal_type,
1315 typename BlockCrsMatrixType::global_ordinal_type,
1316 typename BlockCrsMatrixType::node_type>& exporter)
1318 Teuchos::RCP<BlockCrsMatrixType> destMatrix;
1319 sourceMatrix->exportAndFillComplete (destMatrix, exporter);
1325 #endif // TPETRA_BLOCKCRSMATRIX_DECL_HPP
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.
size_t getNumEntriesInLocalRow(const LO localRowInd) const override
Return the number of entries in the given row on the calling process.
Communication plan for data redistribution from a uniquely-owned to a (possibly) multiply-owned distr...
virtual size_t getLocalNumEntries() const override
The local number of stored (structurally nonzero) entries.
virtual global_size_t getGlobalNumCols() const override
The global number of columns of this matrix.
::Tpetra::MultiVector< Scalar, LO, GO, node_type > mv_type
The implementation of MultiVector that this class uses.
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...
typename BMV::impl_scalar_type impl_scalar_type
The implementation type of entries in the matrix.
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:...
void describe(Teuchos::FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel) const override
Print a description of this object to the given output stream.
Kokkos::View< impl_scalar_type **, Impl::BlockCrsMatrixLittleBlockArrayLayout, device_type, Kokkos::MemoryTraits< Kokkos::Unmanaged > > little_block_type
The type used to access nonconst matrix blocks.
virtual typename::Tpetra::RowMatrix< Scalar, LO, GO, Node >::mag_type getFrobeniusNorm() const override
The Frobenius norm of the matrix.
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, i.e., block) row.
virtual void leftScale(const ::Tpetra::Vector< Scalar, LO, GO, Node > &x) override
Scale the RowMatrix on the left with the given Vector x.
virtual LO getBlockSize() const override
The number of degrees of freedom per mesh point.
LO replaceLocalValuesByOffsets(const LO localRowInd, const ptrdiff_t offsets[], const Scalar vals[], const LO numOffsets) const
Like replaceLocalValues, but avoids computing row offsets.
std::string description() const override
One-line description of this object.
Sparse matrix whose entries are small dense square blocks, all of the same dimensions.
typename DistObject< Scalar, LO, GO, Node >::buffer_device_type buffer_device_type
Kokkos::Device specialization for communication buffers.
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 hasColMap() const override
Whether this matrix has a well-defined column Map.
virtual void copyAndPermute(const SrcDistObject &source, 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)
Perform copies and permutations that are local to the calling (MPI) process.
virtual bool isLocallyIndexed() const override
Whether matrix indices are locally indexed.
bool hasTransposeApply() const override
Whether it is valid to apply the transpose or conjugate transpose of this matrix. ...
LO local_ordinal_type
The type of local indices.
void getLocalRowViewNonConst(LO LocalRow, local_inds_host_view_type &indices, nonconst_values_host_view_type &values) const
::Tpetra::CrsGraph< LO, GO, node_type > crs_graph_type
The implementation of CrsGraph that this class uses.
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...
void setAllToScalar(const Scalar &alpha)
Set all matrix entries equal to alpha.
Node node_type
The Node type.
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.
bool localError() const
Whether this object had an error on the calling process.
Declaration of the Tpetra::CrsMatrix class.
Scalar scalar_type
The type of entries in the matrix (that is, of each entry in each block).
size_t getLocalNumRows() const override
get the local number of block rows
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)
Perform any unpacking and combining after communication.
virtual Teuchos::RCP< const Teuchos::Comm< int > > getComm() const override
The communicator over which this matrix is distributed.
Kokkos::LayoutRight BlockCrsMatrixLittleBlockArrayLayout
give an option to use layoutleft
virtual void rightScale(const ::Tpetra::Vector< Scalar, LO, GO, Node > &x) override
Scale the RowMatrix on the right with the given Vector x.
::Tpetra::Map< LO, GO, node_type > map_type
The implementation of Map that this class uses.
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.
virtual ~BlockCrsMatrix()
Destructor (declared virtual for memory safety).
MultiVector for multiple degrees of freedom per mesh point.
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
Teuchos::RCP< const map_type > getColMap() const override
get the (mesh) map for the columns of this block matrix.
GO global_ordinal_type
The type of global indices.
virtual size_t getGlobalMaxNumRowEntries() const override
The maximum number of entries in any row over all processes in the matrix's communicator.
size_t global_size_t
Global size_t object.
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.
BlockCrsMatrix()
Default constructor: Makes an empty block matrix.
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:...
Teuchos::RCP< const map_type > getDomainMap() const override
Get the (point) domain Map of this matrix.
device_type::memory_space memory_space
The Kokkos memory space that this class uses.
Teuchos::RCP< const map_type > getRowMap() const override
get the (mesh) map for the rows of this block matrix.
std::string errorMessages() const
The current stream of error messages.
LO sumIntoLocalValuesByOffsets(const LO localRowInd, const ptrdiff_t offsets[], const Scalar vals[], const LO numOffsets) const
Like sumIntoLocalValues, but avoids computing row offsets.
global_size_t getGlobalNumRows() const override
get the global number of block rows
BMV::const_little_vec_type const_little_vec_type
The type used to access const vector blocks.
Communication plan for data redistribution from a (possibly) multiply-owned to a uniquely-owned distr...
virtual Teuchos::RCP< const ::Tpetra::RowGraph< LO, GO, Node > > getGraph() const override
Get the (mesh) graph.
virtual GO getIndexBase() const override
The index base for global indices in this matrix.
virtual void packAndPrepare(const SrcDistObject &source, 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)
Pack data and metadata for communication (sends).
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 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.
CombineMode
Rule for combining data in an Import or Export.
virtual bool isGloballyIndexed() const override
Whether matrix indices are globally indexed.
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.
size_t getLocalMaxNumRowEntries() const override
Maximum number of entries in any row of the matrix, on this process.
virtual global_size_t getGlobalNumEntries() const override
The global number of stored (structurally nonzero) entries.
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.
Abstract base class for objects that can be the source of an Import or Export operation.
device_type::execution_space execution_space
The Kokkos execution space that this class uses.
Teuchos::RCP< const map_type > getRangeMap() const override
Get the (point) range Map 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.
char packet_type
Implementation detail; tells.
local_matrix_device_type getLocalMatrixDevice() const
A read-only, row-oriented interface to a sparse matrix.
A distributed dense vector.
virtual bool supportsRowViews() const override
Whether this object implements getLocalRowView() and getGlobalRowView().
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
BMV::little_vec_type little_vec_type
The type used to access nonconst vector blocks.
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
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.
Node::device_type device_type
The Kokkos::Device specialization that this class uses.
virtual bool isFillComplete() const override
Whether fillComplete() has been called.
impl_scalar_type_dualview::t_host getValuesHostNonConst() const
Get the host or device View of the matrix's values (val_).
Base class for distributed Tpetra objects that support data redistribution.
typename mv_type::impl_scalar_type impl_scalar_type
The implementation type of entries in the object.
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, i.e., block) row.
virtual size_t getLocalNumCols() const override
The number of columns needed to apply the forward operator on this node.
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.
virtual size_t getNumEntriesInGlobalRow(GO globalRow) const override
The current number of entries on the calling process in the specified global row. ...