]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Update test and rename to constraint_linear_operator_01
authorMatthias Maier <tamiko@43-1.org>
Sat, 24 Oct 2015 17:27:04 +0000 (12:27 -0500)
committerMatthias Maier <tamiko@43-1.org>
Mon, 28 Dec 2015 11:36:24 +0000 (12:36 +0100)
tests/lac/constraint_linear_operator_01.cc [new file with mode: 0644]
tests/lac/constraint_linear_operator_01.with_cxx11=on.output [new file with mode: 0644]
tests/lac/linear_operator_09.cc [deleted file]
tests/lac/linear_operator_09.with_cxx11=on.output [deleted file]

diff --git a/tests/lac/constraint_linear_operator_01.cc b/tests/lac/constraint_linear_operator_01.cc
new file mode 100644 (file)
index 0000000..188f8ba
--- /dev/null
@@ -0,0 +1,261 @@
+// ---------------------------------------------------------------------
+//
+// Copyright (C) 2015 by the deal.II authors
+//
+// This file is part of the deal.II library.
+//
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
+// Set up a laplace problem with inhomogeneity 1 on the boundary, and run a
+// cycle with local refinement to have hanging nodes.
+//
+// This test compares the solution vector obtained by the classical method
+// of applying the constraints directly to the solution obtained by solving
+// the system:
+//   (C^T * A * C + Id_c) * x = C^t * (b - A * k)
+// with the help of constrainted_linear_operator and
+// constrained_right_hand_side
+
+#include "../tests.h"
+
+#include <deal.II/base/quadrature_lib.h>
+#include <deal.II/dofs/dof_handler.h>
+#include <deal.II/dofs/dof_tools.h>
+#include <deal.II/fe/fe_q.h>
+#include <deal.II/fe/fe_values.h>
+#include <deal.II/grid/grid_generator.h>
+#include <deal.II/grid/grid_refinement.h>
+#include <deal.II/grid/tria.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
+#include <deal.II/lac/full_matrix.h>
+#include <deal.II/lac/precondition.h>
+#include <deal.II/lac/solver_cg.h>
+#include <deal.II/lac/sparse_matrix.h>
+#include <deal.II/lac/vector.h>
+#include <deal.II/numerics/error_estimator.h>
+#include <deal.II/numerics/vector_tools.h>
+
+#include <deal.II/lac/constraint_matrix.h>
+#include <deal.II/lac/linear_operator.h>
+#include <deal.II/lac/packaged_operation.h>
+#include <deal.II/lac/constraint_linear_operator.h>
+
+#include <fstream>
+#include <iostream>
+
+using namespace dealii;
+
+template <int dim>
+class Step6
+{
+public:
+  Step6 ();
+
+  void run ();
+
+private:
+  void setup_system ();
+
+  void assemble_system ();
+
+  void solve ();
+
+  void refine_grid ();
+
+  Triangulation<dim>   triangulation;
+  FE_Q<dim>            fe;
+  DoFHandler<dim>      dof_handler;
+  ConstraintMatrix     constraints;
+
+  SparsityPattern      sparsity_pattern;
+  SparseMatrix<double> system_matrix;
+  SparseMatrix<double> system_matrix_lo;
+
+  Vector<double>       solution;
+  Vector<double>       solution_lo;
+  Vector<double>       system_rhs;
+  Vector<double>       system_rhs_lo;
+};
+
+
+template <int dim>
+Step6<dim>::Step6 ()
+  :
+  fe (2),
+  dof_handler (triangulation)
+{}
+
+
+template <int dim>
+void Step6<dim>::setup_system ()
+{
+  dof_handler.distribute_dofs (fe);
+
+  solution.reinit (dof_handler.n_dofs());
+  solution_lo.reinit (dof_handler.n_dofs());
+
+  system_rhs.reinit (dof_handler.n_dofs());
+  system_rhs_lo.reinit (dof_handler.n_dofs());
+
+  constraints.clear ();
+  DoFTools::make_hanging_node_constraints (dof_handler,
+                                           constraints);
+  VectorTools::interpolate_boundary_values (dof_handler,
+                                            0,
+                                            ConstantFunction<dim>(1.),
+                                            constraints);
+  constraints.close ();
+
+  DynamicSparsityPattern dsp(dof_handler.n_dofs());
+  DoFTools::make_sparsity_pattern(dof_handler, dsp, constraints);
+  sparsity_pattern.copy_from(dsp);
+
+  system_matrix.reinit (sparsity_pattern);
+  system_matrix_lo.reinit (sparsity_pattern);
+}
+
+
+template <int dim>
+void Step6<dim>::assemble_system ()
+{
+  const QGauss<dim> quadrature_formula(3);
+
+  FEValues<dim> fe_values (fe, quadrature_formula,
+                           update_values |  update_gradients |
+                           update_quadrature_points  |  update_JxW_values);
+
+  const unsigned int dofs_per_cell = fe.dofs_per_cell;
+  const unsigned int n_q_points    = quadrature_formula.size();
+
+  FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
+  Vector<double> cell_rhs (dofs_per_cell);
+
+  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
+
+  typename DoFHandler<dim>::active_cell_iterator
+  cell = dof_handler.begin_active(),
+  endc = dof_handler.end();
+  for (; cell!=endc; ++cell)
+    {
+      cell_matrix = 0;
+      cell_rhs = 0;
+
+      fe_values.reinit (cell);
+
+      for (unsigned int q_index=0; q_index<n_q_points; ++q_index)
+        for (unsigned int i=0; i<dofs_per_cell; ++i)
+          {
+            for (unsigned int j=0; j<dofs_per_cell; ++j)
+              cell_matrix(i,j) += (fe_values.shape_grad(i,q_index) *
+                                   fe_values.shape_grad(j,q_index) *
+                                   fe_values.JxW(q_index));
+
+            cell_rhs(i) += (fe_values.shape_value(i,q_index) *
+                            1.0 *
+                            fe_values.JxW(q_index));
+          }
+
+      cell->get_dof_indices (local_dof_indices);
+      constraints.distribute_local_to_global (cell_matrix,
+                                              cell_rhs,
+                                              local_dof_indices,
+                                              system_matrix,
+                                              system_rhs);
+      cell->distribute_local_to_global(cell_matrix, system_matrix_lo);
+      cell->distribute_local_to_global(cell_rhs, system_rhs_lo);
+    }
+}
+
+
+template <int dim>
+void Step6<dim>::solve ()
+{
+  SolverControl      solver_control (1000, 1e-8);
+  SolverCG<>         solver (solver_control);
+
+  PreconditionSSOR<> preconditioner;
+  preconditioner.initialize(system_matrix, 1.2);
+
+  check_solver_within_range(
+    solver.solve(system_matrix, solution, system_rhs, preconditioner),
+    solver_control.last_step(),
+    10,
+    60);
+  constraints.distribute (solution);
+
+  const auto A = linear_operator(system_matrix_lo);
+  const auto M = constrained_linear_operator(constraints, A);
+  Vector<double> rhs =
+    constrained_right_hand_side(constraints, A, system_rhs_lo);
+
+  check_solver_within_range(
+    solver.solve(M, solution_lo, rhs, preconditioner),
+    solver_control.last_step(),
+    10,
+    60);
+  constraints.distribute(solution_lo);
+}
+
+
+template <int dim>
+void Step6<dim>::refine_grid ()
+{
+  Vector<float> estimated_error_per_cell (triangulation.n_active_cells());
+
+  KellyErrorEstimator<dim>::estimate (dof_handler,
+                                      QGauss<dim-1>(3),
+                                      typename FunctionMap<dim>::type(),
+                                      solution,
+                                      estimated_error_per_cell);
+
+  GridRefinement::refine_and_coarsen_fixed_number (triangulation,
+                                                   estimated_error_per_cell,
+                                                   0.3, 0.03);
+
+  triangulation.execute_coarsening_and_refinement ();
+}
+
+
+template <int dim>
+void Step6<dim>::run ()
+{
+  for (unsigned int cycle=0; cycle<3; ++cycle)
+    {
+      if (cycle == 0)
+        {
+          GridGenerator::hyper_cube(triangulation);
+          triangulation.refine_global(3);
+        }
+      else
+        refine_grid();
+
+      setup_system();
+      assemble_system();
+      solve();
+
+      Vector<double> diff = solution - solution_lo;
+      if (diff.l2_norm() < 1e-10)
+        deallog << "OK" << std::endl;
+      else
+        deallog << "ERROR! Output does not match!" << std::endl;
+    }
+}
+
+
+int main()
+{
+  initlog();
+  deallog << std::setprecision(10);
+
+  Step6<2> laplace_problem_2d;
+  laplace_problem_2d.run ();
+
+  return 0;
+}
diff --git a/tests/lac/constraint_linear_operator_01.with_cxx11=on.output b/tests/lac/constraint_linear_operator_01.with_cxx11=on.output
new file mode 100644 (file)
index 0000000..30e009e
--- /dev/null
@@ -0,0 +1,10 @@
+
+DEAL::Solver stopped within 10 - 60 iterations
+DEAL::Solver stopped within 10 - 60 iterations
+DEAL::OK
+DEAL::Solver stopped within 10 - 60 iterations
+DEAL::Solver stopped within 10 - 60 iterations
+DEAL::OK
+DEAL::Solver stopped within 10 - 60 iterations
+DEAL::Solver stopped within 10 - 60 iterations
+DEAL::OK
diff --git a/tests/lac/linear_operator_09.cc b/tests/lac/linear_operator_09.cc
deleted file mode 100644 (file)
index 6369b81..0000000
+++ /dev/null
@@ -1,482 +0,0 @@
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2015 by the deal.II authors
-//
-// This file is part of the deal.II library.
-//
-// The deal.II library is free software; you can use it, redistribute
-// it, and/or modify it under the terms of the GNU Lesser General
-// Public License as published by the Free Software Foundation; either
-// version 2.1 of the License, or (at your option) any later version.
-// The full text of the license can be found in the file LICENSE at
-// the top level of the deal.II distribution.
-//
-// ---------------------------------------------------------------------
-
-// This test is based on step-6
-// The aim is to test constrained linear operators
-// and compare them to the old implementation.
-
-#include "../tests.h"
-
-#include <deal.II/base/quadrature_lib.h>
-#include <deal.II/base/function.h>
-#include <deal.II/base/logstream.h>
-
-#include <deal.II/base/timer.h>
-
-#include <deal.II/lac/vector.h>
-#include <deal.II/lac/full_matrix.h>
-#include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/dynamic_sparsity_pattern.h>
-#include <deal.II/lac/solver_cg.h>
-#include <deal.II/lac/solver_gmres.h>
-#include <deal.II/lac/precondition.h>
-#include <deal.II/grid/tria.h>
-#include <deal.II/dofs/dof_handler.h>
-#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/tria_accessor.h>
-#include <deal.II/grid/tria_iterator.h>
-#include <deal.II/grid/manifold_lib.h>
-#include <deal.II/dofs/dof_accessor.h>
-#include <deal.II/dofs/dof_tools.h>
-#include <deal.II/fe/fe_values.h>
-#include <deal.II/numerics/vector_tools.h>
-#include <deal.II/numerics/matrix_tools.h>
-#include <fstream>
-#include <iostream>
-#include <deal.II/fe/fe_q.h>
-#include <deal.II/grid/grid_out.h>
-#include <deal.II/lac/constraint_matrix.h>
-#include <deal.II/lac/linear_operator.h>
-#include <deal.II/lac/packaged_operation.h>
-#include <deal.II/grid/grid_refinement.h>
-#include <deal.II/numerics/error_estimator.h>
-
-using namespace dealii;
-
-template <int dim>
-class Step6
-{
-public:
-  Step6 ();
-  ~Step6 ();
-
-  void run ();
-
-private:
-  void setup_system ();
-
-  void assemble_system ();
-  void assemble_system_lo ();
-
-  void solve ();
-  void solve_lo ();
-
-  void refine_grid ();
-
-  Triangulation<dim>   triangulation;
-  Triangulation<dim>   triangulation_lo;
-
-  DoFHandler<dim>      dof_handler;
-  DoFHandler<dim>      dof_handler_lo;
-
-  FE_Q<dim>            fe;
-  FE_Q<dim>            fe_lo;
-
-  ConstraintMatrix     constraints;
-  ConstraintMatrix     constraints_lo;
-
-  SparsityPattern      sparsity_pattern;
-  SparsityPattern      sparsity_pattern_lo;
-
-  SparseMatrix<double> system_matrix;
-  SparseMatrix<double> system_matrix_lo;
-
-  Vector<double>       solution;
-  Vector<double>       solution_lo;
-
-  Vector<double>       system_rhs;
-  Vector<double>       system_rhs_lo;
-};
-
-
-
-
-template <int dim>
-class Coefficient : public Function<dim>
-{
-public:
-  Coefficient () : Function<dim>() {}
-
-  virtual double value (const Point<dim>   &p,
-                        const unsigned int  component = 0) const;
-
-  virtual void value_list (const std::vector<Point<dim> > &points,
-                           std::vector<double>            &values,
-                           const unsigned int              component = 0) const;
-};
-
-
-
-template <int dim>
-double Coefficient<dim>::value (const Point<dim> &p,
-                                const unsigned int) const
-{
-  if (p.square() < 0.5*0.5)
-    return 20;
-  else
-    return 1;
-}
-
-
-
-template <int dim>
-void Coefficient<dim>::value_list (const std::vector<Point<dim> > &points,
-                                   std::vector<double>            &values,
-                                   const unsigned int              component) const
-{
-  const unsigned int n_points = points.size();
-
-  Assert (values.size() == n_points,
-          ExcDimensionMismatch (values.size(), n_points));
-
-  Assert (component == 0,
-          ExcIndexRange (component, 0, 1));
-
-  for (unsigned int i=0; i<n_points; ++i)
-    {
-      if (points[i].square() < 0.5*0.5)
-        values[i] = 20;
-      else
-        values[i] = 1;
-    }
-}
-
-template <int dim>
-Step6<dim>::Step6 ()
-  :
-  dof_handler (triangulation),
-  dof_handler_lo (triangulation_lo),
-  fe (2),
-  fe_lo (2)
-{}
-
-template <int dim>
-Step6<dim>::~Step6 ()
-{
-  dof_handler.clear ();
-}
-
-
-
-template <int dim>
-void Step6<dim>::setup_system ()
-{
-  dof_handler.distribute_dofs (fe);
-
-  solution.reinit (dof_handler.n_dofs());
-  solution_lo.reinit (dof_handler.n_dofs());
-
-  system_rhs.reinit (dof_handler.n_dofs());
-  system_rhs_lo.reinit (dof_handler.n_dofs());
-
-  constraints.clear ();
-  DoFTools::make_hanging_node_constraints (dof_handler,
-                                           constraints);
-
-
-  VectorTools::interpolate_boundary_values (dof_handler,
-                                            0,
-                                            ConstantFunction<dim>(1.),
-                                            constraints);
-
-
-  constraints.close ();
-
-  DynamicSparsityPattern dsp(dof_handler.n_dofs());
-  DoFTools::make_sparsity_pattern(dof_handler,
-                                  dsp,
-                                  constraints,
-                                  /*keep_constrained_dofs = */ false);
-
-  sparsity_pattern.copy_from(dsp);
-
-  system_matrix.reinit (sparsity_pattern);
-
-  constraints_lo.clear ();
-  constraints_lo.close ();
-
-  DynamicSparsityPattern dsp_lo(dof_handler.n_dofs());
-  DoFTools::make_sparsity_pattern(dof_handler,
-                                  dsp_lo,
-                                  constraints_lo,
-                                  /*keep_constrained_dofs = */ false);
-
-  sparsity_pattern_lo.copy_from(dsp_lo);
-
-  system_matrix_lo.reinit (sparsity_pattern_lo);
-}
-
-
-
-template <int dim>
-void Step6<dim>::assemble_system ()
-{
-  const QGauss<dim>  quadrature_formula(3);
-
-  FEValues<dim> fe_values (fe, quadrature_formula,
-                           update_values    |  update_gradients |
-                           update_quadrature_points  |  update_JxW_values);
-
-  const unsigned int   dofs_per_cell = fe.dofs_per_cell;
-  const unsigned int   n_q_points    = quadrature_formula.size();
-
-  FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
-  Vector<double>       cell_rhs (dofs_per_cell);
-
-  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
-
-  const Coefficient<dim> coefficient;
-  std::vector<double>    coefficient_values (n_q_points);
-
-  typename DoFHandler<dim>::active_cell_iterator
-  cell = dof_handler.begin_active(),
-  endc = dof_handler.end();
-  for (; cell!=endc; ++cell)
-    {
-      cell_matrix = 0;
-      cell_rhs = 0;
-
-      fe_values.reinit (cell);
-
-      coefficient.value_list (fe_values.get_quadrature_points(),
-                              coefficient_values);
-
-      for (unsigned int q_index=0; q_index<n_q_points; ++q_index)
-        for (unsigned int i=0; i<dofs_per_cell; ++i)
-          {
-            for (unsigned int j=0; j<dofs_per_cell; ++j)
-              cell_matrix(i,j) += (coefficient_values[q_index] *
-                                   fe_values.shape_grad(i,q_index) *
-                                   fe_values.shape_grad(j,q_index) *
-                                   fe_values.JxW(q_index));
-
-            cell_rhs(i) += (fe_values.shape_value(i,q_index) *
-                            1.0 *
-                            fe_values.JxW(q_index));
-          }
-
-      cell->get_dof_indices (local_dof_indices);
-      constraints.distribute_local_to_global (cell_matrix,
-                                              cell_rhs,
-                                              local_dof_indices,
-                                              system_matrix,
-                                              system_rhs);
-    }
-}
-
-template <int dim>
-void Step6<dim>::assemble_system_lo ()
-{
-  const QGauss<dim>  quadrature_formula(3);
-
-  FEValues<dim> fe_values (fe, quadrature_formula,
-                           update_values    |  update_gradients |
-                           update_quadrature_points  |  update_JxW_values);
-
-  const unsigned int   dofs_per_cell = fe.dofs_per_cell;
-  const unsigned int   n_q_points    = quadrature_formula.size();
-
-  FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
-  Vector<double>       cell_rhs (dofs_per_cell);
-
-  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
-
-  const Coefficient<dim> coefficient;
-  std::vector<double>    coefficient_values (n_q_points);
-
-  typename DoFHandler<dim>::active_cell_iterator
-  cell = dof_handler.begin_active(),
-  endc = dof_handler.end();
-  for (; cell!=endc; ++cell)
-    {
-      cell_matrix = 0;
-      cell_rhs = 0;
-
-      fe_values.reinit (cell);
-
-      coefficient.value_list (fe_values.get_quadrature_points(),
-                              coefficient_values);
-
-      for (unsigned int q_index=0; q_index<n_q_points; ++q_index)
-        for (unsigned int i=0; i<dofs_per_cell; ++i)
-          {
-            for (unsigned int j=0; j<dofs_per_cell; ++j)
-              cell_matrix(i,j) +=  (coefficient_values[q_index] *
-                                    fe_values.shape_grad(i,q_index) *
-                                    fe_values.shape_grad(j,q_index) *
-                                    fe_values.JxW(q_index));
-
-            cell_rhs(i) += (fe_values.shape_value(i,q_index) *
-                            1.0 *
-                            fe_values.JxW(q_index));
-          }
-
-      cell->get_dof_indices (local_dof_indices);
-      constraints_lo.distribute_local_to_global (cell_matrix,
-                                                 cell_rhs,
-                                                 local_dof_indices,
-                                                 system_matrix_lo,
-                                                 system_rhs_lo);
-    }
-
-}
-
-
-template <int dim>
-void Step6<dim>::solve ()
-{
-  // constraints.condense(system_matrix, system_rhs);
-  unsigned int n_iterations = 0;
-  auto M = linear_operator(system_matrix);
-
-  SolverControl      solver_control (10000, 1e-12);
-  SolverCG<>         solver (solver_control);
-
-  PreconditionSSOR<> preconditioner;
-  preconditioner.initialize(system_matrix, 1.2);
-
-  auto M_inv = inverse_operator(  M,
-                                  solver,
-                                  preconditioner);
-
-
-
-  M_inv.vmult(solution, system_rhs);
-  n_iterations = solver_control.last_step();
-  constraints.distribute (solution);
-}
-
-
-template <int dim>
-void Step6<dim>::solve_lo ()
-{
-  unsigned int n_iterations = 0;
-
-  auto new_system_rhs_lo = constrained_rhs< >(
-                             constraints, system_matrix_lo, system_rhs_lo);;
-  auto M = constrained_linear_operator< >( constraints, system_matrix_lo );
-
-  SolverControl      solver_control (10000, 1e-12);
-  SolverCG<>         solver (solver_control);
-
-  PreconditionSSOR<> preconditioner;
-  preconditioner.initialize(system_matrix, 1.2);
-
-  auto M_inv = inverse_operator(  M,
-                                  solver,
-                                  preconditioner);
-
-  M_inv.vmult(solution_lo, new_system_rhs_lo);
-  n_iterations = solver_control.last_step();
-
-  constraints.distribute(solution_lo);
-}
-
-
-
-template <int dim>
-void Step6<dim>::refine_grid ()
-{
-  Vector<float> estimated_error_per_cell (triangulation.n_active_cells());
-
-  KellyErrorEstimator<dim>::estimate (dof_handler,
-                                      QGauss<dim-1>(3),
-                                      typename FunctionMap<dim>::type(),
-                                      solution,
-                                      estimated_error_per_cell);
-
-  GridRefinement::refine_and_coarsen_fixed_number (triangulation,
-                                                   estimated_error_per_cell,
-                                                   0.3, 0.03);
-
-  triangulation.execute_coarsening_and_refinement ();
-}
-
-template <int dim>
-void Step6<dim>::run ()
-{
-  for (unsigned int cycle=0; cycle<3; ++cycle)
-    {
-      if (cycle == 0)
-        {
-          GridGenerator::hyper_ball (triangulation);
-
-          static const SphericalManifold<dim> boundary;
-          triangulation.set_all_manifold_ids_on_boundary(0);
-          triangulation.set_manifold (0, boundary);
-
-          triangulation.refine_global (1);
-        }
-      else
-        refine_grid ();
-
-      setup_system ();
-
-      assemble_system ();
-      solve ();
-
-      assemble_system_lo ();
-      solve_lo ();
-
-      // auto rhs_tmp = system_rhs;
-      // new_system_rhs_lo.apply(rhs_tmp);
-      // compare_solution(system_rhs, rhs_tmp, dof_handler.n_dofs(), 1e-6, false, false, "RHS");
-      Vector<double> diff = solution-solution_lo;
-      if (diff.l2_norm() < 1e-10)
-        deallog << "OK" << std::endl;
-    }
-}
-
-int main()
-{
-  initlog();
-  deallog << std::setprecision(10);
-
-  {
-    try
-      {
-        Step6<2> laplace_problem_2d;
-        laplace_problem_2d.run ();
-      }
-    catch (std::exception &exc)
-      {
-        std::cerr << std::endl << std::endl
-                  << "----------------------------------------------------"
-                  << std::endl;
-        std::cerr << "Exception on processing: " << std::endl
-                  << exc.what() << std::endl
-                  << "Aborting!" << std::endl
-                  << "----------------------------------------------------"
-                  << std::endl;
-
-        return 1;
-      }
-    catch (...)
-      {
-        std::cerr << std::endl << std::endl
-                  << "----------------------------------------------------"
-                  << std::endl;
-        std::cerr << "Unknown exception!" << std::endl
-                  << "Aborting!" << std::endl
-                  << "----------------------------------------------------"
-                  << std::endl;
-        return 1;
-      }
-
-    return 0;
-
-    deallog << "OK" << std::endl;
-  }
-}
diff --git a/tests/lac/linear_operator_09.with_cxx11=on.output b/tests/lac/linear_operator_09.with_cxx11=on.output
deleted file mode 100644 (file)
index 80feeb7..0000000
+++ /dev/null
@@ -1,16 +0,0 @@
-
-DEAL:cg::Starting value 13.25516422
-DEAL:cg::Convergence step 24 value 1.400407060e-13
-DEAL:cg::Starting value 13.25516422
-DEAL:cg::Convergence step 24 value 1.399854635e-13
-DEAL::OK
-DEAL:cg::Starting value 17.40605136
-DEAL:cg::Convergence step 33 value 3.786179069e-13
-DEAL:cg::Starting value 17.40605136
-DEAL:cg::Convergence step 33 value 3.789771041e-13
-DEAL::OK
-DEAL:cg::Starting value 17.40587637
-DEAL:cg::Convergence step 56 value 4.293614863e-13
-DEAL:cg::Starting value 17.40587637
-DEAL:cg::Convergence step 56 value 4.295516840e-13
-DEAL::OK

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.