MueLu Version of the Day
Loading...
Searching...
No Matches
MueLu_Maxwell1_decl.hpp
Go to the documentation of this file.
1// @HEADER
2//
3// ***********************************************************************
4//
5// MueLu: A package for multigrid based preconditioning
6// Copyright 2012 Sandia Corporation
7//
8// Under the terms of Contract DE-AC04-94AL85000 with Sandia Corporation,
9// the U.S. Government retains certain rights in this software.
10//
11// Redistribution and use in source and binary forms, with or without
12// modification, are permitted provided that the following conditions are
13// met:
14//
15// 1. Redistributions of source code must retain the above copyright
16// notice, this list of conditions and the following disclaimer.
17//
18// 2. Redistributions in binary form must reproduce the above copyright
19// notice, this list of conditions and the following disclaimer in the
20// documentation and/or other materials provided with the distribution.
21//
22// 3. Neither the name of the Corporation nor the names of the
23// contributors may be used to endorse or promote products derived from
24// this software without specific prior written permission.
25//
26// THIS SOFTWARE IS PROVIDED BY SANDIA CORPORATION "AS IS" AND ANY
27// EXPRESS OR IMPLIED WARRANTIES, INCLUDING, BUT NOT LIMITED TO, THE
28// IMPLIED WARRANTIES OF MERCHANTABILITY AND FITNESS FOR A PARTICULAR
29// PURPOSE ARE DISCLAIMED. IN NO EVENT SHALL SANDIA CORPORATION OR THE
30// CONTRIBUTORS BE LIABLE FOR ANY DIRECT, INDIRECT, INCIDENTAL, SPECIAL,
31// EXEMPLARY, OR CONSEQUENTIAL DAMAGES (INCLUDING, BUT NOT LIMITED TO,
32// PROCUREMENT OF SUBSTITUTE GOODS OR SERVICES; LOSS OF USE, DATA, OR
33// PROFITS; OR BUSINESS INTERRUPTION) HOWEVER CAUSED AND ON ANY THEORY OF
34// LIABILITY, WHETHER IN CONTRACT, STRICT LIABILITY, OR TORT (INCLUDING
35// NEGLIGENCE OR OTHERWISE) ARISING IN ANY WAY OUT OF THE USE OF THIS
36// SOFTWARE, EVEN IF ADVISED OF THE POSSIBILITY OF SUCH DAMAGE.
37//
38// Questions? Contact
39// Jonathan Hu (jhu@sandia.gov)
40// Andrey Prokopenko (aprokop@sandia.gov)
41// Ray Tuminaro (rstumin@sandia.gov)
42//
43// ***********************************************************************
44//
45// @HEADER
46#ifndef MUELU_MAXWELL1_DECL_HPP
47#define MUELU_MAXWELL1_DECL_HPP
48
49#include "MueLu_ConfigDefs.hpp"
50#include "MueLu_BaseClass.hpp"
51
54
56#include "MueLu_TrilinosSmoother.hpp"
58#include "MueLu_Level_fwd.hpp"
63
65
66#include "Xpetra_Map_fwd.hpp"
67#include "Xpetra_Matrix_fwd.hpp"
68#include "Xpetra_MatrixFactory_fwd.hpp"
69#include "Xpetra_MultiVectorFactory_fwd.hpp"
70#include "Xpetra_VectorFactory_fwd.hpp"
71#include "Xpetra_CrsMatrixWrap_fwd.hpp"
72
73namespace MueLu {
74
81 template <class Scalar,
82 class LocalOrdinal,
83 class GlobalOrdinal,
84 class Node>
85 class Maxwell1 : public VerboseObject, public Xpetra::Operator<Scalar,LocalOrdinal,GlobalOrdinal,Node> {
86
87#undef MUELU_MAXWELL1_SHORT
89
90 public:
91
92 typedef typename Teuchos::ScalarTraits<Scalar>::magnitudeType magnitudeType;
93 typedef typename Teuchos::ScalarTraits<Scalar>::coordinateType coordinateType;
94 typedef typename Xpetra::MultiVector<coordinateType,LO,GO,NO> RealValuedMultiVector;
95
98 Hierarchy11_(Teuchos::null),
99 Hierarchy22_(Teuchos::null),
100 HierarchyGmhd_(Teuchos::null),
102 {
103 }
104
106 Maxwell1(Teuchos::RCP<Hierarchy> H11, Teuchos::RCP<Hierarchy> H22) :
107 Hierarchy11_(H11),
108 Hierarchy22_(H22),
109 HierarchyGmhd_(Teuchos::null),
111 {
112 }
113
123 Maxwell1(const Teuchos::RCP<Matrix> & SM_Matrix,
124 const Teuchos::RCP<Matrix> & D0_Matrix,
125 const Teuchos::RCP<MultiVector> & Nullspace,
126 const Teuchos::RCP<RealValuedMultiVector> & Coords,
127 Teuchos::ParameterList& List,
128 bool ComputePrec = true):
130 {
131 RCP<Matrix> Kn_Matrix;
132 initialize(D0_Matrix,Kn_Matrix,Nullspace,Coords,List);
133 resetMatrix(SM_Matrix,ComputePrec);
134 }
135
145 Maxwell1(const Teuchos::RCP<Matrix> & SM_Matrix,
146 const Teuchos::RCP<Matrix> & D0_Matrix,
147 const Teuchos::RCP<Matrix> & Kn_Matrix,
148 const Teuchos::RCP<MultiVector> & Nullspace,
149 const Teuchos::RCP<RealValuedMultiVector> & Coords,
150 Teuchos::ParameterList& List,
151 bool ComputePrec = true):
153 {
154 initialize(D0_Matrix,Kn_Matrix,Nullspace,Coords,List);
155 resetMatrix(SM_Matrix,ComputePrec);
156 }
157
168 Maxwell1(const Teuchos::RCP<Matrix> & SM_Matrix,
169 const Teuchos::RCP<Matrix> & D0_Matrix,
170 const Teuchos::RCP<Matrix> & Kn_Matrix,
171 const Teuchos::RCP<MultiVector> & Nullspace,
172 const Teuchos::RCP<RealValuedMultiVector> & Coords,
173 Teuchos::ParameterList& List, const Teuchos::RCP<Matrix> & GmhdA_Matrix,
174 bool ComputePrec = true):
176 {
177 initialize(D0_Matrix,Kn_Matrix,Nullspace,Coords,List);
178 resetMatrix(SM_Matrix,ComputePrec);
179 GmhdA_Matrix_ = GmhdA_Matrix;
180 HierarchyGmhd_ = rcp(new Hierarchy("HierarchyGmhd"));
181 GMHDSetupHierarchy(List);
182 }
183
190 Maxwell1(const Teuchos::RCP<Matrix> & SM_Matrix,
191 Teuchos::ParameterList& List,
192 bool ComputePrec = true):
194 {
195
196 RCP<MultiVector> Nullspace = List.get<RCP<MultiVector> >("Nullspace", Teuchos::null);
197 RCP<RealValuedMultiVector> Coords = List.get<RCP<RealValuedMultiVector> >("Coordinates", Teuchos::null);
198 RCP<Matrix> D0_Matrix = List.get<RCP<Matrix> >("D0");
199 RCP<Matrix> Kn_Matrix;
200 if (List.isType<RCP<Matrix> >("Kn"))
201 Kn_Matrix = List.get<RCP<Matrix> >("Kn");
202
203 initialize(D0_Matrix,Kn_Matrix,Nullspace,Coords,List);
204
205 if (SM_Matrix != Teuchos::null)
206 resetMatrix(SM_Matrix,ComputePrec);
207 }
208
210 virtual ~Maxwell1() {}
211
213 Teuchos::RCP<const Map> getDomainMap() const;
214
216 Teuchos::RCP<const Map> getRangeMap() const;
217
219 const Teuchos::RCP<Matrix> & getJacobian() const {
220 return SM_Matrix_;
221 }
222
224 void setParameters(Teuchos::ParameterList& list);
225
227 void compute(bool reuse=false);
228
230 void resetMatrix(Teuchos::RCP<Matrix> SM_Matrix_new, bool ComputePrec=true);
231
235 void apply (const MultiVector& X, MultiVector& Y,
236 Teuchos::ETransp mode = Teuchos::NO_TRANS,
237 Scalar alpha = Teuchos::ScalarTraits<Scalar>::one(),
238 Scalar beta = Teuchos::ScalarTraits<Scalar>::zero()) const;
239
241 bool hasTransposeApply() const;
242
243 void describe(Teuchos::FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel = Teuchos::VERB_HIGH) const;
244
246 void residual(const MultiVector & X,
247 const MultiVector & B,
248 MultiVector & R) const {
249 using STS = Teuchos::ScalarTraits<Scalar>;
250 R.update(STS::one(),B,STS::zero());
251 this->apply (X, R, Teuchos::NO_TRANS, -STS::one(), STS::one());
252 }
253
254
255 private:
257 Teuchos::RCP<Matrix> generate_kn() const;
258
259
261 void GMHDSetupHierarchy(Teuchos::ParameterList& List) const;
262
271 void initialize(const Teuchos::RCP<Matrix> & D0_Matrix,
272 const Teuchos::RCP<Matrix> & Kn_Matrix,
273 const Teuchos::RCP<MultiVector> & Nullspace,
274 const Teuchos::RCP<RealValuedMultiVector> & Coords,
275 Teuchos::ParameterList& List);
276
277
279 void applyInverseRefMaxwellAdditive(const MultiVector& RHS, MultiVector& X) const;
280
282 void applyInverseStandard(const MultiVector& RHS, MultiVector& X) const;
283
285 void allocateMemory(int numVectors) const;
286
288 void dump(const Matrix& A, std::string name) const;
289
291 void dump(const MultiVector& X, std::string name) const;
292
294 void dumpCoords(const RealValuedMultiVector& X, std::string name) const;
295
297 void dump(const Teuchos::ArrayRCP<bool>& v, std::string name) const;
298
300 void dump(const Kokkos::View<bool*, typename Node::device_type>& v, std::string name) const;
301
303 Teuchos::RCP<Teuchos::TimeMonitor> getTimer(std::string name, RCP<const Teuchos::Comm<int> > comm=Teuchos::null) const;
304
306 mutable Teuchos::ParameterList parameterList_, precList11_, precList22_;
307
309 Teuchos::RCP<Hierarchy> Hierarchy11_, Hierarchy22_, HierarchyGmhd_;
310
313
315 Kokkos::View<bool*, typename Node::device_type> BCrowsKokkos_, BCcolsKokkos_, BCdomainKokkos_;
317 Teuchos::ArrayRCP<bool> BCrows_, BCcols_, BCdomain_;
319 Teuchos::RCP<MultiVector> Nullspace_;
321 Teuchos::RCP<RealValuedMultiVector> Coords_;
325
329
331 RCP<Matrix> P11_;
332 mutable Teuchos::RCP<MultiVector> residualFine_, residual11c_, residual22_, update11c_,update22_;
333
334 };
335
336
337
338
339} // namespace
340
341#define MUELU_MAXWELL1_SHORT
342#endif // MUELU_MAXWELL1_DECL_HPP
MueLu::DefaultLocalOrdinal LocalOrdinal
MueLu::DefaultScalar Scalar
MueLu::DefaultGlobalOrdinal GlobalOrdinal
MueLu::DefaultNode Node
Provides methods to build a multigrid hierarchy and apply multigrid cycles.
Preconditioner (wrapped as a Xpetra::Operator) for Maxwell's equations in curl-curl form.
Teuchos::ScalarTraits< Scalar >::coordinateType coordinateType
Xpetra::MultiVector< coordinateType, LO, GO, NO > RealValuedMultiVector
bool useKokkos_
Some options.
Teuchos::RCP< Matrix > generate_kn() const
Generates the Kn matrix.
Teuchos::RCP< Hierarchy > Hierarchy11_
Two hierarchies: one for the (1,1)-block, another for the (2,2)-block.
Teuchos::RCP< Hierarchy > HierarchyGmhd_
Teuchos::RCP< MultiVector > residualFine_
Teuchos::ArrayRCP< bool > BCcols_
virtual ~Maxwell1()
Destructor.
Teuchos::ArrayRCP< bool > BCrows_
Teuchos::RCP< Matrix > SM_Matrix_
Various matrices.
Teuchos::RCP< Hierarchy > Hierarchy22_
Maxwell1(const Teuchos::RCP< Matrix > &SM_Matrix, const Teuchos::RCP< Matrix > &D0_Matrix, const Teuchos::RCP< MultiVector > &Nullspace, const Teuchos::RCP< RealValuedMultiVector > &Coords, Teuchos::ParameterList &List, bool ComputePrec=true)
Teuchos::RCP< const Map > getDomainMap() const
Returns the Xpetra::Map object associated with the domain of this operator.
Maxwell1(const Teuchos::RCP< Matrix > &SM_Matrix, const Teuchos::RCP< Matrix > &D0_Matrix, const Teuchos::RCP< Matrix > &Kn_Matrix, const Teuchos::RCP< MultiVector > &Nullspace, const Teuchos::RCP< RealValuedMultiVector > &Coords, Teuchos::ParameterList &List, bool ComputePrec=true)
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.
void GMHDSetupHierarchy(Teuchos::ParameterList &List) const
Sets up hiearchy for GMHD matrices that include generalized Ohms law equations.
mode_type
Execution modes.
Teuchos::ParameterList parameterList_
ParameterLists.
Teuchos::RCP< MultiVector > residual22_
Teuchos::RCP< RealValuedMultiVector > Coords_
Coordinates.
Teuchos::RCP< Matrix > D0_Matrix_
Teuchos::ScalarTraits< Scalar >::magnitudeType magnitudeType
void applyInverseRefMaxwellAdditive(const MultiVector &RHS, MultiVector &X) const
apply RefMaxwell additive 2x2 style cycle
Teuchos::RCP< MultiVector > Nullspace_
Nullspace.
Kokkos::View< bool *, typename Node::device_type > BCdomainKokkos_
Teuchos::RCP< MultiVector > update11c_
Kokkos::View< bool *, typename Node::device_type > BCcolsKokkos_
Maxwell1(Teuchos::RCP< Hierarchy > H11, Teuchos::RCP< Hierarchy > H22)
Constructor with Hierarchies.
void applyInverseStandard(const MultiVector &RHS, MultiVector &X) const
apply standard Maxwell1 cycle
void initialize(const Teuchos::RCP< Matrix > &D0_Matrix, const Teuchos::RCP< Matrix > &Kn_Matrix, const Teuchos::RCP< MultiVector > &Nullspace, const Teuchos::RCP< RealValuedMultiVector > &Coords, Teuchos::ParameterList &List)
RCP< Matrix > P11_
Temporary memory (cached vectors for RefMaxwell-style)
void dumpCoords(const RealValuedMultiVector &X, std::string name) const
dump out real-valued multivector
Teuchos::RCP< MultiVector > update22_
Teuchos::ArrayRCP< bool > BCdomain_
Teuchos::ParameterList precList11_
Maxwell1(const Teuchos::RCP< Matrix > &SM_Matrix, const Teuchos::RCP< Matrix > &D0_Matrix, const Teuchos::RCP< Matrix > &Kn_Matrix, const Teuchos::RCP< MultiVector > &Nullspace, const Teuchos::RCP< RealValuedMultiVector > &Coords, Teuchos::ParameterList &List, const Teuchos::RCP< Matrix > &GmhdA_Matrix, bool ComputePrec=true)
void residual(const MultiVector &X, const MultiVector &B, MultiVector &R) const
Compute a residual R = B - (*this) * X.
const Teuchos::RCP< Matrix > & getJacobian() const
Returns Jacobian matrix SM.
void describe(Teuchos::FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel=Teuchos::VERB_HIGH) const
Teuchos::RCP< Matrix > GmhdA_Matrix_
void dump(const Matrix &A, std::string name) const
dump out matrix
Maxwell1(const Teuchos::RCP< Matrix > &SM_Matrix, Teuchos::ParameterList &List, bool ComputePrec=true)
Teuchos::ParameterList precList22_
void resetMatrix(Teuchos::RCP< Matrix > SM_Matrix_new, bool ComputePrec=true)
Reset system matrix.
Teuchos::RCP< Matrix > Kn_Matrix_
Teuchos::RCP< MultiVector > residual11c_
bool hasTransposeApply() const
Indicates whether this operator supports applying the adjoint operator.
Kokkos::View< bool *, typename Node::device_type > BCrowsKokkos_
Vectors for BCs.
Teuchos::RCP< Teuchos::TimeMonitor > getTimer(std::string name, RCP< const Teuchos::Comm< int > > comm=Teuchos::null) const
get a (synced) timer
void setParameters(Teuchos::ParameterList &list)
Set parameters.
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
void allocateMemory(int numVectors) const
allocate multivectors for solve
Verbose class for MueLu classes.
Namespace for MueLu classes and methods.