]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Remove tests for overridden project_to_surface.
authorDavid Wells <wellsd2@rpi.edu>
Sat, 12 Aug 2017 15:46:36 +0000 (11:46 -0400)
committerDavid Wells <wellsd2@rpi.edu>
Sun, 8 Oct 2017 23:22:35 +0000 (19:22 -0400)
Since a previous commit removed the call inside
GridTools::fix_up_distorted_child_cells to Boundary::project_to_surface,
testing overriden implementations of this function no longer makes
sense.

tests/bits/distorted_cells_04.cc [deleted file]
tests/bits/distorted_cells_04.debug.output [deleted file]
tests/bits/distorted_cells_05.cc [deleted file]
tests/bits/distorted_cells_05.debug.output [deleted file]

diff --git a/tests/bits/distorted_cells_04.cc b/tests/bits/distorted_cells_04.cc
deleted file mode 100644 (file)
index be3f684..0000000
+++ /dev/null
@@ -1,156 +0,0 @@
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2003 - 2015 by the deal.II authors
-//
-// This file is part of the deal.II library.
-//
-// The deal.II library is free software; you can use it, redistribute
-// it, and/or modify it under the terms of the GNU Lesser General
-// Public License as published by the Free Software Foundation; either
-// version 2.1 of the License, or (at your option) any later version.
-// The full text of the license can be found in the file LICENSE at
-// the top level of the deal.II distribution.
-//
-// ---------------------------------------------------------------------
-
-
-
-// like _03, but catch the exception and pass it to GridTools::fix_up_distorted_child_cells
-
-#include "../tests.h"
-#include <deal.II/base/quadrature_lib.h>
-#include <deal.II/grid/tria.h>
-#include <deal.II/grid/tria_accessor.h>
-#include <deal.II/grid/tria_iterator.h>
-#include <deal.II/grid/grid_reordering.h>
-#include <deal.II/grid/grid_tools.h>
-#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/tria_boundary.h>
-#include <deal.II/grid/grid_out.h>
-#include <deal.II/dofs/dof_handler.h>
-#include <deal.II/fe/fe_q.h>
-#include <deal.II/fe/fe_values.h>
-
-
-
-template <int dim>
-class MyBoundary : public Boundary<dim>
-{
-  virtual Point<dim>
-  get_new_point_on_line (const typename Triangulation<dim>::line_iterator &line) const
-  {
-    deallog << "Finding point between "
-            << line->vertex(0) << " and "
-            << line->vertex(1) << std::endl;
-
-    // in 2d, find a point that
-    // lies on the opposite side
-    // of the quad. in 3d, choose
-    // the midpoint of the edge
-    if (dim == 2)
-      return Point<dim>(0,0.75);
-    else
-      return (line->vertex(0) + line->vertex(1)) / 2;
-  }
-
-  virtual Point<dim>
-  get_new_point_on_quad (const typename Triangulation<dim>::quad_iterator &quad) const
-  {
-    deallog << "Finding point between "
-            << quad->vertex(0) << " and "
-            << quad->vertex(1) << " and "
-            << quad->vertex(2) << " and "
-            << quad->vertex(3) << std::endl;
-
-    return Point<dim>(0,0,.75);
-  }
-
-  virtual
-  Point<dim>
-  project_to_surface (const typename Triangulation<dim>::line_iterator &,
-                      const Point<dim> &p) const
-  {
-    deallog << "Projecting line point " << p << std::endl;
-
-    if (dim == 2)
-      return Point<dim>(p[0], 0.75-1.75*std::fabs(p[0]));
-    else
-      return p;
-  }
-
-  virtual
-  Point<dim>
-  project_to_surface (const typename Triangulation<dim>::quad_iterator &,
-                      const Point<dim> &p) const
-  {
-    deallog << "Projecting quad point " << p << std::endl;
-
-    Assert (dim == 3, ExcInternalError());
-
-    return Point<dim>(p[0], p[1],
-                      0.75-1.75*std::max(std::fabs(p[0]),
-                                         std::fabs(p[1])));
-  }
-
-  virtual
-  Point<dim>
-  project_to_surface (const typename Triangulation<dim>::hex_iterator &,
-                      const Point<dim> &) const
-  {
-    Assert (false, ExcInternalError());
-    return Point<dim>();
-  }
-};
-
-
-
-template <int dim>
-void check ()
-{
-  MyBoundary<dim> my_boundary;
-
-  // create a single square/cube
-  Triangulation<dim> coarse_grid (Triangulation<dim>::none, true);
-  GridGenerator::hyper_cube (coarse_grid, -1, 1);
-
-  // set bottom face to use MyBoundary
-  for (unsigned int f=0; f<GeometryInfo<dim>::faces_per_cell; ++f)
-    if (coarse_grid.begin_active()->face(f)->center()[dim-1] == -1)
-      coarse_grid.begin_active()->face(f)->set_boundary_id (1);
-  coarse_grid.set_boundary (1, my_boundary);
-
-  // now try to refine this one
-  // cell. we should get an exception
-  try
-    {
-      coarse_grid.begin_active()->set_refine_flag ();
-      coarse_grid.execute_coarsening_and_refinement ();
-    }
-  catch (typename Triangulation<dim>::DistortedCellList &dcv)
-    {
-      typename Triangulation<dim>::DistortedCellList
-      subset = GridTools::fix_up_distorted_child_cells (dcv,
-                                                        coarse_grid);
-      Assert (subset.distorted_cells.size() == 0,
-              ExcInternalError());
-    }
-
-  Assert (coarse_grid.n_levels() == 2, ExcInternalError());
-  Assert (coarse_grid.n_active_cells() == 1<<dim, ExcInternalError());
-
-  // output the coordinates of the
-  // child cells
-  GridOut().write_gnuplot (coarse_grid, deallog.get_file_stream());
-}
-
-
-int main ()
-{
-  initlog();
-
-  check<2> ();
-  check<3> ();
-}
-
-
-
diff --git a/tests/bits/distorted_cells_04.debug.output b/tests/bits/distorted_cells_04.debug.output
deleted file mode 100644 (file)
index 0c189e2..0000000
+++ /dev/null
@@ -1,233 +0,0 @@
-
-DEAL::Finding point between -1.00000 -1.00000 and 1.00000 -1.00000
-DEAL::Projecting line point 0.0250000 0.750000
-DEAL::Projecting line point -0.0250000 0.750000
-DEAL::Projecting line point 0.00000 0.775000
-DEAL::Projecting line point 0.00000 0.725000
--1.00000 -1.00000 1 0
-0.00000 0.750000 1 0
-2.06045e-12 0.955320 1 0
--1.00000 0.00000 1 0
--1.00000 -1.00000 1 0
-
-
-0.00000 0.750000 1 0
-1.00000 -1.00000 1 0
-1.00000 0.00000 1 0
-2.06045e-12 0.955320 1 0
-0.00000 0.750000 1 0
-
-
--1.00000 0.00000 1 0
-2.06045e-12 0.955320 1 0
-0.00000 1.00000 1 0
--1.00000 1.00000 1 0
--1.00000 0.00000 1 0
-
-
-2.06045e-12 0.955320 1 0
-1.00000 0.00000 1 0
-1.00000 1.00000 1 0
-0.00000 1.00000 1 0
-2.06045e-12 0.955320 1 0
-
-
-DEAL::Finding point between -1.00000 -1.00000 -1.00000 and 1.00000 -1.00000 -1.00000 and -1.00000 1.00000 -1.00000 and 1.00000 1.00000 -1.00000
-DEAL::Projecting quad point 0.0176777 0.00000 0.750000
-DEAL::Projecting quad point -0.0176777 0.00000 0.750000
-DEAL::Projecting quad point 0.00000 0.0176777 0.750000
-DEAL::Projecting quad point 0.00000 -0.0176777 0.750000
-DEAL::Projecting quad point 0.00000 0.00000 0.767678
-DEAL::Projecting quad point 0.00000 0.00000 0.732322
--1.00000 -1.00000 -1.00000 1 0
-0.00000 -1.00000 -1.00000 1 0
-0.00000 -1.00000 0.00000 1 0
--1.00000 -1.00000 0.00000 1 0
--1.00000 -1.00000 -1.00000 1 0
-
--1.00000 0.00000 -1.00000 1 0
-0.00000 0.00000 0.750000 1 0
-9.30035e-11 2.00529e-11 0.811692 1 0
--1.00000 0.00000 0.00000 1 0
--1.00000 0.00000 -1.00000 1 0
-
--1.00000 -1.00000 -1.00000 1 0
--1.00000 0.00000 -1.00000 1 0
-
-0.00000 -1.00000 -1.00000 1 0
-0.00000 0.00000 0.750000 1 0
-
-0.00000 -1.00000 0.00000 1 0
-9.30035e-11 2.00529e-11 0.811692 1 0
-
--1.00000 -1.00000 0.00000 1 0
--1.00000 0.00000 0.00000 1 0
-
-0.00000 -1.00000 -1.00000 1 0
-1.00000 -1.00000 -1.00000 1 0
-1.00000 -1.00000 0.00000 1 0
-0.00000 -1.00000 0.00000 1 0
-0.00000 -1.00000 -1.00000 1 0
-
-0.00000 0.00000 0.750000 1 0
-1.00000 0.00000 -1.00000 1 0
-1.00000 0.00000 0.00000 1 0
-9.30035e-11 2.00529e-11 0.811692 1 0
-0.00000 0.00000 0.750000 1 0
-
-0.00000 -1.00000 -1.00000 1 0
-0.00000 0.00000 0.750000 1 0
-
-1.00000 -1.00000 -1.00000 1 0
-1.00000 0.00000 -1.00000 1 0
-
-1.00000 -1.00000 0.00000 1 0
-1.00000 0.00000 0.00000 1 0
-
-0.00000 -1.00000 0.00000 1 0
-9.30035e-11 2.00529e-11 0.811692 1 0
-
--1.00000 0.00000 -1.00000 1 0
-0.00000 0.00000 0.750000 1 0
-9.30035e-11 2.00529e-11 0.811692 1 0
--1.00000 0.00000 0.00000 1 0
--1.00000 0.00000 -1.00000 1 0
-
--1.00000 1.00000 -1.00000 1 0
-0.00000 1.00000 -1.00000 1 0
-0.00000 1.00000 0.00000 1 0
--1.00000 1.00000 0.00000 1 0
--1.00000 1.00000 -1.00000 1 0
-
--1.00000 0.00000 -1.00000 1 0
--1.00000 1.00000 -1.00000 1 0
-
-0.00000 0.00000 0.750000 1 0
-0.00000 1.00000 -1.00000 1 0
-
-9.30035e-11 2.00529e-11 0.811692 1 0
-0.00000 1.00000 0.00000 1 0
-
--1.00000 0.00000 0.00000 1 0
--1.00000 1.00000 0.00000 1 0
-
-0.00000 0.00000 0.750000 1 0
-1.00000 0.00000 -1.00000 1 0
-1.00000 0.00000 0.00000 1 0
-9.30035e-11 2.00529e-11 0.811692 1 0
-0.00000 0.00000 0.750000 1 0
-
-0.00000 1.00000 -1.00000 1 0
-1.00000 1.00000 -1.00000 1 0
-1.00000 1.00000 0.00000 1 0
-0.00000 1.00000 0.00000 1 0
-0.00000 1.00000 -1.00000 1 0
-
-0.00000 0.00000 0.750000 1 0
-0.00000 1.00000 -1.00000 1 0
-
-1.00000 0.00000 -1.00000 1 0
-1.00000 1.00000 -1.00000 1 0
-
-1.00000 0.00000 0.00000 1 0
-1.00000 1.00000 0.00000 1 0
-
-9.30035e-11 2.00529e-11 0.811692 1 0
-0.00000 1.00000 0.00000 1 0
-
--1.00000 -1.00000 0.00000 1 0
-0.00000 -1.00000 0.00000 1 0
-0.00000 -1.00000 1.00000 1 0
--1.00000 -1.00000 1.00000 1 0
--1.00000 -1.00000 0.00000 1 0
-
--1.00000 0.00000 0.00000 1 0
-9.30035e-11 2.00529e-11 0.811692 1 0
-0.00000 0.00000 1.00000 1 0
--1.00000 0.00000 1.00000 1 0
--1.00000 0.00000 0.00000 1 0
-
--1.00000 -1.00000 0.00000 1 0
--1.00000 0.00000 0.00000 1 0
-
-0.00000 -1.00000 0.00000 1 0
-9.30035e-11 2.00529e-11 0.811692 1 0
-
-0.00000 -1.00000 1.00000 1 0
-0.00000 0.00000 1.00000 1 0
-
--1.00000 -1.00000 1.00000 1 0
--1.00000 0.00000 1.00000 1 0
-
-0.00000 -1.00000 0.00000 1 0
-1.00000 -1.00000 0.00000 1 0
-1.00000 -1.00000 1.00000 1 0
-0.00000 -1.00000 1.00000 1 0
-0.00000 -1.00000 0.00000 1 0
-
-9.30035e-11 2.00529e-11 0.811692 1 0
-1.00000 0.00000 0.00000 1 0
-1.00000 0.00000 1.00000 1 0
-0.00000 0.00000 1.00000 1 0
-9.30035e-11 2.00529e-11 0.811692 1 0
-
-0.00000 -1.00000 0.00000 1 0
-9.30035e-11 2.00529e-11 0.811692 1 0
-
-1.00000 -1.00000 0.00000 1 0
-1.00000 0.00000 0.00000 1 0
-
-1.00000 -1.00000 1.00000 1 0
-1.00000 0.00000 1.00000 1 0
-
-0.00000 -1.00000 1.00000 1 0
-0.00000 0.00000 1.00000 1 0
-
--1.00000 0.00000 0.00000 1 0
-9.30035e-11 2.00529e-11 0.811692 1 0
-0.00000 0.00000 1.00000 1 0
--1.00000 0.00000 1.00000 1 0
--1.00000 0.00000 0.00000 1 0
-
--1.00000 1.00000 0.00000 1 0
-0.00000 1.00000 0.00000 1 0
-0.00000 1.00000 1.00000 1 0
--1.00000 1.00000 1.00000 1 0
--1.00000 1.00000 0.00000 1 0
-
--1.00000 0.00000 0.00000 1 0
--1.00000 1.00000 0.00000 1 0
-
-9.30035e-11 2.00529e-11 0.811692 1 0
-0.00000 1.00000 0.00000 1 0
-
-0.00000 0.00000 1.00000 1 0
-0.00000 1.00000 1.00000 1 0
-
--1.00000 0.00000 1.00000 1 0
--1.00000 1.00000 1.00000 1 0
-
-9.30035e-11 2.00529e-11 0.811692 1 0
-1.00000 0.00000 0.00000 1 0
-1.00000 0.00000 1.00000 1 0
-0.00000 0.00000 1.00000 1 0
-9.30035e-11 2.00529e-11 0.811692 1 0
-
-0.00000 1.00000 0.00000 1 0
-1.00000 1.00000 0.00000 1 0
-1.00000 1.00000 1.00000 1 0
-0.00000 1.00000 1.00000 1 0
-0.00000 1.00000 0.00000 1 0
-
-9.30035e-11 2.00529e-11 0.811692 1 0
-0.00000 1.00000 0.00000 1 0
-
-1.00000 0.00000 0.00000 1 0
-1.00000 1.00000 0.00000 1 0
-
-1.00000 0.00000 1.00000 1 0
-1.00000 1.00000 1.00000 1 0
-
-0.00000 0.00000 1.00000 1 0
-0.00000 1.00000 1.00000 1 0
-
diff --git a/tests/bits/distorted_cells_05.cc b/tests/bits/distorted_cells_05.cc
deleted file mode 100644 (file)
index b86823d..0000000
+++ /dev/null
@@ -1,158 +0,0 @@
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2003 - 2015 by the deal.II authors
-//
-// This file is part of the deal.II library.
-//
-// The deal.II library is free software; you can use it, redistribute
-// it, and/or modify it under the terms of the GNU Lesser General
-// Public License as published by the Free Software Foundation; either
-// version 2.1 of the License, or (at your option) any later version.
-// The full text of the license can be found in the file LICENSE at
-// the top level of the deal.II distribution.
-//
-// ---------------------------------------------------------------------
-
-
-
-// like _04, except that this time the cell really can't be fixed up
-// because we move the node from the bottom face all the way above the
-// top face
-
-#include "../tests.h"
-#include <deal.II/base/quadrature_lib.h>
-#include <deal.II/grid/tria.h>
-#include <deal.II/grid/tria_accessor.h>
-#include <deal.II/grid/tria_iterator.h>
-#include <deal.II/grid/grid_reordering.h>
-#include <deal.II/grid/grid_tools.h>
-#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/tria_boundary.h>
-#include <deal.II/grid/grid_out.h>
-#include <deal.II/dofs/dof_handler.h>
-#include <deal.II/fe/fe_q.h>
-#include <deal.II/fe/fe_values.h>
-
-
-
-template <int dim>
-class MyBoundary : public Boundary<dim>
-{
-  virtual Point<dim>
-  get_new_point_on_line (const typename Triangulation<dim>::line_iterator &line) const
-  {
-    deallog << "Finding point between "
-            << line->vertex(0) << " and "
-            << line->vertex(1) << std::endl;
-
-    // in 2d, find a point that
-    // lies on the opposite side
-    // of the quad. in 3d, choose
-    // the midpoint of the edge
-    if (dim == 2)
-      return Point<dim>(0,1.25);
-    else
-      return (line->vertex(0) + line->vertex(1)) / 2;
-  }
-
-  virtual Point<dim>
-  get_new_point_on_quad (const typename Triangulation<dim>::quad_iterator &quad) const
-  {
-    deallog << "Finding point between "
-            << quad->vertex(0) << " and "
-            << quad->vertex(1) << " and "
-            << quad->vertex(2) << " and "
-            << quad->vertex(3) << std::endl;
-
-    return Point<dim>(0,0,1.25);
-  }
-
-  virtual
-  Point<dim>
-  project_to_surface (const typename Triangulation<dim>::line_iterator &,
-                      const Point<dim> &p) const
-  {
-    deallog << "Projecting line point " << p << std::endl;
-
-    if (dim == 2)
-      return Point<dim>(p[0], 1.25-2.25*std::fabs(p[0]));
-    else
-      return p;
-  }
-
-  virtual
-  Point<dim>
-  project_to_surface (const typename Triangulation<dim>::quad_iterator &,
-                      const Point<dim> &p) const
-  {
-    deallog << "Projecting quad point " << p << std::endl;
-
-    Assert (dim == 3, ExcInternalError());
-
-    return Point<dim>(p[0], p[1],
-                      1.25-2.25*std::max(std::fabs(p[0]),
-                                         std::fabs(p[1])));
-  }
-
-  virtual
-  Point<dim>
-  project_to_surface (const typename Triangulation<dim>::hex_iterator &,
-                      const Point<dim> &) const
-  {
-    Assert (false, ExcInternalError());
-    return Point<dim>();
-  }
-};
-
-
-
-template <int dim>
-void check ()
-{
-  MyBoundary<dim> my_boundary;
-
-  // create a single square/cube
-  Triangulation<dim> coarse_grid (Triangulation<dim>::none, true);
-  GridGenerator::hyper_cube (coarse_grid, -1, 1);
-
-  // set bottom face to use MyBoundary
-  for (unsigned int f=0; f<GeometryInfo<dim>::faces_per_cell; ++f)
-    if (coarse_grid.begin_active()->face(f)->center()[dim-1] == -1)
-      coarse_grid.begin_active()->face(f)->set_boundary_id (1);
-  coarse_grid.set_boundary (1, my_boundary);
-
-  // now try to refine this one
-  // cell. we should get an exception
-  try
-    {
-      coarse_grid.begin_active()->set_refine_flag ();
-      coarse_grid.execute_coarsening_and_refinement ();
-    }
-  catch (typename Triangulation<dim>::DistortedCellList &dcv)
-    {
-      typename Triangulation<dim>::DistortedCellList
-      subset = GridTools::fix_up_distorted_child_cells (dcv,
-                                                        coarse_grid);
-      Assert (subset.distorted_cells.size() == 1,
-              ExcInternalError());
-    }
-
-  Assert (coarse_grid.n_levels() == 2, ExcInternalError());
-  Assert (coarse_grid.n_active_cells() == 1<<dim, ExcInternalError());
-
-  // output the coordinates of the
-  // child cells
-  GridOut().write_gnuplot (coarse_grid, deallog.get_file_stream());
-}
-
-
-int main ()
-{
-  initlog();
-
-  check<2> ();
-  check<3> ();
-}
-
-
-
diff --git a/tests/bits/distorted_cells_05.debug.output b/tests/bits/distorted_cells_05.debug.output
deleted file mode 100644 (file)
index ffef263..0000000
+++ /dev/null
@@ -1,367 +0,0 @@
-
-DEAL::Finding point between -1.00000 -1.00000 and 1.00000 -1.00000
-DEAL::Projecting line point 0.0250000 1.25000
-DEAL::Projecting line point -0.0250000 1.25000
-DEAL::Projecting line point 0.00000 1.27500
-DEAL::Projecting line point 0.00000 1.22500
--1.00000 -1.00000 1 0
-0.00000 1.25000 1 0
--2.85864e-12 1.09695 1 0
--1.00000 0.00000 1 0
--1.00000 -1.00000 1 0
-
-
-0.00000 1.25000 1 0
-1.00000 -1.00000 1 0
-1.00000 0.00000 1 0
--2.85864e-12 1.09695 1 0
-0.00000 1.25000 1 0
-
-
--1.00000 0.00000 1 0
--2.85864e-12 1.09695 1 0
-0.00000 1.00000 1 0
--1.00000 1.00000 1 0
--1.00000 0.00000 1 0
-
-
--2.85864e-12 1.09695 1 0
-1.00000 0.00000 1 0
-1.00000 1.00000 1 0
-0.00000 1.00000 1 0
--2.85864e-12 1.09695 1 0
-
-
-DEAL::Finding point between -1.00000 -1.00000 -1.00000 and 1.00000 -1.00000 -1.00000 and -1.00000 1.00000 -1.00000 and 1.00000 1.00000 -1.00000
-DEAL::Projecting quad point 0.0176777 0.00000 1.25000
-DEAL::Projecting quad point -0.0176777 0.00000 1.25000
-DEAL::Projecting quad point 0.00000 0.0176777 1.25000
-DEAL::Projecting quad point 0.00000 -0.0176777 1.25000
-DEAL::Projecting quad point 0.00000 0.00000 1.26768
-DEAL::Projecting quad point 0.00000 0.00000 1.23232
-DEAL::Projecting quad point 0.250000 0.250000 1.25000
-DEAL::Projecting quad point 0.258839 0.250000 0.687500
-DEAL::Projecting quad point 0.241161 0.250000 0.687500
-DEAL::Projecting quad point 0.250000 0.258839 0.687500
-DEAL::Projecting quad point 0.250000 0.241161 0.687500
-DEAL::Projecting quad point 0.250000 0.250000 0.696339
-DEAL::Projecting quad point 0.250000 0.250000 0.678661
-DEAL::Projecting quad point 0.375000 0.375000 0.687500
-DEAL::Projecting quad point 0.380893 0.375000 0.406250
-DEAL::Projecting quad point 0.369107 0.375000 0.406250
-DEAL::Projecting quad point 0.375000 0.380893 0.406250
-DEAL::Projecting quad point 0.375000 0.369107 0.406250
-DEAL::Projecting quad point 0.375000 0.375000 0.412143
-DEAL::Projecting quad point 0.375000 0.375000 0.400357
-DEAL::Projecting quad point 0.458333 0.458333 0.406250
-DEAL::Projecting quad point 0.462753 0.458333 0.218750
-DEAL::Projecting quad point 0.453914 0.458333 0.218750
-DEAL::Projecting quad point 0.458333 0.462753 0.218750
-DEAL::Projecting quad point 0.458333 0.453914 0.218750
-DEAL::Projecting quad point 0.458333 0.458333 0.223169
-DEAL::Projecting quad point 0.458333 0.458333 0.214331
-DEAL::Projecting quad point 0.520833 0.520833 0.218750
-DEAL::Projecting quad point 0.524369 0.520833 0.0781250
-DEAL::Projecting quad point 0.517298 0.520833 0.0781250
-DEAL::Projecting quad point 0.520833 0.524369 0.0781250
-DEAL::Projecting quad point 0.520833 0.517298 0.0781250
-DEAL::Projecting quad point 0.520833 0.520833 0.0816605
-DEAL::Projecting quad point 0.520833 0.520833 0.0745895
-DEAL::Projecting quad point 0.570833 0.570833 0.0781250
-DEAL::Projecting quad point 0.573780 0.570833 -0.0343750
-DEAL::Projecting quad point 0.567887 0.570833 -0.0343750
-DEAL::Projecting quad point 0.570833 0.573780 -0.0343750
-DEAL::Projecting quad point 0.570833 0.567887 -0.0343750
-DEAL::Projecting quad point 0.570833 0.570833 -0.0314287
-DEAL::Projecting quad point 0.570833 0.570833 -0.0373213
-DEAL::Projecting quad point 0.612500 0.612500 -0.0343750
-DEAL::Projecting quad point 0.615025 0.612500 -0.128125
-DEAL::Projecting quad point 0.609975 0.612500 -0.128125
-DEAL::Projecting quad point 0.612500 0.615025 -0.128125
-DEAL::Projecting quad point 0.612500 0.609975 -0.128125
-DEAL::Projecting quad point 0.612500 0.612500 -0.125600
-DEAL::Projecting quad point 0.612500 0.612500 -0.130650
-DEAL::Projecting quad point 0.648214 0.648214 -0.128125
-DEAL::Projecting quad point 0.650424 0.648214 -0.208482
-DEAL::Projecting quad point 0.646005 0.648214 -0.208482
-DEAL::Projecting quad point 0.648214 0.650424 -0.208482
-DEAL::Projecting quad point 0.648214 0.646004 -0.208482
-DEAL::Projecting quad point 0.648214 0.648214 -0.206273
-DEAL::Projecting quad point 0.648214 0.648214 -0.210692
-DEAL::Projecting quad point 0.679470 0.679459 -0.208482
-DEAL::Projecting quad point 0.681434 0.679459 -0.278807
-DEAL::Projecting quad point 0.677505 0.679459 -0.278807
-DEAL::Projecting quad point 0.679470 0.681423 -0.278807
-DEAL::Projecting quad point 0.679470 0.677495 -0.278807
-DEAL::Projecting quad point 0.679470 0.679459 -0.276842
-DEAL::Projecting quad point 0.679470 0.679459 -0.280771
-DEAL::Projecting quad point 0.707503 0.706978 -0.278807
-DEAL::Projecting quad point 0.709271 0.706978 -0.341883
-DEAL::Projecting quad point 0.705736 0.706978 -0.341883
-DEAL::Projecting quad point 0.707503 0.708746 -0.341883
-DEAL::Projecting quad point 0.707503 0.705211 -0.341883
-DEAL::Projecting quad point 0.707503 0.706978 -0.340115
-DEAL::Projecting quad point 0.707503 0.706978 -0.343651
-DEAL::Projecting quad point 0.741599 0.716332 -0.341883
-DEAL::Projecting quad point 0.743206 0.716332 -0.418598
-DEAL::Projecting quad point 0.739992 0.716332 -0.418598
-DEAL::Projecting quad point 0.741599 0.717939 -0.418598
-DEAL::Projecting quad point 0.741599 0.714725 -0.418598
-DEAL::Projecting quad point 0.741599 0.716332 -0.416991
-DEAL::Projecting quad point 0.741599 0.716332 -0.420205
-DEAL::Projecting quad point 0.771623 0.704860 -0.418598
-DEAL::Projecting quad point 0.773096 0.704860 -0.486152
-DEAL::Projecting quad point 0.770150 0.704860 -0.486152
-DEAL::Projecting quad point 0.771623 0.706333 -0.486152
-DEAL::Projecting quad point 0.771623 0.703387 -0.486152
-DEAL::Projecting quad point 0.771623 0.704860 -0.484679
-DEAL::Projecting quad point 0.771623 0.704860 -0.487625
-DEAL::Projecting quad point 0.798415 0.692603 -0.486152
-DEAL::Projecting quad point 0.799775 0.692603 -0.546434
-DEAL::Projecting quad point 0.797055 0.692603 -0.546434
-DEAL::Projecting quad point 0.798415 0.693962 -0.546434
-DEAL::Projecting quad point 0.798415 0.691243 -0.546434
-DEAL::Projecting quad point 0.798415 0.692603 -0.545074
-DEAL::Projecting quad point 0.798415 0.692603 -0.547794
-DEAL::Projecting quad point 0.822171 0.679362 -0.546434
-DEAL::Projecting quad point 0.823433 0.679362 -0.599884
-DEAL::Projecting quad point 0.820908 0.679362 -0.599884
-DEAL::Projecting quad point 0.822171 0.680625 -0.599884
-DEAL::Projecting quad point 0.822171 0.678099 -0.599884
-DEAL::Projecting quad point 0.822171 0.679362 -0.598622
-DEAL::Projecting quad point 0.822171 0.679362 -0.601147
-DEAL::Projecting quad point 0.842914 0.664958 -0.599884
-DEAL::Projecting quad point 0.844092 0.664958 -0.646556
-DEAL::Projecting quad point 0.841735 0.664958 -0.646556
-DEAL::Projecting quad point 0.842914 0.666137 -0.646556
-DEAL::Projecting quad point 0.842914 0.663779 -0.646556
-DEAL::Projecting quad point 0.842914 0.664958 -0.645378
-DEAL::Projecting quad point 0.842914 0.664958 -0.647735
-DEAL::Projecting quad point 0.860525 0.649293 -0.646556
-DEAL::Projecting quad point 0.861630 0.649293 -0.686182
-DEAL::Projecting quad point 0.859421 0.649293 -0.686182
-DEAL::Projecting quad point 0.860525 0.650398 -0.686182
-DEAL::Projecting quad point 0.860525 0.648188 -0.686182
-DEAL::Projecting quad point 0.860525 0.649293 -0.685077
-DEAL::Projecting quad point 0.860525 0.649293 -0.687287
-DEAL::Projecting quad point 0.874833 0.632453 -0.686182
-DEAL::Projecting quad point 0.875873 0.632453 -0.718374
-DEAL::Projecting quad point 0.873793 0.632453 -0.718374
-DEAL::Projecting quad point 0.874833 0.633493 -0.718374
-DEAL::Projecting quad point 0.874833 0.631413 -0.718374
-DEAL::Projecting quad point 0.874833 0.632453 -0.717334
-DEAL::Projecting quad point 0.874833 0.632453 -0.719414
-DEAL::Projecting quad point 0.885799 0.614782 -0.718374
-DEAL::Projecting quad point 0.886781 0.614782 -0.743048
-DEAL::Projecting quad point 0.884817 0.614782 -0.743048
-DEAL::Projecting quad point 0.885799 0.615764 -0.743048
-DEAL::Projecting quad point 0.885799 0.613800 -0.743048
-DEAL::Projecting quad point 0.885799 0.614782 -0.742066
-DEAL::Projecting quad point 0.885799 0.614782 -0.744030
-DEAL::Projecting quad point 0.893709 0.596803 -0.743048
-DEAL::Projecting quad point 0.894640 0.596803 -0.760846
-DEAL::Projecting quad point 0.892779 0.596803 -0.760846
-DEAL::Projecting quad point 0.893709 0.597734 -0.760846
-DEAL::Projecting quad point 0.893709 0.595873 -0.760846
-DEAL::Projecting quad point 0.893709 0.596803 -0.759915
-DEAL::Projecting quad point 0.893709 0.596803 -0.761776
-DEAL::Projecting quad point 0.899150 0.579009 -0.760846
-DEAL::Projecting quad point 0.900034 0.579009 -0.773088
-DEAL::Projecting quad point 0.898266 0.579009 -0.773088
-DEAL::Projecting quad point 0.899150 0.579893 -0.773088
-DEAL::Projecting quad point 0.899150 0.578125 -0.773088
-DEAL::Projecting quad point 0.899150 0.579009 -0.772204
-DEAL::Projecting quad point 0.899150 0.579009 -0.773972
-DEAL::Projecting quad point 0.902794 0.561711 -0.773088
--1.00000 -1.00000 -1.00000 1 0
-0.00000 -1.00000 -1.00000 1 0
-0.00000 -1.00000 0.00000 1 0
--1.00000 -1.00000 0.00000 1 0
--1.00000 -1.00000 -1.00000 1 0
-
--1.00000 0.00000 -1.00000 1 0
-0.00000 0.00000 1.25000 1 0
--1.25099e-12 6.25779e-12 1.14841 1 0
--1.00000 0.00000 0.00000 1 0
--1.00000 0.00000 -1.00000 1 0
-
--1.00000 -1.00000 -1.00000 1 0
--1.00000 0.00000 -1.00000 1 0
-
-0.00000 -1.00000 -1.00000 1 0
-0.00000 0.00000 1.25000 1 0
-
-0.00000 -1.00000 0.00000 1 0
--1.25099e-12 6.25779e-12 1.14841 1 0
-
--1.00000 -1.00000 0.00000 1 0
--1.00000 0.00000 0.00000 1 0
-
-0.00000 -1.00000 -1.00000 1 0
-1.00000 -1.00000 -1.00000 1 0
-1.00000 -1.00000 0.00000 1 0
-0.00000 -1.00000 0.00000 1 0
-0.00000 -1.00000 -1.00000 1 0
-
-0.00000 0.00000 1.25000 1 0
-1.00000 0.00000 -1.00000 1 0
-1.00000 0.00000 0.00000 1 0
--1.25099e-12 6.25779e-12 1.14841 1 0
-0.00000 0.00000 1.25000 1 0
-
-0.00000 -1.00000 -1.00000 1 0
-0.00000 0.00000 1.25000 1 0
-
-1.00000 -1.00000 -1.00000 1 0
-1.00000 0.00000 -1.00000 1 0
-
-1.00000 -1.00000 0.00000 1 0
-1.00000 0.00000 0.00000 1 0
-
-0.00000 -1.00000 0.00000 1 0
--1.25099e-12 6.25779e-12 1.14841 1 0
-
--1.00000 0.00000 -1.00000 1 0
-0.00000 0.00000 1.25000 1 0
--1.25099e-12 6.25779e-12 1.14841 1 0
--1.00000 0.00000 0.00000 1 0
--1.00000 0.00000 -1.00000 1 0
-
--1.00000 1.00000 -1.00000 1 0
-0.00000 1.00000 -1.00000 1 0
-0.00000 1.00000 0.00000 1 0
--1.00000 1.00000 0.00000 1 0
--1.00000 1.00000 -1.00000 1 0
-
--1.00000 0.00000 -1.00000 1 0
--1.00000 1.00000 -1.00000 1 0
-
-0.00000 0.00000 1.25000 1 0
-0.00000 1.00000 -1.00000 1 0
-
--1.25099e-12 6.25779e-12 1.14841 1 0
-0.00000 1.00000 0.00000 1 0
-
--1.00000 0.00000 0.00000 1 0
--1.00000 1.00000 0.00000 1 0
-
-0.00000 0.00000 1.25000 1 0
-1.00000 0.00000 -1.00000 1 0
-1.00000 0.00000 0.00000 1 0
--1.25099e-12 6.25779e-12 1.14841 1 0
-0.00000 0.00000 1.25000 1 0
-
-0.00000 1.00000 -1.00000 1 0
-1.00000 1.00000 -1.00000 1 0
-1.00000 1.00000 0.00000 1 0
-0.00000 1.00000 0.00000 1 0
-0.00000 1.00000 -1.00000 1 0
-
-0.00000 0.00000 1.25000 1 0
-0.00000 1.00000 -1.00000 1 0
-
-1.00000 0.00000 -1.00000 1 0
-1.00000 1.00000 -1.00000 1 0
-
-1.00000 0.00000 0.00000 1 0
-1.00000 1.00000 0.00000 1 0
-
--1.25099e-12 6.25779e-12 1.14841 1 0
-0.00000 1.00000 0.00000 1 0
-
--1.00000 -1.00000 0.00000 1 0
-0.00000 -1.00000 0.00000 1 0
-0.00000 -1.00000 1.00000 1 0
--1.00000 -1.00000 1.00000 1 0
--1.00000 -1.00000 0.00000 1 0
-
--1.00000 0.00000 0.00000 1 0
--1.25099e-12 6.25779e-12 1.14841 1 0
-0.00000 0.00000 1.00000 1 0
--1.00000 0.00000 1.00000 1 0
--1.00000 0.00000 0.00000 1 0
-
--1.00000 -1.00000 0.00000 1 0
--1.00000 0.00000 0.00000 1 0
-
-0.00000 -1.00000 0.00000 1 0
--1.25099e-12 6.25779e-12 1.14841 1 0
-
-0.00000 -1.00000 1.00000 1 0
-0.00000 0.00000 1.00000 1 0
-
--1.00000 -1.00000 1.00000 1 0
--1.00000 0.00000 1.00000 1 0
-
-0.00000 -1.00000 0.00000 1 0
-1.00000 -1.00000 0.00000 1 0
-1.00000 -1.00000 1.00000 1 0
-0.00000 -1.00000 1.00000 1 0
-0.00000 -1.00000 0.00000 1 0
-
--1.25099e-12 6.25779e-12 1.14841 1 0
-1.00000 0.00000 0.00000 1 0
-1.00000 0.00000 1.00000 1 0
-0.00000 0.00000 1.00000 1 0
--1.25099e-12 6.25779e-12 1.14841 1 0
-
-0.00000 -1.00000 0.00000 1 0
--1.25099e-12 6.25779e-12 1.14841 1 0
-
-1.00000 -1.00000 0.00000 1 0
-1.00000 0.00000 0.00000 1 0
-
-1.00000 -1.00000 1.00000 1 0
-1.00000 0.00000 1.00000 1 0
-
-0.00000 -1.00000 1.00000 1 0
-0.00000 0.00000 1.00000 1 0
-
--1.00000 0.00000 0.00000 1 0
--1.25099e-12 6.25779e-12 1.14841 1 0
-0.00000 0.00000 1.00000 1 0
--1.00000 0.00000 1.00000 1 0
--1.00000 0.00000 0.00000 1 0
-
--1.00000 1.00000 0.00000 1 0
-0.00000 1.00000 0.00000 1 0
-0.00000 1.00000 1.00000 1 0
--1.00000 1.00000 1.00000 1 0
--1.00000 1.00000 0.00000 1 0
-
--1.00000 0.00000 0.00000 1 0
--1.00000 1.00000 0.00000 1 0
-
--1.25099e-12 6.25779e-12 1.14841 1 0
-0.00000 1.00000 0.00000 1 0
-
-0.00000 0.00000 1.00000 1 0
-0.00000 1.00000 1.00000 1 0
-
--1.00000 0.00000 1.00000 1 0
--1.00000 1.00000 1.00000 1 0
-
--1.25099e-12 6.25779e-12 1.14841 1 0
-1.00000 0.00000 0.00000 1 0
-1.00000 0.00000 1.00000 1 0
-0.00000 0.00000 1.00000 1 0
--1.25099e-12 6.25779e-12 1.14841 1 0
-
-0.00000 1.00000 0.00000 1 0
-1.00000 1.00000 0.00000 1 0
-1.00000 1.00000 1.00000 1 0
-0.00000 1.00000 1.00000 1 0
-0.00000 1.00000 0.00000 1 0
-
--1.25099e-12 6.25779e-12 1.14841 1 0
-0.00000 1.00000 0.00000 1 0
-
-1.00000 0.00000 0.00000 1 0
-1.00000 1.00000 0.00000 1 0
-
-1.00000 0.00000 1.00000 1 0
-1.00000 1.00000 1.00000 1 0
-
-0.00000 0.00000 1.00000 1 0
-0.00000 1.00000 1.00000 1 0
-

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.