MueLu  Version of the Day
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
MueLu_RefMaxwell_decl.hpp
Go to the documentation of this file.
1 // @HEADER
2 // *****************************************************************************
3 // MueLu: A package for multigrid based preconditioning
4 //
5 // Copyright 2012 NTESS and the MueLu contributors.
6 // SPDX-License-Identifier: BSD-3-Clause
7 // *****************************************************************************
8 // @HEADER
9 
10 #ifndef MUELU_REFMAXWELL_DECL_HPP
11 #define MUELU_REFMAXWELL_DECL_HPP
12 
13 #include "MueLu_ConfigDefs.hpp"
14 #include "MueLu_BaseClass.hpp"
15 
20 #include "MueLu_SaPFactory_fwd.hpp"
23 #include "MueLu_Utilities_fwd.hpp"
24 
25 #include "MueLu_MasterList.hpp"
26 #include "MueLu_FactoryManager.hpp"
29 #include "MueLu_PerfUtils_fwd.hpp"
30 #include "MueLu_RAPFactory_fwd.hpp"
31 
34 
41 
44 #include "MueLu_Hierarchy_fwd.hpp"
45 
46 #include "Xpetra_Operator.hpp"
47 #include "Xpetra_Map_fwd.hpp"
48 #include "Xpetra_Matrix_fwd.hpp"
54 
55 namespace MueLu {
56 
216 template <class Scalar,
217  class LocalOrdinal,
218  class GlobalOrdinal,
219  class Node>
220 class RefMaxwell : public VerboseObject, public Xpetra::Operator<Scalar, LocalOrdinal, GlobalOrdinal, Node> {
221 #undef MUELU_REFMAXWELL_SHORT
222 #include "MueLu_UseShortNames.hpp"
223 
224  public:
228 
231  : HierarchyCoarse11_(Teuchos::null)
232  , Hierarchy22_(Teuchos::null)
233  , disable_addon_(MasterList::getDefault<bool>("refmaxwell: disable addon"))
234  , mode_(MasterList::getDefault<std::string>("refmaxwell: mode")) {
235  }
236 
239  : HierarchyCoarse11_(HH)
240  , Hierarchy22_(H22)
241  , disable_addon_(MasterList::getDefault<bool>("refmaxwell: disable addon"))
242  , mode_(MasterList::getDefault<std::string>("refmaxwell: mode")) {
243  }
244 
246  const Teuchos::RCP<Matrix> &Dk_1,
247  const Teuchos::RCP<Matrix> &Dk_2,
248  const Teuchos::RCP<Matrix> &D0,
249  const Teuchos::RCP<Matrix> &M1_beta,
250  const Teuchos::RCP<Matrix> &M1_alpha,
251  const Teuchos::RCP<Matrix> &Mk_one,
252  const Teuchos::RCP<Matrix> &Mk_1_one,
253  const Teuchos::RCP<Matrix> &invMk_1_invBeta,
254  const Teuchos::RCP<Matrix> &invMk_2_invAlpha,
255  const Teuchos::RCP<MultiVector> &Nullspace11,
256  const Teuchos::RCP<MultiVector> &Nullspace22,
257  const Teuchos::RCP<RealValuedMultiVector> &NodalCoords,
259  bool ComputePrec = true) {
260  int spaceNumber = List.get<int>("refmaxwell: space number", 1);
261  initialize(spaceNumber,
262  Dk_1, Dk_2, D0,
263  M1_beta, M1_alpha,
264  Mk_one, Mk_1_one,
265  invMk_1_invBeta, invMk_2_invAlpha,
266  Nullspace11, Nullspace22, NodalCoords,
267  List);
268  resetMatrix(SM_Matrix, ComputePrec);
269  }
270 
284  const Teuchos::RCP<Matrix> &D0_Matrix,
285  const Teuchos::RCP<Matrix> &Ms_Matrix,
286  const Teuchos::RCP<Matrix> &M0inv_Matrix,
287  const Teuchos::RCP<Matrix> &M1_Matrix,
288  const Teuchos::RCP<MultiVector> &Nullspace11,
289  const Teuchos::RCP<RealValuedMultiVector> &NodalCoords,
291  bool ComputePrec = true) {
292  initialize(D0_Matrix, Ms_Matrix, M0inv_Matrix, M1_Matrix, Nullspace11, NodalCoords, List);
293  resetMatrix(SM_Matrix, ComputePrec);
294  }
295 
308  const Teuchos::RCP<Matrix> &D0_Matrix,
309  const Teuchos::RCP<Matrix> &M0inv_Matrix,
310  const Teuchos::RCP<Matrix> &M1_Matrix,
311  const Teuchos::RCP<MultiVector> &Nullspace11,
312  const Teuchos::RCP<RealValuedMultiVector> &NodalCoords,
314  bool ComputePrec = true) {
315  initialize(D0_Matrix, M1_Matrix, M0inv_Matrix, M1_Matrix, Nullspace11, NodalCoords, List);
316  resetMatrix(SM_Matrix, ComputePrec);
317  }
318 
329  const Teuchos::RCP<Matrix> &M0inv_Matrix,
330  const Teuchos::RCP<Matrix> &M1_Matrix,
331  const Teuchos::RCP<MultiVector> &Nullspace11,
332  const Teuchos::RCP<RealValuedMultiVector> &NodalCoords,
334  : SM_Matrix_(Teuchos::null) {
335  initialize(D0_Matrix, M1_Matrix, M0inv_Matrix, M1_Matrix, Nullspace11, NodalCoords, List);
336  }
337 
349  const Teuchos::RCP<Matrix> &D0_Matrix,
350  const Teuchos::RCP<Matrix> &M1_Matrix,
351  const Teuchos::RCP<MultiVector> &Nullspace11,
352  const Teuchos::RCP<RealValuedMultiVector> &NodalCoords,
354  bool ComputePrec) {
355  initialize(D0_Matrix, M1_Matrix, Teuchos::null, M1_Matrix, Nullspace11, NodalCoords, List);
356  resetMatrix(SM_Matrix, ComputePrec);
357  }
358 
368  const Teuchos::RCP<Matrix> &M1_Matrix,
369  const Teuchos::RCP<MultiVector> &Nullspace11,
370  const Teuchos::RCP<RealValuedMultiVector> &NodalCoords,
372  : SM_Matrix_(Teuchos::null) {
373  initialize(D0_Matrix, M1_Matrix, Teuchos::null, M1_Matrix, Nullspace11, NodalCoords, List);
374  }
375 
382  RefMaxwell(const Teuchos::RCP<Matrix> &SM_Matrix,
384  bool ComputePrec = true);
385 
387  virtual ~RefMaxwell() {}
388 
391 
393  const Teuchos::RCP<const Map> getRangeMap() const;
394 
397  return SM_Matrix_;
398  }
399 
402 
404  void compute(bool reuse = false);
405 
407  void resetMatrix(Teuchos::RCP<Matrix> SM_Matrix_new, bool ComputePrec = true);
408 
412  void apply(const MultiVector &X, MultiVector &Y,
416 
418  bool hasTransposeApply() const;
419 
421 
423  void residual(const MultiVector &X,
424  const MultiVector &B,
425  MultiVector &R) const {
426  using STS = Teuchos::ScalarTraits<Scalar>;
427  R.update(STS::one(), B, STS::zero());
428  this->apply(X, R, Teuchos::NO_TRANS, -STS::one(), STS::one());
429  }
430 
431  private:
433 
446  void initialize(const Teuchos::RCP<Matrix> &D0_Matrix,
447  const Teuchos::RCP<Matrix> &Ms_Matrix,
448  const Teuchos::RCP<Matrix> &M0inv_Matrix,
449  const Teuchos::RCP<Matrix> &M1_Matrix,
450  const Teuchos::RCP<MultiVector> &Nullspace11,
451  const Teuchos::RCP<RealValuedMultiVector> &NodalCoords,
452  Teuchos::ParameterList &List);
453 
471  void initialize(const int k,
472  const Teuchos::RCP<Matrix> &Dk_1,
473  const Teuchos::RCP<Matrix> &Dk_2,
474  const Teuchos::RCP<Matrix> &D0,
475  const Teuchos::RCP<Matrix> &M1_beta,
476  const Teuchos::RCP<Matrix> &M1_alpha,
477  const Teuchos::RCP<Matrix> &Mk_one,
478  const Teuchos::RCP<Matrix> &Mk_1_one,
479  const Teuchos::RCP<Matrix> &invMk_1_invBeta,
480  const Teuchos::RCP<Matrix> &invMk_2_invAlpha,
481  const Teuchos::RCP<MultiVector> &Nullspace11,
482  const Teuchos::RCP<MultiVector> &Nullspace22,
483  const Teuchos::RCP<RealValuedMultiVector> &NodalCoords,
484  Teuchos::ParameterList &List);
485 
487  void determineSubHierarchyCommSizes(bool &doRebalancing, int &rebalanceStriding, int &numProcsCoarseA11, int &numProcsA22);
488 
490  void buildCoarse11Matrix();
491 
493  void rebalanceCoarse11Matrix(const int rebalanceStriding, const int numProcsCoarseA11);
494 
496  void build22Matrix(const bool reuse, const bool doRebalancing, const int rebalanceStriding, const int numProcsA22);
497 
498  public: // due to Cuda build errors otherwise
500  RCP<MultiVector> buildNullspace(const int spaceNumber, const Kokkos::View<bool *, typename Node::device_type> &bcs, const bool applyBCs);
501 
503  Teuchos::RCP<Matrix> buildProjection(const int spaceNumber, const RCP<MultiVector> &EdgeNullspace) const;
504 
511  void buildNodalProlongator(const Teuchos::RCP<Matrix> &A_nodal,
512  Teuchos::RCP<Matrix> &P_nodal,
513  Teuchos::RCP<MultiVector> &Nullspace_nodal,
514  Teuchos::RCP<RealValuedMultiVector> &Coords_nodal) const;
515 
522 
532  void buildProlongator(const int spaceNumber,
533  const Teuchos::RCP<Matrix> &A_nodal_Matrix,
534  const RCP<MultiVector> &EdgeNullspace,
535  Teuchos::RCP<Matrix> &edgeProlongator,
536  Teuchos::RCP<MultiVector> &coarseEdgeNullspace,
537  Teuchos::RCP<RealValuedMultiVector> &coarseNodalCoords) const;
538 
543  RCP<Matrix> buildAddon(const int spaceNumber);
544 
545  private:
547  void setupSubSolve(Teuchos::RCP<Hierarchy> &hierarchy,
548  Teuchos::RCP<Operator> &thyraPrecOp,
549  const Teuchos::RCP<Matrix> &A,
550  const Teuchos::RCP<MultiVector> &Nullspace,
552  Teuchos::ParameterList &params,
553  std::string &label,
554  const bool reuse,
555  const bool isSingular = false);
556 
558  void setFineLevelSmoother11();
559 
561  void applyInverseAdditive(const MultiVector &RHS, MultiVector &X) const;
562 
564  void solveH(const MultiVector &RHS, MultiVector &X) const;
565 
567  void solve22(const MultiVector &RHS, MultiVector &X) const;
568 
570  void allocateMemory(int numVectors) const;
571 
573  void dump(const RCP<Matrix> &A, std::string name) const;
574 
576  void dump(const RCP<MultiVector> &X, std::string name) const;
577 
579  void dumpCoords(const RCP<RealValuedMultiVector> &X, std::string name) const;
580 
582  void dump(const Teuchos::ArrayRCP<bool> &v, std::string name) const;
583 
585  void dump(const Kokkos::View<bool *, typename Node::device_type> &v, std::string name) const;
586 
588  Teuchos::RCP<Teuchos::TimeMonitor> getTimer(std::string name, RCP<const Teuchos::Comm<int> > comm = Teuchos::null) const;
589 
598  std::string solverName_;
600  size_t dim_;
628  Kokkos::View<bool *, typename Node::device_type::memory_space> BCrows11_, BCcols22_, BCdomain22_;
650  std::string mode_;
651 
654 };
655 
656 } // namespace MueLu
657 
658 #define MUELU_REFMAXWELL_SHORT
659 #endif // MUELU_REFMAXWELL_DECL_HPP
const Teuchos::RCP< Matrix > & getJacobian() const
Returns Jacobian matrix SM.
Teuchos::RCP< const Import > Importer22_
size_t dim_
The spatial dimension.
RCP< Matrix > buildAddon(const int spaceNumber)
Teuchos::RCP< SmootherPrototype > PreSmootherData11_
Teuchos::RCP< Matrix > R22_
MueLu::DefaultLocalOrdinal LocalOrdinal
Kokkos::View< bool *, typename Node::device_type::memory_space > BCdomain22_
void solve22(const MultiVector &RHS, MultiVector &X) const
apply solve to 2-2 block only
Teuchos::RCP< SmootherBase > PreSmoother11_
Teuchos::RCP< Teuchos::ParameterList > A22_RAP_reuse_data_
void dumpCoords(const RCP< RealValuedMultiVector > &X, std::string name) const
dump out real-valued multivector
const Teuchos::RCP< const Map > getRangeMap() const
Returns the Xpetra::Map object associated with the range of this operator.
Xpetra::MultiVector< coordinateType, LO, GO, NO > RealValuedMultiVector
Kokkos::View< bool *, typename Node::device_type::memory_space > BCrows11_
Vectors for BCs.
Teuchos::RCP< MultiVector > CoarseNullspace22_
Nullspace for coarse (2,2) problem.
T & get(const std::string &name, T def_value)
void setFineLevelSmoother11()
Set the fine level smoother.
Teuchos::RCP< Matrix > SM_Matrix_
The system that is getting preconditioned.
Xpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > MultiVector
Teuchos::RCP< Matrix > Mk_one_
mass matrices with unit weight on k-th and (k-1)-th spaces
std::string solverName_
The name of the solver.
Teuchos::RCP< Matrix > buildProjection(const int spaceNumber, const RCP< MultiVector > &EdgeNullspace) const
Builds a projection from a vector values space into a vector valued nodal space.
Teuchos::RCP< MultiVector > DxIntermediate_
void buildNodalProlongator(const Teuchos::RCP< Matrix > &A_nodal, Teuchos::RCP< Matrix > &P_nodal, Teuchos::RCP< MultiVector > &Nullspace_nodal, Teuchos::RCP< RealValuedMultiVector > &Coords_nodal) const
Teuchos::RCP< Matrix > A22_
void determineSubHierarchyCommSizes(bool &doRebalancing, int &rebalanceStriding, int &numProcsCoarseA11, int &numProcsA22)
Determine how large the sub-communicators for the two hierarchies should be.
Teuchos::RCP< SmootherBase > PostSmoother11_
void solveH(const MultiVector &RHS, MultiVector &X) const
apply solve to 1-1 block only
Teuchos::RCP< Matrix > Addon11_
the addon for the 11 block
Teuchos::RCP< Matrix > Mk_1_one_
void setParameters(Teuchos::ParameterList &list)
Set parameters.
MueLu::DefaultNode Node
Teuchos::RCP< Matrix > invMk_2_invAlpha_
Teuchos::ScalarTraits< Scalar >::magnitudeType magnitudeType
Teuchos::RCP< Matrix > D0_
D_0 matrix.
Teuchos::RCP< MultiVector > P11res_
Temporary memory.
RCP< MultiVector > buildNullspace(const int spaceNumber, const Kokkos::View< bool *, typename Node::device_type > &bcs, const bool applyBCs)
Builds a nullspace.
Verbose class for MueLu classes.
Static class that holds the complete list of valid MueLu parameters.
Preconditioner (wrapped as a Xpetra::Operator) for Maxwell&#39;s equations in curl-curl form...
Teuchos::RCP< const Import > ImporterCoarse11_
Importer to coarse (1,1) hierarchy.
RefMaxwell(const Teuchos::RCP< Matrix > &SM_Matrix, const Teuchos::RCP< Matrix > &D0_Matrix, const Teuchos::RCP< Matrix > &M1_Matrix, const Teuchos::RCP< MultiVector > &Nullspace11, const Teuchos::RCP< RealValuedMultiVector > &NodalCoords, Teuchos::ParameterList &List, bool ComputePrec)
Teuchos::RCP< MultiVector > P11resSubComm_
RefMaxwell(const Teuchos::RCP< Matrix > &SM_Matrix, const Teuchos::RCP< Matrix > &D0_Matrix, const Teuchos::RCP< Matrix > &M0inv_Matrix, const Teuchos::RCP< Matrix > &M1_Matrix, const Teuchos::RCP< MultiVector > &Nullspace11, const Teuchos::RCP< RealValuedMultiVector > &NodalCoords, Teuchos::ParameterList &List, bool ComputePrec=true)
void allocateMemory(int numVectors) const
allocate multivectors for solve
Teuchos::RCP< Matrix > coarseA22_
Teuchos::RCP< MultiVector > residual_
Teuchos::RCP< MultiVector > DxSubComm_
void applyInverseAdditive(const MultiVector &RHS, MultiVector &X) const
apply additive algorithm for 2x2 solve
Teuchos::RCP< MultiVector > P11resTmp_
Teuchos::RCP< Matrix > Dk_2_
D_{k-2} matrix.
Teuchos::RCP< Matrix > invMk_1_invBeta_
inverse of mass matrices on (k-1)-th and (k-2)-th space with weights 1/beta and 1/alpha respectively ...
Kokkos::View< bool *, typename Node::device_type::memory_space > BCcols22_
MueLu::DefaultScalar Scalar
void resetMatrix(Teuchos::RCP< Matrix > SM_Matrix_new, bool ComputePrec=true)
Reset system matrix.
MueLu::DefaultGlobalOrdinal GlobalOrdinal
void rebalanceCoarse11Matrix(const int rebalanceStriding, const int numProcsCoarseA11)
rebalance the coarse A11 matrix, as well as P11, CoordsCoarse11 and Addon11
Teuchos::ParameterList precList11_
Teuchos::RCP< const Import > DorigImporter_
Teuchos::RCP< Matrix > P11_
special prolongator for 11 block and its transpose
void initialize(const Teuchos::RCP< Matrix > &D0_Matrix, const Teuchos::RCP< Matrix > &Ms_Matrix, const Teuchos::RCP< Matrix > &M0inv_Matrix, const Teuchos::RCP< Matrix > &M1_Matrix, const Teuchos::RCP< MultiVector > &Nullspace11, const Teuchos::RCP< RealValuedMultiVector > &NodalCoords, Teuchos::ParameterList &List)
Teuchos::RCP< Hierarchy > Hierarchy22_
RCP< Matrix > buildVectorNodalProlongator(const Teuchos::RCP< Matrix > &P_nodal) const
Teuchos::RCP< MultiVector > Dres_
void dump(const RCP< Matrix > &A, std::string name) const
dump out matrix
void buildCoarse11Matrix()
Compute coarseA11 = P11^{T}*SM*P11 + addon efficiently.
int spaceNumber_
The number of the space in the deRham complex.
Teuchos::RCP< Teuchos::ParameterList > coarseA11_RAP_reuse_data_
Teuchos::RCP< Hierarchy > HierarchyCoarse11_
Two hierarchies: one for the coarse (1,1)-block, another for the (2,2)-block.
Teuchos::RCP< MultiVector > DTR11Tmp_
RefMaxwell(const Teuchos::RCP< Matrix > &SM_Matrix, const Teuchos::RCP< Matrix > &Dk_1, const Teuchos::RCP< Matrix > &Dk_2, const Teuchos::RCP< Matrix > &D0, const Teuchos::RCP< Matrix > &M1_beta, const Teuchos::RCP< Matrix > &M1_alpha, const Teuchos::RCP< Matrix > &Mk_one, const Teuchos::RCP< Matrix > &Mk_1_one, const Teuchos::RCP< Matrix > &invMk_1_invBeta, const Teuchos::RCP< Matrix > &invMk_2_invAlpha, const Teuchos::RCP< MultiVector > &Nullspace11, const Teuchos::RCP< MultiVector > &Nullspace22, const Teuchos::RCP< RealValuedMultiVector > &NodalCoords, Teuchos::ParameterList &List, bool ComputePrec=true)
Teuchos::RCP< Matrix > Dk_1_T_
RCP< Operator > thyraPrecOp22_
void build22Matrix(const bool reuse, const bool doRebalancing, const int rebalanceStriding, const int numProcsA22)
Setup A22 = D0^T SM D0 and rebalance it, as well as D0 and Coords_.
Teuchos::RCP< RealValuedMultiVector > CoordsCoarse11_
Teuchos::RCP< MultiVector > NullspaceCoarse11_
Nullspace for coarse (1,1) problem.
Teuchos::RCP< Matrix > M1_alpha_
Teuchos::RCP< Teuchos::TimeMonitor > getTimer(std::string name, RCP< const Teuchos::Comm< int > > comm=Teuchos::null) const
get a (synced) timer
void compute(bool reuse=false)
Setup the preconditioner.
Teuchos::RCP< MultiVector > P11xSubComm_
Teuchos::RCP< const Map > DorigDomainMap_
Teuchos::RCP< Teuchos::ParameterList > getValidParamterList()
void describe(Teuchos::FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel=Teuchos::VERB_HIGH) const
bool disable_addon_
Some options.
RefMaxwell(const Teuchos::RCP< Matrix > &D0_Matrix, const Teuchos::RCP< Matrix > &M1_Matrix, const Teuchos::RCP< MultiVector > &Nullspace11, const Teuchos::RCP< RealValuedMultiVector > &NodalCoords, Teuchos::ParameterList &List)
RefMaxwell(const Teuchos::RCP< Matrix > &SM_Matrix, const Teuchos::RCP< Matrix > &D0_Matrix, const Teuchos::RCP< Matrix > &Ms_Matrix, const Teuchos::RCP< Matrix > &M0inv_Matrix, const Teuchos::RCP< Matrix > &M1_Matrix, const Teuchos::RCP< MultiVector > &Nullspace11, const Teuchos::RCP< RealValuedMultiVector > &NodalCoords, Teuchos::ParameterList &List, bool ComputePrec=true)
virtual ~RefMaxwell()
Destructor.
Teuchos::RCP< Matrix > M1_beta_
mass matrices on first space with weights beta and alpha respectively
Teuchos::RCP< Matrix > coarseA11_
coarse 11, 22 and coarse 22 blocks
void setupSubSolve(Teuchos::RCP< Hierarchy > &hierarchy, Teuchos::RCP< Operator > &thyraPrecOp, const Teuchos::RCP< Matrix > &A, const Teuchos::RCP< MultiVector > &Nullspace, const Teuchos::RCP< RealValuedMultiVector > &Coords, Teuchos::ParameterList &params, std::string &label, const bool reuse, const bool isSingular=false)
Setup a subsolve.
Teuchos::ParameterList parameterList_
Parameter lists.
Teuchos::RCP< Matrix > P22_
special prolongator for 22 block and its transpose
Teuchos::RCP< RealValuedMultiVector > Coords22_
Teuchos::RCP< MultiVector > Nullspace11_
Nullspace for (1.1) block.
Teuchos::RCP< MultiVector > Nullspace22_
Teuchos::RCP< MultiVector > DresIntermediate_
Teuchos::RCP< MultiVector > P11x_
Teuchos::RCP< Matrix > R11_
void apply(const MultiVector &X, MultiVector &Y, Teuchos::ETransp mode=Teuchos::NO_TRANS, Scalar alpha=Teuchos::ScalarTraits< Scalar >::one(), Scalar beta=Teuchos::ScalarTraits< Scalar >::zero()) const
RefMaxwell(const Teuchos::RCP< Matrix > &D0_Matrix, const Teuchos::RCP< Matrix > &M0inv_Matrix, const Teuchos::RCP< Matrix > &M1_Matrix, const Teuchos::RCP< MultiVector > &Nullspace11, const Teuchos::RCP< RealValuedMultiVector > &NodalCoords, Teuchos::ParameterList &List)
const Teuchos::RCP< const Map > getDomainMap() const
Returns the Xpetra::Map object associated with the domain of this operator.
void residual(const MultiVector &X, const MultiVector &B, MultiVector &R) const
Compute a residual R = B - (*this) * X.
Teuchos::RCP< MultiVector > DresSubComm_
Teuchos::RCP< Teuchos::ParameterList > coarseA11_AP_reuse_data_
Teuchos::RCP< MultiVector > DresTmp_
Teuchos::RCP< Matrix > Addon22_
the addon for the 22 block
RCP< Operator > thyraPrecOpH_
Teuchos::ScalarTraits< Scalar >::coordinateType coordinateType
RefMaxwell(Teuchos::RCP< Hierarchy > HH, Teuchos::RCP< Hierarchy > H22)
Constructor with Hierarchies.
void buildProlongator(const int spaceNumber, const Teuchos::RCP< Matrix > &A_nodal_Matrix, const RCP< MultiVector > &EdgeNullspace, Teuchos::RCP< Matrix > &edgeProlongator, Teuchos::RCP< MultiVector > &coarseEdgeNullspace, Teuchos::RCP< RealValuedMultiVector > &coarseNodalCoords) const
Teuchos::RCP< Teuchos::ParameterList > A22_AP_reuse_data_
Teuchos::RCP< SmootherPrototype > PostSmootherData11_
Teuchos::RCP< MultiVector > Dx_
Teuchos::RCP< RealValuedMultiVector > NodalCoords_
Coordinates.
Teuchos::ParameterList precList22_
Teuchos::RCP< Matrix > Dk_1_
D_{k-1} matrix and its transpose.
bool hasTransposeApply() const
Indicates whether this operator supports applying the adjoint operator.