From 51a946bbdeb17004646b85d57c08d96aa23eff16 Mon Sep 17 00:00:00 2001 From: Wolfgang Bangerth Date: Tue, 9 Jul 2024 10:57:36 -0600 Subject: [PATCH] Add a test that checks backward compatibility. --- tests/petsc/petsc_ts_03_compat.cc | 272 ++++++ tests/petsc/petsc_ts_03_compat.output | 580 +++++++++++++ tests/petsc/petsc_ts_03_compat.output.3.15.5 | 820 ++++++++++++++++++ tests/petsc/petsc_ts_03_compat.output.pre3.20 | 628 ++++++++++++++ 4 files changed, 2300 insertions(+) create mode 100644 tests/petsc/petsc_ts_03_compat.cc create mode 100644 tests/petsc/petsc_ts_03_compat.output create mode 100644 tests/petsc/petsc_ts_03_compat.output.3.15.5 create mode 100644 tests/petsc/petsc_ts_03_compat.output.pre3.20 diff --git a/tests/petsc/petsc_ts_03_compat.cc b/tests/petsc/petsc_ts_03_compat.cc new file mode 100644 index 0000000000..0ce69a644b --- /dev/null +++ b/tests/petsc/petsc_ts_03_compat.cc @@ -0,0 +1,272 @@ +// ------------------------------------------------------------------------ +// +// SPDX-License-Identifier: LGPL-2.1-or-later +// Copyright (C) 2023 - 2024 by the deal.II authors +// +// This file is part of the deal.II library. +// +// Part of the source code is dual licensed under Apache-2.0 WITH +// LLVM-exception OR LGPL-2.1-or-later. Detailed license information +// governing the source code and code contributions can be found in +// LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II. +// +// ------------------------------------------------------------------------ + + +// This test is a version of petsc_ts_03 that checks that the old but +// deprecated callback names can still be used without error. The test +// can be removed when the deprecated callbacks are removed. + + +#include + +#include +#include +#include + +#include + +#include "../tests.h" + +/** + * Solves the equations of exponential decay: + * + * u' = -k u + * u (t0) = 1 + * + * using the PETScWrappers::TimeStepper class + * that interfaces PETSc TS ODE solver object. + * The ODE can be an EXPLICIT first order ode: + * + * y[0]' = - k y[0] -> y' = G(y,t) + * + * or specified in IMPLICIT form: + * + * y[0]' + k y[1] = 0 -> F(y',y,t) = 0 + * + * The exact solution is, in either case, + * + * y[0](t) = exp(-kt) + * + * We use the same class to test both formulations. + * The class also supports a third approach where + * control for linear systems generation and + * solution is completely on users. In this case + * users are in charge of solving for the + * implicit Jacobian. + * Here we also test the functionalities of the + * various user callbacks available. + * The model used to wrap PETSc's TS is the same + * used for the nonlinear solver SNES. Check + * petsc_snes_00.cc for additional information. + * + */ +using VectorType = PETScWrappers::MPI::Vector; +using MatrixType = PETScWrappers::MatrixBase; +using TimeStepper = PETScWrappers::TimeStepper; +using real_type = TimeStepper::real_type; + +class ExponentialDecay +{ +public: + ExponentialDecay(real_type _kappa, + const typename PETScWrappers::TimeStepperData &data, + bool setjac, + bool implicit, + bool user) + : time_stepper(data) + , kappa(_kappa) + { + // In this case we use the implicit form + if (implicit) + { + time_stepper.implicit_function = [&](const real_type t, + const VectorType &y, + const VectorType &y_dot, + VectorType &res) -> void { + deallog << "Evaluating implicit function at t=" << t << std::endl; + res(0) = y_dot(0) + kappa * y(0); + res.compress(VectorOperation::insert); + }; + + // We either have the possibility of using PETSc standard + // functionalities for Jacobian setup and solve, or take full control of + // the Jacobian solutions. The latter aligns more with deal.II tutorials + // For our testing class, 'user' discriminate between those two + // approaches. + if (!user && setjac) + { + // Callback for Jacobian evaluation + // This callback populates the P matrix with + // shift * dF/dydot + dF/dy + // A and P are the same matrix if not otherwise specified + // PETSc can compute a Jacobian by finite-differencing the residual + // evaluation, and it can be selected at command line. + time_stepper.implicit_jacobian = [&](const real_type t, + const VectorType &y, + const VectorType &y_dot, + const real_type shift, + MatrixType &A, + MatrixType &P) -> void { + deallog << "Evaluating implicit Jacobian at t=" << t << std::endl; + P.set(0, 0, shift + kappa); + P.compress(VectorOperation::insert); + }; + } + else if (user) + { + // In this code block, users are completely in charge of + // setting up the Jacobian system and solve for it. + // In this example we only store the solver shift + // during setup. + time_stepper.setup_jacobian = [&](const real_type t, + const VectorType &y, + const VectorType &y_dot, + const real_type shift) -> void { + deallog << "Setting up Jacobian at t=" << t << std::endl; + myshift = shift; + }; + + // In the solve phase we se the stored shift to solve + // for the implicit Jacobian system + time_stepper.solve_with_jacobian = [&](const VectorType &src, + VectorType &dst) -> void { + deallog << "Solving with Jacobian" << std::endl; + dst(0) = src(0) / (myshift + kappa); + dst.compress(VectorOperation::insert); + }; + } + } + else + { // Here we instead use the explicit form + // This is the only function one would populate in case an explicit + // solver is used. + time_stepper.explicit_function = + [&](const real_type t, const VectorType &y, VectorType &res) -> void { + deallog << "Evaluating explicit function at t=" << t << std::endl; + res(0) = -kappa * y(0); + res.compress(VectorOperation::insert); + }; + + // The explicit Jacobian callback is not needed in case + // an explicit solver is used. We need it when moving to + // an implicit solver like in the parameter file used for + // this test + if (setjac) + { + time_stepper.explicit_jacobian = [&](const real_type t, + const VectorType &y, + MatrixType &A, + MatrixType &P) -> void { + deallog << "Evaluating explicit Jacobian at t=" << t << std::endl; + P.set(0, 0, -kappa); + P.compress(VectorOperation::insert); + }; + } + } + + // Monitoring routine. Here we print diagnostic for the exact + // solution to the log file. + time_stepper.monitor = [&](const real_type t, + const VectorType &sol, + const unsigned int /*step_number*/) -> void { + deallog << "Intermediate output:" << std::endl; + deallog << " t =" << t << std::endl; + deallog << " y =" << sol[0] << " (exact: " << std::exp(-kappa * t) + << ')' << std::endl; + }; + + // This callback is invoked after a successful stage. + // Here we only print that the callback is invoked. + time_stepper.distribute = [&](const real_type t, VectorType &) -> void { + deallog << "Distribute at time " << t << std::endl; + }; + + // This callback is used to decide to remesh. + time_stepper.decide_for_coarsening_and_refinement = + [&](const real_type t, + const unsigned int step, + const VectorType &, + bool &resize) { + deallog << "Prepare at time " << t << " and step " << step << std::endl; + resize = (step && step % 5 == 0); + }; + + // This callback is called if decide_and_prepare_for_remeshing returns true. + time_stepper.interpolate = [&](const std::vector &all_in, + std::vector &all_out) -> void { + deallog << "Interpolate" << std::endl; + for (auto &v : all_in) + all_out.push_back(v); + }; + } + + void + run() + { + // Set initial conditions + // This test uses a nonzero initial time + // We can access the time value with the + // get_time method + auto t = time_stepper.get_time(); + + VectorType y(MPI_COMM_SELF, 1, 1); + y[0] = 1; + y.compress(VectorOperation::insert); + + // Integrate the ODE. + auto nt = time_stepper.solve(y); + deallog << "# Number of steps taken: " << nt << std::endl; + } + +private: + TimeStepper time_stepper; + real_type kappa; // Defines the decay + real_type myshift; // Used by the user solve +}; + + +int +main(int argc, char **argv) +{ + initlog(); + Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1); + + PETScWrappers::TimeStepperData data; + ParameterHandler prm; + + data.add_parameters(prm); + deallog << "# Default Parameters" << std::endl; + prm.print_parameters(deallog.get_file_stream(), ParameterHandler::ShortText); + + std::ifstream ifile(SOURCE_DIR "/petsc_ts_03_in.prm"); + prm.parse_input(ifile); + + deallog << "# Testing Parameters" << std::endl; + prm.print_parameters(deallog.get_file_stream(), ParameterHandler::ShortText); + + for (int setjaci = 0; setjaci < 2; setjaci++) + { + bool setjac = setjaci ? true : false; + + { + deallog << "# Test explicit interface (J " << setjac << ")" + << std::endl; + ExponentialDecay ode_expl(1.0, data, setjac, false, false); + ode_expl.run(); + } + + { + deallog << "# Test implicit interface (J " << setjac << ")" + << std::endl; + ExponentialDecay ode_impl(1.0, data, setjac, true, false); + ode_impl.run(); + } + } + + { + deallog << "# Test user interface" << std::endl; + ExponentialDecay ode_user(1.0, data, true, true, true); + ode_user.run(); + } +} diff --git a/tests/petsc/petsc_ts_03_compat.output b/tests/petsc/petsc_ts_03_compat.output new file mode 100644 index 0000000000..3d15012bcb --- /dev/null +++ b/tests/petsc/petsc_ts_03_compat.output @@ -0,0 +1,580 @@ + +DEAL::# Default Parameters +subsection Error control + set absolute error tolerance = -1 + set adaptor type = none + set ignore algebraic lte = true + set maximum step size = -1 + set minimum step size = -1 + set relative error tolerance = -1 +end +subsection Running parameters + set final time = 0 + set initial step size = 0 + set initial time = 0 + set match final time = false + set maximum number of steps = -1 + set options prefix = + set solver type = +end +DEAL::# Testing Parameters +subsection Error control + set absolute error tolerance = 0.0001 + set adaptor type = none + set ignore algebraic lte = true + set maximum step size = 1e+7 + set minimum step size = 1e-7 + set relative error tolerance = -1 +end +subsection Running parameters + set final time = 2.0 + set initial step size = 0.2 + set initial time = 0 + set match final time = false + set maximum number of steps = -1 + set options prefix = + set solver type = bdf +end +DEAL::# Test explicit interface (J 0) +DEAL::Intermediate output: +DEAL:: t =0.00000 +DEAL:: y =1.00000 (exact: 1.00000) +DEAL::Evaluating explicit function at t=0.100000 +DEAL::Evaluating explicit function at t=0.100000 +DEAL::Evaluating explicit function at t=0.100000 +DEAL::Evaluating explicit function at t=0.100000 +DEAL::Distribute at time 0.100000 +DEAL::Evaluating explicit function at t=0.200000 +DEAL::Evaluating explicit function at t=0.200000 +DEAL::Evaluating explicit function at t=0.200000 +DEAL::Evaluating explicit function at t=0.200000 +DEAL::Distribute at time 0.200000 +DEAL::Prepare at time 0.200000 and step 1 +DEAL::Intermediate output: +DEAL:: t =0.200000 +DEAL:: y =0.823864 (exact: 0.818731) +DEAL::Evaluating explicit function at t=0.400000 +DEAL::Evaluating explicit function at t=0.400000 +DEAL::Evaluating explicit function at t=0.400000 +DEAL::Evaluating explicit function at t=0.400000 +DEAL::Distribute at time 0.400000 +DEAL::Prepare at time 0.400000 and step 2 +DEAL::Intermediate output: +DEAL:: t =0.400000 +DEAL:: y =0.675134 (exact: 0.670320) +DEAL::Evaluating explicit function at t=0.600000 +DEAL::Evaluating explicit function at t=0.600000 +DEAL::Evaluating explicit function at t=0.600000 +DEAL::Evaluating explicit function at t=0.600000 +DEAL::Distribute at time 0.600000 +DEAL::Prepare at time 0.600000 and step 3 +DEAL::Intermediate output: +DEAL:: t =0.600000 +DEAL:: y =0.551962 (exact: 0.548812) +DEAL::Evaluating explicit function at t=0.800000 +DEAL::Evaluating explicit function at t=0.800000 +DEAL::Evaluating explicit function at t=0.800000 +DEAL::Evaluating explicit function at t=0.800000 +DEAL::Distribute at time 0.800000 +DEAL::Prepare at time 0.800000 and step 4 +DEAL::Intermediate output: +DEAL:: t =0.800000 +DEAL:: y =0.450798 (exact: 0.449329) +DEAL::Evaluating explicit function at t=1.00000 +DEAL::Evaluating explicit function at t=1.00000 +DEAL::Evaluating explicit function at t=1.00000 +DEAL::Evaluating explicit function at t=1.00000 +DEAL::Distribute at time 1.00000 +DEAL::Prepare at time 1.00000 and step 5 +DEAL::Interpolate +DEAL::Intermediate output: +DEAL:: t =1.00000 +DEAL:: y =0.368009 (exact: 0.367879) +DEAL::Evaluating explicit function at t=1.20000 +DEAL::Evaluating explicit function at t=1.20000 +DEAL::Evaluating explicit function at t=1.20000 +DEAL::Evaluating explicit function at t=1.20000 +DEAL::Distribute at time 1.20000 +DEAL::Prepare at time 1.20000 and step 6 +DEAL::Intermediate output: +DEAL:: t =1.20000 +DEAL:: y =0.300364 (exact: 0.301194) +DEAL::Evaluating explicit function at t=1.40000 +DEAL::Evaluating explicit function at t=1.40000 +DEAL::Evaluating explicit function at t=1.40000 +DEAL::Evaluating explicit function at t=1.40000 +DEAL::Distribute at time 1.40000 +DEAL::Prepare at time 1.40000 and step 7 +DEAL::Intermediate output: +DEAL:: t =1.40000 +DEAL:: y =0.245132 (exact: 0.246597) +DEAL::Evaluating explicit function at t=1.60000 +DEAL::Evaluating explicit function at t=1.60000 +DEAL::Evaluating explicit function at t=1.60000 +DEAL::Evaluating explicit function at t=1.60000 +DEAL::Distribute at time 1.60000 +DEAL::Prepare at time 1.60000 and step 8 +DEAL::Intermediate output: +DEAL:: t =1.60000 +DEAL:: y =0.200048 (exact: 0.201897) +DEAL::Evaluating explicit function at t=1.80000 +DEAL::Evaluating explicit function at t=1.80000 +DEAL::Evaluating explicit function at t=1.80000 +DEAL::Evaluating explicit function at t=1.80000 +DEAL::Distribute at time 1.80000 +DEAL::Prepare at time 1.80000 and step 9 +DEAL::Intermediate output: +DEAL:: t =1.80000 +DEAL:: y =0.163253 (exact: 0.165299) +DEAL::Evaluating explicit function at t=2.00000 +DEAL::Evaluating explicit function at t=2.00000 +DEAL::Evaluating explicit function at t=2.00000 +DEAL::Evaluating explicit function at t=2.00000 +DEAL::Distribute at time 2.00000 +DEAL::Prepare at time 2.00000 and step 10 +DEAL::Interpolate +DEAL::Intermediate output: +DEAL:: t =2.00000 +DEAL:: y =0.133225 (exact: 0.135335) +DEAL::Evaluating explicit function at t=2.20000 +DEAL::Evaluating explicit function at t=2.20000 +DEAL::Evaluating explicit function at t=2.20000 +DEAL::Evaluating explicit function at t=2.20000 +DEAL::Distribute at time 2.20000 +DEAL::Prepare at time 2.20000 and step 11 +DEAL::Intermediate output: +DEAL:: t =2.20000 +DEAL:: y =0.108719 (exact: 0.110803) +DEAL::# Number of steps taken: 11 +DEAL::# Test implicit interface (J 0) +DEAL::Intermediate output: +DEAL:: t =0.00000 +DEAL:: y =1.00000 (exact: 1.00000) +DEAL::Evaluating implicit function at t=0.100000 +DEAL::Evaluating implicit function at t=0.100000 +DEAL::Evaluating implicit function at t=0.100000 +DEAL::Evaluating implicit function at t=0.100000 +DEAL::Distribute at time 0.100000 +DEAL::Evaluating implicit function at t=0.200000 +DEAL::Evaluating implicit function at t=0.200000 +DEAL::Evaluating implicit function at t=0.200000 +DEAL::Evaluating implicit function at t=0.200000 +DEAL::Distribute at time 0.200000 +DEAL::Prepare at time 0.200000 and step 1 +DEAL::Intermediate output: +DEAL:: t =0.200000 +DEAL:: y =0.823864 (exact: 0.818731) +DEAL::Evaluating implicit function at t=0.400000 +DEAL::Evaluating implicit function at t=0.400000 +DEAL::Evaluating implicit function at t=0.400000 +DEAL::Evaluating implicit function at t=0.400000 +DEAL::Distribute at time 0.400000 +DEAL::Prepare at time 0.400000 and step 2 +DEAL::Intermediate output: +DEAL:: t =0.400000 +DEAL:: y =0.675134 (exact: 0.670320) +DEAL::Evaluating implicit function at t=0.600000 +DEAL::Evaluating implicit function at t=0.600000 +DEAL::Evaluating implicit function at t=0.600000 +DEAL::Evaluating implicit function at t=0.600000 +DEAL::Distribute at time 0.600000 +DEAL::Prepare at time 0.600000 and step 3 +DEAL::Intermediate output: +DEAL:: t =0.600000 +DEAL:: y =0.551962 (exact: 0.548812) +DEAL::Evaluating implicit function at t=0.800000 +DEAL::Evaluating implicit function at t=0.800000 +DEAL::Evaluating implicit function at t=0.800000 +DEAL::Evaluating implicit function at t=0.800000 +DEAL::Distribute at time 0.800000 +DEAL::Prepare at time 0.800000 and step 4 +DEAL::Intermediate output: +DEAL:: t =0.800000 +DEAL:: y =0.450798 (exact: 0.449329) +DEAL::Evaluating implicit function at t=1.00000 +DEAL::Evaluating implicit function at t=1.00000 +DEAL::Evaluating implicit function at t=1.00000 +DEAL::Evaluating implicit function at t=1.00000 +DEAL::Distribute at time 1.00000 +DEAL::Prepare at time 1.00000 and step 5 +DEAL::Interpolate +DEAL::Intermediate output: +DEAL:: t =1.00000 +DEAL:: y =0.368009 (exact: 0.367879) +DEAL::Evaluating implicit function at t=1.20000 +DEAL::Evaluating implicit function at t=1.20000 +DEAL::Evaluating implicit function at t=1.20000 +DEAL::Evaluating implicit function at t=1.20000 +DEAL::Distribute at time 1.20000 +DEAL::Prepare at time 1.20000 and step 6 +DEAL::Intermediate output: +DEAL:: t =1.20000 +DEAL:: y =0.300364 (exact: 0.301194) +DEAL::Evaluating implicit function at t=1.40000 +DEAL::Evaluating implicit function at t=1.40000 +DEAL::Evaluating implicit function at t=1.40000 +DEAL::Evaluating implicit function at t=1.40000 +DEAL::Distribute at time 1.40000 +DEAL::Prepare at time 1.40000 and step 7 +DEAL::Intermediate output: +DEAL:: t =1.40000 +DEAL:: y =0.245132 (exact: 0.246597) +DEAL::Evaluating implicit function at t=1.60000 +DEAL::Evaluating implicit function at t=1.60000 +DEAL::Evaluating implicit function at t=1.60000 +DEAL::Evaluating implicit function at t=1.60000 +DEAL::Distribute at time 1.60000 +DEAL::Prepare at time 1.60000 and step 8 +DEAL::Intermediate output: +DEAL:: t =1.60000 +DEAL:: y =0.200048 (exact: 0.201897) +DEAL::Evaluating implicit function at t=1.80000 +DEAL::Evaluating implicit function at t=1.80000 +DEAL::Evaluating implicit function at t=1.80000 +DEAL::Evaluating implicit function at t=1.80000 +DEAL::Distribute at time 1.80000 +DEAL::Prepare at time 1.80000 and step 9 +DEAL::Intermediate output: +DEAL:: t =1.80000 +DEAL:: y =0.163253 (exact: 0.165299) +DEAL::Evaluating implicit function at t=2.00000 +DEAL::Evaluating implicit function at t=2.00000 +DEAL::Evaluating implicit function at t=2.00000 +DEAL::Evaluating implicit function at t=2.00000 +DEAL::Distribute at time 2.00000 +DEAL::Prepare at time 2.00000 and step 10 +DEAL::Interpolate +DEAL::Intermediate output: +DEAL:: t =2.00000 +DEAL:: y =0.133225 (exact: 0.135335) +DEAL::Evaluating implicit function at t=2.20000 +DEAL::Evaluating implicit function at t=2.20000 +DEAL::Evaluating implicit function at t=2.20000 +DEAL::Evaluating implicit function at t=2.20000 +DEAL::Distribute at time 2.20000 +DEAL::Prepare at time 2.20000 and step 11 +DEAL::Intermediate output: +DEAL:: t =2.20000 +DEAL:: y =0.108719 (exact: 0.110803) +DEAL::# Number of steps taken: 11 +DEAL::# Test explicit interface (J 1) +DEAL::Intermediate output: +DEAL:: t =0.00000 +DEAL:: y =1.00000 (exact: 1.00000) +DEAL::Evaluating explicit function at t=0.100000 +DEAL::Evaluating explicit Jacobian at t=0.100000 +DEAL::Evaluating explicit function at t=0.100000 +DEAL::Distribute at time 0.100000 +DEAL::Evaluating explicit function at t=0.200000 +DEAL::Evaluating explicit Jacobian at t=0.200000 +DEAL::Evaluating explicit function at t=0.200000 +DEAL::Distribute at time 0.200000 +DEAL::Prepare at time 0.200000 and step 1 +DEAL::Intermediate output: +DEAL:: t =0.200000 +DEAL:: y =0.823864 (exact: 0.818731) +DEAL::Evaluating explicit function at t=0.400000 +DEAL::Evaluating explicit Jacobian at t=0.400000 +DEAL::Evaluating explicit function at t=0.400000 +DEAL::Distribute at time 0.400000 +DEAL::Prepare at time 0.400000 and step 2 +DEAL::Intermediate output: +DEAL:: t =0.400000 +DEAL:: y =0.675134 (exact: 0.670320) +DEAL::Evaluating explicit function at t=0.600000 +DEAL::Evaluating explicit Jacobian at t=0.600000 +DEAL::Evaluating explicit function at t=0.600000 +DEAL::Distribute at time 0.600000 +DEAL::Prepare at time 0.600000 and step 3 +DEAL::Intermediate output: +DEAL:: t =0.600000 +DEAL:: y =0.551962 (exact: 0.548812) +DEAL::Evaluating explicit function at t=0.800000 +DEAL::Evaluating explicit Jacobian at t=0.800000 +DEAL::Evaluating explicit function at t=0.800000 +DEAL::Distribute at time 0.800000 +DEAL::Prepare at time 0.800000 and step 4 +DEAL::Intermediate output: +DEAL:: t =0.800000 +DEAL:: y =0.450798 (exact: 0.449329) +DEAL::Evaluating explicit function at t=1.00000 +DEAL::Evaluating explicit Jacobian at t=1.00000 +DEAL::Evaluating explicit function at t=1.00000 +DEAL::Distribute at time 1.00000 +DEAL::Prepare at time 1.00000 and step 5 +DEAL::Interpolate +DEAL::Intermediate output: +DEAL:: t =1.00000 +DEAL:: y =0.368009 (exact: 0.367879) +DEAL::Evaluating explicit function at t=1.20000 +DEAL::Evaluating explicit Jacobian at t=1.20000 +DEAL::Evaluating explicit function at t=1.20000 +DEAL::Distribute at time 1.20000 +DEAL::Prepare at time 1.20000 and step 6 +DEAL::Intermediate output: +DEAL:: t =1.20000 +DEAL:: y =0.300364 (exact: 0.301194) +DEAL::Evaluating explicit function at t=1.40000 +DEAL::Evaluating explicit Jacobian at t=1.40000 +DEAL::Evaluating explicit function at t=1.40000 +DEAL::Distribute at time 1.40000 +DEAL::Prepare at time 1.40000 and step 7 +DEAL::Intermediate output: +DEAL:: t =1.40000 +DEAL:: y =0.245132 (exact: 0.246597) +DEAL::Evaluating explicit function at t=1.60000 +DEAL::Evaluating explicit Jacobian at t=1.60000 +DEAL::Evaluating explicit function at t=1.60000 +DEAL::Distribute at time 1.60000 +DEAL::Prepare at time 1.60000 and step 8 +DEAL::Intermediate output: +DEAL:: t =1.60000 +DEAL:: y =0.200048 (exact: 0.201897) +DEAL::Evaluating explicit function at t=1.80000 +DEAL::Evaluating explicit Jacobian at t=1.80000 +DEAL::Evaluating explicit function at t=1.80000 +DEAL::Distribute at time 1.80000 +DEAL::Prepare at time 1.80000 and step 9 +DEAL::Intermediate output: +DEAL:: t =1.80000 +DEAL:: y =0.163253 (exact: 0.165299) +DEAL::Evaluating explicit function at t=2.00000 +DEAL::Evaluating explicit Jacobian at t=2.00000 +DEAL::Evaluating explicit function at t=2.00000 +DEAL::Distribute at time 2.00000 +DEAL::Prepare at time 2.00000 and step 10 +DEAL::Interpolate +DEAL::Intermediate output: +DEAL:: t =2.00000 +DEAL:: y =0.133225 (exact: 0.135335) +DEAL::Evaluating explicit function at t=2.20000 +DEAL::Evaluating explicit Jacobian at t=2.20000 +DEAL::Evaluating explicit function at t=2.20000 +DEAL::Distribute at time 2.20000 +DEAL::Prepare at time 2.20000 and step 11 +DEAL::Intermediate output: +DEAL:: t =2.20000 +DEAL:: y =0.108719 (exact: 0.110803) +DEAL::# Number of steps taken: 11 +DEAL::# Test implicit interface (J 1) +DEAL::Intermediate output: +DEAL:: t =0.00000 +DEAL:: y =1.00000 (exact: 1.00000) +DEAL::Evaluating implicit function at t=0.100000 +DEAL::Evaluating implicit Jacobian at t=0.100000 +DEAL::Evaluating implicit function at t=0.100000 +DEAL::Distribute at time 0.100000 +DEAL::Evaluating implicit function at t=0.200000 +DEAL::Evaluating implicit Jacobian at t=0.200000 +DEAL::Evaluating implicit function at t=0.200000 +DEAL::Distribute at time 0.200000 +DEAL::Prepare at time 0.200000 and step 1 +DEAL::Intermediate output: +DEAL:: t =0.200000 +DEAL:: y =0.823864 (exact: 0.818731) +DEAL::Evaluating implicit function at t=0.400000 +DEAL::Evaluating implicit Jacobian at t=0.400000 +DEAL::Evaluating implicit function at t=0.400000 +DEAL::Distribute at time 0.400000 +DEAL::Prepare at time 0.400000 and step 2 +DEAL::Intermediate output: +DEAL:: t =0.400000 +DEAL:: y =0.675134 (exact: 0.670320) +DEAL::Evaluating implicit function at t=0.600000 +DEAL::Evaluating implicit Jacobian at t=0.600000 +DEAL::Evaluating implicit function at t=0.600000 +DEAL::Distribute at time 0.600000 +DEAL::Prepare at time 0.600000 and step 3 +DEAL::Intermediate output: +DEAL:: t =0.600000 +DEAL:: y =0.551962 (exact: 0.548812) +DEAL::Evaluating implicit function at t=0.800000 +DEAL::Evaluating implicit Jacobian at t=0.800000 +DEAL::Evaluating implicit function at t=0.800000 +DEAL::Distribute at time 0.800000 +DEAL::Prepare at time 0.800000 and step 4 +DEAL::Intermediate output: +DEAL:: t =0.800000 +DEAL:: y =0.450798 (exact: 0.449329) +DEAL::Evaluating implicit function at t=1.00000 +DEAL::Evaluating implicit Jacobian at t=1.00000 +DEAL::Evaluating implicit function at t=1.00000 +DEAL::Distribute at time 1.00000 +DEAL::Prepare at time 1.00000 and step 5 +DEAL::Interpolate +DEAL::Intermediate output: +DEAL:: t =1.00000 +DEAL:: y =0.368009 (exact: 0.367879) +DEAL::Evaluating implicit function at t=1.20000 +DEAL::Evaluating implicit Jacobian at t=1.20000 +DEAL::Evaluating implicit function at t=1.20000 +DEAL::Distribute at time 1.20000 +DEAL::Prepare at time 1.20000 and step 6 +DEAL::Intermediate output: +DEAL:: t =1.20000 +DEAL:: y =0.300364 (exact: 0.301194) +DEAL::Evaluating implicit function at t=1.40000 +DEAL::Evaluating implicit Jacobian at t=1.40000 +DEAL::Evaluating implicit function at t=1.40000 +DEAL::Distribute at time 1.40000 +DEAL::Prepare at time 1.40000 and step 7 +DEAL::Intermediate output: +DEAL:: t =1.40000 +DEAL:: y =0.245132 (exact: 0.246597) +DEAL::Evaluating implicit function at t=1.60000 +DEAL::Evaluating implicit Jacobian at t=1.60000 +DEAL::Evaluating implicit function at t=1.60000 +DEAL::Distribute at time 1.60000 +DEAL::Prepare at time 1.60000 and step 8 +DEAL::Intermediate output: +DEAL:: t =1.60000 +DEAL:: y =0.200048 (exact: 0.201897) +DEAL::Evaluating implicit function at t=1.80000 +DEAL::Evaluating implicit Jacobian at t=1.80000 +DEAL::Evaluating implicit function at t=1.80000 +DEAL::Distribute at time 1.80000 +DEAL::Prepare at time 1.80000 and step 9 +DEAL::Intermediate output: +DEAL:: t =1.80000 +DEAL:: y =0.163253 (exact: 0.165299) +DEAL::Evaluating implicit function at t=2.00000 +DEAL::Evaluating implicit Jacobian at t=2.00000 +DEAL::Evaluating implicit function at t=2.00000 +DEAL::Distribute at time 2.00000 +DEAL::Prepare at time 2.00000 and step 10 +DEAL::Interpolate +DEAL::Intermediate output: +DEAL:: t =2.00000 +DEAL:: y =0.133225 (exact: 0.135335) +DEAL::Evaluating implicit function at t=2.20000 +DEAL::Evaluating implicit Jacobian at t=2.20000 +DEAL::Evaluating implicit function at t=2.20000 +DEAL::Distribute at time 2.20000 +DEAL::Prepare at time 2.20000 and step 11 +DEAL::Intermediate output: +DEAL:: t =2.20000 +DEAL:: y =0.108719 (exact: 0.110803) +DEAL::# Number of steps taken: 11 +DEAL::# Test user interface +DEAL::Intermediate output: +DEAL:: t =0.00000 +DEAL:: y =1.00000 (exact: 1.00000) +DEAL::Evaluating implicit function at t=0.100000 +DEAL::Setting up Jacobian at t=0.100000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=0.100000 +DEAL::Evaluating implicit function at t=0.100000 +DEAL::Distribute at time 0.100000 +DEAL::Evaluating implicit function at t=0.200000 +DEAL::Setting up Jacobian at t=0.200000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=0.200000 +DEAL::Evaluating implicit function at t=0.200000 +DEAL::Distribute at time 0.200000 +DEAL::Prepare at time 0.200000 and step 1 +DEAL::Intermediate output: +DEAL:: t =0.200000 +DEAL:: y =0.823864 (exact: 0.818731) +DEAL::Evaluating implicit function at t=0.400000 +DEAL::Setting up Jacobian at t=0.400000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=0.400000 +DEAL::Evaluating implicit function at t=0.400000 +DEAL::Distribute at time 0.400000 +DEAL::Prepare at time 0.400000 and step 2 +DEAL::Intermediate output: +DEAL:: t =0.400000 +DEAL:: y =0.675134 (exact: 0.670320) +DEAL::Evaluating implicit function at t=0.600000 +DEAL::Setting up Jacobian at t=0.600000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=0.600000 +DEAL::Evaluating implicit function at t=0.600000 +DEAL::Distribute at time 0.600000 +DEAL::Prepare at time 0.600000 and step 3 +DEAL::Intermediate output: +DEAL:: t =0.600000 +DEAL:: y =0.551962 (exact: 0.548812) +DEAL::Evaluating implicit function at t=0.800000 +DEAL::Setting up Jacobian at t=0.800000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=0.800000 +DEAL::Evaluating implicit function at t=0.800000 +DEAL::Distribute at time 0.800000 +DEAL::Prepare at time 0.800000 and step 4 +DEAL::Intermediate output: +DEAL:: t =0.800000 +DEAL:: y =0.450798 (exact: 0.449329) +DEAL::Evaluating implicit function at t=1.00000 +DEAL::Setting up Jacobian at t=1.00000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=1.00000 +DEAL::Evaluating implicit function at t=1.00000 +DEAL::Distribute at time 1.00000 +DEAL::Prepare at time 1.00000 and step 5 +DEAL::Interpolate +DEAL::Intermediate output: +DEAL:: t =1.00000 +DEAL:: y =0.368009 (exact: 0.367879) +DEAL::Evaluating implicit function at t=1.20000 +DEAL::Setting up Jacobian at t=1.20000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=1.20000 +DEAL::Evaluating implicit function at t=1.20000 +DEAL::Distribute at time 1.20000 +DEAL::Prepare at time 1.20000 and step 6 +DEAL::Intermediate output: +DEAL:: t =1.20000 +DEAL:: y =0.300364 (exact: 0.301194) +DEAL::Evaluating implicit function at t=1.40000 +DEAL::Setting up Jacobian at t=1.40000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=1.40000 +DEAL::Evaluating implicit function at t=1.40000 +DEAL::Distribute at time 1.40000 +DEAL::Prepare at time 1.40000 and step 7 +DEAL::Intermediate output: +DEAL:: t =1.40000 +DEAL:: y =0.245132 (exact: 0.246597) +DEAL::Evaluating implicit function at t=1.60000 +DEAL::Setting up Jacobian at t=1.60000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=1.60000 +DEAL::Evaluating implicit function at t=1.60000 +DEAL::Distribute at time 1.60000 +DEAL::Prepare at time 1.60000 and step 8 +DEAL::Intermediate output: +DEAL:: t =1.60000 +DEAL:: y =0.200048 (exact: 0.201897) +DEAL::Evaluating implicit function at t=1.80000 +DEAL::Setting up Jacobian at t=1.80000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=1.80000 +DEAL::Evaluating implicit function at t=1.80000 +DEAL::Distribute at time 1.80000 +DEAL::Prepare at time 1.80000 and step 9 +DEAL::Intermediate output: +DEAL:: t =1.80000 +DEAL:: y =0.163253 (exact: 0.165299) +DEAL::Evaluating implicit function at t=2.00000 +DEAL::Setting up Jacobian at t=2.00000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=2.00000 +DEAL::Evaluating implicit function at t=2.00000 +DEAL::Distribute at time 2.00000 +DEAL::Prepare at time 2.00000 and step 10 +DEAL::Interpolate +DEAL::Intermediate output: +DEAL:: t =2.00000 +DEAL:: y =0.133225 (exact: 0.135335) +DEAL::Evaluating implicit function at t=2.20000 +DEAL::Setting up Jacobian at t=2.20000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=2.20000 +DEAL::Evaluating implicit function at t=2.20000 +DEAL::Distribute at time 2.20000 +DEAL::Prepare at time 2.20000 and step 11 +DEAL::Intermediate output: +DEAL:: t =2.20000 +DEAL:: y =0.108719 (exact: 0.110803) +DEAL::# Number of steps taken: 11 diff --git a/tests/petsc/petsc_ts_03_compat.output.3.15.5 b/tests/petsc/petsc_ts_03_compat.output.3.15.5 new file mode 100644 index 0000000000..9e9e69494c --- /dev/null +++ b/tests/petsc/petsc_ts_03_compat.output.3.15.5 @@ -0,0 +1,820 @@ + +DEAL::# Default Parameters +subsection Error control + set absolute error tolerance = -1 + set adaptor type = none + set ignore algebraic lte = true + set maximum step size = -1 + set minimum step size = -1 + set relative error tolerance = -1 +end +subsection Running parameters + set final time = 0 + set initial step size = 0 + set initial time = 0 + set match final time = false + set maximum number of steps = -1 + set options prefix = + set solver type = +end +DEAL::# Testing Parameters +subsection Error control + set absolute error tolerance = 0.0001 + set adaptor type = none + set ignore algebraic lte = true + set maximum step size = 1e+7 + set minimum step size = 1e-7 + set relative error tolerance = -1 +end +subsection Running parameters + set final time = 2.0 + set initial step size = 0.2 + set initial time = 0 + set match final time = false + set maximum number of steps = -1 + set options prefix = + set solver type = bdf +end +DEAL::# Test explicit interface (J 0) +DEAL::Intermediate output: +DEAL:: t =0.00000 +DEAL:: y =1.00000 (exact: 1.00000) +DEAL::Evaluating explicit function at t=0.100000 +DEAL::Evaluating explicit function at t=0.100000 +DEAL::Evaluating explicit function at t=0.100000 +DEAL::Evaluating explicit function at t=0.100000 +DEAL::Distribute at time 0.100000 +DEAL::Evaluating explicit function at t=0.200000 +DEAL::Evaluating explicit function at t=0.200000 +DEAL::Evaluating explicit function at t=0.200000 +DEAL::Evaluating explicit function at t=0.200000 +DEAL::Distribute at time 0.200000 +DEAL::Prepare at time 0.200000 and step 1 +DEAL::Intermediate output: +DEAL:: t =0.200000 +DEAL:: y =0.823864 (exact: 0.818731) +DEAL::Evaluating explicit function at t=0.300000 +DEAL::Evaluating explicit function at t=0.300000 +DEAL::Evaluating explicit function at t=0.300000 +DEAL::Evaluating explicit function at t=0.300000 +DEAL::Distribute at time 0.300000 +DEAL::Evaluating explicit function at t=0.400000 +DEAL::Evaluating explicit function at t=0.400000 +DEAL::Evaluating explicit function at t=0.400000 +DEAL::Evaluating explicit function at t=0.400000 +DEAL::Distribute at time 0.400000 +DEAL::Prepare at time 0.400000 and step 2 +DEAL::Intermediate output: +DEAL:: t =0.400000 +DEAL:: y =0.678751 (exact: 0.670320) +DEAL::Evaluating explicit function at t=0.500000 +DEAL::Evaluating explicit function at t=0.500000 +DEAL::Evaluating explicit function at t=0.500000 +DEAL::Evaluating explicit function at t=0.500000 +DEAL::Distribute at time 0.500000 +DEAL::Evaluating explicit function at t=0.600000 +DEAL::Evaluating explicit function at t=0.600000 +DEAL::Evaluating explicit function at t=0.600000 +DEAL::Evaluating explicit function at t=0.600000 +DEAL::Distribute at time 0.600000 +DEAL::Prepare at time 0.600000 and step 3 +DEAL::Intermediate output: +DEAL:: t =0.600000 +DEAL:: y =0.559199 (exact: 0.548812) +DEAL::Evaluating explicit function at t=0.700000 +DEAL::Evaluating explicit function at t=0.700000 +DEAL::Evaluating explicit function at t=0.700000 +DEAL::Evaluating explicit function at t=0.700000 +DEAL::Distribute at time 0.700000 +DEAL::Evaluating explicit function at t=0.800000 +DEAL::Evaluating explicit function at t=0.800000 +DEAL::Evaluating explicit function at t=0.800000 +DEAL::Evaluating explicit function at t=0.800000 +DEAL::Distribute at time 0.800000 +DEAL::Prepare at time 0.800000 and step 4 +DEAL::Intermediate output: +DEAL:: t =0.800000 +DEAL:: y =0.460703 (exact: 0.449329) +DEAL::Evaluating explicit function at t=0.900000 +DEAL::Evaluating explicit function at t=0.900000 +DEAL::Evaluating explicit function at t=0.900000 +DEAL::Evaluating explicit function at t=0.900000 +DEAL::Distribute at time 0.900000 +DEAL::Evaluating explicit function at t=1.00000 +DEAL::Evaluating explicit function at t=1.00000 +DEAL::Evaluating explicit function at t=1.00000 +DEAL::Evaluating explicit function at t=1.00000 +DEAL::Distribute at time 1.00000 +DEAL::Prepare at time 1.00000 and step 5 +DEAL::Interpolate +DEAL::Intermediate output: +DEAL:: t =1.00000 +DEAL:: y =0.379557 (exact: 0.367879) +DEAL::Evaluating explicit function at t=1.10000 +DEAL::Evaluating explicit function at t=1.10000 +DEAL::Evaluating explicit function at t=1.10000 +DEAL::Evaluating explicit function at t=1.10000 +DEAL::Distribute at time 1.10000 +DEAL::Evaluating explicit function at t=1.20000 +DEAL::Evaluating explicit function at t=1.20000 +DEAL::Evaluating explicit function at t=1.20000 +DEAL::Evaluating explicit function at t=1.20000 +DEAL::Distribute at time 1.20000 +DEAL::Prepare at time 1.20000 and step 6 +DEAL::Intermediate output: +DEAL:: t =1.20000 +DEAL:: y =0.312703 (exact: 0.301194) +DEAL::Evaluating explicit function at t=1.30000 +DEAL::Evaluating explicit function at t=1.30000 +DEAL::Evaluating explicit function at t=1.30000 +DEAL::Evaluating explicit function at t=1.30000 +DEAL::Distribute at time 1.30000 +DEAL::Evaluating explicit function at t=1.40000 +DEAL::Evaluating explicit function at t=1.40000 +DEAL::Evaluating explicit function at t=1.40000 +DEAL::Evaluating explicit function at t=1.40000 +DEAL::Distribute at time 1.40000 +DEAL::Prepare at time 1.40000 and step 7 +DEAL::Intermediate output: +DEAL:: t =1.40000 +DEAL:: y =0.257625 (exact: 0.246597) +DEAL::Evaluating explicit function at t=1.50000 +DEAL::Evaluating explicit function at t=1.50000 +DEAL::Evaluating explicit function at t=1.50000 +DEAL::Evaluating explicit function at t=1.50000 +DEAL::Distribute at time 1.50000 +DEAL::Evaluating explicit function at t=1.60000 +DEAL::Evaluating explicit function at t=1.60000 +DEAL::Evaluating explicit function at t=1.60000 +DEAL::Evaluating explicit function at t=1.60000 +DEAL::Distribute at time 1.60000 +DEAL::Prepare at time 1.60000 and step 8 +DEAL::Intermediate output: +DEAL:: t =1.60000 +DEAL:: y =0.212248 (exact: 0.201897) +DEAL::Evaluating explicit function at t=1.70000 +DEAL::Evaluating explicit function at t=1.70000 +DEAL::Evaluating explicit function at t=1.70000 +DEAL::Evaluating explicit function at t=1.70000 +DEAL::Distribute at time 1.70000 +DEAL::Evaluating explicit function at t=1.80000 +DEAL::Evaluating explicit function at t=1.80000 +DEAL::Evaluating explicit function at t=1.80000 +DEAL::Evaluating explicit function at t=1.80000 +DEAL::Distribute at time 1.80000 +DEAL::Prepare at time 1.80000 and step 9 +DEAL::Intermediate output: +DEAL:: t =1.80000 +DEAL:: y =0.174863 (exact: 0.165299) +DEAL::Evaluating explicit function at t=1.90000 +DEAL::Evaluating explicit function at t=1.90000 +DEAL::Evaluating explicit function at t=1.90000 +DEAL::Evaluating explicit function at t=1.90000 +DEAL::Distribute at time 1.90000 +DEAL::Evaluating explicit function at t=2.00000 +DEAL::Evaluating explicit function at t=2.00000 +DEAL::Evaluating explicit function at t=2.00000 +DEAL::Evaluating explicit function at t=2.00000 +DEAL::Distribute at time 2.00000 +DEAL::Prepare at time 2.00000 and step 10 +DEAL::Interpolate +DEAL::Intermediate output: +DEAL:: t =2.00000 +DEAL:: y =0.144063 (exact: 0.135335) +DEAL::Evaluating explicit function at t=2.10000 +DEAL::Evaluating explicit function at t=2.10000 +DEAL::Evaluating explicit function at t=2.10000 +DEAL::Evaluating explicit function at t=2.10000 +DEAL::Distribute at time 2.10000 +DEAL::Evaluating explicit function at t=2.20000 +DEAL::Evaluating explicit function at t=2.20000 +DEAL::Evaluating explicit function at t=2.20000 +DEAL::Evaluating explicit function at t=2.20000 +DEAL::Distribute at time 2.20000 +DEAL::Prepare at time 2.20000 and step 11 +DEAL::Intermediate output: +DEAL:: t =2.20000 +DEAL:: y =0.118689 (exact: 0.110803) +DEAL::# Number of steps taken: 11 +DEAL::# Test implicit interface (J 0) +DEAL::Intermediate output: +DEAL:: t =0.00000 +DEAL:: y =1.00000 (exact: 1.00000) +DEAL::Evaluating implicit function at t=0.100000 +DEAL::Evaluating implicit function at t=0.100000 +DEAL::Evaluating implicit function at t=0.100000 +DEAL::Evaluating implicit function at t=0.100000 +DEAL::Distribute at time 0.100000 +DEAL::Evaluating implicit function at t=0.200000 +DEAL::Evaluating implicit function at t=0.200000 +DEAL::Evaluating implicit function at t=0.200000 +DEAL::Evaluating implicit function at t=0.200000 +DEAL::Distribute at time 0.200000 +DEAL::Prepare at time 0.200000 and step 1 +DEAL::Intermediate output: +DEAL:: t =0.200000 +DEAL:: y =0.823864 (exact: 0.818731) +DEAL::Evaluating implicit function at t=0.300000 +DEAL::Evaluating implicit function at t=0.300000 +DEAL::Evaluating implicit function at t=0.300000 +DEAL::Evaluating implicit function at t=0.300000 +DEAL::Distribute at time 0.300000 +DEAL::Evaluating implicit function at t=0.400000 +DEAL::Evaluating implicit function at t=0.400000 +DEAL::Evaluating implicit function at t=0.400000 +DEAL::Evaluating implicit function at t=0.400000 +DEAL::Distribute at time 0.400000 +DEAL::Prepare at time 0.400000 and step 2 +DEAL::Intermediate output: +DEAL:: t =0.400000 +DEAL:: y =0.678751 (exact: 0.670320) +DEAL::Evaluating implicit function at t=0.500000 +DEAL::Evaluating implicit function at t=0.500000 +DEAL::Evaluating implicit function at t=0.500000 +DEAL::Evaluating implicit function at t=0.500000 +DEAL::Distribute at time 0.500000 +DEAL::Evaluating implicit function at t=0.600000 +DEAL::Evaluating implicit function at t=0.600000 +DEAL::Evaluating implicit function at t=0.600000 +DEAL::Evaluating implicit function at t=0.600000 +DEAL::Distribute at time 0.600000 +DEAL::Prepare at time 0.600000 and step 3 +DEAL::Intermediate output: +DEAL:: t =0.600000 +DEAL:: y =0.559199 (exact: 0.548812) +DEAL::Evaluating implicit function at t=0.700000 +DEAL::Evaluating implicit function at t=0.700000 +DEAL::Evaluating implicit function at t=0.700000 +DEAL::Evaluating implicit function at t=0.700000 +DEAL::Distribute at time 0.700000 +DEAL::Evaluating implicit function at t=0.800000 +DEAL::Evaluating implicit function at t=0.800000 +DEAL::Evaluating implicit function at t=0.800000 +DEAL::Evaluating implicit function at t=0.800000 +DEAL::Distribute at time 0.800000 +DEAL::Prepare at time 0.800000 and step 4 +DEAL::Intermediate output: +DEAL:: t =0.800000 +DEAL:: y =0.460703 (exact: 0.449329) +DEAL::Evaluating implicit function at t=0.900000 +DEAL::Evaluating implicit function at t=0.900000 +DEAL::Evaluating implicit function at t=0.900000 +DEAL::Evaluating implicit function at t=0.900000 +DEAL::Distribute at time 0.900000 +DEAL::Evaluating implicit function at t=1.00000 +DEAL::Evaluating implicit function at t=1.00000 +DEAL::Evaluating implicit function at t=1.00000 +DEAL::Evaluating implicit function at t=1.00000 +DEAL::Distribute at time 1.00000 +DEAL::Prepare at time 1.00000 and step 5 +DEAL::Interpolate +DEAL::Intermediate output: +DEAL:: t =1.00000 +DEAL:: y =0.379557 (exact: 0.367879) +DEAL::Evaluating implicit function at t=1.10000 +DEAL::Evaluating implicit function at t=1.10000 +DEAL::Evaluating implicit function at t=1.10000 +DEAL::Evaluating implicit function at t=1.10000 +DEAL::Distribute at time 1.10000 +DEAL::Evaluating implicit function at t=1.20000 +DEAL::Evaluating implicit function at t=1.20000 +DEAL::Evaluating implicit function at t=1.20000 +DEAL::Evaluating implicit function at t=1.20000 +DEAL::Distribute at time 1.20000 +DEAL::Prepare at time 1.20000 and step 6 +DEAL::Intermediate output: +DEAL:: t =1.20000 +DEAL:: y =0.312703 (exact: 0.301194) +DEAL::Evaluating implicit function at t=1.30000 +DEAL::Evaluating implicit function at t=1.30000 +DEAL::Evaluating implicit function at t=1.30000 +DEAL::Evaluating implicit function at t=1.30000 +DEAL::Distribute at time 1.30000 +DEAL::Evaluating implicit function at t=1.40000 +DEAL::Evaluating implicit function at t=1.40000 +DEAL::Evaluating implicit function at t=1.40000 +DEAL::Evaluating implicit function at t=1.40000 +DEAL::Distribute at time 1.40000 +DEAL::Prepare at time 1.40000 and step 7 +DEAL::Intermediate output: +DEAL:: t =1.40000 +DEAL:: y =0.257625 (exact: 0.246597) +DEAL::Evaluating implicit function at t=1.50000 +DEAL::Evaluating implicit function at t=1.50000 +DEAL::Evaluating implicit function at t=1.50000 +DEAL::Evaluating implicit function at t=1.50000 +DEAL::Distribute at time 1.50000 +DEAL::Evaluating implicit function at t=1.60000 +DEAL::Evaluating implicit function at t=1.60000 +DEAL::Evaluating implicit function at t=1.60000 +DEAL::Evaluating implicit function at t=1.60000 +DEAL::Distribute at time 1.60000 +DEAL::Prepare at time 1.60000 and step 8 +DEAL::Intermediate output: +DEAL:: t =1.60000 +DEAL:: y =0.212248 (exact: 0.201897) +DEAL::Evaluating implicit function at t=1.70000 +DEAL::Evaluating implicit function at t=1.70000 +DEAL::Evaluating implicit function at t=1.70000 +DEAL::Evaluating implicit function at t=1.70000 +DEAL::Distribute at time 1.70000 +DEAL::Evaluating implicit function at t=1.80000 +DEAL::Evaluating implicit function at t=1.80000 +DEAL::Evaluating implicit function at t=1.80000 +DEAL::Evaluating implicit function at t=1.80000 +DEAL::Distribute at time 1.80000 +DEAL::Prepare at time 1.80000 and step 9 +DEAL::Intermediate output: +DEAL:: t =1.80000 +DEAL:: y =0.174863 (exact: 0.165299) +DEAL::Evaluating implicit function at t=1.90000 +DEAL::Evaluating implicit function at t=1.90000 +DEAL::Evaluating implicit function at t=1.90000 +DEAL::Evaluating implicit function at t=1.90000 +DEAL::Distribute at time 1.90000 +DEAL::Evaluating implicit function at t=2.00000 +DEAL::Evaluating implicit function at t=2.00000 +DEAL::Evaluating implicit function at t=2.00000 +DEAL::Evaluating implicit function at t=2.00000 +DEAL::Distribute at time 2.00000 +DEAL::Prepare at time 2.00000 and step 10 +DEAL::Interpolate +DEAL::Intermediate output: +DEAL:: t =2.00000 +DEAL:: y =0.144063 (exact: 0.135335) +DEAL::Evaluating implicit function at t=2.10000 +DEAL::Evaluating implicit function at t=2.10000 +DEAL::Evaluating implicit function at t=2.10000 +DEAL::Evaluating implicit function at t=2.10000 +DEAL::Distribute at time 2.10000 +DEAL::Evaluating implicit function at t=2.20000 +DEAL::Evaluating implicit function at t=2.20000 +DEAL::Evaluating implicit function at t=2.20000 +DEAL::Evaluating implicit function at t=2.20000 +DEAL::Distribute at time 2.20000 +DEAL::Prepare at time 2.20000 and step 11 +DEAL::Intermediate output: +DEAL:: t =2.20000 +DEAL:: y =0.118689 (exact: 0.110803) +DEAL::# Number of steps taken: 11 +DEAL::# Test explicit interface (J 1) +DEAL::Intermediate output: +DEAL:: t =0.00000 +DEAL:: y =1.00000 (exact: 1.00000) +DEAL::Evaluating explicit function at t=0.100000 +DEAL::Evaluating explicit Jacobian at t=0.100000 +DEAL::Evaluating explicit function at t=0.100000 +DEAL::Distribute at time 0.100000 +DEAL::Evaluating explicit function at t=0.200000 +DEAL::Evaluating explicit Jacobian at t=0.200000 +DEAL::Evaluating explicit function at t=0.200000 +DEAL::Distribute at time 0.200000 +DEAL::Prepare at time 0.200000 and step 1 +DEAL::Intermediate output: +DEAL:: t =0.200000 +DEAL:: y =0.823864 (exact: 0.818731) +DEAL::Evaluating explicit function at t=0.300000 +DEAL::Evaluating explicit Jacobian at t=0.300000 +DEAL::Evaluating explicit function at t=0.300000 +DEAL::Distribute at time 0.300000 +DEAL::Evaluating explicit function at t=0.400000 +DEAL::Evaluating explicit Jacobian at t=0.400000 +DEAL::Evaluating explicit function at t=0.400000 +DEAL::Distribute at time 0.400000 +DEAL::Prepare at time 0.400000 and step 2 +DEAL::Intermediate output: +DEAL:: t =0.400000 +DEAL:: y =0.678751 (exact: 0.670320) +DEAL::Evaluating explicit function at t=0.500000 +DEAL::Evaluating explicit Jacobian at t=0.500000 +DEAL::Evaluating explicit function at t=0.500000 +DEAL::Distribute at time 0.500000 +DEAL::Evaluating explicit function at t=0.600000 +DEAL::Evaluating explicit Jacobian at t=0.600000 +DEAL::Evaluating explicit function at t=0.600000 +DEAL::Distribute at time 0.600000 +DEAL::Prepare at time 0.600000 and step 3 +DEAL::Intermediate output: +DEAL:: t =0.600000 +DEAL:: y =0.559199 (exact: 0.548812) +DEAL::Evaluating explicit function at t=0.700000 +DEAL::Evaluating explicit Jacobian at t=0.700000 +DEAL::Evaluating explicit function at t=0.700000 +DEAL::Distribute at time 0.700000 +DEAL::Evaluating explicit function at t=0.800000 +DEAL::Evaluating explicit Jacobian at t=0.800000 +DEAL::Evaluating explicit function at t=0.800000 +DEAL::Distribute at time 0.800000 +DEAL::Prepare at time 0.800000 and step 4 +DEAL::Intermediate output: +DEAL:: t =0.800000 +DEAL:: y =0.460703 (exact: 0.449329) +DEAL::Evaluating explicit function at t=0.900000 +DEAL::Evaluating explicit Jacobian at t=0.900000 +DEAL::Evaluating explicit function at t=0.900000 +DEAL::Distribute at time 0.900000 +DEAL::Evaluating explicit function at t=1.00000 +DEAL::Evaluating explicit Jacobian at t=1.00000 +DEAL::Evaluating explicit function at t=1.00000 +DEAL::Distribute at time 1.00000 +DEAL::Prepare at time 1.00000 and step 5 +DEAL::Interpolate +DEAL::Intermediate output: +DEAL:: t =1.00000 +DEAL:: y =0.379557 (exact: 0.367879) +DEAL::Evaluating explicit function at t=1.10000 +DEAL::Evaluating explicit Jacobian at t=1.10000 +DEAL::Evaluating explicit function at t=1.10000 +DEAL::Distribute at time 1.10000 +DEAL::Evaluating explicit function at t=1.20000 +DEAL::Evaluating explicit Jacobian at t=1.20000 +DEAL::Evaluating explicit function at t=1.20000 +DEAL::Distribute at time 1.20000 +DEAL::Prepare at time 1.20000 and step 6 +DEAL::Intermediate output: +DEAL:: t =1.20000 +DEAL:: y =0.312703 (exact: 0.301194) +DEAL::Evaluating explicit function at t=1.30000 +DEAL::Evaluating explicit Jacobian at t=1.30000 +DEAL::Evaluating explicit function at t=1.30000 +DEAL::Distribute at time 1.30000 +DEAL::Evaluating explicit function at t=1.40000 +DEAL::Evaluating explicit Jacobian at t=1.40000 +DEAL::Evaluating explicit function at t=1.40000 +DEAL::Distribute at time 1.40000 +DEAL::Prepare at time 1.40000 and step 7 +DEAL::Intermediate output: +DEAL:: t =1.40000 +DEAL:: y =0.257625 (exact: 0.246597) +DEAL::Evaluating explicit function at t=1.50000 +DEAL::Evaluating explicit Jacobian at t=1.50000 +DEAL::Evaluating explicit function at t=1.50000 +DEAL::Distribute at time 1.50000 +DEAL::Evaluating explicit function at t=1.60000 +DEAL::Evaluating explicit Jacobian at t=1.60000 +DEAL::Evaluating explicit function at t=1.60000 +DEAL::Distribute at time 1.60000 +DEAL::Prepare at time 1.60000 and step 8 +DEAL::Intermediate output: +DEAL:: t =1.60000 +DEAL:: y =0.212248 (exact: 0.201897) +DEAL::Evaluating explicit function at t=1.70000 +DEAL::Evaluating explicit Jacobian at t=1.70000 +DEAL::Evaluating explicit function at t=1.70000 +DEAL::Distribute at time 1.70000 +DEAL::Evaluating explicit function at t=1.80000 +DEAL::Evaluating explicit Jacobian at t=1.80000 +DEAL::Evaluating explicit function at t=1.80000 +DEAL::Distribute at time 1.80000 +DEAL::Prepare at time 1.80000 and step 9 +DEAL::Intermediate output: +DEAL:: t =1.80000 +DEAL:: y =0.174863 (exact: 0.165299) +DEAL::Evaluating explicit function at t=1.90000 +DEAL::Evaluating explicit Jacobian at t=1.90000 +DEAL::Evaluating explicit function at t=1.90000 +DEAL::Distribute at time 1.90000 +DEAL::Evaluating explicit function at t=2.00000 +DEAL::Evaluating explicit Jacobian at t=2.00000 +DEAL::Evaluating explicit function at t=2.00000 +DEAL::Distribute at time 2.00000 +DEAL::Prepare at time 2.00000 and step 10 +DEAL::Interpolate +DEAL::Intermediate output: +DEAL:: t =2.00000 +DEAL:: y =0.144063 (exact: 0.135335) +DEAL::Evaluating explicit function at t=2.10000 +DEAL::Evaluating explicit Jacobian at t=2.10000 +DEAL::Evaluating explicit function at t=2.10000 +DEAL::Distribute at time 2.10000 +DEAL::Evaluating explicit function at t=2.20000 +DEAL::Evaluating explicit Jacobian at t=2.20000 +DEAL::Evaluating explicit function at t=2.20000 +DEAL::Distribute at time 2.20000 +DEAL::Prepare at time 2.20000 and step 11 +DEAL::Intermediate output: +DEAL:: t =2.20000 +DEAL:: y =0.118689 (exact: 0.110803) +DEAL::# Number of steps taken: 11 +DEAL::# Test implicit interface (J 1) +DEAL::Intermediate output: +DEAL:: t =0.00000 +DEAL:: y =1.00000 (exact: 1.00000) +DEAL::Evaluating implicit function at t=0.100000 +DEAL::Evaluating implicit Jacobian at t=0.100000 +DEAL::Evaluating implicit function at t=0.100000 +DEAL::Distribute at time 0.100000 +DEAL::Evaluating implicit function at t=0.200000 +DEAL::Evaluating implicit Jacobian at t=0.200000 +DEAL::Evaluating implicit function at t=0.200000 +DEAL::Distribute at time 0.200000 +DEAL::Prepare at time 0.200000 and step 1 +DEAL::Intermediate output: +DEAL:: t =0.200000 +DEAL:: y =0.823864 (exact: 0.818731) +DEAL::Evaluating implicit function at t=0.300000 +DEAL::Evaluating implicit Jacobian at t=0.300000 +DEAL::Evaluating implicit function at t=0.300000 +DEAL::Distribute at time 0.300000 +DEAL::Evaluating implicit function at t=0.400000 +DEAL::Evaluating implicit Jacobian at t=0.400000 +DEAL::Evaluating implicit function at t=0.400000 +DEAL::Distribute at time 0.400000 +DEAL::Prepare at time 0.400000 and step 2 +DEAL::Intermediate output: +DEAL:: t =0.400000 +DEAL:: y =0.678751 (exact: 0.670320) +DEAL::Evaluating implicit function at t=0.500000 +DEAL::Evaluating implicit Jacobian at t=0.500000 +DEAL::Evaluating implicit function at t=0.500000 +DEAL::Distribute at time 0.500000 +DEAL::Evaluating implicit function at t=0.600000 +DEAL::Evaluating implicit Jacobian at t=0.600000 +DEAL::Evaluating implicit function at t=0.600000 +DEAL::Distribute at time 0.600000 +DEAL::Prepare at time 0.600000 and step 3 +DEAL::Intermediate output: +DEAL:: t =0.600000 +DEAL:: y =0.559199 (exact: 0.548812) +DEAL::Evaluating implicit function at t=0.700000 +DEAL::Evaluating implicit Jacobian at t=0.700000 +DEAL::Evaluating implicit function at t=0.700000 +DEAL::Distribute at time 0.700000 +DEAL::Evaluating implicit function at t=0.800000 +DEAL::Evaluating implicit Jacobian at t=0.800000 +DEAL::Evaluating implicit function at t=0.800000 +DEAL::Distribute at time 0.800000 +DEAL::Prepare at time 0.800000 and step 4 +DEAL::Intermediate output: +DEAL:: t =0.800000 +DEAL:: y =0.460703 (exact: 0.449329) +DEAL::Evaluating implicit function at t=0.900000 +DEAL::Evaluating implicit Jacobian at t=0.900000 +DEAL::Evaluating implicit function at t=0.900000 +DEAL::Distribute at time 0.900000 +DEAL::Evaluating implicit function at t=1.00000 +DEAL::Evaluating implicit Jacobian at t=1.00000 +DEAL::Evaluating implicit function at t=1.00000 +DEAL::Distribute at time 1.00000 +DEAL::Prepare at time 1.00000 and step 5 +DEAL::Interpolate +DEAL::Intermediate output: +DEAL:: t =1.00000 +DEAL:: y =0.379557 (exact: 0.367879) +DEAL::Evaluating implicit function at t=1.10000 +DEAL::Evaluating implicit Jacobian at t=1.10000 +DEAL::Evaluating implicit function at t=1.10000 +DEAL::Distribute at time 1.10000 +DEAL::Evaluating implicit function at t=1.20000 +DEAL::Evaluating implicit Jacobian at t=1.20000 +DEAL::Evaluating implicit function at t=1.20000 +DEAL::Distribute at time 1.20000 +DEAL::Prepare at time 1.20000 and step 6 +DEAL::Intermediate output: +DEAL:: t =1.20000 +DEAL:: y =0.312703 (exact: 0.301194) +DEAL::Evaluating implicit function at t=1.30000 +DEAL::Evaluating implicit Jacobian at t=1.30000 +DEAL::Evaluating implicit function at t=1.30000 +DEAL::Distribute at time 1.30000 +DEAL::Evaluating implicit function at t=1.40000 +DEAL::Evaluating implicit Jacobian at t=1.40000 +DEAL::Evaluating implicit function at t=1.40000 +DEAL::Distribute at time 1.40000 +DEAL::Prepare at time 1.40000 and step 7 +DEAL::Intermediate output: +DEAL:: t =1.40000 +DEAL:: y =0.257625 (exact: 0.246597) +DEAL::Evaluating implicit function at t=1.50000 +DEAL::Evaluating implicit Jacobian at t=1.50000 +DEAL::Evaluating implicit function at t=1.50000 +DEAL::Distribute at time 1.50000 +DEAL::Evaluating implicit function at t=1.60000 +DEAL::Evaluating implicit Jacobian at t=1.60000 +DEAL::Evaluating implicit function at t=1.60000 +DEAL::Distribute at time 1.60000 +DEAL::Prepare at time 1.60000 and step 8 +DEAL::Intermediate output: +DEAL:: t =1.60000 +DEAL:: y =0.212248 (exact: 0.201897) +DEAL::Evaluating implicit function at t=1.70000 +DEAL::Evaluating implicit Jacobian at t=1.70000 +DEAL::Evaluating implicit function at t=1.70000 +DEAL::Distribute at time 1.70000 +DEAL::Evaluating implicit function at t=1.80000 +DEAL::Evaluating implicit Jacobian at t=1.80000 +DEAL::Evaluating implicit function at t=1.80000 +DEAL::Distribute at time 1.80000 +DEAL::Prepare at time 1.80000 and step 9 +DEAL::Intermediate output: +DEAL:: t =1.80000 +DEAL:: y =0.174863 (exact: 0.165299) +DEAL::Evaluating implicit function at t=1.90000 +DEAL::Evaluating implicit Jacobian at t=1.90000 +DEAL::Evaluating implicit function at t=1.90000 +DEAL::Distribute at time 1.90000 +DEAL::Evaluating implicit function at t=2.00000 +DEAL::Evaluating implicit Jacobian at t=2.00000 +DEAL::Evaluating implicit function at t=2.00000 +DEAL::Distribute at time 2.00000 +DEAL::Prepare at time 2.00000 and step 10 +DEAL::Interpolate +DEAL::Intermediate output: +DEAL:: t =2.00000 +DEAL:: y =0.144063 (exact: 0.135335) +DEAL::Evaluating implicit function at t=2.10000 +DEAL::Evaluating implicit Jacobian at t=2.10000 +DEAL::Evaluating implicit function at t=2.10000 +DEAL::Distribute at time 2.10000 +DEAL::Evaluating implicit function at t=2.20000 +DEAL::Evaluating implicit Jacobian at t=2.20000 +DEAL::Evaluating implicit function at t=2.20000 +DEAL::Distribute at time 2.20000 +DEAL::Prepare at time 2.20000 and step 11 +DEAL::Intermediate output: +DEAL:: t =2.20000 +DEAL:: y =0.118689 (exact: 0.110803) +DEAL::# Number of steps taken: 11 +DEAL::# Test user interface +DEAL::Intermediate output: +DEAL:: t =0.00000 +DEAL:: y =1.00000 (exact: 1.00000) +DEAL::Evaluating implicit function at t=0.100000 +DEAL::Setting up Jacobian at t=0.100000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=0.100000 +DEAL::Evaluating implicit function at t=0.100000 +DEAL::Distribute at time 0.100000 +DEAL::Evaluating implicit function at t=0.200000 +DEAL::Setting up Jacobian at t=0.200000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=0.200000 +DEAL::Evaluating implicit function at t=0.200000 +DEAL::Distribute at time 0.200000 +DEAL::Prepare at time 0.200000 and step 1 +DEAL::Intermediate output: +DEAL:: t =0.200000 +DEAL:: y =0.823864 (exact: 0.818731) +DEAL::Evaluating implicit function at t=0.300000 +DEAL::Setting up Jacobian at t=0.300000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=0.300000 +DEAL::Evaluating implicit function at t=0.300000 +DEAL::Distribute at time 0.300000 +DEAL::Evaluating implicit function at t=0.400000 +DEAL::Setting up Jacobian at t=0.400000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=0.400000 +DEAL::Evaluating implicit function at t=0.400000 +DEAL::Distribute at time 0.400000 +DEAL::Prepare at time 0.400000 and step 2 +DEAL::Intermediate output: +DEAL:: t =0.400000 +DEAL:: y =0.678751 (exact: 0.670320) +DEAL::Evaluating implicit function at t=0.500000 +DEAL::Setting up Jacobian at t=0.500000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=0.500000 +DEAL::Evaluating implicit function at t=0.500000 +DEAL::Distribute at time 0.500000 +DEAL::Evaluating implicit function at t=0.600000 +DEAL::Setting up Jacobian at t=0.600000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=0.600000 +DEAL::Evaluating implicit function at t=0.600000 +DEAL::Distribute at time 0.600000 +DEAL::Prepare at time 0.600000 and step 3 +DEAL::Intermediate output: +DEAL:: t =0.600000 +DEAL:: y =0.559199 (exact: 0.548812) +DEAL::Evaluating implicit function at t=0.700000 +DEAL::Setting up Jacobian at t=0.700000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=0.700000 +DEAL::Evaluating implicit function at t=0.700000 +DEAL::Distribute at time 0.700000 +DEAL::Evaluating implicit function at t=0.800000 +DEAL::Setting up Jacobian at t=0.800000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=0.800000 +DEAL::Evaluating implicit function at t=0.800000 +DEAL::Distribute at time 0.800000 +DEAL::Prepare at time 0.800000 and step 4 +DEAL::Intermediate output: +DEAL:: t =0.800000 +DEAL:: y =0.460703 (exact: 0.449329) +DEAL::Evaluating implicit function at t=0.900000 +DEAL::Setting up Jacobian at t=0.900000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=0.900000 +DEAL::Evaluating implicit function at t=0.900000 +DEAL::Distribute at time 0.900000 +DEAL::Evaluating implicit function at t=1.00000 +DEAL::Setting up Jacobian at t=1.00000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=1.00000 +DEAL::Evaluating implicit function at t=1.00000 +DEAL::Distribute at time 1.00000 +DEAL::Prepare at time 1.00000 and step 5 +DEAL::Interpolate +DEAL::Intermediate output: +DEAL:: t =1.00000 +DEAL:: y =0.379557 (exact: 0.367879) +DEAL::Evaluating implicit function at t=1.10000 +DEAL::Setting up Jacobian at t=1.10000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=1.10000 +DEAL::Evaluating implicit function at t=1.10000 +DEAL::Distribute at time 1.10000 +DEAL::Evaluating implicit function at t=1.20000 +DEAL::Setting up Jacobian at t=1.20000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=1.20000 +DEAL::Evaluating implicit function at t=1.20000 +DEAL::Distribute at time 1.20000 +DEAL::Prepare at time 1.20000 and step 6 +DEAL::Intermediate output: +DEAL:: t =1.20000 +DEAL:: y =0.312703 (exact: 0.301194) +DEAL::Evaluating implicit function at t=1.30000 +DEAL::Setting up Jacobian at t=1.30000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=1.30000 +DEAL::Evaluating implicit function at t=1.30000 +DEAL::Distribute at time 1.30000 +DEAL::Evaluating implicit function at t=1.40000 +DEAL::Setting up Jacobian at t=1.40000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=1.40000 +DEAL::Evaluating implicit function at t=1.40000 +DEAL::Distribute at time 1.40000 +DEAL::Prepare at time 1.40000 and step 7 +DEAL::Intermediate output: +DEAL:: t =1.40000 +DEAL:: y =0.257625 (exact: 0.246597) +DEAL::Evaluating implicit function at t=1.50000 +DEAL::Setting up Jacobian at t=1.50000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=1.50000 +DEAL::Evaluating implicit function at t=1.50000 +DEAL::Distribute at time 1.50000 +DEAL::Evaluating implicit function at t=1.60000 +DEAL::Setting up Jacobian at t=1.60000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=1.60000 +DEAL::Evaluating implicit function at t=1.60000 +DEAL::Distribute at time 1.60000 +DEAL::Prepare at time 1.60000 and step 8 +DEAL::Intermediate output: +DEAL:: t =1.60000 +DEAL:: y =0.212248 (exact: 0.201897) +DEAL::Evaluating implicit function at t=1.70000 +DEAL::Setting up Jacobian at t=1.70000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=1.70000 +DEAL::Evaluating implicit function at t=1.70000 +DEAL::Distribute at time 1.70000 +DEAL::Evaluating implicit function at t=1.80000 +DEAL::Setting up Jacobian at t=1.80000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=1.80000 +DEAL::Evaluating implicit function at t=1.80000 +DEAL::Distribute at time 1.80000 +DEAL::Prepare at time 1.80000 and step 9 +DEAL::Intermediate output: +DEAL:: t =1.80000 +DEAL:: y =0.174863 (exact: 0.165299) +DEAL::Evaluating implicit function at t=1.90000 +DEAL::Setting up Jacobian at t=1.90000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=1.90000 +DEAL::Evaluating implicit function at t=1.90000 +DEAL::Distribute at time 1.90000 +DEAL::Evaluating implicit function at t=2.00000 +DEAL::Setting up Jacobian at t=2.00000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=2.00000 +DEAL::Evaluating implicit function at t=2.00000 +DEAL::Distribute at time 2.00000 +DEAL::Prepare at time 2.00000 and step 10 +DEAL::Interpolate +DEAL::Intermediate output: +DEAL:: t =2.00000 +DEAL:: y =0.144063 (exact: 0.135335) +DEAL::Evaluating implicit function at t=2.10000 +DEAL::Setting up Jacobian at t=2.10000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=2.10000 +DEAL::Evaluating implicit function at t=2.10000 +DEAL::Distribute at time 2.10000 +DEAL::Evaluating implicit function at t=2.20000 +DEAL::Setting up Jacobian at t=2.20000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=2.20000 +DEAL::Evaluating implicit function at t=2.20000 +DEAL::Distribute at time 2.20000 +DEAL::Prepare at time 2.20000 and step 11 +DEAL::Intermediate output: +DEAL:: t =2.20000 +DEAL:: y =0.118689 (exact: 0.110803) +DEAL::# Number of steps taken: 11 diff --git a/tests/petsc/petsc_ts_03_compat.output.pre3.20 b/tests/petsc/petsc_ts_03_compat.output.pre3.20 new file mode 100644 index 0000000000..e25b8b7f10 --- /dev/null +++ b/tests/petsc/petsc_ts_03_compat.output.pre3.20 @@ -0,0 +1,628 @@ + +DEAL::# Default Parameters +subsection Error control + set absolute error tolerance = -1 + set adaptor type = none + set ignore algebraic lte = true + set maximum step size = -1 + set minimum step size = -1 + set relative error tolerance = -1 +end +subsection Running parameters + set final time = 0 + set initial step size = 0 + set initial time = 0 + set match final time = false + set maximum number of steps = -1 + set options prefix = + set solver type = +end +DEAL::# Testing Parameters +subsection Error control + set absolute error tolerance = 0.0001 + set adaptor type = none + set ignore algebraic lte = true + set maximum step size = 1e+7 + set minimum step size = 1e-7 + set relative error tolerance = -1 +end +subsection Running parameters + set final time = 2.0 + set initial step size = 0.2 + set initial time = 0 + set match final time = false + set maximum number of steps = -1 + set options prefix = + set solver type = bdf +end +DEAL::# Test explicit interface (J 0) +DEAL::Intermediate output: +DEAL:: t =0.00000 +DEAL:: y =1.00000 (exact: 1.00000) +DEAL::Evaluating explicit function at t=0.100000 +DEAL::Evaluating explicit function at t=0.100000 +DEAL::Evaluating explicit function at t=0.100000 +DEAL::Evaluating explicit function at t=0.100000 +DEAL::Distribute at time 0.100000 +DEAL::Evaluating explicit function at t=0.200000 +DEAL::Evaluating explicit function at t=0.200000 +DEAL::Evaluating explicit function at t=0.200000 +DEAL::Evaluating explicit function at t=0.200000 +DEAL::Distribute at time 0.200000 +DEAL::Prepare at time 0.200000 and step 1 +DEAL::Intermediate output: +DEAL:: t =0.200000 +DEAL:: y =0.823864 (exact: 0.818731) +DEAL::Evaluating explicit function at t=0.400000 +DEAL::Evaluating explicit function at t=0.400000 +DEAL::Evaluating explicit function at t=0.400000 +DEAL::Evaluating explicit function at t=0.400000 +DEAL::Distribute at time 0.400000 +DEAL::Prepare at time 0.400000 and step 2 +DEAL::Intermediate output: +DEAL:: t =0.400000 +DEAL:: y =0.675134 (exact: 0.670320) +DEAL::Evaluating explicit function at t=0.600000 +DEAL::Evaluating explicit function at t=0.600000 +DEAL::Evaluating explicit function at t=0.600000 +DEAL::Evaluating explicit function at t=0.600000 +DEAL::Distribute at time 0.600000 +DEAL::Prepare at time 0.600000 and step 3 +DEAL::Intermediate output: +DEAL:: t =0.600000 +DEAL:: y =0.551962 (exact: 0.548812) +DEAL::Evaluating explicit function at t=0.800000 +DEAL::Evaluating explicit function at t=0.800000 +DEAL::Evaluating explicit function at t=0.800000 +DEAL::Evaluating explicit function at t=0.800000 +DEAL::Distribute at time 0.800000 +DEAL::Prepare at time 0.800000 and step 4 +DEAL::Intermediate output: +DEAL:: t =0.800000 +DEAL:: y =0.450798 (exact: 0.449329) +DEAL::Evaluating explicit function at t=1.00000 +DEAL::Evaluating explicit function at t=1.00000 +DEAL::Evaluating explicit function at t=1.00000 +DEAL::Evaluating explicit function at t=1.00000 +DEAL::Distribute at time 1.00000 +DEAL::Prepare at time 1.00000 and step 5 +DEAL::Interpolate +DEAL::Intermediate output: +DEAL:: t =1.00000 +DEAL:: y =0.368009 (exact: 0.367879) +DEAL::Evaluating explicit function at t=1.10000 +DEAL::Evaluating explicit function at t=1.10000 +DEAL::Evaluating explicit function at t=1.10000 +DEAL::Evaluating explicit function at t=1.10000 +DEAL::Distribute at time 1.10000 +DEAL::Evaluating explicit function at t=1.20000 +DEAL::Evaluating explicit function at t=1.20000 +DEAL::Evaluating explicit function at t=1.20000 +DEAL::Evaluating explicit function at t=1.20000 +DEAL::Distribute at time 1.20000 +DEAL::Prepare at time 1.20000 and step 6 +DEAL::Intermediate output: +DEAL:: t =1.20000 +DEAL:: y =0.303189 (exact: 0.301194) +DEAL::Evaluating explicit function at t=1.40000 +DEAL::Evaluating explicit function at t=1.40000 +DEAL::Evaluating explicit function at t=1.40000 +DEAL::Evaluating explicit function at t=1.40000 +DEAL::Distribute at time 1.40000 +DEAL::Prepare at time 1.40000 and step 7 +DEAL::Intermediate output: +DEAL:: t =1.40000 +DEAL:: y =0.248455 (exact: 0.246597) +DEAL::Evaluating explicit function at t=1.60000 +DEAL::Evaluating explicit function at t=1.60000 +DEAL::Evaluating explicit function at t=1.60000 +DEAL::Evaluating explicit function at t=1.60000 +DEAL::Distribute at time 1.60000 +DEAL::Prepare at time 1.60000 and step 8 +DEAL::Intermediate output: +DEAL:: t =1.60000 +DEAL:: y =0.203127 (exact: 0.201897) +DEAL::Evaluating explicit function at t=1.80000 +DEAL::Evaluating explicit function at t=1.80000 +DEAL::Evaluating explicit function at t=1.80000 +DEAL::Evaluating explicit function at t=1.80000 +DEAL::Distribute at time 1.80000 +DEAL::Prepare at time 1.80000 and step 9 +DEAL::Intermediate output: +DEAL:: t =1.80000 +DEAL:: y =0.165898 (exact: 0.165299) +DEAL::Evaluating explicit function at t=2.00000 +DEAL::Evaluating explicit function at t=2.00000 +DEAL::Evaluating explicit function at t=2.00000 +DEAL::Evaluating explicit function at t=2.00000 +DEAL::Distribute at time 2.00000 +DEAL::Prepare at time 2.00000 and step 10 +DEAL::Interpolate +DEAL::Intermediate output: +DEAL:: t =2.00000 +DEAL:: y =0.135431 (exact: 0.135335) +DEAL::Evaluating explicit function at t=2.10000 +DEAL::Evaluating explicit function at t=2.10000 +DEAL::Evaluating explicit function at t=2.10000 +DEAL::Evaluating explicit function at t=2.10000 +DEAL::Distribute at time 2.10000 +DEAL::Evaluating explicit function at t=2.20000 +DEAL::Evaluating explicit function at t=2.20000 +DEAL::Evaluating explicit function at t=2.20000 +DEAL::Evaluating explicit function at t=2.20000 +DEAL::Distribute at time 2.20000 +DEAL::Prepare at time 2.20000 and step 11 +DEAL::Intermediate output: +DEAL:: t =2.20000 +DEAL:: y =0.111577 (exact: 0.110803) +DEAL::# Number of steps taken: 11 +DEAL::# Test implicit interface (J 0) +DEAL::Intermediate output: +DEAL:: t =0.00000 +DEAL:: y =1.00000 (exact: 1.00000) +DEAL::Evaluating implicit function at t=0.100000 +DEAL::Evaluating implicit function at t=0.100000 +DEAL::Evaluating implicit function at t=0.100000 +DEAL::Evaluating implicit function at t=0.100000 +DEAL::Distribute at time 0.100000 +DEAL::Evaluating implicit function at t=0.200000 +DEAL::Evaluating implicit function at t=0.200000 +DEAL::Evaluating implicit function at t=0.200000 +DEAL::Evaluating implicit function at t=0.200000 +DEAL::Distribute at time 0.200000 +DEAL::Prepare at time 0.200000 and step 1 +DEAL::Intermediate output: +DEAL:: t =0.200000 +DEAL:: y =0.823864 (exact: 0.818731) +DEAL::Evaluating implicit function at t=0.400000 +DEAL::Evaluating implicit function at t=0.400000 +DEAL::Evaluating implicit function at t=0.400000 +DEAL::Evaluating implicit function at t=0.400000 +DEAL::Distribute at time 0.400000 +DEAL::Prepare at time 0.400000 and step 2 +DEAL::Intermediate output: +DEAL:: t =0.400000 +DEAL:: y =0.675134 (exact: 0.670320) +DEAL::Evaluating implicit function at t=0.600000 +DEAL::Evaluating implicit function at t=0.600000 +DEAL::Evaluating implicit function at t=0.600000 +DEAL::Evaluating implicit function at t=0.600000 +DEAL::Distribute at time 0.600000 +DEAL::Prepare at time 0.600000 and step 3 +DEAL::Intermediate output: +DEAL:: t =0.600000 +DEAL:: y =0.551962 (exact: 0.548812) +DEAL::Evaluating implicit function at t=0.800000 +DEAL::Evaluating implicit function at t=0.800000 +DEAL::Evaluating implicit function at t=0.800000 +DEAL::Evaluating implicit function at t=0.800000 +DEAL::Distribute at time 0.800000 +DEAL::Prepare at time 0.800000 and step 4 +DEAL::Intermediate output: +DEAL:: t =0.800000 +DEAL:: y =0.450798 (exact: 0.449329) +DEAL::Evaluating implicit function at t=1.00000 +DEAL::Evaluating implicit function at t=1.00000 +DEAL::Evaluating implicit function at t=1.00000 +DEAL::Evaluating implicit function at t=1.00000 +DEAL::Distribute at time 1.00000 +DEAL::Prepare at time 1.00000 and step 5 +DEAL::Interpolate +DEAL::Intermediate output: +DEAL:: t =1.00000 +DEAL:: y =0.368009 (exact: 0.367879) +DEAL::Evaluating implicit function at t=1.10000 +DEAL::Evaluating implicit function at t=1.10000 +DEAL::Evaluating implicit function at t=1.10000 +DEAL::Evaluating implicit function at t=1.10000 +DEAL::Distribute at time 1.10000 +DEAL::Evaluating implicit function at t=1.20000 +DEAL::Evaluating implicit function at t=1.20000 +DEAL::Evaluating implicit function at t=1.20000 +DEAL::Evaluating implicit function at t=1.20000 +DEAL::Distribute at time 1.20000 +DEAL::Prepare at time 1.20000 and step 6 +DEAL::Intermediate output: +DEAL:: t =1.20000 +DEAL:: y =0.303189 (exact: 0.301194) +DEAL::Evaluating implicit function at t=1.40000 +DEAL::Evaluating implicit function at t=1.40000 +DEAL::Evaluating implicit function at t=1.40000 +DEAL::Evaluating implicit function at t=1.40000 +DEAL::Distribute at time 1.40000 +DEAL::Prepare at time 1.40000 and step 7 +DEAL::Intermediate output: +DEAL:: t =1.40000 +DEAL:: y =0.248455 (exact: 0.246597) +DEAL::Evaluating implicit function at t=1.60000 +DEAL::Evaluating implicit function at t=1.60000 +DEAL::Evaluating implicit function at t=1.60000 +DEAL::Evaluating implicit function at t=1.60000 +DEAL::Distribute at time 1.60000 +DEAL::Prepare at time 1.60000 and step 8 +DEAL::Intermediate output: +DEAL:: t =1.60000 +DEAL:: y =0.203127 (exact: 0.201897) +DEAL::Evaluating implicit function at t=1.80000 +DEAL::Evaluating implicit function at t=1.80000 +DEAL::Evaluating implicit function at t=1.80000 +DEAL::Evaluating implicit function at t=1.80000 +DEAL::Distribute at time 1.80000 +DEAL::Prepare at time 1.80000 and step 9 +DEAL::Intermediate output: +DEAL:: t =1.80000 +DEAL:: y =0.165898 (exact: 0.165299) +DEAL::Evaluating implicit function at t=2.00000 +DEAL::Evaluating implicit function at t=2.00000 +DEAL::Evaluating implicit function at t=2.00000 +DEAL::Evaluating implicit function at t=2.00000 +DEAL::Distribute at time 2.00000 +DEAL::Prepare at time 2.00000 and step 10 +DEAL::Interpolate +DEAL::Intermediate output: +DEAL:: t =2.00000 +DEAL:: y =0.135431 (exact: 0.135335) +DEAL::Evaluating implicit function at t=2.10000 +DEAL::Evaluating implicit function at t=2.10000 +DEAL::Evaluating implicit function at t=2.10000 +DEAL::Evaluating implicit function at t=2.10000 +DEAL::Distribute at time 2.10000 +DEAL::Evaluating implicit function at t=2.20000 +DEAL::Evaluating implicit function at t=2.20000 +DEAL::Evaluating implicit function at t=2.20000 +DEAL::Evaluating implicit function at t=2.20000 +DEAL::Distribute at time 2.20000 +DEAL::Prepare at time 2.20000 and step 11 +DEAL::Intermediate output: +DEAL:: t =2.20000 +DEAL:: y =0.111577 (exact: 0.110803) +DEAL::# Number of steps taken: 11 +DEAL::# Test explicit interface (J 1) +DEAL::Intermediate output: +DEAL:: t =0.00000 +DEAL:: y =1.00000 (exact: 1.00000) +DEAL::Evaluating explicit function at t=0.100000 +DEAL::Evaluating explicit Jacobian at t=0.100000 +DEAL::Evaluating explicit function at t=0.100000 +DEAL::Distribute at time 0.100000 +DEAL::Evaluating explicit function at t=0.200000 +DEAL::Evaluating explicit Jacobian at t=0.200000 +DEAL::Evaluating explicit function at t=0.200000 +DEAL::Distribute at time 0.200000 +DEAL::Prepare at time 0.200000 and step 1 +DEAL::Intermediate output: +DEAL:: t =0.200000 +DEAL:: y =0.823864 (exact: 0.818731) +DEAL::Evaluating explicit function at t=0.400000 +DEAL::Evaluating explicit Jacobian at t=0.400000 +DEAL::Evaluating explicit function at t=0.400000 +DEAL::Distribute at time 0.400000 +DEAL::Prepare at time 0.400000 and step 2 +DEAL::Intermediate output: +DEAL:: t =0.400000 +DEAL:: y =0.675134 (exact: 0.670320) +DEAL::Evaluating explicit function at t=0.600000 +DEAL::Evaluating explicit Jacobian at t=0.600000 +DEAL::Evaluating explicit function at t=0.600000 +DEAL::Distribute at time 0.600000 +DEAL::Prepare at time 0.600000 and step 3 +DEAL::Intermediate output: +DEAL:: t =0.600000 +DEAL:: y =0.551962 (exact: 0.548812) +DEAL::Evaluating explicit function at t=0.800000 +DEAL::Evaluating explicit Jacobian at t=0.800000 +DEAL::Evaluating explicit function at t=0.800000 +DEAL::Distribute at time 0.800000 +DEAL::Prepare at time 0.800000 and step 4 +DEAL::Intermediate output: +DEAL:: t =0.800000 +DEAL:: y =0.450798 (exact: 0.449329) +DEAL::Evaluating explicit function at t=1.00000 +DEAL::Evaluating explicit Jacobian at t=1.00000 +DEAL::Evaluating explicit function at t=1.00000 +DEAL::Distribute at time 1.00000 +DEAL::Prepare at time 1.00000 and step 5 +DEAL::Interpolate +DEAL::Intermediate output: +DEAL:: t =1.00000 +DEAL:: y =0.368009 (exact: 0.367879) +DEAL::Evaluating explicit function at t=1.10000 +DEAL::Evaluating explicit Jacobian at t=1.10000 +DEAL::Evaluating explicit function at t=1.10000 +DEAL::Distribute at time 1.10000 +DEAL::Evaluating explicit function at t=1.20000 +DEAL::Evaluating explicit Jacobian at t=1.20000 +DEAL::Evaluating explicit function at t=1.20000 +DEAL::Distribute at time 1.20000 +DEAL::Prepare at time 1.20000 and step 6 +DEAL::Intermediate output: +DEAL:: t =1.20000 +DEAL:: y =0.303189 (exact: 0.301194) +DEAL::Evaluating explicit function at t=1.40000 +DEAL::Evaluating explicit Jacobian at t=1.40000 +DEAL::Evaluating explicit function at t=1.40000 +DEAL::Distribute at time 1.40000 +DEAL::Prepare at time 1.40000 and step 7 +DEAL::Intermediate output: +DEAL:: t =1.40000 +DEAL:: y =0.248455 (exact: 0.246597) +DEAL::Evaluating explicit function at t=1.60000 +DEAL::Evaluating explicit Jacobian at t=1.60000 +DEAL::Evaluating explicit function at t=1.60000 +DEAL::Distribute at time 1.60000 +DEAL::Prepare at time 1.60000 and step 8 +DEAL::Intermediate output: +DEAL:: t =1.60000 +DEAL:: y =0.203127 (exact: 0.201897) +DEAL::Evaluating explicit function at t=1.80000 +DEAL::Evaluating explicit Jacobian at t=1.80000 +DEAL::Evaluating explicit function at t=1.80000 +DEAL::Distribute at time 1.80000 +DEAL::Prepare at time 1.80000 and step 9 +DEAL::Intermediate output: +DEAL:: t =1.80000 +DEAL:: y =0.165898 (exact: 0.165299) +DEAL::Evaluating explicit function at t=2.00000 +DEAL::Evaluating explicit Jacobian at t=2.00000 +DEAL::Evaluating explicit function at t=2.00000 +DEAL::Distribute at time 2.00000 +DEAL::Prepare at time 2.00000 and step 10 +DEAL::Interpolate +DEAL::Intermediate output: +DEAL:: t =2.00000 +DEAL:: y =0.135431 (exact: 0.135335) +DEAL::Evaluating explicit function at t=2.10000 +DEAL::Evaluating explicit Jacobian at t=2.10000 +DEAL::Evaluating explicit function at t=2.10000 +DEAL::Distribute at time 2.10000 +DEAL::Evaluating explicit function at t=2.20000 +DEAL::Evaluating explicit Jacobian at t=2.20000 +DEAL::Evaluating explicit function at t=2.20000 +DEAL::Distribute at time 2.20000 +DEAL::Prepare at time 2.20000 and step 11 +DEAL::Intermediate output: +DEAL:: t =2.20000 +DEAL:: y =0.111577 (exact: 0.110803) +DEAL::# Number of steps taken: 11 +DEAL::# Test implicit interface (J 1) +DEAL::Intermediate output: +DEAL:: t =0.00000 +DEAL:: y =1.00000 (exact: 1.00000) +DEAL::Evaluating implicit function at t=0.100000 +DEAL::Evaluating implicit Jacobian at t=0.100000 +DEAL::Evaluating implicit function at t=0.100000 +DEAL::Distribute at time 0.100000 +DEAL::Evaluating implicit function at t=0.200000 +DEAL::Evaluating implicit Jacobian at t=0.200000 +DEAL::Evaluating implicit function at t=0.200000 +DEAL::Distribute at time 0.200000 +DEAL::Prepare at time 0.200000 and step 1 +DEAL::Intermediate output: +DEAL:: t =0.200000 +DEAL:: y =0.823864 (exact: 0.818731) +DEAL::Evaluating implicit function at t=0.400000 +DEAL::Evaluating implicit Jacobian at t=0.400000 +DEAL::Evaluating implicit function at t=0.400000 +DEAL::Distribute at time 0.400000 +DEAL::Prepare at time 0.400000 and step 2 +DEAL::Intermediate output: +DEAL:: t =0.400000 +DEAL:: y =0.675134 (exact: 0.670320) +DEAL::Evaluating implicit function at t=0.600000 +DEAL::Evaluating implicit Jacobian at t=0.600000 +DEAL::Evaluating implicit function at t=0.600000 +DEAL::Distribute at time 0.600000 +DEAL::Prepare at time 0.600000 and step 3 +DEAL::Intermediate output: +DEAL:: t =0.600000 +DEAL:: y =0.551962 (exact: 0.548812) +DEAL::Evaluating implicit function at t=0.800000 +DEAL::Evaluating implicit Jacobian at t=0.800000 +DEAL::Evaluating implicit function at t=0.800000 +DEAL::Distribute at time 0.800000 +DEAL::Prepare at time 0.800000 and step 4 +DEAL::Intermediate output: +DEAL:: t =0.800000 +DEAL:: y =0.450798 (exact: 0.449329) +DEAL::Evaluating implicit function at t=1.00000 +DEAL::Evaluating implicit Jacobian at t=1.00000 +DEAL::Evaluating implicit function at t=1.00000 +DEAL::Distribute at time 1.00000 +DEAL::Prepare at time 1.00000 and step 5 +DEAL::Interpolate +DEAL::Intermediate output: +DEAL:: t =1.00000 +DEAL:: y =0.368009 (exact: 0.367879) +DEAL::Evaluating implicit function at t=1.10000 +DEAL::Evaluating implicit Jacobian at t=1.10000 +DEAL::Evaluating implicit function at t=1.10000 +DEAL::Distribute at time 1.10000 +DEAL::Evaluating implicit function at t=1.20000 +DEAL::Evaluating implicit Jacobian at t=1.20000 +DEAL::Evaluating implicit function at t=1.20000 +DEAL::Distribute at time 1.20000 +DEAL::Prepare at time 1.20000 and step 6 +DEAL::Intermediate output: +DEAL:: t =1.20000 +DEAL:: y =0.303189 (exact: 0.301194) +DEAL::Evaluating implicit function at t=1.40000 +DEAL::Evaluating implicit Jacobian at t=1.40000 +DEAL::Evaluating implicit function at t=1.40000 +DEAL::Distribute at time 1.40000 +DEAL::Prepare at time 1.40000 and step 7 +DEAL::Intermediate output: +DEAL:: t =1.40000 +DEAL:: y =0.248455 (exact: 0.246597) +DEAL::Evaluating implicit function at t=1.60000 +DEAL::Evaluating implicit Jacobian at t=1.60000 +DEAL::Evaluating implicit function at t=1.60000 +DEAL::Distribute at time 1.60000 +DEAL::Prepare at time 1.60000 and step 8 +DEAL::Intermediate output: +DEAL:: t =1.60000 +DEAL:: y =0.203127 (exact: 0.201897) +DEAL::Evaluating implicit function at t=1.80000 +DEAL::Evaluating implicit Jacobian at t=1.80000 +DEAL::Evaluating implicit function at t=1.80000 +DEAL::Distribute at time 1.80000 +DEAL::Prepare at time 1.80000 and step 9 +DEAL::Intermediate output: +DEAL:: t =1.80000 +DEAL:: y =0.165898 (exact: 0.165299) +DEAL::Evaluating implicit function at t=2.00000 +DEAL::Evaluating implicit Jacobian at t=2.00000 +DEAL::Evaluating implicit function at t=2.00000 +DEAL::Distribute at time 2.00000 +DEAL::Prepare at time 2.00000 and step 10 +DEAL::Interpolate +DEAL::Intermediate output: +DEAL:: t =2.00000 +DEAL:: y =0.135431 (exact: 0.135335) +DEAL::Evaluating implicit function at t=2.10000 +DEAL::Evaluating implicit Jacobian at t=2.10000 +DEAL::Evaluating implicit function at t=2.10000 +DEAL::Distribute at time 2.10000 +DEAL::Evaluating implicit function at t=2.20000 +DEAL::Evaluating implicit Jacobian at t=2.20000 +DEAL::Evaluating implicit function at t=2.20000 +DEAL::Distribute at time 2.20000 +DEAL::Prepare at time 2.20000 and step 11 +DEAL::Intermediate output: +DEAL:: t =2.20000 +DEAL:: y =0.111577 (exact: 0.110803) +DEAL::# Number of steps taken: 11 +DEAL::# Test user interface +DEAL::Intermediate output: +DEAL:: t =0.00000 +DEAL:: y =1.00000 (exact: 1.00000) +DEAL::Evaluating implicit function at t=0.100000 +DEAL::Setting up Jacobian at t=0.100000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=0.100000 +DEAL::Evaluating implicit function at t=0.100000 +DEAL::Distribute at time 0.100000 +DEAL::Evaluating implicit function at t=0.200000 +DEAL::Setting up Jacobian at t=0.200000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=0.200000 +DEAL::Evaluating implicit function at t=0.200000 +DEAL::Distribute at time 0.200000 +DEAL::Prepare at time 0.200000 and step 1 +DEAL::Intermediate output: +DEAL:: t =0.200000 +DEAL:: y =0.823864 (exact: 0.818731) +DEAL::Evaluating implicit function at t=0.400000 +DEAL::Setting up Jacobian at t=0.400000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=0.400000 +DEAL::Evaluating implicit function at t=0.400000 +DEAL::Distribute at time 0.400000 +DEAL::Prepare at time 0.400000 and step 2 +DEAL::Intermediate output: +DEAL:: t =0.400000 +DEAL:: y =0.675134 (exact: 0.670320) +DEAL::Evaluating implicit function at t=0.600000 +DEAL::Setting up Jacobian at t=0.600000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=0.600000 +DEAL::Evaluating implicit function at t=0.600000 +DEAL::Distribute at time 0.600000 +DEAL::Prepare at time 0.600000 and step 3 +DEAL::Intermediate output: +DEAL:: t =0.600000 +DEAL:: y =0.551962 (exact: 0.548812) +DEAL::Evaluating implicit function at t=0.800000 +DEAL::Setting up Jacobian at t=0.800000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=0.800000 +DEAL::Evaluating implicit function at t=0.800000 +DEAL::Distribute at time 0.800000 +DEAL::Prepare at time 0.800000 and step 4 +DEAL::Intermediate output: +DEAL:: t =0.800000 +DEAL:: y =0.450798 (exact: 0.449329) +DEAL::Evaluating implicit function at t=1.00000 +DEAL::Setting up Jacobian at t=1.00000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=1.00000 +DEAL::Evaluating implicit function at t=1.00000 +DEAL::Distribute at time 1.00000 +DEAL::Prepare at time 1.00000 and step 5 +DEAL::Interpolate +DEAL::Intermediate output: +DEAL:: t =1.00000 +DEAL:: y =0.368009 (exact: 0.367879) +DEAL::Evaluating implicit function at t=1.10000 +DEAL::Setting up Jacobian at t=1.10000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=1.10000 +DEAL::Evaluating implicit function at t=1.10000 +DEAL::Distribute at time 1.10000 +DEAL::Evaluating implicit function at t=1.20000 +DEAL::Setting up Jacobian at t=1.20000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=1.20000 +DEAL::Evaluating implicit function at t=1.20000 +DEAL::Distribute at time 1.20000 +DEAL::Prepare at time 1.20000 and step 6 +DEAL::Intermediate output: +DEAL:: t =1.20000 +DEAL:: y =0.303189 (exact: 0.301194) +DEAL::Evaluating implicit function at t=1.40000 +DEAL::Setting up Jacobian at t=1.40000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=1.40000 +DEAL::Evaluating implicit function at t=1.40000 +DEAL::Distribute at time 1.40000 +DEAL::Prepare at time 1.40000 and step 7 +DEAL::Intermediate output: +DEAL:: t =1.40000 +DEAL:: y =0.248455 (exact: 0.246597) +DEAL::Evaluating implicit function at t=1.60000 +DEAL::Setting up Jacobian at t=1.60000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=1.60000 +DEAL::Evaluating implicit function at t=1.60000 +DEAL::Distribute at time 1.60000 +DEAL::Prepare at time 1.60000 and step 8 +DEAL::Intermediate output: +DEAL:: t =1.60000 +DEAL:: y =0.203127 (exact: 0.201897) +DEAL::Evaluating implicit function at t=1.80000 +DEAL::Setting up Jacobian at t=1.80000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=1.80000 +DEAL::Evaluating implicit function at t=1.80000 +DEAL::Distribute at time 1.80000 +DEAL::Prepare at time 1.80000 and step 9 +DEAL::Intermediate output: +DEAL:: t =1.80000 +DEAL:: y =0.165898 (exact: 0.165299) +DEAL::Evaluating implicit function at t=2.00000 +DEAL::Setting up Jacobian at t=2.00000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=2.00000 +DEAL::Evaluating implicit function at t=2.00000 +DEAL::Distribute at time 2.00000 +DEAL::Prepare at time 2.00000 and step 10 +DEAL::Interpolate +DEAL::Intermediate output: +DEAL:: t =2.00000 +DEAL:: y =0.135431 (exact: 0.135335) +DEAL::Evaluating implicit function at t=2.10000 +DEAL::Setting up Jacobian at t=2.10000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=2.10000 +DEAL::Evaluating implicit function at t=2.10000 +DEAL::Distribute at time 2.10000 +DEAL::Evaluating implicit function at t=2.20000 +DEAL::Setting up Jacobian at t=2.20000 +DEAL::Solving with Jacobian +DEAL::Evaluating implicit function at t=2.20000 +DEAL::Evaluating implicit function at t=2.20000 +DEAL::Distribute at time 2.20000 +DEAL::Prepare at time 2.20000 and step 11 +DEAL::Intermediate output: +DEAL:: t =2.20000 +DEAL:: y =0.111577 (exact: 0.110803) +DEAL::# Number of steps taken: 11 -- 2.39.5