]> https://gitweb.dealii.org/ - dealii.git/commitdiff
remove saddle point 14535/head
authorMagdalena Schreter <schreter.magdalena@gmail.com>
Mon, 5 Dec 2022 21:24:39 +0000 (22:24 +0100)
committerMagdalena Schreter <schreter.magdalena@gmail.com>
Mon, 5 Dec 2022 22:16:57 +0000 (23:16 +0100)
include/deal.II/grid/grid_tools.h
source/grid/grid_tools.cc
tests/grid/grid_generator_marching_cube_algorithm_02.cc
tests/grid/grid_generator_marching_cube_algorithm_02.with_p4est=true.mpirun=1.output

index 7776cc7552d2cb0d2e1b2d52047d751727f4e480..51dab5ac8b69e8a63b8158ae744e087064410d50 100644 (file)
@@ -3431,6 +3431,9 @@ namespace GridTools
    * @note The resulting mesh will not be of high quality, since it might
    *   contain cells with very small diameters if the mesh is cut close to a
    *   vertex.
+   *
+   * @note Iso lines/contours as a saddle point within a subcell is not
+   *       detected by the implemented algorithm.
    */
   template <int dim, typename VectorType>
   class MarchingCubeAlgorithm
index ea1cc381ca66256f3652c29301f9d9be2b171f34..dc2aa6242ae79d109a3b25b279ca7d145c9e66cd 100644 (file)
@@ -6942,12 +6942,6 @@ namespace GridTools
                 if (i + 1 == n_subdivisions)
                   vertices.emplace_back(points[mask[1]]);
               }
-            // check for a saddle point, if iso_level values of the two
-            // corner nodes are identical
-            else if ((std::abs(ls_values[mask[0]] - ls_values[mask[1]]) <
-                      tolerance) &&
-                     (ls_values[mask[0]] >= iso_level))
-              vertices.emplace_back(0.5 * (points[mask[0]] + points[mask[1]]));
             // check if the edge is cut
             else if (((ls_values[mask[0]] > iso_level) &&
                       (ls_values[mask[1]] < iso_level)) ||
index 019573f842ac288ac3e03fda5d243c22cd6b7e20..bdd765d715cafcd5a760eb687c0489fd49a8dcd3 100644 (file)
@@ -42,9 +42,32 @@ using namespace dealii;
 
 using VectorType = LinearAlgebra::distributed::Vector<double>;
 
+template <int dim>
+class HeavisideFunction : public Function<dim>
+{
+public:
+  HeavisideFunction(const Point<dim> &center, const double radius)
+    : Function<dim>(1)
+    , distance_sphere(center, radius)
+  {}
+
+  double
+  value(const Point<dim> &p, const unsigned int component) const
+  {
+    const double distance = distance_sphere.value(p);
+
+    // compute sign
+    return boost::math::sign(distance);
+  }
+
+  Functions::SignedDistance::Sphere<dim> distance_sphere;
+};
+
 template <int dim>
 void
-test(const unsigned int n_subdivisions, const double iso_level)
+create_mca_tria(const unsigned int   n_subdivisions,
+                const double         iso_level,
+                const Function<dim> &my_function)
 {
   deallog << "dim=" << dim << " iso level: " << iso_level << std::endl;
   const int degree        = 3;
@@ -73,11 +96,10 @@ test(const unsigned int n_subdivisions, const double iso_level)
                    locally_relevant_dofs,
                    MPI_COMM_WORLD);
 
-  dealii::VectorTools::interpolate(
-    mapping,
-    background_dof_handler,
-    Functions::SignedDistance::Sphere<dim>(Point<dim>(), 0.75),
-    ls_vector);
+  dealii::VectorTools::interpolate(mapping,
+                                   background_dof_handler,
+                                   my_function,
+                                   ls_vector);
 
   std::vector<Point<dim>> vertices;
 
@@ -104,6 +126,27 @@ test(const unsigned int n_subdivisions, const double iso_level)
     }
 }
 
