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" 56 template<
class MatrixType>
63 reverseperm_ (reverseperm)
66 A_.
is_null (), std::invalid_argument,
67 "Ifpack2::ReorderFilter: The input matrix is null.");
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.");
77 A_->getNodeNumRows () != A_->getGlobalNumRows (),
78 std::invalid_argument,
79 "Ifpack2::ReorderFilter: The input matrix is not square.");
82 Indices_.
resize (A_->getNodeMaxNumRowEntries ());
83 Values_.
resize (A_->getNodeMaxNumRowEntries ());
87 template<
class MatrixType>
91 template<
class MatrixType>
98 template<
class MatrixType>
102 return A_->getNode ();
106 template<
class MatrixType>
111 A_.is_null (), std::runtime_error,
"Ifpack2::ReorderFilter::" 112 "getRowMap: The matrix A is null, so there is no row Map.");
114 return A_->getRowMap ();
118 template<
class MatrixType>
123 A_.is_null (), std::runtime_error,
"Ifpack2::ReorderFilter::" 124 "getColMap: The matrix A is null, so there is no column Map.");
126 return A_->getColMap();
130 template<
class MatrixType>
135 A_.is_null (), std::runtime_error,
"Ifpack2::ReorderFilter::" 136 "getDomainMap: The matrix A is null, so there is no domain Map.");
138 return A_->getDomainMap();
142 template<
class MatrixType>
147 A_.is_null (), std::runtime_error,
"Ifpack2::ReorderFilter::" 148 "getRangeMap: The matrix A is null, so there is no range Map.");
150 return A_->getRangeMap();
154 template<
class MatrixType>
155 Teuchos::RCP<
const Tpetra::RowGraph<
typename MatrixType::local_ordinal_type,
156 typename MatrixType::global_ordinal_type,
157 typename MatrixType::node_type> >
160 throw std::runtime_error(
"Ifpack2::ReorderFilter: does not support getGraph.");
164 template<
class MatrixType>
167 return A_->getGlobalNumRows();
171 template<
class MatrixType>
174 return A_->getGlobalNumCols();
178 template<
class MatrixType>
181 return A_->getNodeNumRows();
185 template<
class MatrixType>
188 return A_->getNodeNumCols();
192 template<
class MatrixType>
195 return A_->getIndexBase();
199 template<
class MatrixType>
202 return A_->getGlobalNumEntries();
206 template<
class MatrixType>
209 return A_->getNodeNumEntries();
213 template<
class MatrixType>
217 if (A_.is_null () || A_->getRowMap ().is_null ()) {
221 const local_ordinal_type lclRow =
222 A_->getRowMap ()->getLocalElement (globalRow);
225 return static_cast<size_t> (0);
227 const local_ordinal_type origLclRow = reverseperm_[lclRow];
228 return A_->getNumEntriesInLocalRow (origLclRow);
234 template<
class MatrixType>
240 if (A_->getRowMap ()->isNodeLocalElement (localRow)) {
242 const local_ordinal_type localReorderedRow = reverseperm_[localRow];
243 return A_->getNumEntriesInLocalRow (localReorderedRow);
246 return static_cast<size_t> (0);
251 template<
class MatrixType>
254 return A_->getGlobalMaxNumRowEntries();
258 template<
class MatrixType>
261 return A_->getNodeMaxNumRowEntries();
265 template<
class MatrixType>
272 template<
class MatrixType>
275 return A_->isLocallyIndexed();
279 template<
class MatrixType>
282 return A_->isGloballyIndexed();
286 template<
class MatrixType>
289 return A_->isFillComplete();
293 template<
class MatrixType>
298 size_t& numEntries)
const 302 using Teuchos::av_reinterpret_cast;
303 typedef local_ordinal_type LO;
304 typedef global_ordinal_type GO;
307 const map_type& rowMap = * (A_->getRowMap ());
308 const local_ordinal_type localRow = rowMap.getLocalElement (globalRow);
310 localRow == OTLO::invalid (), std::invalid_argument,
"Ifpack2::Reorder" 311 "Filter::getGlobalRowCopy: The given global row index " << globalRow
312 <<
" is not owned by the calling process with rank " 313 << rowMap.getComm ()->getRank () <<
".");
315 if (
sizeof (GO) ==
sizeof (LO)) {
317 ArrayView<LO> localInd = av_reinterpret_cast<LO> (globalInd);
318 this->getLocalRowCopy (localRow, localInd, val, numEntries);
321 for (
size_t k = 0; k < numEntries; ++k) {
322 globalInd[k] = rowMap.getGlobalElement (localInd[k]);
328 numEntries = this->getNumEntriesInLocalRow (localRow);
329 Array<LO> localInd (numEntries);
330 this->getLocalRowCopy (localRow, localInd, val, numEntries);
333 for (
size_t k = 0; k < numEntries; ++k) {
334 globalInd[k] = rowMap.getGlobalElement (localInd[k]);
340 template<
class MatrixType>
345 size_t &NumEntries)
const 348 ! A_->getRowMap ()->isNodeLocalElement (LocalRow),
349 std::invalid_argument,
350 "Ifpack2::ReorderFilter::getLocalRowCopy: The given local row index " 351 << LocalRow <<
" is not a valid local row index on the calling process " 352 "with rank " << A_->getRowMap ()->getComm ()->getRank () <<
".");
356 const local_ordinal_type origLclRow = reverseperm_[LocalRow];
357 const size_t numEntries = A_->getNumEntriesInLocalRow (origLclRow);
360 static_cast<size_t> (Indices.
size ()) < numEntries ||
361 static_cast<size_t> (Values.
size ()) < numEntries,
362 std::invalid_argument,
363 "Ifpack2::ReorderFilter::getLocalRowCopy: The given array views are not " 364 "long enough to store all the data in the given row " << LocalRow
365 <<
". Indices.size() = " << Indices.
size () <<
", Values.size() = " 366 << Values.
size () <<
", but the (original) row has " << numEntries
369 A_->getLocalRowCopy (origLclRow, Indices, Values, NumEntries);
374 for (
size_t i = 0; i < NumEntries; ++i) {
375 Indices[i] = perm_[Indices[i]];
380 template<
class MatrixType>
386 throw std::runtime_error(
"Ifpack2::ReorderFilter: does not support getGlobalRowView.");
390 template<
class MatrixType>
396 throw std::runtime_error(
"Ifpack2::ReorderFilter: does not support getLocalRowView.");
400 template<
class MatrixType>
402 getLocalDiagCopy (Tpetra::Vector<scalar_type,local_ordinal_type,global_ordinal_type,node_type> &diag)
const 405 return A_->getLocalDiagCopy(diag);
409 template<
class MatrixType>
412 throw std::runtime_error(
"Ifpack2::ReorderFilter does not support leftScale.");
416 template<
class MatrixType>
419 throw std::runtime_error(
"Ifpack2::ReorderFilter does not support rightScale.");
423 template<
class MatrixType>
425 apply (
const Tpetra::MultiVector<scalar_type,local_ordinal_type,global_ordinal_type,node_type> &X,
426 Tpetra::MultiVector<scalar_type,local_ordinal_type,global_ordinal_type,node_type> &Y,
429 scalar_type beta)
const 434 alpha != STS::one () || beta != STS::zero (), std::logic_error,
435 "Ifpack2::ReorderFilter::apply is only implemented for alpha = 1 and " 436 "beta = 0. You set alpha = " << alpha <<
" and beta = " << beta <<
".");
441 X.getNumVectors() != Y.getNumVectors(), std::runtime_error,
442 "Ifpack2::ReorderFilter::apply: X.getNumVectors() != Y.getNumVectors().");
444 const scalar_type
zero = STS::zero ();
449 const size_t NumVectors = Y.getNumVectors ();
451 for (
size_t i = 0; i < A_->getNodeNumRows (); ++i) {
454 getLocalRowCopy (i, Indices_ (), Values_ (), Nnz);
455 if (mode == Teuchos::NO_TRANS) {
456 for (
size_t j = 0; j < Nnz; ++j) {
457 for (
size_t k = 0; k < NumVectors; ++k) {
458 y_ptr[k][i] += Values_[j] * x_ptr[k][Indices_[j]];
462 else if (mode == Teuchos::TRANS) {
463 for (
size_t j = 0; j < Nnz; ++j) {
464 for (
size_t k = 0; k < NumVectors; ++k) {
465 y_ptr[k][Indices_[j]] += Values_[j] * x_ptr[k][i];
470 for (
size_t j = 0; j < Nnz; ++j) {
471 for (
size_t k = 0; k < NumVectors; ++k) {
472 y_ptr[k][Indices_[j]] += STS::conjugate(Values_[j]) * x_ptr[k][i];
480 template<
class MatrixType>
487 template<
class MatrixType>
494 template<
class MatrixType>
498 return A_->getFrobeniusNorm ();
502 template<
class MatrixType>
505 Tpetra::MultiVector<scalar_type,local_ordinal_type,global_ordinal_type,node_type> &reorderedY)
const 507 this->
template permuteOriginalToReorderedTempl<scalar_type,scalar_type>(originalX, reorderedY);
511 template<
class MatrixType>
512 template<
class DomainScalar,
class RangeScalar>
514 Tpetra::MultiVector<RangeScalar,local_ordinal_type,global_ordinal_type,node_type> &reorderedY)
const 517 "Ifpack2::ReorderFilter::permuteOriginalToReordered ERROR: X.getNumVectors() != Y.getNumVectors().");
522 for(
size_t k=0; k < originalX.getNumVectors(); k++)
523 for(local_ordinal_type i=0; (size_t)i< originalX.getLocalLength(); i++)
524 y_ptr[k][perm_[i]] = (RangeScalar)x_ptr[k][i];
528 template<
class MatrixType>
530 Tpetra::MultiVector<scalar_type,local_ordinal_type,global_ordinal_type,node_type> &originalY)
const 532 this->
template permuteReorderedToOriginalTempl<scalar_type,scalar_type>(reorderedX, originalY);
536 template<
class MatrixType>
537 template<
class DomainScalar,
class RangeScalar>
540 Tpetra::MultiVector<RangeScalar,local_ordinal_type,global_ordinal_type,node_type> &originalY)
const 543 reorderedX.getNumVectors() != originalY.getNumVectors(),
545 "Ifpack2::ReorderFilter::permuteReorderedToOriginal: " 546 "X.getNumVectors() != Y.getNumVectors().");
548 #ifdef HAVE_IFPACK2_DEBUG 551 typedef typename STS::magnitudeType magnitude_type;
554 reorderedX.norm2 (norms ());
557 j < reorderedX.getNumVectors (); ++j) {
558 if (STM::isnaninf (norms[j])) {
564 ! good, std::runtime_error,
"Ifpack2::ReorderFilter::" 565 "permuteReorderedToOriginalTempl: The 2-norm of the input reorderedX is " 568 #endif // HAVE_IFPACK2_DEBUG 573 for (
size_t k = 0; k < reorderedX.getNumVectors (); ++k) {
574 for (local_ordinal_type i = 0; (size_t)i < reorderedX.getLocalLength (); ++i) {
575 y_ptr[k][reverseperm_[i]] = (RangeScalar) x_ptr[k][i];
579 #ifdef HAVE_IFPACK2_DEBUG 582 typedef typename STS::magnitudeType magnitude_type;
585 originalY.norm2 (norms ());
588 j < originalY.getNumVectors (); ++j) {
589 if (STM::isnaninf (norms[j])) {
595 ! good, std::runtime_error,
"Ifpack2::ReorderFilter::" 596 "permuteReorderedToOriginalTempl: The 2-norm of the output originalY is " 599 #endif // HAVE_IFPACK2_DEBUG 604 #define IFPACK2_REORDERFILTER_INSTANT(S,LO,GO,N) \ 605 template class Ifpack2::ReorderFilter< Tpetra::RowMatrix<S, LO, GO, N> >; 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:236
Wraps a Tpetra::RowMatrix in a filter that reorders local rows and columns.
Definition: Ifpack2_ReorderFilter_decl.hpp:69
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:273
virtual void getLocalRowView(local_ordinal_type LocalRow, Teuchos::ArrayView< const local_ordinal_type > &indices, Teuchos::ArrayView< const scalar_type > &values) const
Extract a const, non-persisting view of local indices in a specified row of the matrix.
Definition: Ifpack2_ReorderFilter_def.hpp:392
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:504
virtual bool supportsRowViews() const
Returns true if RowViews are supported.
Definition: Ifpack2_ReorderFilter_def.hpp:488
#define TEUCHOS_TEST_FOR_EXCEPTION(throw_exception_test, Exception, msg)
virtual global_size_t getGlobalNumEntries() const
Returns the global number of entries in this matrix.
Definition: Ifpack2_ReorderFilter_def.hpp:200
virtual Teuchos::RCP< const map_type > getRangeMap() const
Returns the Map that describes the range distribution in this matrix.
Definition: Ifpack2_ReorderFilter_def.hpp:144
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:529
virtual Teuchos::RCP< const map_type > getRowMap() const
Returns the Map that describes the row distribution in this matrix.
Definition: Ifpack2_ReorderFilter_def.hpp:108
virtual size_t getGlobalMaxNumRowEntries() const
Returns the maximum number of entries across all rows/columns on all nodes.
Definition: Ifpack2_ReorderFilter_def.hpp:252
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 global_size_t getGlobalNumCols() const
Returns the number of global columns in this matrix.
Definition: Ifpack2_ReorderFilter_def.hpp:172
virtual size_t getNodeNumEntries() const
Returns the local number of entries in this matrix.
Definition: Ifpack2_ReorderFilter_def.hpp:207
virtual size_t getNodeNumCols() const
Returns the number of columns needed to apply the forward operator on this node, i.e., the number of elements listed in the column map.
Definition: Ifpack2_ReorderFilter_def.hpp:186
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:280
virtual global_size_t getGlobalNumRows() const
Returns the number of global rows in this matrix.
Definition: Ifpack2_ReorderFilter_def.hpp:165
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:402
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:425
virtual Teuchos::RCP< node_type > getNode() const
The matrix's Node instance.
Definition: Ifpack2_ReorderFilter_def.hpp:100
virtual Teuchos::RCP< const map_type > getDomainMap() const
Returns the Map that describes the domain distribution in this matrix.
Definition: Ifpack2_ReorderFilter_def.hpp:132
virtual void getGlobalRowCopy(global_ordinal_type GlobalRow, const Teuchos::ArrayView< global_ordinal_type > &Indices, const Teuchos::ArrayView< scalar_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:295
virtual Teuchos::RCP< const map_type > getColMap() const
Returns the Map that describes the column distribution in this matrix.
Definition: Ifpack2_ReorderFilter_def.hpp:120
virtual mag_type getFrobeniusNorm() const
Returns the Frobenius norm of the matrix.
Definition: Ifpack2_ReorderFilter_def.hpp:495
LinearOp zero(const VectorSpace &vs)
void resize(size_type new_size, const value_type &x=value_type())
virtual size_t getNodeMaxNumRowEntries() const
Returns the maximum number of entries across all rows/columns on this node.
Definition: Ifpack2_ReorderFilter_def.hpp:259
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:215
virtual Teuchos::RCP< const Teuchos::Comm< int > > getComm() const
The matrix's communicator.
Definition: Ifpack2_ReorderFilter_def.hpp:92
virtual void getLocalRowCopy(local_ordinal_type DropRow, const Teuchos::ArrayView< local_ordinal_type > &Indices, const Teuchos::ArrayView< scalar_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:342
virtual bool hasTransposeApply() const
Whether apply() can apply the transpose or conjugate transpose.
Definition: Ifpack2_ReorderFilter_def.hpp:481
virtual size_t getNodeNumRows() const
Returns the number of rows owned on the calling node.
Definition: Ifpack2_ReorderFilter_def.hpp:179
virtual bool isFillComplete() const
Returns true if fillComplete() has been called.
Definition: Ifpack2_ReorderFilter_def.hpp:287
virtual void getGlobalRowView(global_ordinal_type GlobalRow, Teuchos::ArrayView< const global_ordinal_type > &indices, Teuchos::ArrayView< const scalar_type > &values) const
Extract a const, non-persisting view of global indices in a specified row of the matrix.
Definition: Ifpack2_ReorderFilter_def.hpp:382
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:410
Preconditioners and smoothers for Tpetra sparse matrices.
Definition: Ifpack2_AdditiveSchwarz_decl.hpp:72
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:417
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:158
virtual bool hasColMap() const
Indicates whether this matrix has a well-defined column map.
Definition: Ifpack2_ReorderFilter_def.hpp:266
virtual ~ReorderFilter()
Destructor.
Definition: Ifpack2_ReorderFilter_def.hpp:88
virtual global_ordinal_type getIndexBase() const
Returns the index base for global indices for this matrix.
Definition: Ifpack2_ReorderFilter_def.hpp:193