]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Generalize MappingFE::compute_mapping_support_points() 17550/head
authorPeter Munch <peterrmuench@gmail.com>
Thu, 15 Aug 2024 20:25:58 +0000 (22:25 +0200)
committerPeter Munch <peterrmuench@gmail.com>
Tue, 20 Aug 2024 16:20:23 +0000 (18:20 +0200)
doc/news/changes/minor/20240816Munch [new file with mode: 0644]
source/fe/mapping_fe.cc
tests/simplex/mapping_fe_02.cc [new file with mode: 0644]
tests/simplex/mapping_fe_02.output [new file with mode: 0644]

diff --git a/doc/news/changes/minor/20240816Munch b/doc/news/changes/minor/20240816Munch
new file mode 100644 (file)
index 0000000..62f42bd
--- /dev/null
@@ -0,0 +1,5 @@
+Improved: MappingFE now supports the case that not
+all geometric objects of a cell have the same
+manifold id.
+<br>
+(Peter Munch, 2024/08/16)
index 7856db406f7d9bc4722ff180cb39c246eaec865b..f06ffb89973fdd33804a8425457e1995e16752e3 100644 (file)
@@ -26,6 +26,7 @@
 #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/manifold_lib.h>
 #include <deal.II/grid/tria.h>
 #include <deal.II/grid/tria_iterator.h>
@@ -2270,22 +2271,105 @@ std::vector<Point<spacedim>>
 MappingFE<dim, spacedim>::compute_mapping_support_points(
   const typename Triangulation<dim, spacedim>::cell_iterator &cell) const
 {
-  Assert(
-    check_all_manifold_ids_identical(cell),
-    ExcMessage(
-      "All entities of a cell need to have the same manifold id as the cell has."));
+  std::vector<Point<spacedim>> mapping_support_points(
+    fe->get_unit_support_points().size());
 
   std::vector<Point<spacedim>> vertices(cell->n_vertices());
-
   for (const unsigned int i : cell->vertex_indices())
     vertices[i] = cell->vertex(i);
 
-  std::vector<Point<spacedim>> mapping_support_points(
-    fe->get_unit_support_points().size());
+  if (check_all_manifold_ids_identical(cell))
+    {
+      // version 1) all geometric entities have the same manifold:
+
+      cell->get_manifold().get_new_points(vertices,
+                                          mapping_support_point_weights,
+                                          mapping_support_points);
+    }
+  else
+    {
+      // version 1) geometric entities have different manifold
+
+      // helper function to compute mapped points on subentities
+      // note[PM]: this function currently only uses the vertices
+      // of cells to create new points on subentities; however,
+      // one should use all bounding points to create new points
+      // as in the case of MappingQ.
+      const auto process = [&](const auto    &manifold,
+                               const auto    &indices,
+                               const unsigned n_points) {
+        if ((indices.size() == 0) || (n_points == 0))
+          return;
+
+        const unsigned int n_shape_functions =
+          this->fe->reference_cell().n_vertices();
+
+        Table<2, double> mapping_support_point_weights_local(n_points,
+                                                             n_shape_functions);
+        std::vector<Point<spacedim>> mapping_support_points_local(n_points);
 
-  cell->get_manifold().get_new_points(vertices,
-                                      mapping_support_point_weights,
-                                      mapping_support_points);
+        for (unsigned int p = 0; p < n_points; ++p)
+          for (unsigned int i = 0; i < n_shape_functions; ++i)
+            mapping_support_point_weights_local(p, i) =
+              mapping_support_point_weights(
+                indices[p + (indices.size() - n_points)], i);
+
+        manifold.get_new_points(vertices,
+                                mapping_support_point_weights_local,
+                                mapping_support_points_local);
+
+        for (unsigned int p = 0; p < n_points; ++p)
+          mapping_support_points[indices[p + (indices.size() - n_points)]] =
+            mapping_support_points_local[p];
+      };
+
+      // create dummy DoFHandler to extract indices on subobjects
+      const auto                  &fe = *this->fe;
+      Triangulation<dim, spacedim> tria;
+      GridGenerator::reference_cell(tria, fe.reference_cell());
+      DoFHandler<dim, spacedim> dof_handler(tria);
+      dof_handler.distribute_dofs(fe);
+      const auto &cell_ref = dof_handler.begin_active();
+
+      std::vector<types::global_dof_index> indices;
+
+      // add vertices
+      for (const unsigned int i : cell->vertex_indices())
+        mapping_support_points[i] = cell->vertex(i);
+
+      // process and add line support points
+      for (unsigned int l = 0; l < cell_ref->n_lines(); ++l)
+        {
+          const auto accessor = cell_ref->line(l);
+          indices.resize(fe.n_dofs_per_line() + 2 * fe.n_dofs_per_vertex());
+          accessor->get_dof_indices(indices);
+          process(cell->line(l)->get_manifold(), indices, fe.n_dofs_per_line());
+        }
+
+      // process and add face support points
+      if constexpr (dim >= 3)
+        {
+          for (unsigned int f = 0; f < cell_ref->n_faces(); ++f)
+            {
+              const auto accessor = cell_ref->face(f);
+              indices.resize(fe.n_dofs_per_face());
+              accessor->get_dof_indices(indices);
+              process(cell->face(f)->get_manifold(),
+                      indices,
+                      fe.n_dofs_per_quad());
+            }
+        }
+
+      // process and add volume support points
+      if constexpr (dim >= 2)
+        {
+          indices.resize(fe.n_dofs_per_cell());
+          cell_ref->get_dof_indices(indices);
+          process(cell->get_manifold(),
+                  indices,
+                  (dim == 2) ? fe.n_dofs_per_quad() : fe.n_dofs_per_hex());
+        }
+    }
 
   return mapping_support_points;
 }
diff --git a/tests/simplex/mapping_fe_02.cc b/tests/simplex/mapping_fe_02.cc
new file mode 100644 (file)
index 0000000..4432034
--- /dev/null
@@ -0,0 +1,87 @@
+// ------------------------------------------------------------------------
+//
+// SPDX-License-Identifier: LGPL-2.1-or-later
+// Copyright (C) 2021 - 2024 by the deal.II authors
+//
+// This file is part of the deal.II library.
+//
+// Part of the source code is dual licensed under Apache-2.0 WITH
+// LLVM-exception OR LGPL-2.1-or-later. Detailed license information
+// governing the source code and code contributions can be found in
+// LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II.
+//
+// ------------------------------------------------------------------------
+
+
+// Distribute FE_WedgeP on a DoFHandler.
+
+#include <deal.II/base/quadrature_lib.h>
+
+#include <deal.II/dofs/dof_handler.h>
+
+#include <deal.II/fe/fe_pyramid_p.h>
+#include <deal.II/fe/fe_simplex_p.h>
+#include <deal.II/fe/fe_simplex_p_bubbles.h>
+#include <deal.II/fe/fe_values.h>
+#include <deal.II/fe/fe_wedge_p.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 "../tests.h"
+
+
+void
+test(const unsigned int mapping_degree)
+{
+  const int dim = 2;
+
+  Triangulation<dim> tria, tria_temp;
+  GridGenerator::hyper_ball(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));
+
+  FE_SimplexP<dim> fe(2);
+
+  DoFHandler<dim> dof_handler(tria);
+  dof_handler.distribute_dofs(fe);
+
+  MappingFE<dim> mapping(FE_SimplexP<dim>{mapping_degree});
+
+  {
+    DataOutBase::VtkFlags flags;
+    flags.write_higher_order_cells = true;
+
+    DataOut<dim> data_out;
+    data_out.set_flags(flags);
+
+    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, 3);
+
+#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);
+  test(3);
+}
diff --git a/tests/simplex/mapping_fe_02.output b/tests/simplex/mapping_fe_02.output
new file mode 100644 (file)
index 0000000..9b63dd6
--- /dev/null
@@ -0,0 +1,1366 @@
+
+# vtk DataFile Version 3.0
+#This file was generated 
+ASCII
+DATASET UNSTRUCTURED_GRID
+
+POINTS 400 double
+-0.707107 -0.707107 0
+-1.11022e-16 -1.00000 0
+-0.500000 -0.500000 0
+-0.471405 -0.804738 0
+-0.235702 -0.902369 0
+-0.166667 -0.833333 0
+-0.333333 -0.666667 0
+-0.569036 -0.569036 0
+-0.638071 -0.638071 0
+-0.402369 -0.735702 0
+-1.27108e-16 -0.691942 0
+-0.500000 -0.500000 0
+-1.83697e-16 -1.00000 0
+-0.166667 -0.627961 0
+-0.333333 -0.563981 0
+-0.333333 -0.666667 0
+-0.166667 -0.833333 0
+-1.64834e-16 -0.897314 0
+-1.45971e-16 -0.794628 0
+-0.166667 -0.730647 0
+-1.27108e-16 -0.691942 0
+-1.83697e-16 -1.00000 0
+0.500000 -0.500000 0
+-1.45971e-16 -0.794628 0
+-1.64834e-16 -0.897314 0
+0.166667 -0.833333 0
+0.333333 -0.666667 0
+0.333333 -0.563981 0
+0.166667 -0.627961 0
+0.166667 -0.730647 0
+0.707107 -0.707107 0
+0.500000 -0.500000 0
+-1.11022e-16 -1.00000 0
+0.638071 -0.638071 0
+0.569036 -0.569036 0
+0.333333 -0.666667 0
+0.166667 -0.833333 0
+0.235702 -0.902369 0
+0.471405 -0.804738 0
+0.402369 -0.735702 0
+-0.292893 -0.292893 0
+-0.500000 -0.500000 0
+0.00000 -0.292893 0
+-0.361929 -0.361929 0
+-0.430964 -0.430964 0
+-0.333333 -0.430964 0
+-0.166667 -0.361929 0
+-0.0976311 -0.292893 0
+-0.195262 -0.292893 0
+-0.264298 -0.361929 0
+-1.27108e-16 -0.691942 0
+-5.38036e-17 -0.292893 0
+-0.500000 -0.500000 0
+-1.02673e-16 -0.558926 0
+-7.82383e-17 -0.425909 0
+-0.166667 -0.361929 0
+-0.333333 -0.430964 0
+-0.333333 -0.563981 0
+-0.166667 -0.627961 0
+-0.166667 -0.494945 0
+-1.27108e-16 -0.691942 0
+0.500000 -0.500000 0
+-5.38036e-17 -0.292893 0
+0.166667 -0.627961 0
+0.333333 -0.563981 0
+0.333333 -0.430964 0
+0.166667 -0.361929 0
+-7.82383e-17 -0.425909 0
+-1.02673e-16 -0.558926 0
+0.166667 -0.494945 0
+0.292893 -0.292893 0
+0.00000 -0.292893 0
+0.500000 -0.500000 0
+0.195262 -0.292893 0
+0.0976311 -0.292893 0
+0.166667 -0.361929 0
+0.333333 -0.430964 0
+0.430964 -0.430964 0
+0.361929 -0.361929 0
+0.264298 -0.361929 0
+-0.707107 -0.707107 0
+-0.500000 -0.500000 0
+-1.00000 -1.11022e-16 0
+-0.638071 -0.638071 0
+-0.569036 -0.569036 0
+-0.666667 -0.333333 0
+-0.833333 -0.166667 0
+-0.902369 -0.235702 0
+-0.804738 -0.471405 0
+-0.735702 -0.402369 0
+-0.691942 8.47384e-17 0
+-1.00000 1.22465e-16 0
+-0.500000 -0.500000 0
+-0.794628 9.73138e-17 0
+-0.897314 1.09889e-16 0
+-0.833333 -0.166667 0
+-0.666667 -0.333333 0
+-0.563981 -0.333333 0
+-0.627961 -0.166667 0
+-0.730647 -0.166667 0
+-0.691942 8.47384e-17 0
+-0.500000 -0.500000 0
+-0.292893 3.58691e-17 0
+-0.627961 -0.166667 0
+-0.563981 -0.333333 0
+-0.430964 -0.333333 0
+-0.361929 -0.166667 0
+-0.425909 5.21589e-17 0
+-0.558926 6.84486e-17 0
+-0.494945 -0.166667 0
+-0.292893 -0.292893 0
+-0.292893 0.00000 0
+-0.500000 -0.500000 0
+-0.292893 -0.195262 0
+-0.292893 -0.0976311 0
+-0.361929 -0.166667 0
+-0.430964 -0.333333 0
+-0.430964 -0.430964 0
+-0.361929 -0.361929 0
+-0.361929 -0.264298 0
+-0.707107 0.707107 0
+-1.00000 -1.11022e-16 0
+-0.500000 0.500000 0
+-0.804738 0.471405 0
+-0.902369 0.235702 0
+-0.833333 0.166667 0
+-0.666667 0.333333 0
+-0.569036 0.569036 0
+-0.638071 0.638071 0
+-0.735702 0.402369 0
+-0.691942 8.47384e-17 0
+-0.500000 0.500000 0
+-1.00000 1.22465e-16 0
+-0.627961 0.166667 0
+-0.563981 0.333333 0
+-0.666667 0.333333 0
+-0.833333 0.166667 0
+-0.897314 1.09889e-16 0
+-0.794628 9.73138e-17 0
+-0.730647 0.166667 0
+-0.691942 8.47384e-17 0
+-0.292893 3.58691e-17 0
+-0.500000 0.500000 0
+-0.558926 6.84486e-17 0
+-0.425909 5.21589e-17 0
+-0.361929 0.166667 0
+-0.430964 0.333333 0
+-0.563981 0.333333 0
+-0.627961 0.166667 0
+-0.494945 0.166667 0
+-0.292893 0.292893 0
+-0.500000 0.500000 0
+-0.292893 0.00000 0
+-0.361929 0.361929 0
+-0.430964 0.430964 0
+-0.430964 0.333333 0
+-0.361929 0.166667 0
+-0.292893 0.0976311 0
+-0.292893 0.195262 0
+-0.361929 0.264298 0
+-0.292893 -0.292893 0
+0.00000 -0.292893 0
+-0.292893 0.00000 0
+-0.195262 -0.292893 0
+-0.0976311 -0.292893 0
+-0.0976311 -0.195262 0
+-0.195262 -0.0976311 0
+-0.292893 -0.0976311 0
+-0.292893 -0.195262 0
+-0.195262 -0.195262 0
+0.00000 0.00000 0
+-0.292893 0.00000 0
+0.00000 -0.292893 0
+-0.0976311 0.00000 0
+-0.195262 0.00000 0
+-0.195262 -0.0976311 0
+-0.0976311 -0.195262 0
+0.00000 -0.195262 0
+0.00000 -0.0976311 0
+-0.0976311 -0.0976311 0
+0.00000 0.00000 0
+0.00000 -0.292893 0
+0.292893 0.00000 0
+0.00000 -0.0976311 0
+0.00000 -0.195262 0
+0.0976311 -0.195262 0
+0.195262 -0.0976311 0
+0.195262 0.00000 0
+0.0976311 0.00000 0
+0.0976311 -0.0976311 0
+0.292893 -0.292893 0
+0.292893 0.00000 0
+0.00000 -0.292893 0
+0.292893 -0.195262 0
+0.292893 -0.0976311 0
+0.195262 -0.0976311 0
+0.0976311 -0.195262 0
+0.0976311 -0.292893 0
+0.195262 -0.292893 0
+0.195262 -0.195262 0
+-0.292893 0.292893 0
+-0.292893 0.00000 0
+0.00000 0.292893 0
+-0.292893 0.195262 0
+-0.292893 0.0976311 0
+-0.195262 0.0976311 0
+-0.0976311 0.195262 0
+-0.0976311 0.292893 0
+-0.195262 0.292893 0
+-0.195262 0.195262 0
+0.00000 0.00000 0
+0.00000 0.292893 0
+-0.292893 0.00000 0
+0.00000 0.0976311 0
+0.00000 0.195262 0
+-0.0976311 0.195262 0
+-0.195262 0.0976311 0
+-0.195262 0.00000 0
+-0.0976311 0.00000 0
+-0.0976311 0.0976311 0
+0.00000 0.00000 0
+0.292893 0.00000 0
+0.00000 0.292893 0
+0.0976311 0.00000 0
+0.195262 0.00000 0
+0.195262 0.0976311 0
+0.0976311 0.195262 0
+0.00000 0.195262 0
+0.00000 0.0976311 0
+0.0976311 0.0976311 0
+0.292893 0.292893 0
+0.00000 0.292893 0
+0.292893 0.00000 0
+0.195262 0.292893 0
+0.0976311 0.292893 0
+0.0976311 0.195262 0
+0.195262 0.0976311 0
+0.292893 0.0976311 0
+0.292893 0.195262 0
+0.195262 0.195262 0
+0.707107 -0.707107 0
+1.00000 -1.11022e-16 0
+0.500000 -0.500000 0
+0.804738 -0.471405 0
+0.902369 -0.235702 0
+0.833333 -0.166667 0
+0.666667 -0.333333 0
+0.569036 -0.569036 0
+0.638071 -0.638071 0
+0.735702 -0.402369 0
+0.691942 0.00000 0
+0.500000 -0.500000 0
+1.00000 0.00000 0
+0.627961 -0.166667 0
+0.563981 -0.333333 0
+0.666667 -0.333333 0
+0.833333 -0.166667 0
+0.897314 0.00000 0
+0.794628 0.00000 0
+0.730647 -0.166667 0
+0.691942 0.00000 0
+1.00000 0.00000 0
+0.500000 0.500000 0
+0.794628 0.00000 0
+0.897314 0.00000 0
+0.833333 0.166667 0
+0.666667 0.333333 0
+0.563981 0.333333 0
+0.627961 0.166667 0
+0.730647 0.166667 0
+0.707107 0.707107 0
+0.500000 0.500000 0
+1.00000 -1.11022e-16 0
+0.638071 0.638071 0
+0.569036 0.569036 0
+0.666667 0.333333 0
+0.833333 0.166667 0
+0.902369 0.235702 0
+0.804738 0.471405 0
+0.735702 0.402369 0
+0.292893 -0.292893 0
+0.500000 -0.500000 0
+0.292893 0.00000 0
+0.361929 -0.361929 0
+0.430964 -0.430964 0
+0.430964 -0.333333 0
+0.361929 -0.166667 0
+0.292893 -0.0976311 0
+0.292893 -0.195262 0
+0.361929 -0.264298 0
+0.691942 0.00000 0
+0.292893 0.00000 0
+0.500000 -0.500000 0
+0.558926 0.00000 0
+0.425909 0.00000 0
+0.361929 -0.166667 0
+0.430964 -0.333333 0
+0.563981 -0.333333 0
+0.627961 -0.166667 0
+0.494945 -0.166667 0
+0.691942 0.00000 0
+0.500000 0.500000 0
+0.292893 0.00000 0
+0.627961 0.166667 0
+0.563981 0.333333 0
+0.430964 0.333333 0
+0.361929 0.166667 0
+0.425909 0.00000 0
+0.558926 0.00000 0
+0.494945 0.166667 0
+0.292893 0.292893 0
+0.292893 0.00000 0
+0.500000 0.500000 0
+0.292893 0.195262 0
+0.292893 0.0976311 0
+0.361929 0.166667 0
+0.430964 0.333333 0
+0.430964 0.430964 0
+0.361929 0.361929 0
+0.361929 0.264298 0
+-0.707107 0.707107 0
+-0.500000 0.500000 0
+-1.11022e-16 1.00000 0
+-0.638071 0.638071 0
+-0.569036 0.569036 0
+-0.333333 0.666667 0
+-0.166667 0.833333 0
+-0.235702 0.902369 0
+-0.471405 0.804738 0
+-0.402369 0.735702 0
+4.23692e-17 0.691942 0
+-1.60812e-16 1.00000 0
+-0.500000 0.500000 0
+-2.53579e-17 0.794628 0
+-9.30851e-17 0.897314 0
+-0.166667 0.833333 0
+-0.333333 0.666667 0
+-0.333333 0.563981 0
+-0.166667 0.627961 0
+-0.166667 0.730647 0
+4.23692e-17 0.691942 0
+-0.500000 0.500000 0
+1.79345e-17 0.292893 0
+-0.166667 0.627961 0
+-0.333333 0.563981 0
+-0.333333 0.430964 0
+-0.166667 0.361929 0
+2.60794e-17 0.425909 0
+3.42243e-17 0.558926 0
+-0.166667 0.494945 0
+-0.292893 0.292893 0
+0.00000 0.292893 0
+-0.500000 0.500000 0
+-0.195262 0.292893 0
+-0.0976311 0.292893 0
+-0.166667 0.361929 0
+-0.333333 0.430964 0
+-0.430964 0.430964 0
+-0.361929 0.361929 0
+-0.264298 0.361929 0
+0.707107 0.707107 0
+-1.11022e-16 1.00000 0
+0.500000 0.500000 0
+0.471405 0.804738 0
+0.235702 0.902369 0
+0.166667 0.833333 0
+0.333333 0.666667 0
+0.569036 0.569036 0
+0.638071 0.638071 0
+0.402369 0.735702 0
+4.23692e-17 0.691942 0
+0.500000 0.500000 0
+-1.60812e-16 1.00000 0
+0.166667 0.627961 0
+0.333333 0.563981 0
+0.333333 0.666667 0
+0.166667 0.833333 0
+-9.30851e-17 0.897314 0
+-2.53579e-17 0.794628 0
+0.166667 0.730647 0
+4.23692e-17 0.691942 0
+1.79345e-17 0.292893 0
+0.500000 0.500000 0
+3.42243e-17 0.558926 0
+2.60794e-17 0.425909 0
+0.166667 0.361929 0
+0.333333 0.430964 0
+0.333333 0.563981 0
+0.166667 0.627961 0
+0.166667 0.494945 0
+0.292893 0.292893 0
+0.500000 0.500000 0
+0.00000 0.292893 0
+0.361929 0.361929 0
+0.430964 0.430964 0
+0.333333 0.430964 0
+0.166667 0.361929 0
+0.0976311 0.292893 0
+0.195262 0.292893 0
+0.264298 0.361929 0
+
+CELLS 40 440
+10     0       1       2       3       4       5       6       7       8       9
+10     10      11      12      13      14      15      16      17      18      19
+10     20      21      22      23      24      25      26      27      28      29
+10     30      31      32      33      34      35      36      37      38      39
+10     40      41      42      43      44      45      46      47      48      49
+10     50      51      52      53      54      55      56      57      58      59
+10     60      61      62      63      64      65      66      67      68      69
+10     70      71      72      73      74      75      76      77      78      79
+10     80      81      82      83      84      85      86      87      88      89
+10     90      91      92      93      94      95      96      97      98      99
+10     100     101     102     103     104     105     106     107     108     109
+10     110     111     112     113     114     115     116     117     118     119
+10     120     121     122     123     124     125     126     127     128     129
+10     130     131     132     133     134     135     136     137     138     139
+10     140     141     142     143     144     145     146     147     148     149
+10     150     151     152     153     154     155     156     157     158     159
+10     160     161     162     163     164     165     166     167     168     169
+10     170     171     172     173     174     175     176     177     178     179
+10     180     181     182     183     184     185     186     187     188     189
+10     190     191     192     193     194     195     196     197     198     199
+10     200     201     202     203     204     205     206     207     208     209
+10     210     211     212     213     214     215     216     217     218     219
+10     220     221     222     223     224     225     226     227     228     229
+10     230     231     232     233     234     235     236     237     238     239
+10     240     241     242     243     244     245     246     247     248     249
+10     250     251     252     253     254     255     256     257     258     259
+10     260     261     262     263     264     265     266     267     268     269
+10     270     271     272     273     274     275     276     277     278     279
+10     280     281     282     283     284     285     286     287     288     289
+10     290     291     292     293     294     295     296     297     298     299
+10     300     301     302     303     304     305     306     307     308     309
+10     310     311     312     313     314     315     316     317     318     319
+10     320     321     322     323     324     325     326     327     328     329
+10     330     331     332     333     334     335     336     337     338     339
+10     340     341     342     343     344     345     346     347     348     349
+10     350     351     352     353     354     355     356     357     358     359
+10     360     361     362     363     364     365     366     367     368     369
+10     370     371     372     373     374     375     376     377     378     379
+10     380     381     382     383     384     385     386     387     388     389
+10     390     391     392     393     394     395     396     397     398     399
+
+CELL_TYPES 40
+ 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69
+POINT_DATA 400
+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 
+# vtk DataFile Version 3.0
+#This file was generated 
+ASCII
+DATASET UNSTRUCTURED_GRID
+
+POINTS 400 double
+-0.707107 -0.707107 0
+-1.11022e-16 -1.00000 0
+-0.500000 -0.500000 0
+-0.497298 -0.867250 0
+-0.261596 -0.964881 0
+-0.234792 -0.867627 0
+-0.401458 -0.700960 0
+-0.569036 -0.569036 0
+-0.638071 -0.638071 0
+-0.449378 -0.784105 0
+-1.27108e-16 -0.691942 0
+-0.500000 -0.500000 0
+-1.83697e-16 -1.00000 0
+-0.182397 -0.672677 0
+-0.349063 -0.608696 0
+-0.401458 -0.700960 0
+-0.234792 -0.867627 0
+-1.64834e-16 -0.897314 0
+-1.45971e-16 -0.794628 0
+-0.208594 -0.770152 0
+-1.27108e-16 -0.691942 0
+-1.83697e-16 -1.00000 0
+0.500000 -0.500000 0
+-1.45971e-16 -0.794628 0
+-1.64834e-16 -0.897314 0
+0.234792 -0.867627 0
+0.401458 -0.700960 0
+0.349063 -0.608696 0
+0.182397 -0.672677 0
+0.208594 -0.770152 0
+0.707107 -0.707107 0
+0.500000 -0.500000 0
+-1.11022e-16 -1.00000 0
+0.638071 -0.638071 0
+0.569036 -0.569036 0
+0.401458 -0.700960 0
+0.234792 -0.867627 0
+0.261596 -0.964881 0
+0.497298 -0.867250 0
+0.449378 -0.784105 0
+-0.292893 -0.292893 0
+-0.500000 -0.500000 0
+0.00000 -0.292893 0
+-0.361929 -0.361929 0
+-0.430964 -0.430964 0
+-0.281193 -0.489181 0
+-0.114526 -0.420145 0
+-0.0976311 -0.292893 0
+-0.195262 -0.292893 0
+-0.238227 -0.391037 0
+-1.27108e-16 -0.691942 0
+-5.38036e-17 -0.292893 0
+-0.500000 -0.500000 0
+-1.02673e-16 -0.558926 0
+-7.82383e-17 -0.425909 0
+-0.114526 -0.420145 0
+-0.281193 -0.489181 0
+-0.349063 -0.608696 0
+-0.182397 -0.672677 0
+-0.148461 -0.546411 0
+-1.27108e-16 -0.691942 0
+0.500000 -0.500000 0
+-5.38036e-17 -0.292893 0
+0.182397 -0.672677 0
+0.349063 -0.608696 0
+0.281193 -0.489181 0
+0.114526 -0.420145 0
+-7.82383e-17 -0.425909 0
+-1.02673e-16 -0.558926 0
+0.148461 -0.546411 0
+0.292893 -0.292893 0
+0.00000 -0.292893 0
+0.500000 -0.500000 0
+0.195262 -0.292893 0
+0.0976311 -0.292893 0
+0.114526 -0.420145 0
+0.281193 -0.489181 0
+0.430964 -0.430964 0
+0.361929 -0.361929 0
+0.238227 -0.391037 0
+-0.707107 -0.707107 0
+-0.500000 -0.500000 0
+-1.00000 -1.11022e-16 0
+-0.638071 -0.638071 0
+-0.569036 -0.569036 0
+-0.700960 -0.401458 0
+-0.867627 -0.234792 0
+-0.964881 -0.261596 0
+-0.867250 -0.497298 0
+-0.784105 -0.449378 0
+-0.691942 8.47384e-17 0
+-1.00000 1.22465e-16 0
+-0.500000 -0.500000 0
+-0.794628 9.73138e-17 0
+-0.897314 1.09889e-16 0
+-0.867627 -0.234792 0
+-0.700960 -0.401458 0
+-0.608696 -0.349063 0
+-0.672677 -0.182397 0
+-0.770152 -0.208594 0
+-0.691942 8.47384e-17 0
+-0.500000 -0.500000 0
+-0.292893 3.58691e-17 0
+-0.672677 -0.182397 0
+-0.608696 -0.349063 0
+-0.489181 -0.281193 0
+-0.420145 -0.114526 0
+-0.425909 5.21589e-17 0
+-0.558926 6.84486e-17 0
+-0.546411 -0.148461 0
+-0.292893 -0.292893 0
+-0.292893 0.00000 0
+-0.500000 -0.500000 0
+-0.292893 -0.195262 0
+-0.292893 -0.0976311 0
+-0.420145 -0.114526 0
+-0.489181 -0.281193 0
+-0.430964 -0.430964 0
+-0.361929 -0.361929 0
+-0.391037 -0.238227 0
+-0.707107 0.707107 0
+-1.00000 -1.11022e-16 0
+-0.500000 0.500000 0
+-0.867250 0.497298 0
+-0.964881 0.261596 0
+-0.867627 0.234792 0
+-0.700960 0.401458 0
+-0.569036 0.569036 0
+-0.638071 0.638071 0
+-0.784105 0.449378 0
+-0.691942 8.47384e-17 0
+-0.500000 0.500000 0
+-1.00000 1.22465e-16 0
+-0.672677 0.182397 0
+-0.608696 0.349063 0
+-0.700960 0.401458 0
+-0.867627 0.234792 0
+-0.897314 1.09889e-16 0
+-0.794628 9.73138e-17 0
+-0.770152 0.208594 0
+-0.691942 8.47384e-17 0
+-0.292893 3.58691e-17 0
+-0.500000 0.500000 0
+-0.558926 6.84486e-17 0
+-0.425909 5.21589e-17 0
+-0.420145 0.114526 0
+-0.489181 0.281193 0
+-0.608696 0.349063 0
+-0.672677 0.182397 0
+-0.546411 0.148461 0
+-0.292893 0.292893 0
+-0.500000 0.500000 0
+-0.292893 0.00000 0
+-0.361929 0.361929 0
+-0.430964 0.430964 0
+-0.489181 0.281193 0
+-0.420145 0.114526 0
+-0.292893 0.0976311 0
+-0.292893 0.195262 0
+-0.391037 0.238227 0
+-0.292893 -0.292893 0
+0.00000 -0.292893 0
+-0.292893 0.00000 0
+-0.195262 -0.292893 0
+-0.0976311 -0.292893 0
+-0.0976311 -0.195262 0
+-0.195262 -0.0976311 0
+-0.292893 -0.0976311 0
+-0.292893 -0.195262 0
+-0.195262 -0.195262 0
+0.00000 0.00000 0
+-0.292893 0.00000 0
+0.00000 -0.292893 0
+-0.0976311 0.00000 0
+-0.195262 0.00000 0
+-0.195262 -0.0976311 0
+-0.0976311 -0.195262 0
+0.00000 -0.195262 0
+0.00000 -0.0976311 0
+-0.0976311 -0.0976311 0
+0.00000 0.00000 0
+0.00000 -0.292893 0
+0.292893 0.00000 0
+0.00000 -0.0976311 0
+0.00000 -0.195262 0
+0.0976311 -0.195262 0
+0.195262 -0.0976311 0
+0.195262 0.00000 0
+0.0976311 0.00000 0
+0.0976311 -0.0976311 0
+0.292893 -0.292893 0
+0.292893 0.00000 0
+0.00000 -0.292893 0
+0.292893 -0.195262 0
+0.292893 -0.0976311 0
+0.195262 -0.0976311 0
+0.0976311 -0.195262 0
+0.0976311 -0.292893 0
+0.195262 -0.292893 0
+0.195262 -0.195262 0
+-0.292893 0.292893 0
+-0.292893 0.00000 0
+0.00000 0.292893 0
+-0.292893 0.195262 0
+-0.292893 0.0976311 0
+-0.195262 0.0976311 0
+-0.0976311 0.195262 0
+-0.0976311 0.292893 0
+-0.195262 0.292893 0
+-0.195262 0.195262 0
+0.00000 0.00000 0
+0.00000 0.292893 0
+-0.292893 0.00000 0
+0.00000 0.0976311 0
+0.00000 0.195262 0
+-0.0976311 0.195262 0
+-0.195262 0.0976311 0
+-0.195262 0.00000 0
+-0.0976311 0.00000 0
+-0.0976311 0.0976311 0
+0.00000 0.00000 0
+0.292893 0.00000 0
+0.00000 0.292893 0
+0.0976311 0.00000 0
+0.195262 0.00000 0
+0.195262 0.0976311 0
+0.0976311 0.195262 0
+0.00000 0.195262 0
+0.00000 0.0976311 0
+0.0976311 0.0976311 0
+0.292893 0.292893 0
+0.00000 0.292893 0
+0.292893 0.00000 0
+0.195262 0.292893 0
+0.0976311 0.292893 0
+0.0976311 0.195262 0
+0.195262 0.0976311 0
+0.292893 0.0976311 0
+0.292893 0.195262 0
+0.195262 0.195262 0
+0.707107 -0.707107 0
+1.00000 -1.11022e-16 0
+0.500000 -0.500000 0
+0.867250 -0.497298 0
+0.964881 -0.261596 0
+0.867627 -0.234792 0
+0.700960 -0.401458 0
+0.569036 -0.569036 0
+0.638071 -0.638071 0
+0.784105 -0.449378 0
+0.691942 0.00000 0
+0.500000 -0.500000 0
+1.00000 0.00000 0
+0.672677 -0.182397 0
+0.608696 -0.349063 0
+0.700960 -0.401458 0
+0.867627 -0.234792 0
+0.897314 0.00000 0
+0.794628 0.00000 0
+0.770152 -0.208594 0
+0.691942 0.00000 0
+1.00000 0.00000 0
+0.500000 0.500000 0
+0.794628 0.00000 0
+0.897314 0.00000 0
+0.867627 0.234792 0
+0.700960 0.401458 0
+0.608696 0.349063 0
+0.672677 0.182397 0
+0.770152 0.208594 0
+0.707107 0.707107 0
+0.500000 0.500000 0
+1.00000 -1.11022e-16 0
+0.638071 0.638071 0
+0.569036 0.569036 0
+0.700960 0.401458 0
+0.867627 0.234792 0
+0.964881 0.261596 0
+0.867250 0.497298 0
+0.784105 0.449378 0
+0.292893 -0.292893 0
+0.500000 -0.500000 0
+0.292893 0.00000 0
+0.361929 -0.361929 0
+0.430964 -0.430964 0
+0.489181 -0.281193 0
+0.420145 -0.114526 0
+0.292893 -0.0976311 0
+0.292893 -0.195262 0
+0.391037 -0.238227 0
+0.691942 0.00000 0
+0.292893 0.00000 0
+0.500000 -0.500000 0
+0.558926 0.00000 0
+0.425909 0.00000 0
+0.420145 -0.114526 0
+0.489181 -0.281193 0
+0.608696 -0.349063 0
+0.672677 -0.182397 0
+0.546411 -0.148461 0
+0.691942 0.00000 0
+0.500000 0.500000 0
+0.292893 0.00000 0
+0.672677 0.182397 0
+0.608696 0.349063 0
+0.489181 0.281193 0
+0.420145 0.114526 0
+0.425909 0.00000 0
+0.558926 0.00000 0
+0.546411 0.148461 0
+0.292893 0.292893 0
+0.292893 0.00000 0
+0.500000 0.500000 0
+0.292893 0.195262 0
+0.292893 0.0976311 0
+0.420145 0.114526 0
+0.489181 0.281193 0
+0.430964 0.430964 0
+0.361929 0.361929 0
+0.391037 0.238227 0
+-0.707107 0.707107 0
+-0.500000 0.500000 0
+-1.11022e-16 1.00000 0
+-0.638071 0.638071 0
+-0.569036 0.569036 0
+-0.401458 0.700960 0
+-0.234792 0.867627 0
+-0.261596 0.964881 0
+-0.497298 0.867250 0
+-0.449378 0.784105 0
+4.23692e-17 0.691942 0
+-1.60812e-16 1.00000 0
+-0.500000 0.500000 0
+7.33285e-17 0.794628 0
+5.60139e-18 0.897314 0
+-0.234792 0.867627 0
+-0.401458 0.700960 0
+-0.349063 0.608696 0
+-0.182397 0.672677 0
+-0.208594 0.770152 0
+4.23692e-17 0.691942 0
+-0.500000 0.500000 0
+1.79345e-17 0.292893 0
+-0.182397 0.672677 0
+-0.349063 0.608696 0
+-0.281193 0.489181 0
+-0.114526 0.420145 0
+2.60794e-17 0.425909 0
+3.42243e-17 0.558926 0
+-0.148461 0.546411 0
+-0.292893 0.292893 0
+0.00000 0.292893 0
+-0.500000 0.500000 0
+-0.195262 0.292893 0
+-0.0976311 0.292893 0
+-0.114526 0.420145 0
+-0.281193 0.489181 0
+-0.430964 0.430964 0
+-0.361929 0.361929 0
+-0.238227 0.391037 0
+0.707107 0.707107 0
+-1.11022e-16 1.00000 0
+0.500000 0.500000 0
+0.497298 0.867250 0
+0.261596 0.964881 0
+0.234792 0.867627 0
+0.401458 0.700960 0
+0.569036 0.569036 0
+0.638071 0.638071 0
+0.449378 0.784105 0
+4.23692e-17 0.691942 0
+0.500000 0.500000 0
+-1.60812e-16 1.00000 0
+0.182397 0.672677 0
+0.349063 0.608696 0
+0.401458 0.700960 0
+0.234792 0.867627 0
+5.60139e-18 0.897314 0
+7.33285e-17 0.794628 0
+0.208594 0.770152 0
+4.23692e-17 0.691942 0
+1.79345e-17 0.292893 0
+0.500000 0.500000 0
+3.42243e-17 0.558926 0
+2.60794e-17 0.425909 0
+0.114526 0.420145 0
+0.281193 0.489181 0
+0.349063 0.608696 0
+0.182397 0.672677 0
+0.148461 0.546411 0
+0.292893 0.292893 0
+0.500000 0.500000 0
+0.00000 0.292893 0
+0.361929 0.361929 0
+0.430964 0.430964 0
+0.281193 0.489181 0
+0.114526 0.420145 0
+0.0976311 0.292893 0
+0.195262 0.292893 0
+0.238227 0.391037 0
+
+CELLS 40 440
+10     0       1       2       3       4       5       6       7       8       9
+10     10      11      12      13      14      15      16      17      18      19
+10     20      21      22      23      24      25      26      27      28      29
+10     30      31      32      33      34      35      36      37      38      39
+10     40      41      42      43      44      45      46      47      48      49
+10     50      51      52      53      54      55      56      57      58      59
+10     60      61      62      63      64      65      66      67      68      69
+10     70      71      72      73      74      75      76      77      78      79
+10     80      81      82      83      84      85      86      87      88      89
+10     90      91      92      93      94      95      96      97      98      99
+10     100     101     102     103     104     105     106     107     108     109
+10     110     111     112     113     114     115     116     117     118     119
+10     120     121     122     123     124     125     126     127     128     129
+10     130     131     132     133     134     135     136     137     138     139
+10     140     141     142     143     144     145     146     147     148     149
+10     150     151     152     153     154     155     156     157     158     159
+10     160     161     162     163     164     165     166     167     168     169
+10     170     171     172     173     174     175     176     177     178     179
+10     180     181     182     183     184     185     186     187     188     189
+10     190     191     192     193     194     195     196     197     198     199
+10     200     201     202     203     204     205     206     207     208     209
+10     210     211     212     213     214     215     216     217     218     219
+10     220     221     222     223     224     225     226     227     228     229
+10     230     231     232     233     234     235     236     237     238     239
+10     240     241     242     243     244     245     246     247     248     249
+10     250     251     252     253     254     255     256     257     258     259
+10     260     261     262     263     264     265     266     267     268     269
+10     270     271     272     273     274     275     276     277     278     279
+10     280     281     282     283     284     285     286     287     288     289
+10     290     291     292     293     294     295     296     297     298     299
+10     300     301     302     303     304     305     306     307     308     309
+10     310     311     312     313     314     315     316     317     318     319
+10     320     321     322     323     324     325     326     327     328     329
+10     330     331     332     333     334     335     336     337     338     339
+10     340     341     342     343     344     345     346     347     348     349
+10     350     351     352     353     354     355     356     357     358     359
+10     360     361     362     363     364     365     366     367     368     369
+10     370     371     372     373     374     375     376     377     378     379
+10     380     381     382     383     384     385     386     387     388     389
+10     390     391     392     393     394     395     396     397     398     399
+
+CELL_TYPES 40
+ 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69
+POINT_DATA 400
+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 
+# vtk DataFile Version 3.0
+#This file was generated 
+ASCII
+DATASET UNSTRUCTURED_GRID
+
+POINTS 400 double
+-0.707107 -0.707107 0
+-1.11022e-16 -1.00000 0
+-0.500000 -0.500000 0
+-0.500000 -0.866025 0
+-0.258819 -0.965926 0
+-0.233550 -0.871621 0
+-0.402369 -0.696923 0
+-0.569036 -0.569036 0
+-0.638071 -0.638071 0
+-0.451184 -0.781474 0
+-1.27108e-16 -0.691942 0
+-0.500000 -0.500000 0
+-1.83697e-16 -1.00000 0
+-0.180396 -0.673247 0
+-0.351026 -0.607995 0
+-0.402369 -0.696923 0
+-0.233550 -0.871621 0
+-1.64834e-16 -0.897314 0
+-1.45971e-16 -0.794628 0
+-0.206973 -0.772434 0
+-1.27108e-16 -0.691942 0
+-1.83697e-16 -1.00000 0
+0.500000 -0.500000 0
+-1.45971e-16 -0.794628 0
+-1.64834e-16 -0.897314 0
+0.233550 -0.871621 0
+0.402369 -0.696923 0
+0.351026 -0.607995 0
+0.180396 -0.673247 0
+0.206973 -0.772434 0
+0.707107 -0.707107 0
+0.500000 -0.500000 0
+-1.11022e-16 -1.00000 0
+0.638071 -0.638071 0
+0.569036 -0.569036 0
+0.402369 -0.696923 0
+0.233550 -0.871621 0
+0.258819 -0.965926 0
+0.500000 -0.866025 0
+0.451184 -0.781474 0
+-0.292893 -0.292893 0
+-0.500000 -0.500000 0
+0.00000 -0.292893 0
+-0.361929 -0.361929 0
+-0.430964 -0.430964 0
+-0.284518 -0.492799 0
+-0.111542 -0.416280 0
+-0.0976311 -0.292893 0
+-0.195262 -0.292893 0
+-0.235702 -0.408248 0
+-1.27108e-16 -0.691942 0
+-5.38036e-17 -0.292893 0
+-0.500000 -0.500000 0
+-1.02673e-16 -0.558926 0
+-7.82383e-17 -0.425909 0
+-0.111542 -0.416280 0
+-0.284518 -0.492799 0
+-0.351026 -0.607995 0
+-0.180396 -0.673247 0
+-0.145969 -0.544763 0
+-1.27108e-16 -0.691942 0
+0.500000 -0.500000 0
+-5.38036e-17 -0.292893 0
+0.180396 -0.673247 0
+0.351026 -0.607995 0
+0.284518 -0.492799 0
+0.111542 -0.416280 0
+-7.82383e-17 -0.425909 0
+-1.02673e-16 -0.558926 0
+0.145969 -0.544763 0
+0.292893 -0.292893 0
+0.00000 -0.292893 0
+0.500000 -0.500000 0
+0.195262 -0.292893 0
+0.0976311 -0.292893 0
+0.111542 -0.416280 0
+0.284518 -0.492799 0
+0.430964 -0.430964 0
+0.361929 -0.361929 0
+0.235702 -0.408248 0
+-0.707107 -0.707107 0
+-0.500000 -0.500000 0
+-1.00000 -1.11022e-16 0
+-0.638071 -0.638071 0
+-0.569036 -0.569036 0
+-0.696923 -0.402369 0
+-0.871621 -0.233550 0
+-0.965926 -0.258819 0
+-0.866025 -0.500000 0
+-0.781474 -0.451184 0
+-0.691942 8.47384e-17 0
+-1.00000 1.22465e-16 0
+-0.500000 -0.500000 0
+-0.794628 9.73138e-17 0
+-0.897314 1.09889e-16 0
+-0.871621 -0.233550 0
+-0.696923 -0.402369 0
+-0.607995 -0.351026 0
+-0.673247 -0.180396 0
+-0.772434 -0.206973 0
+-0.691942 8.47384e-17 0
+-0.500000 -0.500000 0
+-0.292893 3.58691e-17 0
+-0.673247 -0.180396 0
+-0.607995 -0.351026 0
+-0.492799 -0.284518 0
+-0.416280 -0.111542 0
+-0.425909 5.21589e-17 0
+-0.558926 6.84486e-17 0
+-0.544763 -0.145969 0
+-0.292893 -0.292893 0
+-0.292893 0.00000 0
+-0.500000 -0.500000 0
+-0.292893 -0.195262 0
+-0.292893 -0.0976311 0
+-0.416280 -0.111542 0
+-0.492799 -0.284518 0
+-0.430964 -0.430964 0
+-0.361929 -0.361929 0
+-0.408248 -0.235702 0
+-0.707107 0.707107 0
+-1.00000 -1.11022e-16 0
+-0.500000 0.500000 0
+-0.866025 0.500000 0
+-0.965926 0.258819 0
+-0.871621 0.233550 0
+-0.696923 0.402369 0
+-0.569036 0.569036 0
+-0.638071 0.638071 0
+-0.781474 0.451184 0
+-0.691942 8.47384e-17 0
+-0.500000 0.500000 0
+-1.00000 1.22465e-16 0
+-0.673247 0.180396 0
+-0.607995 0.351026 0
+-0.696923 0.402369 0
+-0.871621 0.233550 0
+-0.897314 1.09889e-16 0
+-0.794628 9.73138e-17 0
+-0.772434 0.206973 0
+-0.691942 8.47384e-17 0
+-0.292893 3.58691e-17 0
+-0.500000 0.500000 0
+-0.558926 6.84486e-17 0
+-0.425909 5.21589e-17 0
+-0.416280 0.111542 0
+-0.492799 0.284518 0
+-0.607995 0.351026 0
+-0.673247 0.180396 0
+-0.544763 0.145969 0
+-0.292893 0.292893 0
+-0.500000 0.500000 0
+-0.292893 0.00000 0
+-0.361929 0.361929 0
+-0.430964 0.430964 0
+-0.492799 0.284518 0
+-0.416280 0.111542 0
+-0.292893 0.0976311 0
+-0.292893 0.195262 0
+-0.408248 0.235702 0
+-0.292893 -0.292893 0
+0.00000 -0.292893 0
+-0.292893 0.00000 0
+-0.195262 -0.292893 0
+-0.0976311 -0.292893 0
+-0.0976311 -0.195262 0
+-0.195262 -0.0976311 0
+-0.292893 -0.0976311 0
+-0.292893 -0.195262 0
+-0.195262 -0.195262 0
+0.00000 0.00000 0
+-0.292893 0.00000 0
+0.00000 -0.292893 0
+-0.0976311 0.00000 0
+-0.195262 0.00000 0
+-0.195262 -0.0976311 0
+-0.0976311 -0.195262 0
+0.00000 -0.195262 0
+0.00000 -0.0976311 0
+-0.0976311 -0.0976311 0
+0.00000 0.00000 0
+0.00000 -0.292893 0
+0.292893 0.00000 0
+0.00000 -0.0976311 0
+0.00000 -0.195262 0
+0.0976311 -0.195262 0
+0.195262 -0.0976311 0
+0.195262 0.00000 0
+0.0976311 0.00000 0
+0.0976311 -0.0976311 0
+0.292893 -0.292893 0
+0.292893 0.00000 0
+0.00000 -0.292893 0
+0.292893 -0.195262 0
+0.292893 -0.0976311 0
+0.195262 -0.0976311 0
+0.0976311 -0.195262 0
+0.0976311 -0.292893 0
+0.195262 -0.292893 0
+0.195262 -0.195262 0
+-0.292893 0.292893 0
+-0.292893 0.00000 0
+0.00000 0.292893 0
+-0.292893 0.195262 0
+-0.292893 0.0976311 0
+-0.195262 0.0976311 0
+-0.0976311 0.195262 0
+-0.0976311 0.292893 0
+-0.195262 0.292893 0
+-0.195262 0.195262 0
+0.00000 0.00000 0
+0.00000 0.292893 0
+-0.292893 0.00000 0
+0.00000 0.0976311 0
+0.00000 0.195262 0
+-0.0976311 0.195262 0
+-0.195262 0.0976311 0
+-0.195262 0.00000 0
+-0.0976311 0.00000 0
+-0.0976311 0.0976311 0
+0.00000 0.00000 0
+0.292893 0.00000 0
+0.00000 0.292893 0
+0.0976311 0.00000 0
+0.195262 0.00000 0
+0.195262 0.0976311 0
+0.0976311 0.195262 0
+0.00000 0.195262 0
+0.00000 0.0976311 0
+0.0976311 0.0976311 0
+0.292893 0.292893 0
+0.00000 0.292893 0
+0.292893 0.00000 0
+0.195262 0.292893 0
+0.0976311 0.292893 0
+0.0976311 0.195262 0
+0.195262 0.0976311 0
+0.292893 0.0976311 0
+0.292893 0.195262 0
+0.195262 0.195262 0
+0.707107 -0.707107 0
+1.00000 -1.11022e-16 0
+0.500000 -0.500000 0
+0.866025 -0.500000 0
+0.965926 -0.258819 0
+0.871621 -0.233550 0
+0.696923 -0.402369 0
+0.569036 -0.569036 0
+0.638071 -0.638071 0
+0.781474 -0.451184 0
+0.691942 0.00000 0
+0.500000 -0.500000 0
+1.00000 0.00000 0
+0.673247 -0.180396 0
+0.607995 -0.351026 0
+0.696923 -0.402369 0
+0.871621 -0.233550 0
+0.897314 0.00000 0
+0.794628 0.00000 0
+0.772434 -0.206973 0
+0.691942 0.00000 0
+1.00000 0.00000 0
+0.500000 0.500000 0
+0.794628 0.00000 0
+0.897314 0.00000 0
+0.871621 0.233550 0
+0.696923 0.402369 0
+0.607995 0.351026 0
+0.673247 0.180396 0
+0.772434 0.206973 0
+0.707107 0.707107 0
+0.500000 0.500000 0
+1.00000 -1.11022e-16 0
+0.638071 0.638071 0
+0.569036 0.569036 0
+0.696923 0.402369 0
+0.871621 0.233550 0
+0.965926 0.258819 0
+0.866025 0.500000 0
+0.781474 0.451184 0
+0.292893 -0.292893 0
+0.500000 -0.500000 0
+0.292893 0.00000 0
+0.361929 -0.361929 0
+0.430964 -0.430964 0
+0.492799 -0.284518 0
+0.416280 -0.111542 0
+0.292893 -0.0976311 0
+0.292893 -0.195262 0
+0.408248 -0.235702 0
+0.691942 0.00000 0
+0.292893 0.00000 0
+0.500000 -0.500000 0
+0.558926 0.00000 0
+0.425909 0.00000 0
+0.416280 -0.111542 0
+0.492799 -0.284518 0
+0.607995 -0.351026 0
+0.673247 -0.180396 0
+0.544763 -0.145969 0
+0.691942 0.00000 0
+0.500000 0.500000 0
+0.292893 0.00000 0
+0.673247 0.180396 0
+0.607995 0.351026 0
+0.492799 0.284518 0
+0.416280 0.111542 0
+0.425909 0.00000 0
+0.558926 0.00000 0
+0.544763 0.145969 0
+0.292893 0.292893 0
+0.292893 0.00000 0
+0.500000 0.500000 0
+0.292893 0.195262 0
+0.292893 0.0976311 0
+0.416280 0.111542 0
+0.492799 0.284518 0
+0.430964 0.430964 0
+0.361929 0.361929 0
+0.408248 0.235702 0
+-0.707107 0.707107 0
+-0.500000 0.500000 0
+-1.11022e-16 1.00000 0
+-0.638071 0.638071 0
+-0.569036 0.569036 0
+-0.402369 0.696923 0
+-0.233550 0.871621 0
+-0.258819 0.965926 0
+-0.500000 0.866025 0
+-0.451184 0.781474 0
+4.23692e-17 0.691942 0
+-1.60812e-16 1.00000 0
+-0.500000 0.500000 0
+-1.27786e-16 0.794628 0
+-1.44299e-16 0.897314 0
+-0.233550 0.871621 0
+-0.402369 0.696923 0
+-0.351026 0.607995 0
+-0.180396 0.673247 0
+-0.206973 0.772434 0
+4.23692e-17 0.691942 0
+-0.500000 0.500000 0
+1.79345e-17 0.292893 0
+-0.180396 0.673247 0
+-0.351026 0.607995 0
+-0.284518 0.492799 0
+-0.111542 0.416280 0
+2.60794e-17 0.425909 0
+3.42243e-17 0.558926 0
+-0.145969 0.544763 0
+-0.292893 0.292893 0
+0.00000 0.292893 0
+-0.500000 0.500000 0
+-0.195262 0.292893 0
+-0.0976311 0.292893 0
+-0.111542 0.416280 0
+-0.284518 0.492799 0
+-0.430964 0.430964 0
+-0.361929 0.361929 0
+-0.235702 0.408248 0
+0.707107 0.707107 0
+-1.11022e-16 1.00000 0
+0.500000 0.500000 0
+0.500000 0.866025 0
+0.258819 0.965926 0
+0.233550 0.871621 0
+0.402369 0.696923 0
+0.569036 0.569036 0
+0.638071 0.638071 0
+0.451184 0.781474 0
+4.23692e-17 0.691942 0
+0.500000 0.500000 0
+-1.60812e-16 1.00000 0
+0.180396 0.673247 0
+0.351026 0.607995 0
+0.402369 0.696923 0
+0.233550 0.871621 0
+-1.44299e-16 0.897314 0
+-1.27786e-16 0.794628 0
+0.206973 0.772434 0
+4.23692e-17 0.691942 0
+1.79345e-17 0.292893 0
+0.500000 0.500000 0
+3.42243e-17 0.558926 0
+2.60794e-17 0.425909 0
+0.111542 0.416280 0
+0.284518 0.492799 0
+0.351026 0.607995 0
+0.180396 0.673247 0
+0.145969 0.544763 0
+0.292893 0.292893 0
+0.500000 0.500000 0
+0.00000 0.292893 0
+0.361929 0.361929 0
+0.430964 0.430964 0
+0.284518 0.492799 0
+0.111542 0.416280 0
+0.0976311 0.292893 0
+0.195262 0.292893 0
+0.235702 0.408248 0
+
+CELLS 40 440
+10     0       1       2       3       4       5       6       7       8       9
+10     10      11      12      13      14      15      16      17      18      19
+10     20      21      22      23      24      25      26      27      28      29
+10     30      31      32      33      34      35      36      37      38      39
+10     40      41      42      43      44      45      46      47      48      49
+10     50      51      52      53      54      55      56      57      58      59
+10     60      61      62      63      64      65      66      67      68      69
+10     70      71      72      73      74      75      76      77      78      79
+10     80      81      82      83      84      85      86      87      88      89
+10     90      91      92      93      94      95      96      97      98      99
+10     100     101     102     103     104     105     106     107     108     109
+10     110     111     112     113     114     115     116     117     118     119
+10     120     121     122     123     124     125     126     127     128     129
+10     130     131     132     133     134     135     136     137     138     139
+10     140     141     142     143     144     145     146     147     148     149
+10     150     151     152     153     154     155     156     157     158     159
+10     160     161     162     163     164     165     166     167     168     169
+10     170     171     172     173     174     175     176     177     178     179
+10     180     181     182     183     184     185     186     187     188     189
+10     190     191     192     193     194     195     196     197     198     199
+10     200     201     202     203     204     205     206     207     208     209
+10     210     211     212     213     214     215     216     217     218     219
+10     220     221     222     223     224     225     226     227     228     229
+10     230     231     232     233     234     235     236     237     238     239
+10     240     241     242     243     244     245     246     247     248     249
+10     250     251     252     253     254     255     256     257     258     259
+10     260     261     262     263     264     265     266     267     268     269
+10     270     271     272     273     274     275     276     277     278     279
+10     280     281     282     283     284     285     286     287     288     289
+10     290     291     292     293     294     295     296     297     298     299
+10     300     301     302     303     304     305     306     307     308     309
+10     310     311     312     313     314     315     316     317     318     319
+10     320     321     322     323     324     325     326     327     328     329
+10     330     331     332     333     334     335     336     337     338     339
+10     340     341     342     343     344     345     346     347     348     349
+10     350     351     352     353     354     355     356     357     358     359
+10     360     361     362     363     364     365     366     367     368     369
+10     370     371     372     373     374     375     376     377     378     379
+10     380     381     382     383     384     385     386     387     388     389
+10     390     391     392     393     394     395     396     397     398     399
+
+CELL_TYPES 40
+ 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69 69
+POINT_DATA 400
+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 

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.