Ifpack2 Templated Preconditioning Package  Version 1.0
Ifpack2_ReorderFilter_def.hpp
1 /*@HEADER
2 // ***********************************************************************
3 //
4 // Ifpack2: Tempated Object-Oriented Algebraic Preconditioner Package
5 // Copyright (2009) Sandia Corporation
6 //
7 // Under terms of Contract DE-AC04-94AL85000, there is a non-exclusive
8 // license for use of this work by or on behalf of the U.S. Government.
9 //
10 // Redistribution and use in source and binary forms, with or without
11 // modification, are permitted provided that the following conditions are
12 // met:
13 //
14 // 1. Redistributions of source code must retain the above copyright
15 // notice, this list of conditions and the following disclaimer.
16 //
17 // 2. Redistributions in binary form must reproduce the above copyright
18 // notice, this list of conditions and the following disclaimer in the
19 // documentation and/or other materials provided with the distribution.
20 //
21 // 3. Neither the name of the Corporation nor the names of the
22 // contributors may be used to endorse or promote products derived from
23 // this software without specific prior written permission.
24 //
25 // THIS SOFTWARE IS PROVIDED BY SANDIA CORPORATION "AS IS" AND ANY
26 // EXPRESS OR IMPLIED WARRANTIES, INCLUDING, BUT NOT LIMITED TO, THE
27 // IMPLIED WARRANTIES OF MERCHANTABILITY AND FITNESS FOR A PARTICULAR
28 // PURPOSE ARE DISCLAIMED. IN NO EVENT SHALL SANDIA CORPORATION OR THE
29 // CONTRIBUTORS BE LIABLE FOR ANY DIRECT, INDIRECT, INCIDENTAL, SPECIAL,
30 // EXEMPLARY, OR CONSEQUENTIAL DAMAGES (INCLUDING, BUT NOT LIMITED TO,
31 // PROCUREMENT OF SUBSTITUTE GOODS OR SERVICES; LOSS OF USE, DATA, OR
32 // PROFITS; OR BUSINESS INTERRUPTION) HOWEVER CAUSED AND ON ANY THEORY OF
33 // LIABILITY, WHETHER IN CONTRACT, STRICT LIABILITY, OR TORT (INCLUDING
34 // NEGLIGENCE OR OTHERWISE) ARISING IN ANY WAY OUT OF THE USE OF THIS
35 // SOFTWARE, EVEN IF ADVISED OF THE POSSIBILITY OF SUCH DAMAGE.
36 //
37 // Questions? Contact Michael A. Heroux (maherou@sandia.gov)
38 //
39 // ***********************************************************************
40 //@HEADER
41 */
42 
43 #ifndef IFPACK2_REORDERFILTER_DEF_HPP
44 #define IFPACK2_REORDERFILTER_DEF_HPP
45 #include "Ifpack2_ReorderFilter_decl.hpp"
46 #include <vector>
47 
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"
53 
54 namespace Ifpack2 {
55 
56 template<class MatrixType>
60  const Teuchos::ArrayRCP<local_ordinal_type>& reverseperm)
61  : A_ (A),
62  perm_ (perm),
63  reverseperm_ (reverseperm)
64 {
66  A_.is_null (), std::invalid_argument,
67  "Ifpack2::ReorderFilter: The input matrix is null.");
68 
69  // use this filter only on serial matrices
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.");
75 
77  A_->getNodeNumRows () != A_->getGlobalNumRows (),
78  std::invalid_argument,
79  "Ifpack2::ReorderFilter: The input matrix is not square.");
80 
81  // Temp arrays for apply
82  Indices_.resize (A_->getNodeMaxNumRowEntries ());
83  Values_.resize (A_->getNodeMaxNumRowEntries ());
84 }
85 
86 
87 template<class MatrixType>
89 
90 
91 template<class MatrixType>
93 {
94  return A_->getComm();
95 }
96 
97 
98 template<class MatrixType>
101 {
102  return A_->getNode ();
103 }
104 
105 
106 template<class MatrixType>
109 {
111  A_.is_null (), std::runtime_error, "Ifpack2::ReorderFilter::"
112  "getRowMap: The matrix A is null, so there is no row Map.");
113 
114  return A_->getRowMap ();
115 }
116 
117 
118 template<class MatrixType>
121 {
123  A_.is_null (), std::runtime_error, "Ifpack2::ReorderFilter::"
124  "getColMap: The matrix A is null, so there is no column Map.");
125 
126  return A_->getColMap();
127 }
128 
129 
130 template<class MatrixType>
133 {
135  A_.is_null (), std::runtime_error, "Ifpack2::ReorderFilter::"
136  "getDomainMap: The matrix A is null, so there is no domain Map.");
137 
138  return A_->getDomainMap();
139 }
140 
141 
142 template<class MatrixType>
145 {
147  A_.is_null (), std::runtime_error, "Ifpack2::ReorderFilter::"
148  "getRangeMap: The matrix A is null, so there is no range Map.");
149 
150  return A_->getRangeMap();
151 }
152 
153 
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> >
159 {
160  throw std::runtime_error("Ifpack2::ReorderFilter: does not support getGraph.");
161 }
162 
163 
164 template<class MatrixType>
166 {
167  return A_->getGlobalNumRows();
168 }
169 
170 
171 template<class MatrixType>
173 {
174  return A_->getGlobalNumCols();
175 }
176 
177 
178 template<class MatrixType>
180 {
181  return A_->getNodeNumRows();
182 }
183 
184 
185 template<class MatrixType>
187 {
188  return A_->getNodeNumCols();
189 }
190 
191 
192 template<class MatrixType>
193 typename MatrixType::global_ordinal_type ReorderFilter<MatrixType>::getIndexBase() const
194 {
195  return A_->getIndexBase();
196 }
197 
198 
199 template<class MatrixType>
201 {
202  return A_->getGlobalNumEntries();
203 }
204 
205 
206 template<class MatrixType>
208 {
209  return A_->getNodeNumEntries();
210 }
211 
212 
213 template<class MatrixType>
215 getNumEntriesInGlobalRow (global_ordinal_type globalRow) const
216 {
217  if (A_.is_null () || A_->getRowMap ().is_null ()) {
219  }
220  else {
221  const local_ordinal_type lclRow =
222  A_->getRowMap ()->getLocalElement (globalRow);
224  // The calling process doesn't own any entries in this row.
225  return static_cast<size_t> (0);
226  } else {
227  const local_ordinal_type origLclRow = reverseperm_[lclRow];
228  return A_->getNumEntriesInLocalRow (origLclRow);
229  }
230  }
231 }
232 
233 
234 template<class MatrixType>
236 getNumEntriesInLocalRow (local_ordinal_type localRow) const
237 {
238  // Make sure that localRow is in bounds before using it to index
239  // into the permutation.
240  if (A_->getRowMap ()->isNodeLocalElement (localRow)) {
241  // localRow is a valid index into reverseperm_.
242  const local_ordinal_type localReorderedRow = reverseperm_[localRow];
243  return A_->getNumEntriesInLocalRow (localReorderedRow);
244  } else {
245  // The calling process doesn't own any entries in this row.
246  return static_cast<size_t> (0);
247  }
248 }
249 
250 
251 template<class MatrixType>
253 {
254  return A_->getGlobalNumDiags();
255 }
256 
257 
258 template<class MatrixType>
260 {
261  return A_->getNodeNumDiags();
262 }
263 
264 
265 template<class MatrixType>
267 {
268  return A_->getGlobalMaxNumRowEntries();
269 }
270 
271 
272 template<class MatrixType>
274 {
275  return A_->getNodeMaxNumRowEntries();
276 }
277 
278 
279 template<class MatrixType>
281 {
282  return true;
283 }
284 
285 
286 template<class MatrixType>
288 {
289  return A_->isLowerTriangular();
290 }
291 
292 
293 template<class MatrixType>
295 {
296  return A_->isUpperTriangular();
297 }
298 
299 
300 template<class MatrixType>
302 {
303  return A_->isLocallyIndexed();
304 }
305 
306 
307 template<class MatrixType>
309 {
310  return A_->isGloballyIndexed();
311 }
312 
313 
314 template<class MatrixType>
316 {
317  return A_->isFillComplete();
318 }
319 
320 
321 template<class MatrixType>
323 getGlobalRowCopy (global_ordinal_type globalRow,
326  size_t& numEntries) const
327 {
328  using Teuchos::Array;
329  using Teuchos::ArrayView;
330  using Teuchos::av_reinterpret_cast;
331  typedef local_ordinal_type LO;
332  typedef global_ordinal_type GO;
333  typedef Teuchos::OrdinalTraits<LO> OTLO;
334 
335  const map_type& rowMap = * (A_->getRowMap ());
336  const local_ordinal_type localRow = rowMap.getLocalElement (globalRow);
338  localRow == OTLO::invalid (), std::invalid_argument, "Ifpack2::Reorder"
339  "Filter::getGlobalRowCopy: The given global row index " << globalRow
340  << " is not owned by the calling process with rank "
341  << rowMap.getComm ()->getRank () << ".");
342 
343  if (sizeof (GO) == sizeof (LO)) {
344  // This means we can convert local to global in place.
345  ArrayView<LO> localInd = av_reinterpret_cast<LO> (globalInd);
346  this->getLocalRowCopy (localRow, localInd, val, numEntries);
347 
348  // Convert local indices back to global indices.
349  for (size_t k = 0; k < numEntries; ++k) {
350  globalInd[k] = rowMap.getGlobalElement (localInd[k]);
351  }
352  }
353  else {
354  // LO and GO have different sizes, so we need a temp array
355  // for converting local to global.
356  numEntries = this->getNumEntriesInLocalRow (localRow);
357  Array<LO> localInd (numEntries);
358  this->getLocalRowCopy (localRow, localInd, val, numEntries);
359 
360  // Convert local indices back to global indices.
361  for (size_t k = 0; k < numEntries; ++k) {
362  globalInd[k] = rowMap.getGlobalElement (localInd[k]);
363  }
364  }
365 }
366 
367 
368 template<class MatrixType>
370 getLocalRowCopy (local_ordinal_type LocalRow,
372  const Teuchos::ArrayView<scalar_type> &Values,
373  size_t &NumEntries) const
374 {
376  ! A_->getRowMap ()->isNodeLocalElement (LocalRow),
377  std::invalid_argument,
378  "Ifpack2::ReorderFilter::getLocalRowCopy: The given local row index "
379  << LocalRow << " is not a valid local row index on the calling process "
380  "with rank " << A_->getRowMap ()->getComm ()->getRank () << ".");
381 
382  // This duplicates code in getNumEntriesInGlobalRow, but avoids an
383  // extra array lookup and some extra tests.
384  const local_ordinal_type origLclRow = reverseperm_[LocalRow];
385  const size_t numEntries = A_->getNumEntriesInLocalRow (origLclRow);
386 
388  static_cast<size_t> (Indices.size ()) < numEntries ||
389  static_cast<size_t> (Values.size ()) < numEntries,
390  std::invalid_argument,
391  "Ifpack2::ReorderFilter::getLocalRowCopy: The given array views are not "
392  "long enough to store all the data in the given row " << LocalRow
393  << ". Indices.size() = " << Indices.size () << ", Values.size() = "
394  << Values.size () << ", but the (original) row has " << numEntries
395  << " entry/ies.");
396 
397  A_->getLocalRowCopy (origLclRow, Indices, Values, NumEntries);
398  // Do a col reindex via perm
399  //
400  // FIXME (mfh 30 Jan 2014) This assumes that the row and column
401  // indices are the same.
402  for (size_t i = 0; i < NumEntries; ++i) {
403  Indices[i] = perm_[Indices[i]];
404  }
405 }
406 
407 
408 template<class MatrixType>
410 getGlobalRowView (global_ordinal_type GlobalRow,
413 {
414  throw std::runtime_error("Ifpack2::ReorderFilter: does not support getGlobalRowView.");
415 }
416 
417 
418 template<class MatrixType>
420 getLocalRowView (local_ordinal_type LocalRow,
423 {
424  throw std::runtime_error("Ifpack2::ReorderFilter: does not support getLocalRowView.");
425 }
426 
427 
428 template<class MatrixType>
430 getLocalDiagCopy (Tpetra::Vector<scalar_type,local_ordinal_type,global_ordinal_type,node_type> &diag) const
431 {
432  // This is somewhat dubious as to how the maps match.
433  return A_->getLocalDiagCopy(diag);
434 }
435 
436 
437 template<class MatrixType>
438 void ReorderFilter<MatrixType>::leftScale(const Tpetra::Vector<scalar_type, local_ordinal_type, global_ordinal_type, node_type>& x)
439 {
440  throw std::runtime_error("Ifpack2::ReorderFilter does not support leftScale.");
441 }
442 
443 
444 template<class MatrixType>
445 void ReorderFilter<MatrixType>::rightScale(const Tpetra::Vector<scalar_type, local_ordinal_type, global_ordinal_type, node_type>& x)
446 {
447  throw std::runtime_error("Ifpack2::ReorderFilter does not support rightScale.");
448 }
449 
450 
451 template<class MatrixType>
453 apply (const Tpetra::MultiVector<scalar_type,local_ordinal_type,global_ordinal_type,node_type> &X,
454  Tpetra::MultiVector<scalar_type,local_ordinal_type,global_ordinal_type,node_type> &Y,
455  Teuchos::ETransp mode,
456  scalar_type alpha,
457  scalar_type beta) const
458 {
460 
462  alpha != STS::one () || beta != STS::zero (), std::logic_error,
463  "Ifpack2::ReorderFilter::apply is only implemented for alpha = 1 and "
464  "beta = 0. You set alpha = " << alpha << " and beta = " << beta << ".");
465 
466  // Note: This isn't AztecOO compliant. But neither was Ifpack's version.
467  // Note: The localized maps mean the matvec is trivial (and has no import)
469  X.getNumVectors() != Y.getNumVectors(), std::runtime_error,
470  "Ifpack2::ReorderFilter::apply: X.getNumVectors() != Y.getNumVectors().");
471 
472  const scalar_type zero = STS::zero ();
474  Teuchos::ArrayRCP<Teuchos::ArrayRCP<scalar_type> > y_ptr = Y.get2dViewNonConst();
475 
476  Y.putScalar (zero);
477  const size_t NumVectors = Y.getNumVectors ();
478 
479  for (size_t i = 0; i < A_->getNodeNumRows (); ++i) {
480  size_t Nnz;
481  // Use this class's getrow to make the below code simpler
482  getLocalRowCopy (i, Indices_ (), Values_ (), Nnz);
483  if (mode == Teuchos::NO_TRANS) {
484  for (size_t j = 0; j < Nnz; ++j) {
485  for (size_t k = 0; k < NumVectors; ++k) {
486  y_ptr[k][i] += Values_[j] * x_ptr[k][Indices_[j]];
487  }
488  }
489  }
490  else if (mode == Teuchos::TRANS) {
491  for (size_t j = 0; j < Nnz; ++j) {
492  for (size_t k = 0; k < NumVectors; ++k) {
493  y_ptr[k][Indices_[j]] += Values_[j] * x_ptr[k][i];
494  }
495  }
496  }
497  else { //mode==Teuchos::CONJ_TRANS
498  for (size_t j = 0; j < Nnz; ++j) {
499  for (size_t k = 0; k < NumVectors; ++k) {
500  y_ptr[k][Indices_[j]] += STS::conjugate(Values_[j]) * x_ptr[k][i];
501  }
502  }
503  }
504  }
505 }
506 
507 
508 template<class MatrixType>
510 {
511  return true;
512 }
513 
514 
515 template<class MatrixType>
517 {
518  return false;
519 }
520 
521 
522 template<class MatrixType>
523 typename ReorderFilter<MatrixType>::mag_type ReorderFilter<MatrixType>::getFrobeniusNorm() const
524 {
525  // Reordering doesn't change the Frobenius norm.
526  return A_->getFrobeniusNorm ();
527 }
528 
529 
530 template<class MatrixType>
532 permuteOriginalToReordered (const Tpetra::MultiVector<scalar_type,local_ordinal_type,global_ordinal_type,node_type> &originalX,
533  Tpetra::MultiVector<scalar_type,local_ordinal_type,global_ordinal_type,node_type> &reorderedY) const
534 {
535  this->template permuteOriginalToReorderedTempl<scalar_type,scalar_type>(originalX, reorderedY);
536 }
537 
538 
539 template<class MatrixType>
540 template<class DomainScalar, class RangeScalar>
541 void ReorderFilter<MatrixType>::permuteOriginalToReorderedTempl(const Tpetra::MultiVector<DomainScalar,local_ordinal_type,global_ordinal_type,node_type> &originalX,
542  Tpetra::MultiVector<RangeScalar,local_ordinal_type,global_ordinal_type,node_type> &reorderedY) const
543 {
544  TEUCHOS_TEST_FOR_EXCEPTION(originalX.getNumVectors() != reorderedY.getNumVectors(), std::runtime_error,
545  "Ifpack2::ReorderFilter::permuteOriginalToReordered ERROR: X.getNumVectors() != Y.getNumVectors().");
546 
547  Teuchos::ArrayRCP<Teuchos::ArrayRCP<const DomainScalar> > x_ptr = originalX.get2dView();
548  Teuchos::ArrayRCP<Teuchos::ArrayRCP<RangeScalar> > y_ptr = reorderedY.get2dViewNonConst();
549 
550  for(size_t k=0; k < originalX.getNumVectors(); k++)
551  for(local_ordinal_type i=0; (size_t)i< originalX.getLocalLength(); i++)
552  y_ptr[k][perm_[i]] = (RangeScalar)x_ptr[k][i];
553 }
554 
555 
556 template<class MatrixType>
557 void ReorderFilter<MatrixType>::permuteReorderedToOriginal(const Tpetra::MultiVector<scalar_type,local_ordinal_type,global_ordinal_type,node_type> &reorderedX,
558  Tpetra::MultiVector<scalar_type,local_ordinal_type,global_ordinal_type,node_type> &originalY) const
559 {
560  this->template permuteReorderedToOriginalTempl<scalar_type,scalar_type>(reorderedX, originalY);
561 }
562 
563 
564 template<class MatrixType>
565 template<class DomainScalar, class RangeScalar>
567 permuteReorderedToOriginalTempl (const Tpetra::MultiVector<DomainScalar,local_ordinal_type,global_ordinal_type,node_type> &reorderedX,
568  Tpetra::MultiVector<RangeScalar,local_ordinal_type,global_ordinal_type,node_type> &originalY) const
569 {
571  reorderedX.getNumVectors() != originalY.getNumVectors(),
572  std::runtime_error,
573  "Ifpack2::ReorderFilter::permuteReorderedToOriginal: "
574  "X.getNumVectors() != Y.getNumVectors().");
575 
576 #ifdef HAVE_IFPACK2_DEBUG
577  {
579  typedef typename STS::magnitudeType magnitude_type;
581  Teuchos::Array<magnitude_type> norms (reorderedX.getNumVectors ());
582  reorderedX.norm2 (norms ());
583  bool good = true;
584  for (size_t j = 0;
585  j < reorderedX.getNumVectors (); ++j) {
586  if (STM::isnaninf (norms[j])) {
587  good = false;
588  break;
589  }
590  }
592  ! good, std::runtime_error, "Ifpack2::ReorderFilter::"
593  "permuteReorderedToOriginalTempl: The 2-norm of the input reorderedX is "
594  "NaN or Inf.");
595  }
596 #endif // HAVE_IFPACK2_DEBUG
597 
598  Teuchos::ArrayRCP<Teuchos::ArrayRCP<const DomainScalar> > x_ptr = reorderedX.get2dView();
599  Teuchos::ArrayRCP<Teuchos::ArrayRCP<RangeScalar> > y_ptr = originalY.get2dViewNonConst();
600 
601  for (size_t k = 0; k < reorderedX.getNumVectors (); ++k) {
602  for (local_ordinal_type i = 0; (size_t)i < reorderedX.getLocalLength (); ++i) {
603  y_ptr[k][reverseperm_[i]] = (RangeScalar) x_ptr[k][i];
604  }
605  }
606 
607 #ifdef HAVE_IFPACK2_DEBUG
608  {
610  typedef typename STS::magnitudeType magnitude_type;
612  Teuchos::Array<magnitude_type> norms (originalY.getNumVectors ());
613  originalY.norm2 (norms ());
614  bool good = true;
615  for (size_t j = 0;
616  j < originalY.getNumVectors (); ++j) {
617  if (STM::isnaninf (norms[j])) {
618  good = false;
619  break;
620  }
621  }
623  ! good, std::runtime_error, "Ifpack2::ReorderFilter::"
624  "permuteReorderedToOriginalTempl: The 2-norm of the output originalY is "
625  "NaN or Inf.");
626  }
627 #endif // HAVE_IFPACK2_DEBUG
628 }
629 
630 } // namespace Ifpack2
631 
632 #define IFPACK2_REORDERFILTER_INSTANT(S,LO,GO,N) \
633  template class Ifpack2::ReorderFilter< Tpetra::RowMatrix<S, LO, GO, N> >;
634 
635 #endif
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 isUpperTriangular() const
Indicates whether this matrix is upper triangular.
Definition: Ifpack2_ReorderFilter_def.hpp:294
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:301
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:420
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:532
virtual bool supportsRowViews() const
Returns true if RowViews are supported.
Definition: Ifpack2_ReorderFilter_def.hpp:516
#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:557
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
size_type size() const
virtual size_t getGlobalMaxNumRowEntries() const
Returns the maximum number of entries across all rows/columns on all nodes.
Definition: Ifpack2_ReorderFilter_def.hpp:266
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
bool is_null() const
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:308
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:430
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:453
virtual Teuchos::RCP< node_type > getNode() const
The matrix&#39;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:323
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:523
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:273
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&#39;s communicator.
Definition: Ifpack2_ReorderFilter_def.hpp:92
virtual global_size_t getGlobalNumDiags() const
Returns the number of global diagonal entries, based on global row/column index comparisons.
Definition: Ifpack2_ReorderFilter_def.hpp:252
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:370
virtual bool hasTransposeApply() const
Whether apply() can apply the transpose or conjugate transpose.
Definition: Ifpack2_ReorderFilter_def.hpp:509
virtual size_t getNodeNumRows() const
Returns the number of rows owned on the calling node.
Definition: Ifpack2_ReorderFilter_def.hpp:179
virtual bool isLowerTriangular() const
Indicates whether this matrix is lower triangular.
Definition: Ifpack2_ReorderFilter_def.hpp:287
virtual bool isFillComplete() const
Returns true if fillComplete() has been called.
Definition: Ifpack2_ReorderFilter_def.hpp:315
virtual size_t getNodeNumDiags() const
Returns the number of local diagonal entries, based on global row/column index comparisons.
Definition: Ifpack2_ReorderFilter_def.hpp:259
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:410
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:438
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:445
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:280
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