]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Make output cells, faces and co-faces optional in GridOut::write_vtk 8902/head
authorPeter Munch <peterrmuench@gmail.com>
Fri, 11 Oct 2019 20:46:38 +0000 (22:46 +0200)
committerPeter Munch <peterrmuench@gmail.com>
Tue, 22 Oct 2019 07:22:51 +0000 (09:22 +0200)
doc/news/changes/minor/20191011PeterMunch [new file with mode: 0644]
include/deal.II/grid/grid_out.h
source/grid/grid_out.cc
tests/grid/grid_out_vtk_03.cc [new file with mode: 0644]
tests/grid/grid_out_vtk_03.output [new file with mode: 0644]

diff --git a/doc/news/changes/minor/20191011PeterMunch b/doc/news/changes/minor/20191011PeterMunch
new file mode 100644 (file)
index 0000000..c2af4e6
--- /dev/null
@@ -0,0 +1,4 @@
+Improved: Make the output of cells, faces and co-faces optional in
+GridOut::write_vtk.
+<br>
+(Peter Munch, Niklas Fehn, 2019/10/11)
index aec8819a12fb8a8c16daa296533c9d0ed9bb7f88..b05c7e57f73685f82e37b324c3577dc90888783c 100644 (file)
@@ -865,7 +865,33 @@ namespace GridOutFlags
    * @ingroup output
    */
   struct Vtk : public DataOutBase::VtkFlags
