46#ifndef MUELU_REFMAXWELL_DECL_HPP
47#define MUELU_REFMAXWELL_DECL_HPP
80#include "MueLu_XpetraOperator.hpp"
82#include "Xpetra_Map_fwd.hpp"
83#include "Xpetra_Matrix_fwd.hpp"
84#include "Xpetra_MatrixFactory_fwd.hpp"
85#include "Xpetra_MultiVectorFactory_fwd.hpp"
86#include "Xpetra_VectorFactory_fwd.hpp"
87#include "Xpetra_CrsMatrixWrap_fwd.hpp"
123#undef MUELU_REFMAXWELL_SHORT
128 typedef typename Teuchos::ScalarTraits<Scalar>::magnitudeType
magnitudeType;
142 RefMaxwell(Teuchos::RCP<Hierarchy> HH, Teuchos::RCP<Hierarchy> H22) :
163 const Teuchos::RCP<Matrix> & D0_Matrix,
164 const Teuchos::RCP<Matrix> & Ms_Matrix,
165 const Teuchos::RCP<Matrix> & M0inv_Matrix,
166 const Teuchos::RCP<Matrix> & M1_Matrix,
167 const Teuchos::RCP<MultiVector> & Nullspace,
168 const Teuchos::RCP<RealValuedMultiVector> & Coords,
169 Teuchos::ParameterList& List,
170 bool ComputePrec =
true)
172 initialize(D0_Matrix,Ms_Matrix,M0inv_Matrix,M1_Matrix,Nullspace,Coords,List);
188 const Teuchos::RCP<Matrix> & D0_Matrix,
189 const Teuchos::RCP<Matrix> & M0inv_Matrix,
190 const Teuchos::RCP<Matrix> & M1_Matrix,
191 const Teuchos::RCP<MultiVector> & Nullspace,
192 const Teuchos::RCP<RealValuedMultiVector> & Coords,
193 Teuchos::ParameterList& List,
194 bool ComputePrec =
true)
196 initialize(D0_Matrix,M1_Matrix,M0inv_Matrix,M1_Matrix,Nullspace,Coords,List);
210 const Teuchos::RCP<Matrix> & M0inv_Matrix,
211 const Teuchos::RCP<Matrix> & M1_Matrix,
212 const Teuchos::RCP<MultiVector> & Nullspace,
213 const Teuchos::RCP<RealValuedMultiVector> & Coords,
216 initialize(D0_Matrix,M1_Matrix,M0inv_Matrix,M1_Matrix,Nullspace,Coords,List);
230 const Teuchos::RCP<Matrix> & D0_Matrix,
231 const Teuchos::RCP<Matrix> & M1_Matrix,
232 const Teuchos::RCP<MultiVector> & Nullspace,
233 const Teuchos::RCP<RealValuedMultiVector> & Coords,
234 Teuchos::ParameterList& List,
237 initialize(D0_Matrix,M1_Matrix,Teuchos::null,M1_Matrix,Nullspace,Coords,List);
250 const Teuchos::RCP<Matrix> & M1_Matrix,
251 const Teuchos::RCP<MultiVector> & Nullspace,
252 const Teuchos::RCP<RealValuedMultiVector> & Coords,
255 initialize(D0_Matrix,M1_Matrix,Teuchos::null,M1_Matrix,Nullspace,Coords,List);
265 Teuchos::ParameterList& List,
266 bool ComputePrec =
true)
269 RCP<MultiVector> Nullspace = List.get<RCP<MultiVector> >(
"Nullspace", Teuchos::null);
270 RCP<RealValuedMultiVector> Coords = List.get<RCP<RealValuedMultiVector> >(
"Coordinates", Teuchos::null);
271 RCP<Matrix> D0_Matrix = List.get<RCP<Matrix> >(
"D0");
272 RCP<Matrix> Ms_Matrix;
273 if (List.isType<RCP<Matrix> >(
"Ms"))
274 Ms_Matrix = List.get<RCP<Matrix> >(
"Ms");
276 Ms_Matrix = List.get<RCP<Matrix> >(
"M1");
277 RCP<Matrix> M1_Matrix = List.get<RCP<Matrix> >(
"M1");
278 RCP<Matrix> M0inv_Matrix = List.get<RCP<Matrix> >(
"M0inv", Teuchos::null);
280 initialize(D0_Matrix,Ms_Matrix,M0inv_Matrix,M1_Matrix,Nullspace,Coords,List);
282 if (SM_Matrix != Teuchos::null)
304 void compute(
bool reuse=
false);
313 void resetMatrix(Teuchos::RCP<Matrix> SM_Matrix_new,
bool ComputePrec=
true);
318 void apply (
const MultiVector& X, MultiVector& Y,
319 Teuchos::ETransp mode = Teuchos::NO_TRANS,
320 Scalar alpha = Teuchos::ScalarTraits<Scalar>::one(),
321 Scalar beta = Teuchos::ScalarTraits<Scalar>::zero())
const;
326 void describe(Teuchos::FancyOStream &out,
const Teuchos::EVerbosityLevel verbLevel = Teuchos::VERB_HIGH)
const;
330 const MultiVector & B,
331 MultiVector & R)
const {
332 using STS = Teuchos::ScalarTraits<Scalar>;
333 R.update(STS::one(),B,STS::zero());
334 this->
apply (X, R, Teuchos::NO_TRANS, -STS::one(), STS::one());
350 void initialize(
const Teuchos::RCP<Matrix> & D0_Matrix,
351 const Teuchos::RCP<Matrix> & Ms_Matrix,
352 const Teuchos::RCP<Matrix> & M0inv_Matrix,
353 const Teuchos::RCP<Matrix> & M1_Matrix,
354 const Teuchos::RCP<MultiVector> & Nullspace,
355 const Teuchos::RCP<RealValuedMultiVector> & Coords,
356 Teuchos::ParameterList& List);
365 void solveH(
const MultiVector& RHS, MultiVector& X)
const;
368 void solve22(
const MultiVector& RHS, MultiVector& X)
const;
374 void dump(
const Matrix& A, std::string name)
const;
377 void dump(
const MultiVector& X, std::string name)
const;
383 void dump(
const Teuchos::ArrayRCP<bool>& v, std::string name)
const;
386 void dump(
const Kokkos::View<bool*, typename Node::device_type>& v, std::string name)
const;
426 mutable Teuchos::RCP<MultiVector>
P11res_,
P11x_,
P11resSubComm_,
P11xSubComm_,
D0res_,
D0x_,
D0resSubComm_,
D0xSubComm_,
residual_,
P11resTmp_,
D0resTmp_,
D0TR11Tmp_;
432#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 > D0xSubComm_
Teuchos::RCP< MultiVector > NullspaceH_
Nullspace for (1,1) problem.
Teuchos::RCP< MultiVector > P11resTmp_
Kokkos::View< bool *, typename Node::device_type > BCdomainKokkos_
void dumpCoords(const RealValuedMultiVector &X, std::string name) const
dump out real-valued multivector
Teuchos::ScalarTraits< Scalar >::coordinateType coordinateType
Teuchos::RCP< SmootherBase > PreSmoother_
Teuchos::RCP< MultiVector > P11x_
Teuchos::RCP< MultiVector > residual_
Teuchos::ArrayRCP< bool > BCrows_
Teuchos::RCP< Matrix > D0_Matrix_
Teuchos::RCP< const Import > D0origImporter_
Teuchos::RCP< Teuchos::ParameterList > A22_AP_reuse_data_
Teuchos::RCP< MultiVector > P11res_
Temporary memory.
RefMaxwell(const Teuchos::RCP< Matrix > &D0_Matrix, const Teuchos::RCP< Matrix > &M1_Matrix, const Teuchos::RCP< MultiVector > &Nullspace, const Teuchos::RCP< RealValuedMultiVector > &Coords, Teuchos::ParameterList &List)
Teuchos::ArrayRCP< bool > BCdomain_
Xpetra::MultiVector< coordinateType, LO, GO, NO > RealValuedMultiVector
Teuchos::RCP< RealValuedMultiVector > Coords_
Coordinates.
void formCoarseMatrix()
Compute P11^{T}*A*P11 efficiently.
Teuchos::RCP< Matrix > AH_
Teuchos::RCP< Teuchos::TimeMonitor > getTimer(std::string name, RCP< const Teuchos::Comm< int > > comm=Teuchos::null) const
get a (synced) timer
void allocateMemory(int numVectors) const
allocate multivectors for solve
Teuchos::RCP< Matrix > M0inv_Matrix_
RefMaxwell(const Teuchos::RCP< Matrix > &SM_Matrix, const Teuchos::RCP< Matrix > &D0_Matrix, const Teuchos::RCP< Matrix > &M1_Matrix, const Teuchos::RCP< MultiVector > &Nullspace, const Teuchos::RCP< RealValuedMultiVector > &Coords, Teuchos::ParameterList &List, bool ComputePrec)
Teuchos::RCP< MultiVector > D0x_
Teuchos::RCP< Matrix > SM_Matrix_
Various matrices.
Teuchos::RCP< Teuchos::ParameterList > AH_AP_reuse_data_
void describe(Teuchos::FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel=Teuchos::VERB_HIGH) const
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 > &Nullspace, const Teuchos::RCP< RealValuedMultiVector > &Coords, Teuchos::ParameterList &List)
Teuchos::RCP< Matrix > D0_T_Matrix_
Teuchos::ParameterList smootherList_
Teuchos::RCP< MultiVector > D0res_
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 > PostSmootherData_
Teuchos::RCP< Teuchos::ParameterList > A22_RAP_reuse_data_
bool hasTransposeApply() const
Indicates whether this operator supports applying the adjoint operator.
Teuchos::RCP< SmootherPrototype > PreSmootherData_
bool disable_addon_
Some options.
void solveH(const MultiVector &RHS, MultiVector &X) const
apply solve to 1-1 block only
Teuchos::ParameterList precList22_
Teuchos::RCP< const Import > ImporterH_
Importer to coarse (1,1) hierarchy.
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 > &Nullspace, const Teuchos::RCP< RealValuedMultiVector > &Coords, Teuchos::ParameterList &List, bool ComputePrec=true)
Teuchos::RCP< Matrix > A22_
Teuchos::RCP< Matrix > R11_
Teuchos::ScalarTraits< Scalar >::magnitudeType magnitudeType
const Teuchos::RCP< Matrix > & getJacobian() const
Returns Jacobian matrix SM.
Teuchos::RCP< const Import > Importer22_
void buildProlongator()
Setup the prolongator for the (1,1)-block.
Teuchos::RCP< Teuchos::ParameterList > AH_RAP_reuse_data_
Teuchos::RCP< Matrix > A_nodal_Matrix_
Teuchos::RCP< Matrix > P11_
RefMaxwell(Teuchos::RCP< Hierarchy > HH, Teuchos::RCP< Hierarchy > H22)
Constructor with Hierarchies.
virtual ~RefMaxwell()
Destructor.
bool use_as_preconditioner_
Teuchos::ArrayRCP< bool > BCcols_
Teuchos::RCP< MultiVector > P11resSubComm_
Teuchos::RCP< MultiVector > P11xSubComm_
Kokkos::View< bool *, typename Node::device_type > BCcolsKokkos_
Teuchos::RCP< Hierarchy > Hierarchy22_
Teuchos::RCP< SmootherBase > PostSmoother_
Teuchos::RCP< MultiVector > D0resTmp_
Teuchos::RCP< Matrix > Addon_Matrix_
Teuchos::RCP< Matrix > M1_Matrix_
void setFineLevelSmoother()
Set the fine level smoother.
Teuchos::RCP< MultiVector > D0TR11Tmp_
void applyInverseAdditive(const MultiVector &RHS, MultiVector &X) const
apply additive algorithm for 2x2 solve
bool fuseProlongationAndUpdate_
RCP< Operator > thyraPrecOpH_
RefMaxwell(const Teuchos::RCP< Matrix > &SM_Matrix, Teuchos::ParameterList &List, bool ComputePrec=true)
RefMaxwell(const Teuchos::RCP< Matrix > &D0_Matrix, const Teuchos::RCP< Matrix > &M0inv_Matrix, const Teuchos::RCP< Matrix > &M1_Matrix, const Teuchos::RCP< MultiVector > &Nullspace, const Teuchos::RCP< RealValuedMultiVector > &Coords, Teuchos::ParameterList &List)
Teuchos::RCP< const Map > getRangeMap() const
Returns the Xpetra::Map object associated with the range of this operator.
Teuchos::RCP< RealValuedMultiVector > CoordsH_
void compute(bool reuse=false)
Setup the preconditioner.
Teuchos::RCP< Hierarchy > HierarchyH_
Two hierarchies: one for the coarse (1,1)-block, another for the (2,2)-block.
Teuchos::ParameterList precList11_
Teuchos::RCP< Matrix > Ms_Matrix_
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 > &Nullspace, const Teuchos::RCP< RealValuedMultiVector > &Coords, Teuchos::ParameterList &List, bool ComputePrec=true)
Teuchos::ParameterList parameterList_
Parameter lists.
Teuchos::RCP< MultiVector > D0resSubComm_
void resetMatrix(Teuchos::RCP< Matrix > SM_Matrix_new, bool ComputePrec=true)
Reset system matrix.
void setParameters(Teuchos::ParameterList &list)
Set parameters.
Teuchos::RCP< MultiVector > Nullspace_
Nullspace.
bool D0_T_R11_colMapsMatch_
Kokkos::View< bool *, typename Node::device_type > BCrowsKokkos_
Vectors for BCs.
void dump(const Matrix &A, std::string name) const
dump out matrix
void solve22(const MultiVector &RHS, MultiVector &X) const
apply solve to 2-2 block only
Teuchos::RCP< const Map > D0origDomainMap_
Teuchos::RCP< const Map > getDomainMap() const
Returns the Xpetra::Map object associated with the domain of this operator.
RCP< Operator > thyraPrecOp22_
void residual(const MultiVector &X, const MultiVector &B, MultiVector &R) const
Compute a residual R = B - (*this) * X.
Verbose class for MueLu classes.
Namespace for MueLu classes and methods.