libMesh
petsc_nonlinear_solver.h
Go to the documentation of this file.
1 // The libMesh Finite Element Library.
2 // Copyright (C) 2002-2024 Benjamin S. Kirk, John W. Peterson, Roy H. Stogner
3 
4 // This library is free software; you can redistribute it and/or
5 // modify it under the terms of the GNU Lesser General Public
6 // License as published by the Free Software Foundation; either
7 // version 2.1 of the License, or (at your option) any later version.
8 
9 // This library is distributed in the hope that it will be useful,
10 // but WITHOUT ANY WARRANTY; without even the implied warranty of
11 // MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU
12 // Lesser General Public License for more details.
13 
14 // You should have received a copy of the GNU Lesser General Public
15 // License along with this library; if not, write to the Free Software
16 // Foundation, Inc., 59 Temple Place, Suite 330, Boston, MA 02111-1307 USA
17 
18 
19 
20 #ifndef LIBMESH_PETSC_NONLINEAR_SOLVER_H
21 #define LIBMESH_PETSC_NONLINEAR_SOLVER_H
22 
23 #include "libmesh/libmesh_config.h"
24 
25 // Petsc include files.
26 #ifdef LIBMESH_HAVE_PETSC
27 
28 // Local includes
29 #include "libmesh/nonlinear_solver.h"
30 #include "libmesh/petsc_macro.h"
31 #include "libmesh/wrapped_petsc.h"
32 
33 // PETSc includes
34 #ifdef I
35 # define LIBMESH_SAW_I
36 #endif
37 #include <petscsnes.h>
38 #ifndef LIBMESH_SAW_I
39 # undef I // Avoid complex.h contamination
40 #endif
41 
42 namespace libMesh
43 {
44 class ResidualContext;
45 
46 // Allow users access to these functions in case they want to reuse them. Users shouldn't
47 // need access to these most of the time as they are used internally by this object.
48 extern "C"
49 {
50  PetscErrorCode libmesh_petsc_recalculate_monitor(SNES snes, PetscInt it, PetscReal norm, void* mctx);
51  PetscErrorCode libmesh_petsc_snes_monitor (SNES, PetscInt its, PetscReal fnorm, void *);
52  PetscErrorCode libmesh_petsc_snes_residual (SNES, Vec x, Vec r, void * ctx);
53  PetscErrorCode libmesh_petsc_snes_fd_residual (SNES, Vec x, Vec r, void * ctx);
54  PetscErrorCode libmesh_petsc_snes_mffd_residual (SNES snes, Vec x, Vec r, void * ctx);
55  PetscErrorCode libmesh_petsc_snes_mffd_interface (void * ctx, Vec x, Vec r);
56  PetscErrorCode libmesh_petsc_snes_jacobian (SNES, Vec x, Mat jac, Mat pc, void * ctx);
57  PetscErrorCode libmesh_petsc_snes_precheck(SNESLineSearch, Vec X, Vec Y, PetscBool * changed, void * context);
58  PetscErrorCode libmesh_petsc_snes_postcheck(SNESLineSearch, Vec x, Vec y, Vec w, PetscBool * changed_y, PetscBool * changed_w, void * context);
59  PetscErrorCode libmesh_petsc_linesearch_shellfunc(SNESLineSearch linesearch, void * ctx);
60 
61 #ifdef LIBMESH_ENABLE_DEPRECATED
62  PetscErrorCode __libmesh_petsc_snes_monitor (SNES, PetscInt its, PetscReal fnorm, void *);
63  PetscErrorCode __libmesh_petsc_snes_residual (SNES, Vec x, Vec r, void * ctx);
64  PetscErrorCode __libmesh_petsc_snes_fd_residual (SNES, Vec x, Vec r, void * ctx);
65  PetscErrorCode __libmesh_petsc_snes_mffd_interface (void * ctx, Vec x, Vec r);
66  PetscErrorCode __libmesh_petsc_snes_jacobian (SNES, Vec x, Mat jac, Mat pc, void * ctx);
67  PetscErrorCode __libmesh_petsc_snes_postcheck(SNESLineSearch, Vec x, Vec y, Vec w, PetscBool * changed_y, PetscBool * changed_w, void * context);
68 #endif
69 }
70 
79 template <typename T>
81 {
82 public:
87 
91  explicit
93 
98 
102  virtual void clear () override;
103 
108  virtual void init (const char * name = nullptr) override;
109 
113  SNES snes();
114 
119  virtual std::pair<unsigned int, Real>
120  solve (SparseMatrix<T> &, // System Jacobian Matrix
121  NumericVector<T> &, // Solution vector
122  NumericVector<T> &, // Residual vector
123  const double, // Stopping tolerance
124  const unsigned int) override; // N. Iterations
125 
130  virtual void print_converged_reason() override;
131 
139  SNESConvergedReason get_converged_reason();
140 
144  virtual int get_total_linear_iterations() override;
145 
151  virtual unsigned get_current_nonlinear_iteration_number() const override
153 
157  void set_residual_zero_out(bool state) { _zero_out_residual = state; }
158 
162  void set_jacobian_zero_out(bool state) { _zero_out_jacobian = state; }
163 
167  void use_default_monitor(bool state) { _default_monitor = state; }
168 
172  void set_snesmf_reuse_base(bool state) { _snesmf_reuse_base = state; }
173 
178  bool snes_mf_reuse_base() const { return _snesmf_reuse_base; }
179 
184 
189 
194  {
195  public:
196  virtual ~ComputeLineSearchObject () = default;
197 
198  virtual void linesearch (SNESLineSearch linesearch) = 0;
199  };
200 
204  std::unique_ptr<ComputeLineSearchObject> linesearch_object;
205 
209  void setup_default_monitor();
210 
214  virtual bool reuse_preconditioner() const override;
215 
219  virtual unsigned int reuse_preconditioner_max_linear_its() const override;
220 
224  virtual void force_new_preconditioner() override;
225 
226 protected:
227 
232 
243  SNESConvergedReason _reason;
244 
249 
254 
259 
264 
269 
276 
278  void (*)(std::vector<NumericVector<Number> *> &, sys_type &),
279  MatNullSpace *);
280 
285 
290 
291 private:
292  friend ResidualContext libmesh_petsc_snes_residual_helper (SNES snes, Vec x, void * ctx);
293  friend PetscErrorCode libmesh_petsc_snes_residual (SNES snes, Vec x, Vec r, void * ctx);
294  friend PetscErrorCode libmesh_petsc_snes_fd_residual (SNES snes, Vec x, Vec r, void * ctx);
295  friend PetscErrorCode libmesh_petsc_snes_mffd_residual (SNES snes, Vec x, Vec r, void * ctx);
296  friend PetscErrorCode libmesh_petsc_snes_jacobian (SNES snes, Vec x, Mat jac, Mat pc, void * ctx);
297  friend PetscErrorCode libmesh_petsc_snes_precheck (SNESLineSearch,
298  Vec X,
299  Vec Y,
300  PetscBool * changed,
301  void * context);
302 };
303 
304 } // namespace libMesh
305 
306 
307 #endif // #ifdef LIBMESH_HAVE_PETSC
308 #endif // LIBMESH_PETSC_NONLINEAR_SOLVER_H
unsigned _current_nonlinear_iteration_number
Stores the current nonlinear iteration number.
std::string name(const ElemQuality q)
This function returns a string containing some name for q.
Definition: elem_quality.C:42
friend PetscErrorCode libmesh_petsc_snes_residual(SNES snes, Vec x, Vec r, void *ctx)
PetscErrorCode __libmesh_petsc_snes_jacobian(SNES, Vec x, Mat jac, Mat pc, void *ctx)
virtual unsigned int reuse_preconditioner_max_linear_its() const override
Getter for the maximum iterations flag for preconditioner reuse.
PetscErrorCode libmesh_petsc_snes_fd_residual(SNES, Vec x, Vec r, void *ctx)
PetscNonlinearSolver(sys_type &system)
Constructor.
void use_default_monitor(bool state)
Set to true to use the libMesh&#39;s default monitor, set to false to use your own.
WrappedPetsc< SNES > _snes
Nonlinear solver context.
PetscErrorCode __libmesh_petsc_snes_monitor(SNES, PetscInt its, PetscReal fnorm, void *)
friend PetscErrorCode libmesh_petsc_snes_jacobian(SNES snes, Vec x, Mat jac, Mat pc, void *ctx)
Provides a uniform interface to vector storage schemes for different linear algebra libraries...
Definition: vector_fe_ex5.C:43
This base class can be inherited from to provide interfaces to nonlinear solvers from different packa...
virtual void clear() override
Release all memory and clear data structures.
PetscErrorCode libmesh_petsc_snes_postcheck(SNESLineSearch, Vec x, Vec y, Vec w, PetscBool *changed_y, PetscBool *changed_w, void *context)
PetscErrorCode __libmesh_petsc_snes_residual(SNES, Vec x, Vec r, void *ctx)
virtual int get_total_linear_iterations() override
Get the total number of linear iterations done in the last solve.
bool _zero_out_residual
true to zero out residual before going into application level call-back, otherwise false ...
The libMesh namespace provides an interface to certain functionality in the library.
PetscErrorCode libmesh_petsc_snes_monitor(SNES, PetscInt its, PetscReal fnorm, void *)
PetscErrorCode __libmesh_petsc_snes_mffd_interface(void *ctx, Vec x, Vec r)
This class provides an interface to PETSc iterative solvers that is compatible with the libMesh Nonli...
bool _setup_reuse
Whether we&#39;ve triggered the preconditioner reuse.
~PetscNonlinearSolver()
Destructor.
Generic sparse matrix.
Definition: vector_fe_ex5.C:45
PetscErrorCode libmesh_petsc_snes_mffd_residual(SNES snes, Vec x, Vec r, void *ctx)
const sys_type & system() const
friend PetscErrorCode libmesh_petsc_snes_fd_residual(SNES snes, Vec x, Vec r, void *ctx)
bool _zero_out_jacobian
true to zero out jacobian before going into application level call-back, otherwise false ...
PetscInt _n_linear_iterations
Stores the total number of linear iterations from the last solve.
friend PetscErrorCode libmesh_petsc_snes_mffd_residual(SNES snes, Vec x, Vec r, void *ctx)
friend ResidualContext libmesh_petsc_snes_residual_helper(SNES snes, Vec x, void *ctx)
Manages consistently variables, degrees of freedom, coefficient vectors, matrices and non-linear solv...
PetscErrorCode __libmesh_petsc_snes_fd_residual(SNES, Vec x, Vec r, void *ctx)
void setup_default_monitor()
Setup the default monitor if required.
auto norm(const T &a) -> decltype(std::abs(a))
Definition: tensor_tools.h:74
virtual unsigned get_current_nonlinear_iteration_number() const override
void set_residual_zero_out(bool state)
Set if the residual should be zeroed out in the callback.
SNESConvergedReason _reason
Store the reason for SNES convergence/divergence for use even after the _snes has been cleared...
void set_jacobian_zero_out(bool state)
Set if the jacobian should be zeroed out in the callback.
PetscErrorCode libmesh_petsc_snes_mffd_interface(void *ctx, Vec x, Vec r)
virtual void linesearch(SNESLineSearch linesearch)=0
SNESConvergedReason get_converged_reason()
PetscErrorCode libmesh_petsc_linesearch_shellfunc(SNESLineSearch linesearch, void *ctx)
Abstract base class to be used to implement a custom line-search algorithm.
std::unique_ptr< ComputeLineSearchObject > linesearch_object
A callable object that can be used to specify a custom line-search.
virtual void force_new_preconditioner() override
Immediately force a new preconditioner, even if reuse is set.
PetscErrorCode libmesh_petsc_snes_jacobian(SNES, Vec x, Mat jac, Mat pc, void *ctx)
virtual void print_converged_reason() override
Prints a useful message about why the latest nonlinear solve con(di)verged.
PetscErrorCode libmesh_petsc_snes_precheck(SNESLineSearch, Vec X, Vec Y, PetscBool *changed, void *context)
void set_snesmf_reuse_base(bool state)
Set to true to let PETSc reuse the base vector.
void build_mat_null_space(NonlinearImplicitSystem::ComputeVectorSubspace *computeSubspaceObject, void(*)(std::vector< NumericVector< Number > *> &, sys_type &), MatNullSpace *)
bool _default_monitor
true if we want the default monitor to be set, false for no monitor (i.e.
virtual void init(const char *name=nullptr) override
Initialize data structures if not done so already.
friend PetscErrorCode libmesh_petsc_snes_precheck(SNESLineSearch, Vec X, Vec Y, PetscBool *changed, void *context)
virtual std::pair< unsigned int, Real > solve(SparseMatrix< T > &, NumericVector< T > &, NumericVector< T > &, const double, const unsigned int) override
Call the Petsc solver.
PetscErrorCode __libmesh_petsc_snes_postcheck(SNESLineSearch, Vec x, Vec y, Vec w, PetscBool *changed_y, PetscBool *changed_w, void *context)
virtual bool reuse_preconditioner() const override
Getter for preconditioner reuse.
void * ctx
bool _computing_base_vector
Whether we are computing the base vector for matrix-free finite differencing.
void set_computing_base_vector(bool computing_base_vector)
Set whether we are computing the base vector for matrix-free finite-differencing. ...
NonlinearImplicitSystem sys_type
The type of system.
PetscErrorCode libmesh_petsc_snes_residual(SNES, Vec x, Vec r, void *ctx)
bool _snesmf_reuse_base
True, If we want the base vector to be used for differencing even if the function provided to SNESSet...
PetscErrorCode libmesh_petsc_recalculate_monitor(SNES snes, PetscInt it, PetscReal norm, void *mctx)
Callable abstract base class to be used as a callback to provide the solver with a basis for the syst...