+template <int dim>
+void
+test()
+{
+  for (unsigned int i = 1; i <= 3; ++i)
+    {
+      {
+        deallog << "signed distance function" << std::endl;
+        const auto my_function =
+          Functions::SignedDistance::Sphere<dim>(Point<dim>(), 0.75);
+        create_mca_tria<dim>(i, -0.1 + i * 0.05, my_function);
+      }
+      {
+        // test function with constant regions
+        deallog << "heaviside function" << std::endl;
+        const auto my_function = HeavisideFunction<dim>(Point<dim>(), 0.75);
+        create_mca_tria<dim>(i, 0, my_function);
+      }
+    }
+}
+
 int
 main(int argc, char *argv[])
 {
@@ -112,13 +155,8 @@ main(int argc, char *argv[])
 
   deallog << std::scientific << std::setprecision(6);
 
-  // dim==1
-  for (unsigned int i = 1; i <= 3; ++i)
-    test<1>(i, -0.1 + i * 0.05);
-
-  // dim==2
-  for (unsigned int i = 1; i <= 3; ++i)
-    test<2>(i, -0.1 + i * 0.05);
+  test<1>();
+  test<2>();
 
   return 0;
 }
index c5e6c9c6ff72d0f603357b4133606c6d51bd820a..0a3cbd6f47921c47ca6f9e5a4b8b9c25ea0fab12 100644 (file)
@@ -1,13 +1,29 @@
 
+DEAL:0::signed distance function
 DEAL:0::dim=1 iso level: -5.000000e-02
 DEAL:0::point found: -7.000000e-01
 DEAL:0::point found: 7.000000e-01
+DEAL:0::heaviside function
 DEAL:0::dim=1 iso level: 0.000000e+00
 DEAL:0::point found: -7.500000e-01
 DEAL:0::point found: 7.500000e-01
+DEAL:0::signed distance function
+DEAL:0::dim=1 iso level: 0.000000e+00
+DEAL:0::point found: -7.500000e-01
+DEAL:0::point found: 7.500000e-01
+DEAL:0::heaviside function
+DEAL:0::dim=1 iso level: 0.000000e+00
+DEAL:0::point found: -7.500000e-01
+DEAL:0::point found: 7.500000e-01
+DEAL:0::signed distance function
 DEAL:0::dim=1 iso level: 5.000000e-02
 DEAL:0::point found: -8.000000e-01
 DEAL:0::point found: 8.000000e-01
+DEAL:0::heaviside function
+DEAL:0::dim=1 iso level: 0.000000e+00
+DEAL:0::point found: -7.500000e-01
+DEAL:0::point found: 7.500000e-01
+DEAL:0::signed distance function
 DEAL:0::dim=2 iso level: -5.000000e-02
 DEAL:0::point found: -7.000000e-01 0.000000e+00
 DEAL:0::point found: -6.936670e-01 -9.375000e-02
@@ -69,6 +85,69 @@ DEAL:0::point found: 6.743534e-01 1.875000e-01
 DEAL:0::point found: 6.936670e-01 -9.375000e-02
 DEAL:0::point found: 6.936670e-01 9.375000e-02
 DEAL:0::point found: 7.000000e-01 0.000000e+00
