Ifpack2 Templated Preconditioning Package  Version 1.0
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Groups Pages
Ifpack2_ReorderFilter_def.hpp
1 /*@HEADER
2 // ***********************************************************************
3 //
4 // Ifpack2: Templated 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 
99 
100 template<class MatrixType>
103 {
105  A_.is_null (), std::runtime_error, "Ifpack2::ReorderFilter::"
106  "getRowMap: The matrix A is null, so there is no row Map.");
107 
108  return A_->getRowMap ();
109 }
110 
111 
112 template<class MatrixType>
115 {
117  A_.is_null (), std::runtime_error, "Ifpack2::ReorderFilter::"
118  "getColMap: The matrix A is null, so there is no column Map.");
119 
120  return A_->getColMap();
121 }
122 
123 
124 template<class MatrixType>
127 {
129  A_.is_null (), std::runtime_error, "Ifpack2::ReorderFilter::"
130  "getDomainMap: The matrix A is null, so there is no domain Map.");
131 
132  return A_->getDomainMap();
133 }
134 
135 
136 template<class MatrixType>
139 {
141  A_.is_null (), std::runtime_error, "Ifpack2::ReorderFilter::"
142  "getRangeMap: The matrix A is null, so there is no range Map.");
143 
144  return A_->getRangeMap();
145 }
146 
147 
148 template<class MatrixType>
149 Teuchos::RCP<const Tpetra::RowGraph<typename MatrixType::local_ordinal_type,
150  typename MatrixType::global_ordinal_type,
151  typename MatrixType::node_type> >
153 {
154  throw std::runtime_error("Ifpack2::ReorderFilter: does not support getGraph.");
155 }
156 
157 
158 template<class MatrixType>
160 {
161  return A_->getGlobalNumRows();
162 }
163 
164 
165 template<class MatrixType>
167 {
168  return A_->getGlobalNumCols();
169 }
170 
171 
172 template<class MatrixType>
174 {
175  return A_->getNodeNumRows();
176 }
177 
178 
179 template<class MatrixType>
181 {
182  return A_->getNodeNumCols();
183 }
184 
185 
186 template<class MatrixType>
187 typename MatrixType::global_ordinal_type ReorderFilter<MatrixType>::getIndexBase() const
188 {
189  return A_->getIndexBase();
190 }
191 
192 
193 template<class MatrixType>
195 {
196  return A_->getGlobalNumEntries();
197 }
198 
199 
200 template<class MatrixType>
202 {
203  return A_->getNodeNumEntries();
204 }
205 
206 
207 template<class MatrixType>
209 getNumEntriesInGlobalRow (global_ordinal_type globalRow) const
210 {
211  if (A_.is_null () || A_->getRowMap ().is_null ()) {
213  }
214  else {
215  const local_ordinal_type lclRow =
216  A_->getRowMap ()->getLocalElement (globalRow);
218  // The calling process doesn't own any entries in this row.
219  return static_cast<size_t> (0);
220  } else {
221  const local_ordinal_type origLclRow = reverseperm_[lclRow];
222  return A_->getNumEntriesInLocalRow (origLclRow);
223  }
224  }
225 }
226 
227 
228 template<class MatrixType>
230 getNumEntriesInLocalRow (local_ordinal_type localRow) const
231 {
232  // Make sure that localRow is in bounds before using it to index
233  // into the permutation.
234  if (A_->getRowMap ()->isNodeLocalElement (localRow)) {
235  // localRow is a valid index into reverseperm_.
236  const local_ordinal_type localReorderedRow = reverseperm_[localRow];
237  return A_->getNumEntriesInLocalRow (localReorderedRow);
238  } else {
239  // The calling process doesn't own any entries in this row.
240  return static_cast<size_t> (0);
241  }
242 }
243 
244 
245 template<class MatrixType>
247 {
248  return A_->getGlobalMaxNumRowEntries();
249 }
250 
251 
252 template<class MatrixType>
254 {
255  return A_->getNodeMaxNumRowEntries();
256 }
257 
258 
259 template<class MatrixType>
261 {
262  return true;
263 }
264 
265 
266 template<class MatrixType>
268 {
269  return A_->isLocallyIndexed();
270 }
271 
272 
273 template<class MatrixType>
275 {
276  return A_->isGloballyIndexed();
277 }
278 
279 
280 template<class MatrixType>
282 {
283  return A_->isFillComplete();
284 }
285 
286 
287 template<class MatrixType>
289 getGlobalRowCopy (global_ordinal_type globalRow,
292  size_t& numEntries) const
293 {
294  using Teuchos::Array;
295  using Teuchos::ArrayView;
296  using Teuchos::av_reinterpret_cast;
297  typedef local_ordinal_type LO;
298  typedef global_ordinal_type GO;
299  typedef Teuchos::OrdinalTraits<LO> OTLO;
300 
301  const map_type& rowMap = * (A_->getRowMap ());
302  const local_ordinal_type localRow = rowMap.getLocalElement (globalRow);
304  localRow == OTLO::invalid (), std::invalid_argument, "Ifpack2::Reorder"
305  "Filter::getGlobalRowCopy: The given global row index " << globalRow
306  << " is not owned by the calling process with rank "
307  << rowMap.getComm ()->getRank () << ".");
308 
309  if (sizeof (GO) == sizeof (LO)) {
310  // This means we can convert local to global in place.
311  ArrayView<LO> localInd = av_reinterpret_cast<LO> (globalInd);
312  this->getLocalRowCopy (localRow, localInd, val, numEntries);
313 
314  // Convert local indices back to global indices.
315  for (size_t k = 0; k < numEntries; ++k) {
316  globalInd[k] = rowMap.getGlobalElement (localInd[k]);
317  }
318  }
319  else {
320  // LO and GO have different sizes, so we need a temp array
321  // for converting local to global.
322  numEntries = this->getNumEntriesInLocalRow (localRow);
323  Array<LO> localInd (numEntries);
324  this->getLocalRowCopy (localRow, localInd, val, numEntries);
325 
326  // Convert local indices back to global indices.
327  for (size_t k = 0; k < numEntries; ++k) {
328  globalInd[k] = rowMap.getGlobalElement (localInd[k]);
329  }
330  }
331 }
332 
333 
334 template<class MatrixType>
336 getLocalRowCopy (local_ordinal_type LocalRow,
338  const Teuchos::ArrayView<scalar_type> &Values,
339  size_t &NumEntries) const
340 {
342  ! A_->getRowMap ()->isNodeLocalElement (LocalRow),
343  std::invalid_argument,
344  "Ifpack2::ReorderFilter::getLocalRowCopy: The given local row index "
345  << LocalRow << " is not a valid local row index on the calling process "
346  "with rank " << A_->getRowMap ()->getComm ()->getRank () << ".");
347 
348  // This duplicates code in getNumEntriesInGlobalRow, but avoids an
349  // extra array lookup and some extra tests.
350  const local_ordinal_type origLclRow = reverseperm_[LocalRow];
351  const size_t numEntries = A_->getNumEntriesInLocalRow (origLclRow);
352 
354  static_cast<size_t> (Indices.size ()) < numEntries ||
355  static_cast<size_t> (Values.size ()) < numEntries,
356  std::invalid_argument,
357  "Ifpack2::ReorderFilter::getLocalRowCopy: The given array views are not "
358  "long enough to store all the data in the given row " << LocalRow
359  << ". Indices.size() = " << Indices.size () << ", Values.size() = "
360  << Values.size () << ", but the (original) row has " << numEntries
361  << " entry/ies.");
362 
363  A_->getLocalRowCopy (origLclRow, Indices, Values, NumEntries);
364  // Do a col reindex via perm
365  //
366  // FIXME (mfh 30 Jan 2014) This assumes that the row and column
367  // indices are the same.
368  for (size_t i = 0; i < NumEntries; ++i) {
369  Indices[i] = perm_[Indices[i]];
370  }
371 }
372 
373 
374 template<class MatrixType>
376 getGlobalRowView (global_ordinal_type /* GlobalRow */,
378  Teuchos::ArrayView<const scalar_type> &/* values */) const
379 {
380  throw std::runtime_error("Ifpack2::ReorderFilter: does not support getGlobalRowView.");
381 }
382 
383 
384 template<class MatrixType>
386 getLocalRowView (local_ordinal_type /* LocalRow */,
388  Teuchos::ArrayView<const scalar_type> &/* values */) const
389 {
390  throw std::runtime_error("Ifpack2::ReorderFilter: does not support getLocalRowView.");
391 }
392 
393 
394 template<class MatrixType>
396 getLocalDiagCopy (Tpetra::Vector<scalar_type,local_ordinal_type,global_ordinal_type,node_type> &diag) const
397 {
398  // This is somewhat dubious as to how the maps match.
399  return A_->getLocalDiagCopy(diag);
400 }
401 
402 
403 template<class MatrixType>
404 void ReorderFilter<MatrixType>::leftScale(const Tpetra::Vector<scalar_type, local_ordinal_type, global_ordinal_type, node_type>& /* x */)
405 {
406  throw std::runtime_error("Ifpack2::ReorderFilter does not support leftScale.");
407 }
408 
409 
410 template<class MatrixType>
411 void ReorderFilter<MatrixType>::rightScale(const Tpetra::Vector<scalar_type, local_ordinal_type, global_ordinal_type, node_type>& /* x */)
412 {
413  throw std::runtime_error("Ifpack2::ReorderFilter does not support rightScale.");
414 }
415 
416 
417 template<class MatrixType>
419 apply (const Tpetra::MultiVector<scalar_type,local_ordinal_type,global_ordinal_type,node_type> &X,
420  Tpetra::MultiVector<scalar_type,local_ordinal_type,global_ordinal_type,node_type> &Y,
421  Teuchos::ETransp mode,
422  scalar_type alpha,
423  scalar_type beta) const
424 {
426 
428  alpha != STS::one () || beta != STS::zero (), std::logic_error,
429  "Ifpack2::ReorderFilter::apply is only implemented for alpha = 1 and "
430  "beta = 0. You set alpha = " << alpha << " and beta = " << beta << ".");
431 
432  // Note: This isn't AztecOO compliant. But neither was Ifpack's version.
433  // Note: The localized maps mean the matvec is trivial (and has no import)
435  X.getNumVectors() != Y.getNumVectors(), std::runtime_error,
436  "Ifpack2::ReorderFilter::apply: X.getNumVectors() != Y.getNumVectors().");
437 
438  const scalar_type zero = STS::zero ();
440  Teuchos::ArrayRCP<Teuchos::ArrayRCP<scalar_type> > y_ptr = Y.get2dViewNonConst();
441 
442  Y.putScalar (zero);
443  const size_t NumVectors = Y.getNumVectors ();
444 
445  for (size_t i = 0; i < A_->getNodeNumRows (); ++i) {
446  size_t Nnz;
447  // Use this class's getrow to make the below code simpler
448  getLocalRowCopy (i, Indices_ (), Values_ (), Nnz);
449  if (mode == Teuchos::NO_TRANS) {
450  for (size_t j = 0; j < Nnz; ++j) {
451  for (size_t k = 0; k < NumVectors; ++k) {
452  y_ptr[k][i] += Values_[j] * x_ptr[k][Indices_[j]];
453  }
454  }
455  }
456  else if (mode == Teuchos::TRANS) {
457  for (size_t j = 0; j < Nnz; ++j) {
458  for (size_t k = 0; k < NumVectors; ++k) {
459  y_ptr[k][Indices_[j]] += Values_[j] * x_ptr[k][i];
460  }
461  }
462  }
463  else { //mode==Teuchos::CONJ_TRANS
464  for (size_t j = 0; j < Nnz; ++j) {
465  for (size_t k = 0; k < NumVectors; ++k) {
466  y_ptr[k][Indices_[j]] += STS::conjugate(Values_[j]) * x_ptr[k][i];
467  }
468  }
469  }
470  }
471 }
472 
473 
474 template<class MatrixType>
476 {
477  return true;
478 }
479 
480 
481 template<class MatrixType>
483 {
484  return false;
485 }
486 
487 
488 template<class MatrixType>
489 typename ReorderFilter<MatrixType>::mag_type ReorderFilter<MatrixType>::getFrobeniusNorm() const
490 {
491  // Reordering doesn't change the Frobenius norm.
492  return A_->getFrobeniusNorm ();
493 }
494 
495 
496 template<class MatrixType>
498 permuteOriginalToReordered (const Tpetra::MultiVector<scalar_type,local_ordinal_type,global_ordinal_type,node_type> &originalX,
499  Tpetra::MultiVector<scalar_type,local_ordinal_type,global_ordinal_type,node_type> &reorderedY) const
500 {
501  this->template permuteOriginalToReorderedTempl<scalar_type,scalar_type>(originalX, reorderedY);
502 }
503 
504 
505 template<class MatrixType>
506 template<class DomainScalar, class RangeScalar>
507 void ReorderFilter<MatrixType>::permuteOriginalToReorderedTempl(const Tpetra::MultiVector<DomainScalar,local_ordinal_type,global_ordinal_type,node_type> &originalX,
508  Tpetra::MultiVector<RangeScalar,local_ordinal_type,global_ordinal_type,node_type> &reorderedY) const
509 {
510  TEUCHOS_TEST_FOR_EXCEPTION(originalX.getNumVectors() != reorderedY.getNumVectors(), std::runtime_error,
511  "Ifpack2::ReorderFilter::permuteOriginalToReordered ERROR: X.getNumVectors() != Y.getNumVectors().");
512 
513  Teuchos::ArrayRCP<Teuchos::ArrayRCP<const DomainScalar> > x_ptr = originalX.get2dView();
514  Teuchos::ArrayRCP<Teuchos::ArrayRCP<RangeScalar> > y_ptr = reorderedY.get2dViewNonConst();
515 
516  for(size_t k=0; k < originalX.getNumVectors(); k++)
517  for(local_ordinal_type i=0; (size_t)i< originalX.getLocalLength(); i++)
518  y_ptr[k][perm_[i]] = (RangeScalar)x_ptr[k][i];
519 }
520 
521 
522 template<class MatrixType>
523 void ReorderFilter<MatrixType>::permuteReorderedToOriginal(const Tpetra::MultiVector<scalar_type,local_ordinal_type,global_ordinal_type,node_type> &reorderedX,
524  Tpetra::MultiVector<scalar_type,local_ordinal_type,global_ordinal_type,node_type> &originalY) const
525 {
526  this->template permuteReorderedToOriginalTempl<scalar_type,scalar_type>(reorderedX, originalY);
527 }
528 
529 
530 template<class MatrixType>
531 template<class DomainScalar, class RangeScalar>
533 permuteReorderedToOriginalTempl (const Tpetra::MultiVector<DomainScalar,local_ordinal_type,global_ordinal_type,node_type> &reorderedX,
534  Tpetra::MultiVector<RangeScalar,local_ordinal_type,global_ordinal_type,node_type> &originalY) const
535 {
537  reorderedX.getNumVectors() != originalY.getNumVectors(),
538  std::runtime_error,
539  "Ifpack2::ReorderFilter::permuteReorderedToOriginal: "
540  "X.getNumVectors() != Y.getNumVectors().");
541 
542 #ifdef HAVE_IFPACK2_DEBUG
543  {
545  typedef typename STS::magnitudeType magnitude_type;
547  Teuchos::Array<magnitude_type> norms (reorderedX.getNumVectors ());
548  reorderedX.norm2 (norms ());
549  bool good = true;
550  for (size_t j = 0;
551  j < reorderedX.getNumVectors (); ++j) {
552  if (STM::isnaninf (norms[j])) {
553  good = false;
554  break;
555  }
556  }
558  ! good, std::runtime_error, "Ifpack2::ReorderFilter::"
559  "permuteReorderedToOriginalTempl: The 2-norm of the input reorderedX is "
560  "NaN or Inf.");
561  }
562 #endif // HAVE_IFPACK2_DEBUG
563 
564  Teuchos::ArrayRCP<Teuchos::ArrayRCP<const DomainScalar> > x_ptr = reorderedX.get2dView();
565  Teuchos::ArrayRCP<Teuchos::ArrayRCP<RangeScalar> > y_ptr = originalY.get2dViewNonConst();
566 
567  for (size_t k = 0; k < reorderedX.getNumVectors (); ++k) {
568  for (local_ordinal_type i = 0; (size_t)i < reorderedX.getLocalLength (); ++i) {
569  y_ptr[k][reverseperm_[i]] = (RangeScalar) x_ptr[k][i];
570  }
571  }
572 
573 #ifdef HAVE_IFPACK2_DEBUG
574  {
576  typedef typename STS::magnitudeType magnitude_type;
578  Teuchos::Array<magnitude_type> norms (originalY.getNumVectors ());
579  originalY.norm2 (norms ());
580  bool good = true;
581  for (size_t j = 0;
582  j < originalY.getNumVectors (); ++j) {
583  if (STM::isnaninf (norms[j])) {
584  good = false;
585  break;
586  }
587  }
589  ! good, std::runtime_error, "Ifpack2::ReorderFilter::"
590  "permuteReorderedToOriginalTempl: The 2-norm of the output originalY is "
591  "NaN or Inf.");
592  }
593 #endif // HAVE_IFPACK2_DEBUG
594 }
595 
596 } // namespace Ifpack2
597 
598 #define IFPACK2_REORDERFILTER_INSTANT(S,LO,GO,N) \
599  template class Ifpack2::ReorderFilter< Tpetra::RowMatrix<S, LO, GO, N> >;
600 
601 #endif
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:376
Wraps a Tpetra::RowMatrix in a filter that reorders local rows and columns.
Definition: Ifpack2_ReorderFilter_decl.hpp:69
virtual mag_type getFrobeniusNorm() const
Returns the Frobenius norm of the matrix.
Definition: Ifpack2_ReorderFilter_def.hpp:489
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 bool supportsRowViews() const
Returns true if RowViews are supported.
Definition: Ifpack2_ReorderFilter_def.hpp:482
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:289
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 > getDomainMap() const
Returns the Map that describes the domain distribution in this matrix.
Definition: Ifpack2_ReorderFilter_def.hpp:126
virtual size_t getNodeMaxNumRowEntries() const
Returns the maximum number of entries across all rows/columns on this node.
Definition: Ifpack2_ReorderFilter_def.hpp:253
#define TEUCHOS_TEST_FOR_EXCEPTION(throw_exception_test, Exception, msg)
virtual global_size_t getGlobalNumRows() const
Returns the number of global rows in this matrix.
Definition: Ifpack2_ReorderFilter_def.hpp:159
size_type size() const
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
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 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 size_t getNodeNumEntries() const
Returns the local number of entries in this matrix.
Definition: Ifpack2_ReorderFilter_def.hpp:201
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:419
virtual size_t getNodeNumRows() const
Returns the number of rows owned on the calling node.
Definition: Ifpack2_ReorderFilter_def.hpp:173
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:180
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 Teuchos::Comm< int > > getComm() const
The matrix&#39;s communicator.
Definition: Ifpack2_ReorderFilter_def.hpp:92
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:396
void resize(size_type new_size, const value_type &x=value_type())
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 bool hasColMap() const
Indicates whether this matrix has a well-defined column map.
Definition: Ifpack2_ReorderFilter_def.hpp:260
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 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:336
virtual global_size_t getGlobalNumCols() const
Returns the number of global columns in this matrix.
Definition: Ifpack2_ReorderFilter_def.hpp:166
virtual bool hasTransposeApply() const
Whether apply() can apply the transpose or conjugate transpose.
Definition: Ifpack2_ReorderFilter_def.hpp:475
virtual global_ordinal_type getIndexBase() const
Returns the index base for global indices for this matrix.
Definition: Ifpack2_ReorderFilter_def.hpp:187
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:386
virtual global_size_t getGlobalNumEntries() const
Returns the global number of entries in this matrix.
Definition: Ifpack2_ReorderFilter_def.hpp:194
virtual bool isFillComplete() const
Returns true if fillComplete() has been called.
Definition: Ifpack2_ReorderFilter_def.hpp:281
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:523
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 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:404
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:411
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:498
virtual ~ReorderFilter()
Destructor.
Definition: Ifpack2_ReorderFilter_def.hpp:88
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
bool is_null() const