-  {};
+  {
+    /**
+     * Default constructor.
+     */
+    Vtk(const bool output_cells    = true,
+        const bool output_faces    = true,
+        const bool output_co_faces = true)
+      : output_cells(output_cells)
+      , output_faces(output_faces)
+      , output_co_faces(output_co_faces)
+    {}
+
+    /**
+     * Output cells.
+     */
+    bool output_cells;
+
+    /**
+     * Output faces.
+     */
+    bool output_faces;
+
+    /**
+     * Output co-faces/edges.
+     */
+    bool output_co_faces;
+  };
 
 
   /**
index f5fa52003ed5d5a5d206d629259c81ba6d787b7e..96c063561201fd8da738c68da343b81b99ea4d65 100644 (file)
@@ -3050,8 +3050,16 @@ GridOut::write_vtk(const Triangulation<dim, spacedim> &tria,
   const auto faces    = relevant_faces(tria);
   const auto co_faces = relevant_co_faces(tria);
 
+  AssertThrow(
+    vtk_flags.output_cells || (dim > 2 && vtk_flags.output_faces) ||
+      (dim > 3 && vtk_flags.output_co_faces),
+    ExcMessage(
+      "At least one of the flags (output_cells, output_faces, output_co_faces) has to be enabled!"));
+
   // Write cells preamble
-  const int n_cells = tria.n_active_cells() + faces.size() + co_faces.size();
+  const int n_cells = (vtk_flags.output_cells ? tria.n_active_cells() : 0) +
+                      (vtk_flags.output_faces ? faces.size() : 0) +
+                      (vtk_flags.output_co_faces ? co_faces.size() : 0);
 
   // VTK now expects a number telling the total storage requirement to read all
   // cell connectivity information. The connectivity information is read cell by
@@ -3060,10 +3068,16 @@ GridOut::write_vtk(const Triangulation<dim, spacedim> &tria,
   // deal.II object type, we always need n_vertices + 1 integer per cell.
   // Compute the total number here.
   const int cells_size =
-    tria.n_active_cells() * (GeometryInfo<dim>::vertices_per_cell + 1) +
-    faces.size() * (GeometryInfo<dim>::vertices_per_face + 1) +
-    co_faces.size() * (3); // only in 3d, otherwise it is always zero.
+    (vtk_flags.output_cells ?
+       tria.n_active_cells() * (GeometryInfo<dim>::vertices_per_cell + 1) :
+       0) +
+    (vtk_flags.output_faces ?
+       faces.size() * (GeometryInfo<dim>::vertices_per_face + 1) :
+       0) +
+    (vtk_flags.output_co_faces ? co_faces.size() * (3) :
+                                 0); // only in 3d, otherwise it is always zero.
 
+  AssertThrow(cells_size > 0, ExcMessage("No cells given to be output!"));
 
   out << "\nCELLS " << n_cells << ' ' << cells_size << '\n';
   /*
@@ -3080,101 +3094,132 @@ GridOut::write_vtk(const Triangulation<dim, spacedim> &tria,
   const int co_face_type = (dim == 1 ? -1 : dim == 2 ? -1 : 3);
 
   // write cells.
-  for (const auto &cell : tria.active_cell_iterators())
+  if (vtk_flags.output_cells)
+    for (const auto &cell : tria.active_cell_iterators())
+      {
+        out << GeometryInfo<dim>::vertices_per_cell;
+        for (unsigned int i = 0; i < GeometryInfo<dim>::vertices_per_cell; ++i)
+          {
+            out << ' ' << cell->vertex_index(GeometryInfo<dim>::ucd_to_deal[i]);
+          }
+        out << '\n';
+      }
+  if (vtk_flags.output_faces)
+    for (const auto &face : faces)
+      {
+        out << GeometryInfo<dim>::vertices_per_face;
+        for (unsigned int i = 0; i < GeometryInfo<dim>::vertices_per_face; ++i)
+          {
+            out << ' '
+                << face->vertex_index(GeometryInfo < (dim > 1) ?
+                                        dim - 1 :
+                                        dim > ::ucd_to_deal[i]);
+          }
+        out << '\n';
+      }
+  if (vtk_flags.output_co_faces)
+    for (const auto &co_face : co_faces)
+      {
+        out << 2;
+        for (unsigned int i = 0; i < 2; ++i)
+          out << ' ' << co_face->vertex_index(i);
+        out << '\n';
+      }
+
+  // write cell types
+  out << "\nCELL_TYPES " << n_cells << '\n';
+  if (vtk_flags.output_cells)
     {
-      out << GeometryInfo<dim>::vertices_per_cell;
-      for (unsigned int i = 0; i < GeometryInfo<dim>::vertices_per_cell; ++i)
+      for (unsigned int i = 0; i < tria.n_active_cells(); ++i)
         {
-          out << ' ' << cell->vertex_index(GeometryInfo<dim>::ucd_to_deal[i]);
+          out << cell_type << ' ';
         }
       out << '\n';
     }
-  for (const auto &face : faces)
+  if (vtk_flags.output_faces)
     {
-      out << GeometryInfo<dim>::vertices_per_face;
-      for (unsigned int i = 0; i < GeometryInfo<dim>::vertices_per_face; ++i)
+      for (unsigned int i = 0; i < faces.size(); ++i)
         {
-          out << ' '
-              << face->vertex_index(
-                   GeometryInfo < (dim > 1) ? dim - 1 : dim > ::ucd_to_deal[i]);
+          out << face_type << ' ';
         }
       out << '\n';
     }
-  for (const auto &co_face : co_faces)
-    {
-      out << 2;
-      for (unsigned int i = 0; i < 2; ++i)
-        out << ' ' << co_face->vertex_index(i);
-      out << '\n';
-    }
-
-  // write cell types
-  out << "\nCELL_TYPES " << n_cells << '\n';
-  for (unsigned int i = 0; i < tria.n_active_cells(); ++i)
+  if (vtk_flags.output_co_faces)
     {
-      out << cell_type << ' ';
-    }
-  out << '\n';
-  for (unsigned int i = 0; i < faces.size(); ++i)
-    {
-      out << face_type << ' ';
-    }
-  out << '\n';
-  for (unsigned int i = 0; i < co_faces.size(); ++i)
-    {
-      out << co_face_type << ' ';
+      for (unsigned int i = 0; i < co_faces.size(); ++i)
+        {
+          out << co_face_type << ' ';
+        }
     }
   out << "\n\nCELL_DATA " << n_cells << '\n'
       << "SCALARS MaterialID int 1\n"
       << "LOOKUP_TABLE default\n";
 
   // Now material id and boundary id
-  for (const auto &cell : tria.active_cell_iterators())
+  if (vtk_flags.output_cells)
     {
-      out << static_cast<std::make_signed<types::material_id>::type>(
-               cell->material_id())
-          << ' ';
+      for (const auto &cell : tria.active_cell_iterators())
+        {
+          out << static_cast<std::make_signed<types::material_id>::type>(
+                   cell->material_id())
+              << ' ';
+        }
+      out << '\n';
     }
-  out << '\n';
-  for (const auto &face : faces)
+  if (vtk_flags.output_faces)
     {
-      out << static_cast<std::make_signed<types::boundary_id>::type>(
-               face->boundary_id())
-          << ' ';
+      for (const auto &face : faces)
+        {
+          out << static_cast<std::make_signed<types::boundary_id>::type>(
+                   face->boundary_id())
+              << ' ';
+        }
+      out << '\n';
     }
-  out << '\n';
-  for (const auto &co_face : co_faces)
+  if (vtk_flags.output_co_faces)
     {
-      out << static_cast<std::make_signed<types::boundary_id>::type>(
-               co_face->boundary_id())
-          << ' ';
+      for (const auto &co_face : co_faces)
+        {
+          out << static_cast<std::make_signed<types::boundary_id>::type>(
+                   co_face->boundary_id())
+              << ' ';
+        }
     }
 
   out << "\n\nSCALARS ManifoldID int 1\n"
       << "LOOKUP_TABLE default\n";
 
   // Now material id and boundary id
-  for (const auto &cell : tria.active_cell_iterators())
+  if (vtk_flags.output_cells)
     {
-      out << static_cast<std::make_signed<types::boundary_id>::type>(
-               cell->manifold_id())
-          << ' ';
+      for (const auto &cell : tria.active_cell_iterators())
+        {
+          out << static_cast<std::make_signed<types::boundary_id>::type>(
+                   cell->manifold_id())
+              << ' ';
+        }
+      out << '\n';
     }
-  out << '\n';
-  for (const auto &face : faces)
+  if (vtk_flags.output_faces)
     {
-      out << static_cast<std::make_signed<types::boundary_id>::type>(
-               face->manifold_id())
-          << ' ';
+      for (const auto &face : faces)
+        {
+          out << static_cast<std::make_signed<types::boundary_id>::type>(
+                   face->manifold_id())
+              << ' ';
+        }
+      out << '\n';
     }
-  out << '\n';
-  for (const auto &co_face : co_faces)
+  if (vtk_flags.output_co_faces)
     {
-      out << static_cast<std::make_signed<types::boundary_id>::type>(
-               co_face->manifold_id())
-          << ' ';
+      for (const auto &co_face : co_faces)
+        {
+          out << static_cast<std::make_signed<types::boundary_id>::type>(
+                   co_face->manifold_id())
+              << ' ';
+        }
+      out << '\n';
     }
-  out << '\n';
 
   out.flush();
 
diff --git a/tests/grid/grid_out_vtk_03.cc b/tests/grid/grid_out_vtk_03.cc
new file mode 100644 (file)
index 0000000..f5c9d6b
--- /dev/null
@@ -0,0 +1,102 @@
+// ---------------------------------------------------------------------
+//
+// Copyright (C) 2002 - 2018 by the deal.II authors
+//
+// This file is part of the deal.II library.
+//
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE.md at
+// the top level directory of deal.II.
+//
+// ---------------------------------------------------------------------
+
+
+// test the draq_*-flags for GridOut::write_vtk
+
+#include <deal.II/base/geometry_info.h>
+
+#include <deal.II/dofs/dof_handler.h>
+
+#include <deal.II/grid/grid_generator.h>
+#include <deal.II/grid/grid_in.h>
+#include <deal.II/grid/grid_out.h>
+#include <deal.II/grid/manifold_lib.h>
+#include <deal.II/grid/tria.h>
+#include <deal.II/grid/tria_accessor.h>
+#include <deal.II/grid/tria_iterator.h>
+
+#include "../tests.h"
+
+
+
+template <int dim, int spacedim>
+void
+do_test(std::ostream &logfile,
+        const bool    output_cells,
+        const bool    output_faces,
+        const bool    output_co_faces)
+{
+  Triangulation<dim, spacedim> tria_1;
+  GridGenerator::hyper_cube(tria_1, 0, 1, true);
+  tria_1.refine_global(1);
+
+  tria_1.begin_active()->set_refine_flag();
+  tria_1.execute_coarsening_and_refinement();
+
+  GridOutFlags::Vtk flags;
+  flags.output_cells    = output_cells;
+  flags.output_faces    = output_faces;
+  flags.output_co_faces = output_co_faces;
+
+  GridOut grid_out_1;
+  grid_out_1.set_flags(flags);
+  grid_out_1.write_vtk(tria_1, logfile);
+
+
+  // write to buffer
+  std::ostringstream buf;
+  grid_out_1.write_vtk(tria_1, buf);
+
+
+  std::istringstream buf_in;
+  buf_in.str(buf.str());
+
+
+  // read from buffer and create a new triangulation
+  Triangulation<dim, spacedim> tria_2;
+  GridIn<dim, spacedim>        grid_in;
+  grid_in.attach_triangulation(tria_2);
+  grid_in.read_vtk(buf_in);
+
+  // output the new triangulation
+  GridOut grid_out_2;
+  grid_out_2.write_vtk(tria_2, logfile);
+}
+
+
+
+template <int dim, int spacedim>
+void
+test(std::ostream &logfile)
+{
+  do_test<dim, spacedim>(logfile, true, false, false);
+  do_test<dim, spacedim>(logfile, true, false, true);
+  do_test<dim, spacedim>(logfile, true, true, false);
+  do_test<dim, spacedim>(logfile, true, true, true);
+}
+
+
+
+int
+main()
+{
+  initlog("output");
+  test<1, 1>(deallog.get_file_stream());
+  test<1, 2>(deallog.get_file_stream());
+  test<2, 2>(deallog.get_file_stream());
+  test<2, 3>(deallog.get_file_stream());
+  test<3, 3>(deallog.get_file_stream());
+}
diff --git a/tests/grid/grid_out_vtk_03.output b/tests/grid/grid_out_vtk_03.output
new file mode 100644 (file)
index 0000000..aa95b55
--- /dev/null
@@ -0,0 +1,2185 @@
+
+# vtk DataFile Version 3.0
+Triangulation generated with deal.II
+ASCII
+DATASET UNSTRUCTURED_GRID
+POINTS 4 double
+0.00000 0 0
+1.00000 0 0
+0.500000 0 0
+0.250000 0 0
+
+CELLS 3 9
+2 2 1
+2 0 3
+2 3 2
+
+CELL_TYPES 3
+3 3 3 
+
+
+CELL_DATA 3
+SCALARS MaterialID int 1
+LOOKUP_TABLE default
+0 0 0 
+
+
+SCALARS ManifoldID int 1
+LOOKUP_TABLE default
+-1 -1 -1 
+# vtk DataFile Version 3.0
+Triangulation generated with deal.II
+ASCII
+DATASET UNSTRUCTURED_GRID
+POINTS 4 double
+0.00000 0 0
+1.00000 0 0
+0.500000 0 0
+0.250000 0 0
+
+CELLS 3 9
+2 2 1
+2 0 3
+2 3 2
+
+CELL_TYPES 3
+3 3 3 
+
+
+
+CELL_DATA 3
+SCALARS MaterialID int 1
+LOOKUP_TABLE default
+0 0 0 
+
+
+
+SCALARS ManifoldID int 1
+LOOKUP_TABLE default
+-1 -1 -1 
+
+
+# vtk DataFile Version 3.0
+Triangulation generated with deal.II
+ASCII
+DATASET UNSTRUCTURED_GRID
+POINTS 4 double
+0.00000 0 0
+1.00000 0 0
+0.500000 0 0
+0.250000 0 0
+
+CELLS 3 9
+2 2 1
+2 0 3
+2 3 2
+
+CELL_TYPES 3
+3 3 3 
+
+
+CELL_DATA 3
+SCALARS MaterialID int 1
+LOOKUP_TABLE default
+0 0 0 
+
+
+SCALARS ManifoldID int 1
+LOOKUP_TABLE default
+-1 -1 -1 
+
+# vtk DataFile Version 3.0
+Triangulation generated with deal.II
+ASCII
+DATASET UNSTRUCTURED_GRID
+POINTS 4 double
+0.00000 0 0
+1.00000 0 0
+0.500000 0 0
+0.250000 0 0
+
+CELLS 3 9
+2 2 1
+2 0 3
+2 3 2
+
+CELL_TYPES 3
+3 3 3 
+
+
+
+CELL_DATA 3
+SCALARS MaterialID int 1
+LOOKUP_TABLE default
+0 0 0 
+
+
+
+SCALARS ManifoldID int 1
+LOOKUP_TABLE default
+-1 -1 -1 
+
+
+# vtk DataFile Version 3.0
+Triangulation generated with deal.II
+ASCII
+DATASET UNSTRUCTURED_GRID
+POINTS 4 double
+0.00000 0 0
+1.00000 0 0
+0.500000 0 0
+0.250000 0 0
+
+CELLS 3 9
+2 2 1
+2 0 3
+2 3 2
+
+CELL_TYPES 3
+3 3 3 
+
+
+
+CELL_DATA 3
+SCALARS MaterialID int 1
+LOOKUP_TABLE default
+0 0 0 
+
+
+
+SCALARS ManifoldID int 1
+LOOKUP_TABLE default
+-1 -1 -1 
+
+# vtk DataFile Version 3.0
+Triangulation generated with deal.II
+ASCII
+DATASET UNSTRUCTURED_GRID
+POINTS 4 double
+0.00000 0 0
+1.00000 0 0
+0.500000 0 0
+0.250000 0 0
+
+CELLS 3 9
+2 2 1
+2 0 3
+2 3 2
+
+CELL_TYPES 3
+3 3 3 
+
+
+
+CELL_DATA 3
+SCALARS MaterialID int 1
+LOOKUP_TABLE default
+0 0 0 
+
+
+
+SCALARS ManifoldID int 1
+LOOKUP_TABLE default
+-1 -1 -1 
+
+
+# vtk DataFile Version 3.0
+Triangulation generated with deal.II
+ASCII
+DATASET UNSTRUCTURED_GRID
+POINTS 4 double
+0.00000 0 0
+1.00000 0 0
+0.500000 0 0
+0.250000 0 0
+
+CELLS 3 9
+2 2 1
+2 0 3
+2 3 2
+
+CELL_TYPES 3
+3 3 3 
+
+
+
+CELL_DATA 3
+SCALARS MaterialID int 1
+LOOKUP_TABLE default
+0 0 0 
+
+
+
+SCALARS ManifoldID int 1
+LOOKUP_TABLE default
+-1 -1 -1 
+
+
+# vtk DataFile Version 3.0
+Triangulation generated with deal.II
+ASCII
+DATASET UNSTRUCTURED_GRID
+POINTS 4 double
+0.00000 0 0
+1.00000 0 0
+0.500000 0 0
+0.250000 0 0
+
+CELLS 3 9
+2 2 1
+2 0 3
+2 3 2
+
+CELL_TYPES 3
+3 3 3 
+
+
+
+CELL_DATA 3
+SCALARS MaterialID int 1
+LOOKUP_TABLE default
+0 0 0 
+
+
+
+SCALARS ManifoldID int 1
+LOOKUP_TABLE default
+-1 -1 -1 
+
+
+# vtk DataFile Version 3.0
+Triangulation generated with deal.II
+ASCII
+DATASET UNSTRUCTURED_GRID
+POINTS 4 double
+0.00000 0.00000 0
+1.00000 0.00000 0
+0.500000 0.00000 0
+0.250000 0.00000 0
+
+CELLS 3 9
+2 2 1
+2 0 3
+2 3 2
+
+CELL_TYPES 3
+3 3 3 
+
+
+CELL_DATA 3
+SCALARS MaterialID int 1
+LOOKUP_TABLE default
+0 0 0 
+
+
+SCALARS ManifoldID int 1
+LOOKUP_TABLE default
+-1 -1 -1 
+# vtk DataFile Version 3.0
+Triangulation generated with deal.II
+ASCII
+DATASET UNSTRUCTURED_GRID
+POINTS 4 double
+0.00000 0.00000 0
+1.00000 0.00000 0
+0.500000 0.00000 0
+0.250000 0.00000 0
+
+CELLS 3 9
+2 2 1
+2 0 3
+2 3 2
+
+CELL_TYPES 3
+3 3 3 
+
+
+
+CELL_DATA 3
+SCALARS MaterialID int 1
+LOOKUP_TABLE default
+0 0 0 
+
+
+
+SCALARS ManifoldID int 1
+LOOKUP_TABLE default
+-1 -1 -1 
+
+
+# vtk DataFile Version 3.0
+Triangulation generated with deal.II
+ASCII
+DATASET UNSTRUCTURED_GRID
+POINTS 4 double
+0.00000 0.00000 0
+1.00000 0.00000 0
+0.500000 0.00000 0
+0.250000 0.00000 0
+
+CELLS 3 9
+2 2 1
+2 0 3
+2 3 2
+
+CELL_TYPES 3
+3 3 3 
+
+
+CELL_DATA 3
+SCALARS MaterialID int 1
+LOOKUP_TABLE default
+0 0 0 
+
+
+SCALARS ManifoldID int 1
+LOOKUP_TABLE default
+-1 -1 -1 
+
+# vtk DataFile Version 3.0
+Triangulation generated with deal.II
+ASCII
+DATASET UNSTRUCTURED_GRID
+POINTS 4 double
+0.00000 0.00000 0
+1.00000 0.00000 0
+0.500000 0.00000 0
+0.250000 0.00000 0
+
+CELLS 3 9
+2 2 1
+2 0 3
+2 3 2
+
+CELL_TYPES 3
+3 3 3 
+
+
+
+CELL_DATA 3
+SCALARS MaterialID int 1
+LOOKUP_TABLE default
+0 0 0 
+
+
+
+SCALARS ManifoldID int 1
+LOOKUP_TABLE default
+-1 -1 -1 
+
+
+# vtk DataFile Version 3.0
+Triangulation generated with deal.II
+ASCII
+DATASET UNSTRUCTURED_GRID
+POINTS 4 double
+0.00000 0.00000 0
+1.00000 0.00000 0
+0.500000 0.00000 0
+0.250000 0.00000 0
+
+CELLS 3 9
+2 2 1
+2 0 3
+2 3 2
+
+CELL_TYPES 3
+3 3 3 
+
+
+
+CELL_DATA 3
+SCALARS MaterialID int 1
+LOOKUP_TABLE default
+0 0 0 
+
+
+
+SCALARS ManifoldID int 1
+LOOKUP_TABLE default
+-1 -1 -1 
+
+# vtk DataFile Version 3.0
+Triangulation generated with deal.II
+ASCII
+DATASET UNSTRUCTURED_GRID
+POINTS 4 double
+0.00000 0.00000 0
+1.00000 0.00000 0
+0.500000 0.00000 0
+0.250000 0.00000 0
+
+CELLS 3 9
+2 2 1
+2 0 3
+2 3 2
+
+CELL_TYPES 3
+3 3 3 
+
+
+
+CELL_DATA 3
+SCALARS MaterialID int 1
+LOOKUP_TABLE default
+0 0 0 
+
+
+
+SCALARS ManifoldID int 1
+LOOKUP_TABLE default
+-1 -1 -1 
+
+
+# vtk DataFile Version 3.0
+Triangulation generated with deal.II
+ASCII
+DATASET UNSTRUCTURED_GRID
+POINTS 4 double
+0.00000 0.00000 0
+1.00000 0.00000 0
+0.500000 0.00000 0
+0.250000 0.00000 0
+
+CELLS 3 9
+2 2 1
+2 0 3
+2 3 2
+
+CELL_TYPES 3
+3 3 3 
+
+
+
+CELL_DATA 3
+SCALARS MaterialID int 1
+LOOKUP_TABLE default
+0 0 0 
+
+
+
+SCALARS ManifoldID int 1
+LOOKUP_TABLE default
+-1 -1 -1 
+
+
+# vtk DataFile Version 3.0
+Triangulation generated with deal.II
+ASCII
+DATASET UNSTRUCTURED_GRID
+POINTS 4 double
+0.00000 0.00000 0
+1.00000 0.00000 0
+0.500000 0.00000 0
+0.250000 0.00000 0
+
+CELLS 3 9
+2 2 1
+2 0 3
+2 3 2
+
+CELL_TYPES 3
+3 3 3 
+
+
+
+CELL_DATA 3
+SCALARS MaterialID int 1
+LOOKUP_TABLE default
+0 0 0 
+
+
+
+SCALARS ManifoldID int 1
+LOOKUP_TABLE default
+-1 -1 -1 
+
+
+# vtk DataFile Version 3.0
+Triangulation generated with deal.II
+ASCII
+DATASET UNSTRUCTURED_GRID
+POINTS 14 double
+0.00000 0.00000 0
+1.00000 0.00000 0
+0.00000 1.00000 0
+1.00000 1.00000 0
+0.500000 0.00000 0
+0.00000 0.500000 0
+1.00000 0.500000 0
+0.500000 1.00000 0
+0.500000 0.500000 0
+0.250000 0.00000 0
+0.00000 0.250000 0
+0.500000 0.250000 0
+0.250000 0.500000 0
+0.250000 0.250000 0
+
+CELLS 7 35
+4 4 1 6 8
+4 5 8 7 2
+4 8 6 3 7
+4 0 9 13 10
+4 9 4 11 13
+4 10 13 12 5
+4 13 11 8 12
+
+CELL_TYPES 7
+9 9 9 9 9 9 9 
+
+
+CELL_DATA 7
+SCALARS MaterialID int 1
+LOOKUP_TABLE default
+0 0 0 0 0 0 0 
+
+
+SCALARS ManifoldID int 1
+LOOKUP_TABLE default
+-1 -1 -1 -1 -1 -1 -1 
+# vtk DataFile Version 3.0
+Triangulation generated with deal.II
+ASCII
+DATASET UNSTRUCTURED_GRID
+POINTS 14 double
+0.00000 0.00000 0
+1.00000 0.00000 0
+0.00000 1.00000 0
+1.00000 1.00000 0
+0.500000 0.00000 0
+0.00000 0.500000 0
+1.00000 0.500000 0
+0.500000 1.00000 0
+0.500000 0.500000 0
+0.250000 0.00000 0
+0.00000 0.250000 0
+0.500000 0.250000 0
+0.250000 0.500000 0
+0.250000 0.250000 0
+
+CELLS 7 35
+4 4 1 6 8
+4 5 8 7 2
+4 8 6 3 7
+4 0 9 13 10
+4 9 4 11 13
+4 10 13 12 5
+4 13 11 8 12
+
+CELL_TYPES 7
+9 9 9 9 9 9 9 
+
+
+
+CELL_DATA 7
+SCALARS MaterialID int 1
+LOOKUP_TABLE default
+0 0 0 0 0 0 0 
+
+
+
+SCALARS ManifoldID int 1
+LOOKUP_TABLE default
+-1 -1 -1 -1 -1 -1 -1 
+
+
+# vtk DataFile Version 3.0
+Triangulation generated with deal.II
+ASCII
+DATASET UNSTRUCTURED_GRID
+POINTS 14 double
+0.00000 0.00000 0
+1.00000 0.00000 0
+0.00000 1.00000 0
+1.00000 1.00000 0
+0.500000 0.00000 0
+0.00000 0.500000 0
+1.00000 0.500000 0
+0.500000 1.00000 0
+0.500000 0.500000 0
+0.250000 0.00000 0
+0.00000 0.250000 0
+0.500000 0.250000 0
+0.250000 0.500000 0
+0.250000 0.250000 0
+
+CELLS 7 35
+4 4 1 6 8
+4 5 8 7 2
+4 8 6 3 7
+4 0 9 13 10
+4 9 4 11 13
+4 10 13 12 5
+4 13 11 8 12
+
+CELL_TYPES 7
+9 9 9 9 9 9 9 
+
+
+CELL_DATA 7
+SCALARS MaterialID int 1
+LOOKUP_TABLE default
+0 0 0 0 0 0 0 
+
+
+SCALARS ManifoldID int 1
+LOOKUP_TABLE default
+-1 -1 -1 -1 -1 -1 -1 
+
+# vtk DataFile Version 3.0
+Triangulation generated with deal.II
+ASCII
+DATASET UNSTRUCTURED_GRID
+POINTS 14 double
+0.00000 0.00000 0
+1.00000 0.00000 0
+0.00000 1.00000 0
+1.00000 1.00000 0
+0.500000 0.00000 0
+0.00000 0.500000 0
+1.00000 0.500000 0
+0.500000 1.00000 0
+0.500000 0.500000 0
+0.250000 0.00000 0
+0.00000 0.250000 0
+0.500000 0.250000 0
+0.250000 0.500000 0
+0.250000 0.250000 0
+
+CELLS 7 35
+4 4 1 6 8
+4 5 8 7 2
+4 8 6 3 7
+4 0 9 13 10
+4 9 4 11 13
+4 10 13 12 5
+4 13 11 8 12
+
+CELL_TYPES 7
+9 9 9 9 9 9 9 
+
+
+
+CELL_DATA 7
+SCALARS MaterialID int 1
+LOOKUP_TABLE default
+0 0 0 0 0 0 0 
+
+
+
+SCALARS ManifoldID int 1
+LOOKUP_TABLE default
+-1 -1 -1 -1 -1 -1 -1 
+
+
+# vtk DataFile Version 3.0
+Triangulation generated with deal.II
+ASCII
+DATASET UNSTRUCTURED_GRID
+POINTS 14 double
+0.00000 0.00000 0
+1.00000 0.00000 0
+0.00000 1.00000 0
+1.00000 1.00000 0
+0.500000 0.00000 0
+0.00000 0.500000 0
+1.00000 0.500000 0
+0.500000 1.00000 0
+0.500000 0.500000 0
+0.250000 0.00000 0
+0.00000 0.250000 0
+0.500000 0.250000 0
+0.250000 0.500000 0
+0.250000 0.250000 0
+
+CELLS 14 56
+4 4 1 6 8
+4 5 8 7 2
+4 8 6 3 7
+4 0 9 13 10
+4 9 4 11 13
+4 10 13 12 5
+4 13 11 8 12
+2 4 1
+2 1 6
+2 6 3
+2 2 7
+2 7 3
+2 0 9
+2 9 4
+
+CELL_TYPES 14
+9 9 9 9 9 9 9 
+3 3 3 3 3 3 3 
+
+
+CELL_DATA 14
+SCALARS MaterialID int 1
+LOOKUP_TABLE default
+0 0 0 0 0 0 0 
+2 1 1 3 3 2 2 
+
+
+SCALARS ManifoldID int 1
+LOOKUP_TABLE default
+-1 -1 -1 -1 -1 -1 -1 
+-1 -1 -1 -1 -1 -1 -1 
+# vtk DataFile Version 3.0
+Triangulation generated with deal.II
+ASCII
+DATASET UNSTRUCTURED_GRID
+POINTS 14 double
+0.00000 0.00000 0
+1.00000 0.00000 0
+0.00000 1.00000 0
+1.00000 1.00000 0
+0.500000 0.00000 0
+0.00000 0.500000 0
+1.00000 0.500000 0
+0.500000 1.00000 0
+0.500000 0.500000 0
+0.250000 0.00000 0
+0.00000 0.250000 0
+0.500000 0.250000 0
+0.250000 0.500000 0
+0.250000 0.250000 0
+
+CELLS 14 56
+4 4 1 6 8
+4 5 8 7 2
+4 8 6 3 7
+4 0 9 13 10
+4 9 4 11 13
+4 10 13 12 5
+4 13 11 8 12
+2 0 9
+2 1 6
+2 2 7
+2 4 1
+2 6 3
+2 7 3
+2 9 4
+
+CELL_TYPES 14
+9 9 9 9 9 9 9 
+3 3 3 3 3 3 3 
+
+
+CELL_DATA 14
+SCALARS MaterialID int 1
+LOOKUP_TABLE default
+0 0 0 0 0 0 0 
+2 1 3 2 1 3 2 
+
+
+SCALARS ManifoldID int 1
+LOOKUP_TABLE default
+-1 -1 -1 -1 -1 -1 -1 
+-1 -1 -1 -1 -1 -1 -1 
+
+# vtk DataFile Version 3.0
+Triangulation generated with deal.II
+ASCII
+DATASET UNSTRUCTURED_GRID
+POINTS 14 double
+0.00000 0.00000 0
+1.00000 0.00000 0
+0.00000 1.00000 0
+1.00000 1.00000 0
+0.500000 0.00000 0
+0.00000 0.500000 0
+1.00000 0.500000 0
+0.500000 1.00000 0
+0.500000 0.500000 0
+0.250000 0.00000 0
+0.00000 0.250000 0
+0.500000 0.250000 0
+0.250000 0.500000 0
+0.250000 0.250000 0
+
+CELLS 14 56
+4 4 1 6 8
+4 5 8 7 2
+4 8 6 3 7
+4 0 9 13 10
+4 9 4 11 13
+4 10 13 12 5
+4 13 11 8 12
+2 4 1
+2 1 6
+2 6 3
+2 2 7
+2 7 3
+2 0 9
+2 9 4
+
+CELL_TYPES 14
+9 9 9 9 9 9 9 
+3 3 3 3 3 3 3 
+
+
+CELL_DATA 14
+SCALARS MaterialID int 1
+LOOKUP_TABLE default
+0 0 0 0 0 0 0 
+2 1 1 3 3 2 2 
+
+
+SCALARS ManifoldID int 1
+LOOKUP_TABLE default
+-1 -1 -1 -1 -1 -1 -1 
+-1 -1 -1 -1 -1 -1 -1 
+
+# vtk DataFile Version 3.0
+Triangulation generated with deal.II
+ASCII
+DATASET UNSTRUCTURED_GRID
+POINTS 14 double
+0.00000 0.00000 0
+1.00000 0.00000 0
+0.00000 1.00000 0
+1.00000 1.00000 0
+0.500000 0.00000 0
+0.00000 0.500000 0
+1.00000 0.500000 0
+0.500000 1.00000 0
+0.500000 0.500000 0
+0.250000 0.00000 0
+0.00000 0.250000 0
+0.500000 0.250000 0
+0.250000 0.500000 0
+0.250000 0.250000 0
+
+CELLS 14 56
+4 4 1 6 8
+4 5 8 7 2
+4 8 6 3 7
+4 0 9 13 10
+4 9 4 11 13
+4 10 13 12 5
+4 13 11 8 12
+2 0 9
+2 1 6
+2 2 7
+2 4 1
+2 6 3
+2 7 3
+2 9 4
+
+CELL_TYPES 14
+9 9 9 9 9 9 9 
+3 3 3 3 3 3 3 
+
+
+CELL_DATA 14
+SCALARS MaterialID int 1
+LOOKUP_TABLE default
+0 0 0 0 0 0 0 
+2 1 3 2 1 3 2 
+
+
+SCALARS ManifoldID int 1
+LOOKUP_TABLE default
+-1 -1 -1 -1 -1 -1 -1 
+-1 -1 -1 -1 -1 -1 -1 
+
+# vtk DataFile Version 3.0
+Triangulation generated with deal.II
+ASCII
+DATASET UNSTRUCTURED_GRID
+POINTS 14 double
+0.00000 0.00000 0.00000
+1.00000 0.00000 0.00000
+0.00000 1.00000 0.00000
+1.00000 1.00000 0.00000
+0.500000 0.00000 0.00000
+0.00000 0.500000 0.00000
+1.00000 0.500000 0.00000
+0.500000 1.00000 0.00000
+0.500000 0.500000 0.00000
+0.250000 0.00000 0.00000
+0.00000 0.250000 0.00000
+0.500000 0.250000 0.00000
+0.250000 0.500000 0.00000
+0.250000 0.250000 0.00000
+
+CELLS 7 35
+4 4 1 6 8
+4 5 8 7 2
+4 8 6 3 7
+4 0 9 13 10
+4 9 4 11 13
+4 10 13 12 5
+4 13 11 8 12
+
+CELL_TYPES 7
+9 9 9 9 9 9 9 
+
+
+CELL_DATA 7
+SCALARS MaterialID int 1
+LOOKUP_TABLE default
+0 0 0 0 0 0 0 
+
+
+SCALARS ManifoldID int 1
+LOOKUP_TABLE default
+-1 -1 -1 -1 -1 -1 -1 
+# vtk DataFile Version 3.0
+Triangulation generated with deal.II
+ASCII
+DATASET UNSTRUCTURED_GRID
+POINTS 14 double
+0.00000 0.00000 0.00000
+1.00000 0.00000 0.00000
+0.00000 1.00000 0.00000
+1.00000 1.00000 0.00000
+0.500000 0.00000 0.00000
+0.00000 0.500000 0.00000
+1.00000 0.500000 0.00000
+0.500000 1.00000 0.00000
+0.500000 0.500000 0.00000
+0.250000 0.00000 0.00000
+0.00000 0.250000 0.00000
+0.500000 0.250000 0.00000
+0.250000 0.500000 0.00000
+0.250000 0.250000 0.00000
+
+CELLS 7 35
+4 4 1 6 8
+4 5 8 7 2
+4 8 6 3 7
+4 0 9 13 10
+4 9 4 11 13
+4 10 13 12 5
+4 13 11 8 12
+
+CELL_TYPES 7
+9 9 9 9 9 9 9 
+
+
+
+CELL_DATA 7
+SCALARS MaterialID int 1
+LOOKUP_TABLE default
+0 0 0 0 0 0 0 
+
+
+
+SCALARS ManifoldID int 1
+LOOKUP_TABLE default
+-1 -1 -1 -1 -1 -1 -1 
+
+
+# vtk DataFile Version 3.0
+Triangulation generated with deal.II
+ASCII
+DATASET UNSTRUCTURED_GRID
+POINTS 14 double
+0.00000 0.00000 0.00000
+1.00000 0.00000 0.00000
+0.00000 1.00000 0.00000
+1.00000 1.00000 0.00000
+0.500000 0.00000 0.00000
+0.00000 0.500000 0.00000
+1.00000 0.500000 0.00000
+0.500000 1.00000 0.00000
+0.500000 0.500000 0.00000
+0.250000 0.00000 0.00000
+0.00000 0.250000 0.00000
+0.500000 0.250000 0.00000
+0.250000 0.500000 0.00000
+0.250000 0.250000 0.00000
+
+CELLS 7 35
+4 4 1 6 8
+4 5 8 7 2
+4 8 6 3 7
+4 0 9 13 10
+4 9 4 11 13
+4 10 13 12 5
+4 13 11 8 12
+
+CELL_TYPES 7
+9 9 9 9 9 9 9 
+
+
+CELL_DATA 7
+SCALARS MaterialID int 1
+LOOKUP_TABLE default
+0 0 0 0 0 0 0 
+
+
+SCALARS ManifoldID int 1
+LOOKUP_TABLE default
+-1 -1 -1 -1 -1 -1 -1 
+
+# vtk DataFile Version 3.0
+Triangulation generated with deal.II
+ASCII
+DATASET UNSTRUCTURED_GRID
+POINTS 14 double
+0.00000 0.00000 0.00000
+1.00000 0.00000 0.00000
+0.00000 1.00000 0.00000
+1.00000 1.00000 0.00000
+0.500000 0.00000 0.00000
+0.00000 0.500000 0.00000
+1.00000 0.500000 0.00000
+0.500000 1.00000 0.00000
+0.500000 0.500000 0.00000
+0.250000 0.00000 0.00000
+0.00000 0.250000 0.00000
+0.500000 0.250000 0.00000
+0.250000 0.500000 0.00000
+0.250000 0.250000 0.00000
+
+CELLS 7 35
+4 4 1 6 8
+4 5 8 7 2
+4 8 6 3 7
+4 0 9 13 10
+4 9 4 11 13
+4 10 13 12 5
+4 13 11 8 12
+
+CELL_TYPES 7
+9 9 9 9 9 9 9 
+
+
+
+CELL_DATA 7
+SCALARS MaterialID int 1
+LOOKUP_TABLE default
+0 0 0 0 0 0 0 
+
+
+
+SCALARS ManifoldID int 1
+LOOKUP_TABLE default
+-1 -1 -1 -1 -1 -1 -1 
+
+
+# vtk DataFile Version 3.0
+Triangulation generated with deal.II
+ASCII
+DATASET UNSTRUCTURED_GRID
+POINTS 14 double
+0.00000 0.00000 0.00000
+1.00000 0.00000 0.00000
+0.00000 1.00000 0.00000
+1.00000 1.00000 0.00000
+0.500000 0.00000 0.00000
+0.00000 0.500000 0.00000
+1.00000 0.500000 0.00000
+0.500000 1.00000 0.00000
+0.500000 0.500000 0.00000
+0.250000 0.00000 0.00000
+0.00000 0.250000 0.00000
+0.500000 0.250000 0.00000
+0.250000 0.500000 0.00000
+0.250000 0.250000 0.00000
+
+CELLS 14 56
+4 4 1 6 8
+4 5 8 7 2
+4 8 6 3 7
+4 0 9 13 10
+4 9 4 11 13
+4 10 13 12 5
+4 13 11 8 12
+2 4 1
+2 1 6
+2 6 3
+2 2 7
+2 7 3
+2 0 9
+2 9 4
+
+CELL_TYPES 14
+9 9 9 9 9 9 9 
+3 3 3 3 3 3 3 
+
+
+CELL_DATA 14
+SCALARS MaterialID int 1
+LOOKUP_TABLE default
+0 0 0 0 0 0 0 
+2 1 1 3 3 2 2 
+
+
+SCALARS ManifoldID int 1
+LOOKUP_TABLE default
+-1 -1 -1 -1 -1 -1 -1 
+-1 -1 -1 -1 -1 -1 -1 
+# vtk DataFile Version 3.0
+Triangulation generated with deal.II
+ASCII
+DATASET UNSTRUCTURED_GRID
+POINTS 14 double
+0.00000 0.00000 0.00000
+1.00000 0.00000 0.00000
+0.00000 1.00000 0.00000
+1.00000 1.00000 0.00000
+0.500000 0.00000 0.00000
+0.00000 0.500000 0.00000
+1.00000 0.500000 0.00000
+0.500000 1.00000 0.00000
+0.500000 0.500000 0.00000
+0.250000 0.00000 0.00000
+0.00000 0.250000 0.00000
+0.500000 0.250000 0.00000
+0.250000 0.500000 0.00000
+0.250000 0.250000 0.00000
+
+CELLS 14 56
+4 4 1 6 8
+4 5 8 7 2
+4 8 6 3 7
+4 0 9 13 10
+4 9 4 11 13
+4 10 13 12 5
+4 13 11 8 12
+2 0 9
+2 1 6
+2 2 7
+2 4 1
+2 6 3
+2 7 3
+2 9 4
+
+CELL_TYPES 14
+9 9 9 9 9 9 9 
+3 3 3 3 3 3 3 
+
+
+CELL_DATA 14
+SCALARS MaterialID int 1
+LOOKUP_TABLE default
+0 0 0 0 0 0 0 
+2 1 3 2 1 3 2 
+
+
+SCALARS ManifoldID int 1
+LOOKUP_TABLE default
+-1 -1 -1 -1 -1 -1 -1 
+-1 -1 -1 -1 -1 -1 -1 
+
+# vtk DataFile Version 3.0
+Triangulation generated with deal.II
+ASCII
+DATASET UNSTRUCTURED_GRID
+POINTS 14 double
+0.00000 0.00000 0.00000
+1.00000 0.00000 0.00000
+0.00000 1.00000 0.00000
+1.00000 1.00000 0.00000
+0.500000 0.00000 0.00000
+0.00000 0.500000 0.00000
+1.00000 0.500000 0.00000
+0.500000 1.00000 0.00000
+0.500000 0.500000 0.00000
+0.250000 0.00000 0.00000
+0.00000 0.250000 0.00000
+0.500000 0.250000 0.00000
+0.250000 0.500000 0.00000
+0.250000 0.250000 0.00000
+
+CELLS 14 56
+4 4 1 6 8
+4 5 8 7 2
+4 8 6 3 7
+4 0 9 13 10
+4 9 4 11 13
+4 10 13 12 5
+4 13 11 8 12
+2 4 1
+2 1 6
+2 6 3
+2 2 7
+2 7 3
+2 0 9
+2 9 4
+
+CELL_TYPES 14
+9 9 9 9 9 9 9 
+3 3 3 3 3 3 3 
+
+
+CELL_DATA 14
+SCALARS MaterialID int 1
+LOOKUP_TABLE default
+0 0 0 0 0 0 0 
+2 1 1 3 3 2 2 
+
+
+SCALARS ManifoldID int 1
+LOOKUP_TABLE default
+-1 -1 -1 -1 -1 -1 -1 
+-1 -1 -1 -1 -1 -1 -1 
+
+# vtk DataFile Version 3.0
+Triangulation generated with deal.II
+ASCII
+DATASET UNSTRUCTURED_GRID
+POINTS 14 double
+0.00000 0.00000 0.00000
+1.00000 0.00000 0.00000
+0.00000 1.00000 0.00000
+1.00000 1.00000 0.00000
+0.500000 0.00000 0.00000
+0.00000 0.500000 0.00000
+1.00000 0.500000 0.00000
+0.500000 1.00000 0.00000
+0.500000 0.500000 0.00000
+0.250000 0.00000 0.00000
+0.00000 0.250000 0.00000
+0.500000 0.250000 0.00000
+0.250000 0.500000 0.00000
+0.250000 0.250000 0.00000
+
+CELLS 14 56
+4 4 1 6 8
+4 5 8 7 2
+4 8 6 3 7
+4 0 9 13 10
+4 9 4 11 13
+4 10 13 12 5
+4 13 11 8 12
+2 0 9
+2 1 6
+2 2 7
+2 4 1
+2 6 3
+2 7 3
+2 9 4
+
+CELL_TYPES 14
+9 9 9 9 9 9 9 
+3 3 3 3 3 3 3 
+
+
+CELL_DATA 14
+SCALARS MaterialID int 1
+LOOKUP_TABLE default
+0 0 0 0 0 0 0 
+2 1 3 2 1 3 2 
+
+
+SCALARS ManifoldID int 1
+LOOKUP_TABLE default
+-1 -1 -1 -1 -1 -1 -1 
+-1 -1 -1 -1 -1 -1 -1 
+
+# vtk DataFile Version 3.0
+Triangulation generated with deal.II
+ASCII
+DATASET UNSTRUCTURED_GRID
+POINTS 46 double
+0.00000 0.00000 0.00000
+1.00000 0.00000 0.00000
+0.00000 1.00000 0.00000
+1.00000 1.00000 0.00000
+0.00000 0.00000 1.00000
+1.00000 0.00000 1.00000
+0.00000 1.00000 1.00000
+1.00000 1.00000 1.00000
+0.500000 0.00000 0.00000
+0.00000 0.500000 0.00000
+0.00000 0.00000 0.500000
+1.00000 0.500000 0.00000
+1.00000 0.00000 0.500000
+0.500000 1.00000 0.00000
+0.00000 1.00000 0.500000
+1.00000 1.00000 0.500000
+0.500000 0.00000 1.00000
+0.00000 0.500000 1.00000
+1.00000 0.500000 1.00000
+0.500000 1.00000 1.00000
+0.500000 0.00000 0.500000
+0.500000 0.500000 0.00000
+0.00000 0.500000 0.500000
+1.00000 0.500000 0.500000
+0.500000 1.00000 0.500000
+0.500000 0.500000 1.00000
+0.500000 0.500000 0.500000
+0.250000 0.00000 0.00000
+0.00000 0.250000 0.00000
+0.00000 0.00000 0.250000
+0.250000 0.00000 0.500000
+0.500000 0.00000 0.250000
+0.500000 0.250000 0.00000
+0.250000 0.500000 0.00000
+0.00000 0.500000 0.250000
+0.00000 0.250000 0.500000
+0.500000 0.500000 0.250000
+0.250000 0.500000 0.500000
+0.500000 0.250000 0.500000
+0.250000 0.00000 0.250000
+0.250000 0.250000 0.00000
+0.00000 0.250000 0.250000
+0.250000 0.250000 0.500000
+0.250000 0.500000 0.250000
+0.500000 0.250000 0.250000
+0.250000 0.250000 0.250000
+
+CELLS 15 135
+8 8 1 12 20 21 11 23 26
+8 9 21 26 22 2 13 24 14
+8 21 11 23 26 13 3 15 24
+8 10 20 16 4 22 26 25 17
+8 20 12 5 16 26 23 18 25
+8 22 26 25 17 14 24 19 6
+8 26 23 18 25 24 15 7 19
+8 0 27 39 29 28 40 45 41
+8 27 8 31 39 40 32 44 45
+8 28 40 45 41 9 33 43 34
+8 40 32 44 45 33 21 36 43
+8 29 39 30 10 41 45 42 35
+8 39 31 20 30 45 44 38 42
+8 41 45 42 35 34 43 37 22
+8 45 44 38 42 43 36 26 37
+
+CELL_TYPES 15
+12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 
+
+
+CELL_DATA 15
+SCALARS MaterialID int 1
+LOOKUP_TABLE default
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+
+
+SCALARS ManifoldID int 1
+LOOKUP_TABLE default
+-1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 
+# vtk DataFile Version 3.0
+Triangulation generated with deal.II
+ASCII
+DATASET UNSTRUCTURED_GRID
+POINTS 46 double
+0.00000 0.00000 0.00000
+1.00000 0.00000 0.00000
+0.00000 1.00000 0.00000
+1.00000 1.00000 0.00000
+0.00000 0.00000 1.00000
+1.00000 0.00000 1.00000
+0.00000 1.00000 1.00000
+1.00000 1.00000 1.00000
+0.500000 0.00000 0.00000
+0.00000 0.500000 0.00000
+0.00000 0.00000 0.500000
+1.00000 0.500000 0.00000
+1.00000 0.00000 0.500000
+0.500000 1.00000 0.00000
+0.00000 1.00000 0.500000
+1.00000 1.00000 0.500000
+0.500000 0.00000 1.00000
+0.00000 0.500000 1.00000
+1.00000 0.500000 1.00000
+0.500000 1.00000 1.00000
+0.500000 0.00000 0.500000
+0.500000 0.500000 0.00000
+0.00000 0.500000 0.500000
+1.00000 0.500000 0.500000
+0.500000 1.00000 0.500000
+0.500000 0.500000 1.00000
+0.500000 0.500000 0.500000
+0.250000 0.00000 0.00000
+0.00000 0.250000 0.00000
+0.00000 0.00000 0.250000
+0.250000 0.00000 0.500000
+0.500000 0.00000 0.250000
+0.500000 0.250000 0.00000
+0.250000 0.500000 0.00000
+0.00000 0.500000 0.250000
+0.00000 0.250000 0.500000
+0.500000 0.500000 0.250000
+0.250000 0.500000 0.500000
+0.500000 0.250000 0.500000
+0.250000 0.00000 0.250000
+0.250000 0.250000 0.00000
+0.00000 0.250000 0.250000
+0.250000 0.250000 0.500000
+0.250000 0.500000 0.250000
+0.500000 0.250000 0.250000
+0.250000 0.250000 0.250000
+
+CELLS 15 135
+8 8 1 12 20 21 11 23 26
+8 9 21 26 22 2 13 24 14
+8 21 11 23 26 13 3 15 24
+8 10 20 16 4 22 26 25 17
+8 20 12 5 16 26 23 18 25
+8 22 26 25 17 14 24 19 6
+8 26 23 18 25 24 15 7 19
+8 0 27 39 29 28 40 45 41
+8 27 8 31 39 40 32 44 45
+8 28 40 45 41 9 33 43 34
+8 40 32 44 45 33 21 36 43
+8 29 39 30 10 41 45 42 35
+8 39 31 20 30 45 44 38 42
+8 41 45 42 35 34 43 37 22
+8 45 44 38 42 43 36 26 37
+
+CELL_TYPES 15
+12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 
+
+
+
+CELL_DATA 15
+SCALARS MaterialID int 1
+LOOKUP_TABLE default
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+
+
+
+SCALARS ManifoldID int 1
+LOOKUP_TABLE default
+-1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 
+
+
+# vtk DataFile Version 3.0
+Triangulation generated with deal.II
+ASCII
+DATASET UNSTRUCTURED_GRID
+POINTS 46 double
+0.00000 0.00000 0.00000
+1.00000 0.00000 0.00000
+0.00000 1.00000 0.00000
+1.00000 1.00000 0.00000
+0.00000 0.00000 1.00000
+1.00000 0.00000 1.00000
+0.00000 1.00000 1.00000
+1.00000 1.00000 1.00000
+0.500000 0.00000 0.00000
+0.00000 0.500000 0.00000
+0.00000 0.00000 0.500000
+1.00000 0.500000 0.00000
+1.00000 0.00000 0.500000
+0.500000 1.00000 0.00000
+0.00000 1.00000 0.500000
+1.00000 1.00000 0.500000
+0.500000 0.00000 1.00000
+0.00000 0.500000 1.00000
+1.00000 0.500000 1.00000
+0.500000 1.00000 1.00000
+0.500000 0.00000 0.500000
+0.500000 0.500000 0.00000
+0.00000 0.500000 0.500000
+1.00000 0.500000 0.500000
+0.500000 1.00000 0.500000
+0.500000 0.500000 1.00000
+0.500000 0.500000 0.500000
+0.250000 0.00000 0.00000
+0.00000 0.250000 0.00000
+0.00000 0.00000 0.250000
+0.250000 0.00000 0.500000
+0.500000 0.00000 0.250000
+0.500000 0.250000 0.00000
+0.250000 0.500000 0.00000
+0.00000 0.500000 0.250000
+0.00000 0.250000 0.500000
+0.500000 0.500000 0.250000
+0.250000 0.500000 0.500000
+0.500000 0.250000 0.500000
+0.250000 0.00000 0.250000
+0.250000 0.250000 0.00000
+0.00000 0.250000 0.250000
+0.250000 0.250000 0.500000
+0.250000 0.500000 0.250000
+0.500000 0.250000 0.250000
+0.250000 0.250000 0.250000
+
+CELLS 47 231
+8 8 1 12 20 21 11 23 26
+8 9 21 26 22 2 13 24 14
+8 21 11 23 26 13 3 15 24
+8 10 20 16 4 22 26 25 17
+8 20 12 5 16 26 23 18 25
+8 22 26 25 17 14 24 19 6
+8 26 23 18 25 24 15 7 19
+8 0 27 39 29 28 40 45 41
+8 27 8 31 39 40 32 44 45
+8 28 40 45 41 9 33 43 34
+8 40 32 44 45 33 21 36 43
+8 29 39 30 10 41 45 42 35
+8 39 31 20 30 45 44 38 42
+8 41 45 42 35 34 43 37 22
+8 45 44 38 42 43 36 26 37
+2 20 16
+2 20 12
+2 21 11
+2 21 13
+2 11 23
+2 12 23
+2 23 15
+2 23 18
+2 14 24
+2 13 24
+2 24 19
+2 24 15
+2 16 25
+2 17 25
+2 25 18
+2 25 19
+2 29 39
+2 27 39
+2 10 30
+2 39 30
+2 39 31
+2 8 31
+2 30 20
+2 31 20
+2 27 40
+2 28 40
+2 8 32
+2 40 32
+2 40 33
+2 9 33
+2 32 21
+2 33 21
+
+CELL_TYPES 47
+12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 
+3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 
+
+CELL_DATA 47
+SCALARS MaterialID int 1
+LOOKUP_TABLE default
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+2 2 4 4 1 1 1 1 3 3 3 3 5 5 5 5 2 2 2 2 2 2 2 2 4 4 4 4 4 4 4 4 
+
+SCALARS ManifoldID int 1
+LOOKUP_TABLE default
+-1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 
+-1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 
+# vtk DataFile Version 3.0
+Triangulation generated with deal.II
+ASCII
+DATASET UNSTRUCTURED_GRID
+POINTS 46 double
+0.00000 0.00000 0.00000
+1.00000 0.00000 0.00000
+0.00000 1.00000 0.00000
+1.00000 1.00000 0.00000
+0.00000 0.00000 1.00000
+1.00000 0.00000 1.00000
+0.00000 1.00000 1.00000
+1.00000 1.00000 1.00000
+0.500000 0.00000 0.00000
+0.00000 0.500000 0.00000
+0.00000 0.00000 0.500000
+1.00000 0.500000 0.00000
+1.00000 0.00000 0.500000
+0.500000 1.00000 0.00000
+0.00000 1.00000 0.500000
+1.00000 1.00000 0.500000
+0.500000 0.00000 1.00000
+0.00000 0.500000 1.00000
+1.00000 0.500000 1.00000
+0.500000 1.00000 1.00000
+0.500000 0.00000 0.500000
+0.500000 0.500000 0.00000
+0.00000 0.500000 0.500000
+1.00000 0.500000 0.500000
+0.500000 1.00000 0.500000
+0.500000 0.500000 1.00000
+0.500000 0.500000 0.500000
+0.250000 0.00000 0.00000
+0.00000 0.250000 0.00000
+0.00000 0.00000 0.250000
+0.250000 0.00000 0.500000
+0.500000 0.00000 0.250000
+0.500000 0.250000 0.00000
+0.250000 0.500000 0.00000
+0.00000 0.500000 0.250000
+0.00000 0.250000 0.500000
+0.500000 0.500000 0.250000
+0.250000 0.500000 0.500000
+0.500000 0.250000 0.500000
+0.250000 0.00000 0.250000
+0.250000 0.250000 0.00000
+0.00000 0.250000 0.250000
+0.250000 0.250000 0.500000
+0.250000 0.500000 0.250000
+0.500000 0.250000 0.250000
+0.250000 0.250000 0.250000
+
+CELLS 47 231
+8 8 1 12 20 21 11 23 26
+8 9 21 26 22 2 13 24 14
+8 21 11 23 26 13 3 15 24
+8 10 20 16 4 22 26 25 17
+8 20 12 5 16 26 23 18 25
+8 22 26 25 17 14 24 19 6
+8 26 23 18 25 24 15 7 19
+8 0 27 39 29 28 40 45 41
+8 27 8 31 39 40 32 44 45
+8 28 40 45 41 9 33 43 34
+8 40 32 44 45 33 21 36 43
+8 29 39 30 10 41 45 42 35
+8 39 31 20 30 45 44 38 42
+8 41 45 42 35 34 43 37 22
+8 45 44 38 42 43 36 26 37
+2 29 39
+2 27 39
+2 27 40
+2 28 40
+2 11 23
+2 12 23
+2 14 24
+2 13 24
+2 16 25
+2 17 25
+2 20 12
+2 21 11
+2 8 31
+2 8 32
+2 21 13
+2 9 33
+2 20 16
+2 10 30
+2 23 15
+2 23 18
+2 24 15
+2 24 19
+2 25 18
+2 25 19
+2 39 31
+2 40 32
+2 40 33
+2 39 30
+2 30 20
+2 31 20
+2 32 21
+2 33 21
+
+CELL_TYPES 47
+12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 
+
+3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 
+
+CELL_DATA 47
+SCALARS MaterialID int 1
+LOOKUP_TABLE default
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+
+2 2 4 4 1 1 3 3 5 5 2 4 2 4 4 4 2 2 1 1 3 3 5 5 2 4 4 2 2 2 4 4 
+
+SCALARS ManifoldID int 1
+LOOKUP_TABLE default
+-1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 
+
+-1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 
+# vtk DataFile Version 3.0
+Triangulation generated with deal.II
+ASCII
+DATASET UNSTRUCTURED_GRID
+POINTS 46 double
+0.00000 0.00000 0.00000
+1.00000 0.00000 0.00000
+0.00000 1.00000 0.00000
+1.00000 1.00000 0.00000
+0.00000 0.00000 1.00000
+1.00000 0.00000 1.00000
+0.00000 1.00000 1.00000
+1.00000 1.00000 1.00000
+0.500000 0.00000 0.00000
+0.00000 0.500000 0.00000
+0.00000 0.00000 0.500000
+1.00000 0.500000 0.00000
+1.00000 0.00000 0.500000
+0.500000 1.00000 0.00000
+0.00000 1.00000 0.500000
+1.00000 1.00000 0.500000
+0.500000 0.00000 1.00000
+0.00000 0.500000 1.00000
+1.00000 0.500000 1.00000
+0.500000 1.00000 1.00000
+0.500000 0.00000 0.500000
+0.500000 0.500000 0.00000
+0.00000 0.500000 0.500000
+1.00000 0.500000 0.500000
+0.500000 1.00000 0.500000
+0.500000 0.500000 1.00000
+0.500000 0.500000 0.500000
+0.250000 0.00000 0.00000
+0.00000 0.250000 0.00000
+0.00000 0.00000 0.250000
+0.250000 0.00000 0.500000
+0.500000 0.00000 0.250000
+0.500000 0.250000 0.00000
+0.250000 0.500000 0.00000
+0.00000 0.500000 0.250000
+0.00000 0.250000 0.500000
+0.500000 0.500000 0.250000
+0.250000 0.500000 0.500000
+0.500000 0.250000 0.500000
+0.250000 0.00000 0.250000
+0.250000 0.250000 0.00000
+0.00000 0.250000 0.250000
+0.250000 0.250000 0.500000
+0.250000 0.500000 0.250000
+0.500000 0.250000 0.250000
+0.250000 0.250000 0.250000
+
+CELLS 41 265
+8 8 1 12 20 21 11 23 26
+8 9 21 26 22 2 13 24 14
+8 21 11 23 26 13 3 15 24
+8 10 20 16 4 22 26 25 17
+8 20 12 5 16 26 23 18 25
+8 22 26 25 17 14 24 19 6
+8 26 23 18 25 24 15 7 19
+8 0 27 39 29 28 40 45 41
+8 27 8 31 39 40 32 44 45
+8 28 40 45 41 9 33 43 34
+8 40 32 44 45 33 21 36 43
+8 29 39 30 10 41 45 42 35
+8 39 31 20 30 45 44 38 42
+8 41 45 42 35 34 43 37 22
+8 45 44 38 42 43 36 26 37
+4 10 4 16 20
+4 8 20 12 1
+4 20 16 5 12
+4 8 1 11 21
+4 9 21 13 2
+4 21 11 3 13
+4 1 11 23 12
+4 11 3 15 23
+4 12 23 18 5
+4 23 15 7 18
+4 2 14 24 13
+4 14 6 19 24
+4 13 24 15 3
+4 24 19 7 15
+4 4 16 25 17
+4 16 5 18 25
+4 17 25 19 6
+4 25 18 7 19
+4 0 29 39 27
+4 29 10 30 39
+4 27 39 31 8
+4 39 30 20 31
+4 0 27 40 28
+4 27 8 32 40
+4 28 40 33 9
+4 40 32 21 33
+
+CELL_TYPES 41
+12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 
+9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 
+
+
+CELL_DATA 41
+SCALARS MaterialID int 1
+LOOKUP_TABLE default
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+2 2 2 4 4 4 1 1 1 1 3 3 3 3 5 5 5 5 2 2 2 2 4 4 4 4 
+
+
+SCALARS ManifoldID int 1
+LOOKUP_TABLE default
+-1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 
+-1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 
+# vtk DataFile Version 3.0
+Triangulation generated with deal.II
+ASCII
+DATASET UNSTRUCTURED_GRID
+POINTS 46 double
+0.00000 0.00000 0.00000
+1.00000 0.00000 0.00000
+0.00000 1.00000 0.00000
+1.00000 1.00000 0.00000
+0.00000 0.00000 1.00000
+1.00000 0.00000 1.00000
+0.00000 1.00000 1.00000
+1.00000 1.00000 1.00000
+0.500000 0.00000 0.00000
+0.00000 0.500000 0.00000
+0.00000 0.00000 0.500000
+1.00000 0.500000 0.00000
+1.00000 0.00000 0.500000
+0.500000 1.00000 0.00000
+0.00000 1.00000 0.500000
+1.00000 1.00000 0.500000
+0.500000 0.00000 1.00000
+0.00000 0.500000 1.00000
+1.00000 0.500000 1.00000
+0.500000 1.00000 1.00000
+0.500000 0.00000 0.500000
+0.500000 0.500000 0.00000
+0.00000 0.500000 0.500000
+1.00000 0.500000 0.500000
+0.500000 1.00000 0.500000
+0.500000 0.500000 1.00000
+0.500000 0.500000 0.500000
+0.250000 0.00000 0.00000
+0.00000 0.250000 0.00000
+0.00000 0.00000 0.250000
+0.250000 0.00000 0.500000
+0.500000 0.00000 0.250000
+0.500000 0.250000 0.00000
+0.250000 0.500000 0.00000
+0.00000 0.500000 0.250000
+0.00000 0.250000 0.500000
+0.500000 0.500000 0.250000
+0.250000 0.500000 0.500000
+0.500000 0.250000 0.500000
+0.250000 0.00000 0.250000
+0.250000 0.250000 0.00000
+0.00000 0.250000 0.250000
+0.250000 0.250000 0.500000
+0.250000 0.500000 0.250000
+0.500000 0.250000 0.250000
+0.250000 0.250000 0.250000
+
+CELLS 41 265
+8 8 1 12 20 21 11 23 26
+8 9 21 26 22 2 13 24 14
+8 21 11 23 26 13 3 15 24
+8 10 20 16 4 22 26 25 17
+8 20 12 5 16 26 23 18 25
+8 22 26 25 17 14 24 19 6
+8 26 23 18 25 24 15 7 19
+8 0 27 39 29 28 40 45 41
+8 27 8 31 39 40 32 44 45
+8 28 40 45 41 9 33 43 34
+8 40 32 44 45 33 21 36 43
+8 29 39 30 10 41 45 42 35
+8 39 31 20 30 45 44 38 42
+8 41 45 42 35 34 43 37 22
+8 45 44 38 42 43 36 26 37
+4 0 29 39 27
+4 0 27 40 28
+4 1 11 23 12
+4 2 14 24 13
+4 4 16 25 17
+4 8 20 12 1
+4 8 1 11 21
+4 9 21 13 2
+4 10 4 16 20
+4 11 3 15 23
+4 12 23 18 5
+4 13 24 15 3
+4 14 6 19 24
+4 16 5 18 25
+4 17 25 19 6
+4 20 16 5 12
+4 21 11 3 13
+4 23 15 7 18
+4 24 19 7 15
+4 25 18 7 19
+4 27 39 31 8
+4 27 8 32 40
+4 28 40 33 9
+4 29 10 30 39
+4 39 30 20 31
+4 40 32 21 33
+
+CELL_TYPES 41
+12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 
+9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 
+
+
+CELL_DATA 41
+SCALARS MaterialID int 1
+LOOKUP_TABLE default
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+2 4 1 3 5 2 4 4 2 1 1 3 3 5 5 2 4 1 3 5 2 4 4 2 2 4 
+
+
+SCALARS ManifoldID int 1
+LOOKUP_TABLE default
+-1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 
+-1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 
+
+# vtk DataFile Version 3.0
+Triangulation generated with deal.II
+ASCII
+DATASET UNSTRUCTURED_GRID
+POINTS 46 double
+0.00000 0.00000 0.00000
+1.00000 0.00000 0.00000
+0.00000 1.00000 0.00000
+1.00000 1.00000 0.00000
+0.00000 0.00000 1.00000
+1.00000 0.00000 1.00000
+0.00000 1.00000 1.00000
+1.00000 1.00000 1.00000
+0.500000 0.00000 0.00000
+0.00000 0.500000 0.00000
+0.00000 0.00000 0.500000
+1.00000 0.500000 0.00000
+1.00000 0.00000 0.500000
+0.500000 1.00000 0.00000
+0.00000 1.00000 0.500000
+1.00000 1.00000 0.500000
+0.500000 0.00000 1.00000
+0.00000 0.500000 1.00000
+1.00000 0.500000 1.00000
+0.500000 1.00000 1.00000
+0.500000 0.00000 0.500000
+0.500000 0.500000 0.00000
+0.00000 0.500000 0.500000
+1.00000 0.500000 0.500000
+0.500000 1.00000 0.500000
+0.500000 0.500000 1.00000
+0.500000 0.500000 0.500000
+0.250000 0.00000 0.00000
+0.00000 0.250000 0.00000
+0.00000 0.00000 0.250000
+0.250000 0.00000 0.500000
+0.500000 0.00000 0.250000
+0.500000 0.250000 0.00000
+0.250000 0.500000 0.00000
+0.00000 0.500000 0.250000
+0.00000 0.250000 0.500000
+0.500000 0.500000 0.250000
+0.250000 0.500000 0.500000
+0.500000 0.250000 0.500000
+0.250000 0.00000 0.250000
+0.250000 0.250000 0.00000
+0.00000 0.250000 0.250000
+0.250000 0.250000 0.500000
+0.250000 0.500000 0.250000
+0.500000 0.250000 0.250000
+0.250000 0.250000 0.250000
+
+CELLS 73 361
+8 8 1 12 20 21 11 23 26
+8 9 21 26 22 2 13 24 14
+8 21 11 23 26 13 3 15 24
+8 10 20 16 4 22 26 25 17
+8 20 12 5 16 26 23 18 25
+8 22 26 25 17 14 24 19 6
+8 26 23 18 25 24 15 7 19
+8 0 27 39 29 28 40 45 41
+8 27 8 31 39 40 32 44 45
+8 28 40 45 41 9 33 43 34
+8 40 32 44 45 33 21 36 43
+8 29 39 30 10 41 45 42 35
+8 39 31 20 30 45 44 38 42
+8 41 45 42 35 34 43 37 22
+8 45 44 38 42 43 36 26 37
+4 10 4 16 20
+4 8 20 12 1
+4 20 16 5 12
+4 8 1 11 21
+4 9 21 13 2
+4 21 11 3 13
+4 1 11 23 12
+4 11 3 15 23
+4 12 23 18 5
+4 23 15 7 18
+4 2 14 24 13
+4 14 6 19 24
+4 13 24 15 3
+4 24 19 7 15
+4 4 16 25 17
+4 16 5 18 25
+4 17 25 19 6
+4 25 18 7 19
+4 0 29 39 27
+4 29 10 30 39
+4 27 39 31 8
+4 39 30 20 31
+4 0 27 40 28
+4 27 8 32 40
+4 28 40 33 9
+4 40 32 21 33
+2 20 16
+2 20 12
+2 21 11
+2 21 13
+2 11 23
+2 12 23
+2 23 15
+2 23 18
+2 14 24
+2 13 24
+2 24 19
+2 24 15
+2 16 25
+2 17 25
+2 25 18
+2 25 19
+2 29 39
+2 27 39
+2 10 30
+2 39 30
+2 39 31
+2 8 31
+2 30 20
+2 31 20
+2 27 40
+2 28 40
+2 8 32
+2 40 32
+2 40 33
+2 9 33
+2 32 21
+2 33 21
+
+CELL_TYPES 73
+12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 
+9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 
+3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 
+
+CELL_DATA 73
+SCALARS MaterialID int 1
+LOOKUP_TABLE default
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+2 2 2 4 4 4 1 1 1 1 3 3 3 3 5 5 5 5 2 2 2 2 4 4 4 4 
+2 2 4 4 1 1 1 1 3 3 3 3 5 5 5 5 2 2 2 2 2 2 2 2 4 4 4 4 4 4 4 4 
+
+SCALARS ManifoldID int 1
+LOOKUP_TABLE default
+-1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 
+-1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 
+-1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 
+# vtk DataFile Version 3.0
+Triangulation generated with deal.II
+ASCII
+DATASET UNSTRUCTURED_GRID
+POINTS 46 double
+0.00000 0.00000 0.00000
+1.00000 0.00000 0.00000
+0.00000 1.00000 0.00000
+1.00000 1.00000 0.00000
+0.00000 0.00000 1.00000
+1.00000 0.00000 1.00000
+0.00000 1.00000 1.00000
+1.00000 1.00000 1.00000
+0.500000 0.00000 0.00000
+0.00000 0.500000 0.00000
+0.00000 0.00000 0.500000
+1.00000 0.500000 0.00000
+1.00000 0.00000 0.500000
+0.500000 1.00000 0.00000
+0.00000 1.00000 0.500000
+1.00000 1.00000 0.500000
+0.500000 0.00000 1.00000
+0.00000 0.500000 1.00000
+1.00000 0.500000 1.00000
+0.500000 1.00000 1.00000
+0.500000 0.00000 0.500000
+0.500000 0.500000 0.00000
+0.00000 0.500000 0.500000
+1.00000 0.500000 0.500000
+0.500000 1.00000 0.500000
+0.500000 0.500000 1.00000
+0.500000 0.500000 0.500000
+0.250000 0.00000 0.00000
+0.00000 0.250000 0.00000
+0.00000 0.00000 0.250000
+0.250000 0.00000 0.500000
+0.500000 0.00000 0.250000
+0.500000 0.250000 0.00000
+0.250000 0.500000 0.00000
+0.00000 0.500000 0.250000
+0.00000 0.250000 0.500000
+0.500000 0.500000 0.250000
+0.250000 0.500000 0.500000
+0.500000 0.250000 0.500000
+0.250000 0.00000 0.250000
+0.250000 0.250000 0.00000
+0.00000 0.250000 0.250000
+0.250000 0.250000 0.500000
+0.250000 0.500000 0.250000
+0.500000 0.250000 0.250000
+0.250000 0.250000 0.250000
+
+CELLS 73 361
+8 8 1 12 20 21 11 23 26
+8 9 21 26 22 2 13 24 14
+8 21 11 23 26 13 3 15 24
+8 10 20 16 4 22 26 25 17
+8 20 12 5 16 26 23 18 25
+8 22 26 25 17 14 24 19 6
+8 26 23 18 25 24 15 7 19
+8 0 27 39 29 28 40 45 41
+8 27 8 31 39 40 32 44 45
+8 28 40 45 41 9 33 43 34
+8 40 32 44 45 33 21 36 43
+8 29 39 30 10 41 45 42 35
+8 39 31 20 30 45 44 38 42
+8 41 45 42 35 34 43 37 22
+8 45 44 38 42 43 36 26 37
+4 0 29 39 27
+4 0 27 40 28
+4 1 11 23 12
+4 2 14 24 13
+4 4 16 25 17
+4 8 20 12 1
+4 8 1 11 21
+4 9 21 13 2
+4 10 4 16 20
+4 11 3 15 23
+4 12 23 18 5
+4 13 24 15 3
+4 14 6 19 24
+4 16 5 18 25
+4 17 25 19 6
+4 20 16 5 12
+4 21 11 3 13
+4 23 15 7 18
+4 24 19 7 15
+4 25 18 7 19
+4 27 39 31 8
+4 27 8 32 40
+4 28 40 33 9
+4 29 10 30 39
+4 39 30 20 31
+4 40 32 21 33
+2 29 39
+2 27 39
+2 27 40
+2 28 40
+2 11 23
+2 12 23
+2 14 24
+2 13 24
+2 16 25
+2 17 25
+2 20 12
+2 21 11
+2 8 31
+2 8 32
+2 21 13
+2 9 33
+2 20 16
+2 10 30
+2 23 15
+2 23 18
+2 24 15
+2 24 19
+2 25 18
+2 25 19
+2 39 31
+2 40 32
+2 40 33
+2 39 30
+2 30 20
+2 31 20
+2 32 21
+2 33 21
+
+CELL_TYPES 73
+12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 
+9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 
+3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 
+
+CELL_DATA 73
+SCALARS MaterialID int 1
+LOOKUP_TABLE default
+0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+2 4 1 3 5 2 4 4 2 1 1 3 3 5 5 2 4 1 3 5 2 4 4 2 2 4 
+2 2 4 4 1 1 3 3 5 5 2 4 2 4 4 4 2 2 1 1 3 3 5 5 2 4 4 2 2 2 4 4 
+
+SCALARS ManifoldID int 1
+LOOKUP_TABLE default
+-1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 
+-1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 
+-1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 -1 

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.