+DEAL:0::heaviside function
+DEAL:0::dim=2 iso level: 0.000000e+00
+DEAL:0::point found: -7.500000e-01 0.000000e+00
+DEAL:0::point found: -7.031250e-01 -2.812500e-01
+DEAL:0::point found: -7.031250e-01 -1.875000e-01
+DEAL:0::point found: -7.031250e-01 -9.375000e-02
+DEAL:0::point found: -7.031250e-01 9.375000e-02
+DEAL:0::point found: -7.031250e-01 1.875000e-01
+DEAL:0::point found: -7.031250e-01 2.812500e-01
+DEAL:0::point found: -6.562500e-01 -3.281250e-01
+DEAL:0::point found: -6.562500e-01 3.281250e-01
+DEAL:0::point found: -6.093750e-01 -4.687500e-01
+DEAL:0::point found: -6.093750e-01 -3.750000e-01
+DEAL:0::point found: -6.093750e-01 3.750000e-01
+DEAL:0::point found: -6.093750e-01 4.687500e-01
+DEAL:0::point found: -5.625000e-01 -5.156250e-01
+DEAL:0::point found: -5.625000e-01 5.156250e-01
+DEAL:0::point found: -5.156250e-01 -5.625000e-01
+DEAL:0::point found: -5.156250e-01 5.625000e-01
+DEAL:0::point found: -4.687500e-01 -6.093750e-01
+DEAL:0::point found: -4.687500e-01 6.093750e-01
+DEAL:0::point found: -3.750000e-01 -6.093750e-01
+DEAL:0::point found: -3.750000e-01 6.093750e-01
+DEAL:0::point found: -3.281250e-01 -6.562500e-01
+DEAL:0::point found: -3.281250e-01 6.562500e-01
+DEAL:0::point found: -2.812500e-01 -7.031250e-01
+DEAL:0::point found: -2.812500e-01 7.031250e-01
+DEAL:0::point found: -1.875000e-01 -7.031250e-01
+DEAL:0::point found: -1.875000e-01 7.031250e-01
+DEAL:0::point found: -9.375000e-02 -7.031250e-01
+DEAL:0::point found: -9.375000e-02 7.031250e-01
+DEAL:0::point found: 0.000000e+00 -7.500000e-01
+DEAL:0::point found: 0.000000e+00 7.500000e-01
+DEAL:0::point found: 9.375000e-02 -7.031250e-01
+DEAL:0::point found: 9.375000e-02 7.031250e-01
+DEAL:0::point found: 1.875000e-01 -7.031250e-01
+DEAL:0::point found: 1.875000e-01 7.031250e-01
+DEAL:0::point found: 2.812500e-01 -7.031250e-01
+DEAL:0::point found: 2.812500e-01 7.031250e-01
+DEAL:0::point found: 3.281250e-01 -6.562500e-01
+DEAL:0::point found: 3.281250e-01 6.562500e-01
+DEAL:0::point found: 3.750000e-01 -6.093750e-01
+DEAL:0::point found: 3.750000e-01 6.093750e-01
+DEAL:0::point found: 4.687500e-01 -6.093750e-01
+DEAL:0::point found: 4.687500e-01 6.093750e-01
+DEAL:0::point found: 5.156250e-01 -5.625000e-01
+DEAL:0::point found: 5.156250e-01 5.625000e-01
+DEAL:0::point found: 5.625000e-01 -5.156250e-01
+DEAL:0::point found: 5.625000e-01 5.156250e-01
+DEAL:0::point found: 6.093750e-01 -4.687500e-01
+DEAL:0::point found: 6.093750e-01 -3.750000e-01
+DEAL:0::point found: 6.093750e-01 3.750000e-01
+DEAL:0::point found: 6.093750e-01 4.687500e-01
+DEAL:0::point found: 6.562500e-01 -3.281250e-01
+DEAL:0::point found: 6.562500e-01 3.281250e-01
+DEAL:0::point found: 7.031250e-01 -2.812500e-01
+DEAL:0::point found: 7.031250e-01 -1.875000e-01
+DEAL:0::point found: 7.031250e-01 -9.375000e-02
+DEAL:0::point found: 7.031250e-01 9.375000e-02
+DEAL:0::point found: 7.031250e-01 1.875000e-01
+DEAL:0::point found: 7.031250e-01 2.812500e-01
+DEAL:0::point found: 7.500000e-01 0.000000e+00
+DEAL:0::signed distance function
 DEAL:0::dim=2 iso level: 0.000000e+00
 DEAL:0::point found: -7.500000e-01 0.000000e+00
 DEAL:0::point found: -7.485333e-01 -4.687500e-02
@@ -194,6 +273,125 @@ DEAL:0::point found: 7.441149e-01 9.375000e-02
 DEAL:0::point found: 7.485333e-01 -4.687500e-02
 DEAL:0::point found: 7.485333e-01 4.687500e-02
 DEAL:0::point found: 7.500000e-01 0.000000e+00
