10#ifndef MUELU_REFMAXWELL_DECL_HPP
11#define MUELU_REFMAXWELL_DECL_HPP
26#include "MueLu_FactoryManager.hpp"
46#include "Xpetra_Operator.hpp"
47#include "Xpetra_Map_fwd.hpp"
48#include "Xpetra_Matrix_fwd.hpp"
49#include "Xpetra_MapFactory_fwd.hpp"
50#include "Xpetra_MatrixFactory_fwd.hpp"
51#include "Xpetra_MultiVectorFactory_fwd.hpp"
52#include "Xpetra_VectorFactory_fwd.hpp"
53#include "Xpetra_CrsMatrixWrap_fwd.hpp"
221#undef MUELU_REFMAXWELL_SHORT
225 using magnitudeType =
typename Teuchos::ScalarTraits<Scalar>::magnitudeType;
238 RefMaxwell(Teuchos::RCP<Hierarchy> HH, Teuchos::RCP<Hierarchy> H22)
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,
258 Teuchos::ParameterList &List,
259 bool ComputePrec =
true) {
260 int spaceNumber = List.get<
int>(
"refmaxwell: space number", 1);
265 invMk_1_invBeta, invMk_2_invAlpha,
266 Nullspace11, Nullspace22, NodalCoords,
267 Teuchos::null, Teuchos::null,
273 const Teuchos::RCP<Matrix> &Dk_1,
274 const Teuchos::RCP<Matrix> &Dk_2,
275 const Teuchos::RCP<Matrix> &D0,
276 const Teuchos::RCP<Matrix> &M1_beta,
277 const Teuchos::RCP<Matrix> &M1_alpha,
278 const Teuchos::RCP<Matrix> &Mk_one,
279 const Teuchos::RCP<Matrix> &Mk_1_one,
280 const Teuchos::RCP<Matrix> &invMk_1_invBeta,
281 const Teuchos::RCP<Matrix> &invMk_2_invAlpha,
282 const Teuchos::RCP<MultiVector> &Nullspace11,
283 const Teuchos::RCP<MultiVector> &Nullspace22,
284 const Teuchos::RCP<RealValuedMultiVector> &NodalCoords,
285 const Teuchos::RCP<MultiVector> &Material_beta,
286 const Teuchos::RCP<MultiVector> &Material_alpha,
287 Teuchos::ParameterList &List,
288 bool ComputePrec =
true) {
289 int spaceNumber = List.get<
int>(
"refmaxwell: space number", 1);
294 invMk_1_invBeta, invMk_2_invAlpha,
295 Nullspace11, Nullspace22, NodalCoords,
296 Material_beta, Material_alpha,
314 const Teuchos::RCP<Matrix> &D0_Matrix,
315 const Teuchos::RCP<Matrix> &Ms_Matrix,
316 const Teuchos::RCP<Matrix> &M0inv_Matrix,
317 const Teuchos::RCP<Matrix> &M1_Matrix,
318 const Teuchos::RCP<MultiVector> &Nullspace11,
319 const Teuchos::RCP<RealValuedMultiVector> &NodalCoords,
320 Teuchos::ParameterList &List,
321 bool ComputePrec =
true) {
322 initialize(D0_Matrix, Ms_Matrix, M0inv_Matrix, M1_Matrix, Nullspace11, NodalCoords, Teuchos::null, List);
327 const Teuchos::RCP<Matrix> &D0_Matrix,
328 const Teuchos::RCP<Matrix> &Ms_Matrix,
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,
333 const Teuchos::RCP<MultiVector> &Material,
334 Teuchos::ParameterList &List,
335 bool ComputePrec =
true) {
336 initialize(D0_Matrix, Ms_Matrix, M0inv_Matrix, M1_Matrix, Nullspace11, NodalCoords, Material, List);
352 const Teuchos::RCP<Matrix> &D0_Matrix,
353 const Teuchos::RCP<Matrix> &M0inv_Matrix,
354 const Teuchos::RCP<Matrix> &M1_Matrix,
355 const Teuchos::RCP<MultiVector> &Nullspace11,
356 const Teuchos::RCP<RealValuedMultiVector> &NodalCoords,
357 Teuchos::ParameterList &List,
358 bool ComputePrec =
true) {
359 initialize(D0_Matrix, M1_Matrix, M0inv_Matrix, M1_Matrix, Nullspace11, NodalCoords, Teuchos::null, List);
373 const Teuchos::RCP<Matrix> &M0inv_Matrix,
374 const Teuchos::RCP<Matrix> &M1_Matrix,
375 const Teuchos::RCP<MultiVector> &Nullspace11,
376 const Teuchos::RCP<RealValuedMultiVector> &NodalCoords,
377 Teuchos::ParameterList &List)
379 initialize(D0_Matrix, M1_Matrix, M0inv_Matrix, M1_Matrix, Nullspace11, NodalCoords, Teuchos::null, List);
393 const Teuchos::RCP<Matrix> &D0_Matrix,
394 const Teuchos::RCP<Matrix> &M1_Matrix,
395 const Teuchos::RCP<MultiVector> &Nullspace11,
396 const Teuchos::RCP<RealValuedMultiVector> &NodalCoords,
397 Teuchos::ParameterList &List,
399 initialize(D0_Matrix, M1_Matrix, Teuchos::null, M1_Matrix, Nullspace11, NodalCoords, Teuchos::null, List);
412 const Teuchos::RCP<Matrix> &M1_Matrix,
413 const Teuchos::RCP<MultiVector> &Nullspace11,
414 const Teuchos::RCP<RealValuedMultiVector> &NodalCoords,
415 Teuchos::ParameterList &List)
417 initialize(D0_Matrix, M1_Matrix, Teuchos::null, M1_Matrix, Nullspace11, NodalCoords, Teuchos::null, List);
426 RefMaxwell(
const Teuchos::RCP<Matrix> &SM_Matrix,
427 Teuchos::ParameterList &List,
428 bool ComputePrec =
true);
448 void compute(
bool reuse =
false);
451 void resetMatrix(Teuchos::RCP<Matrix> SM_Matrix_new,
bool ComputePrec =
true);
456 void apply(
const MultiVector &X, MultiVector &Y,
457 Teuchos::ETransp mode = Teuchos::NO_TRANS,
458 Scalar alpha = Teuchos::ScalarTraits<Scalar>::one(),
459 Scalar beta = Teuchos::ScalarTraits<Scalar>::zero())
const;
464 void describe(Teuchos::FancyOStream &out,
const Teuchos::EVerbosityLevel verbLevel = Teuchos::VERB_HIGH)
const;
468 const MultiVector &B,
469 MultiVector &R)
const {
470 using STS = Teuchos::ScalarTraits<Scalar>;
471 R.update(STS::one(), B, STS::zero());
472 this->
apply(X, R, Teuchos::NO_TRANS, -STS::one(), STS::one());
490 void initialize(
const Teuchos::RCP<Matrix> &D0_Matrix,
491 const Teuchos::RCP<Matrix> &Ms_Matrix,
492 const Teuchos::RCP<Matrix> &M0inv_Matrix,
493 const Teuchos::RCP<Matrix> &M1_Matrix,
494 const Teuchos::RCP<MultiVector> &Nullspace11,
495 const Teuchos::RCP<RealValuedMultiVector> &NodalCoords,
496 const Teuchos::RCP<MultiVector> &Material,
497 Teuchos::ParameterList &List);
517 const Teuchos::RCP<Matrix> &Dk_1,
518 const Teuchos::RCP<Matrix> &Dk_2,
519 const Teuchos::RCP<Matrix> &D0,
520 const Teuchos::RCP<Matrix> &M1_beta,
521 const Teuchos::RCP<Matrix> &M1_alpha,
522 const Teuchos::RCP<Matrix> &Mk_one,
523 const Teuchos::RCP<Matrix> &Mk_1_one,
524 const Teuchos::RCP<Matrix> &invMk_1_invBeta,
525 const Teuchos::RCP<Matrix> &invMk_2_invAlpha,
526 const Teuchos::RCP<MultiVector> &Nullspace11,
527 const Teuchos::RCP<MultiVector> &Nullspace22,
528 const Teuchos::RCP<RealValuedMultiVector> &NodalCoords,
529 const Teuchos::RCP<MultiVector> &Material_beta,
530 const Teuchos::RCP<MultiVector> &Material_alpha,
531 Teuchos::ParameterList &List);
543 void build22Matrix(
const bool reuse,
const bool doRebalancing,
const int rebalanceStriding,
const int numProcsA22);
547 RCP<MultiVector>
buildNullspace(
const int spaceNumber,
const Kokkos::View<bool *, typename Node::device_type> &bcs,
const bool applyBCs);
550 Teuchos::RCP<Matrix>
buildProjection(
const int spaceNumber,
const RCP<MultiVector> &EdgeNullspace)
const;
559 Teuchos::RCP<Matrix> &P_nodal,
560 Teuchos::RCP<MultiVector> &Nullspace_nodal,
561 Teuchos::RCP<RealValuedMultiVector> &Coords_nodal)
const;
580 const Teuchos::RCP<Matrix> &A_nodal_Matrix,
581 const RCP<MultiVector> &EdgeNullspace,
582 Teuchos::RCP<Matrix> &edgeProlongator,
583 Teuchos::RCP<MultiVector> &coarseEdgeNullspace,
584 Teuchos::RCP<RealValuedMultiVector> &coarseNodalCoords)
const;
590 RCP<Matrix>
buildAddon(
const int spaceNumber);
595 Teuchos::RCP<Operator> &thyraPrecOp,
596 const Teuchos::RCP<Matrix> &A,
597 const Teuchos::RCP<MultiVector> &Nullspace,
598 const Teuchos::RCP<RealValuedMultiVector> &Coords,
599 const Teuchos::RCP<MultiVector> &Material,
600 Teuchos::ParameterList ¶ms,
603 const bool isSingular =
false);
612 void solveH(
const MultiVector &RHS, MultiVector &X)
const;
615 void solve22(
const MultiVector &RHS, MultiVector &X)
const;
621 void dump(
const RCP<Matrix> &A, std::string name)
const;
624 void dump(
const RCP<MultiVector> &X, std::string name)
const;
627 void dumpCoords(
const RCP<RealValuedMultiVector> &X, std::string name)
const;
630 void dump(
const Teuchos::ArrayRCP<bool> &v, std::string name)
const;
633 void dump(
const Kokkos::View<bool *, typename Node::device_type> &v, std::string name)
const;
697 bool disable_addon_,
disable_addon_22_,
dump_matrices_,
useKokkos_,
use_as_preconditioner_,
implicitTranspose_,
fuseProlongationAndUpdate_,
syncTimers_,
enable_reuse_,
skipFirst11Level_,
skipFirst22Level_;
703 mutable Teuchos::RCP<MultiVector>
P11res_,
P11x_,
P11resSubComm_,
P11xSubComm_,
DresIntermediate_,
Dres_,
DxIntermediate_,
Dx_,
DresSubComm_,
DxSubComm_,
residual_,
P11resTmp_,
DresTmp_,
DTR11Tmp_,
P11x_colmap_,
Dx_colmap_;
708#define MUELU_REFMAXWELL_SHORT
MueLu::DefaultLocalOrdinal LocalOrdinal
MueLu::DefaultScalar Scalar
MueLu::DefaultGlobalOrdinal GlobalOrdinal
Static class that holds the complete list of valid MueLu parameters.
Preconditioner (wrapped as a Xpetra::Operator) for Maxwell's equations in curl-curl form.
Teuchos::RCP< MultiVector > P11resTmp_
Teuchos::RCP< Matrix > Mk_1_one_
Teuchos::RCP< RealValuedMultiVector > NodalCoords_
Coordinates.
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)
Teuchos::RCP< MultiVector > Material_beta_
material for first space
Teuchos::RCP< MultiVector > P11x_
Teuchos::RCP< MultiVector > Nullspace22_
Teuchos::RCP< MultiVector > residual_
Teuchos::RCP< Matrix > M1_beta_
mass matrices on first space with weights beta and alpha respectively
Teuchos::RCP< MultiVector > Dx_colmap_
Teuchos::RCP< Teuchos::ParameterList > coarseA11_AP_reuse_data_
Kokkos::View< bool *, typename Node::device_type::memory_space > BCrows11_
Vectors for BCs.
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, const Teuchos::RCP< MultiVector > &Material_beta, const Teuchos::RCP< MultiVector > &Material_alpha, Teuchos::ParameterList &List, bool ComputePrec=true)
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, const Teuchos::RCP< MultiVector > &Material, Teuchos::ParameterList ¶ms, std::string &label, const bool reuse, const bool isSingular=false)
Setup a subsolve.
int globalNumberBoundaryUnknowns22_
Teuchos::RCP< Teuchos::ParameterList > A22_AP_reuse_data_
Teuchos::RCP< Matrix > coarseA22_
Teuchos::RCP< MultiVector > P11res_
Temporary memory.
Teuchos::RCP< MultiVector > DxIntermediate_
Teuchos::RCP< Matrix > coarseA11_
coarse 11, 22 and coarse 22 blocks
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 > Mk_one_
mass matrices with unit weight on k-th and (k-1)-th spaces
Teuchos::RCP< Matrix > Dk_1_T_
Teuchos::RCP< Teuchos::TimeMonitor > getTimer(std::string name, RCP< const Teuchos::Comm< int > > comm=Teuchos::null) const
get a (synced) timer
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)
void allocateMemory(int numVectors) const
allocate multivectors for solve
RCP< Matrix > buildVectorNodalProlongator(const Teuchos::RCP< Matrix > &P_nodal) const
Teuchos::RCP< const Map > DorigDomainMap_
Teuchos::RCP< Matrix > SM_Matrix_
The system that is getting preconditioned.
void describe(Teuchos::FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel=Teuchos::VERB_HIGH) const
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_
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_.
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)
void buildCoarse11Matrix()
Compute coarseA11 = P11^{T}*SM*P11 + addon efficiently.
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
Teuchos::RCP< SmootherPrototype > PostSmootherData11_
Teuchos::RCP< Teuchos::ParameterList > A22_RAP_reuse_data_
RCP< MultiVector > buildNullspace(const int spaceNumber, const Kokkos::View< bool *, typename Node::device_type > &bcs, const bool applyBCs)
Builds a nullspace.
bool hasTransposeApply() const
Indicates whether this operator supports applying the adjoint operator.
void determineSubHierarchyCommSizes(bool &doRebalancing, int &rebalanceStriding, int &numProcsCoarseA11, int &numProcsA22)
Determine how large the sub-communicators for the two hierarchies should be.
virtual ~RefMaxwell()=default
Destructor.
Teuchos::RCP< RealValuedMultiVector > Coords22_
bool disable_addon_
Some options.
Kokkos::View< bool *, typename Node::device_type::memory_space > BCdomain22_
void solveH(const MultiVector &RHS, MultiVector &X) const
apply solve to 1-1 block only
Teuchos::ParameterList precList22_
Teuchos::RCP< Matrix > A22_
typename Teuchos::ScalarTraits< Scalar >::coordinateType coordinateType
Teuchos::RCP< SmootherBase > PostSmoother11_
Teuchos::RCP< MultiVector > NullspaceCoarse11_
Nullspace for coarse (1,1) problem.
Teuchos::RCP< Matrix > Dk_2_
D_{k-2} matrix.
void setFineLevelSmoother11()
Set the fine level smoother.
Teuchos::RCP< Matrix > R11_
std::string solverName_
The name of the solver.
const Teuchos::RCP< Matrix > & getJacobian() const
Returns Jacobian matrix SM.
void dumpCoords(const RCP< RealValuedMultiVector > &X, std::string name) const
dump out real-valued multivector
Teuchos::RCP< Matrix > D0_
D_0 matrix.
Teuchos::RCP< const Import > Importer22_
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.
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)
Teuchos::RCP< MultiVector > Dx_
Teuchos::RCP< Matrix > M1_alpha_
Teuchos::RCP< Matrix > P11_
special prolongator for 11 block and its transpose
RefMaxwell(Teuchos::RCP< Hierarchy > HH, Teuchos::RCP< Hierarchy > H22)
Constructor with Hierarchies.
Teuchos::RCP< MultiVector > DresTmp_
bool use_as_preconditioner_
Teuchos::RCP< MultiVector > P11resSubComm_
Teuchos::RCP< MultiVector > P11xSubComm_
Teuchos::RCP< Hierarchy > Hierarchy22_
Teuchos::RCP< Teuchos::ParameterList > getValidParamterList()
Teuchos::RCP< Matrix > P22_
special prolongator for 22 block and its transpose
Teuchos::RCP< Hierarchy > HierarchyCoarse11_
Two hierarchies: one for the coarse (1,1)-block, another for the (2,2)-block.
Teuchos::RCP< MultiVector > CoarseNullspace22_
Nullspace for coarse (2,2) problem.
Teuchos::RCP< MultiVector > DTR11Tmp_
Teuchos::RCP< SmootherPrototype > PreSmootherData11_
int spaceNumber_
The number of the space in the deRham complex.
Teuchos::RCP< MultiVector > Dres_
void applyInverseAdditive(const MultiVector &RHS, MultiVector &X) const
apply additive algorithm for 2x2 solve
bool fuseProlongationAndUpdate_
RCP< Operator > thyraPrecOpH_
int globalNumberBoundaryUnknowns11_
Teuchos::RCP< MultiVector > DresIntermediate_
Teuchos::RCP< Matrix > Addon22_
the addon for the 22 block
Teuchos::RCP< RealValuedMultiVector > CoordsCoarse11_
Teuchos::RCP< const Import > DorigImporter_
bool Dk_1_T_R11_colMapsMatch_
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
const Teuchos::RCP< const Map > getRangeMap() const
Returns the Xpetra::Map object associated with the range of this operator.
void compute(bool reuse=false)
Setup the preconditioner.
Teuchos::ParameterList precList11_
Teuchos::RCP< Matrix > Dk_1_
D_{k-1} matrix and its transpose.
Teuchos::RCP< Teuchos::ParameterList > coarseA11_RAP_reuse_data_
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, const Teuchos::RCP< MultiVector > &Material, Teuchos::ParameterList &List)
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 > Addon11_
the addon for the 11 block
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.
typename Xpetra::MultiVector< coordinateType, LO, GO, NO > RealValuedMultiVector
Teuchos::ParameterList parameterList_
Parameter lists.
void dump(const RCP< Matrix > &A, std::string name) const
dump out matrix
void rebalanceCoarse11Matrix(const int rebalanceStriding, const int numProcsCoarseA11)
rebalance the coarse A11 matrix, as well as P11, CoordsCoarse11 and Addon11
Teuchos::RCP< MultiVector > Nullspace11_
Nullspace for (1.1) block.
size_t dim_
The spatial dimension.
Teuchos::RCP< MultiVector > P11x_colmap_
Teuchos::RCP< MultiVector > DresSubComm_
void resetMatrix(Teuchos::RCP< Matrix > SM_Matrix_new, bool ComputePrec=true)
Reset system matrix.
void setParameters(Teuchos::ParameterList &list)
Set parameters.
typename Teuchos::ScalarTraits< Scalar >::magnitudeType magnitudeType
Teuchos::RCP< SmootherBase > PreSmoother11_
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, const Teuchos::RCP< MultiVector > &Material, Teuchos::ParameterList &List, bool ComputePrec=true)
Teuchos::RCP< MultiVector > Material_alpha_
Teuchos::RCP< const Import > ImporterCoarse11_
Importer to coarse (1,1) hierarchy.
Teuchos::RCP< Matrix > R22_
RCP< Matrix > buildAddon(const int spaceNumber)
void solve22(const MultiVector &RHS, MultiVector &X) const
apply solve to 2-2 block only
Teuchos::RCP< Matrix > invMk_2_invAlpha_
RCP< Operator > thyraPrecOp22_
void residual(const MultiVector &X, const MultiVector &B, MultiVector &R) const
Compute a residual R = B - (*this) * X.
Teuchos::RCP< MultiVector > DxSubComm_
Verbose class for MueLu classes.
Namespace for MueLu classes and methods.