]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Add another test for simplex-mesh DataOutFaces.
authorWolfgang Bangerth <bangerth@colostate.edu>
Thu, 28 Oct 2021 20:54:09 +0000 (14:54 -0600)
committerWolfgang Bangerth <bangerth@colostate.edu>
Thu, 28 Oct 2021 23:05:31 +0000 (17:05 -0600)
tests/simplex/data_out_faces_01.cc [new file with mode: 0644]
tests/simplex/data_out_faces_01.output [new file with mode: 0644]

diff --git a/tests/simplex/data_out_faces_01.cc b/tests/simplex/data_out_faces_01.cc
new file mode 100644 (file)
index 0000000..e5fe7de
--- /dev/null
@@ -0,0 +1,107 @@
+// ---------------------------------------------------------------------
+//
+// Copyright (C) 2020 - 2021 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 DataOutFaces::write_vtk() for simplex meshes.
+
+#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_system.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/grid_in.h>
+#include <deal.II/grid/grid_out.h>
+#include <deal.II/grid/tria.h>
+
+#include <deal.II/numerics/data_out_faces.h>
+#include <deal.II/numerics/vector_tools.h>
+
+#include "../tests.h"
+
+using namespace dealii;
+
+template <int dim>
+class RightHandSideFunction : public Function<dim>
+{
+public:
+  RightHandSideFunction(const unsigned int n_components)
+    : Function<dim>(n_components)
+  {}
+
+  virtual double
+  value(const Point<dim> &p, const unsigned int component = 0) const
+  {
+    return p[component % dim] * p[component % dim];
+  }
+};
+
+template <int dim, int spacedim = dim>
+void
+test(const FiniteElement<dim, spacedim> &fe, const unsigned int n_components)
+{
+  Triangulation<dim, spacedim> tria;
+  GridGenerator::subdivided_hyper_cube_with_simplices(tria, dim == 2 ? 4 : 2);
+
+  DoFHandler<dim> dof_handler(tria);
+  dof_handler.distribute_dofs(fe);
+
+  Vector<double> solution(dof_handler.n_dofs());
+
+  VectorTools::interpolate(dof_handler,
+                           RightHandSideFunction<dim>(n_components),
+                           solution);
+
+  DataOutFaces<dim> data_out;
+
+  data_out.attach_dof_handler(dof_handler);
+  data_out.add_data_vector(solution, "solution");
+
+  data_out.build_patches();
+
+#if true
+  static unsigned int counter = 0;
+  std::ofstream       output("test." + std::to_string(dim) +
+                       std::to_string(counter++) + ".vtk");
+  data_out.write_vtk(output);
+#endif
+
+  data_out.write_vtk(deallog.get_file_stream());
+}
+
+int
+main()
+{
+  initlog();
+
+  {
+    const int dim = 2;
+    test<dim>(FE_SimplexP<dim>(2) /*=degree*/, 1);
+    test<dim>(FESystem<dim>(FE_SimplexP<dim>(2 /*=degree*/), dim), dim);
+  }
+
+  {
+    const int dim = 3;
+    test<dim>(FE_SimplexP<dim>(2) /*=degree*/, 1);
+    test<dim>(FESystem<dim>(FE_SimplexP<dim>(2 /*=degree*/), dim), dim);
+  }
+}
diff --git a/tests/simplex/data_out_faces_01.output b/tests/simplex/data_out_faces_01.output
new file mode 100644 (file)
index 0000000..ae8e5dc
--- /dev/null
@@ -0,0 +1,550 @@
+
+# vtk DataFile Version 3.0
+#This file was generated 
+ASCII
+DATASET UNSTRUCTURED_GRID
+
+POINTS 32 double
+0.00000 0.00000 0
+0.250000 0.00000 0
+0.00000 0.250000 0
+0.00000 0.00000 0
+0.250000 0.00000 0
+0.500000 0.00000 0
+0.500000 0.00000 0
+0.750000 0.00000 0
+0.750000 0.00000 0
+1.00000 0.00000 0
+1.00000 0.00000 0
+1.00000 0.250000 0
+0.00000 0.500000 0
+0.00000 0.250000 0
+1.00000 0.250000 0
+1.00000 0.500000 0
+0.00000 0.750000 0
+0.00000 0.500000 0
+1.00000 0.500000 0
+1.00000 0.750000 0
+0.00000 1.00000 0
+0.00000 0.750000 0
+0.250000 1.00000 0
+0.00000 1.00000 0
+0.500000 1.00000 0
+0.250000 1.00000 0
+0.750000 1.00000 0
+0.500000 1.00000 0
+1.00000 1.00000 0
+0.750000 1.00000 0
+1.00000 0.750000 0
+1.00000 1.00000 0
+
+CELLS 16 48
+2      0       1
+2      2       3
+2      4       5
+2      6       7
+2      8       9
+2      10      11
+2      12      13
+2      14      15
+2      16      17
+2      18      19
+2      20      21
+2      22      23
+2      24      25
+2      26      27
+2      28      29
+2      30      31
+
+CELL_TYPES 16
+ 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3
+POINT_DATA 32
+SCALARS solution double 1
+LOOKUP_TABLE default
+0.00000 0.0625000 0.00000 0.00000 0.0625000 0.250000 0.250000 0.562500 0.562500 1.00000 1.00000 1.00000 0.00000 0.00000 1.00000 1.00000 0.00000 0.00000 1.00000 1.00000 0.00000 0.00000 0.0625000 0.00000 0.250000 0.0625000 0.562500 0.250000 1.00000 0.562500 1.00000 1.00000 
+# vtk DataFile Version 3.0
+#This file was generated 
+ASCII
+DATASET UNSTRUCTURED_GRID
+
+POINTS 32 double
+0.00000 0.00000 0
+0.250000 0.00000 0
+0.00000 0.250000 0
+0.00000 0.00000 0
+0.250000 0.00000 0
+0.500000 0.00000 0
+0.500000 0.00000 0
+0.750000 0.00000 0
+0.750000 0.00000 0
+1.00000 0.00000 0
+1.00000 0.00000 0
+1.00000 0.250000 0
+0.00000 0.500000 0
+0.00000 0.250000 0
+1.00000 0.250000 0
+1.00000 0.500000 0
+0.00000 0.750000 0
+0.00000 0.500000 0
+1.00000 0.500000 0
+1.00000 0.750000 0
+0.00000 1.00000 0
+0.00000 0.750000 0
+0.250000 1.00000 0
+0.00000 1.00000 0
+0.500000 1.00000 0
+0.250000 1.00000 0
+0.750000 1.00000 0
+0.500000 1.00000 0
+1.00000 1.00000 0
+0.750000 1.00000 0
+1.00000 0.750000 0
+1.00000 1.00000 0
+
+CELLS 16 48
+2      0       1
+2      2       3
+2      4       5
+2      6       7
+2      8       9
+2      10      11
+2      12      13
+2      14      15
+2      16      17
+2      18      19
+2      20      21
+2      22      23
+2      24      25
+2      26      27
+2      28      29
+2      30      31
+
+CELL_TYPES 16
+ 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3
+POINT_DATA 32
+SCALARS solution_0 double 1
+LOOKUP_TABLE default
+0.00000 0.0625000 0.00000 0.00000 0.0625000 0.250000 0.250000 0.562500 0.562500 1.00000 1.00000 1.00000 0.00000 0.00000 1.00000 1.00000 0.00000 0.00000 1.00000 1.00000 0.00000 0.00000 0.0625000 0.00000 0.250000 0.0625000 0.562500 0.250000 1.00000 0.562500 1.00000 1.00000 
+SCALARS solution_1 double 1
+LOOKUP_TABLE default
+0.00000 0.00000 0.0625000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.0625000 0.250000 0.0625000 0.0625000 0.250000 0.562500 0.250000 0.250000 0.562500 1.00000 0.562500 1.00000 1.00000 1.00000 1.00000 1.00000 1.00000 1.00000 1.00000 0.562500 1.00000 
+# vtk DataFile Version 3.0
+#This file was generated 
+ASCII
+DATASET UNSTRUCTURED_GRID
+
+POINTS 144 double
+0.00000 0.00000 0.00000
+0.500000 0.00000 0.00000
+0.00000 0.500000 0.00000
+0.500000 0.00000 0.00000
+0.00000 0.00000 0.00000
+0.00000 0.00000 0.500000
+0.00000 0.00000 0.00000
+0.00000 0.500000 0.00000
+0.00000 0.00000 0.500000
+0.00000 0.500000 0.00000
+0.500000 0.00000 0.00000
+0.500000 0.500000 0.00000
+0.500000 0.00000 0.00000
+0.00000 0.00000 0.500000
+0.500000 0.00000 0.500000
+0.00000 0.00000 0.500000
+0.00000 0.500000 0.00000
+0.00000 0.500000 0.500000
+0.500000 0.00000 0.00000
+1.00000 0.00000 0.00000
+1.00000 0.500000 0.00000
+1.00000 0.00000 0.00000
+0.500000 0.00000 0.00000
+1.00000 0.00000 0.500000
+1.00000 0.500000 0.00000
+1.00000 0.00000 0.00000
+1.00000 0.00000 0.500000
+0.500000 0.00000 0.00000
+1.00000 0.500000 0.00000
+0.500000 0.500000 0.00000
+0.500000 0.00000 0.00000
+0.500000 0.00000 0.500000
+1.00000 0.00000 0.500000
+1.00000 0.500000 0.00000
+1.00000 0.00000 0.500000
+1.00000 0.500000 0.500000
+0.00000 0.500000 0.00000
+0.500000 0.500000 0.00000
+0.500000 1.00000 0.00000
+0.00000 0.500000 0.00000
+0.500000 1.00000 0.00000
+0.00000 1.00000 0.00000
+0.00000 0.500000 0.00000
+0.00000 1.00000 0.00000
+0.00000 1.00000 0.500000
+0.00000 1.00000 0.00000
+0.500000 1.00000 0.00000
+0.00000 1.00000 0.500000
+0.00000 0.500000 0.500000
+0.00000 0.500000 0.00000
+0.00000 1.00000 0.500000
+0.500000 1.00000 0.00000
+0.500000 1.00000 0.500000
+0.00000 1.00000 0.500000
+0.500000 0.500000 0.00000
+1.00000 0.500000 0.00000
+0.500000 1.00000 0.00000
+0.500000 1.00000 0.00000
+1.00000 0.500000 0.00000
+1.00000 1.00000 0.00000
+0.500000 1.00000 0.00000
+1.00000 1.00000 0.00000
+1.00000 1.00000 0.500000
+1.00000 1.00000 0.00000
+1.00000 0.500000 0.00000
+1.00000 1.00000 0.500000
+1.00000 0.500000 0.00000
+1.00000 0.500000 0.500000
+1.00000 1.00000 0.500000
+0.500000 1.00000 0.00000
+1.00000 1.00000 0.500000
+0.500000 1.00000 0.500000
+0.500000 0.00000 0.500000
+0.00000 0.00000 0.500000
+0.500000 0.00000 1.00000
+0.00000 0.00000 0.500000
+0.00000 0.500000 0.500000
+0.00000 0.500000 1.00000
+0.00000 0.00000 0.500000
+0.00000 0.00000 1.00000
+0.500000 0.00000 1.00000
+0.00000 0.00000 1.00000
+0.00000 0.00000 0.500000
+0.00000 0.500000 1.00000
+0.500000 0.00000 1.00000
+0.00000 0.00000 1.00000
+0.00000 0.500000 1.00000
+0.500000 0.500000 1.00000
+0.500000 0.00000 1.00000
+0.00000 0.500000 1.00000
+1.00000 0.00000 0.500000
+0.500000 0.00000 0.500000
+0.500000 0.00000 1.00000
+1.00000 0.500000 0.500000
+1.00000 0.00000 0.500000
+1.00000 0.500000 1.00000
+1.00000 0.00000 0.500000
+0.500000 0.00000 1.00000
+1.00000 0.00000 1.00000
+1.00000 0.00000 0.500000
+1.00000 0.00000 1.00000
+1.00000 0.500000 1.00000
+1.00000 0.00000 1.00000
+0.500000 0.00000 1.00000
+1.00000 0.500000 1.00000
+1.00000 0.500000 1.00000
+0.500000 0.00000 1.00000
+0.500000 0.500000 1.00000
+0.00000 0.500000 0.500000
+0.00000 1.00000 0.500000
+0.00000 0.500000 1.00000
+0.00000 1.00000 0.500000
+0.500000 1.00000 0.500000
+0.500000 1.00000 1.00000
+0.500000 0.500000 1.00000
+0.00000 0.500000 1.00000
+0.500000 1.00000 1.00000
+0.00000 0.500000 1.00000
+0.00000 1.00000 0.500000
+0.00000 1.00000 1.00000
+0.00000 1.00000 0.500000
+0.500000 1.00000 1.00000
+0.00000 1.00000 1.00000
+0.500000 1.00000 1.00000
+0.00000 0.500000 1.00000
+0.00000 1.00000 1.00000
+1.00000 1.00000 0.500000
+1.00000 0.500000 0.500000
+1.00000 0.500000 1.00000
+0.500000 1.00000 0.500000
+1.00000 1.00000 0.500000
+0.500000 1.00000 1.00000
+1.00000 0.500000 1.00000
+0.500000 0.500000 1.00000
+0.500000 1.00000 1.00000
+1.00000 1.00000 0.500000
+1.00000 0.500000 1.00000
+1.00000 1.00000 1.00000
+1.00000 1.00000 0.500000
+1.00000 1.00000 1.00000
+0.500000 1.00000 1.00000
+1.00000 1.00000 1.00000
+1.00000 0.500000 1.00000
+0.500000 1.00000 1.00000
+
+CELLS 48 192
+       3       0       1       2
+       3       3       4       5
+       3       6       7       8
+       3       9       10      11
+       3       12      13      14
+       3       15      16      17
+       3       18      19      20
+       3       21      22      23
+       3       24      25      26
+       3       27      28      29
+       3       30      31      32
+       3       33      34      35
+       3       36      37      38
+       3       39      40      41
+       3       42      43      44
+       3       45      46      47
+       3       48      49      50
+       3       51      52      53
+       3       54      55      56
+       3       57      58      59
+       3       60      61      62
+       3       63      64      65
+       3       66      67      68
+       3       69      70      71
+       3       72      73      74
+       3       75      76      77
+       3       78      79      80
+       3       81      82      83
+       3       84      85      86
+       3       87      88      89
+       3       90      91      92
+       3       93      94      95
+       3       96      97      98
+       3       99      100     101
+       3       102     103     104
+       3       105     106     107
+       3       108     109     110
+       3       111     112     113
+       3       114     115     116
+       3       117     118     119
+       3       120     121     122
+       3       123     124     125
+       3       126     127     128
+       3       129     130     131
+       3       132     133     134
+       3       135     136     137
+       3       138     139     140
+       3       141     142     143
+
+CELL_TYPES 48
+ 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5
+POINT_DATA 144
+SCALARS solution double 1
+LOOKUP_TABLE default
+0.00000 0.250000 0.00000 0.250000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.250000 0.250000 0.250000 0.00000 0.250000 0.00000 0.00000 0.00000 0.250000 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 1.00000 1.00000 0.250000 1.00000 0.250000 0.250000 0.250000 1.00000 1.00000 1.00000 1.00000 0.00000 0.250000 0.250000 0.00000 0.250000 0.00000 0.00000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.00000 0.250000 0.250000 0.00000 0.250000 1.00000 0.250000 0.250000 1.00000 1.00000 0.250000 1.00000 1.00000 1.00000 1.00000 1.00000 1.00000 1.00000 1.00000 0.250000 1.00000 0.250000 0.250000 0.00000 0.250000 0.00000 0.00000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.250000 0.250000 0.00000 1.00000 0.250000 0.250000 1.00000 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 0.250000 0.250000 0.00000 0.00000 0.00000 0.00000 0.250000 0.250000 0.250000 0.00000 0.250000 0.00000 0.00000 0.00000 0.00000 0.250000 0.00000 0.250000 0.00000 0.00000 1.00000 1.00000 1.00000 0.250000 1.00000 0.250000 1.00000 0.250000 0.250000 1.00000 1.00000 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 0.250000 
+# vtk DataFile Version 3.0
+#This file was generated 
+ASCII
+DATASET UNSTRUCTURED_GRID
+
+POINTS 144 double
+0.00000 0.00000 0.00000
+0.500000 0.00000 0.00000
+0.00000 0.500000 0.00000
+0.500000 0.00000 0.00000
+0.00000 0.00000 0.00000
+0.00000 0.00000 0.500000
+0.00000 0.00000 0.00000
+0.00000 0.500000 0.00000
+0.00000 0.00000 0.500000
+0.00000 0.500000 0.00000
+0.500000 0.00000 0.00000
+0.500000 0.500000 0.00000
+0.500000 0.00000 0.00000
+0.00000 0.00000 0.500000
+0.500000 0.00000 0.500000
+0.00000 0.00000 0.500000
+0.00000 0.500000 0.00000
+0.00000 0.500000 0.500000
+0.500000 0.00000 0.00000
+1.00000 0.00000 0.00000
+1.00000 0.500000 0.00000
+1.00000 0.00000 0.00000
+0.500000 0.00000 0.00000
+1.00000 0.00000 0.500000
+1.00000 0.500000 0.00000
+1.00000 0.00000 0.00000
+1.00000 0.00000 0.500000
+0.500000 0.00000 0.00000
+1.00000 0.500000 0.00000
+0.500000 0.500000 0.00000
+0.500000 0.00000 0.00000
+0.500000 0.00000 0.500000
+1.00000 0.00000 0.500000
+1.00000 0.500000 0.00000
+1.00000 0.00000 0.500000
+1.00000 0.500000 0.500000
+0.00000 0.500000 0.00000
+0.500000 0.500000 0.00000
+0.500000 1.00000 0.00000
+0.00000 0.500000 0.00000
+0.500000 1.00000 0.00000
+0.00000 1.00000 0.00000
+0.00000 0.500000 0.00000
+0.00000 1.00000 0.00000
+0.00000 1.00000 0.500000
+0.00000 1.00000 0.00000
+0.500000 1.00000 0.00000
+0.00000 1.00000 0.500000
+0.00000 0.500000 0.500000
+0.00000 0.500000 0.00000
+0.00000 1.00000 0.500000
+0.500000 1.00000 0.00000
+0.500000 1.00000 0.500000
+0.00000 1.00000 0.500000
+0.500000 0.500000 0.00000
+1.00000 0.500000 0.00000
+0.500000 1.00000 0.00000
+0.500000 1.00000 0.00000
+1.00000 0.500000 0.00000
+1.00000 1.00000 0.00000
+0.500000 1.00000 0.00000
+1.00000 1.00000 0.00000
+1.00000 1.00000 0.500000
+1.00000 1.00000 0.00000
+1.00000 0.500000 0.00000
+1.00000 1.00000 0.500000
+1.00000 0.500000 0.00000
+1.00000 0.500000 0.500000
+1.00000 1.00000 0.500000
+0.500000 1.00000 0.00000
+1.00000 1.00000 0.500000
+0.500000 1.00000 0.500000
+0.500000 0.00000 0.500000
+0.00000 0.00000 0.500000
+0.500000 0.00000 1.00000
+0.00000 0.00000 0.500000
+0.00000 0.500000 0.500000
+0.00000 0.500000 1.00000
+0.00000 0.00000 0.500000
+0.00000 0.00000 1.00000
+0.500000 0.00000 1.00000
+0.00000 0.00000 1.00000
+0.00000 0.00000 0.500000
+0.00000 0.500000 1.00000
+0.500000 0.00000 1.00000
+0.00000 0.00000 1.00000
+0.00000 0.500000 1.00000
+0.500000 0.500000 1.00000
+0.500000 0.00000 1.00000
+0.00000 0.500000 1.00000
+1.00000 0.00000 0.500000
+0.500000 0.00000 0.500000
+0.500000 0.00000 1.00000
+1.00000 0.500000 0.500000
+1.00000 0.00000 0.500000
+1.00000 0.500000 1.00000
+1.00000 0.00000 0.500000
+0.500000 0.00000 1.00000
+1.00000 0.00000 1.00000
+1.00000 0.00000 0.500000
+1.00000 0.00000 1.00000
+1.00000 0.500000 1.00000
+1.00000 0.00000 1.00000
+0.500000 0.00000 1.00000
+1.00000 0.500000 1.00000
+1.00000 0.500000 1.00000
+0.500000 0.00000 1.00000
+0.500000 0.500000 1.00000
+0.00000 0.500000 0.500000
+0.00000 1.00000 0.500000
+0.00000 0.500000 1.00000
+0.00000 1.00000 0.500000
+0.500000 1.00000 0.500000
+0.500000 1.00000 1.00000
+0.500000 0.500000 1.00000
+0.00000 0.500000 1.00000
+0.500000 1.00000 1.00000
+0.00000 0.500000 1.00000
+0.00000 1.00000 0.500000
+0.00000 1.00000 1.00000
+0.00000 1.00000 0.500000
+0.500000 1.00000 1.00000
+0.00000 1.00000 1.00000
+0.500000 1.00000 1.00000
+0.00000 0.500000 1.00000
+0.00000 1.00000 1.00000
+1.00000 1.00000 0.500000
+1.00000 0.500000 0.500000
+1.00000 0.500000 1.00000
+0.500000 1.00000 0.500000
+1.00000 1.00000 0.500000
+0.500000 1.00000 1.00000
+1.00000 0.500000 1.00000
+0.500000 0.500000 1.00000
+0.500000 1.00000 1.00000
+1.00000 1.00000 0.500000
+1.00000 0.500000 1.00000
+1.00000 1.00000 1.00000
+1.00000 1.00000 0.500000
+1.00000 1.00000 1.00000
+0.500000 1.00000 1.00000
+1.00000 1.00000 1.00000
+1.00000 0.500000 1.00000
+0.500000 1.00000 1.00000
+
+CELLS 48 192
+       3       0       1       2
+       3       3       4       5
+       3       6       7       8
+       3       9       10      11
+       3       12      13      14
+       3       15      16      17
+       3       18      19      20
+       3       21      22      23
+       3       24      25      26
+       3       27      28      29
+       3       30      31      32
+       3       33      34      35
+       3       36      37      38
+       3       39      40      41
+       3       42      43      44
+       3       45      46      47
+       3       48      49      50
+       3       51      52      53
+       3       54      55      56
+       3       57      58      59
+       3       60      61      62
+       3       63      64      65
+       3       66      67      68
+       3       69      70      71
+       3       72      73      74
+       3       75      76      77
+       3       78      79      80
+       3       81      82      83
+       3       84      85      86
+       3       87      88      89
+       3       90      91      92
+       3       93      94      95
+       3       96      97      98
+       3       99      100     101
+       3       102     103     104
+       3       105     106     107
+       3       108     109     110
+       3       111     112     113
+       3       114     115     116
+       3       117     118     119
+       3       120     121     122
+       3       123     124     125
+       3       126     127     128
+       3       129     130     131
+       3       132     133     134
+       3       135     136     137
+       3       138     139     140
+       3       141     142     143
+
+CELL_TYPES 48
+ 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5
+POINT_DATA 144
+SCALARS solution_0 double 1
+LOOKUP_TABLE default
+0.00000 0.250000 0.00000 0.250000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.250000 0.250000 0.250000 0.00000 0.250000 0.00000 0.00000 0.00000 0.250000 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 1.00000 1.00000 0.250000 1.00000 0.250000 0.250000 0.250000 1.00000 1.00000 1.00000 1.00000 0.00000 0.250000 0.250000 0.00000 0.250000 0.00000 0.00000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.00000 0.250000 0.250000 0.00000 0.250000 1.00000 0.250000 0.250000 1.00000 1.00000 0.250000 1.00000 1.00000 1.00000 1.00000 1.00000 1.00000 1.00000 1.00000 0.250000 1.00000 0.250000 0.250000 0.00000 0.250000 0.00000 0.00000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.250000 0.250000 0.00000 1.00000 0.250000 0.250000 1.00000 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 0.250000 0.250000 0.00000 0.00000 0.00000 0.00000 0.250000 0.250000 0.250000 0.00000 0.250000 0.00000 0.00000 0.00000 0.00000 0.250000 0.00000 0.250000 0.00000 0.00000 1.00000 1.00000 1.00000 0.250000 1.00000 0.250000 1.00000 0.250000 0.250000 1.00000 1.00000 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 0.250000 
+SCALARS solution_1 double 1
+LOOKUP_TABLE default
+0.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.00000 0.250000 0.00000 0.250000 0.00000 0.250000 0.00000 0.00000 0.00000 0.00000 0.250000 0.250000 0.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.250000 0.250000 0.00000 0.00000 0.00000 0.250000 0.00000 0.250000 0.250000 0.250000 1.00000 0.250000 1.00000 1.00000 0.250000 1.00000 1.00000 1.00000 1.00000 1.00000 0.250000 0.250000 1.00000 1.00000 1.00000 1.00000 0.250000 0.250000 1.00000 1.00000 0.250000 1.00000 1.00000 1.00000 1.00000 1.00000 0.250000 1.00000 0.250000 0.250000 1.00000 1.00000 1.00000 1.00000 0.00000 0.00000 0.00000 0.00000 0.250000 0.250000 0.00000 0.00000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.250000 0.250000 0.00000 0.250000 0.00000 0.00000 0.00000 0.250000 0.00000 0.250000 0.00000 0.00000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.250000 0.250000 0.00000 0.250000 0.250000 1.00000 0.250000 1.00000 1.00000 1.00000 0.250000 0.250000 1.00000 0.250000 1.00000 1.00000 1.00000 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 0.250000 0.250000 1.00000 1.00000 1.00000 0.250000 0.250000 1.00000 1.00000 0.250000 1.00000 1.00000 1.00000 1.00000 1.00000 0.250000 1.00000 
+SCALARS solution_2 double 1
+LOOKUP_TABLE default
+0.00000 0.00000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.00000 0.250000 0.250000 0.250000 0.00000 0.250000 0.00000 0.00000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.00000 0.250000 0.250000 0.00000 0.250000 0.250000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.250000 0.250000 0.00000 0.250000 0.00000 0.250000 0.250000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.250000 0.00000 0.250000 0.250000 0.00000 0.250000 0.250000 0.250000 0.250000 1.00000 0.250000 0.250000 1.00000 0.250000 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 1.00000 1.00000 1.00000 1.00000 1.00000 0.250000 0.250000 1.00000 0.250000 0.250000 1.00000 0.250000 1.00000 1.00000 0.250000 1.00000 1.00000 1.00000 1.00000 1.00000 1.00000 1.00000 1.00000 0.250000 0.250000 1.00000 0.250000 0.250000 1.00000 1.00000 1.00000 1.00000 1.00000 0.250000 1.00000 0.250000 1.00000 1.00000 1.00000 1.00000 1.00000 0.250000 0.250000 1.00000 0.250000 0.250000 1.00000 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 0.250000 1.00000 1.00000 1.00000 1.00000 1.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.