+DEAL:0::heaviside function
+DEAL:0::dim=2 iso level: 0.000000e+00
+DEAL:0::point found: -7.500000e-01 0.000000e+00
+DEAL:0::point found: -7.291667e-01 -1.875000e-01
+DEAL:0::point found: -7.291667e-01 -1.406250e-01
+DEAL:0::point found: -7.291667e-01 -9.375000e-02
+DEAL:0::point found: -7.291667e-01 9.375000e-02
+DEAL:0::point found: -7.291667e-01 1.406250e-01
+DEAL:0::point found: -7.291667e-01 1.875000e-01
+DEAL:0::point found: -7.279412e-01 -4.687500e-02
+DEAL:0::point found: -7.279412e-01 4.687500e-02
+DEAL:0::point found: -7.031250e-01 -2.812500e-01
+DEAL:0::point found: -7.031250e-01 -2.291667e-01
+DEAL:0::point found: -7.031250e-01 2.291667e-01
+DEAL:0::point found: -7.031250e-01 2.812500e-01
+DEAL:0::point found: -6.967905e-01 -2.343750e-01
+DEAL:0::point found: -6.967905e-01 2.343750e-01
+DEAL:0::point found: -6.869877e-01 -3.281250e-01
+DEAL:0::point found: -6.869877e-01 3.281250e-01
+DEAL:0::point found: -6.562500e-01 -3.541667e-01
+DEAL:0::point found: -6.562500e-01 3.541667e-01
+DEAL:0::point found: -6.354167e-01 -3.750000e-01
+DEAL:0::point found: -6.354167e-01 3.750000e-01
+DEAL:0::point found: -6.299342e-01 -4.218750e-01
+DEAL:0::point found: -6.299342e-01 4.218750e-01
+DEAL:0::point found: -6.093750e-01 -4.399038e-01
+DEAL:0::point found: -6.093750e-01 4.399038e-01
+DEAL:0::point found: -5.833333e-01 -4.687500e-01
+DEAL:0::point found: -5.833333e-01 4.687500e-01
+DEAL:0::point found: -5.625000e-01 -5.156250e-01
+DEAL:0::point found: -5.625000e-01 5.156250e-01
+DEAL:0::point found: -5.156250e-01 -5.625000e-01
+DEAL:0::point found: -5.156250e-01 5.625000e-01
+DEAL:0::point found: -4.687500e-01 -5.833333e-01
+DEAL:0::point found: -4.687500e-01 5.833333e-01
+DEAL:0::point found: -4.399038e-01 -6.093750e-01
+DEAL:0::point found: -4.399038e-01 6.093750e-01
+DEAL:0::point found: -4.218750e-01 -6.299342e-01
+DEAL:0::point found: -4.218750e-01 6.299342e-01
+DEAL:0::point found: -3.750000e-01 -6.354167e-01
+DEAL:0::point found: -3.750000e-01 6.354167e-01
+DEAL:0::point found: -3.541667e-01 -6.562500e-01
+DEAL:0::point found: -3.541667e-01 6.562500e-01
+DEAL:0::point found: -3.281250e-01 -6.869877e-01
+DEAL:0::point found: -3.281250e-01 6.869877e-01
+DEAL:0::point found: -2.812500e-01 -7.031250e-01
+DEAL:0::point found: -2.812500e-01 7.031250e-01
+DEAL:0::point found: -2.343750e-01 -6.967905e-01
+DEAL:0::point found: -2.343750e-01 6.967905e-01
+DEAL:0::point found: -2.291667e-01 -7.031250e-01
+DEAL:0::point found: -2.291667e-01 7.031250e-01
+DEAL:0::point found: -1.875000e-01 -7.291667e-01
+DEAL:0::point found: -1.875000e-01 7.291667e-01
+DEAL:0::point found: -1.406250e-01 -7.291667e-01
+DEAL:0::point found: -1.406250e-01 7.291667e-01
+DEAL:0::point found: -9.375000e-02 -7.291667e-01
+DEAL:0::point found: -9.375000e-02 7.291667e-01
+DEAL:0::point found: -4.687500e-02 -7.279412e-01
+DEAL:0::point found: -4.687500e-02 7.279412e-01
+DEAL:0::point found: 0.000000e+00 -7.500000e-01
+DEAL:0::point found: 0.000000e+00 7.500000e-01
+DEAL:0::point found: 4.687500e-02 -7.279412e-01
+DEAL:0::point found: 4.687500e-02 7.279412e-01
+DEAL:0::point found: 9.375000e-02 -7.291667e-01
+DEAL:0::point found: 9.375000e-02 7.291667e-01
+DEAL:0::point found: 1.406250e-01 -7.291667e-01
+DEAL:0::point found: 1.406250e-01 7.291667e-01
+DEAL:0::point found: 1.875000e-01 -7.291667e-01
+DEAL:0::point found: 1.875000e-01 7.291667e-01
+DEAL:0::point found: 2.291667e-01 -7.031250e-01
+DEAL:0::point found: 2.291667e-01 7.031250e-01
+DEAL:0::point found: 2.343750e-01 -6.967905e-01
+DEAL:0::point found: 2.343750e-01 6.967905e-01
+DEAL:0::point found: 2.812500e-01 -7.031250e-01
+DEAL:0::point found: 2.812500e-01 7.031250e-01
+DEAL:0::point found: 3.281250e-01 -6.869877e-01
+DEAL:0::point found: 3.281250e-01 6.869877e-01
+DEAL:0::point found: 3.541667e-01 -6.562500e-01
+DEAL:0::point found: 3.541667e-01 6.562500e-01
+DEAL:0::point found: 3.750000e-01 -6.354167e-01
+DEAL:0::point found: 3.750000e-01 6.354167e-01
+DEAL:0::point found: 4.218750e-01 -6.299342e-01
+DEAL:0::point found: 4.218750e-01 6.299342e-01
+DEAL:0::point found: 4.399038e-01 -6.093750e-01
+DEAL:0::point found: 4.399038e-01 6.093750e-01
+DEAL:0::point found: 4.687500e-01 -5.833333e-01
+DEAL:0::point found: 4.687500e-01 5.833333e-01
+DEAL:0::point found: 5.156250e-01 -5.625000e-01
+DEAL:0::point found: 5.156250e-01 5.625000e-01
+DEAL:0::point found: 5.625000e-01 -5.156250e-01
+DEAL:0::point found: 5.625000e-01 5.156250e-01
+DEAL:0::point found: 5.833333e-01 -4.687500e-01
+DEAL:0::point found: 5.833333e-01 4.687500e-01
+DEAL:0::point found: 6.093750e-01 -4.399038e-01
+DEAL:0::point found: 6.093750e-01 4.399038e-01
+DEAL:0::point found: 6.299342e-01 -4.218750e-01
+DEAL:0::point found: 6.299342e-01 4.218750e-01
+DEAL:0::point found: 6.354167e-01 -3.750000e-01
+DEAL:0::point found: 6.354167e-01 3.750000e-01
+DEAL:0::point found: 6.562500e-01 -3.541667e-01
+DEAL:0::point found: 6.562500e-01 3.541667e-01
+DEAL:0::point found: 6.869877e-01 -3.281250e-01
+DEAL:0::point found: 6.869877e-01 3.281250e-01
+DEAL:0::point found: 6.967905e-01 -2.343750e-01
+DEAL:0::point found: 6.967905e-01 2.343750e-01
+DEAL:0::point found: 7.031250e-01 -2.812500e-01
+DEAL:0::point found: 7.031250e-01 -2.291667e-01
+DEAL:0::point found: 7.031250e-01 2.291667e-01
+DEAL:0::point found: 7.031250e-01 2.812500e-01
+DEAL:0::point found: 7.279412e-01 -4.687500e-02
+DEAL:0::point found: 7.279412e-01 4.687500e-02
+DEAL:0::point found: 7.291667e-01 -1.875000e-01
+DEAL:0::point found: 7.291667e-01 -1.406250e-01
+DEAL:0::point found: 7.291667e-01 -9.375000e-02
+DEAL:0::point found: 7.291667e-01 9.375000e-02
+DEAL:0::point found: 7.291667e-01 1.406250e-01
+DEAL:0::point found: 7.291667e-01 1.875000e-01
+DEAL:0::point found: 7.500000e-01 0.000000e+00
+DEAL:0::signed distance function
 DEAL:0::dim=2 iso level: 5.000000e-02
 DEAL:0::point found: -8.000000e-01 0.000000e+00
 DEAL:0::point found: -7.993891e-01 -3.125000e-02
