Solving differential algebraic equations with SDC¶
This project contains the sweepers, hooks, example problems, plotting and simulation scripts for a Master’s thesis investigating the usage of SDC methods to solve differential algebraic equations (DAEs).
To run the scripts contained in this project a standard installation of pySDC should suffice.
Project overview¶
- misc
- meshDAE.pyDatatype for semi-explicit DAE problem classes differential and algebraic parts to have a clean treatment.
- hooksDAE.pySimple hook classes to read out the approximate solution and error after each time step.
- problemDAE.pyParent class for DAE problems containing the method to solve the (non)-linear system at each node/stage.
 
 
- plotting
- linear_plot.pyReads a previously generated data file in .npy format and generates a plot on linear axis of the specified parameters.
- loglog_plot.pyReads a previously generated data file in .npy format and generates a plot on logarithmic axis of the specified parameters. Commonly used to generate convergence plots.
- semilogy_plot.pyReads a previously generated data file in .npy format and generates a plot on logarithmic y-axis and linear x-axis.
 
 
- problems
- discontinousTestDAE.pySimple nonlinear semi-explicit index-1 DAE with discrete state event whose event time is known.
- pendulum2D.pyExample of the pendulum described by a semi-implicit DAE of index 3.
- problematicF.pyFully-implicit DAE of index 2 which is not solvable for numerically solvable for certain choices of parameter \(\eta\).
- simpleDAE.pyLinear semi-explicit index-2 system of Hessenberg form with known analytical solution.
- synchronousMachine.pySynchronous machine model attached to an infinite bus undergoing torque disturbance test. Results in an index-1 system.
- transistorAmplifier.pyA two transistor amplifier model that results in an index-1 differential algebraic system. A nice example of a system resulting from a common real world situation.
- wscc9BusSystem.pyLarge power system test case with three reduced model synchronous machines and nine buses. It is also part of the PinTSimE project.
 
 
- run
- run_convergence_test.pyScript to generate convergence data of applying SDC to the simple linear index-2 differential algebraic system mentioned above.
- run_iteration_test.pyScript to generate data describing behaviour of error and residual of applying SDC to the simple linear index-2 differential algebraic system mentioned above.
- fully_implicit_dae_playground.pyTesting arena for the fully implicit sweeper.
- synchronous_machine_playground.pyTesting arena for the synchronous machine model.
- accuracy_check_MPI.pyScript checking the order of accuracy of MPI sweepers for DAEs of different indices.
 
 
- sweepers
- fullyImplicitDAE.pySweeper that accepts a fully implicit formulation of a system of differential equations and applies to it a modified version of spectral deferred correction
- semiImplicitDAE.pySDC sweeper especially for semi-explicit DAEs. This sweeper is based on ideas mentioned in Huang et al. (2007).
- fullyImplicitDAEMPI.pyMPI version of fully-implicit SDC-DAE sweeper.
- semiImplicitDAEMPI.pyMPI version of semi-implicit SDC-DAE sweeper.
- rungeKuttaDAE.pyRunge-Kutta methods that can be used to solve DAEs in pySDC in a fully-implicit description.
 
 
- tests
- Here, all tests for the project can be found. 
 
