]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Make Mapping::get_center() work with simplices. 14829/head
authorDavid Wells <drwells@email.unc.edu>
Sat, 25 Feb 2023 20:28:13 +0000 (15:28 -0500)
committerDavid Wells <drwells@email.unc.edu>
Fri, 3 Mar 2023 14:28:30 +0000 (09:28 -0500)
include/deal.II/fe/mapping.h
source/fe/mapping.cc
tests/simplex/mapping_01.cc [new file with mode: 0644]
tests/simplex/mapping_01.output [new file with mode: 0644]

index 99c3fc210919d89ef518305c0a7d5f675eb33d27..051406b2c4b1cab3a1558813e8bb59d145d54797 100644 (file)
@@ -361,7 +361,7 @@ public:
                const unsigned int face_no) const;
 
   /**
-   * Return the mapped center of a cell.
+   * Return one of two possible mapped centers of a cell.
    *
    * If you are using a (bi-,tri-)linear mapping that preserves vertex
    * locations, this function simply returns the value also produced by
@@ -371,21 +371,21 @@ public:
    * polynomials, for which the center may not coincide with the average of
    * the vertex locations.
    *
-   * By default, this function returns the push forward of the center of the
+   * By default, this function returns the push forward of the barycenter of the
    * reference cell. If the parameter
-   * @p map_center_of_reference_cell is set to false, than the return value
-   * will be the average of the vertex locations, as returned by the
+   * @p map_barycenter_of_reference_cell is set to false, then the returned
+   * value will be the average of the vertex locations, as returned by the
    * get_vertices() method.
    *
    * @param[in] cell The cell for which you want to compute the center
-   * @param[in] map_center_of_reference_cell A flag that switches the algorithm
-   * for the computation of the cell center from
+   * @param[in] map_barycenter_of_reference_cell A flag that switches the
+   * algorithm for the computation of the cell center from
    * transform_unit_to_real_cell() applied to the center of the reference cell
    * to computing the vertex averages.
    */
   virtual Point<spacedim>
   get_center(const typename Triangulation<dim, spacedim>::cell_iterator &cell,
-             const bool map_center_of_reference_cell = true) const;
+             const bool map_barycenter_of_reference_cell = true) const;
 
   /**
    * Return the bounding box of a mapped cell.
index 1da11f2088438fd6f954a8105839f4cb1a772b79..7d95cc3caf405b6574ce8e120dc4d6486b40af57 100644 (file)
@@ -82,14 +82,12 @@ template <int dim, int spacedim>
 Point<spacedim>
 Mapping<dim, spacedim>::get_center(
   const typename Triangulation<dim, spacedim>::cell_iterator &cell,
-  const bool map_center_of_reference_cell) const
+  const bool map_barycenter_of_reference_cell) const
 {
-  if (map_center_of_reference_cell)
+  if (map_barycenter_of_reference_cell)
     {
-      Point<dim> reference_center;
-      for (unsigned int d = 0; d < dim; ++d)
-        reference_center[d] = .5;
-      return transform_unit_to_real_cell(cell, reference_center);
+      return transform_unit_to_real_cell(
+        cell, cell->reference_cell().template barycenter<dim>());
     }
   else
     {
@@ -97,7 +95,7 @@ Mapping<dim, spacedim>::get_center(
       Point<spacedim> center;
       for (const auto &v : vertices)
         center += v;
-      return center / GeometryInfo<dim>::vertices_per_cell;
+      return center / cell->n_vertices();
     }
 }
 
diff --git a/tests/simplex/mapping_01.cc b/tests/simplex/mapping_01.cc
new file mode 100644 (file)
index 0000000..0a9f053
--- /dev/null
@@ -0,0 +1,105 @@
+// ---------------------------------------------------------------------
+//
+// Copyright (C) 2023 - 2023 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.md at
+// the top level directory of deal.II.
+//
+// ---------------------------------------------------------------------
+
+// Test mapping centers with simplices
+
+#include <deal.II/base/function.h>
+
+#include <deal.II/dofs/dof_handler.h>
+
+#include <deal.II/fe/fe_simplex_p.h>
+#include <deal.II/fe/fe_system.h>
+#include <deal.II/fe/mapping_fe.h>
+#include <deal.II/fe/mapping_fe_field.h>
+
+#include <deal.II/grid/grid_generator.h>
+#include <deal.II/grid/tria.h>
+
+#include <deal.II/numerics/vector_tools.h>
+
+#include "../tests.h"
+
+using namespace dealii;
+
+template <int dim>
+class Position : public Function<dim>
+{
+public:
+  Position()
+    : Function<dim>(dim)
+  {}
+
+  double
+  value(const Point<dim> &point, const unsigned int component) const
+  {
+    if (component == 0)
+      return point[component] + std::sin(point[dim - 1] * numbers::PI);
+    return point[component];
+  }
+};
+
+void
+test(const unsigned int mapping_degree)
+{
+  const int dim = 3;
+
+  Triangulation<dim> tria;
+  GridGenerator::subdivided_hyper_cube_with_simplices(tria, 2);
+
+  FE_SimplexP<dim> fe(mapping_degree);
+  FESystem<dim>    position_fe(fe, dim);
+
+  DoFHandler<dim> dof_handler(tria);
+  dof_handler.distribute_dofs(fe);
+
+  DoFHandler<dim> position_dof_handler(tria);
+  position_dof_handler.distribute_dofs(position_fe);
+
+  Vector<double> position_vector(position_dof_handler.n_dofs());
+  MappingFE<dim> mapping_interpolation(FE_SimplexP<dim>(1));
+  VectorTools::interpolate(mapping_interpolation,
+                           position_dof_handler,
+                           Position<dim>(),
+                           position_vector);
+
+  MappingFEField<dim> mapping(position_dof_handler, position_vector);
+
+  for (const auto &cell : tria.active_cell_iterators())
+    {
+      deallog << "cell = " << cell << std::endl;
+      deallog << "mapped barycenter       = " << mapping.get_center(cell, true)
+              << std::endl;
+      Point<dim> manually_mapped_center;
+      for (unsigned int d = 0; d < dim; ++d)
+        manually_mapped_center[d] =
+          Position<dim>().value(cell->barycenter(), d);
+      deallog << "exact mapped barycenter = " << manually_mapped_center
+              << std::endl;
+      deallog << "mapped vertex mean      = " << mapping.get_center(cell, false)
+              << std::endl;
+    }
+}
+
+int
+main()
+{
+  initlog();
+
+  test(1); // linear mapping
+
+  deallog << std::endl << "quadratic mapping" << std::endl << std::endl;
+
+  test(2); // quadratic mapping
+}
diff --git a/tests/simplex/mapping_01.output b/tests/simplex/mapping_01.output
new file mode 100644 (file)
index 0000000..88e2683
--- /dev/null
@@ -0,0 +1,324 @@
+
+DEAL::cell = 0.0
+DEAL::mapped barycenter       = 0.375000 0.125000 0.125000
+DEAL::exact mapped barycenter = 0.507683 0.125000 0.125000
+DEAL::mapped vertex mean      = 0.375000 0.125000 0.125000
+DEAL::cell = 0.1
+DEAL::mapped barycenter       = 0.625000 0.375000 0.125000
+DEAL::exact mapped barycenter = 0.757683 0.375000 0.125000
+DEAL::mapped vertex mean      = 0.625000 0.375000 0.125000
+DEAL::cell = 0.2
+DEAL::mapped barycenter       = 1.12500 0.125000 0.375000
+DEAL::exact mapped barycenter = 1.29888 0.125000 0.375000
+DEAL::mapped vertex mean      = 1.12500 0.125000 0.375000
+DEAL::cell = 0.3
+DEAL::mapped barycenter       = 0.875000 0.375000 0.375000
+DEAL::exact mapped barycenter = 1.04888 0.375000 0.375000
+DEAL::mapped vertex mean      = 0.875000 0.375000 0.375000
+DEAL::cell = 0.4
+DEAL::mapped barycenter       = 0.750000 0.250000 0.250000
+DEAL::exact mapped barycenter = 0.957107 0.250000 0.250000
+DEAL::mapped vertex mean      = 0.750000 0.250000 0.250000
+DEAL::cell = 0.5
+DEAL::mapped barycenter       = 1.12500 0.125000 0.125000
+DEAL::exact mapped barycenter = 1.25768 0.125000 0.125000
+DEAL::mapped vertex mean      = 1.12500 0.125000 0.125000
+DEAL::cell = 0.6
+DEAL::mapped barycenter       = 0.875000 0.375000 0.125000
+DEAL::exact mapped barycenter = 1.00768 0.375000 0.125000
+DEAL::mapped vertex mean      = 0.875000 0.375000 0.125000
+DEAL::cell = 0.7
+DEAL::mapped barycenter       = 1.37500 0.125000 0.375000
+DEAL::exact mapped barycenter = 1.54888 0.125000 0.375000
+DEAL::mapped vertex mean      = 1.37500 0.125000 0.375000
+DEAL::cell = 0.8
+DEAL::mapped barycenter       = 1.62500 0.375000 0.375000
+DEAL::exact mapped barycenter = 1.79888 0.375000 0.375000
+DEAL::mapped vertex mean      = 1.62500 0.375000 0.375000
+DEAL::cell = 0.9
+DEAL::mapped barycenter       = 1.25000 0.250000 0.250000
+DEAL::exact mapped barycenter = 1.45711 0.250000 0.250000
+DEAL::mapped vertex mean      = 1.25000 0.250000 0.250000
+DEAL::cell = 0.10
+DEAL::mapped barycenter       = 0.625000 0.625000 0.125000
+DEAL::exact mapped barycenter = 0.757683 0.625000 0.125000
+DEAL::mapped vertex mean      = 0.625000 0.625000 0.125000
+DEAL::cell = 0.11
+DEAL::mapped barycenter       = 0.375000 0.875000 0.125000
+DEAL::exact mapped barycenter = 0.507683 0.875000 0.125000
+DEAL::mapped vertex mean      = 0.375000 0.875000 0.125000
+DEAL::cell = 0.12
+DEAL::mapped barycenter       = 0.875000 0.625000 0.375000
+DEAL::exact mapped barycenter = 1.04888 0.625000 0.375000
+DEAL::mapped vertex mean      = 0.875000 0.625000 0.375000
+DEAL::cell = 0.13
+DEAL::mapped barycenter       = 1.12500 0.875000 0.375000
+DEAL::exact mapped barycenter = 1.29888 0.875000 0.375000
+DEAL::mapped vertex mean      = 1.12500 0.875000 0.375000
+DEAL::cell = 0.14
+DEAL::mapped barycenter       = 0.750000 0.750000 0.250000
+DEAL::exact mapped barycenter = 0.957107 0.750000 0.250000
+DEAL::mapped vertex mean      = 0.750000 0.750000 0.250000
+DEAL::cell = 0.15
+DEAL::mapped barycenter       = 0.875000 0.625000 0.125000
+DEAL::exact mapped barycenter = 1.00768 0.625000 0.125000
+DEAL::mapped vertex mean      = 0.875000 0.625000 0.125000
+DEAL::cell = 0.16
+DEAL::mapped barycenter       = 1.12500 0.875000 0.125000
+DEAL::exact mapped barycenter = 1.25768 0.875000 0.125000
+DEAL::mapped vertex mean      = 1.12500 0.875000 0.125000
+DEAL::cell = 0.17
+DEAL::mapped barycenter       = 1.62500 0.625000 0.375000
+DEAL::exact mapped barycenter = 1.79888 0.625000 0.375000
+DEAL::mapped vertex mean      = 1.62500 0.625000 0.375000
+DEAL::cell = 0.18
+DEAL::mapped barycenter       = 1.37500 0.875000 0.375000
+DEAL::exact mapped barycenter = 1.54888 0.875000 0.375000
+DEAL::mapped vertex mean      = 1.37500 0.875000 0.375000
+DEAL::cell = 0.19
+DEAL::mapped barycenter       = 1.25000 0.750000 0.250000
+DEAL::exact mapped barycenter = 1.45711 0.750000 0.250000
+DEAL::mapped vertex mean      = 1.25000 0.750000 0.250000
+DEAL::cell = 0.20
+DEAL::mapped barycenter       = 1.12500 0.125000 0.625000
+DEAL::exact mapped barycenter = 1.29888 0.125000 0.625000
+DEAL::mapped vertex mean      = 1.12500 0.125000 0.625000
+DEAL::cell = 0.21
+DEAL::mapped barycenter       = 0.875000 0.375000 0.625000
+DEAL::exact mapped barycenter = 1.04888 0.375000 0.625000
+DEAL::mapped vertex mean      = 0.875000 0.375000 0.625000
+DEAL::cell = 0.22
+DEAL::mapped barycenter       = 0.375000 0.125000 0.875000
+DEAL::exact mapped barycenter = 0.507683 0.125000 0.875000
+DEAL::mapped vertex mean      = 0.375000 0.125000 0.875000
+DEAL::cell = 0.23
+DEAL::mapped barycenter       = 0.625000 0.375000 0.875000
+DEAL::exact mapped barycenter = 0.757683 0.375000 0.875000
+DEAL::mapped vertex mean      = 0.625000 0.375000 0.875000
+DEAL::cell = 0.24
+DEAL::mapped barycenter       = 0.750000 0.250000 0.750000
+DEAL::exact mapped barycenter = 0.957107 0.250000 0.750000
+DEAL::mapped vertex mean      = 0.750000 0.250000 0.750000
+DEAL::cell = 0.25
+DEAL::mapped barycenter       = 1.37500 0.125000 0.625000
+DEAL::exact mapped barycenter = 1.54888 0.125000 0.625000
+DEAL::mapped vertex mean      = 1.37500 0.125000 0.625000
+DEAL::cell = 0.26
+DEAL::mapped barycenter       = 1.62500 0.375000 0.625000
+DEAL::exact mapped barycenter = 1.79888 0.375000 0.625000
+DEAL::mapped vertex mean      = 1.62500 0.375000 0.625000
+DEAL::cell = 0.27
+DEAL::mapped barycenter       = 1.12500 0.125000 0.875000
+DEAL::exact mapped barycenter = 1.25768 0.125000 0.875000
+DEAL::mapped vertex mean      = 1.12500 0.125000 0.875000
+DEAL::cell = 0.28
+DEAL::mapped barycenter       = 0.875000 0.375000 0.875000
+DEAL::exact mapped barycenter = 1.00768 0.375000 0.875000
+DEAL::mapped vertex mean      = 0.875000 0.375000 0.875000
+DEAL::cell = 0.29
+DEAL::mapped barycenter       = 1.25000 0.250000 0.750000
+DEAL::exact mapped barycenter = 1.45711 0.250000 0.750000
+DEAL::mapped vertex mean      = 1.25000 0.250000 0.750000
+DEAL::cell = 0.30
+DEAL::mapped barycenter       = 0.875000 0.625000 0.625000
+DEAL::exact mapped barycenter = 1.04888 0.625000 0.625000
+DEAL::mapped vertex mean      = 0.875000 0.625000 0.625000
+DEAL::cell = 0.31
+DEAL::mapped barycenter       = 1.12500 0.875000 0.625000
+DEAL::exact mapped barycenter = 1.29888 0.875000 0.625000
+DEAL::mapped vertex mean      = 1.12500 0.875000 0.625000
+DEAL::cell = 0.32
+DEAL::mapped barycenter       = 0.625000 0.625000 0.875000
+DEAL::exact mapped barycenter = 0.757683 0.625000 0.875000
+DEAL::mapped vertex mean      = 0.625000 0.625000 0.875000
+DEAL::cell = 0.33
+DEAL::mapped barycenter       = 0.375000 0.875000 0.875000
+DEAL::exact mapped barycenter = 0.507683 0.875000 0.875000
+DEAL::mapped vertex mean      = 0.375000 0.875000 0.875000
+DEAL::cell = 0.34
+DEAL::mapped barycenter       = 0.750000 0.750000 0.750000
+DEAL::exact mapped barycenter = 0.957107 0.750000 0.750000
+DEAL::mapped vertex mean      = 0.750000 0.750000 0.750000
+DEAL::cell = 0.35
+DEAL::mapped barycenter       = 1.62500 0.625000 0.625000
+DEAL::exact mapped barycenter = 1.79888 0.625000 0.625000
+DEAL::mapped vertex mean      = 1.62500 0.625000 0.625000
+DEAL::cell = 0.36
+DEAL::mapped barycenter       = 1.37500 0.875000 0.625000
+DEAL::exact mapped barycenter = 1.54888 0.875000 0.625000
+DEAL::mapped vertex mean      = 1.37500 0.875000 0.625000
+DEAL::cell = 0.37
+DEAL::mapped barycenter       = 0.875000 0.625000 0.875000
+DEAL::exact mapped barycenter = 1.00768 0.625000 0.875000
+DEAL::mapped vertex mean      = 0.875000 0.625000 0.875000
+DEAL::cell = 0.38
+DEAL::mapped barycenter       = 1.12500 0.875000 0.875000
+DEAL::exact mapped barycenter = 1.25768 0.875000 0.875000
+DEAL::mapped vertex mean      = 1.12500 0.875000 0.875000
+DEAL::cell = 0.39
+DEAL::mapped barycenter       = 1.25000 0.750000 0.750000
+DEAL::exact mapped barycenter = 1.45711 0.750000 0.750000
+DEAL::mapped vertex mean      = 1.25000 0.750000 0.750000
+DEAL::
+DEAL::quadratic mapping
+DEAL::
+DEAL::cell = 0.0
+DEAL::mapped barycenter       = 0.530330 0.125000 0.125000
+DEAL::exact mapped barycenter = 0.507683 0.125000 0.125000
+DEAL::mapped vertex mean      = 0.375000 0.125000 0.125000
+DEAL::cell = 0.1
+DEAL::mapped barycenter       = 0.780330 0.375000 0.125000
+DEAL::exact mapped barycenter = 0.757683 0.375000 0.125000
+DEAL::mapped vertex mean      = 0.625000 0.375000 0.125000
+DEAL::cell = 0.2
+DEAL::mapped barycenter       = 1.28033 0.125000 0.375000
+DEAL::exact mapped barycenter = 1.29888 0.125000 0.375000
+DEAL::mapped vertex mean      = 1.12500 0.125000 0.375000
+DEAL::cell = 0.3
+DEAL::mapped barycenter       = 1.03033 0.375000 0.375000
+DEAL::exact mapped barycenter = 1.04888 0.375000 0.375000
+DEAL::mapped vertex mean      = 0.875000 0.375000 0.375000
+DEAL::cell = 0.4
+DEAL::mapped barycenter       = 0.957107 0.250000 0.250000
+DEAL::exact mapped barycenter = 0.957107 0.250000 0.250000
+DEAL::mapped vertex mean      = 0.750000 0.250000 0.250000
+DEAL::cell = 0.5
+DEAL::mapped barycenter       = 1.28033 0.125000 0.125000
+DEAL::exact mapped barycenter = 1.25768 0.125000 0.125000
+DEAL::mapped vertex mean      = 1.12500 0.125000 0.125000
+DEAL::cell = 0.6
+DEAL::mapped barycenter       = 1.03033 0.375000 0.125000
+DEAL::exact mapped barycenter = 1.00768 0.375000 0.125000
+DEAL::mapped vertex mean      = 0.875000 0.375000 0.125000
+DEAL::cell = 0.7
+DEAL::mapped barycenter       = 1.53033 0.125000 0.375000
+DEAL::exact mapped barycenter = 1.54888 0.125000 0.375000
+DEAL::mapped vertex mean      = 1.37500 0.125000 0.375000
+DEAL::cell = 0.8
+DEAL::mapped barycenter       = 1.78033 0.375000 0.375000
+DEAL::exact mapped barycenter = 1.79888 0.375000 0.375000
+DEAL::mapped vertex mean      = 1.62500 0.375000 0.375000
+DEAL::cell = 0.9
+DEAL::mapped barycenter       = 1.45711 0.250000 0.250000
+DEAL::exact mapped barycenter = 1.45711 0.250000 0.250000
+DEAL::mapped vertex mean      = 1.25000 0.250000 0.250000
+DEAL::cell = 0.10
+DEAL::mapped barycenter       = 0.780330 0.625000 0.125000
+DEAL::exact mapped barycenter = 0.757683 0.625000 0.125000
+DEAL::mapped vertex mean      = 0.625000 0.625000 0.125000
+DEAL::cell = 0.11
+DEAL::mapped barycenter       = 0.530330 0.875000 0.125000
+DEAL::exact mapped barycenter = 0.507683 0.875000 0.125000
+DEAL::mapped vertex mean      = 0.375000 0.875000 0.125000
+DEAL::cell = 0.12
+DEAL::mapped barycenter       = 1.03033 0.625000 0.375000
+DEAL::exact mapped barycenter = 1.04888 0.625000 0.375000
+DEAL::mapped vertex mean      = 0.875000 0.625000 0.375000
+DEAL::cell = 0.13
+DEAL::mapped barycenter       = 1.28033 0.875000 0.375000
+DEAL::exact mapped barycenter = 1.29888 0.875000 0.375000
+DEAL::mapped vertex mean      = 1.12500 0.875000 0.375000
+DEAL::cell = 0.14
+DEAL::mapped barycenter       = 0.957107 0.750000 0.250000
+DEAL::exact mapped barycenter = 0.957107 0.750000 0.250000
+DEAL::mapped vertex mean      = 0.750000 0.750000 0.250000
+DEAL::cell = 0.15
+DEAL::mapped barycenter       = 1.03033 0.625000 0.125000
+DEAL::exact mapped barycenter = 1.00768 0.625000 0.125000
+DEAL::mapped vertex mean      = 0.875000 0.625000 0.125000
+DEAL::cell = 0.16
+DEAL::mapped barycenter       = 1.28033 0.875000 0.125000
+DEAL::exact mapped barycenter = 1.25768 0.875000 0.125000
+DEAL::mapped vertex mean      = 1.12500 0.875000 0.125000
+DEAL::cell = 0.17
+DEAL::mapped barycenter       = 1.78033 0.625000 0.375000
+DEAL::exact mapped barycenter = 1.79888 0.625000 0.375000
+DEAL::mapped vertex mean      = 1.62500 0.625000 0.375000
+DEAL::cell = 0.18
+DEAL::mapped barycenter       = 1.53033 0.875000 0.375000
+DEAL::exact mapped barycenter = 1.54888 0.875000 0.375000
+DEAL::mapped vertex mean      = 1.37500 0.875000 0.375000
+DEAL::cell = 0.19
+DEAL::mapped barycenter       = 1.45711 0.750000 0.250000
+DEAL::exact mapped barycenter = 1.45711 0.750000 0.250000
+DEAL::mapped vertex mean      = 1.25000 0.750000 0.250000
+DEAL::cell = 0.20
+DEAL::mapped barycenter       = 1.28033 0.125000 0.625000
+DEAL::exact mapped barycenter = 1.29888 0.125000 0.625000
+DEAL::mapped vertex mean      = 1.12500 0.125000 0.625000
+DEAL::cell = 0.21
+DEAL::mapped barycenter       = 1.03033 0.375000 0.625000
+DEAL::exact mapped barycenter = 1.04888 0.375000 0.625000
+DEAL::mapped vertex mean      = 0.875000 0.375000 0.625000
+DEAL::cell = 0.22
+DEAL::mapped barycenter       = 0.530330 0.125000 0.875000
+DEAL::exact mapped barycenter = 0.507683 0.125000 0.875000
+DEAL::mapped vertex mean      = 0.375000 0.125000 0.875000
+DEAL::cell = 0.23
+DEAL::mapped barycenter       = 0.780330 0.375000 0.875000
+DEAL::exact mapped barycenter = 0.757683 0.375000 0.875000
+DEAL::mapped vertex mean      = 0.625000 0.375000 0.875000
+DEAL::cell = 0.24
+DEAL::mapped barycenter       = 0.957107 0.250000 0.750000
+DEAL::exact mapped barycenter = 0.957107 0.250000 0.750000
+DEAL::mapped vertex mean      = 0.750000 0.250000 0.750000
+DEAL::cell = 0.25
+DEAL::mapped barycenter       = 1.53033 0.125000 0.625000
+DEAL::exact mapped barycenter = 1.54888 0.125000 0.625000
+DEAL::mapped vertex mean      = 1.37500 0.125000 0.625000
+DEAL::cell = 0.26
+DEAL::mapped barycenter       = 1.78033 0.375000 0.625000
+DEAL::exact mapped barycenter = 1.79888 0.375000 0.625000
+DEAL::mapped vertex mean      = 1.62500 0.375000 0.625000
+DEAL::cell = 0.27
+DEAL::mapped barycenter       = 1.28033 0.125000 0.875000
+DEAL::exact mapped barycenter = 1.25768 0.125000 0.875000
+DEAL::mapped vertex mean      = 1.12500 0.125000 0.875000
+DEAL::cell = 0.28
+DEAL::mapped barycenter       = 1.03033 0.375000 0.875000
+DEAL::exact mapped barycenter = 1.00768 0.375000 0.875000
+DEAL::mapped vertex mean      = 0.875000 0.375000 0.875000
+DEAL::cell = 0.29
+DEAL::mapped barycenter       = 1.45711 0.250000 0.750000
+DEAL::exact mapped barycenter = 1.45711 0.250000 0.750000
+DEAL::mapped vertex mean      = 1.25000 0.250000 0.750000
+DEAL::cell = 0.30
+DEAL::mapped barycenter       = 1.03033 0.625000 0.625000
+DEAL::exact mapped barycenter = 1.04888 0.625000 0.625000
+DEAL::mapped vertex mean      = 0.875000 0.625000 0.625000
+DEAL::cell = 0.31
+DEAL::mapped barycenter       = 1.28033 0.875000 0.625000
+DEAL::exact mapped barycenter = 1.29888 0.875000 0.625000
+DEAL::mapped vertex mean      = 1.12500 0.875000 0.625000
+DEAL::cell = 0.32
+DEAL::mapped barycenter       = 0.780330 0.625000 0.875000
+DEAL::exact mapped barycenter = 0.757683 0.625000 0.875000
+DEAL::mapped vertex mean      = 0.625000 0.625000 0.875000
+DEAL::cell = 0.33
+DEAL::mapped barycenter       = 0.530330 0.875000 0.875000
+DEAL::exact mapped barycenter = 0.507683 0.875000 0.875000
+DEAL::mapped vertex mean      = 0.375000 0.875000 0.875000
+DEAL::cell = 0.34
+DEAL::mapped barycenter       = 0.957107 0.750000 0.750000
+DEAL::exact mapped barycenter = 0.957107 0.750000 0.750000
+DEAL::mapped vertex mean      = 0.750000 0.750000 0.750000
+DEAL::cell = 0.35
+DEAL::mapped barycenter       = 1.78033 0.625000 0.625000
+DEAL::exact mapped barycenter = 1.79888 0.625000 0.625000
+DEAL::mapped vertex mean      = 1.62500 0.625000 0.625000
+DEAL::cell = 0.36
+DEAL::mapped barycenter       = 1.53033 0.875000 0.625000
+DEAL::exact mapped barycenter = 1.54888 0.875000 0.625000
+DEAL::mapped vertex mean      = 1.37500 0.875000 0.625000
+DEAL::cell = 0.37
+DEAL::mapped barycenter       = 1.03033 0.625000 0.875000
+DEAL::exact mapped barycenter = 1.00768 0.625000 0.875000
+DEAL::mapped vertex mean      = 0.875000 0.625000 0.875000
+DEAL::cell = 0.38
+DEAL::mapped barycenter       = 1.28033 0.875000 0.875000
+DEAL::exact mapped barycenter = 1.25768 0.875000 0.875000
+DEAL::mapped vertex mean      = 1.12500 0.875000 0.875000
+DEAL::cell = 0.39
+DEAL::mapped barycenter       = 1.45711 0.750000 0.750000
+DEAL::exact mapped barycenter = 1.45711 0.750000 0.750000
+DEAL::mapped vertex mean      = 1.25000 0.750000 0.750000

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.