Reference documentation for deal.II version GIT relicensing-216-gcda843ca70 2024-03-28 12:20:02+00:00
\(\newcommand{\dealvcentcolon}{\mathrel{\mathop{:}}}\) \(\newcommand{\dealcoloneq}{\dealvcentcolon\mathrel{\mkern-1.2mu}=}\) \(\newcommand{\jump}[1]{\left[\!\left[ #1 \right]\!\right]}\) \(\newcommand{\average}[1]{\left\{\!\left\{ #1 \right\}\!\right\}}\)
Loading...
Searching...
No Matches
Classes | Public Member Functions | Static Public Member Functions | Public Attributes | Private Member Functions | Static Private Member Functions | Private Attributes | List of all members
SUNDIALS::KINSOL< VectorType > Class Template Reference

#include <deal.II/sundials/kinsol.h>

Inheritance diagram for SUNDIALS::KINSOL< VectorType >:
Inheritance graph
[legend]

Classes

class  AdditionalData
 

Public Member Functions

 KINSOL (const AdditionalData &data=AdditionalData())
 
 KINSOL (const AdditionalData &data, const MPI_Comm mpi_comm)
 
 ~KINSOL ()
 
unsigned int solve (VectorType &initial_guess_and_solution)
 

Static Public Member Functions

static ::ExceptionBaseExcKINSOLError (int arg1)
 

Public Attributes

std::function< void(VectorType &)> reinit_vector
 
std::function< void(const VectorType &src, VectorType &dst)> residual
 
std::function< void(const VectorType &src, VectorType &dst)> iteration_function
 
std::function< void(const VectorType &current_u, const VectorType &current_f)> setup_jacobian
 
std::function< void(const VectorType &rhs, VectorType &dst, const double tolerance)> solve_with_jacobian
 
std::function< VectorType &()> get_solution_scaling
 
std::function< VectorType &()> get_function_scaling
 
std::function< void(void *kinsol_mem)> custom_setup
 

Private Member Functions

void set_functions_to_trigger_an_assert ()
 

Static Private Member Functions

static ::ExceptionBaseExcFunctionNotProvided (std::string arg1)
 

Private Attributes

AdditionalData data
 
MPI_Comm mpi_communicator
 
void * kinsol_mem
 
SUNContext kinsol_ctx
 
GrowingVectorMemory< VectorType > mem
 
std::exception_ptr pending_exception
 

Detailed Description

template<typename VectorType = Vector<double>>
class SUNDIALS::KINSOL< VectorType >

Interface to SUNDIALS' nonlinear solver (KINSOL).

KINSOL is a solver for nonlinear algebraic systems in residual form \(F(u) = 0\) or fixed point form \(G(u) = u\), where \(u\) is a vector which we will assume to be in \({\mathbb R}^n\) or \({\mathbb C}^n\), but that may also have a block structure and may be distributed in parallel computations; the functions \(F\) and \(G\) satisfy \(F,G:{\mathbb R}^N \to{\mathbb R}^N\) or \(F,G:{\mathbb C}^N \to{\mathbb C}^N\). It includes a Newton-Krylov solver as well as Picard and fixed point solvers, both of which can be accelerated with Anderson acceleration. KINSOL is based on the previous Fortran package NKSOL of Brown and Saad. An example of using KINSOL can be found in the step-77 tutorial program.

KINSOL's Newton solver employs the inexact Newton method. As this solver is intended mainly for large systems, the user is required to provide their own solver function.

At the highest level, KINSOL implements the following iteration scheme:

Here, \(u_n\) is the \(n\)-th iterate to \(u\), and \(J(u) = \nabla_u F(u)\) is the system Jacobian. At each stage in the iteration process, a scalar multiple of the step \(\delta_n\), is added to \(u_n\) to produce a new iterate, \(u_{n+1}\). A test for convergence is made before the iteration continues.

Unless specified otherwise by the user, KINSOL strives to update Jacobian information as infrequently as possible to balance the high costs of matrix operations against other costs. Specifically, these updates occur when:

KINSOL allows changes to the above strategy through optional solver inputs. The user can disable the initial Jacobian information evaluation or change the default value of the number of nonlinear iterations after which a Jacobian information update is enforced.

To address the case of ill-conditioned nonlinear systems, KINSOL allows prescribing scaling factors both for the solution vector and for the residual vector. For scaling to be used, the user may supply the function get_solution_scaling(), that returns values \(D_u\), which are diagonal elements of the scaling matrix such that \(D_u u_n\) has all components roughly the same magnitude when \(u_n\) is close to a solution, and get_function_scaling(), that supply values \(D_F\), which are diagonal scaling matrix elements such that \(D_F F\) has all components roughly the same magnitude when \(u_n\) is not too close to a solution.

When scaling values are provided for the solution vector, these values are automatically incorporated into the calculation of the perturbations used for the default difference quotient approximations for Jacobian information if the user does not supply a Jacobian solver through the solve_with_jacobian() function.

Two methods of applying a computed step \(\delta_n\) to the previously computed solution vector are implemented. The first and simplest is the standard Newton strategy which applies the update with a constant \(\lambda\) always set to 1. The other method is a global strategy, which attempts to use the direction implied by \(\delta_n\) in the most efficient way for furthering convergence of the nonlinear problem. This technique is implemented in the second strategy, called Linesearch. This option employs both the \(\alpha\) and \(\beta\) conditions of the Goldstein-Armijo linesearch algorithm given in [68] , where \(\lambda\) is chosen to guarantee a sufficient decrease in \(F\) relative to the step length as well as a minimum step length relative to the initial rate of decrease of \(F\). One property of the algorithm is that the full Newton step tends to be taken close to the solution.

The basic fixed-point iteration scheme implemented in KINSOL is given by:

At each stage in the iteration process, function \(G\) is applied to the current iterate to produce a new iterate, \(u_{n+1}\). A test for convergence is made before the iteration continues.

For Picard iteration, as implemented in KINSOL, we consider a special form of the nonlinear function \(F\), such that \(F(u) = Lu - N(u)\), where \(L\) is a constant nonsingular matrix and \(N\) is (in general) nonlinear.

Then the fixed-point function \(G\) is defined as \(G(u) = u - L^{-1}F(u)\). Within each iteration, the Picard step is computed then added to \(u_n\) to produce the new iterate. Next, the nonlinear residual function is evaluated at the new iterate, and convergence is checked. The Picard and fixed point methods can be significantly accelerated using Anderson's acceleration method.

The user has to provide the implementation of the following std::functions:

Specifying residual() allows the user to use Newton and Picard strategies (i.e., \(F(u)=0\) will be solved), while specifying iteration_function(), a fixed point iteration will be used (i.e., \(G(u)=u\) will be solved). An error will be thrown if iteration_function() is set for Picard or Newton.

If the use of a Newton or Picard method is desired, then the user should also supply

Fixed point iteration does not require the solution of any linear system.

Also the following functions could be rewritten, to provide additional scaling factors for both the solution and the residual evaluation during convergence checks:

Definition at line 184 of file kinsol.h.

Constructor & Destructor Documentation

◆ KINSOL() [1/2]

template<typename VectorType >
SUNDIALS::KINSOL< VectorType >::KINSOL ( const AdditionalData data = AdditionalData())

Constructor, with class parameters set by the AdditionalData object.

Parameters
dataKINSOL configuration data
Note
With SUNDIALS 6 and later this constructor sets up logging objects to only work on the present processor (i.e., results are only communicated over MPI_COMM_SELF).

Definition at line 159 of file kinsol.cc.

◆ KINSOL() [2/2]

template<typename VectorType >
SUNDIALS::KINSOL< VectorType >::KINSOL ( const AdditionalData data,
const MPI_Comm  mpi_comm 
)

Constructor.

Parameters
dataKINSOL configuration data
mpi_commMPI Communicator over which logging operations are computed. Only used in SUNDIALS 6 and newer.

Definition at line 166 of file kinsol.cc.

◆ ~KINSOL()

template<typename VectorType >
SUNDIALS::KINSOL< VectorType >::~KINSOL ( )

Destructor.

Definition at line 196 of file kinsol.cc.

Member Function Documentation

◆ solve()

template<typename VectorType >
unsigned int SUNDIALS::KINSOL< VectorType >::solve ( VectorType &  initial_guess_and_solution)

Solve the non linear system. Return the number of nonlinear steps taken to converge. KINSOL uses the content of initial_guess_and_solution as initial guess, and stores the final solution in the same vector.

Definition at line 212 of file kinsol.cc.

◆ set_functions_to_trigger_an_assert()

template<typename VectorType >
void SUNDIALS::KINSOL< VectorType >::set_functions_to_trigger_an_assert ( )
private

This function is executed at construction time to set the std::function above to trigger an assert if they are not implemented.

Definition at line 558 of file kinsol.cc.

Member Data Documentation

◆ reinit_vector

template<typename VectorType = Vector<double>>
std::function<void(VectorType &)> SUNDIALS::KINSOL< VectorType >::reinit_vector

A function object that users need to supply and that is intended to reinitize the given vector to its correct size, block structure (if block vectors are used), and MPI communicator (if the vector is distributed across multiple processors using MPI), along with any other properties necessary.

Note
This variable represents a user provided callback. See there for a description of how to deal with errors and other requirements and conventions. In particular, KINSOL can deal with "recoverable" errors in some circumstances, so callbacks can throw exceptions of type RecoverableUserCallbackError.

Definition at line 482 of file kinsol.h.

◆ residual

template<typename VectorType = Vector<double>>
std::function<void(const VectorType &src, VectorType &dst)> SUNDIALS::KINSOL< VectorType >::residual

A function object that users should supply and that is intended to compute the residual dst = F(src). This function is only used if the SolutionStrategy::newton, SolutionStrategy::linesearch, or SolutionStrategy::picard strategies were selected.

Note
This variable represents a user provided callback. See there for a description of how to deal with errors and other requirements and conventions. In particular, KINSOL can deal with "recoverable" errors in some circumstances, so callbacks can throw exceptions of type RecoverableUserCallbackError.

Definition at line 497 of file kinsol.h.

◆ iteration_function

template<typename VectorType = Vector<double>>
std::function<void(const VectorType &src, VectorType &dst)> SUNDIALS::KINSOL< VectorType >::iteration_function

A function object that users should supply and that is intended to compute the iteration function \(G(u)\) for the fixed point iteration. This function is only used if the SolutionStrategy::fixed_point strategy is selected.

Note
This variable represents a user provided callback. See there for a description of how to deal with errors and other requirements and conventions. In particular, KINSOL can deal with "recoverable" errors in some circumstances, so callbacks can throw exceptions of type RecoverableUserCallbackError.

Definition at line 513 of file kinsol.h.

◆ setup_jacobian

template<typename VectorType = Vector<double>>
std::function<void(const VectorType &current_u, const VectorType &current_f)> SUNDIALS::KINSOL< VectorType >::setup_jacobian

A function object that users may supply and that is intended to prepare the linear solver for subsequent calls to solve_with_jacobian().

The job of setup_jacobian() is to prepare the linear solver for subsequent calls to solve_with_jacobian(), in the solution of linear systems \(Ax = b\). The exact nature of this system depends on the SolutionStrategy that has been selected.

In the cases strategy = SolutionStrategy::newton or SolutionStrategy::linesearch, \(A\) is the Jacobian \(J = \partial F/\partial u\). If strategy = SolutionStrategy::picard, \(A\) is the approximate Jacobian matrix \(L\). If strategy = SolutionStrategy::fixed_point, then linear systems do not arise, and this function is never called.

The setup_jacobian() function may call a user-supplied function, or a function within the linear solver module, to compute Jacobian-related data that is required by the linear solver. It may also preprocess that data as needed for solve_with_jacobian(), which may involve calling a generic function (such as for LU factorization) or, more generally, build preconditioners from the assembled Jacobian. In any case, the data so generated may then be used whenever a linear system is solved.

The point of this function is that setup_jacobian() function is not called at every Newton iteration, but only as frequently as the solver determines that it is appropriate to perform the setup task. In this way, Jacobian-related data generated by setup_jacobian() is expected to be used over a number of Newton iterations. KINSOL determines itself when it is beneficial to regenerate the Jacobian and associated information (such as preconditioners computed for the Jacobian), thereby saving the effort to regenerate the Jacobian matrix and a preconditioner for it whenever possible.

Parameters
current_uCurrent value of \(u\)
current_fCurrent value of \(F(u)\) or \(G(u)\)
Note
This variable represents a user provided callback. See there for a description of how to deal with errors and other requirements and conventions. In particular, KINSOL can deal with "recoverable" errors in some circumstances, so callbacks can throw exceptions of type RecoverableUserCallbackError.

Definition at line 562 of file kinsol.h.

◆ solve_with_jacobian

template<typename VectorType = Vector<double>>
std::function< void(const VectorType &rhs, VectorType &dst, const double tolerance)> SUNDIALS::KINSOL< VectorType >::solve_with_jacobian

A function object that users may supply and that is intended to solve a linear system with the Jacobian matrix. This function will be called by KINSOL (possibly several times) after setup_jacobian() has been called at least once. KINSOL tries to do its best to call setup_jacobian() the minimum number of times. If convergence can be achieved without updating the Jacobian, then KINSOL does not call setup_jacobian() again. If, on the contrary, internal KINSOL convergence tests fail, then KINSOL calls setup_jacobian() again with updated vectors and coefficients so that successive calls to solve_with_jacobian() lead to better convergence in the Newton process.

If you do not specify a solve_with_jacobian function, then only a fixed point iteration strategy can be used. Notice that this may not converge, or may converge very slowly.

A call to this function should store in dst the result of \(J^{-1}\) applied to rhs, i.e., \(J \cdot dst = rhs\). It is the user's responsibility to set up proper solvers and preconditioners inside this function (or in the setup_jacobian callback above). The function attached to this callback is also provided with a tolerance to the linear solver, indicating that it is not necessary to solve the linear system with the Jacobian matrix exactly, but only to a tolerance that KINSOL will adapt over time.

Arguments to the function are:

Parameters
[in]rhsThe system right hand side to solve for.
[out]dstThe solution of \(J^{-1} * src\).
[in]toleranceThe tolerance with which to solve the linear system of equations.
Note
This variable represents a user provided callback. See there for a description of how to deal with errors and other requirements and conventions. In particular, KINSOL can deal with "recoverable" errors in some circumstances, so callbacks can throw exceptions of type RecoverableUserCallbackError.

Definition at line 605 of file kinsol.h.

◆ get_solution_scaling

template<typename VectorType = Vector<double>>
std::function<VectorType &()> SUNDIALS::KINSOL< VectorType >::get_solution_scaling

A function object that users may supply and that is intended to return a vector whose components are the weights used by KINSOL to compute the vector norm of the solution. The implementation of this function is optional, and it is used only if implemented.

The intent for this scaling factor is for problems in which the different components of a solution have vastly different numerical magnitudes – typically because they have different physical units and represent different things. For example, if one were to solve a nonlinear Stokes problem, the solution vector has components that correspond to velocities and other components that correspond to pressures. These have different physical units and depending on which units one chooses, they may have roughly comparable numerical sizes or maybe they don't. To give just one example, in simulations of flow in the Earth's interior, one has velocities on the order of maybe ten centimeters per year, and pressures up to around 100 GPa. If one expresses this in SI units, this corresponds to velocities of around \(0.000,000,003=3 \times 10^{-9}\) m/s, and pressures around \(10^9 \text{kg}/\text{m}/\text{s}^2\), i.e., vastly different. In such cases, computing the \(l_2\) norm of a solution-type vector (e.g., the difference between the previous and the current solution) makes no sense because the norm will either be dominated by the velocity components or the pressure components. The scaling vector this function returns is intended to provide each component of the solution with a scaling factor that is generally chosen as the inverse of a "typical velocity" or "typical pressure" so that upon multiplication of a vector component by the corresponding scaling vector component, one obtains a number that is of order of magnitude of one (i.e., a reasonably small multiple of one times the typical velocity/pressure). The KINSOL manual states this as follows: "The user should supply values \_form#2629, which are diagonal elements of the scaling matrix such that \_form#2645 has all components roughly the same magnitude when \_form#304 is close to a solution".

If no function is provided to a KINSOL object, then this is interpreted as implicitly saying that all of these scaling factors should be considered as one.

Note
This variable represents a user provided callback. See there for a description of how to deal with errors and other requirements and conventions. In particular, KINSOL can deal with "recoverable" errors in some circumstances, so callbacks can throw exceptions of type RecoverableUserCallbackError.

Definition at line 652 of file kinsol.h.

◆ get_function_scaling

template<typename VectorType = Vector<double>>
std::function<VectorType &()> SUNDIALS::KINSOL< VectorType >::get_function_scaling

A function object that users may supply and that is intended to return a vector whose components are the weights used by KINSOL to compute the vector norm of the function evaluation away from the solution. The implementation of this function is optional, and it is used only if implemented.

The point of this function and the scaling vector it returns is similar to the one discussed above for get_solution_scaling, except that it is for a vector that scales the components of the function \(F(U)\), rather than the components of \(U\), when computing norms. As above, if no function is provided, then this is equivalent to using a scaling vector whose components are all equal to one.

Note
This variable represents a user provided callback. See there for a description of how to deal with errors and other requirements and conventions. In particular, KINSOL can deal with "recoverable" errors in some circumstances, so callbacks can throw exceptions of type RecoverableUserCallbackError.

Definition at line 675 of file kinsol.h.

◆ custom_setup

template<typename VectorType = Vector<double>>
std::function<void(void *kinsol_mem)> SUNDIALS::KINSOL< VectorType >::custom_setup

A function object that users may supply and which is intended to perform custom setup on the supplied kinsol_mem object. Refer to the SUNDIALS documentation for valid options.

For instance, the following code attaches a file for error output of the internal KINSOL implementation:

// Open C-style file handle and manage it inside a shared_ptr which
// is handed to the lambda capture in the next statement. When the
// custom_setup function is destroyed, the file is closed.
auto errfile = std::shared_ptr<FILE>(
fopen("kinsol.err", "w"),
[](FILE *fptr) { fclose(fptr); });
ode.custom_setup = [&, errfile](void *kinsol_mem) {
KINSetErrFile(kinsol_mem, errfile.get());
};
void * kinsol_mem
Definition kinsol.h:748
Note
This function will be called at the end of all other setup code right before the actual solve call is issued to KINSOL. Consult the SUNDIALS manual to see which options are still available at this point.
Parameters
kinsol_mempointer to the KINSOL memory block which can be used for custom calls to KINSet... functions.

Definition at line 706 of file kinsol.h.

◆ data

template<typename VectorType = Vector<double>>
AdditionalData SUNDIALS::KINSOL< VectorType >::data
private

KINSOL configuration data.

Definition at line 738 of file kinsol.h.

◆ mpi_communicator

template<typename VectorType = Vector<double>>
MPI_Comm SUNDIALS::KINSOL< VectorType >::mpi_communicator
private

The MPI communicator to be used by this solver, if any.

Definition at line 743 of file kinsol.h.

◆ kinsol_mem

template<typename VectorType = Vector<double>>
void* SUNDIALS::KINSOL< VectorType >::kinsol_mem
private

KINSOL memory object.

Definition at line 748 of file kinsol.h.

◆ kinsol_ctx

template<typename VectorType = Vector<double>>
SUNContext SUNDIALS::KINSOL< VectorType >::kinsol_ctx
private

A context object associated with the KINSOL solver.

Definition at line 754 of file kinsol.h.

◆ mem

template<typename VectorType = Vector<double>>
GrowingVectorMemory<VectorType> SUNDIALS::KINSOL< VectorType >::mem
private

Memory pool of vectors.

Definition at line 761 of file kinsol.h.

◆ pending_exception

template<typename VectorType = Vector<double>>
std::exception_ptr SUNDIALS::KINSOL< VectorType >::pending_exception
mutableprivate

A pointer to any exception that may have been thrown in user-defined call-backs and that we have to deal after the KINSOL function we call has returned.

Definition at line 768 of file kinsol.h.


The documentation for this class was generated from the following files: