]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Work on higher-order MappingFE 11563/head
authorPeter Munch <peterrmuench@gmail.com>
Fri, 15 Jan 2021 18:30:49 +0000 (19:30 +0100)
committerPeter Munch <peterrmuench@gmail.com>
Mon, 18 Jan 2021 14:20:02 +0000 (15:20 +0100)
include/deal.II/fe/mapping_fe.h
include/deal.II/grid/reference_cell.h
source/fe/mapping_fe.cc
source/grid/reference_cell.cc
tests/simplex/mapping_fe_01.cc [new file with mode: 0644]
tests/simplex/mapping_fe_01.with_simplex_support=on.output [new file with mode: 0644]

index edcc1d2be57f5f0a8a7ff41d640d184ff701d90a..95c8591884d057e7971a253377393caa8dad5752 100644 (file)
@@ -467,6 +467,9 @@ protected:
   virtual std::vector<Point<spacedim>>
   compute_mapping_support_points(
     const typename Triangulation<dim, spacedim>::cell_iterator &cell) const;
+
+private:
+  Table<2, double> mapping_support_point_weights;
 };
 
 
index ca56d20f892cedc2d108e97cceb2bb7b2d892b58..86441b244a3fb334bd7a752b8000ec0bfe5b5645 100644 (file)
@@ -31,6 +31,8 @@ template <int dim, int spacedim>
 class Mapping;
 template <int dim>
 class Quadrature;
+template <int dim>
+class ScalarPolynomialsBase;
 #endif
 
 /**
@@ -335,14 +337,75 @@ namespace ReferenceCell
         switch (i)
           {
             case 0:
-              return 1.0 - xi[0] - xi[1];
+              return 1.0 - xi[std::min(0, dim - 1)] - xi[std::min(1, dim - 1)];
+            case 1:
+              return xi[std::min(0, dim - 1)];
+            case 2:
+              return xi[std::min(1, dim - 1)];
+          }
+      }
+
+    if (reference_cell ==
+        Type::Tet) // see also Simplex::ScalarPolynomial::compute_value
+      {
+        switch (i)
+          {
+            case 0:
+              return 1.0 - xi[std::min(0, dim - 1)] - xi[std::min(1, dim - 1)] -
+                     xi[std::min(2, dim - 1)];
             case 1:
-              return xi[0];
+              return xi[std::min(0, dim - 1)];
             case 2:
-              return xi[1];
+              return xi[std::min(1, dim - 1)];
+            case 3:
+              return xi[std::min(2, dim - 1)];
           }
       }
 
+    if (reference_cell ==
+        Type::Wedge) // see also Simplex::ScalarWedgePolynomial::compute_value
+      {
+        return d_linear_shape_function<2>(Type::Tri,
+                                          Point<2>(xi[std::min(0, dim - 1)],
+                                                   xi[std::min(1, dim - 1)]),
+                                          i % 3) *
+               d_linear_shape_function<1>(Type::Line,
+                                          Point<1>(xi[std::min(2, dim - 1)]),
+                                          i / 3);
+      }
+
+    if (reference_cell ==
+        Type::Pyramid) // see also
+                       // Simplex::ScalarPyramidPolynomial::compute_value
+      {
+        const double Q14 = 0.25;
+        double       ration;
+
+        const double r = xi[std::min(0, dim - 1)];
+        const double s = xi[std::min(1, dim - 1)];
+        const double t = xi[std::min(2, dim - 1)];
+
+        if (fabs(t - 1.0) > 1.0e-14)
+          {
+            ration = (r * s * t) / (1.0 - t);
+          }
+        else
+          {
+            ration = 0.0;
+          }
+
+        if (i == 0)
+          return Q14 * ((1.0 - r) * (1.0 - s) - t + ration);
+        if (i == 1)
+          return Q14 * ((1.0 + r) * (1.0 - s) - t - ration);
+        if (i == 2)
+          return Q14 * ((1.0 - r) * (1.0 + s) - t - ration);
+        if (i == 3)
+          return Q14 * ((1.0 + r) * (1.0 + s) - t + ration);
+        else
+          return t;
+      }
+
     Assert(false, ExcNotImplemented());
 
     return 0.0;
index 05e18198bc94ab700f0960a34d8ab580f83a3820..be1982c505c5785ffa69098fd47f6ab8d4ad0e4f 100644 (file)
@@ -853,8 +853,27 @@ MappingFE<dim, spacedim>::MappingFE(const FiniteElement<dim, spacedim> &fe)
   Assert(polynomial_degree >= 1,
          ExcMessage("It only makes sense to create polynomial mappings "
                     "with a polynomial degree greater or equal to one."));
-  Assert(fe.tensor_degree() == 1, ExcNotImplemented());
   Assert(fe.n_components() == 1, ExcNotImplemented());
+
+  Assert(fe.has_support_points(), ExcNotImplemented());
+
+  const auto &mapping_support_points = fe.get_unit_support_points();
+
+  const auto reference_cell_type = fe.reference_cell_type();
+
+  const unsigned int n_points = mapping_support_points.size();
+  const unsigned int n_shape_functions =
+    ReferenceCell::internal::Info::get_cell(reference_cell_type).n_vertices();
+
+  this->mapping_support_point_weights =
+    Table<2, double>(n_points, n_shape_functions);
+
+  for (unsigned int point = 0; point < n_points; ++point)
+    for (unsigned int i = 0; i < n_shape_functions; ++i)
+      mapping_support_point_weights(point, i) =
+        ReferenceCell::d_linear_shape_function(reference_cell_type,
+                                               mapping_support_points[point],
+                                               i);
 }
 
 
@@ -863,6 +882,7 @@ template <int dim, int spacedim>
 MappingFE<dim, spacedim>::MappingFE(const MappingFE<dim, spacedim> &mapping)
   : fe(mapping.fe->clone())
   , polynomial_degree(mapping.polynomial_degree)
+  , mapping_support_point_weights(mapping.mapping_support_point_weights)
 {}
 
 
@@ -2204,23 +2224,78 @@ MappingFE<dim, spacedim>::transform(
 
 
 
+namespace
+{
+  template <int spacedim>
+  bool
+  check_all_manifold_ids_identical(
+    const TriaIterator<CellAccessor<1, spacedim>> &)
+  {
+    return true;
+  }
+
+
+
+  template <int spacedim>
+  bool
+  check_all_manifold_ids_identical(
+    const TriaIterator<CellAccessor<2, spacedim>> &cell)
+  {
+    const auto b_id = cell->manifold_id();
+
+    for (const auto f : cell->face_indices())
+      if (b_id != cell->face(f)->manifold_id())
+        return false;
+
+    return true;
+  }
+
+
+
+  template <int spacedim>
+  bool
+  check_all_manifold_ids_identical(
+    const TriaIterator<CellAccessor<3, spacedim>> &cell)
+  {
+    const auto b_id = cell->manifold_id();
+
+    for (const auto f : cell->face_indices())
+      if (b_id != cell->face(f)->manifold_id())
+        return false;
+
+    for (const auto l : cell->line_indices())
+      if (b_id != cell->line(l)->manifold_id())
+        return false;
+
+    return true;
+  }
+} // namespace
+
+
+
 template <int dim, int spacedim>
 std::vector<Point<spacedim>>
 MappingFE<dim, spacedim>::compute_mapping_support_points(
   const typename Triangulation<dim, spacedim>::cell_iterator &cell) const
 {
-  // get the vertices first
-  std::vector<Point<spacedim>> a(cell->n_vertices());
+  Assert(
+    check_all_manifold_ids_identical(cell),
+    ExcMessage(
+      "All entities of a cell need to have the same boundary id as the cell has."));
+
+  std::vector<Point<spacedim>> vertices(cell->n_vertices());
 
   for (const unsigned int i : cell->vertex_indices())
-    a[i] = cell->vertex(i);
+    vertices[i] = cell->vertex(i);
 
-  if (this->polynomial_degree > 1)
-    {
-      Assert(false, ExcNotImplemented());
-    }
+  std::vector<Point<spacedim>> mapping_support_points(
+    fe->get_unit_support_points().size());
+
+  cell->get_manifold().get_new_points(vertices,
+                                      mapping_support_point_weights,
+                                      mapping_support_points);
 
-  return a;
+  return mapping_support_points;
 }
 
 
index f670dde1f8fd8fb04c027f2e6b65214f6e10d405..54ee83ba0a09283b34d91e204bd79c0977c94c32 100644 (file)
@@ -13,7 +13,9 @@
 //
 // ---------------------------------------------------------------------
 
+#include <deal.II/base/polynomial.h>
 #include <deal.II/base/quadrature_lib.h>
+#include <deal.II/base/tensor_product_polynomials.h>
 
 #include <deal.II/fe/mapping_fe.h>
 #include <deal.II/fe/mapping_q1.h>
@@ -23,6 +25,7 @@
 #include <deal.II/grid/tria.h>
 
 #include <deal.II/simplex/fe_lib.h>
+#include <deal.II/simplex/polynomials.h>
 #include <deal.II/simplex/quadrature_lib.h>
 
 DEAL_II_NAMESPACE_OPEN
@@ -102,6 +105,7 @@ namespace ReferenceCell
   }
 
 
+
   template <int dim, int spacedim>
   const Mapping<dim, spacedim> &
   get_default_linear_mapping(const Type &reference_cell)
diff --git a/tests/simplex/mapping_fe_01.cc b/tests/simplex/mapping_fe_01.cc
new file mode 100644 (file)
index 0000000..6bcb8ce
--- /dev/null
@@ -0,0 +1,81 @@
+// ---------------------------------------------------------------------
+//
+// Copyright (C) 2020 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.
+//
+// ---------------------------------------------------------------------
+
+
+// Distribute Simplex::FE_Wedge on a DoFHandler.
+
+#include <deal.II/dofs/dof_handler.h>
+
+#include <deal.II/fe/fe_values.h>
+#include <deal.II/fe/mapping_fe.h>
+
+#include <deal.II/grid/grid_generator.h>
+#include <deal.II/grid/tria.h>
+
+#include <deal.II/numerics/data_out.h>
+
+#include <deal.II/simplex/fe_lib.h>
+#include <deal.II/simplex/quadrature_lib.h>
+
+#include "../tests.h"
+
+using namespace dealii;
+
+void
+test(const unsigned int mapping_degree)
+{
+  const int dim = 2;
+
+  Triangulation<dim> tria, tria_temp;
+  GridGenerator::hyper_shell(tria_temp, Point<dim>(), 1.0, 2.0);
+  GridGenerator::convert_hypercube_to_simplex_mesh(tria_temp, tria);
+  for (const auto i : tria_temp.get_manifold_ids())
+    if (i != numbers::flat_manifold_id)
+      tria.set_manifold(i, tria_temp.get_manifold(i));
+
+  Simplex::FE_P<dim> fe(2);
+
+  DoFHandler<dim> dof_handler(tria);
+  dof_handler.distribute_dofs(fe);
+
+  MappingFE<dim> mapping(Simplex::FE_P<dim>{mapping_degree});
+
+  {
+    DataOut<dim> data_out;
+
+    data_out.attach_dof_handler(dof_handler);
+
+    Vector<double> solution(dof_handler.n_dofs());
+    data_out.add_data_vector(solution, "solution");
+
+    data_out.build_patches(mapping, 2);
+
+#if false
+    std::ofstream output("test." + std::to_string(mapping_degree) +  ".vtk");
+    data_out.write_vtk(output);
+#else
+    data_out.write_vtk(deallog.get_file_stream());
+#endif
+  }
+}
+
+int
+main()
+{
+  initlog();
+
+  test(1);
+  test(2);
+}
diff --git a/tests/simplex/mapping_fe_01.with_simplex_support=on.output b/tests/simplex/mapping_fe_01.with_simplex_support=on.output
new file mode 100644 (file)
index 0000000..d019ed1
--- /dev/null
@@ -0,0 +1,1151 @@
+
+# vtk DataFile Version 3.0
+#This file was generated 
+ASCII
+DATASET UNSTRUCTURED_GRID
+
+POINTS 480 double
+2.00000 0.00000 0
+1.90211 0.618034 0
+1.50000 0.00000 0
+1.95106 0.309017 0
+1.70106 0.309017 0
+1.75000 0.00000 0
+1.42658 0.463526 0
+1.50000 0.00000 0
+1.90211 0.618034 0
+1.46329 0.231763 0
+1.70106 0.309017 0
+1.66435 0.540780 0
+1.42658 0.463526 0
+1.90211 0.618034 0
+1.21353 0.881678 0
+1.66435 0.540780 0
+1.55782 0.749856 0
+1.32006 0.672602 0
+1.61803 1.17557 0
+1.21353 0.881678 0
+1.90211 0.618034 0
+1.41578 1.02862 0
+1.55782 0.749856 0
+1.76007 0.896802 0
+1.00000 0.00000 0
+1.50000 0.00000 0
+0.951057 0.309017 0
+1.25000 0.00000 0
+1.22553 0.154509 0
+0.975528 0.154509 0
+1.42658 0.463526 0
+0.951057 0.309017 0
+1.50000 0.00000 0
+1.18882 0.386271 0
+1.22553 0.154509 0
+1.46329 0.231763 0
+1.42658 0.463526 0
+1.21353 0.881678 0
+0.951057 0.309017 0
+1.32006 0.672602 0
+1.08229 0.595347 0
+1.18882 0.386271 0
+0.809017 0.587785 0
+0.951057 0.309017 0
+1.21353 0.881678 0
+0.880037 0.448401 0
+1.08229 0.595347 0
+1.01127 0.734732 0
+1.61803 1.17557 0
+1.17557 1.61803 0
+1.21353 0.881678 0
+1.39680 1.39680 0
+1.19455 1.24986 0
+1.41578 1.02862 0
+0.881678 1.21353 0
+1.21353 0.881678 0
+1.17557 1.61803 0
+1.04760 1.04760 0
+1.19455 1.24986 0
+1.02862 1.41578 0
+0.881678 1.21353 0
+1.17557 1.61803 0
+0.463526 1.42658 0
+1.02862 1.41578 0
+0.819548 1.52231 0
+0.672602 1.32006 0
+0.618034 1.90211 0
+0.463526 1.42658 0
+1.17557 1.61803 0
+0.540780 1.66435 0
+0.819548 1.52231 0
+0.896802 1.76007 0
+0.809017 0.587785 0
+1.21353 0.881678 0
+0.587785 0.809017 0
+1.01127 0.734732 0
+0.900655 0.845347 0
+0.698401 0.698401 0
+0.881678 1.21353 0
+0.587785 0.809017 0
+1.21353 0.881678 0
+0.734732 1.01127 0
+0.900655 0.845347 0
+1.04760 1.04760 0
+0.881678 1.21353 0
+0.463526 1.42658 0
+0.587785 0.809017 0
+0.672602 1.32006 0
+0.525655 1.11780 0
+0.734732 1.01127 0
+0.309017 0.951057 0
+0.587785 0.809017 0
+0.463526 1.42658 0
+0.448401 0.880037 0
+0.525655 1.11780 0
+0.386271 1.18882 0
+0.618034 1.90211 0
+5.66554e-16 2.00000 0
+0.463526 1.42658 0
+0.309017 1.95106 0
+0.231763 1.71329 0
+0.540780 1.66435 0
+9.18485e-17 1.50000 0
+0.463526 1.42658 0
+5.66554e-16 2.00000 0
+0.231763 1.46329 0
+0.231763 1.71329 0
+3.29201e-16 1.75000 0
+9.18485e-17 1.50000 0
+5.66554e-16 2.00000 0
+-0.463526 1.42658 0
+3.29201e-16 1.75000 0
+-0.231763 1.71329 0
+-0.231763 1.46329 0
+-0.618034 1.90211 0
+-0.463526 1.42658 0
+5.66554e-16 2.00000 0
+-0.540780 1.66435 0
+-0.231763 1.71329 0
+-0.309017 1.95106 0
+0.309017 0.951057 0
+0.463526 1.42658 0
+2.83277e-16 1.00000 0
+0.386271 1.18882 0
+0.231763 1.21329 0
+0.154509 0.975528 0
+9.18485e-17 1.50000 0
+2.83277e-16 1.00000 0
+0.463526 1.42658 0
+1.87563e-16 1.25000 0
+0.231763 1.21329 0
+0.231763 1.46329 0
+9.18485e-17 1.50000 0
+-0.463526 1.42658 0
+2.83277e-16 1.00000 0
+-0.231763 1.46329 0
+-0.231763 1.21329 0
+1.87563e-16 1.25000 0
+-0.309017 0.951057 0
+2.83277e-16 1.00000 0
+-0.463526 1.42658 0
+-0.154509 0.975528 0
+-0.231763 1.21329 0
+-0.386271 1.18882 0
+-0.618034 1.90211 0
+-1.17557 1.61803 0
+-0.463526 1.42658 0
+-0.896802 1.76007 0
+-0.819548 1.52231 0
+-0.540780 1.66435 0
+-0.881678 1.21353 0
+-0.463526 1.42658 0
+-1.17557 1.61803 0
+-0.672602 1.32006 0
+-0.819548 1.52231 0
+-1.02862 1.41578 0
+-0.881678 1.21353 0
+-1.17557 1.61803 0
+-1.21353 0.881678 0
+-1.02862 1.41578 0
+-1.19455 1.24986 0
+-1.04760 1.04760 0
+-1.61803 1.17557 0
+-1.21353 0.881678 0
+-1.17557 1.61803 0
+-1.41578 1.02862 0
+-1.19455 1.24986 0
+-1.39680 1.39680 0
+-0.309017 0.951057 0
+-0.463526 1.42658 0
+-0.587785 0.809017 0
+-0.386271 1.18882 0
+-0.525655 1.11780 0
+-0.448401 0.880037 0
+-0.881678 1.21353 0
+-0.587785 0.809017 0
+-0.463526 1.42658 0
+-0.734732 1.01127 0
+-0.525655 1.11780 0
+-0.672602 1.32006 0
+-0.881678 1.21353 0
+-1.21353 0.881678 0
+-0.587785 0.809017 0
+-1.04760 1.04760 0
+-0.900655 0.845347 0
+-0.734732 1.01127 0
+-0.809017 0.587785 0
+-0.587785 0.809017 0
+-1.21353 0.881678 0
+-0.698401 0.698401 0
+-0.900655 0.845347 0
+-1.01127 0.734732 0
+-1.61803 1.17557 0
+-1.90211 0.618034 0
+-1.21353 0.881678 0
+-1.76007 0.896802 0
+-1.55782 0.749856 0
+-1.41578 1.02862 0
+-1.42658 0.463526 0
+-1.21353 0.881678 0
+-1.90211 0.618034 0
+-1.32006 0.672602 0
+-1.55782 0.749856 0
+-1.66435 0.540780 0
+-1.42658 0.463526 0
+-1.90211 0.618034 0
+-1.50000 1.83697e-16 0
+-1.66435 0.540780 0
+-1.70106 0.309017 0
+-1.46329 0.231763 0
+-2.00000 2.44929e-16 0
+-1.50000 1.83697e-16 0
+-1.90211 0.618034 0
+-1.75000 2.14313e-16 0
+-1.70106 0.309017 0
+-1.95106 0.309017 0
+-0.809017 0.587785 0
+-1.21353 0.881678 0
+-0.951057 0.309017 0
+-1.01127 0.734732 0
+-1.08229 0.595347 0
+-0.880037 0.448401 0
+-1.42658 0.463526 0
+-0.951057 0.309017 0
+-1.21353 0.881678 0
+-1.18882 0.386271 0
+-1.08229 0.595347 0
+-1.32006 0.672602 0
+-1.42658 0.463526 0
+-1.50000 1.83697e-16 0
+-0.951057 0.309017 0
+-1.46329 0.231763 0
+-1.22553 0.154509 0
+-1.18882 0.386271 0
+-1.00000 1.22465e-16 0
+-0.951057 0.309017 0
+-1.50000 1.83697e-16 0
+-0.975528 0.154509 0
+-1.22553 0.154509 0
+-1.25000 1.53081e-16 0
+-2.00000 2.44929e-16 0
+-1.90211 -0.618034 0
+-1.50000 1.83697e-16 0
+-1.95106 -0.309017 0
+-1.70106 -0.309017 0
+-1.75000 2.14313e-16 0
+-1.42658 -0.463526 0
+-1.50000 1.83697e-16 0
+-1.90211 -0.618034 0
+-1.46329 -0.231763 0
+-1.70106 -0.309017 0
+-1.66435 -0.540780 0
+-1.42658 -0.463526 0
+-1.90211 -0.618034 0
+-1.21353 -0.881678 0
+-1.66435 -0.540780 0
+-1.55782 -0.749856 0
+-1.32006 -0.672602 0
+-1.61803 -1.17557 0
+-1.21353 -0.881678 0
+-1.90211 -0.618034 0
+-1.41578 -1.02862 0
+-1.55782 -0.749856 0
+-1.76007 -0.896802 0
+-1.00000 1.22465e-16 0
+-1.50000 1.83697e-16 0
+-0.951057 -0.309017 0
+-1.25000 1.53081e-16 0
+-1.22553 -0.154509 0
+-0.975528 -0.154509 0
+-1.42658 -0.463526 0
+-0.951057 -0.309017 0
+-1.50000 1.83697e-16 0
+-1.18882 -0.386271 0
+-1.22553 -0.154509 0
+-1.46329 -0.231763 0
+-1.42658 -0.463526 0
+-1.21353 -0.881678 0
+-0.951057 -0.309017 0
+-1.32006 -0.672602 0
+-1.08229 -0.595347 0
+-1.18882 -0.386271 0
+-0.809017 -0.587785 0
+-0.951057 -0.309017 0
+-1.21353 -0.881678 0
+-0.880037 -0.448401 0
+-1.08229 -0.595347 0
+-1.01127 -0.734732 0
+-1.61803 -1.17557 0
+-1.17557 -1.61803 0
+-1.21353 -0.881678 0
+-1.39680 -1.39680 0
+-1.19455 -1.24986 0
+-1.41578 -1.02862 0
+-0.881678 -1.21353 0
+-1.21353 -0.881678 0
+-1.17557 -1.61803 0
+-1.04760 -1.04760 0
+-1.19455 -1.24986 0
+-1.02862 -1.41578 0
+-0.881678 -1.21353 0
+-1.17557 -1.61803 0
+-0.463526 -1.42658 0
+-1.02862 -1.41578 0
+-0.819548 -1.52231 0
+-0.672602 -1.32006 0
+-0.618034 -1.90211 0
+-0.463526 -1.42658 0
+-1.17557 -1.61803 0
+-0.540780 -1.66435 0
+-0.819548 -1.52231 0
+-0.896802 -1.76007 0
+-0.809017 -0.587785 0
+-1.21353 -0.881678 0
+-0.587785 -0.809017 0
+-1.01127 -0.734732 0
+-0.900655 -0.845347 0
+-0.698401 -0.698401 0
+-0.881678 -1.21353 0
+-0.587785 -0.809017 0
+-1.21353 -0.881678 0
+-0.734732 -1.01127 0
+-0.900655 -0.845347 0
+-1.04760 -1.04760 0
+-0.881678 -1.21353 0
+-0.463526 -1.42658 0
+-0.587785 -0.809017 0
+-0.672602 -1.32006 0
+-0.525655 -1.11780 0
+-0.734732 -1.01127 0
+-0.309017 -0.951057 0
+-0.587785 -0.809017 0
+-0.463526 -1.42658 0
+-0.448401 -0.880037 0
+-0.525655 -1.11780 0
+-0.386271 -1.18882 0
+-0.618034 -1.90211 0
+-3.67394e-16 -2.00000 0
+-0.463526 -1.42658 0
+-0.309017 -1.95106 0
+-0.231763 -1.71329 0
+-0.540780 -1.66435 0
+-2.75546e-16 -1.50000 0
+-0.463526 -1.42658 0
+-3.67394e-16 -2.00000 0
+-0.231763 -1.46329 0
+-0.231763 -1.71329 0
+-3.21470e-16 -1.75000 0
+-2.75546e-16 -1.50000 0
+-3.67394e-16 -2.00000 0
+0.463526 -1.42658 0
+-3.21470e-16 -1.75000 0
+0.231763 -1.71329 0
+0.231763 -1.46329 0
+0.618034 -1.90211 0
+0.463526 -1.42658 0
+-3.67394e-16 -2.00000 0
+0.540780 -1.66435 0
+0.231763 -1.71329 0
+0.309017 -1.95106 0
+-0.309017 -0.951057 0
+-0.463526 -1.42658 0
+-1.83697e-16 -1.00000 0
+-0.386271 -1.18882 0
+-0.231763 -1.21329 0
+-0.154509 -0.975528 0
+-2.75546e-16 -1.50000 0
+-1.83697e-16 -1.00000 0
+-0.463526 -1.42658 0
+-2.29621e-16 -1.25000 0
+-0.231763 -1.21329 0
+-0.231763 -1.46329 0
+-2.75546e-16 -1.50000 0
+0.463526 -1.42658 0
+-1.83697e-16 -1.00000 0
+0.231763 -1.46329 0
+0.231763 -1.21329 0
+-2.29621e-16 -1.25000 0
+0.309017 -0.951057 0
+-1.83697e-16 -1.00000 0
+0.463526 -1.42658 0
+0.154509 -0.975528 0
+0.231763 -1.21329 0
+0.386271 -1.18882 0
+0.618034 -1.90211 0
+1.17557 -1.61803 0
+0.463526 -1.42658 0
+0.896802 -1.76007 0
+0.819548 -1.52231 0
+0.540780 -1.66435 0
+0.881678 -1.21353 0
+0.463526 -1.42658 0
+1.17557 -1.61803 0
+0.672602 -1.32006 0
+0.819548 -1.52231 0
+1.02862 -1.41578 0
+0.881678 -1.21353 0
+1.17557 -1.61803 0
+1.21353 -0.881678 0
+1.02862 -1.41578 0
+1.19455 -1.24986 0
+1.04760 -1.04760 0
+1.61803 -1.17557 0
+1.21353 -0.881678 0
+1.17557 -1.61803 0
+1.41578 -1.02862 0
+1.19455 -1.24986 0
+1.39680 -1.39680 0
+0.309017 -0.951057 0
+0.463526 -1.42658 0
+0.587785 -0.809017 0
+0.386271 -1.18882 0
+0.525655 -1.11780 0
+0.448401 -0.880037 0
+0.881678 -1.21353 0
+0.587785 -0.809017 0
+0.463526 -1.42658 0
+0.734732 -1.01127 0
+0.525655 -1.11780 0
+0.672602 -1.32006 0
+0.881678 -1.21353 0
+1.21353 -0.881678 0
+0.587785 -0.809017 0
+1.04760 -1.04760 0
+0.900655 -0.845347 0
+0.734732 -1.01127 0
+0.809017 -0.587785 0
+0.587785 -0.809017 0
+1.21353 -0.881678 0
+0.698401 -0.698401 0
+0.900655 -0.845347 0
+1.01127 -0.734732 0
+1.61803 -1.17557 0
+1.90211 -0.618034 0
+1.21353 -0.881678 0
+1.76007 -0.896802 0
+1.55782 -0.749856 0
+1.41578 -1.02862 0
+1.42658 -0.463526 0
+1.21353 -0.881678 0
+1.90211 -0.618034 0
+1.32006 -0.672602 0
+1.55782 -0.749856 0
+1.66435 -0.540780 0
+1.42658 -0.463526 0
+1.90211 -0.618034 0
+1.50000 0.00000 0
+1.66435 -0.540780 0
+1.70106 -0.309017 0
+1.46329 -0.231763 0
+2.00000 0.00000 0
+1.50000 0.00000 0
+1.90211 -0.618034 0
+1.75000 0.00000 0
+1.70106 -0.309017 0
+1.95106 -0.309017 0
+0.809017 -0.587785 0
+1.21353 -0.881678 0
+0.951057 -0.309017 0
+1.01127 -0.734732 0
+1.08229 -0.595347 0
+0.880037 -0.448401 0
+1.42658 -0.463526 0
+0.951057 -0.309017 0
+1.21353 -0.881678 0
+1.18882 -0.386271 0
+1.08229 -0.595347 0
+1.32006 -0.672602 0
+1.42658 -0.463526 0
+1.50000 0.00000 0
+0.951057 -0.309017 0
+1.46329 -0.231763 0
+1.22553 -0.154509 0
+1.18882 -0.386271 0
+1.00000 0.00000 0
+0.951057 -0.309017 0
+1.50000 0.00000 0
+0.975528 -0.154509 0
+1.22553 -0.154509 0
+1.25000 0.00000 0
+
+CELLS 80 560
+       6       0       1       2       3       4       5
+       6       6       7       8       9       10      11
+       6       12      13      14      15      16      17
+       6       18      19      20      21      22      23
+       6       24      25      26      27      28      29
+       6       30      31      32      33      34      35
+       6       36      37      38      39      40      41
+       6       42      43      44      45      46      47
+       6       48      49      50      51      52      53
+       6       54      55      56      57      58      59
+       6       60      61      62      63      64      65
+       6       66      67      68      69      70      71
+       6       72      73      74      75      76      77
+       6       78      79      80      81      82      83
+       6       84      85      86      87      88      89
+       6       90      91      92      93      94      95
+       6       96      97      98      99      100     101
+       6       102     103     104     105     106     107
+       6       108     109     110     111     112     113
+       6       114     115     116     117     118     119
+       6       120     121     122     123     124     125
+       6       126     127     128     129     130     131
+       6       132     133     134     135     136     137
+       6       138     139     140     141     142     143
+       6       144     145     146     147     148     149
+       6       150     151     152     153     154     155
+       6       156     157     158     159     160     161
+       6       162     163     164     165     166     167
+       6       168     169     170     171     172     173
+       6       174     175     176     177     178     179
+       6       180     181     182     183     184     185
+       6       186     187     188     189     190     191
+       6       192     193     194     195     196     197
+       6       198     199     200     201     202     203
+       6       204     205     206     207     208     209
+       6       210     211     212     213     214     215
+       6       216     217     218     219     220     221
+       6       222     223     224     225     226     227
+       6       228     229     230     231     232     233
+       6       234     235     236     237     238     239
+       6       240     241     242     243     244     245
+       6       246     247     248     249     250     251
+       6       252     253     254     255     256     257
+       6       258     259     260     261     262     263
+       6       264     265     266     267     268     269
+       6       270     271     272     273     274     275
+       6       276     277     278     279     280     281
+       6       282     283     284     285     286     287
+       6       288     289     290     291     292     293
+       6       294     295     296     297     298     299
+       6       300     301     302     303     304     305
+       6       306     307     308     309     310     311
+       6       312     313     314     315     316     317
+       6       318     319     320     321     322     323
+       6       324     325     326     327     328     329
+       6       330     331     332     333     334     335
+       6       336     337     338     339     340     341
+       6       342     343     344     345     346     347
+       6       348     349     350     351     352     353
+       6       354     355     356     357     358     359
+       6       360     361     362     363     364     365
+       6       366     367     368     369     370     371
+       6       372     373     374     375     376     377
+       6       378     379     380     381     382     383
+       6       384     385     386     387     388     389
+       6       390     391     392     393     394     395
+       6       396     397     398     399     400     401
+       6       402     403     404     405     406     407
+       6       408     409     410     411     412     413
+       6       414     415     416     417     418     419
+       6       420     421     422     423     424     425
+       6       426     427     428     429     430     431
+       6       432     433     434     435     436     437
+       6       438     439     440     441     442     443
+       6       444     445     446     447     448     449
+       6       450     451     452     453     454     455
+       6       456     457     458     459     460     461
+       6       462     463     464     465     466     467
+       6       468     469     470     471     472     473
+       6       474     475     476     477     478     479
+
+CELL_TYPES 80
+ 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22
+POINT_DATA 480
+SCALARS solution double 1
+LOOKUP_TABLE default
+0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 
+# vtk DataFile Version 3.0
+#This file was generated 
+ASCII
+DATASET UNSTRUCTURED_GRID
+
+POINTS 480 double
+2.00000 0.00000 0
+1.90211 0.618034 0
+1.50000 0.00000 0
+1.97538 0.312869 0
+1.72845 0.273760 0
+1.75000 0.00000 0
+1.42658 0.463526 0
+1.50000 0.00000 0
+1.90211 0.618034 0
+1.48153 0.234652 0
+1.72845 0.273760 0
+1.66435 0.540780 0
+1.42658 0.463526 0
+1.90211 0.618034 0
+1.21353 0.881678 0
+1.66435 0.540780 0
+1.55926 0.794483 0
+1.33651 0.680986 0
+1.61803 1.17557 0
+1.21353 0.881678 0
+1.90211 0.618034 0
+1.41578 1.02862 0
+1.55926 0.794483 0
+1.78201 0.907981 0
+1.00000 0.00000 0
+1.50000 0.00000 0
+0.951057 0.309017 0
+1.25000 0.00000 0
+1.23461 0.195543 0
+0.987688 0.156434 0
+1.42658 0.463526 0
+0.951057 0.309017 0
+1.50000 0.00000 0
+1.18882 0.386271 0
+1.23461 0.195543 0
+1.48153 0.234652 0
+1.42658 0.463526 0
+1.21353 0.881678 0
+0.951057 0.309017 0
+1.33651 0.680986 0
+1.11376 0.567488 0
+1.18882 0.386271 0
+0.809017 0.587785 0
+0.951057 0.309017 0
+1.21353 0.881678 0
+0.891007 0.453990 0
+1.11376 0.567488 0
+1.01127 0.734732 0
+1.61803 1.17557 0
+1.17557 1.61803 0
+1.21353 0.881678 0
+1.41421 1.41421 0
+1.23744 1.23744 0
+1.41578 1.02862 0
+0.881678 1.21353 0
+1.21353 0.881678 0
+1.17557 1.61803 0
+1.06066 1.06066 0
+1.23744 1.23744 0
+1.02862 1.41578 0
+0.881678 1.21353 0
+1.17557 1.61803 0
+0.463526 1.42658 0
+1.02862 1.41578 0
+0.794483 1.55926 0
+0.680986 1.33651 0
+0.618034 1.90211 0
+0.463526 1.42658 0
+1.17557 1.61803 0
+0.540780 1.66435 0
+0.794483 1.55926 0
+0.907981 1.78201 0
+0.809017 0.587785 0
+1.21353 0.881678 0
+0.587785 0.809017 0
+1.01127 0.734732 0
+0.883883 0.883883 0
+0.707107 0.707107 0
+0.881678 1.21353 0
+0.587785 0.809017 0
+1.21353 0.881678 0
+0.734732 1.01127 0
+0.883883 0.883883 0
+1.06066 1.06066 0
+0.881678 1.21353 0
+0.463526 1.42658 0
+0.587785 0.809017 0
+0.680986 1.33651 0
+0.567488 1.11376 0
+0.734732 1.01127 0
+0.309017 0.951057 0
+0.587785 0.809017 0
+0.463526 1.42658 0
+0.453990 0.891007 0
+0.567488 1.11376 0
+0.386271 1.18882 0
+0.618034 1.90211 0
+5.66554e-16 2.00000 0
+0.463526 1.42658 0
+0.312869 1.97538 0
+0.273760 1.72845 0
+0.540780 1.66435 0
+9.18485e-17 1.50000 0
+0.463526 1.42658 0
+5.66554e-16 2.00000 0
+0.234652 1.48153 0
+0.273760 1.72845 0
+1.07157e-16 1.75000 0
+9.18485e-17 1.50000 0
+5.66554e-16 2.00000 0
+-0.463526 1.42658 0
+1.07157e-16 1.75000 0
+-0.273760 1.72845 0
+-0.234652 1.48153 0
+-0.618034 1.90211 0
+-0.463526 1.42658 0
+5.66554e-16 2.00000 0
+-0.540780 1.66435 0
+-0.273760 1.72845 0
+-0.312869 1.97538 0
+0.309017 0.951057 0
+0.463526 1.42658 0
+2.83277e-16 1.00000 0
+0.386271 1.18882 0
+0.195543 1.23461 0
+0.156434 0.987688 0
+9.18485e-17 1.50000 0
+2.83277e-16 1.00000 0
+0.463526 1.42658 0
+7.65404e-17 1.25000 0
+0.195543 1.23461 0
+0.234652 1.48153 0
+9.18485e-17 1.50000 0
+-0.463526 1.42658 0
+2.83277e-16 1.00000 0
+-0.234652 1.48153 0
+-0.195543 1.23461 0
+7.65404e-17 1.25000 0
+-0.309017 0.951057 0
+2.83277e-16 1.00000 0
+-0.463526 1.42658 0
+-0.156434 0.987688 0
+-0.195543 1.23461 0
+-0.386271 1.18882 0
+-0.618034 1.90211 0
+-1.17557 1.61803 0
+-0.463526 1.42658 0
+-0.907981 1.78201 0
+-0.794483 1.55926 0
+-0.540780 1.66435 0
+-0.881678 1.21353 0
+-0.463526 1.42658 0
+-1.17557 1.61803 0
+-0.680986 1.33651 0
+-0.794483 1.55926 0
+-1.02862 1.41578 0
+-0.881678 1.21353 0
+-1.17557 1.61803 0
+-1.21353 0.881678 0
+-1.02862 1.41578 0
+-1.23744 1.23744 0
+-1.06066 1.06066 0
+-1.61803 1.17557 0
+-1.21353 0.881678 0
+-1.17557 1.61803 0
+-1.41578 1.02862 0
+-1.23744 1.23744 0
+-1.41421 1.41421 0
+-0.309017 0.951057 0
+-0.463526 1.42658 0
+-0.587785 0.809017 0
+-0.386271 1.18882 0
+-0.567488 1.11376 0
+-0.453990 0.891007 0
+-0.881678 1.21353 0
+-0.587785 0.809017 0
+-0.463526 1.42658 0
+-0.734732 1.01127 0
+-0.567488 1.11376 0
+-0.680986 1.33651 0
+-0.881678 1.21353 0
+-1.21353 0.881678 0
+-0.587785 0.809017 0
+-1.06066 1.06066 0
+-0.883883 0.883883 0
+-0.734732 1.01127 0
+-0.809017 0.587785 0
+-0.587785 0.809017 0
+-1.21353 0.881678 0
+-0.707107 0.707107 0
+-0.883883 0.883883 0
+-1.01127 0.734732 0
+-1.61803 1.17557 0
+-1.90211 0.618034 0
+-1.21353 0.881678 0
+-1.78201 0.907981 0
+-1.55926 0.794483 0
+-1.41578 1.02862 0
+-1.42658 0.463526 0
+-1.21353 0.881678 0
+-1.90211 0.618034 0
+-1.33651 0.680986 0
+-1.55926 0.794483 0
+-1.66435 0.540780 0
+-1.42658 0.463526 0
+-1.90211 0.618034 0
+-1.50000 1.83697e-16 0
+-1.66435 0.540780 0
+-1.72845 0.273760 0
+-1.48153 0.234652 0
+-2.00000 2.44929e-16 0
+-1.50000 1.83697e-16 0
+-1.90211 0.618034 0
+-1.75000 2.14313e-16 0
+-1.72845 0.273760 0
+-1.97538 0.312869 0
+-0.809017 0.587785 0
+-1.21353 0.881678 0
+-0.951057 0.309017 0
+-1.01127 0.734732 0
+-1.11376 0.567488 0
+-0.891007 0.453990 0
+-1.42658 0.463526 0
+-0.951057 0.309017 0
+-1.21353 0.881678 0
+-1.18882 0.386271 0
+-1.11376 0.567488 0
+-1.33651 0.680986 0
+-1.42658 0.463526 0
+-1.50000 1.83697e-16 0
+-0.951057 0.309017 0
+-1.48153 0.234652 0
+-1.23461 0.195543 0
+-1.18882 0.386271 0
+-1.00000 1.22465e-16 0
+-0.951057 0.309017 0
+-1.50000 1.83697e-16 0
+-0.987688 0.156434 0
+-1.23461 0.195543 0
+-1.25000 1.53081e-16 0
+-2.00000 2.44929e-16 0
+-1.90211 -0.618034 0
+-1.50000 1.83697e-16 0
+-1.97538 -0.312869 0
+-1.72845 -0.273760 0
+-1.75000 2.14313e-16 0
+-1.42658 -0.463526 0
+-1.50000 1.83697e-16 0
+-1.90211 -0.618034 0
+-1.48153 -0.234652 0
+-1.72845 -0.273760 0
+-1.66435 -0.540780 0
+-1.42658 -0.463526 0
+-1.90211 -0.618034 0
+-1.21353 -0.881678 0
+-1.66435 -0.540780 0
+-1.55926 -0.794483 0
+-1.33651 -0.680986 0
+-1.61803 -1.17557 0
+-1.21353 -0.881678 0
+-1.90211 -0.618034 0
+-1.41578 -1.02862 0
+-1.55926 -0.794483 0
+-1.78201 -0.907981 0
+-1.00000 1.22465e-16 0
+-1.50000 1.83697e-16 0
+-0.951057 -0.309017 0
+-1.25000 1.53081e-16 0
+-1.23461 -0.195543 0
+-0.987688 -0.156434 0
+-1.42658 -0.463526 0
+-0.951057 -0.309017 0
+-1.50000 1.83697e-16 0
+-1.18882 -0.386271 0
+-1.23461 -0.195543 0
+-1.48153 -0.234652 0
+-1.42658 -0.463526 0
+-1.21353 -0.881678 0
+-0.951057 -0.309017 0
+-1.33651 -0.680986 0
+-1.11376 -0.567488 0
+-1.18882 -0.386271 0
+-0.809017 -0.587785 0
+-0.951057 -0.309017 0
+-1.21353 -0.881678 0
+-0.891007 -0.453990 0
+-1.11376 -0.567488 0
+-1.01127 -0.734732 0
+-1.61803 -1.17557 0
+-1.17557 -1.61803 0
+-1.21353 -0.881678 0
+-1.41421 -1.41421 0
+-1.23744 -1.23744 0
+-1.41578 -1.02862 0
+-0.881678 -1.21353 0
+-1.21353 -0.881678 0
+-1.17557 -1.61803 0
+-1.06066 -1.06066 0
+-1.23744 -1.23744 0
+-1.02862 -1.41578 0
+-0.881678 -1.21353 0
+-1.17557 -1.61803 0
+-0.463526 -1.42658 0
+-1.02862 -1.41578 0
+-0.794483 -1.55926 0
+-0.680986 -1.33651 0
+-0.618034 -1.90211 0
+-0.463526 -1.42658 0
+-1.17557 -1.61803 0
+-0.540780 -1.66435 0
+-0.794483 -1.55926 0
+-0.907981 -1.78201 0
+-0.809017 -0.587785 0
+-1.21353 -0.881678 0
+-0.587785 -0.809017 0
+-1.01127 -0.734732 0
+-0.883883 -0.883883 0
+-0.707107 -0.707107 0
+-0.881678 -1.21353 0
+-0.587785 -0.809017 0
+-1.21353 -0.881678 0
+-0.734732 -1.01127 0
+-0.883883 -0.883883 0
+-1.06066 -1.06066 0
+-0.881678 -1.21353 0
+-0.463526 -1.42658 0
+-0.587785 -0.809017 0
+-0.680986 -1.33651 0
+-0.567488 -1.11376 0
+-0.734732 -1.01127 0
+-0.309017 -0.951057 0
+-0.587785 -0.809017 0
+-0.463526 -1.42658 0
+-0.453990 -0.891007 0
+-0.567488 -1.11376 0
+-0.386271 -1.18882 0
+-0.618034 -1.90211 0
+-3.67394e-16 -2.00000 0
+-0.463526 -1.42658 0
+-0.312869 -1.97538 0
+-0.273760 -1.72845 0
+-0.540780 -1.66435 0
+-2.75546e-16 -1.50000 0
+-0.463526 -1.42658 0
+-3.67394e-16 -2.00000 0
+-0.234652 -1.48153 0
+-0.273760 -1.72845 0
+-3.21470e-16 -1.75000 0
+-2.75546e-16 -1.50000 0
+-3.67394e-16 -2.00000 0
+0.463526 -1.42658 0
+-3.21470e-16 -1.75000 0
+0.273760 -1.72845 0
+0.234652 -1.48153 0
+0.618034 -1.90211 0
+0.463526 -1.42658 0
+-3.67394e-16 -2.00000 0
+0.540780 -1.66435 0
+0.273760 -1.72845 0
+0.312869 -1.97538 0
+-0.309017 -0.951057 0
+-0.463526 -1.42658 0
+-1.83697e-16 -1.00000 0
+-0.386271 -1.18882 0
+-0.195543 -1.23461 0
+-0.156434 -0.987688 0
+-2.75546e-16 -1.50000 0
+-1.83697e-16 -1.00000 0
+-0.463526 -1.42658 0
+-2.29621e-16 -1.25000 0
+-0.195543 -1.23461 0
+-0.234652 -1.48153 0
+-2.75546e-16 -1.50000 0
+0.463526 -1.42658 0
+-1.83697e-16 -1.00000 0
+0.234652 -1.48153 0
+0.195543 -1.23461 0
+-2.29621e-16 -1.25000 0
+0.309017 -0.951057 0
+-1.83697e-16 -1.00000 0
+0.463526 -1.42658 0
+0.156434 -0.987688 0
+0.195543 -1.23461 0
+0.386271 -1.18882 0
+0.618034 -1.90211 0
+1.17557 -1.61803 0
+0.463526 -1.42658 0
+0.907981 -1.78201 0
+0.794483 -1.55926 0
+0.540780 -1.66435 0
+0.881678 -1.21353 0
+0.463526 -1.42658 0
+1.17557 -1.61803 0
+0.680986 -1.33651 0
+0.794483 -1.55926 0
+1.02862 -1.41578 0
+0.881678 -1.21353 0
+1.17557 -1.61803 0
+1.21353 -0.881678 0
+1.02862 -1.41578 0
+1.23744 -1.23744 0
+1.06066 -1.06066 0
+1.61803 -1.17557 0
+1.21353 -0.881678 0
+1.17557 -1.61803 0
+1.41578 -1.02862 0
+1.23744 -1.23744 0
+1.41421 -1.41421 0
+0.309017 -0.951057 0
+0.463526 -1.42658 0
+0.587785 -0.809017 0
+0.386271 -1.18882 0
+0.567488 -1.11376 0
+0.453990 -0.891007 0
+0.881678 -1.21353 0
+0.587785 -0.809017 0
+0.463526 -1.42658 0
+0.734732 -1.01127 0
+0.567488 -1.11376 0
+0.680986 -1.33651 0
+0.881678 -1.21353 0
+1.21353 -0.881678 0
+0.587785 -0.809017 0
+1.06066 -1.06066 0
+0.883883 -0.883883 0
+0.734732 -1.01127 0
+0.809017 -0.587785 0
+0.587785 -0.809017 0
+1.21353 -0.881678 0
+0.707107 -0.707107 0
+0.883883 -0.883883 0
+1.01127 -0.734732 0
+1.61803 -1.17557 0
+1.90211 -0.618034 0
+1.21353 -0.881678 0
+1.78201 -0.907981 0
+1.55926 -0.794483 0
+1.41578 -1.02862 0
+1.42658 -0.463526 0
+1.21353 -0.881678 0
+1.90211 -0.618034 0
+1.33651 -0.680986 0
+1.55926 -0.794483 0
+1.66435 -0.540780 0
+1.42658 -0.463526 0
+1.90211 -0.618034 0
+1.50000 0.00000 0
+1.66435 -0.540780 0
+1.72845 -0.273760 0
+1.48153 -0.234652 0
+2.00000 0.00000 0
+1.50000 0.00000 0
+1.90211 -0.618034 0
+1.75000 0.00000 0
+1.72845 -0.273760 0
+1.97538 -0.312869 0
+0.809017 -0.587785 0
+1.21353 -0.881678 0
+0.951057 -0.309017 0
+1.01127 -0.734732 0
+1.11376 -0.567488 0
+0.891007 -0.453990 0
+1.42658 -0.463526 0
+0.951057 -0.309017 0
+1.21353 -0.881678 0
+1.18882 -0.386271 0
+1.11376 -0.567488 0
+1.33651 -0.680986 0
+1.42658 -0.463526 0
+1.50000 0.00000 0
+0.951057 -0.309017 0
+1.48153 -0.234652 0
+1.23461 -0.195543 0
+1.18882 -0.386271 0
+1.00000 0.00000 0
+0.951057 -0.309017 0
+1.50000 0.00000 0
+0.987688 -0.156434 0
+1.23461 -0.195543 0
+1.25000 0.00000 0
+
+CELLS 80 560
+       6       0       1       2       3       4       5
+       6       6       7       8       9       10      11
+       6       12      13      14      15      16      17
+       6       18      19      20      21      22      23
+       6       24      25      26      27      28      29
+       6       30      31      32      33      34      35
+       6       36      37      38      39      40      41
+       6       42      43      44      45      46      47
+       6       48      49      50      51      52      53
+       6       54      55      56      57      58      59
+       6       60      61      62      63      64      65
+       6       66      67      68      69      70      71
+       6       72      73      74      75      76      77
+       6       78      79      80      81      82      83
+       6       84      85      86      87      88      89
+       6       90      91      92      93      94      95
+       6       96      97      98      99      100     101
+       6       102     103     104     105     106     107
+       6       108     109     110     111     112     113
+       6       114     115     116     117     118     119
+       6       120     121     122     123     124     125
+       6       126     127     128     129     130     131
+       6       132     133     134     135     136     137
+       6       138     139     140     141     142     143
+       6       144     145     146     147     148     149
+       6       150     151     152     153     154     155
+       6       156     157     158     159     160     161
+       6       162     163     164     165     166     167
+       6       168     169     170     171     172     173
+       6       174     175     176     177     178     179
+       6       180     181     182     183     184     185
+       6       186     187     188     189     190     191
+       6       192     193     194     195     196     197
+       6       198     199     200     201     202     203
+       6       204     205     206     207     208     209
+       6       210     211     212     213     214     215
+       6       216     217     218     219     220     221
+       6       222     223     224     225     226     227
+       6       228     229     230     231     232     233
+       6       234     235     236     237     238     239
+       6       240     241     242     243     244     245
+       6       246     247     248     249     250     251
+       6       252     253     254     255     256     257
+       6       258     259     260     261     262     263
+       6       264     265     266     267     268     269
+       6       270     271     272     273     274     275
+       6       276     277     278     279     280     281
+       6       282     283     284     285     286     287
+       6       288     289     290     291     292     293
+       6       294     295     296     297     298     299
+       6       300     301     302     303     304     305
+       6       306     307     308     309     310     311
+       6       312     313     314     315     316     317
+       6       318     319     320     321     322     323
+       6       324     325     326     327     328     329
+       6       330     331     332     333     334     335
+       6       336     337     338     339     340     341
+       6       342     343     344     345     346     347
+       6       348     349     350     351     352     353
+       6       354     355     356     357     358     359
+       6       360     361     362     363     364     365
+       6       366     367     368     369     370     371
+       6       372     373     374     375     376     377
+       6       378     379     380     381     382     383
+       6       384     385     386     387     388     389
+       6       390     391     392     393     394     395
+       6       396     397     398     399     400     401
+       6       402     403     404     405     406     407
+       6       408     409     410     411     412     413
+       6       414     415     416     417     418     419
+       6       420     421     422     423     424     425
+       6       426     427     428     429     430     431
+       6       432     433     434     435     436     437
+       6       438     439     440     441     442     443
+       6       444     445     446     447     448     449
+       6       450     451     452     453     454     455
+       6       456     457     458     459     460     461
+       6       462     463     464     465     466     467
+       6       468     469     470     471     472     473
+       6       474     475     476     477     478     479
+
+CELL_TYPES 80
+ 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22
+POINT_DATA 480
+SCALARS solution double 1
+LOOKUP_TABLE default
+0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 

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.