@@ -399,3 +597,193 @@ DEAL:0::point found: 7.975538e-01 6.250000e-02
 DEAL:0::point found: 7.993891e-01 -3.125000e-02
 DEAL:0::point found: 7.993891e-01 3.125000e-02
 DEAL:0::point found: 8.000000e-01 0.000000e+00
+DEAL:0::heaviside function
+DEAL:0::dim=2 iso level: 0.000000e+00
+DEAL:0::point found: -7.500000e-01 0.000000e+00
+DEAL:0::point found: -7.354526e-01 -1.875000e-01
+DEAL:0::point found: -7.354526e-01 -1.562500e-01
+DEAL:0::point found: -7.354526e-01 -1.250000e-01
+DEAL:0::point found: -7.354526e-01 -9.375000e-02
+DEAL:0::point found: -7.354526e-01 9.375000e-02
+DEAL:0::point found: -7.354526e-01 1.250000e-01
+DEAL:0::point found: -7.354526e-01 1.562500e-01
+DEAL:0::point found: -7.354526e-01 1.875000e-01
+DEAL:0::point found: -7.351881e-01 -6.250000e-02
+DEAL:0::point found: -7.351881e-01 6.250000e-02
+DEAL:0::point found: -7.349330e-01 -3.125000e-02
+DEAL:0::point found: -7.349330e-01 3.125000e-02
+DEAL:0::point found: -7.187500e-01 -2.047255e-01
+DEAL:0::point found: -7.187500e-01 2.047255e-01
+DEAL:0::point found: -7.031250e-01 -2.812500e-01
+DEAL:0::point found: -7.031250e-01 2.812500e-01
+DEAL:0::point found: -7.023426e-01 -2.500000e-01
+DEAL:0::point found: -7.023426e-01 2.500000e-01
+DEAL:0::point found: -7.016165e-01 -2.187500e-01
+DEAL:0::point found: -7.016165e-01 2.187500e-01
+DEAL:0::point found: -7.004556e-01 -3.125000e-01
+DEAL:0::point found: -7.004556e-01 3.125000e-01
+DEAL:0::point found: -6.875000e-01 -3.243350e-01
+DEAL:0::point found: -6.875000e-01 3.243350e-01
+DEAL:0::point found: -6.732970e-01 -3.437500e-01
+DEAL:0::point found: -6.732970e-01 3.437500e-01
+DEAL:0::point found: -6.562500e-01 -3.604526e-01
+DEAL:0::point found: -6.562500e-01 3.604526e-01
+DEAL:0::point found: -6.417026e-01 -3.750000e-01
+DEAL:0::point found: -6.417026e-01 3.750000e-01
+DEAL:0::point found: -6.402744e-01 -4.062500e-01
+DEAL:0::point found: -6.402744e-01 4.062500e-01
+DEAL:0::point found: -6.250000e-01 -4.258583e-01
+DEAL:0::point found: -6.250000e-01 4.258583e-01
+DEAL:0::point found: -6.134208e-01 -4.375000e-01
+DEAL:0::point found: -6.134208e-01 4.375000e-01
+DEAL:0::point found: -5.937500e-01 -4.517654e-01
+DEAL:0::point found: -5.937500e-01 4.517654e-01
+DEAL:0::point found: -5.770474e-01 -4.687500e-01
+DEAL:0::point found: -5.770474e-01 4.687500e-01
+DEAL:0::point found: -5.753510e-01 -5.000000e-01
+DEAL:0::point found: -5.753510e-01 5.000000e-01
+DEAL:0::point found: -5.625000e-01 -5.156250e-01
+DEAL:0::point found: -5.625000e-01 5.156250e-01
+DEAL:0::point found: -5.312500e-01 -5.179280e-01
+DEAL:0::point found: -5.312500e-01 5.179280e-01
+DEAL:0::point found: -5.179280e-01 -5.312500e-01
+DEAL:0::point found: -5.179280e-01 5.312500e-01
+DEAL:0::point found: -5.156250e-01 -5.625000e-01
+DEAL:0::point found: -5.156250e-01 5.625000e-01
+DEAL:0::point found: -5.000000e-01 -5.753510e-01
+DEAL:0::point found: -5.000000e-01 5.753510e-01
+DEAL:0::point found: -4.687500e-01 -5.770474e-01
+DEAL:0::point found: -4.687500e-01 5.770474e-01
+DEAL:0::point found: -4.517654e-01 -5.937500e-01
+DEAL:0::point found: -4.517654e-01 5.937500e-01
+DEAL:0::point found: -4.375000e-01 -6.134208e-01
+DEAL:0::point found: -4.375000e-01 6.134208e-01
+DEAL:0::point found: -4.258583e-01 -6.250000e-01
+DEAL:0::point found: -4.258583e-01 6.250000e-01
+DEAL:0::point found: -4.062500e-01 -6.402744e-01
+DEAL:0::point found: -4.062500e-01 6.402744e-01
+DEAL:0::point found: -3.750000e-01 -6.417026e-01
+DEAL:0::point found: -3.750000e-01 6.417026e-01
+DEAL:0::point found: -3.604526e-01 -6.562500e-01
+DEAL:0::point found: -3.604526e-01 6.562500e-01
+DEAL:0::point found: -3.437500e-01 -6.732970e-01
+DEAL:0::point found: -3.437500e-01 6.732970e-01
+DEAL:0::point found: -3.243350e-01 -6.875000e-01
+DEAL:0::point found: -3.243350e-01 6.875000e-01
+DEAL:0::point found: -3.125000e-01 -7.004556e-01
+DEAL:0::point found: -3.125000e-01 7.004556e-01
+DEAL:0::point found: -2.812500e-01 -7.031250e-01
+DEAL:0::point found: -2.812500e-01 7.031250e-01
+DEAL:0::point found: -2.500000e-01 -7.023426e-01
+DEAL:0::point found: -2.500000e-01 7.023426e-01
+DEAL:0::point found: -2.187500e-01 -7.016165e-01
+DEAL:0::point found: -2.187500e-01 7.016165e-01
+DEAL:0::point found: -2.047255e-01 -7.187500e-01
+DEAL:0::point found: -2.047255e-01 7.187500e-01
+DEAL:0::point found: -1.875000e-01 -7.354526e-01
+DEAL:0::point found: -1.875000e-01 7.354526e-01
+DEAL:0::point found: -1.562500e-01 -7.354526e-01
+DEAL:0::point found: -1.562500e-01 7.354526e-01
+DEAL:0::point found: -1.250000e-01 -7.354526e-01
+DEAL:0::point found: -1.250000e-01 7.354526e-01
+DEAL:0::point found: -9.375000e-02 -7.354526e-01
+DEAL:0::point found: -9.375000e-02 7.354526e-01
+DEAL:0::point found: -6.250000e-02 -7.351881e-01
+DEAL:0::point found: -6.250000e-02 7.351881e-01
+DEAL:0::point found: -3.125000e-02 -7.349330e-01
+DEAL:0::point found: -3.125000e-02 7.349330e-01
+DEAL:0::point found: 0.000000e+00 -7.500000e-01
+DEAL:0::point found: 0.000000e+00 7.500000e-01
+DEAL:0::point found: 3.125000e-02 -7.349330e-01
+DEAL:0::point found: 3.125000e-02 7.349330e-01
+DEAL:0::point found: 6.250000e-02 -7.351881e-01
+DEAL:0::point found: 6.250000e-02 7.351881e-01
+DEAL:0::point found: 9.375000e-02 -7.354526e-01
+DEAL:0::point found: 9.375000e-02 7.354526e-01
+DEAL:0::point found: 1.250000e-01 -7.354526e-01
+DEAL:0::point found: 1.250000e-01 7.354526e-01
+DEAL:0::point found: 1.562500e-01 -7.354526e-01
+DEAL:0::point found: 1.562500e-01 7.354526e-01
+DEAL:0::point found: 1.875000e-01 -7.354526e-01
+DEAL:0::point found: 1.875000e-01 7.354526e-01
+DEAL:0::point found: 2.047255e-01 -7.187500e-01
+DEAL:0::point found: 2.047255e-01 7.187500e-01
+DEAL:0::point found: 2.187500e-01 -7.016165e-01
+DEAL:0::point found: 2.187500e-01 7.016165e-01
+DEAL:0::point found: 2.500000e-01 -7.023426e-01
+DEAL:0::point found: 2.500000e-01 7.023426e-01
+DEAL:0::point found: 2.812500e-01 -7.031250e-01
+DEAL:0::point found: 2.812500e-01 7.031250e-01
+DEAL:0::point found: 3.125000e-01 -7.004556e-01
+DEAL:0::point found: 3.125000e-01 7.004556e-01
+DEAL:0::point found: 3.243350e-01 -6.875000e-01
+DEAL:0::point found: 3.243350e-01 6.875000e-01
+DEAL:0::point found: 3.437500e-01 -6.732970e-01
+DEAL:0::point found: 3.437500e-01 6.732970e-01
+DEAL:0::point found: 3.604526e-01 -6.562500e-01
+DEAL:0::point found: 3.604526e-01 6.562500e-01
+DEAL:0::point found: 3.750000e-01 -6.417026e-01
+DEAL:0::point found: 3.750000e-01 6.417026e-01
+DEAL:0::point found: 4.062500e-01 -6.402744e-01
+DEAL:0::point found: 4.062500e-01 6.402744e-01
+DEAL:0::point found: 4.258583e-01 -6.250000e-01
+DEAL:0::point found: 4.258583e-01 6.250000e-01
+DEAL:0::point found: 4.375000e-01 -6.134208e-01
+DEAL:0::point found: 4.375000e-01 6.134208e-01
+DEAL:0::point found: 4.517654e-01 -5.937500e-01
+DEAL:0::point found: 4.517654e-01 5.937500e-01
+DEAL:0::point found: 4.687500e-01 -5.770474e-01
+DEAL:0::point found: 4.687500e-01 5.770474e-01
+DEAL:0::point found: 5.000000e-01 -5.753510e-01
+DEAL:0::point found: 5.000000e-01 5.753510e-01
+DEAL:0::point found: 5.156250e-01 -5.625000e-01
+DEAL:0::point found: 5.156250e-01 5.625000e-01
+DEAL:0::point found: 5.179280e-01 -5.312500e-01
+DEAL:0::point found: 5.179280e-01 5.312500e-01
+DEAL:0::point found: 5.312500e-01 -5.179280e-01
+DEAL:0::point found: 5.312500e-01 5.179280e-01
+DEAL:0::point found: 5.625000e-01 -5.156250e-01
+DEAL:0::point found: 5.625000e-01 5.156250e-01
+DEAL:0::point found: 5.753510e-01 -5.000000e-01
+DEAL:0::point found: 5.753510e-01 5.000000e-01
+DEAL:0::point found: 5.770474e-01 -4.687500e-01
+DEAL:0::point found: 5.770474e-01 4.687500e-01
+DEAL:0::point found: 5.937500e-01 -4.517654e-01
+DEAL:0::point found: 5.937500e-01 4.517654e-01
+DEAL:0::point found: 6.134208e-01 -4.375000e-01
+DEAL:0::point found: 6.134208e-01 4.375000e-01
+DEAL:0::point found: 6.250000e-01 -4.258583e-01
+DEAL:0::point found: 6.250000e-01 4.258583e-01
+DEAL:0::point found: 6.402744e-01 -4.062500e-01
+DEAL:0::point found: 6.402744e-01 4.062500e-01
+DEAL:0::point found: 6.417026e-01 -3.750000e-01
+DEAL:0::point found: 6.417026e-01 3.750000e-01
+DEAL:0::point found: 6.562500e-01 -3.604526e-01
+DEAL:0::point found: 6.562500e-01 3.604526e-01
+DEAL:0::point found: 6.732970e-01 -3.437500e-01
+DEAL:0::point found: 6.732970e-01 3.437500e-01
+DEAL:0::point found: 6.875000e-01 -3.243350e-01
+DEAL:0::point found: 6.875000e-01 3.243350e-01
+DEAL:0::point found: 7.004556e-01 -3.125000e-01
+DEAL:0::point found: 7.004556e-01 3.125000e-01
+DEAL:0::point found: 7.016165e-01 -2.187500e-01
+DEAL:0::point found: 7.016165e-01 2.187500e-01
+DEAL:0::point found: 7.023426e-01 -2.500000e-01
+DEAL:0::point found: 7.023426e-01 2.500000e-01
+DEAL:0::point found: 7.031250e-01 -2.812500e-01
+DEAL:0::point found: 7.031250e-01 2.812500e-01
+DEAL:0::point found: 7.187500e-01 -2.047255e-01
+DEAL:0::point found: 7.187500e-01 2.047255e-01
+DEAL:0::point found: 7.349330e-01 -3.125000e-02
+DEAL:0::point found: 7.349330e-01 3.125000e-02
+DEAL:0::point found: 7.351881e-01 -6.250000e-02
+DEAL:0::point found: 7.351881e-01 6.250000e-02
+DEAL:0::point found: 7.354526e-01 -1.875000e-01
+DEAL:0::point found: 7.354526e-01 -1.562500e-01
+DEAL:0::point found: 7.354526e-01 -1.250000e-01
+DEAL:0::point found: 7.354526e-01 -9.375000e-02
+DEAL:0::point found: 7.354526e-01 9.375000e-02
+DEAL:0::point found: 7.354526e-01 1.250000e-01
+DEAL:0::point found: 7.354526e-01 1.562500e-01
+DEAL:0::point found: 7.354526e-01 1.875000e-01
+DEAL:0::point found: 7.500000e-01 0.000000e+00

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.