43#ifndef IFPACK2_REORDERFILTER_DEF_HPP
44#define IFPACK2_REORDERFILTER_DEF_HPP
45#include "Ifpack2_ReorderFilter_decl.hpp"
48#include "Tpetra_ConfigDefs.hpp"
49#include "Tpetra_RowMatrix.hpp"
50#include "Tpetra_Map.hpp"
51#include "Tpetra_MultiVector.hpp"
52#include "Tpetra_Vector.hpp"
56template<
class MatrixType>
59 const Teuchos::ArrayRCP<local_ordinal_type>& perm,
60 const Teuchos::ArrayRCP<local_ordinal_type>& reverseperm)
63 reverseperm_ (reverseperm)
65 TEUCHOS_TEST_FOR_EXCEPTION(
66 A_.is_null (), std::invalid_argument,
67 "Ifpack2::ReorderFilter: The input matrix is null.");
70 TEUCHOS_TEST_FOR_EXCEPTION(
71 A_->getComm()->getSize() != 1, std::invalid_argument,
72 "Ifpack2::ReorderFilter: This class may only be used if the input matrix's "
73 "communicator has one process. This class is an implementation detail of "
74 "Ifpack2::AdditiveSchwarz, and it is not meant to be used otherwise.");
76 TEUCHOS_TEST_FOR_EXCEPTION(
77 A_->getLocalNumRows () != A_->getGlobalNumRows (),
78 std::invalid_argument,
79 "Ifpack2::ReorderFilter: The input matrix is not square.");
82 Kokkos::resize(Indices_,A_->getLocalMaxNumRowEntries ());
83 Kokkos::resize(Values_,A_->getLocalMaxNumRowEntries ());
87template<
class MatrixType>
91template<
class MatrixType>
100template<
class MatrixType>
101Teuchos::RCP<const typename ReorderFilter<MatrixType>::map_type>
104 TEUCHOS_TEST_FOR_EXCEPTION(
105 A_.is_null (), std::runtime_error,
"Ifpack2::ReorderFilter::"
106 "getRowMap: The matrix A is null, so there is no row Map.");
108 return A_->getRowMap ();
112template<
class MatrixType>
113Teuchos::RCP<const typename ReorderFilter<MatrixType>::map_type>
116 TEUCHOS_TEST_FOR_EXCEPTION(
117 A_.is_null (), std::runtime_error,
"Ifpack2::ReorderFilter::"
118 "getColMap: The matrix A is null, so there is no column Map.");
120 return A_->getColMap();
124template<
class MatrixType>
125Teuchos::RCP<const typename ReorderFilter<MatrixType>::map_type>
128 TEUCHOS_TEST_FOR_EXCEPTION(
129 A_.is_null (), std::runtime_error,
"Ifpack2::ReorderFilter::"
130 "getDomainMap: The matrix A is null, so there is no domain Map.");
132 return A_->getDomainMap();
136template<
class MatrixType>
137Teuchos::RCP<const typename ReorderFilter<MatrixType>::map_type>
140 TEUCHOS_TEST_FOR_EXCEPTION(
141 A_.is_null (), std::runtime_error,
"Ifpack2::ReorderFilter::"
142 "getRangeMap: The matrix A is null, so there is no range Map.");
144 return A_->getRangeMap();
148template<
class MatrixType>
149Teuchos::RCP<
const Tpetra::RowGraph<
typename MatrixType::local_ordinal_type,
150 typename MatrixType::global_ordinal_type,
151 typename MatrixType::node_type> >
154 throw std::runtime_error(
"Ifpack2::ReorderFilter: does not support getGraph.");
158template<
class MatrixType>
161 return A_->getGlobalNumRows();
165template<
class MatrixType>
168 return A_->getGlobalNumCols();
172template<
class MatrixType>
175 return A_->getLocalNumRows();
179template<
class MatrixType>
182 return A_->getLocalNumCols();
186template<
class MatrixType>
189 return A_->getIndexBase();
193template<
class MatrixType>
196 return A_->getGlobalNumEntries();
200template<
class MatrixType>
203 return A_->getLocalNumEntries();
207template<
class MatrixType>
211 if (A_.is_null () || A_->getRowMap ().is_null ()) {
212 return Teuchos::OrdinalTraits<size_t>::invalid ();
215 const local_ordinal_type lclRow =
216 A_->getRowMap ()->getLocalElement (globalRow);
217 if (lclRow == Teuchos::OrdinalTraits<local_ordinal_type>::invalid ()) {
219 return static_cast<size_t> (0);
221 const local_ordinal_type origLclRow = reverseperm_[lclRow];
222 return A_->getNumEntriesInLocalRow (origLclRow);
228template<
class MatrixType>
234 if (A_->getRowMap ()->isNodeLocalElement (localRow)) {
236 const local_ordinal_type localReorderedRow = reverseperm_[localRow];
237 return A_->getNumEntriesInLocalRow (localReorderedRow);
240 return static_cast<size_t> (0);
245template<
class MatrixType>
248 return A_->getGlobalMaxNumRowEntries();
252template<
class MatrixType>
255 return A_->getLocalMaxNumRowEntries();
259template<
class MatrixType>
266template<
class MatrixType>
269 return A_->isLocallyIndexed();
273template<
class MatrixType>
276 return A_->isGloballyIndexed();
280template<
class MatrixType>
283 return A_->isFillComplete();
287template<
class MatrixType>
290 nonconst_global_inds_host_view_type &globalInd,
291 nonconst_values_host_view_type &val,
292 size_t& numEntries)
const
294 using Teuchos::Array;
295 using Teuchos::ArrayView;
296 using Teuchos::av_reinterpret_cast;
297 typedef local_ordinal_type LO;
298 typedef Teuchos::OrdinalTraits<LO> OTLO;
300 const map_type& rowMap = * (A_->getRowMap ());
301 const local_ordinal_type localRow = rowMap.getLocalElement (globalRow);
302 TEUCHOS_TEST_FOR_EXCEPTION(
303 localRow == OTLO::invalid (), std::invalid_argument,
"Ifpack2::Reorder"
304 "Filter::getGlobalRowCopy: The given global row index " << globalRow
305 <<
" is not owned by the calling process with rank "
306 << rowMap.getComm ()->getRank () <<
".");
309 numEntries = this->getNumEntriesInLocalRow (localRow);
310 this->getLocalRowCopy (localRow, Indices_, val, numEntries);
313 for (
size_t k = 0; k < numEntries; ++k) {
314 globalInd[k] = rowMap.getGlobalElement (Indices_[k]);
319template<
class MatrixType>
322 nonconst_local_inds_host_view_type &Indices,
323 nonconst_values_host_view_type &Values,
324 size_t& NumEntries)
const
327 TEUCHOS_TEST_FOR_EXCEPTION(
328 ! A_->getRowMap ()->isNodeLocalElement (LocalRow),
329 std::invalid_argument,
330 "Ifpack2::ReorderFilter::getLocalRowCopy: The given local row index "
331 << LocalRow <<
" is not a valid local row index on the calling process "
332 "with rank " << A_->getRowMap ()->getComm ()->getRank () <<
".");
336 const local_ordinal_type origLclRow = reverseperm_[LocalRow];
337 const size_t numEntries = A_->getNumEntriesInLocalRow (origLclRow);
339 TEUCHOS_TEST_FOR_EXCEPTION(
340 static_cast<size_t> (Indices.size ()) < numEntries ||
341 static_cast<size_t> (Values.size ()) < numEntries,
342 std::invalid_argument,
343 "Ifpack2::ReorderFilter::getLocalRowCopy: The given array views are not "
344 "long enough to store all the data in the given row " << LocalRow
345 <<
". Indices.size() = " << Indices.size () <<
", Values.size() = "
346 << Values.size () <<
", but the (original) row has " << numEntries
349 A_->getLocalRowCopy (origLclRow, Indices, Values, NumEntries);
354 for (
size_t i = 0; i < NumEntries; ++i) {
355 Indices[i] = perm_[Indices[i]];
360template<
class MatrixType>
362 global_inds_host_view_type &,
363 values_host_view_type &)
const
365 throw std::runtime_error(
"Ifpack2::ReorderFilter: does not support getGlobalRowView.");
370template<
class MatrixType>
372 local_inds_host_view_type & ,
373 values_host_view_type & )
const
375 throw std::runtime_error(
"Ifpack2::ReorderFilter: does not support getLocalRowView.");
380template<
class MatrixType>
382getLocalDiagCopy (Tpetra::Vector<scalar_type,local_ordinal_type,global_ordinal_type,node_type> &diag)
const
385 return A_->getLocalDiagCopy(diag);
389template<
class MatrixType>
392 throw std::runtime_error(
"Ifpack2::ReorderFilter does not support leftScale.");
396template<
class MatrixType>
399 throw std::runtime_error(
"Ifpack2::ReorderFilter does not support rightScale.");
403template<
class MatrixType>
405apply (
const Tpetra::MultiVector<scalar_type,local_ordinal_type,global_ordinal_type,node_type> &X,
406 Tpetra::MultiVector<scalar_type,local_ordinal_type,global_ordinal_type,node_type> &Y,
407 Teuchos::ETransp mode,
409 scalar_type beta)
const
411 typedef Teuchos::ScalarTraits<scalar_type> STS;
413 TEUCHOS_TEST_FOR_EXCEPTION(
414 alpha != STS::one () || beta != STS::zero (), std::logic_error,
415 "Ifpack2::ReorderFilter::apply is only implemented for alpha = 1 and "
416 "beta = 0. You set alpha = " << alpha <<
" and beta = " << beta <<
".");
420 TEUCHOS_TEST_FOR_EXCEPTION(
421 X.getNumVectors() != Y.getNumVectors(), std::runtime_error,
422 "Ifpack2::ReorderFilter::apply: X.getNumVectors() != Y.getNumVectors().");
424 const scalar_type zero = STS::zero ();
425 Teuchos::ArrayRCP<Teuchos::ArrayRCP<const scalar_type> > x_ptr = X.get2dView();
426 Teuchos::ArrayRCP<Teuchos::ArrayRCP<scalar_type> > y_ptr = Y.get2dViewNonConst();
429 const size_t NumVectors = Y.getNumVectors ();
431 for (
size_t i = 0; i < A_->getLocalNumRows (); ++i) {
434 getLocalRowCopy (i, Indices_ , Values_ , Nnz);
435 scalar_type* Values =
reinterpret_cast<scalar_type*
>(Values_.data());
436 if (mode == Teuchos::NO_TRANS) {
437 for (
size_t j = 0; j < Nnz; ++j) {
438 for (
size_t k = 0; k < NumVectors; ++k) {
439 y_ptr[k][i] += Values[j] * x_ptr[k][Indices_[j]];
443 else if (mode == Teuchos::TRANS) {
444 for (
size_t j = 0; j < Nnz; ++j) {
445 for (
size_t k = 0; k < NumVectors; ++k) {
446 y_ptr[k][Indices_[j]] += Values[j] * x_ptr[k][i];
451 for (
size_t j = 0; j < Nnz; ++j) {
452 for (
size_t k = 0; k < NumVectors; ++k) {
453 y_ptr[k][Indices_[j]] += STS::conjugate(Values[j]) * x_ptr[k][i];
461template<
class MatrixType>
468template<
class MatrixType>
475template<
class MatrixType>
479 return A_->getFrobeniusNorm ();
483template<
class MatrixType>
485permuteOriginalToReordered (
const Tpetra::MultiVector<scalar_type,local_ordinal_type,global_ordinal_type,node_type> &originalX,
486 Tpetra::MultiVector<scalar_type,local_ordinal_type,global_ordinal_type,node_type> &reorderedY)
const
488 this->
template permuteOriginalToReorderedTempl<scalar_type,scalar_type>(originalX, reorderedY);
492template<
class MatrixType>
493template<
class DomainScalar,
class RangeScalar>
495 Tpetra::MultiVector<RangeScalar,local_ordinal_type,global_ordinal_type,node_type> &reorderedY)
const
497 TEUCHOS_TEST_FOR_EXCEPTION(originalX.getNumVectors() != reorderedY.getNumVectors(), std::runtime_error,
498 "Ifpack2::ReorderFilter::permuteOriginalToReordered ERROR: X.getNumVectors() != Y.getNumVectors().");
500 Teuchos::ArrayRCP<Teuchos::ArrayRCP<const DomainScalar> > x_ptr = originalX.get2dView();
501 Teuchos::ArrayRCP<Teuchos::ArrayRCP<RangeScalar> > y_ptr = reorderedY.get2dViewNonConst();
503 for(
size_t k=0; k < originalX.getNumVectors(); k++)
504 for(local_ordinal_type i=0; (size_t)i< originalX.getLocalLength(); i++)
505 y_ptr[k][perm_[i]] = (RangeScalar)x_ptr[k][i];
509template<
class MatrixType>
511 Tpetra::MultiVector<scalar_type,local_ordinal_type,global_ordinal_type,node_type> &originalY)
const
513 this->
template permuteReorderedToOriginalTempl<scalar_type,scalar_type>(reorderedX, originalY);
517template<
class MatrixType>
518template<
class DomainScalar,
class RangeScalar>
521 Tpetra::MultiVector<RangeScalar,local_ordinal_type,global_ordinal_type,node_type> &originalY)
const
523 TEUCHOS_TEST_FOR_EXCEPTION(
524 reorderedX.getNumVectors() != originalY.getNumVectors(),
526 "Ifpack2::ReorderFilter::permuteReorderedToOriginal: "
527 "X.getNumVectors() != Y.getNumVectors().");
529#ifdef HAVE_IFPACK2_DEBUG
531 typedef Teuchos::ScalarTraits<DomainScalar> STS;
532 typedef Teuchos::ScalarTraits<magnitude_type> STM;
533 Teuchos::Array<magnitude_type> norms (reorderedX.getNumVectors ());
534 reorderedX.norm2 (norms ());
537 j < reorderedX.getNumVectors (); ++j) {
538 if (STM::isnaninf (norms[j])) {
543 TEUCHOS_TEST_FOR_EXCEPTION(
544 ! good, std::runtime_error,
"Ifpack2::ReorderFilter::"
545 "permuteReorderedToOriginalTempl: The 2-norm of the input reorderedX is "
550 Teuchos::ArrayRCP<Teuchos::ArrayRCP<const DomainScalar> > x_ptr = reorderedX.get2dView();
551 Teuchos::ArrayRCP<Teuchos::ArrayRCP<RangeScalar> > y_ptr = originalY.get2dViewNonConst();
553 for (
size_t k = 0; k < reorderedX.getNumVectors (); ++k) {
554 for (local_ordinal_type i = 0; (size_t)i < reorderedX.getLocalLength (); ++i) {
555 y_ptr[k][reverseperm_[i]] = (RangeScalar) x_ptr[k][i];
559#ifdef HAVE_IFPACK2_DEBUG
561 typedef Teuchos::ScalarTraits<RangeScalar> STS;
562 typedef Teuchos::ScalarTraits<magnitude_type> STM;
563 Teuchos::Array<magnitude_type> norms (originalY.getNumVectors ());
564 originalY.norm2 (norms ());
567 j < originalY.getNumVectors (); ++j) {
568 if (STM::isnaninf (norms[j])) {
573 TEUCHOS_TEST_FOR_EXCEPTION(
574 ! good, std::runtime_error,
"Ifpack2::ReorderFilter::"
575 "permuteReorderedToOriginalTempl: The 2-norm of the output originalY is "
583#define IFPACK2_REORDERFILTER_INSTANT(S,LO,GO,N) \
584 template class Ifpack2::ReorderFilter< Tpetra::RowMatrix<S, LO, GO, N> >;
Wraps a Tpetra::RowMatrix in a filter that reorders local rows and columns.
Definition Ifpack2_ReorderFilter_decl.hpp:70
virtual size_t getLocalNumCols() const
Returns the number of columns needed to apply the forward operator on this node, i....
Definition Ifpack2_ReorderFilter_def.hpp:180
virtual size_t getNumEntriesInGlobalRow(global_ordinal_type globalRow) const
The current number of entries in this matrix, stored on the calling process, in the row whose global ...
Definition Ifpack2_ReorderFilter_def.hpp:209
virtual mag_type getFrobeniusNorm() const
Returns the Frobenius norm of the matrix.
Definition Ifpack2_ReorderFilter_def.hpp:476
virtual size_t getGlobalMaxNumRowEntries() const
Returns the maximum number of entries across all rows/columns on all nodes.
Definition Ifpack2_ReorderFilter_def.hpp:246
virtual Teuchos::RCP< const map_type > getColMap() const
Returns the Map that describes the column distribution in this matrix.
Definition Ifpack2_ReorderFilter_def.hpp:114
virtual void rightScale(const Tpetra::Vector< scalar_type, local_ordinal_type, global_ordinal_type, node_type > &x)
Scales the RowMatrix on the right with the Vector x.
Definition Ifpack2_ReorderFilter_def.hpp:397
virtual bool hasColMap() const
Indicates whether this matrix has a well-defined column map.
Definition Ifpack2_ReorderFilter_def.hpp:260
virtual size_t getLocalMaxNumRowEntries() const
Returns the maximum number of entries across all rows/columns on this node.
Definition Ifpack2_ReorderFilter_def.hpp:253
virtual void permuteReorderedToOriginal(const Tpetra::MultiVector< scalar_type, local_ordinal_type, global_ordinal_type, node_type > &reorderedX, Tpetra::MultiVector< scalar_type, local_ordinal_type, global_ordinal_type, node_type > &originalY) const
Permute multivector: reordered-to-original.
Definition Ifpack2_ReorderFilter_def.hpp:510
virtual void permuteOriginalToReordered(const Tpetra::MultiVector< scalar_type, local_ordinal_type, global_ordinal_type, node_type > &originalX, Tpetra::MultiVector< scalar_type, local_ordinal_type, global_ordinal_type, node_type > &reorderedY) const
Permute multivector: original-to-reordered.
Definition Ifpack2_ReorderFilter_def.hpp:485
virtual Teuchos::RCP< const map_type > getDomainMap() const
Returns the Map that describes the domain distribution in this matrix.
Definition Ifpack2_ReorderFilter_def.hpp:126
virtual bool supportsRowViews() const
Returns true if RowViews are supported.
Definition Ifpack2_ReorderFilter_def.hpp:469
virtual global_ordinal_type getIndexBase() const
Returns the index base for global indices for this matrix.
Definition Ifpack2_ReorderFilter_def.hpp:187
virtual void getLocalDiagCopy(Tpetra::Vector< scalar_type, local_ordinal_type, global_ordinal_type, node_type > &diag) const
Get a copy of the diagonal entries owned by this node, with local row indices.
Definition Ifpack2_ReorderFilter_def.hpp:382
virtual bool isGloballyIndexed() const
If matrix indices are in the global range, this function returns true. Otherwise, this function retur...
Definition Ifpack2_ReorderFilter_def.hpp:274
virtual Teuchos::RCP< const map_type > getRowMap() const
Returns the Map that describes the row distribution in this matrix.
Definition Ifpack2_ReorderFilter_def.hpp:102
virtual size_t getLocalNumRows() const
Returns the number of rows owned on the calling node.
Definition Ifpack2_ReorderFilter_def.hpp:173
virtual Teuchos::RCP< const map_type > getRangeMap() const
Returns the Map that describes the range distribution in this matrix.
Definition Ifpack2_ReorderFilter_def.hpp:138
virtual Teuchos::RCP< const Teuchos::Comm< int > > getComm() const
The matrix's communicator.
Definition Ifpack2_ReorderFilter_def.hpp:92
ReorderFilter(const Teuchos::RCP< const row_matrix_type > &A, const Teuchos::ArrayRCP< local_ordinal_type > &perm, const Teuchos::ArrayRCP< local_ordinal_type > &reverseperm)
Constructor.
Definition Ifpack2_ReorderFilter_def.hpp:58
virtual bool isFillComplete() const
Returns true if fillComplete() has been called.
Definition Ifpack2_ReorderFilter_def.hpp:281
virtual bool isLocallyIndexed() const
If matrix indices are in the local range, this function returns true. Otherwise, this function return...
Definition Ifpack2_ReorderFilter_def.hpp:267
virtual size_t getLocalNumEntries() const
Returns the local number of entries in this matrix.
Definition Ifpack2_ReorderFilter_def.hpp:201
virtual ~ReorderFilter()
Destructor.
Definition Ifpack2_ReorderFilter_def.hpp:88
virtual void getGlobalRowCopy(global_ordinal_type GlobalRow, nonconst_global_inds_host_view_type &Indices, nonconst_values_host_view_type &Values, size_t &NumEntries) const
Extract a list of entries in a specified global row of this matrix. Put into pre-allocated storage.
Definition Ifpack2_ReorderFilter_def.hpp:289
virtual void getLocalRowView(local_ordinal_type LocalRow, local_inds_host_view_type &indices, values_host_view_type &values) const
Extract a const, non-persisting view of local indices in a specified row of the matrix.
Definition Ifpack2_ReorderFilter_def.hpp:371
virtual size_t getNumEntriesInLocalRow(local_ordinal_type localRow) const
The current number of entries in this matrix, stored on the calling process, in the row whose local i...
Definition Ifpack2_ReorderFilter_def.hpp:230
virtual void getLocalRowCopy(local_ordinal_type LocalRow, nonconst_local_inds_host_view_type &Indices, nonconst_values_host_view_type &Values, size_t &NumEntries) const
Extract a list of entries in a specified local row of the graph. Put into storage allocated by callin...
Definition Ifpack2_ReorderFilter_def.hpp:321
virtual Teuchos::RCP< const Tpetra::RowGraph< local_ordinal_type, global_ordinal_type, node_type > > getGraph() const
Returns the RowGraph associated with this matrix.
Definition Ifpack2_ReorderFilter_def.hpp:152
virtual void apply(const Tpetra::MultiVector< scalar_type, local_ordinal_type, global_ordinal_type, node_type > &X, Tpetra::MultiVector< scalar_type, local_ordinal_type, global_ordinal_type, node_type > &Y, Teuchos::ETransp mode=Teuchos::NO_TRANS, scalar_type alpha=Teuchos::ScalarTraits< scalar_type >::one(), scalar_type beta=Teuchos::ScalarTraits< scalar_type >::zero()) const
, where Op(A) is either A, , or .
Definition Ifpack2_ReorderFilter_def.hpp:405
virtual global_size_t getGlobalNumRows() const
Returns the number of global rows in this matrix.
Definition Ifpack2_ReorderFilter_def.hpp:159
virtual bool hasTransposeApply() const
Whether apply() can apply the transpose or conjugate transpose.
Definition Ifpack2_ReorderFilter_def.hpp:462
virtual global_size_t getGlobalNumCols() const
Returns the number of global columns in this matrix.
Definition Ifpack2_ReorderFilter_def.hpp:166
virtual global_size_t getGlobalNumEntries() const
Returns the global number of entries in this matrix.
Definition Ifpack2_ReorderFilter_def.hpp:194
virtual void leftScale(const Tpetra::Vector< scalar_type, local_ordinal_type, global_ordinal_type, node_type > &x)
Scales the RowMatrix on the left with the Vector x.
Definition Ifpack2_ReorderFilter_def.hpp:390
virtual void getGlobalRowView(global_ordinal_type GlobalRow, global_inds_host_view_type &indices, values_host_view_type &values) const
Extract a const, non-persisting view of global indices in a specified row of the matrix.
Definition Ifpack2_ReorderFilter_def.hpp:361
Preconditioners and smoothers for Tpetra sparse matrices.
Definition Ifpack2_AdditiveSchwarz_decl.hpp:74