Loading [MathJax]/extensions/tex2jax.js
3.6-git
DUNE for Multi-{Phase, Component, Scale, Physics, ...} flow and transport in porous media
All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Modules Pages
preconditioners.hh
Go to the documentation of this file.
1// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*-
2// vi: set et ts=4 sw=4 sts=4:
3/*****************************************************************************
4 * See the file COPYING for full copying permissions. *
5 * *
6 * This program is free software: you can redistribute it and/or modify *
7 * it under the terms of the GNU General Public License as published by *
8 * the Free Software Foundation, either version 3 of the License, or *
9 * (at your option) any later version. *
10 * *
11 * This program is distributed in the hope that it will be useful, *
12 * but WITHOUT ANY WARRANTY; without even the implied warranty of *
13 * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the *
14 * GNU General Public License for more details. *
15 * *
16 * You should have received a copy of the GNU General Public License *
17 * along with this program. If not, see <http://www.gnu.org/licenses/>. *
18 *****************************************************************************/
24#ifndef DUMUX_LINEAR_PRECONDITIONERS_HH
25#define DUMUX_LINEAR_PRECONDITIONERS_HH
26
27#include <dune/common/exceptions.hh>
28#include <dune/common/float_cmp.hh>
29#include <dune/common/indices.hh>
30#include <dune/istl/preconditioners.hh>
31#include <dune/istl/paamg/amg.hh>
32
33#if HAVE_UMFPACK
34#include <dune/istl/umfpack.hh>
35#endif
36
40
41namespace Dumux {
42
77template<class M, class X, class Y, int l = 1>
78class SeqUzawa : public Dune::Preconditioner<X,Y>
79{
80 static_assert(Dumux::isMultiTypeBlockMatrix<M>::value && M::M() == 2 && M::N() == 2, "SeqUzawa expects a 2x2 MultiTypeBlockMatrix.");
81 static_assert(l== 1, "SeqUzawa expects a block level of 1.");
82
83 using A = std::decay_t<decltype(std::declval<M>()[Dune::Indices::_0][Dune::Indices::_0])>;
84 using U = std::decay_t<decltype(std::declval<X>()[Dune::Indices::_0])>;
85
86 using Comm = Dune::Amg::SequentialInformation;
87 using LinearOperator = Dune::MatrixAdapter<A, U, U>;
88 using Smoother = Dune::SeqSSOR<A, U, U>;
89 using AMGSolverForA = Dune::Amg::AMG<LinearOperator, U, Smoother, Comm>;
90
91public:
93 using matrix_type = M;
95 using domain_type = X;
97 using range_type = Y;
99 using field_type = typename X::field_type;
101 using scalar_field_type = Dune::Simd::Scalar<field_type>;
102
109 SeqUzawa(const std::shared_ptr<const Dune::AssembledLinearOperator<M,X,Y>>& op, const Dune::ParameterTree& params)
110 : matrix_(op->getmat())
111 , numIterations_(params.get<std::size_t>("iterations"))
112 , relaxationFactor_(params.get<scalar_field_type>("relaxation"))
113 , verbosity_(params.get<int>("verbosity"))
114 , paramGroup_(params.get<std::string>("ParameterGroup"))
115 , useDirectVelocitySolverForA_(getParamFromGroup<bool>(paramGroup_, "LinearSolver.Preconditioner.DirectSolverForA", false))
116 {
117 const bool determineRelaxationFactor = getParamFromGroup<bool>(paramGroup_, "LinearSolver.Preconditioner.DetermineRelaxationFactor", true);
118
119 // AMG is needed for determination of omega
120 if (determineRelaxationFactor || !useDirectVelocitySolverForA_)
121 initAMG_(params);
122
123 if (useDirectVelocitySolverForA_)
124 initUMFPack_();
125
126 if (determineRelaxationFactor)
127 relaxationFactor_ = estimateOmega_();
128 }
129
133 virtual void pre(X& x, Y& b) {}
134
141 virtual void apply(X& update, const Y& currentDefect)
142 {
143 using namespace Dune::Indices;
144
145 auto& A = matrix_[_0][_0];
146 auto& B = matrix_[_0][_1];
147 auto& C = matrix_[_1][_0];
148 auto& D = matrix_[_1][_1];
149
150 const auto& f = currentDefect[_0];
151 const auto& g = currentDefect[_1];
152 auto& u = update[_0];
153 auto& p = update[_1];
154
155 // incorporate Dirichlet cell values
156 // TODO: pass Dirichlet constraint handler from outside
157 for (std::size_t i = 0; i < D.N(); ++i)
158 {
159 const auto& block = D[i][i];
160 for (auto rowIt = block.begin(); rowIt != block.end(); ++rowIt)
161 if (Dune::FloatCmp::eq<scalar_field_type>(rowIt->one_norm(), 1.0))
162 p[i][rowIt.index()] = g[i][rowIt.index()];
163 }
164
165 // the actual Uzawa iteration
166 for (std::size_t k = 0; k < numIterations_; ++k)
167 {
168 // u_k+1 = u_k + Q_A^−1*(f − (A*u_k + B*p_k)),
169 auto uRhs = f;
170 A.mmv(u, uRhs);
171 B.mmv(p, uRhs);
172 auto uIncrement = u;
173 applySolverForA_(uIncrement, uRhs);
174 u += uIncrement;
175
176 // p_k+1 = p_k + omega*(g - C*u_k+1 - D*p_k)
177 auto pIncrement = g;
178 C.mmv(u, pIncrement);
179 D.mmv(p, pIncrement);
180 pIncrement *= relaxationFactor_;
181 p += pIncrement;
182
183 if (verbosity_ > 1)
184 {
185 std::cout << "Uzawa iteration " << k
186 << ", residual: " << uRhs.two_norm() + pIncrement.two_norm()/relaxationFactor_ << std::endl;
187 }
188 }
189 }
190
194 virtual void post(X& x) {}
195
197 virtual Dune::SolverCategory::Category category() const
198 {
199 return Dune::SolverCategory::sequential;
200 }
201
202private:
203
204 void initAMG_(const Dune::ParameterTree& params)
205 {
206 using namespace Dune::Indices;
207 auto linearOperator = std::make_shared<LinearOperator>(matrix_[_0][_0]);
208 amgSolverForA_ = std::make_unique<AMGSolverForA>(linearOperator, params);
209 }
210
211 void initUMFPack_()
212 {
213#if HAVE_UMFPACK
214 using namespace Dune::Indices;
215 umfPackSolverForA_ = std::make_unique<Dune::UMFPack<A>>(matrix_[_0][_0]);
216#else
217 DUNE_THROW(Dune::InvalidStateException, "UMFPack not available. Use LinearSolver.Preconditioner.DirectVelocitySolver = false.");
218#endif
219 }
220
240 scalar_field_type estimateOmega_() const
241 {
242 using namespace Dune::Indices;
243 auto& A = matrix_[_0][_0];
244 auto& B = matrix_[_0][_1];
245 auto& C = matrix_[_1][_0];
246
247 U x(A.M());
248 x = 1.0;
249
250 scalar_field_type omega = 0.0;
251 scalar_field_type lambdaMax = 0.0;
252
253 static const auto iterations = Dumux::getParamFromGroup<std::size_t>(paramGroup_, "LinearSolver.Preconditioner.PowerLawIterations", 5);
254
255 // apply power iteration x_k+1 = M*x_k/|M*x_k| for the matrix M = -C*Ainv*B
256 for (std::size_t i = 0; i < iterations; ++i)
257 {
258 // bx = B*x
259 U bx(x.size());
260 B.mv(x, bx);
261
262 // ainvbx = Ainv*(B*x)
263 auto ainvbx = x;
264 applySolverForA_(ainvbx, bx);
265
266 // v = M*x = -C*(Ainv*B*x)
267 U v(x.size());
268 C.mv(ainvbx, v);
269 v *= -1.0;
270
271 // eigenvalue lambdaMax = xt*M*x/(xt*x) = xt*v/(xt*x);
272 lambdaMax = x.dot(v)/(x.dot(x));
273
274 // relaxation factor omega = 1/lambda;
275 omega = 1.0/lambdaMax;
276
277 // new iterate x = M*x/|M*x| = v/|v|
278 x = v;
279 x /= v.two_norm();
280 }
281
282 if (verbosity_ > 0)
283 {
284 std::cout << "\n*** Uzawa Preconditioner ***" << std::endl;
285 std::cout << "Estimating relaxation factor based on Schur complement" << std::endl;
286 std::cout << "Largest estimated eigenvalue lambdaMax = " << lambdaMax << std::endl;
287 std::cout << "Relaxation factor omega = 1/lambdaMax = " << omega << std::endl;
288 }
289
290 return omega;
291 }
292
293 template<class Sol, class Rhs>
294 void applySolverForA_(Sol& sol, Rhs& rhs) const
295 {
296 if (useDirectVelocitySolverForA_)
297 {
298#if HAVE_UMFPACK
299 Dune::InverseOperatorResult res;
300 umfPackSolverForA_->apply(sol, rhs, res);
301#endif
302 }
303 else
304 {
305 amgSolverForA_->pre(sol, rhs);
306 amgSolverForA_->apply(sol, rhs);
307 amgSolverForA_->post(sol);
308 }
309 }
310
312 const M& matrix_;
314 const std::size_t numIterations_;
316 scalar_field_type relaxationFactor_;
318 const int verbosity_;
319
320 std::unique_ptr<AMGSolverForA> amgSolverForA_;
321#if HAVE_UMFPACK
322 std::unique_ptr<Dune::UMFPack<A>> umfPackSolverForA_;
323#endif
324 const std::string paramGroup_;
325 const bool useDirectVelocitySolverForA_;
326};
327
328DUMUX_REGISTER_PRECONDITIONER("uzawa", Dumux::MultiTypeBlockMatrixPreconditionerTag, Dune::defaultPreconditionerBlockLevelCreator<Dumux::SeqUzawa, 1>());
329
330} // end namespace Dumux
331
332#endif
Type traits to be used with matrix types.
The infrastructure to retrieve run-time parameters from Dune::ParameterTrees.
The specialized Dumux macro and tag for the ISTL registry to choose the solver and preconditioner at ...
T getParamFromGroup(Args &&... args)
A free function to get a parameter from the parameter tree singleton with a model group.
Definition: parameters.hh:161
Adaption of the non-isothermal two-phase two-component flow model to problems with CO2.
Definition: adapt.hh:29
DUMUX_REGISTER_PRECONDITIONER("uzawa", Dumux::MultiTypeBlockMatrixPreconditionerTag, Dune::defaultPreconditionerBlockLevelCreator< Dumux::SeqUzawa, 1 >())
Helper type to determine whether a given type is a Dune::MultiTypeBlockMatrix.
Definition: matrix.hh:49
A preconditioner based on the Uzawa algorithm for saddle-point problems of the form .
Definition: preconditioners.hh:79
virtual Dune::SolverCategory::Category category() const
Category of the preconditioner (see SolverCategory::Category)
Definition: preconditioners.hh:197
M matrix_type
The matrix type the preconditioner is for.
Definition: preconditioners.hh:93
virtual void pre(X &x, Y &b)
Prepare the preconditioner.
Definition: preconditioners.hh:133
SeqUzawa(const std::shared_ptr< const Dune::AssembledLinearOperator< M, X, Y > > &op, const Dune::ParameterTree &params)
Constructor.
Definition: preconditioners.hh:109
virtual void post(X &x)
Clean up.
Definition: preconditioners.hh:194
Dune::Simd::Scalar< field_type > scalar_field_type
Scalar type underlying the field_type.
Definition: preconditioners.hh:101
typename X::field_type field_type
The field type of the preconditioner.
Definition: preconditioners.hh:99
X domain_type
The domain type of the preconditioner.
Definition: preconditioners.hh:95
Y range_type
The range type of the preconditioner.
Definition: preconditioners.hh:97
virtual void apply(X &update, const Y &currentDefect)
Apply the preconditioner.
Definition: preconditioners.hh:141