]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Test on a curved geometry.
authorMartin Kronbichler <kronbichler@lnm.mw.tum.de>
Mon, 28 May 2018 16:52:45 +0000 (18:52 +0200)
committerMartin Kronbichler <kronbichler@lnm.mw.tum.de>
Tue, 29 May 2018 07:06:09 +0000 (09:06 +0200)
tests/grid/find_all_active_cells_around_point_02.cc [new file with mode: 0644]
tests/grid/find_all_active_cells_around_point_02.output [new file with mode: 0644]

diff --git a/tests/grid/find_all_active_cells_around_point_02.cc b/tests/grid/find_all_active_cells_around_point_02.cc
new file mode 100644 (file)
index 0000000..544c919
--- /dev/null
@@ -0,0 +1,173 @@
+// ---------------------------------------------------------------------
+//
+// Copyright (C) 2017 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.
+//
+// ---------------------------------------------------------------------
+
+
+// find_all_active_cells_around_point for a deformed shell mesh
+
+#include <deal.II/base/logstream.h>
+#include <deal.II/base/utilities.h>
+
+#include <deal.II/fe/mapping_q_generic.h>
+
+#include <deal.II/grid/grid_generator.h>
+#include <deal.II/grid/grid_tools.h>
+
+#include "../tests.h"
+
+
+
+template <int dim, int spacedim>
+void
+print_result(const Mapping<dim, spacedim> &      mapping,
+             const Triangulation<dim, spacedim> &tria,
+             const Point<dim>                    p,
+             const double                        tolerance)
+{
+  deallog << "Testing " << dim << "D with point " << p << " tolerance "
+          << tolerance << std::endl;
+  auto c_p =
+    GridTools::find_all_active_cells_around_point(mapping, tria, p, tolerance);
+  for (auto i : c_p)
+    deallog << "Cell: " << i.first->id() << " unit point " << i.second
+            << std::endl;
+  deallog << std::endl;
+}
+
+
+
+template <int dim, int spacedim>
+void
+test(unsigned int n_ref)
+{
+  Triangulation<dim, spacedim> tria;
+  GridGenerator::hyper_shell(tria, Point<dim>(), 0.8, 1., dim == 2 ? 3 : 6);
+  tria.refine_global(n_ref);
+  MappingQGeneric<dim, spacedim> mapping(8);
+
+  {
+    const double phi   = 0.;
+    const double theta = 0.5 * numbers::PI;
+    for (unsigned int i = 0; i <= 4; ++i)
+      {
+        const double r = 0.8 + 0.2 * i / 4;
+        Point<dim>   p;
+        p[0] = std::cos(phi) * std::sin(theta) * r;
+        p[1] = std::sin(phi) * std::sin(theta) * r;
+        if (dim == 3)
+          p[2] = std::cos(theta) * r;
+        print_result(mapping, tria, p, 1e-8);
+      }
+  }
+  {
+    const double phi   = 0.25 * numbers::PI;
+    const double theta = 0.5 * numbers::PI;
+    for (unsigned int i = 0; i <= 4; ++i)
+      {
+        const double r = 0.8 + 0.2 * i / 4;
+        Point<dim>   p;
+        p[0] = std::cos(phi) * std::sin(theta) * r;
+        p[1] = std::sin(phi) * std::sin(theta) * r;
+        if (dim == 3)
+          p[2] = std::cos(theta) * r;
+        print_result(mapping, tria, p, 1e-8);
+      }
+  }
+  {
+    const double phi   = 0.3 * numbers::PI;
+    const double theta = 0.5 * numbers::PI;
+    for (unsigned int i = 0; i <= 4; ++i)
+      {
+        const double r = 0.8 + 0.2 * i / 4;
+        Point<dim>   p;
+        p[0] = std::cos(phi) * std::sin(theta) * r;
+        p[1] = std::sin(phi) * std::sin(theta) * r;
+        if (dim == 3)
+          p[2] = std::cos(theta) * r;
+        print_result(mapping, tria, p, 1e-8);
+      }
+  }
+  {
+    const double phi   = 0.5 * numbers::PI;
+    const double theta = 0.5 * numbers::PI;
+    for (unsigned int i = 0; i <= 4; ++i)
+      {
+        const double r = 0.8 + 0.2 * i / 4;
+        Point<dim>   p;
+        p[0] = std::cos(phi) * std::sin(theta) * r;
+        p[1] = std::sin(phi) * std::sin(theta) * r;
+        if (dim == 3)
+          p[2] = std::cos(theta) * r;
+        print_result(mapping, tria, p, 1e-8);
+      }
+  }
+  {
+    const double phi   = 0.75 * numbers::PI;
+    const double theta = 0.5 * numbers::PI;
+    for (unsigned int i = 0; i <= 4; ++i)
+      {
+        const double r = 0.8 + 0.2 * i / 4;
+        Point<dim>   p;
+        p[0] = std::cos(phi) * std::sin(theta) * r;
+        p[1] = std::sin(phi) * std::sin(theta) * r;
+        if (dim == 3)
+          p[2] = std::cos(theta) * r;
+        print_result(mapping, tria, p, 1e-8);
+      }
+  }
+  if (dim == 3)
+    {
+      const double phi   = 0.75 * numbers::PI;
+      const double theta = 0.;
+      for (unsigned int i = 0; i <= 4; ++i)
+        {
+          const double r = 0.8 + 0.2 * i / 4;
+          Point<dim>   p;
+          p[0] = std::cos(phi) * std::sin(theta) * r;
+          p[1] = std::sin(phi) * std::sin(theta) * r;
+          if (dim == 3)
+            p[2] = std::cos(theta) * r;
+          print_result(mapping, tria, p, 1e-8);
+        }
+    }
+  if (dim == 3)
+    {
+      const double phi   = 0.3 * numbers::PI;
+      const double theta = 0.1;
+      for (unsigned int i = 0; i <= 6; ++i)
+        {
+          const double r = 0.8 + 0.2 * i / 6;
+          Point<dim>   p;
+          p[0] = std::cos(phi) * std::sin(theta) * r;
+          p[1] = std::sin(phi) * std::sin(theta) * r;
+          if (dim == 3)
+            p[2] = std::cos(theta) * r;
+          print_result(mapping, tria, p, 1e-8);
+        }
+    }
+}
+
+
+
+int
+main()
+{
+  initlog();
+  deallog << std::setprecision(10);
+
+  test<2, 2>(1);
+  test<2, 2>(2);
+  test<3, 3>(1);
+  test<3, 3>(2);
+}
diff --git a/tests/grid/find_all_active_cells_around_point_02.output b/tests/grid/find_all_active_cells_around_point_02.output
new file mode 100644 (file)
index 0000000..f5c3ab0
--- /dev/null
@@ -0,0 +1,665 @@
+
+DEAL::Testing 2D with point 0.8000000000 0.000000000 tolerance 1.000000000e-08
+DEAL::Cell: 0_1:2 unit point 2.616041405e-20 1.000000000
+DEAL::Cell: 2_1:3 unit point 1.000000000 1.000000000
+DEAL::
+DEAL::Testing 2D with point 0.8500000000 0.000000000 tolerance 1.000000000e-08
+DEAL::Cell: 0_1:2 unit point 0.000000000 0.5000000000
+DEAL::Cell: 2_1:3 unit point 1.000000000 0.5000000000
+DEAL::
+DEAL::Testing 2D with point 0.9000000000 0.000000000 tolerance 1.000000000e-08
+DEAL::Cell: 0_1:0 unit point 7.694434058e-21 1.000000000
+DEAL::Cell: 0_1:2 unit point 0.000000000 5.412337245e-16
+DEAL::Cell: 2_1:1 unit point 1.000000000 1.000000000
+DEAL::Cell: 2_1:3 unit point 1.000000000 0.000000000
+DEAL::
+DEAL::Testing 2D with point 0.9500000000 0.000000000 tolerance 1.000000000e-08
+DEAL::Cell: 0_1:0 unit point 0.000000000 0.5000000000
+DEAL::Cell: 2_1:1 unit point 1.000000000 0.5000000000
+DEAL::
+DEAL::Testing 2D with point 1.000000000 0.000000000 tolerance 1.000000000e-08
+DEAL::Cell: 0_1:0 unit point 0.000000000 0.000000000
+DEAL::Cell: 2_1:1 unit point 1.000000000 1.776356839e-15
+DEAL::
+DEAL::Testing 2D with point 0.5656854249 0.5656854249 tolerance 1.000000000e-08
+DEAL::Cell: 0_1:2 unit point 0.7500000000 1.000000000
+DEAL::
+DEAL::Testing 2D with point 0.6010407640 0.6010407640 tolerance 1.000000000e-08
+DEAL::Cell: 0_1:2 unit point 0.7500000000 0.5000000001
+DEAL::
+DEAL::Testing 2D with point 0.6363961031 0.6363961031 tolerance 1.000000000e-08
+DEAL::Cell: 0_1:0 unit point 0.7500000000 1.000000000
+DEAL::Cell: 0_1:2 unit point 0.7500000000 8.799456528e-11
+DEAL::
+DEAL::Testing 2D with point 0.6717514421 0.6717514421 tolerance 1.000000000e-08
+DEAL::Cell: 0_1:0 unit point 0.7500000000 0.5000000001
+DEAL::
+DEAL::Testing 2D with point 0.7071067812 0.7071067812 tolerance 1.000000000e-08
+DEAL::Cell: 0_1:0 unit point 0.7500000000 9.776992135e-11
+DEAL::
+DEAL::Testing 2D with point 0.4702282018 0.6472135955 tolerance 1.000000000e-08
+DEAL::Cell: 0_1:2 unit point 0.9000000000 0.9999999999
+DEAL::
+DEAL::Testing 2D with point 0.4996174644 0.6876644452 tolerance 1.000000000e-08
+DEAL::Cell: 0_1:2 unit point 0.9000000000 0.4999999999
+DEAL::
+DEAL::Testing 2D with point 0.5290067271 0.7281152949 tolerance 1.000000000e-08
+DEAL::Cell: 0_1:0 unit point 0.9000000000 0.9999999999
+DEAL::Cell: 0_1:2 unit point 0.9000000000 -1.207502519e-10
+DEAL::
+DEAL::Testing 2D with point 0.5583959897 0.7685661447 tolerance 1.000000000e-08
+DEAL::Cell: 0_1:0 unit point 0.9000000000 0.4999999999
+DEAL::
+DEAL::Testing 2D with point 0.5877852523 0.8090169944 tolerance 1.000000000e-08
+DEAL::Cell: 0_1:0 unit point 0.9000000000 -1.341805763e-10
+DEAL::
+DEAL::Testing 2D with point 4.898587197e-17 0.8000000000 tolerance 1.000000000e-08
+DEAL::Cell: 0_1:3 unit point 0.5000000000 1.000000000
+DEAL::
+DEAL::Testing 2D with point 5.204748896e-17 0.8500000000 tolerance 1.000000000e-08
+DEAL::Cell: 0_1:3 unit point 0.5000000000 0.5000000000
+DEAL::
+DEAL::Testing 2D with point 5.510910596e-17 0.9000000000 tolerance 1.000000000e-08
+DEAL::Cell: 0_1:1 unit point 0.5000000000 1.000000000
+DEAL::Cell: 0_1:3 unit point 0.5000000000 0.000000000
+DEAL::
+DEAL::Testing 2D with point 5.817072296e-17 0.9500000000 tolerance 1.000000000e-08
+DEAL::Cell: 0_1:1 unit point 0.5000000000 0.5000000000
+DEAL::
+DEAL::Testing 2D with point 6.123233996e-17 1.000000000 tolerance 1.000000000e-08
+DEAL::Cell: 0_1:1 unit point 0.5000000000 0.000000000
+DEAL::
+DEAL::Testing 2D with point -0.5656854249 0.5656854249 tolerance 1.000000000e-08
+DEAL::Cell: 1_1:2 unit point 0.2500000000 1.000000000
+DEAL::
+DEAL::Testing 2D with point -0.6010407640 0.6010407640 tolerance 1.000000000e-08
+DEAL::Cell: 1_1:2 unit point 0.2500000000 0.5000000001
+DEAL::
+DEAL::Testing 2D with point -0.6363961031 0.6363961031 tolerance 1.000000000e-08
+DEAL::Cell: 1_1:0 unit point 0.2500000000 1.000000000
+DEAL::Cell: 1_1:2 unit point 0.2500000000 8.799198560e-11
+DEAL::
+DEAL::Testing 2D with point -0.6717514421 0.6717514421 tolerance 1.000000000e-08
+DEAL::Cell: 1_1:0 unit point 0.2500000000 0.5000000001
+DEAL::
+DEAL::Testing 2D with point -0.7071067812 0.7071067812 tolerance 1.000000000e-08
+DEAL::Cell: 1_1:0 unit point 0.2500000000 9.776801047e-11
+DEAL::
+DEAL::Testing 2D with point 0.8000000000 0.000000000 tolerance 1.000000000e-08
+DEAL::Cell: 0_2:22 unit point -5.001540070e-12 1.000000000
+DEAL::Cell: 2_2:33 unit point 1.000000000 1.000000000
+DEAL::
+DEAL::Testing 2D with point 0.8500000000 0.000000000 tolerance 1.000000000e-08
+DEAL::Cell: 0_2:20 unit point -3.726766057e-12 1.000000000
+DEAL::Cell: 0_2:22 unit point 0.000000000 0.000000000
+DEAL::Cell: 2_2:31 unit point 1.000000000 1.000000000
+DEAL::Cell: 2_2:33 unit point 1.000000000 0.000000000
+DEAL::
+DEAL::Testing 2D with point 0.9000000000 0.000000000 tolerance 1.000000000e-08
+DEAL::Cell: 0_2:02 unit point -2.822687562e-12 1.000000000
+DEAL::Cell: 0_2:20 unit point 0.000000000 1.387778781e-15
+DEAL::Cell: 2_2:13 unit point 1.000000000 1.000000000
+DEAL::Cell: 2_2:31 unit point 1.000000000 8.881784197e-16
+DEAL::
+DEAL::Testing 2D with point 0.9500000000 0.000000000 tolerance 1.000000000e-08
+DEAL::Cell: 0_2:00 unit point -2.169439844e-12 1.000000000
+DEAL::Cell: 0_2:02 unit point 0.000000000 0.000000000
+DEAL::Cell: 2_2:11 unit point 1.000000000 1.000000000
+DEAL::Cell: 2_2:13 unit point 1.000000000 0.000000000
+DEAL::
+DEAL::Testing 2D with point 1.000000000 0.000000000 tolerance 1.000000000e-08
+DEAL::Cell: 0_2:00 unit point 0.000000000 0.000000000
+DEAL::Cell: 2_2:11 unit point 1.000000000 8.881784197e-16
+DEAL::
+DEAL::Testing 2D with point 0.5656854249 0.5656854249 tolerance 1.000000000e-08
+DEAL::Cell: 0_2:23 unit point 0.5000000000 1.000000000
+DEAL::
+DEAL::Testing 2D with point 0.6010407640 0.6010407640 tolerance 1.000000000e-08
+DEAL::Cell: 0_2:21 unit point 0.5000000000 1.000000000
+DEAL::Cell: 0_2:23 unit point 0.5000000000 0.000000000
+DEAL::
+DEAL::Testing 2D with point 0.6363961031 0.6363961031 tolerance 1.000000000e-08
+DEAL::Cell: 0_2:03 unit point 0.5000000000 1.000000000
+DEAL::Cell: 0_2:21 unit point 0.5000000000 0.000000000
+DEAL::
+DEAL::Testing 2D with point 0.6717514421 0.6717514421 tolerance 1.000000000e-08
+DEAL::Cell: 0_2:01 unit point 0.5000000000 1.000000000
+DEAL::Cell: 0_2:03 unit point 0.5000000000 0.000000000
+DEAL::
+DEAL::Testing 2D with point 0.7071067812 0.7071067812 tolerance 1.000000000e-08
+DEAL::Cell: 0_2:01 unit point 0.5000000000 0.000000000
+DEAL::
+DEAL::Testing 2D with point 0.4702282018 0.6472135955 tolerance 1.000000000e-08
+DEAL::Cell: 0_2:23 unit point 0.8000000000 1.000000000
+DEAL::
+DEAL::Testing 2D with point 0.4996174644 0.6876644452 tolerance 1.000000000e-08
+DEAL::Cell: 0_2:21 unit point 0.8000000000 1.000000000
+DEAL::Cell: 0_2:23 unit point 0.8000000000 1.575023206e-13
+DEAL::
+DEAL::Testing 2D with point 0.5290067271 0.7281152949 tolerance 1.000000000e-08
+DEAL::Cell: 0_2:03 unit point 0.8000000000 1.000000000
+DEAL::Cell: 0_2:21 unit point 0.8000000000 1.655683511e-13
+DEAL::
+DEAL::Testing 2D with point 0.5583959897 0.7685661447 tolerance 1.000000000e-08
+DEAL::Cell: 0_2:01 unit point 0.8000000000 1.000000000
+DEAL::Cell: 0_2:03 unit point 0.8000000000 1.728132611e-13
+DEAL::
+DEAL::Testing 2D with point 0.5877852523 0.8090169944 tolerance 1.000000000e-08
+DEAL::Cell: 0_2:01 unit point 0.8000000000 1.841740194e-13
+DEAL::
+DEAL::Testing 2D with point 4.898587197e-17 0.8000000000 tolerance 1.000000000e-08
+DEAL::Cell: 0_2:32 unit point 1.000000000 1.000000000
+DEAL::Cell: 0_2:33 unit point -5.001444986e-12 1.000000000
+DEAL::
+DEAL::Testing 2D with point 5.204748896e-17 0.8500000000 tolerance 1.000000000e-08
+DEAL::Cell: 0_2:30 unit point 1.000000000 1.000000000
+DEAL::Cell: 0_2:31 unit point -3.726341960e-12 1.000000000
+DEAL::Cell: 0_2:32 unit point 1.000000000 0.000000000
+DEAL::Cell: 0_2:33 unit point 0.000000000 0.000000000
+DEAL::
+DEAL::Testing 2D with point 5.510910596e-17 0.9000000000 tolerance 1.000000000e-08
+DEAL::Cell: 0_2:12 unit point 1.000000000 1.000000000
+DEAL::Cell: 0_2:13 unit point -2.822592474e-12 1.000000000
+DEAL::Cell: 0_2:30 unit point 1.000000000 1.332267630e-15
+DEAL::Cell: 0_2:31 unit point 0.000000000 0.000000000
+DEAL::
+DEAL::Testing 2D with point 5.817072296e-17 0.9500000000 tolerance 1.000000000e-08
+DEAL::Cell: 0_2:10 unit point 1.000000000 1.000000000
+DEAL::Cell: 0_2:11 unit point -2.168591708e-12 1.000000000
+DEAL::Cell: 0_2:12 unit point 1.000000000 0.000000000
+DEAL::Cell: 0_2:13 unit point 0.000000000 0.000000000
+DEAL::
+DEAL::Testing 2D with point 6.123233996e-17 1.000000000 tolerance 1.000000000e-08
+DEAL::Cell: 0_2:10 unit point 1.000000000 1.776356839e-15
+DEAL::Cell: 0_2:11 unit point 0.000000000 0.000000000
+DEAL::
+DEAL::Testing 2D with point -0.5656854249 0.5656854249 tolerance 1.000000000e-08
+DEAL::Cell: 1_2:22 unit point 0.5000000000 1.000000000
+DEAL::
+DEAL::Testing 2D with point -0.6010407640 0.6010407640 tolerance 1.000000000e-08
+DEAL::Cell: 1_2:20 unit point 0.5000000000 1.000000000
+DEAL::Cell: 1_2:22 unit point 0.5000000000 0.000000000
+DEAL::
+DEAL::Testing 2D with point -0.6363961031 0.6363961031 tolerance 1.000000000e-08
+DEAL::Cell: 1_2:02 unit point 0.5000000000 1.000000000
+DEAL::Cell: 1_2:20 unit point 0.5000000000 0.000000000
+DEAL::
+DEAL::Testing 2D with point -0.6717514421 0.6717514421 tolerance 1.000000000e-08
+DEAL::Cell: 1_2:00 unit point 0.5000000000 1.000000000
+DEAL::Cell: 1_2:02 unit point 0.5000000000 0.000000000
+DEAL::
+DEAL::Testing 2D with point -0.7071067812 0.7071067812 tolerance 1.000000000e-08
+DEAL::Cell: 1_2:00 unit point 0.5000000000 0.000000000
+DEAL::
+DEAL::Testing 3D with point 0.8000000000 0.000000000 4.898587197e-17 tolerance 1.000000000e-08
+DEAL::Cell: 1_1:2 unit point 1.000000000 1.000000000 1.000000000
+DEAL::Cell: 1_1:3 unit point -8.303440800e-17 1.000000000 1.000000000
+DEAL::Cell: 1_1:6 unit point 1.000000000 1.000000000 1.926518011e-16
+DEAL::Cell: 1_1:7 unit point -7.417973061e-17 1.000000000 1.926518011e-16
+DEAL::
+DEAL::Testing 3D with point 0.8500000000 0.000000000 5.204748896e-17 tolerance 1.000000000e-08
+DEAL::Cell: 1_1:2 unit point 1.000000000 0.5000000000 1.000000000
+DEAL::Cell: 1_1:3 unit point -7.964959890e-17 0.5000000000 1.000000000
+DEAL::Cell: 1_1:6 unit point 1.000000000 0.5000000000 1.280236223e-16
+DEAL::Cell: 1_1:7 unit point -7.704963069e-17 0.5000000000 1.280236223e-16
+DEAL::
+DEAL::Testing 3D with point 0.9000000000 0.000000000 5.510910596e-17 tolerance 1.000000000e-08
+DEAL::Cell: 1_1:0 unit point 1.000000000 1.000000000 1.000000000
+DEAL::Cell: 1_1:1 unit point -7.645262908e-17 1.000000000 1.000000000
+DEAL::Cell: 1_1:2 unit point 1.000000000 0.000000000 1.000000000
+DEAL::Cell: 1_1:3 unit point 0.000000000 0.000000000 1.000000000
+DEAL::Cell: 1_1:4 unit point 1.000000000 1.000000000 5.760667565e-17
+DEAL::Cell: 1_1:5 unit point 2.088318203e-17 1.000000000 5.760667565e-17
+DEAL::Cell: 1_1:6 unit point 1.000000000 0.000000000 0.000000000
+DEAL::Cell: 1_1:7 unit point 0.000000000 0.000000000 0.000000000
+DEAL::
+DEAL::Testing 3D with point 0.9500000000 0.000000000 5.817072296e-17 tolerance 1.000000000e-08
+DEAL::Cell: 1_1:0 unit point 1.000000000 0.5000000000 1.000000000
+DEAL::Cell: 1_1:1 unit point -3.834084110e-17 0.5000000000 1.000000000
+DEAL::Cell: 1_1:4 unit point 1.000000000 0.5000000000 8.536581456e-17
+DEAL::Cell: 1_1:5 unit point -9.581616542e-18 0.5000000000 8.536581456e-17
+DEAL::
+DEAL::Testing 3D with point 1.000000000 0.000000000 6.123233996e-17 tolerance 1.000000000e-08
+DEAL::Cell: 1_1:0 unit point 1.000000000 0.000000000 1.000000000
+DEAL::Cell: 1_1:1 unit point 0.000000000 0.000000000 1.000000000
+DEAL::Cell: 1_1:4 unit point 1.000000000 0.000000000 0.000000000
+DEAL::Cell: 1_1:5 unit point 0.000000000 0.000000000 0.000000000
+DEAL::
+DEAL::Testing 3D with point 0.5656854249 0.5656854249 4.898587197e-17 tolerance 1.000000000e-08
+DEAL::Cell: 1_1:3 unit point 1.000000000 1.000000000 1.000000000
+DEAL::Cell: 1_1:7 unit point 1.000000000 1.000000000 4.276252452e-17
+DEAL::Cell: 5_1:3 unit point 1.000000000 1.000000000 1.000000000
+DEAL::Cell: 5_1:7 unit point 1.000000000 1.000000000 4.276232599e-17
+DEAL::
+DEAL::Testing 3D with point 0.6010407640 0.6010407640 5.204748896e-17 tolerance 1.000000000e-08
+DEAL::Cell: 1_1:3 unit point 1.000000000 0.5000000000 1.000000000
+DEAL::Cell: 1_1:7 unit point 1.000000000 0.5000000000 -2.320031823e-13
+DEAL::Cell: 5_1:3 unit point 0.5000000000 1.000000000 1.000000000
+DEAL::Cell: 5_1:7 unit point 0.5000000000 1.000000000 -2.320437623e-13
+DEAL::
+DEAL::Testing 3D with point 0.6363961031 0.6363961031 5.510910596e-17 tolerance 1.000000000e-08
+DEAL::Cell: 1_1:1 unit point 1.000000000 1.000000000 1.000000000
+DEAL::Cell: 1_1:3 unit point 1.000000000 9.017311099e-14 1.000000000
+DEAL::Cell: 1_1:5 unit point 1.000000000 1.000000000 1.235815776e-16
+DEAL::Cell: 1_1:7 unit point 1.000000000 8.198972229e-14 -2.042607279e-14
+DEAL::Cell: 5_1:2 unit point 1.000000000 1.000000000 1.000000000
+DEAL::Cell: 5_1:3 unit point 8.598570907e-14 1.000000000 1.000000000
+DEAL::Cell: 5_1:6 unit point 1.000000000 1.000000000 1.235816173e-16
+DEAL::Cell: 5_1:7 unit point 8.533583225e-14 1.000000000 -2.042607414e-14
+DEAL::
+DEAL::Testing 3D with point 0.6717514421 0.6717514421 5.817072296e-17 tolerance 1.000000000e-08
+DEAL::Cell: 1_1:1 unit point 1.000000000 0.5000000000 1.000000000
+DEAL::Cell: 1_1:5 unit point 1.000000000 0.5000000000 -2.319986659e-13
+DEAL::Cell: 5_1:2 unit point 0.5000000000 1.000000000 1.000000000
+DEAL::Cell: 5_1:6 unit point 0.5000000000 1.000000000 -2.319986632e-13
+DEAL::
+DEAL::Testing 3D with point 0.7071067812 0.7071067812 6.123233996e-17 tolerance 1.000000000e-08
+DEAL::Cell: 1_1:1 unit point 1.000000000 1.299125740e-13 1.000000000
+DEAL::Cell: 1_1:5 unit point 1.000000000 1.314985210e-13 -2.818294969e-14
+DEAL::Cell: 5_1:2 unit point 1.242078213e-13 1.000000000 1.000000000
+DEAL::Cell: 5_1:6 unit point 1.311862348e-13 1.000000000 -2.818294900e-14
+DEAL::
+DEAL::Testing 3D with point 0.4702282018 0.6472135955 4.898587197e-17 tolerance 1.000000000e-08
+DEAL::Cell: 5_1:3 unit point 1.000000000 0.8000000000 1.000000000
+DEAL::Cell: 5_1:7 unit point 1.000000000 0.8000000000 4.637380246e-13
+DEAL::
+DEAL::Testing 3D with point 0.4996174644 0.6876644452 5.204748896e-17 tolerance 1.000000000e-08
+DEAL::Cell: 5_1:3 unit point 0.5000000000 0.8000000000 1.000000000
+DEAL::Cell: 5_1:7 unit point 0.5000000000 0.8000000000 1.904608511e-13
+DEAL::
+DEAL::Testing 3D with point 0.5290067271 0.7281152949 5.510910596e-17 tolerance 1.000000000e-08
+DEAL::Cell: 5_1:2 unit point 1.000000000 0.8000000000 1.000000000
+DEAL::Cell: 5_1:3 unit point 4.493258005e-12 0.8000000000 1.000000000
+DEAL::Cell: 5_1:6 unit point 1.000000000 0.8000000000 3.887212074e-13
+DEAL::Cell: 5_1:7 unit point 4.490620232e-12 0.8000000000 7.293961670e-17
+DEAL::
+DEAL::Testing 3D with point 0.5583959897 0.7685661447 5.817072296e-17 tolerance 1.000000000e-08
+DEAL::Cell: 5_1:2 unit point 0.5000000000 0.8000000000 1.000000000
+DEAL::Cell: 5_1:6 unit point 0.5000000000 0.8000000000 1.905389365e-13
+DEAL::
+DEAL::Testing 3D with point 0.5877852523 0.8090169944 6.123233996e-17 tolerance 1.000000000e-08
+DEAL::Cell: 5_1:2 unit point 4.984411987e-12 0.8000000000 1.000000000
+DEAL::Cell: 5_1:6 unit point 4.984602584e-12 0.8000000000 8.457493308e-17
+DEAL::
+DEAL::Testing 3D with point 4.898587197e-17 0.8000000000 4.898587197e-17 tolerance 1.000000000e-08
+DEAL::Cell: 5_1:1 unit point 1.000000000 1.000000000 1.000000000
+DEAL::Cell: 5_1:3 unit point 1.000000000 -6.373773359e-18 1.000000000
+DEAL::Cell: 5_1:5 unit point 1.000000000 1.000000000 -6.248547175e-18
+DEAL::Cell: 5_1:7 unit point 1.000000000 -1.137590585e-17 -7.938514149e-17
+DEAL::
+DEAL::Testing 3D with point 5.204748896e-17 0.8500000000 5.204748896e-17 tolerance 1.000000000e-08
+DEAL::Cell: 5_1:1 unit point 0.5000000000 1.000000000 1.000000000
+DEAL::Cell: 5_1:3 unit point 0.5000000000 -8.285899889e-18 1.000000000
+DEAL::Cell: 5_1:5 unit point 0.5000000000 1.000000000 -3.420590787e-17
+DEAL::Cell: 5_1:7 unit point 0.5000000000 -9.754658701e-18 -5.568075236e-17
+DEAL::
+DEAL::Testing 3D with point 5.510910596e-17 0.9000000000 5.510910596e-17 tolerance 1.000000000e-08
+DEAL::Cell: 5_1:0 unit point 1.000000000 1.000000000 1.000000000
+DEAL::Cell: 5_1:1 unit point 0.000000000 1.000000000 1.000000000
+DEAL::Cell: 5_1:2 unit point 1.000000000 -1.044316826e-17 1.000000000
+DEAL::Cell: 5_1:3 unit point 0.000000000 0.000000000 1.000000000
+DEAL::Cell: 5_1:4 unit point 1.000000000 1.000000000 -6.269016932e-17
+DEAL::Cell: 5_1:5 unit point 0.000000000 1.000000000 0.000000000
+DEAL::Cell: 5_1:6 unit point 1.000000000 1.004207808e-16 1.146921492e-16
+DEAL::Cell: 5_1:7 unit point 0.000000000 0.000000000 0.000000000
+DEAL::
+DEAL::Testing 3D with point 5.817072296e-17 0.9500000000 5.817072296e-17 tolerance 1.000000000e-08
+DEAL::Cell: 5_1:0 unit point 0.5000000000 1.000000000 1.000000000
+DEAL::Cell: 5_1:2 unit point 0.5000000000 3.296555534e-17 1.000000000
+DEAL::Cell: 5_1:4 unit point 0.5000000000 1.000000000 6.763788448e-18
+DEAL::Cell: 5_1:6 unit point 0.5000000000 6.572185716e-17 5.917387136e-17
+DEAL::
+DEAL::Testing 3D with point 6.123233996e-17 1.000000000 6.123233996e-17 tolerance 1.000000000e-08
+DEAL::Cell: 5_1:0 unit point 0.000000000 1.000000000 1.000000000
+DEAL::Cell: 5_1:2 unit point 0.000000000 0.000000000 1.000000000
+DEAL::Cell: 5_1:4 unit point 0.000000000 1.000000000 0.000000000
+DEAL::Cell: 5_1:6 unit point 0.000000000 0.000000000 0.000000000
+DEAL::
+DEAL::Testing 3D with point -0.5656854249 0.5656854249 4.898587197e-17 tolerance 1.000000000e-08
+DEAL::Cell: 3_1:3 unit point 1.000000000 1.000000000 1.000000000
+DEAL::Cell: 3_1:7 unit point 1.000000000 1.000000000 4.276251128e-17
+DEAL::Cell: 5_1:1 unit point 1.000000000 1.700275412e-16 1.000000000
+DEAL::Cell: 5_1:5 unit point 1.000000000 -1.467277005e-16 4.276244511e-17
+DEAL::
+DEAL::Testing 3D with point -0.6010407640 0.6010407640 5.204748896e-17 tolerance 1.000000000e-08
+DEAL::Cell: 3_1:3 unit point 0.5000000000 1.000000000 1.000000000
+DEAL::Cell: 3_1:7 unit point 0.5000000000 1.000000000 -2.320663067e-13
+DEAL::Cell: 5_1:1 unit point 0.5000000000 -2.317657626e-16 1.000000000
+DEAL::Cell: 5_1:5 unit point 0.5000000000 2.569940930e-16 -2.320460178e-13
+DEAL::
+DEAL::Testing 3D with point -0.6363961031 0.6363961031 5.510910596e-17 tolerance 1.000000000e-08
+DEAL::Cell: 3_1:2 unit point 1.000000000 1.000000000 1.000000000
+DEAL::Cell: 3_1:3 unit point 9.070134212e-14 1.000000000 1.000000000
+DEAL::Cell: 3_1:6 unit point 1.000000000 1.000000000 7.848572879e-17
+DEAL::Cell: 3_1:7 unit point 8.670987576e-14 1.000000000 -2.047116914e-14
+DEAL::Cell: 5_1:0 unit point 1.000000000 -2.649390483e-16 1.000000000
+DEAL::Cell: 5_1:1 unit point 8.200887043e-14 3.252674746e-16 1.000000000
+DEAL::Cell: 5_1:4 unit point 1.000000000 -7.245256636e-17 7.848568908e-17
+DEAL::Cell: 5_1:5 unit point 8.718125584e-14 3.258148497e-16 -2.047116980e-14
+DEAL::
+DEAL::Testing 3D with point -0.6717514421 0.6717514421 5.817072296e-17 tolerance 1.000000000e-08
+DEAL::Cell: 3_1:2 unit point 0.5000000000 1.000000000 1.000000000
+DEAL::Cell: 3_1:6 unit point 0.5000000000 1.000000000 -2.320212095e-13
+DEAL::Cell: 5_1:0 unit point 0.5000000000 2.176573764e-16 1.000000000
+DEAL::Cell: 5_1:4 unit point 0.5000000000 2.219835315e-16 -2.320009233e-13
+DEAL::
+DEAL::Testing 3D with point -0.7071067812 0.7071067812 6.123233996e-17 tolerance 1.000000000e-08
+DEAL::Cell: 3_1:2 unit point 1.289157964e-13 1.000000000 1.000000000
+DEAL::Cell: 3_1:6 unit point 1.311993409e-13 1.000000000 -2.818294948e-14
+DEAL::Cell: 5_1:0 unit point 1.279549447e-13 2.095585832e-16 1.000000000
+DEAL::Cell: 5_1:4 unit point 1.325617341e-13 2.107918106e-16 -2.818294974e-14
+DEAL::
+DEAL::Testing 3D with point 0.000000000 0.000000000 0.8000000000 tolerance 1.000000000e-08
+DEAL::Cell: 2_1:2 unit point 1.000000000 1.000000000 1.000000000
+DEAL::Cell: 2_1:3 unit point -8.303440800e-17 1.000000000 1.000000000
+DEAL::Cell: 2_1:6 unit point 1.000000000 1.000000000 1.160166342e-16
+DEAL::Cell: 2_1:7 unit point -7.417973061e-17 1.000000000 1.160166342e-16
+DEAL::
+DEAL::Testing 3D with point 0.000000000 0.000000000 0.8500000000 tolerance 1.000000000e-08
+DEAL::Cell: 2_1:2 unit point 1.000000000 0.5000000000 1.000000000
+DEAL::Cell: 2_1:3 unit point -7.964959890e-17 0.5000000000 1.000000000
+DEAL::Cell: 2_1:6 unit point 1.000000000 0.5000000000 5.138845544e-17
+DEAL::Cell: 2_1:7 unit point -7.704963069e-17 0.5000000000 5.138845544e-17
+DEAL::
+DEAL::Testing 3D with point 0.000000000 0.000000000 0.9000000000 tolerance 1.000000000e-08
+DEAL::Cell: 2_1:0 unit point 1.000000000 1.000000000 1.000000000
+DEAL::Cell: 2_1:1 unit point -7.645262908e-17 1.000000000 1.000000000
+DEAL::Cell: 2_1:2 unit point 1.000000000 0.000000000 1.000000000
+DEAL::Cell: 2_1:3 unit point 0.000000000 0.000000000 1.000000000
+DEAL::Cell: 2_1:4 unit point 1.000000000 1.000000000 -1.902849118e-17
+DEAL::Cell: 2_1:5 unit point 2.088318203e-17 1.000000000 -1.902849118e-17
+DEAL::Cell: 2_1:6 unit point 1.000000000 0.000000000 0.000000000
+DEAL::Cell: 2_1:7 unit point 0.000000000 0.000000000 0.000000000
+DEAL::
+DEAL::Testing 3D with point 0.000000000 0.000000000 0.9500000000 tolerance 1.000000000e-08
+DEAL::Cell: 2_1:0 unit point 1.000000000 0.5000000000 1.000000000
+DEAL::Cell: 2_1:1 unit point -3.834084110e-17 0.5000000000 1.000000000
+DEAL::Cell: 2_1:4 unit point 1.000000000 0.5000000000 8.730647733e-18
+DEAL::Cell: 2_1:5 unit point -9.581616542e-18 0.5000000000 8.730647733e-18
+DEAL::
+DEAL::Testing 3D with point 0.000000000 0.000000000 1.000000000 tolerance 1.000000000e-08
+DEAL::Cell: 2_1:0 unit point 1.000000000 0.000000000 1.000000000
+DEAL::Cell: 2_1:1 unit point 0.000000000 0.000000000 1.000000000
+DEAL::Cell: 2_1:4 unit point 1.000000000 0.000000000 0.000000000
+DEAL::Cell: 2_1:5 unit point 0.000000000 0.000000000 0.000000000
+DEAL::
+DEAL::Testing 3D with point 0.04694448799 0.06461354454 0.7960033322 tolerance 1.000000000e-08
+DEAL::Cell: 2_1:7 unit point 0.07445477977 0.9999999998 0.1025915666
+DEAL::
+DEAL::Testing 3D with point 0.04890050833 0.06730577556 0.8291701377 tolerance 1.000000000e-08
+DEAL::Cell: 2_1:7 unit point 0.07445477978 0.6666666664 0.1025915666
+DEAL::
+DEAL::Testing 3D with point 0.05085652866 0.06999800658 0.8623369432 tolerance 1.000000000e-08
+DEAL::Cell: 2_1:7 unit point 0.07445477978 0.3333333331 0.1025915666
+DEAL::
+DEAL::Testing 3D with point 0.05281254899 0.07269023761 0.8955037488 tolerance 1.000000000e-08
+DEAL::Cell: 2_1:5 unit point 0.07445477978 0.9999999998 0.1025915666
+DEAL::Cell: 2_1:7 unit point 0.07445477978 -2.382335201e-10 0.1025915666
+DEAL::
+DEAL::Testing 3D with point 0.05476856932 0.07538246863 0.9286705543 tolerance 1.000000000e-08
+DEAL::Cell: 2_1:5 unit point 0.07445477978 0.6666666664 0.1025915666
+DEAL::
+DEAL::Testing 3D with point 0.05672458966 0.07807469965 0.9618373598 tolerance 1.000000000e-08
+DEAL::Cell: 2_1:5 unit point 0.07445477978 0.3333333331 0.1025915666
+DEAL::
+DEAL::Testing 3D with point 0.05868060999 0.08076693067 0.9950041653 tolerance 1.000000000e-08
+DEAL::Cell: 2_1:5 unit point 0.07445477978 -2.652698368e-10 0.1025915666
+DEAL::
+DEAL::Testing 3D with point 0.8000000000 0.000000000 4.898587197e-17 tolerance 1.000000000e-08
+DEAL::Cell: 1_2:27 unit point 1.000000000 1.000000000 1.000000000
+DEAL::Cell: 1_2:36 unit point -8.456450374e-13 1.000000000 1.000000000
+DEAL::Cell: 1_2:63 unit point 1.000000000 1.000000000 -8.454891077e-13
+DEAL::Cell: 1_2:72 unit point -8.456450349e-13 1.000000000 -8.454891060e-13
+DEAL::
+DEAL::Testing 3D with point 0.8500000000 0.000000000 5.204748896e-17 tolerance 1.000000000e-08
+DEAL::Cell: 1_2:25 unit point 1.000000000 1.000000000 1.000000000
+DEAL::Cell: 1_2:27 unit point 1.000000000 0.000000000 1.000000000
+DEAL::Cell: 1_2:34 unit point -1.432112442e-13 1.000000000 1.000000000
+DEAL::Cell: 1_2:36 unit point 0.000000000 0.000000000 1.000000000
+DEAL::Cell: 1_2:61 unit point 1.000000000 1.000000000 -1.428983504e-13
+DEAL::Cell: 1_2:63 unit point 1.000000000 0.000000000 0.000000000
+DEAL::Cell: 1_2:70 unit point -1.432112438e-13 1.000000000 -1.428983521e-13
+DEAL::Cell: 1_2:72 unit point 0.000000000 0.000000000 0.000000000
+DEAL::
+DEAL::Testing 3D with point 0.9000000000 0.000000000 5.510910596e-17 tolerance 1.000000000e-08
+DEAL::Cell: 1_2:07 unit point 1.000000000 1.000000000 1.000000000
+DEAL::Cell: 1_2:16 unit point -3.712430608e-15 1.000000000 1.000000000
+DEAL::Cell: 1_2:25 unit point 1.000000000 0.000000000 1.000000000
+DEAL::Cell: 1_2:34 unit point 0.000000000 0.000000000 1.000000000
+DEAL::Cell: 1_2:43 unit point 1.000000000 1.000000000 -3.260009294e-15
+DEAL::Cell: 1_2:52 unit point -3.712429920e-15 1.000000000 -3.260009215e-15
+DEAL::Cell: 1_2:61 unit point 1.000000000 0.000000000 0.000000000
+DEAL::Cell: 1_2:70 unit point 0.000000000 0.000000000 0.000000000
+DEAL::
+DEAL::Testing 3D with point 0.9500000000 0.000000000 5.817072296e-17 tolerance 1.000000000e-08
+DEAL::Cell: 1_2:05 unit point 1.000000000 1.000000000 1.000000000
+DEAL::Cell: 1_2:07 unit point 1.000000000 0.000000000 1.000000000
+DEAL::Cell: 1_2:14 unit point -7.344041500e-17 1.000000000 1.000000000
+DEAL::Cell: 1_2:16 unit point 0.000000000 0.000000000 1.000000000
+DEAL::Cell: 1_2:41 unit point 1.000000000 1.000000000 2.195009723e-16
+DEAL::Cell: 1_2:43 unit point 1.000000000 0.000000000 0.000000000
+DEAL::Cell: 1_2:50 unit point -6.987682479e-17 1.000000000 2.195009723e-16
+DEAL::Cell: 1_2:52 unit point 0.000000000 0.000000000 0.000000000
+DEAL::
+DEAL::Testing 3D with point 1.000000000 0.000000000 6.123233996e-17 tolerance 1.000000000e-08
+DEAL::Cell: 1_2:05 unit point 1.000000000 0.000000000 1.000000000
+DEAL::Cell: 1_2:14 unit point 0.000000000 0.000000000 1.000000000
+DEAL::Cell: 1_2:41 unit point 1.000000000 0.000000000 0.000000000
+DEAL::Cell: 1_2:50 unit point 0.000000000 0.000000000 0.000000000
+DEAL::
+DEAL::Testing 3D with point 0.5656854249 0.5656854249 4.898587197e-17 tolerance 1.000000000e-08
+DEAL::Cell: 1_2:37 unit point 1.000000000 1.000000000 1.000000000
+DEAL::Cell: 1_2:73 unit point 1.000000000 1.000000000 1.859145936e-17
+DEAL::Cell: 5_2:37 unit point 1.000000000 1.000000000 1.000000000
+DEAL::Cell: 5_2:73 unit point 1.000000000 1.000000000 1.859146040e-17
+DEAL::
+DEAL::Testing 3D with point 0.6010407640 0.6010407640 5.204748896e-17 tolerance 1.000000000e-08
+DEAL::Cell: 1_2:35 unit point 1.000000000 1.000000000 1.000000000
+DEAL::Cell: 1_2:37 unit point 1.000000000 1.035237010e-15 1.000000000
+DEAL::Cell: 1_2:71 unit point 1.000000000 1.000000000 1.140884766e-16
+DEAL::Cell: 1_2:73 unit point 1.000000000 6.309532335e-15 1.123543561e-16
+DEAL::Cell: 5_2:36 unit point 1.000000000 1.000000000 1.000000000
+DEAL::Cell: 5_2:37 unit point 3.371760536e-15 1.000000000 1.000000000
+DEAL::Cell: 5_2:72 unit point 1.000000000 1.000000000 1.140884752e-16
+DEAL::Cell: 5_2:73 unit point 5.810029089e-15 1.000000000 1.123543668e-16
+DEAL::
+DEAL::Testing 3D with point 0.6363961031 0.6363961031 5.510910596e-17 tolerance 1.000000000e-08
+DEAL::Cell: 1_2:17 unit point 1.000000000 1.000000000 1.000000000
+DEAL::Cell: 1_2:35 unit point 1.000000000 5.739641719e-15 1.000000000
+DEAL::Cell: 1_2:53 unit point 1.000000000 1.000000000 1.989747201e-16
+DEAL::Cell: 1_2:71 unit point 1.000000000 -4.180203939e-15 1.970388233e-16
+DEAL::Cell: 5_2:27 unit point 1.000000000 1.000000000 1.000000000
+DEAL::Cell: 5_2:36 unit point 2.984230820e-15 1.000000000 1.000000000
+DEAL::Cell: 5_2:63 unit point 1.000000000 1.000000000 1.989747189e-16
+DEAL::Cell: 5_2:72 unit point -5.554517273e-15 1.000000000 1.970388457e-16
+DEAL::
+DEAL::Testing 3D with point 0.6717514421 0.6717514421 5.817072296e-17 tolerance 1.000000000e-08
+DEAL::Cell: 1_2:15 unit point 1.000000000 1.000000000 1.000000000
+DEAL::Cell: 1_2:17 unit point 1.000000000 3.522141350e-15 1.000000000
+DEAL::Cell: 1_2:51 unit point 1.000000000 1.000000000 1.989746804e-16
+DEAL::Cell: 1_2:53 unit point 1.000000000 -2.574390584e-15 1.968435037e-16
+DEAL::Cell: 5_2:26 unit point 1.000000000 1.000000000 1.000000000
+DEAL::Cell: 5_2:27 unit point 6.083266222e-15 1.000000000 1.000000000
+DEAL::Cell: 5_2:62 unit point 1.000000000 1.000000000 1.989746802e-16
+DEAL::Cell: 5_2:63 unit point 3.099632218e-16 1.000000000 1.968434937e-16
+DEAL::
+DEAL::Testing 3D with point 0.7071067812 0.7071067812 6.123233996e-17 tolerance 1.000000000e-08
+DEAL::Cell: 1_2:15 unit point 1.000000000 -2.152963627e-14 1.000000000
+DEAL::Cell: 1_2:51 unit point 1.000000000 -3.910010845e-15 1.966551364e-16
+DEAL::Cell: 5_2:26 unit point -1.080858785e-14 1.000000000 1.000000000
+DEAL::Cell: 5_2:62 unit point -1.077699249e-14 1.000000000 1.966551340e-16
+DEAL::
+DEAL::Testing 3D with point 0.4702282018 0.6472135955 4.898587197e-17 tolerance 1.000000000e-08
+DEAL::Cell: 5_2:37 unit point 1.000000000 0.6000000000 1.000000000
+DEAL::Cell: 5_2:73 unit point 1.000000000 0.6000000000 2.350707507e-17
+DEAL::
+DEAL::Testing 3D with point 0.4996174644 0.6876644452 5.204748896e-17 tolerance 1.000000000e-08
+DEAL::Cell: 5_2:36 unit point 1.000000000 0.6000000000 1.000000000
+DEAL::Cell: 5_2:37 unit point -8.404030510e-15 0.6000000000 1.000000000
+DEAL::Cell: 5_2:72 unit point 1.000000000 0.6000000000 8.330452900e-17
+DEAL::Cell: 5_2:73 unit point 1.278260809e-14 0.6000000000 5.493817314e-17
+DEAL::
+DEAL::Testing 3D with point 0.5290067271 0.7281152949 5.510910596e-17 tolerance 1.000000000e-08
+DEAL::Cell: 5_2:27 unit point 1.000000000 0.6000000000 1.000000000
+DEAL::Cell: 5_2:36 unit point 6.477294829e-15 0.6000000000 1.000000000
+DEAL::Cell: 5_2:63 unit point 1.000000000 0.6000000000 1.509460010e-16
+DEAL::Cell: 5_2:72 unit point 1.827815785e-14 0.6000000000 1.231611879e-16
+DEAL::
+DEAL::Testing 3D with point 0.5583959897 0.7685661447 5.817072296e-17 tolerance 1.000000000e-08
+DEAL::Cell: 5_2:26 unit point 1.000000000 0.6000000000 1.000000000
+DEAL::Cell: 5_2:27 unit point 1.540044134e-14 0.6000000000 1.000000000
+DEAL::Cell: 5_2:62 unit point 1.000000000 0.6000000000 1.520394056e-16
+DEAL::Cell: 5_2:63 unit point -2.850909613e-16 0.6000000000 1.640124797e-16
+DEAL::
+DEAL::Testing 3D with point 0.5877852523 0.8090169944 6.123233996e-17 tolerance 1.000000000e-08
+DEAL::Cell: 5_2:26 unit point 6.615584816e-15 0.6000000000 1.000000000
+DEAL::Cell: 5_2:62 unit point -6.522451849e-15 0.6000000000 1.836003912e-16
+DEAL::
+DEAL::Testing 3D with point 4.898587197e-17 0.8000000000 4.898587197e-17 tolerance 1.000000000e-08
+DEAL::Cell: 5_2:17 unit point 1.000000000 1.000000000 1.000000000
+DEAL::Cell: 5_2:35 unit point 1.000000000 -8.454891086e-13 1.000000000
+DEAL::Cell: 5_2:53 unit point 1.000000000 1.000000000 -8.454891132e-13
+DEAL::Cell: 5_2:71 unit point 1.000000000 -8.454891107e-13 -8.454891088e-13
+DEAL::
+DEAL::Testing 3D with point 5.204748896e-17 0.8500000000 5.204748896e-17 tolerance 1.000000000e-08
+DEAL::Cell: 5_2:16 unit point 1.000000000 1.000000000 1.000000000
+DEAL::Cell: 5_2:17 unit point 0.000000000 1.000000000 1.000000000
+DEAL::Cell: 5_2:34 unit point 1.000000000 -1.430667312e-13 1.000000000
+DEAL::Cell: 5_2:35 unit point 0.000000000 0.000000000 1.000000000
+DEAL::Cell: 5_2:52 unit point 1.000000000 1.000000000 -1.431228595e-13
+DEAL::Cell: 5_2:53 unit point 0.000000000 1.000000000 0.000000000
+DEAL::Cell: 5_2:70 unit point 1.000000000 -1.430667322e-13 -1.431228592e-13
+DEAL::Cell: 5_2:71 unit point 0.000000000 0.000000000 0.000000000
+DEAL::
+DEAL::Testing 3D with point 5.510910596e-17 0.9000000000 5.510910596e-17 tolerance 1.000000000e-08
+DEAL::Cell: 5_2:07 unit point 1.000000000 1.000000000 1.000000000
+DEAL::Cell: 5_2:16 unit point 0.000000000 1.000000000 1.000000000
+DEAL::Cell: 5_2:25 unit point 1.000000000 -3.578065004e-15 1.000000000
+DEAL::Cell: 5_2:34 unit point 0.000000000 0.000000000 1.000000000
+DEAL::Cell: 5_2:43 unit point 1.000000000 1.000000000 -3.684083618e-15
+DEAL::Cell: 5_2:52 unit point 0.000000000 1.000000000 0.000000000
+DEAL::Cell: 5_2:61 unit point 1.000000000 -3.578064131e-15 -3.684083486e-15
+DEAL::Cell: 5_2:70 unit point 0.000000000 0.000000000 0.000000000
+DEAL::
+DEAL::Testing 3D with point 5.817072296e-17 0.9500000000 5.817072296e-17 tolerance 1.000000000e-08
+DEAL::Cell: 5_2:06 unit point 1.000000000 1.000000000 1.000000000
+DEAL::Cell: 5_2:07 unit point 0.000000000 1.000000000 1.000000000
+DEAL::Cell: 5_2:24 unit point 1.000000000 7.218262295e-17 1.000000000
+DEAL::Cell: 5_2:25 unit point 0.000000000 0.000000000 1.000000000
+DEAL::Cell: 5_2:42 unit point 1.000000000 1.000000000 2.199414040e-17
+DEAL::Cell: 5_2:43 unit point 0.000000000 1.000000000 0.000000000
+DEAL::Cell: 5_2:60 unit point 1.000000000 7.624149583e-17 2.848833702e-17
+DEAL::Cell: 5_2:61 unit point 0.000000000 0.000000000 0.000000000
+DEAL::
+DEAL::Testing 3D with point 6.123233996e-17 1.000000000 6.123233996e-17 tolerance 1.000000000e-08
+DEAL::Cell: 5_2:06 unit point 0.000000000 1.000000000 1.000000000
+DEAL::Cell: 5_2:24 unit point 0.000000000 0.000000000 1.000000000
+DEAL::Cell: 5_2:42 unit point 0.000000000 1.000000000 0.000000000
+DEAL::Cell: 5_2:60 unit point 0.000000000 0.000000000 0.000000000
+DEAL::
+DEAL::Testing 3D with point -0.5656854249 0.5656854249 4.898587197e-17 tolerance 1.000000000e-08
+DEAL::Cell: 3_2:37 unit point 1.000000000 1.000000000 1.000000000
+DEAL::Cell: 3_2:73 unit point 1.000000000 1.000000000 1.859146081e-17
+DEAL::Cell: 5_2:15 unit point 1.000000000 3.146892442e-16 1.000000000
+DEAL::Cell: 5_2:51 unit point 1.000000000 3.145537130e-16 1.859145936e-17
+DEAL::
+DEAL::Testing 3D with point -0.6010407640 0.6010407640 5.204748896e-17 tolerance 1.000000000e-08
+DEAL::Cell: 3_2:36 unit point 1.000000000 1.000000000 1.000000000
+DEAL::Cell: 3_2:37 unit point 2.668637771e-15 1.000000000 1.000000000
+DEAL::Cell: 3_2:72 unit point 1.000000000 1.000000000 6.633993693e-17
+DEAL::Cell: 3_2:73 unit point -4.483502676e-15 1.000000000 6.460583746e-17
+DEAL::Cell: 5_2:14 unit point 1.000000000 5.332662292e-16 1.000000000
+DEAL::Cell: 5_2:15 unit point -1.065756323e-15 4.724401220e-16 1.000000000
+DEAL::Cell: 5_2:50 unit point 1.000000000 5.332933343e-16 6.633993776e-17
+DEAL::Cell: 5_2:51 unit point -7.074598230e-15 1.913766975e-18 6.460582919e-17
+DEAL::
+DEAL::Testing 3D with point -0.6363961031 0.6363961031 5.510910596e-17 tolerance 1.000000000e-08
+DEAL::Cell: 3_2:27 unit point 1.000000000 1.000000000 1.000000000
+DEAL::Cell: 3_2:36 unit point 1.051910066e-14 1.000000000 1.000000000
+DEAL::Cell: 3_2:63 unit point 1.000000000 1.000000000 1.087830353e-16
+DEAL::Cell: 3_2:72 unit point 1.615454782e-14 1.000000000 1.068471563e-16
+DEAL::Cell: 5_2:05 unit point 1.000000000 5.056866185e-16 1.000000000
+DEAL::Cell: 5_2:14 unit point 1.735363614e-14 4.452019244e-16 1.000000000
+DEAL::Cell: 5_2:41 unit point 1.000000000 5.056886735e-16 1.087830338e-16
+DEAL::Cell: 5_2:50 unit point 1.142764135e-14 1.607985976e-18 1.068471571e-16
+DEAL::
+DEAL::Testing 3D with point -0.6717514421 0.6717514421 5.817072296e-17 tolerance 1.000000000e-08
+DEAL::Cell: 3_2:26 unit point 1.000000000 1.000000000 1.000000000
+DEAL::Cell: 3_2:27 unit point 1.952337647e-15 1.000000000 1.000000000
+DEAL::Cell: 3_2:62 unit point 1.000000000 1.000000000 1.562523033e-16
+DEAL::Cell: 3_2:63 unit point 9.175998291e-15 1.000000000 1.541211189e-16
+DEAL::Cell: 5_2:04 unit point 1.000000000 -1.499570302e-16 1.000000000
+DEAL::Cell: 5_2:05 unit point -3.372573651e-15 2.045394248e-16 1.000000000
+DEAL::Cell: 5_2:40 unit point 1.000000000 2.272810969e-16 1.562523046e-16
+DEAL::Cell: 5_2:41 unit point 1.535210893e-14 -2.175468530e-16 1.541211123e-16
+DEAL::
+DEAL::Testing 3D with point -0.7071067812 0.7071067812 6.123233996e-17 tolerance 1.000000000e-08
+DEAL::Cell: 3_2:26 unit point -1.240804196e-14 1.000000000 1.000000000
+DEAL::Cell: 3_2:62 unit point -8.497314572e-15 1.000000000 1.966551075e-16
+DEAL::Cell: 5_2:04 unit point -7.077887064e-15 4.020468385e-16 1.000000000
+DEAL::Cell: 5_2:40 unit point -4.058510126e-16 4.015442803e-16 1.966551340e-16
+DEAL::
+DEAL::Testing 3D with point 0.000000000 0.000000000 0.8000000000 tolerance 1.000000000e-08
+DEAL::Cell: 2_2:27 unit point 1.000000000 1.000000000 1.000000000
+DEAL::Cell: 2_2:36 unit point -8.456450380e-13 1.000000000 1.000000000
+DEAL::Cell: 2_2:63 unit point 1.000000000 1.000000000 -8.456450376e-13
+DEAL::Cell: 2_2:72 unit point -8.456450308e-13 1.000000000 -8.456450310e-13
+DEAL::
+DEAL::Testing 3D with point 0.000000000 0.000000000 0.8500000000 tolerance 1.000000000e-08
+DEAL::Cell: 2_2:25 unit point 1.000000000 1.000000000 1.000000000
+DEAL::Cell: 2_2:27 unit point 1.000000000 0.000000000 1.000000000
+DEAL::Cell: 2_2:34 unit point -1.432112455e-13 1.000000000 1.000000000
+DEAL::Cell: 2_2:36 unit point 0.000000000 0.000000000 1.000000000
+DEAL::Cell: 2_2:61 unit point 1.000000000 1.000000000 -1.430542804e-13
+DEAL::Cell: 2_2:63 unit point 1.000000000 0.000000000 0.000000000
+DEAL::Cell: 2_2:70 unit point -1.432112428e-13 1.000000000 -1.430542763e-13
+DEAL::Cell: 2_2:72 unit point 0.000000000 0.000000000 0.000000000
+DEAL::
+DEAL::Testing 3D with point 0.000000000 0.000000000 0.9000000000 tolerance 1.000000000e-08
+DEAL::Cell: 2_2:07 unit point 1.000000000 1.000000000 1.000000000
+DEAL::Cell: 2_2:16 unit point -3.712430741e-15 1.000000000 1.000000000
+DEAL::Cell: 2_2:25 unit point 1.000000000 0.000000000 1.000000000
+DEAL::Cell: 2_2:34 unit point 0.000000000 0.000000000 1.000000000
+DEAL::Cell: 2_2:43 unit point 1.000000000 1.000000000 -3.415936254e-15
+DEAL::Cell: 2_2:52 unit point -3.712429761e-15 1.000000000 -3.415936651e-15
+DEAL::Cell: 2_2:61 unit point 1.000000000 0.000000000 0.000000000
+DEAL::Cell: 2_2:70 unit point 0.000000000 0.000000000 0.000000000
+DEAL::
+DEAL::Testing 3D with point 0.000000000 0.000000000 0.9500000000 tolerance 1.000000000e-08
+DEAL::Cell: 2_2:05 unit point 1.000000000 1.000000000 1.000000000
+DEAL::Cell: 2_2:07 unit point 1.000000000 0.000000000 1.000000000
+DEAL::Cell: 2_2:14 unit point -7.344041500e-17 1.000000000 1.000000000
+DEAL::Cell: 2_2:16 unit point 0.000000000 0.000000000 1.000000000
+DEAL::Cell: 2_2:41 unit point 1.000000000 1.000000000 6.367087842e-17
+DEAL::Cell: 2_2:43 unit point 1.000000000 0.000000000 0.000000000
+DEAL::Cell: 2_2:50 unit point -6.987682479e-17 1.000000000 6.367087842e-17
+DEAL::Cell: 2_2:52 unit point 0.000000000 0.000000000 0.000000000
+DEAL::
+DEAL::Testing 3D with point 0.000000000 0.000000000 1.000000000 tolerance 1.000000000e-08
+DEAL::Cell: 2_2:05 unit point 1.000000000 0.000000000 1.000000000
+DEAL::Cell: 2_2:14 unit point 0.000000000 0.000000000 1.000000000
+DEAL::Cell: 2_2:41 unit point 1.000000000 0.000000000 0.000000000
+DEAL::Cell: 2_2:50 unit point 0.000000000 0.000000000 0.000000000
+DEAL::
+DEAL::Testing 3D with point 0.04694448799 0.06461354454 0.7960033322 tolerance 1.000000000e-08
+DEAL::Cell: 2_2:72 unit point 0.1492716444 1.000000000 0.2055240902
+DEAL::
+DEAL::Testing 3D with point 0.04890050833 0.06730577556 0.8291701377 tolerance 1.000000000e-08
+DEAL::Cell: 2_2:72 unit point 0.1492716444 0.3333333333 0.2055240902
+DEAL::
+DEAL::Testing 3D with point 0.05085652866 0.06999800658 0.8623369432 tolerance 1.000000000e-08
+DEAL::Cell: 2_2:70 unit point 0.1492716444 0.6666666667 0.2055240902
+DEAL::
+DEAL::Testing 3D with point 0.05281254899 0.07269023761 0.8955037488 tolerance 1.000000000e-08
+DEAL::Cell: 2_2:52 unit point 0.1492716444 1.000000000 0.2055240902
+DEAL::Cell: 2_2:70 unit point 0.1492716444 -1.547757204e-14 0.2055240902
+DEAL::
+DEAL::Testing 3D with point 0.05476856932 0.07538246863 0.9286705543 tolerance 1.000000000e-08
+DEAL::Cell: 2_2:52 unit point 0.1492716444 0.3333333333 0.2055240902
+DEAL::
+DEAL::Testing 3D with point 0.05672458966 0.07807469965 0.9618373598 tolerance 1.000000000e-08
+DEAL::Cell: 2_2:50 unit point 0.1492716444 0.6666666667 0.2055240902
+DEAL::
+DEAL::Testing 3D with point 0.05868060999 0.08076693067 0.9950041653 tolerance 1.000000000e-08
+DEAL::Cell: 2_2:50 unit point 0.1492716444 -9.964828187e-14 0.2055240902
+DEAL::

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.