Theoretical details¶
A fully implicit representation of a system of differential equations takes the form
A special case of such an implicit differential equation arises when the Jacobian \(\partial_{u'}F\) is singular. This implies that the derivative of some of the components of \(u(t)\) do not appear in the system of equations. The system is thus denoted a differential algebraic system of equations.
Since the derivative \(u'(t)\) cannot be isolated the Picard formulation used in SDC for ordinary differential equations (ODEs) cannot be used here. Instead the derivative, henceforth denoted by \(U(t)\), is cast as the new unknown solution and the implicit system of equations is written as
The solution \(u(t)\) can then be recovered using an quadrature step. This approach is also called the yp-formulation.
Based on this equation and an initial approximate solution \(\tilde{U}\), the following error equation is formed
This results directly in
from which the following time marching discretisation becomes obvious
The spectral integration matrix \(\mathbf{Q}\) is used to approximate the integral of the current approximation \(\tilde{U}\) and a low order approximation, in this case implicit Euler, is used for the unknown error \(\delta(t)\). Combining each step in the time marching scheme into a vector results in the following matrix formulation
with the integration matrix of the implicit Euler method
Finally, the iterative nature of the method is made clear by considering that the approximate solution can be updated repeatedly with a \(\tilde{\mathbf{\delta}}\) that is recalculated after each iteration and using the previously updated solution as the initial condition for the next iteration. In this way, reformulation of the previous equation as
results in the following iterative scheme
In practice each iteration is carried out line by line and the resulting implicit equation for \(U_{m+1}^{k+1}\) is solved using the familiar scipy.optimize.root() function.
How to implement a DAE problem in pySDC?¶
Different from all other ODE problem classes in pySDC the DAE problem classes use the yp-formulation where the derivative is the unknown and the solution \(u\) is recovered using quadrature. Interested readers about the different formulations for spectral deferred corrections are referred to Qu et al. (2015).
Let us consider the fully-implicit DAE
which is of the general form
import numpy as np
from pySDC.projects.DAE.misc.problemDAE import ProblemDAE
from pySDC.implementations.datatype_classes.mesh import mesh
class ProblematicF(ProblemDAE):
    r"""
    Standard example of a very simple fully implicit index-2 differential algebraic equation (DAE) that is not
    numerically solvable for certain choices of the parameter :math:`\eta`. The DAE system is given by
    .. math::
        \frac{d y(t)}{dt} + \eta t \frac{d z(t)}{dt} + (1 + \eta) z (t) = g (t).
    .. math::
        y (t) + \eta t z (t) = f(t),
    See, for example, page 264 of [1]_.
    Parameters
    ----------
    nvars : int
        Number of unknowns of the system of DAEs.
    newton_tol : float
        Tolerance for Newton solver.
    Attributes
    ----------
    eta : float
        Specific parameter of the problem.
    References
    ----------
    .. [1] U. Ascher, L. R. Petzold. Computer method for ordinary differential equations and differential-algebraic
        equations. Society for Industrial and Applied Mathematics (1998).
    """
    dtype_u = mesh
    dtype_f = mesh
    def __init__(self, newton_tol, eta=1):
        """Initialization routine"""
        super().__init__(nvars=2, newton_tol=newton_tol)
        self._makeAttributeAndRegister('eta', localVars=locals())
    def eval_f(self, u, du, t):
        r"""
        Routine to evaluate the implicit representation of the problem, i.e., :math:`F(u, u', t)`.
        Parameters
        ----------
        u : dtype_u
            Current values of the numerical solution at time t.
        du : dtype_u
            Current values of the derivative of the numerical solution at time t.
        t : float
            Current time of the numerical solution.
        Returns
        -------
        f : dtype_f
            Current value of the right-hand side of f (which includes two components).
        """
        f = self.dtype_f(self.init)
        f[:] = (
            u[0] + self.eta * t * u[1] - np.sin(t),
            du[0] + self.eta * t * du[1] + (1 + self.eta) * u[1] - np.cos(t),
        )
        self.work_counters['rhs']()
        return f
    def u_exact(self, t):
        """
        Routine for the exact solution.
        Parameters
        ----------
        t : float
            The time of the reference solution.
        Returns
        -------
        me : dtype_u
            The reference solution as mesh object containing two components.
        """
        me = self.dtype_u(self.init)
        me[:] = (np.sin(t), 0)
        return me
    def du_exact(self, t):
        """
        Routine for the derivative of the exact solution.
        Parameters
        ----------
        t : float
            The time of the reference solution.
        Returns
        -------
        me : dtype_u
            The reference solution as mesh object containing two components.
        """
        me = self.dtype_u(self.init)
        me[:] = (np.cos(t), 0)
        return me
The imports for the classes ProblemDAE and mesh are necessary for implementing this problem.
The problem class inherits from the parent ProblemDAE that
has the solve_system method solving the (non)-linear system to find the root, i.e., updating the values of the unknown derivative. All DAE problem classes should therefore inherit from this class.
For this general type of DAEs the datatype mesh is used here for both, u and f.
Further, the constructor requires at least the parameter newton_tol, the tolerance passed to the root solver. It is possible to set a default value (which is set to 1e-8 in the example above).
Note: The name newton_tol could be confusing. The implicit system is not solved by Newton but rather by a root solver from SciPy. Different quasi-Newton methods can be chosen (see the [documentation](https://docs.scipy.org/doc/scipy/reference/generated/scipy.optimize.root.html)). Default here is 'hybr' that uses modified Powell hybrid method. To change to solver it is possible to overload the solve_system method in a new implemented problem class.
Possibly other problem-specific parameters are needed. Our example class also needs a constant eta set to \(1\) and storing it as an attribute using self._makeAttributeAndRegister('eta', localVars=locals()).
The system of DAEs consists of two equations, i.e., two unknowns. Thus, the number of variables nvars needs to be set to \(2\).
Implementing this system of equations the problem class also requires the eval_f method. As it can be seen, the method returns the right-hand side function \(F\) of the DAE in the way to have a function for which the root is sought.
Since the exact solution is known for this problem, the method u_exact returns it for each time t.
For Runge-Kutta methods, an initial condition for the derivatives at initial time \(t_0\) \(y'(t_0)\) and \(z'(t_0)\) are needed as well. They are implemented using the du_exact method.
The second large class of DAEs is the one of semi-explicit form
which is also called a constrained differential equation. \(y\) is the differential variable and \(z\) denotes the algebraic variable since no corresponding integration is in the problem. We want to implement such an equation and consider the example
This example has two differential variables \(u_1\), \(u_2\) (two differential equations) and one algebraic variable \(z\) (thus one algebraic equation).
In pySDC defining a problem class for semi-explicit DAEs is slightly different to those of fully-implicit form. Additionally to numpy for the example the imports for the classes ProblemDAE and MeshDAE are needed.
import numpy as np
from pySDC.projects.DAE.misc.problemDAE import ProblemDAE
class SimpleDAE(ProblemDAE):
    r"""
    Example implementing a smooth linear index-2 differential-algebraic equation (DAE) with known analytical solution.
    The DAE system is given by
    .. math::
        \frac{d u_1 (t)}{dt} = (\alpha - \frac{1}{2 - t}) u_1 (t) + (2-t) \alpha z (t) + \frac{3 - t}{2 - t},
    .. math::
        \frac{d u_2 (t)}{dt} = \frac{1 - \alpha}{t - 2} u_1 (t) - u_2 (t) + (\alpha - 1) z (t) + 2 e^{t},
    .. math::
        0 = (t + 2) u_1 (t) + (t^{2} - 4) u_2 (t) - (t^{2} + t - 2) e^{t}.
    The exact solution of this system is
    .. math::
        u_1 (t) = u_2 (t) = e^{t},
    .. math::
        z (t) = -\frac{e^{t}}{2 - t}.
    This example is commonly used to test that numerical implementations are functioning correctly. See, for example,
    page 267 of [1]_.
    Parameters
    ----------
    nvars : int
        Number of unknowns of the system of DAEs.
    newton_tol : float
        Tolerance for Newton solver.
    References
    ----------
    .. [1] U. Ascher, L. R. Petzold. Computer method for ordinary differential equations and differential-algebraic
        equations. Society for Industrial and Applied Mathematics (1998).
    """
    def __init__(self, newton_tol=1e-10):
        """Initialization routine"""
        super().__init__(nvars=3, newton_tol=newton_tol)
    def eval_f(self, u, du, t):
        r"""
        Routine to evaluate the implicit representation of the problem, i.e., :math:`F(u, u', t)`.
        Parameters
        ----------
        u : dtype_u
            Current values of the numerical solution at time t.
        du : dtype_u
            Current values of the derivative of the numerical solution at time t.
        t : float
            Current time of the numerical solution.
        Returns
        -------
        f : dtype_f
            Current value of the right-hand side of f (which includes three components).
        """
        # Smooth index-2 DAE pg. 267 Ascher and Petzold (also the first example in KDC Minion paper)
        a = 10.0
        f = self.dtype_f(self.init)
        f.diff[:2] = (
            -du.diff[0] + (a - 1 / (2 - t)) * u.diff[0] + (2 - t) * a * u.alg[0] + (3 - t) / (2 - t) * np.exp(t),
            -du.diff[1] + (1 - a) / (t - 2) * u.diff[0] - u.diff[1] + (a - 1) * u.alg[0] + 2 * np.exp(t),
        )
        f.alg[0] = (t + 2) * u.diff[0] + (t**2 - 4) * u.diff[1] - (t**2 + t - 2) * np.exp(t)
        self.work_counters['rhs']()
        return f
    def u_exact(self, t):
        """
        Routine for the exact solution.
        Parameters
        ----------
        t : float
            The time of the reference solution.
        Returns
        -------
        me : dtype_u
            The reference solution as mesh object containing three components.
        """
        me = self.dtype_u(self.init)
        me.diff[:2] = (np.exp(t), np.exp(t))
        me.alg[0] = -np.exp(t) / (2 - t)
        return me
    def du_exact(self, t):
        """
        Routine for the derivative of the exact solution.
        Parameters
        ----------
        t : float
            The time of the reference solution.
        Returns
        -------
        me : dtype_u
            The reference solution as mesh object containing three components.
        """
        me = self.dtype_u(self.init)
        me.diff[:2] = (np.exp(t), np.exp(t))
        me.alg[0] = (np.exp(t) * (t - 3)) / ((2 - t) ** 2)
        return me
This problem class inherits again from ProblemDAE. In contrast, for the solution u and the right-hand side of the f
a different datatype MeshDAE is used that allows to separate between the differential variables and the algebraic variables as well
as for the equations. The tolerance for the root solver is passed with a default value of 1e-10 and the number of unknowns is \(3\), i.e., nvars=3.
The problem-specific parameter a has a default value of 10.0.
In the eval_f method the equations and the variables are now separated using the components of the MeshDAE. Recall that eval_f returns the right-hand side function so that we have a root problem. However, for this semi-explicit DAE this is not the case, but we can change that by rewriting the system to
In the example above the differential variables are \(u_1\) and \(u_2\) which can be accessed using u.diff[0] and u.diff[1].
The algebraic variable \(z\) is stored in u.alg[0]. The corresponding derivatives for \(u_1\) and \(u_2\) are stored in du.diff[0] and du.diff[1].
It is also possible to separate the differential and algebraic equations by assigning the corresponding equations to f.diff[0] and f.diff[1], and f.alg[0], respectively.
In the same way the method u_exact to access the exact solution can be implemented.
This example class also have an du_exact method to implement initial conditions for \(u_1'(t_0)\), \(u_2'(t_0)\), and \(z'(t_0)\).