42 #ifndef TPETRA_ROWMATRIX_DEF_HPP
43 #define TPETRA_ROWMATRIX_DEF_HPP
45 #include "Tpetra_CrsMatrix.hpp"
46 #include "Tpetra_Map.hpp"
47 #include "Tpetra_RowGraph.hpp"
51 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
54 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
55 Teuchos::RCP<RowMatrix<Scalar, LocalOrdinal, GlobalOrdinal, Node> >
57 add (
const Scalar& alpha,
62 const Teuchos::RCP<Teuchos::ParameterList>& params)
const
65 using Teuchos::ArrayView;
66 using Teuchos::ParameterList;
69 using Teuchos::rcp_implicit_cast;
70 using Teuchos::sublist;
71 typedef LocalOrdinal LO;
72 typedef GlobalOrdinal GO;
73 typedef Teuchos::ScalarTraits<Scalar> STS;
78 const this_type& B = *
this;
86 RCP<const map_type> B_domainMap = B.getDomainMap ();
87 RCP<const map_type> B_rangeMap = B.getRangeMap ();
89 RCP<const map_type> theDomainMap = domainMap;
90 RCP<const map_type> theRangeMap = rangeMap;
92 if (domainMap.is_null ()) {
93 if (B_domainMap.is_null ()) {
94 TEUCHOS_TEST_FOR_EXCEPTION(
95 A_domainMap.is_null (), std::invalid_argument,
96 "Tpetra::RowMatrix::add: If neither A nor B have a domain Map, "
97 "then you must supply a nonnull domain Map to this method.");
98 theDomainMap = A_domainMap;
100 theDomainMap = B_domainMap;
103 if (rangeMap.is_null ()) {
104 if (B_rangeMap.is_null ()) {
105 TEUCHOS_TEST_FOR_EXCEPTION(
106 A_rangeMap.is_null (), std::invalid_argument,
107 "Tpetra::RowMatrix::add: If neither A nor B have a range Map, "
108 "then you must supply a nonnull range Map to this method.");
109 theRangeMap = A_rangeMap;
111 theRangeMap = B_rangeMap;
115 #ifdef HAVE_TPETRA_DEBUG
119 if (! A_domainMap.is_null () && ! A_rangeMap.is_null ()) {
120 if (! B_domainMap.is_null () && ! B_rangeMap.is_null ()) {
121 TEUCHOS_TEST_FOR_EXCEPTION(
122 ! B_domainMap->isSameAs (*A_domainMap), std::invalid_argument,
123 "Tpetra::RowMatrix::add: The input RowMatrix A must have a domain Map "
124 "which is the same as (isSameAs) this RowMatrix's domain Map.");
125 TEUCHOS_TEST_FOR_EXCEPTION(
126 ! B_rangeMap->isSameAs (*A_rangeMap), std::invalid_argument,
127 "Tpetra::RowMatrix::add: The input RowMatrix A must have a range Map "
128 "which is the same as (isSameAs) this RowMatrix's range Map.");
129 TEUCHOS_TEST_FOR_EXCEPTION(
130 ! domainMap.is_null () && ! domainMap->isSameAs (*B_domainMap),
131 std::invalid_argument,
132 "Tpetra::RowMatrix::add: The input domain Map must be the same as "
133 "(isSameAs) this RowMatrix's domain Map.");
134 TEUCHOS_TEST_FOR_EXCEPTION(
135 ! rangeMap.is_null () && ! rangeMap->isSameAs (*B_rangeMap),
136 std::invalid_argument,
137 "Tpetra::RowMatrix::add: The input range Map must be the same as "
138 "(isSameAs) this RowMatrix's range Map.");
141 else if (! B_domainMap.is_null () && ! B_rangeMap.is_null ()) {
142 TEUCHOS_TEST_FOR_EXCEPTION(
143 ! domainMap.is_null () && ! domainMap->isSameAs (*B_domainMap),
144 std::invalid_argument,
145 "Tpetra::RowMatrix::add: The input domain Map must be the same as "
146 "(isSameAs) this RowMatrix's domain Map.");
147 TEUCHOS_TEST_FOR_EXCEPTION(
148 ! rangeMap.is_null () && ! rangeMap->isSameAs (*B_rangeMap),
149 std::invalid_argument,
150 "Tpetra::RowMatrix::add: The input range Map must be the same as "
151 "(isSameAs) this RowMatrix's range Map.");
154 TEUCHOS_TEST_FOR_EXCEPTION(
155 domainMap.is_null () || rangeMap.is_null (), std::invalid_argument,
156 "Tpetra::RowMatrix::add: If neither A nor B have a domain and range "
157 "Map, then you must supply a nonnull domain and range Map to this "
160 #endif // HAVE_TPETRA_DEBUG
165 bool callFillComplete =
true;
166 RCP<ParameterList> constructorSublist;
167 RCP<ParameterList> fillCompleteSublist;
168 if (! params.is_null ()) {
169 callFillComplete = params->get (
"Call fillComplete", callFillComplete);
170 constructorSublist = sublist (params,
"Constructor parameters");
171 fillCompleteSublist = sublist (params,
"fillComplete parameters");
174 RCP<const map_type> A_rowMap = A.
getRowMap ();
175 RCP<const map_type> B_rowMap = B.getRowMap ();
176 RCP<const map_type> C_rowMap = B_rowMap;
177 RCP<crs_matrix_type> C;
184 if (A_rowMap->isSameAs (*B_rowMap)) {
185 const LO localNumRows =
static_cast<LO
> (A_rowMap->getNodeNumElements ());
186 Array<size_t> C_maxNumEntriesPerRow (localNumRows, 0);
189 if (alpha != STS::zero ()) {
190 for (LO localRow = 0; localRow < localNumRows; ++localRow) {
192 C_maxNumEntriesPerRow[localRow] += A_numEntries;
196 if (beta != STS::zero ()) {
197 for (LO localRow = 0; localRow < localNumRows; ++localRow) {
198 const size_t B_numEntries = B.getNumEntriesInLocalRow (localRow);
199 C_maxNumEntriesPerRow[localRow] += B_numEntries;
203 if (constructorSublist.is_null ()) {
204 C = rcp (
new crs_matrix_type (C_rowMap, C_maxNumEntriesPerRow (),
207 C = rcp (
new crs_matrix_type (C_rowMap, C_maxNumEntriesPerRow (),
208 StaticProfile, constructorSublist));
219 TEUCHOS_TEST_FOR_EXCEPTION(
true,
220 std::invalid_argument,
221 "Tpetra::RowMatrix::add: The row maps must be the same for statically "
222 "allocated matrices in order to be sure that there is sufficient space "
223 "to do the addition");
226 #ifdef HAVE_TPETRA_DEBUG
227 TEUCHOS_TEST_FOR_EXCEPTION(C.is_null (), std::logic_error,
228 "Tpetra::RowMatrix::add: C should not be null at this point. "
229 "Please report this bug to the Tpetra developers.");
230 #endif // HAVE_TPETRA_DEBUG
237 if (alpha != STS::zero ()) {
238 const LO A_localNumRows =
static_cast<LO
> (A_rowMap->getNodeNumElements ());
239 for (LO localRow = 0; localRow < A_localNumRows; ++localRow) {
241 const GO globalRow = A_rowMap->getGlobalElement (localRow);
242 if (A_numEntries > static_cast<size_t> (ind.size ())) {
243 ind.resize (A_numEntries);
244 val.resize (A_numEntries);
246 ArrayView<GO> indView = ind (0, A_numEntries);
247 ArrayView<Scalar> valView = val (0, A_numEntries);
250 if (alpha != STS::one ()) {
251 for (
size_t k = 0; k < A_numEntries; ++k) {
255 C->insertGlobalValues (globalRow, indView, valView);
259 if (beta != STS::zero ()) {
260 const LO B_localNumRows =
static_cast<LO
> (B_rowMap->getNodeNumElements ());
261 for (LO localRow = 0; localRow < B_localNumRows; ++localRow) {
262 size_t B_numEntries = B.getNumEntriesInLocalRow (localRow);
263 const GO globalRow = B_rowMap->getGlobalElement (localRow);
264 if (B_numEntries > static_cast<size_t> (ind.size ())) {
265 ind.resize (B_numEntries);
266 val.resize (B_numEntries);
268 ArrayView<GO> indView = ind (0, B_numEntries);
269 ArrayView<Scalar> valView = val (0, B_numEntries);
270 B.getGlobalRowCopy (globalRow, indView, valView, B_numEntries);
272 if (beta != STS::one ()) {
273 for (
size_t k = 0; k < B_numEntries; ++k) {
277 C->insertGlobalValues (globalRow, indView, valView);
281 if (callFillComplete) {
282 if (fillCompleteSublist.is_null ()) {
283 C->fillComplete (theDomainMap, theRangeMap);
285 C->fillComplete (theDomainMap, theRangeMap, fillCompleteSublist);
289 return rcp_implicit_cast<this_type> (C);
293 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
296 pack (
const Teuchos::ArrayView<const LocalOrdinal>& exportLIDs,
297 Teuchos::Array<char>& exports,
298 const Teuchos::ArrayView<size_t>& numPacketsPerLID,
299 size_t& constantNumPackets,
302 #ifdef HAVE_TPETRA_DEBUG
303 const char tfecfFuncName[] =
"pack: ";
305 using Teuchos::reduceAll;
306 std::ostringstream msg;
309 this->packImpl (exportLIDs, exports, numPacketsPerLID,
310 constantNumPackets, distor);
311 }
catch (std::exception& e) {
316 const Teuchos::Comm<int>& comm = * (this->getComm ());
317 reduceAll<int, int> (comm, Teuchos::REDUCE_MAX,
318 lclBad, Teuchos::outArg (gblBad));
320 const int myRank = comm.getRank ();
321 const int numProcs = comm.getSize ();
322 for (
int r = 0; r < numProcs; ++r) {
323 if (r == myRank && lclBad != 0) {
324 std::ostringstream os;
325 os <<
"Proc " << myRank <<
": " << msg.str () << std::endl;
326 std::cerr << os.str ();
332 TEUCHOS_TEST_FOR_EXCEPTION_CLASS_FUNC(
333 true, std::logic_error,
"packImpl() threw an exception on one or "
334 "more participating processes.");
338 this->packImpl (exportLIDs, exports, numPacketsPerLID,
339 constantNumPackets, distor);
340 #endif // HAVE_TPETRA_DEBUG
343 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
347 size_t& totalNumEntries,
348 const Teuchos::ArrayView<const LocalOrdinal>& exportLIDs)
const
350 typedef LocalOrdinal LO;
351 typedef GlobalOrdinal GO;
352 typedef typename Teuchos::ArrayView<const LO>::size_type size_type;
354 const size_type numExportLIDs = exportLIDs.size ();
358 for (size_type i = 0; i < numExportLIDs; ++i) {
359 const LO lclRow = exportLIDs[i];
360 size_t curNumEntries = this->getNumEntriesInLocalRow (lclRow);
363 if (curNumEntries == Teuchos::OrdinalTraits<size_t>::invalid ()) {
366 totalNumEntries += curNumEntries;
377 const size_t allocSize =
378 static_cast<size_t> (numExportLIDs) *
sizeof (LO) +
379 totalNumEntries * (
sizeof (Scalar) +
sizeof (GO));
380 if (static_cast<size_t> (exports.size ()) < allocSize) {
381 exports.resize (allocSize);
385 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
387 RowMatrix<Scalar, LocalOrdinal, GlobalOrdinal, Node>::
388 packRow (
char*
const numEntOut,
392 const LocalOrdinal lclRow)
const
394 using Teuchos::Array;
395 using Teuchos::ArrayView;
396 typedef LocalOrdinal LO;
397 typedef GlobalOrdinal GO;
400 const LO numEntLO =
static_cast<LO
> (numEnt);
401 memcpy (numEntOut, &numEntLO,
sizeof (LO));
403 if (this->supportsRowViews ()) {
404 if (this->isLocallyIndexed ()) {
408 ArrayView<const LO> indIn;
409 ArrayView<const Scalar> valIn;
410 this->getLocalRowView (lclRow, indIn, valIn);
411 const map_type& colMap = * (this->getColMap ());
414 for (
size_t k = 0; k < numEnt; ++k) {
415 const GO gblIndIn = colMap.getGlobalElement (indIn[k]);
416 memcpy (indOut + k *
sizeof (GO), &gblIndIn,
sizeof (GO));
418 memcpy (valOut, valIn.getRawPtr (), numEnt *
sizeof (Scalar));
420 else if (this->isGloballyIndexed ()) {
426 ArrayView<const GO> indIn;
427 ArrayView<const Scalar> valIn;
428 const map_type& rowMap = * (this->getRowMap ());
429 const GO gblRow = rowMap.getGlobalElement (lclRow);
430 this->getGlobalRowView (gblRow, indIn, valIn);
431 memcpy (indOut, indIn.getRawPtr (), numEnt *
sizeof (GO));
432 memcpy (valOut, valIn.getRawPtr (), numEnt *
sizeof (Scalar));
443 if (this->isLocallyIndexed ()) {
444 Array<LO> indIn (numEnt);
445 Array<Scalar> valIn (numEnt);
446 size_t theNumEnt = 0;
447 this->getLocalRowCopy (lclRow, indIn (), valIn (), theNumEnt);
448 if (theNumEnt != numEnt) {
451 const map_type& colMap = * (this->getColMap ());
454 for (
size_t k = 0; k < numEnt; ++k) {
455 const GO gblIndIn = colMap.getGlobalElement (indIn[k]);
456 memcpy (indOut + k *
sizeof (GO), &gblIndIn,
sizeof (GO));
458 memcpy (valOut, valIn.getRawPtr (), numEnt *
sizeof (Scalar));
460 else if (this->isGloballyIndexed ()) {
461 Array<GO> indIn (numEnt);
462 Array<Scalar> valIn (numEnt);
463 const map_type& rowMap = * (this->getRowMap ());
464 const GO gblRow = rowMap.getGlobalElement (lclRow);
465 size_t theNumEnt = 0;
466 this->getGlobalRowCopy (gblRow, indIn, valIn, theNumEnt);
467 if (theNumEnt != numEnt) {
470 memcpy (indOut, indIn.getRawPtr (), numEnt *
sizeof (GO));
471 memcpy (valOut, valIn.getRawPtr (), numEnt *
sizeof (Scalar));
482 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
484 RowMatrix<Scalar, LocalOrdinal, GlobalOrdinal, Node>::
485 packImpl (
const Teuchos::ArrayView<const LocalOrdinal>& exportLIDs,
486 Teuchos::Array<char>& exports,
487 const Teuchos::ArrayView<size_t>& numPacketsPerLID,
488 size_t& constantNumPackets,
491 using Teuchos::Array;
492 using Teuchos::ArrayView;
494 using Teuchos::av_reinterpret_cast;
496 typedef LocalOrdinal LO;
497 typedef GlobalOrdinal GO;
498 typedef typename ArrayView<const LO>::size_type size_type;
499 const char tfecfFuncName[] =
"packImpl: ";
501 const size_type numExportLIDs = exportLIDs.size ();
502 TEUCHOS_TEST_FOR_EXCEPTION_CLASS_FUNC(
503 numExportLIDs != numPacketsPerLID.size (), std::invalid_argument,
504 "exportLIDs.size() = " << numExportLIDs <<
" != numPacketsPerLID.size()"
505 " = " << numPacketsPerLID.size () <<
".");
510 constantNumPackets = 0;
515 size_t totalNumEntries = 0;
516 allocatePackSpace (exports, totalNumEntries, exportLIDs);
517 const size_t bufSize =
static_cast<size_t> (exports.size ());
529 size_type firstBadIndex = 0;
530 size_t firstBadOffset = 0;
531 size_t firstBadNumBytes = 0;
533 bool packErr =
false;
535 char*
const exportsRawPtr = exports.getRawPtr ();
537 for (size_type i = 0; i < numExportLIDs; ++i) {
538 const LO lclRow = exportLIDs[i];
539 const size_t numEnt = this->getNumEntriesInLocalRow (lclRow);
543 numPacketsPerLID[i] = 0;
546 char*
const numEntBeg = exportsRawPtr + offset;
547 char*
const numEntEnd = numEntBeg +
sizeof (LO);
548 char*
const valBeg = numEntEnd;
549 char*
const valEnd = valBeg + numEnt *
sizeof (Scalar);
550 char*
const indBeg = valEnd;
551 const size_t numBytes =
sizeof (LO) +
552 numEnt * (
sizeof (Scalar) +
sizeof (GO));
553 if (offset > bufSize || offset + numBytes > bufSize) {
555 firstBadOffset = offset;
556 firstBadNumBytes = numBytes;
560 packErr = ! packRow (numEntBeg, valBeg, indBeg, numEnt, lclRow);
563 firstBadOffset = offset;
564 firstBadNumBytes = numBytes;
570 numPacketsPerLID[i] = numBytes;
581 TEUCHOS_TEST_FOR_EXCEPTION(
582 outOfBounds, std::logic_error,
"First invalid offset into 'exports' "
583 "pack buffer at index i = " << firstBadIndex <<
". exportLIDs[i]: "
584 << exportLIDs[firstBadIndex] <<
", bufSize: " << bufSize <<
", offset: "
585 << firstBadOffset <<
", numBytes: " << firstBadNumBytes <<
".");
586 TEUCHOS_TEST_FOR_EXCEPTION(
587 packErr, std::logic_error,
"First error in packRow() at index i = "
588 << firstBadIndex <<
". exportLIDs[i]: " << exportLIDs[firstBadIndex]
589 <<
", bufSize: " << bufSize <<
", offset: " << firstBadOffset
590 <<
", numBytes: " << firstBadNumBytes <<
".");
593 template <
class Scalar,
class LocalOrdinal,
class GlobalOrdinal,
class Node>
597 LocalOrdinal& numEnt,
598 const LocalOrdinal*& lclColInds,
599 const Scalar*& vals)
const
604 Teuchos::ArrayView<const LocalOrdinal> lclColInds_av;
605 Teuchos::ArrayView<const Scalar> vals_av;
607 this->getLocalRowView (lclRow, lclColInds_av, vals_av);
608 numEnt =
static_cast<LocalOrdinal
> (lclColInds_av.size ());
614 lclColInds = lclColInds_av.getRawPtr ();
615 vals = vals_av.getRawPtr ();
618 return static_cast<LocalOrdinal
> (0);
629 #define TPETRA_ROWMATRIX_INSTANT(SCALAR,LO,GO,NODE) \
630 template class RowMatrix< SCALAR , LO , GO , NODE >;
633 #endif // TPETRA_ROWMATRIX_DEF_HPP
KOKKOS_INLINE_FUNCTION bool outOfBounds(const IntegerType x, const IntegerType exclusiveUpperBound)
Is x out of bounds? That is, is x less than zero, or greater than or equal to the given exclusive upp...
Sparse matrix that presents a row-oriented interface that lets users read or modify entries...
virtual size_t getNumEntriesInLocalRow(LocalOrdinal localRow) const =0
The current number of entries on the calling process in the specified local row.
virtual Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > getRangeMap() const =0
The Map associated with the range of this operator, which must be compatible with Y...
virtual LocalOrdinal getLocalRowViewRaw(const LocalOrdinal lclRow, LocalOrdinal &numEnt, const LocalOrdinal *&lclColInds, const Scalar *&vals) const
Get a constant, nonpersisting, locally indexed view of the given row of the matrix, using "raw" pointers instead of Teuchos::ArrayView.
virtual ~RowMatrix()
Destructor (virtual for memory safety of derived classes).
virtual void getGlobalRowCopy(GlobalOrdinal GlobalRow, const Teuchos::ArrayView< GlobalOrdinal > &Indices, const Teuchos::ArrayView< Scalar > &Values, size_t &NumEntries) const =0
Get a copy of the given global row's entries.
virtual Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > getDomainMap() const =0
The Map associated with the domain of this operator, which must be compatible with X...
Sets up and executes a communication plan for a Tpetra DistObject.
virtual void pack(const Teuchos::ArrayView< const LocalOrdinal > &exportLIDs, Teuchos::Array< char > &exports, const Teuchos::ArrayView< size_t > &numPacketsPerLID, size_t &constantNumPackets, Distributor &distor) const
Pack this object's data for an Import or Export.
virtual Teuchos::RCP< RowMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > add(const Scalar &alpha, const RowMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > &A, const Scalar &beta, const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &domainMap=Teuchos::null, const Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > &rangeMap=Teuchos::null, const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) const
Return a new RowMatrix which is the result of beta*this + alpha*A.
A parallel distribution of indices over processes.
A read-only, row-oriented interface to a sparse matrix.
virtual Teuchos::RCP< const Map< LocalOrdinal, GlobalOrdinal, Node > > getRowMap() const =0
The Map that describes the distribution of rows over processes.