]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Read meshes with field data in read_vtk()
authorVaishnavi Kale <vaishnav@ualberta.ca>
Thu, 14 Nov 2024 23:12:28 +0000 (16:12 -0700)
committerVaishnavi Kale <vaishnav@ualberta.ca>
Thu, 14 Nov 2024 23:20:08 +0000 (16:20 -0700)
include/deal.II/grid/grid_in.h
source/grid/grid_in.cc
tests/grid/grid_in_vtk_2d_field_data.cc [new file with mode: 0644]
tests/grid/grid_in_vtk_2d_field_data.output [new file with mode: 0644]
tests/grid/grid_in_vtk_2d_field_data/mesh [new file with mode: 0644]

index b5fb6e8fa4e947183f5ecd244eb3f5a2651021d9..cc25583cb8c281e2a750b02c807903972a525d89 100644 (file)
@@ -23,6 +23,7 @@
 #include <deal.II/base/point.h>
 
 #include <iostream>
+#include <map>
 #include <string>
 #include <vector>
 
@@ -878,6 +879,17 @@ public:
       std::to_string(arg1) + " lines and " + std::to_string(arg2) +
       " facets (surface triangles or quadrilaterals).");
 
+  /**
+   * Return a map containing field data. The format of the returned map is as
+   * follows:
+   * - std::string stores the name of the field data (identifier) as specified
+   * in the external mesh
+   * - std::vector<double> stores value for the given identifier in each cell.
+   * To access the value use field_data[name_field][cell_id].
+   */
+  const std::map<std::string, std::vector<double>> &
+  get_field_data() const;
+
 protected:
   /**
    * Store address of the triangulation to be fed with the data read in.
@@ -948,6 +960,15 @@ private:
    * Input format used by read() if no format is given.
    */
   Format default_format;
+
+  /**
+   * Data member that stores cell data. The format is as follows:
+   * - std::string stores the name of the field data (identifier) as specified
+   * in the external mesh
+   * - std::vector<double> stores value for the given identifier in each
+   * cell_id. To access the value use field_data[name_field][cell_id].
+   */
+  std::map<std::string, std::vector<double>> field_data;
 };
 
 /* -------------- declaration of explicit specializations ------------- */
index 3483130d77426293c8ed9cb933bdc07c10dbba20..3609794bc0057ca252cd58e71b6f87dce877de4b 100644 (file)
@@ -163,10 +163,11 @@ GridIn<dim, spacedim>::read_vtk(std::istream &in)
 {
   std::string line;
 
-  // verify that the first, third and fourth lines match
-  // expectations. the second line of the file may essentially be
-  // anything the author of the file chose to identify what's in
-  // there, so we just ensure that we can read it
+  // verify that the third and fourth lines match
+  // expectations. the first line is not checked to allow use of
+  // different vtk versions and the second line of the file may
+  // essentially be anything the author of the file chose to
+  // identify what's in there, so we just ensure that we can read it.
   {
     std::string text[4];
     text[0] = "# vtk DataFile Version 3.0";
@@ -177,7 +178,7 @@ GridIn<dim, spacedim>::read_vtk(std::istream &in)
     for (unsigned int i = 0; i < 4; ++i)
       {
         getline(in, line);
-        if (i != 1)
+        if (i == 2 || i == 3)
           AssertThrow(
             line.compare(text[i]) == 0,
             ExcMessage(
@@ -433,35 +434,41 @@ GridIn<dim, spacedim>::read_vtk(std::istream &in)
       for (unsigned int i = 0; i < n_ints; ++i)
         in >> tmp_int;
 
+
+      // Processing the CELL_DATA and FIELD_DATA sections
+
       // Ignore everything up to CELL_DATA
       while (in >> keyword)
-        if (keyword == "CELL_DATA")
-          {
-            unsigned int n_ids;
-            in >> n_ids;
-
-            AssertThrow(n_ids == n_geometric_objects,
-                        ExcMessage("The VTK reader found a CELL_DATA statement "
-                                   "that lists a total of " +
-                                   Utilities::int_to_string(n_ids) +
-                                   " cell data objects, but this needs to "
-                                   "equal the number of cells (which is " +
-                                   Utilities::int_to_string(cells.size()) +
-                                   ") plus the number of quads (" +
-                                   Utilities::int_to_string(
-                                     subcelldata.boundary_quads.size()) +
-                                   " in 3d or the number of lines (" +
-                                   Utilities::int_to_string(
-                                     subcelldata.boundary_lines.size()) +
-                                   ") in 2d."));
-
-            const std::vector<std::string> data_sets{"MaterialID",
-                                                     "ManifoldID"};
-
-            for (unsigned int i = 0; i < data_sets.size(); ++i)
-              {
-                // Ignore everything until we get to a SCALARS data set
-                while (in >> keyword)
+        {
+          if (keyword == "CELL_DATA")
+            {
+              unsigned int n_ids;
+              in >> n_ids;
+
+              AssertThrow(
+                n_ids == n_geometric_objects,
+                ExcMessage(
+                  "The VTK reader found a CELL_DATA statement "
+                  "that lists a total of " +
+                  Utilities::int_to_string(n_ids) +
+                  " cell data objects, but this needs to "
+                  "equal the number of cells (which is " +
+                  Utilities::int_to_string(cells.size()) +
+                  ") plus the number of quads (" +
+                  Utilities::int_to_string(subcelldata.boundary_quads.size()) +
+                  " in 3d or the number of lines (" +
+                  Utilities::int_to_string(subcelldata.boundary_lines.size()) +
+                  ") in 2d."));
+
+              const std::vector<std::string> data_sets{"MaterialID",
+                                                       "ManifoldID"};
+
+              in >> keyword;
+              for (unsigned int i = 0; i < data_sets.size(); ++i)
+                {
+                  // Ignore everything until we get to a SCALARS data set
+
+                  std::cout << "keyword: " << keyword << std::endl;
                   if (keyword == "SCALARS")
                     {
                       // Now see if we know about this type of data set,
@@ -568,8 +575,76 @@ GridIn<dim, spacedim>::read_vtk(std::istream &in)
                             }
                         }
                     }
-              }
-          }
+                  // check if a second SCALAR exists. If so, read the new
+                  // keyword SCALARS, otherwise, return to the bookmarked
+                  // position.
+                  std::streampos oldpos = in.tellg();
+                  in >> keyword;
+                  if (keyword == "SCALARS")
+                    continue;
+                  else
+                    in.seekg(oldpos);
+                }
+            }
+
+
+          // Addition of FIELD DATA:
+
+
+          else if (keyword == "FIELD")
+            {
+              unsigned int n_fields;
+              in >> keyword;
+              AssertThrow(
+                keyword == "FieldData",
+                ExcMessage(
+                  "While reading VTK file, missing keyword FieldData"));
+
+              in >> n_fields;
+
+              for (unsigned int i = 0; i < n_fields; ++i)
+                {
+                  std::string  section_name;
+                  std::string  data_type;
+                  unsigned int temp, n_ids;
+                  double       data;
+                  in >> section_name;
+                  in >> temp;
+                  in >> n_ids;
+                  AssertThrow(
+                    n_ids == n_geometric_objects,
+                    ExcMessage(
+                      "The VTK reader found a FIELD statement "
+                      "that lists a total of " +
+                      Utilities::int_to_string(n_ids) +
+                      " cell data objects, but this needs to equal the number of cells (which is " +
+                      Utilities::int_to_string(cells.size()) +
+                      ") plus the number of quads (" +
+                      Utilities::int_to_string(
+                        subcelldata.boundary_quads.size()) +
+                      " in 3d or the number of lines (" +
+                      Utilities::int_to_string(
+                        subcelldata.boundary_lines.size()) +
+                      ") in 2d."));
+                  in >> data_type;
+                  std::vector<double> temp_data;
+                  temp_data.resize(n_ids);
+                  for (unsigned int j = 0; j < n_ids; ++j)
+                    {
+                      in >> data;
+                      if (j < cells.size())
+                        temp_data[j] = data;
+                    }
+                  this->field_data[section_name] = std::move(temp_data);
+                }
+            }
+          else
+            {
+              // just ignore a line that doesn't start with any of the
+              // recognized tags
+            }
+        } // end of while loop
+      Assert(subcelldata.check_consistency(dim), ExcInternalError());
 
       apply_grid_fixup_functions(vertices, cells, subcelldata);
       tria->create_triangulation(vertices, cells, subcelldata);
@@ -580,7 +655,12 @@ GridIn<dim, spacedim>::read_vtk(std::istream &in)
                   "While reading VTK file, failed to find CELLS section"));
 }
 
-
+template <int dim, int spacedim>
+const std::map<std::string, std::vector<double>> &
+GridIn<dim, spacedim>::get_field_data() const
+{
+  return this->field_data;
+}
 
 template <int dim, int spacedim>
 void
diff --git a/tests/grid/grid_in_vtk_2d_field_data.cc b/tests/grid/grid_in_vtk_2d_field_data.cc
new file mode 100644 (file)
index 0000000..c604cc5
--- /dev/null
@@ -0,0 +1,93 @@
+// ---------------------------------------------------------------------
+//
+// 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.
+//
+// ---------------------------------------------------------------------
+
+
+// read a 2d file in the VTK format with field data
+
+#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 <boost/lexical_cast.hpp>
+#include <boost/tokenizer.hpp>
+
+#include <string>
+
+#include "../tests.h"
+
+template <int dim>
+void
+check_file(const std::string name, typename GridIn<dim>::Format format)
+{
+  Triangulation<dim> triangulation;
+  GridIn<dim>        gridin;
+  GridOut            gridout;
+
+  gridin.attach_triangulation(triangulation);
+  gridin.read(name, format);
+  deallog << '\t' << triangulation.n_vertices() << '\t'
+          << triangulation.n_cells() << std::endl;
+  std::map<std::string, std::vector<double>> field_data;
+
+  field_data = gridin.get_field_data();
+  if (field_data.size() > 0)
+    {
+      std::map<std::string, std::vector<double>>::const_iterator iter =
+        field_data.find("Density");
+      if (iter != field_data.end())
+        {
+          std::vector<double> cell_density = iter->second;
+          for (typename Triangulation<dim>::active_cell_iterator cell =
+                 triangulation.begin_active();
+               cell != triangulation.end();
+               ++cell)
+            {
+              // store cell ID as a string
+              std::string text = boost::lexical_cast<std::string>(cell->id());
+              // Convert the string containing cell ID to an integer
+              boost::char_separator<char>                   sep{"_"};
+              boost::tokenizer<boost::char_separator<char>> tokens(text, sep);
+              unsigned int                                  cell_id =
+                boost::lexical_cast<int>(*(tokens.begin()));
+              deallog << '\t' << cell_density[cell_id] << std::endl;
+            }
+        }
+    }
+
+  gridout.write_gnuplot(triangulation, deallog.get_file_stream());
+}
+
+void
+filename_resolution()
+{
+  check_file<2>(std::string(SOURCE_DIR "/grid_in_vtk_2d_field_data/mesh"),
+                GridIn<2>::vtk);
+}
+
+
+int
+main()
+{
+  initlog();
+  deallog << std::setprecision(2);
+
+  filename_resolution();
+}
diff --git a/tests/grid/grid_in_vtk_2d_field_data.output b/tests/grid/grid_in_vtk_2d_field_data.output
new file mode 100644 (file)
index 0000000..afc111e
--- /dev/null
@@ -0,0 +1,1602 @@
+
+DEAL:: 246     200
+DEAL:: 0.88
+DEAL:: 0.57
+DEAL:: 0.65
+DEAL:: 0.26
+DEAL:: 0.32
+DEAL:: 0.50
+DEAL:: 0.32
+DEAL:: 0.52
+DEAL:: 0.22
+DEAL:: 0.64
+DEAL:: 0.0026
+DEAL:: 0.33
+DEAL:: 0.32
+DEAL:: 0.71
+DEAL:: 0.86
+DEAL:: 0.33
+DEAL:: 0.30
+DEAL:: 0.76
+DEAL:: 0.48
+DEAL:: 0.71
+DEAL:: 0.69
+DEAL:: 0.53
+DEAL:: 0.93
+DEAL:: 0.35
+DEAL:: 0.67
+DEAL:: 0.28
+DEAL:: 0.38
+DEAL:: 0.19
+DEAL:: 0.50
+DEAL:: 0.54
+DEAL:: 0.96
+DEAL:: 0.76
+DEAL:: 0.78
+DEAL:: 0.40
+DEAL:: 0.86
+DEAL:: 0.97
+DEAL:: 0.40
+DEAL:: 0.11
+DEAL:: 0.92
+DEAL:: 0.062
+DEAL:: 0.57
+DEAL:: 0.13
+DEAL:: 0.70
+DEAL:: 0.86
+DEAL:: 0.21
+DEAL:: 0.21
+DEAL:: 0.78
+DEAL:: 0.94
+DEAL:: 0.64
+DEAL:: 0.32
+DEAL:: 0.48
+DEAL:: 0.0085
+DEAL:: 0.96
+DEAL:: 0.34
+DEAL:: 0.85
+DEAL:: 0.46
+DEAL:: 0.18
+DEAL:: 0.29
+DEAL:: 0.22
+DEAL:: 0.0069
+DEAL:: 0.98
+DEAL:: 0.93
+DEAL:: 0.98
+DEAL:: 0.013
+DEAL:: 0.053
+DEAL:: 0.88
+DEAL:: 0.16
+DEAL:: 0.58
+DEAL:: 0.17
+DEAL:: 0.25
+DEAL:: 0.44
+DEAL:: 0.31
+DEAL:: 0.27
+DEAL:: 0.14
+DEAL:: 0.77
+DEAL:: 0.20
+DEAL:: 0.46
+DEAL:: 0.10
+DEAL:: 0.30
+DEAL:: 0.97
+DEAL:: 0.52
+DEAL:: 0.59
+DEAL:: 0.078
+DEAL:: 0.57
+DEAL:: 0.044
+DEAL:: 0.13
+DEAL:: 0.73
+DEAL:: 0.59
+DEAL:: 0.37
+DEAL:: 0.88
+DEAL:: 0.61
+DEAL:: 0.38
+DEAL:: 0.98
+DEAL:: 0.65
+DEAL:: 0.18
+DEAL:: 0.79
+DEAL:: 0.91
+DEAL:: 0.36
+DEAL:: 0.81
+DEAL:: 0.38
+DEAL:: 0.049
+DEAL:: 0.36
+DEAL:: 0.052
+DEAL:: 0.25
+DEAL:: 0.025
+DEAL:: 0.82
+DEAL:: 0.87
+DEAL:: 0.70
+DEAL:: 0.21
+DEAL:: 0.13
+DEAL:: 0.16
+DEAL:: 0.94
+DEAL:: 0.90
+DEAL:: 0.88
+DEAL:: 0.85
+DEAL:: 0.90
+DEAL:: 0.66
+DEAL:: 0.00034
+DEAL:: 0.19
+DEAL:: 0.24
+DEAL:: 0.46
+DEAL:: 0.63
+DEAL:: 0.080
+DEAL:: 0.042
+DEAL:: 0.29
+DEAL:: 0.40
+DEAL:: 0.84
+DEAL:: 0.10
+DEAL:: 0.96
+DEAL:: 0.36
+DEAL:: 0.56
+DEAL:: 0.13
+DEAL:: 0.063
+DEAL:: 0.36
+DEAL:: 0.50
+DEAL:: 0.85
+DEAL:: 0.35
+DEAL:: 0.79
+DEAL:: 0.41
+DEAL:: 0.63
+DEAL:: 0.46
+DEAL:: 0.057
+DEAL:: 0.54
+DEAL:: 0.45
+DEAL:: 0.95
+DEAL:: 0.22
+DEAL:: 0.080
+DEAL:: 0.88
+DEAL:: 0.76
+DEAL:: 0.93
+DEAL:: 0.10
+DEAL:: 0.64
+DEAL:: 0.80
+DEAL:: 0.94
+DEAL:: 0.68
+DEAL:: 0.010
+DEAL:: 0.53
+DEAL:: 0.28
+DEAL:: 0.14
+DEAL:: 0.14
+DEAL:: 0.38
+DEAL:: 0.39
+DEAL:: 0.79
+DEAL:: 0.75
+DEAL:: 0.57
+DEAL:: 0.080
+DEAL:: 0.55
+DEAL:: 0.76
+DEAL:: 0.86
+DEAL:: 0.32
+DEAL:: 0.23
+DEAL:: 0.93
+DEAL:: 0.63
+DEAL:: 0.34
+DEAL:: 0.50
+DEAL:: 0.49
+DEAL:: 0.50
+DEAL:: 0.071
+DEAL:: 0.88
+DEAL:: 0.89
+DEAL:: 0.086
+DEAL:: 0.93
+DEAL:: 0.98
+DEAL:: 0.86
+DEAL:: 0.082
+DEAL:: 0.96
+DEAL:: 0.14
+DEAL:: 0.69
+DEAL:: 0.31
+DEAL:: 0.40
+DEAL:: 0.79
+DEAL:: 0.029
+DEAL:: 0.67
+DEAL:: 0.65
+DEAL:: 0.45
+DEAL:: 0.78
+DEAL:: 0.040
+DEAL:: 0.52
+DEAL:: 0.55
+DEAL:: 0.92
+0.00000 0.00000 0 7
+0.00500000 0.00000 0 7
+0.00500000 0.00500000 0 7
+0.00000 0.00500000 0 7
+0.00000 0.00000 0 7
+
+
+0.00500000 0.00000 0 7
+0.0100000 0.00000 0 7
+0.0100000 0.00500000 0 7
+0.00500000 0.00500000 0 7
+0.00500000 0.00000 0 7
+
+
+0.0100000 0.00000 0 7
+0.0150000 0.00000 0 7
+0.0150000 0.00500000 0 7
+0.0100000 0.00500000 0 7
+0.0100000 0.00000 0 7
+
+
+0.0150000 0.00000 0 7
+0.0200000 0.00000 0 7
+0.0200000 0.00500000 0 7
+0.0150000 0.00500000 0 7
+0.0150000 0.00000 0 7
+
+
+0.0200000 0.00000 0 7
+0.0250000 0.00000 0 7
+0.0250000 0.00500000 0 7
+0.0200000 0.00500000 0 7
+0.0200000 0.00000 0 7
+
+
+0.0250000 0.00000 0 7
+0.0300000 0.00000 0 7
+0.0300000 0.00500000 0 7
+0.0250000 0.00500000 0 7
+0.0250000 0.00000 0 7
+
+
+0.0300000 0.00000 0 7
+0.0350000 0.00000 0 7
+0.0350000 0.00500000 0 7
+0.0300000 0.00500000 0 7
+0.0300000 0.00000 0 7
+
+
+0.0350000 0.00000 0 7
+0.0400000 0.00000 0 7
+0.0400000 0.00500000 0 7
+0.0350000 0.00500000 0 7
+0.0350000 0.00000 0 7
+
+
+0.0400000 0.00000 0 7
+0.0450000 0.00000 0 7
+0.0450000 0.00500000 0 7
+0.0400000 0.00500000 0 7
+0.0400000 0.00000 0 7
+
+
+0.0450000 0.00000 0 7
+0.0500000 0.00000 0 7
+0.0500000 0.00500000 0 7
+0.0450000 0.00500000 0 7
+0.0450000 0.00000 0 7
+
+
+0.0500000 0.00000 0 7
+0.0550000 0.00000 0 7
+0.0550000 0.00500000 0 7
+0.0500000 0.00500000 0 7
+0.0500000 0.00000 0 7
+
+
+0.0550000 0.00000 0 7
+0.0600000 0.00000 0 7
+0.0600000 0.00500000 0 7
+0.0550000 0.00500000 0 7
+0.0550000 0.00000 0 7
+
+
+0.0600000 0.00000 0 7
+0.0650000 0.00000 0 7
+0.0650000 0.00500000 0 7
+0.0600000 0.00500000 0 7
+0.0600000 0.00000 0 7
+
+
+0.0650000 0.00000 0 7
+0.0700000 0.00000 0 7
+0.0700000 0.00500000 0 7
+0.0650000 0.00500000 0 7
+0.0650000 0.00000 0 7
+
+
+0.0700000 0.00000 0 7
+0.0750000 0.00000 0 7
+0.0750000 0.00500000 0 7
+0.0700000 0.00500000 0 7
+0.0700000 0.00000 0 7
+
+
+0.0750000 0.00000 0 7
+0.0800000 0.00000 0 7
+0.0800000 0.00500000 0 7
+0.0750000 0.00500000 0 7
+0.0750000 0.00000 0 7
+
+
+0.0800000 0.00000 0 7
+0.0850000 0.00000 0 7
+0.0850000 0.00500000 0 7
+0.0800000 0.00500000 0 7
+0.0800000 0.00000 0 7
+
+
+0.0850000 0.00000 0 7
+0.0900000 0.00000 0 7
+0.0900000 0.00500000 0 7
+0.0850000 0.00500000 0 7
+0.0850000 0.00000 0 7
+
+
+0.0900000 0.00000 0 7
+0.0950000 0.00000 0 7
+0.0950000 0.00500000 0 7
+0.0900000 0.00500000 0 7
+0.0900000 0.00000 0 7
+
+
+0.0950000 0.00000 0 7
+0.100000 0.00000 0 7
+0.100000 0.00500000 0 7
+0.0950000 0.00500000 0 7
+0.0950000 0.00000 0 7
+
+
+0.100000 0.00000 0 7
+0.105000 0.00000 0 7
+0.105000 0.00500000 0 7
+0.100000 0.00500000 0 7
+0.100000 0.00000 0 7
+
+
+0.105000 0.00000 0 7
+0.110000 0.00000 0 7
+0.110000 0.00500000 0 7
+0.105000 0.00500000 0 7
+0.105000 0.00000 0 7
+
+
+0.110000 0.00000 0 7
+0.115000 0.00000 0 7
+0.115000 0.00500000 0 7
+0.110000 0.00500000 0 7
+0.110000 0.00000 0 7
+
+
+0.115000 0.00000 0 7
+0.120000 0.00000 0 7
+0.120000 0.00500000 0 7
+0.115000 0.00500000 0 7
+0.115000 0.00000 0 7
+
+
+0.120000 0.00000 0 7
+0.125000 0.00000 0 7
+0.125000 0.00500000 0 7
+0.120000 0.00500000 0 7
+0.120000 0.00000 0 7
+
+
+0.125000 0.00000 0 7
+0.130000 0.00000 0 7
+0.130000 0.00500000 0 7
+0.125000 0.00500000 0 7
+0.125000 0.00000 0 7
+
+
+0.130000 0.00000 0 7
+0.135000 0.00000 0 7
+0.135000 0.00500000 0 7
+0.130000 0.00500000 0 7
+0.130000 0.00000 0 7
+
+
+0.135000 0.00000 0 7
+0.140000 0.00000 0 7
+0.140000 0.00500000 0 7
+0.135000 0.00500000 0 7
+0.135000 0.00000 0 7
+
+
+0.140000 0.00000 0 7
+0.145000 0.00000 0 7
+0.145000 0.00500000 0 7
+0.140000 0.00500000 0 7
+0.140000 0.00000 0 7
+
+
+0.145000 0.00000 0 7
+0.150000 0.00000 0 7
+0.150000 0.00500000 0 7
+0.145000 0.00500000 0 7
+0.145000 0.00000 0 7
+
+
+0.150000 0.00000 0 7
+0.155000 0.00000 0 7
+0.155000 0.00500000 0 7
+0.150000 0.00500000 0 7
+0.150000 0.00000 0 7
+
+
+0.155000 0.00000 0 7
+0.160000 0.00000 0 7
+0.160000 0.00500000 0 7
+0.155000 0.00500000 0 7
+0.155000 0.00000 0 7
+
+
+0.160000 0.00000 0 7
+0.165000 0.00000 0 7
+0.165000 0.00500000 0 7
+0.160000 0.00500000 0 7
+0.160000 0.00000 0 7
+
+
+0.165000 0.00000 0 7
+0.170000 0.00000 0 7
+0.170000 0.00500000 0 7
+0.165000 0.00500000 0 7
+0.165000 0.00000 0 7
+
+
+0.170000 0.00000 0 7
+0.175000 0.00000 0 7
+0.175000 0.00500000 0 7
+0.170000 0.00500000 0 7
+0.170000 0.00000 0 7
+
+
+0.175000 0.00000 0 7
+0.180000 0.00000 0 7
+0.180000 0.00500000 0 7
+0.175000 0.00500000 0 7
+0.175000 0.00000 0 7
+
+
+0.180000 0.00000 0 7
+0.185000 0.00000 0 7
+0.185000 0.00500000 0 7
+0.180000 0.00500000 0 7
+0.180000 0.00000 0 7
+
+
+0.185000 0.00000 0 7
+0.190000 0.00000 0 7
+0.190000 0.00500000 0 7
+0.185000 0.00500000 0 7
+0.185000 0.00000 0 7
+
+
+0.190000 0.00000 0 7
+0.195000 0.00000 0 7
+0.195000 0.00500000 0 7
+0.190000 0.00500000 0 7
+0.190000 0.00000 0 7
+
+
+0.195000 0.00000 0 7
+0.200000 0.00000 0 7
+0.200000 0.00500000 0 7
+0.195000 0.00500000 0 7
+0.195000 0.00000 0 7
+
+
+0.00000 0.00500000 0 7
+0.00500000 0.00500000 0 7
+0.00500000 0.0100000 0 7
+0.00000 0.0100000 0 7
+0.00000 0.00500000 0 7
+
+
+0.00500000 0.00500000 0 7
+0.0100000 0.00500000 0 7
+0.0100000 0.0100000 0 7
+0.00500000 0.0100000 0 7
+0.00500000 0.00500000 0 7
+
+
+0.0100000 0.00500000 0 7
+0.0150000 0.00500000 0 7
+0.0150000 0.0100000 0 7
+0.0100000 0.0100000 0 7
+0.0100000 0.00500000 0 7
+
+
+0.0150000 0.00500000 0 7
+0.0200000 0.00500000 0 7
+0.0200000 0.0100000 0 7
+0.0150000 0.0100000 0 7
+0.0150000 0.00500000 0 7
+
+
+0.0200000 0.00500000 0 7
+0.0250000 0.00500000 0 7
+0.0250000 0.0100000 0 7
+0.0200000 0.0100000 0 7
+0.0200000 0.00500000 0 7
+
+
+0.0250000 0.00500000 0 7
+0.0300000 0.00500000 0 7
+0.0300000 0.0100000 0 7
+0.0250000 0.0100000 0 7
+0.0250000 0.00500000 0 7
+
+
+0.0300000 0.00500000 0 7
+0.0350000 0.00500000 0 7
+0.0350000 0.0100000 0 7
+0.0300000 0.0100000 0 7
+0.0300000 0.00500000 0 7
+
+
+0.0350000 0.00500000 0 7
+0.0400000 0.00500000 0 7
+0.0400000 0.0100000 0 7
+0.0350000 0.0100000 0 7
+0.0350000 0.00500000 0 7
+
+
+0.0400000 0.00500000 0 7
+0.0450000 0.00500000 0 7
+0.0450000 0.0100000 0 7
+0.0400000 0.0100000 0 7
+0.0400000 0.00500000 0 7
+
+
+0.0450000 0.00500000 0 7
+0.0500000 0.00500000 0 7
+0.0500000 0.0100000 0 7
+0.0450000 0.0100000 0 7
+0.0450000 0.00500000 0 7
+
+
+0.0500000 0.00500000 0 7
+0.0550000 0.00500000 0 7
+0.0550000 0.0100000 0 7
+0.0500000 0.0100000 0 7
+0.0500000 0.00500000 0 7
+
+
+0.0550000 0.00500000 0 7
+0.0600000 0.00500000 0 7
+0.0600000 0.0100000 0 7
+0.0550000 0.0100000 0 7
+0.0550000 0.00500000 0 7
+
+
+0.0600000 0.00500000 0 7
+0.0650000 0.00500000 0 7
+0.0650000 0.0100000 0 7
+0.0600000 0.0100000 0 7
+0.0600000 0.00500000 0 7
+
+
+0.0650000 0.00500000 0 7
+0.0700000 0.00500000 0 7
+0.0700000 0.0100000 0 7
+0.0650000 0.0100000 0 7
+0.0650000 0.00500000 0 7
+
+
+0.0700000 0.00500000 0 7
+0.0750000 0.00500000 0 7
+0.0750000 0.0100000 0 7
+0.0700000 0.0100000 0 7
+0.0700000 0.00500000 0 7
+
+
+0.0750000 0.00500000 0 7
+0.0800000 0.00500000 0 7
+0.0800000 0.0100000 0 7
+0.0750000 0.0100000 0 7
+0.0750000 0.00500000 0 7
+
+
+0.0800000 0.00500000 0 7
+0.0850000 0.00500000 0 7
+0.0850000 0.0100000 0 7
+0.0800000 0.0100000 0 7
+0.0800000 0.00500000 0 7
+
+
+0.0850000 0.00500000 0 7
+0.0900000 0.00500000 0 7
+0.0900000 0.0100000 0 7
+0.0850000 0.0100000 0 7
+0.0850000 0.00500000 0 7
+
+
+0.0900000 0.00500000 0 7
+0.0950000 0.00500000 0 7
+0.0950000 0.0100000 0 7
+0.0900000 0.0100000 0 7
+0.0900000 0.00500000 0 7
+
+
+0.0950000 0.00500000 0 7
+0.100000 0.00500000 0 7
+0.100000 0.0100000 0 7
+0.0950000 0.0100000 0 7
+0.0950000 0.00500000 0 7
+
+
+0.100000 0.00500000 0 7
+0.105000 0.00500000 0 7
+0.105000 0.0100000 0 7
+0.100000 0.0100000 0 7
+0.100000 0.00500000 0 7
+
+
+0.105000 0.00500000 0 7
+0.110000 0.00500000 0 7
+0.110000 0.0100000 0 7
+0.105000 0.0100000 0 7
+0.105000 0.00500000 0 7
+
+
+0.110000 0.00500000 0 7
+0.115000 0.00500000 0 7
+0.115000 0.0100000 0 7
+0.110000 0.0100000 0 7
+0.110000 0.00500000 0 7
+
+
+0.115000 0.00500000 0 7
+0.120000 0.00500000 0 7
+0.120000 0.0100000 0 7
+0.115000 0.0100000 0 7
+0.115000 0.00500000 0 7
+
+
+0.120000 0.00500000 0 7
+0.125000 0.00500000 0 7
+0.125000 0.0100000 0 7
+0.120000 0.0100000 0 7
+0.120000 0.00500000 0 7
+
+
+0.125000 0.00500000 0 7
+0.130000 0.00500000 0 7
+0.130000 0.0100000 0 7
+0.125000 0.0100000 0 7
+0.125000 0.00500000 0 7
+
+
+0.130000 0.00500000 0 7
+0.135000 0.00500000 0 7
+0.135000 0.0100000 0 7
+0.130000 0.0100000 0 7
+0.130000 0.00500000 0 7
+
+
+0.135000 0.00500000 0 7
+0.140000 0.00500000 0 7
+0.140000 0.0100000 0 7
+0.135000 0.0100000 0 7
+0.135000 0.00500000 0 7
+
+
+0.140000 0.00500000 0 7
+0.145000 0.00500000 0 7
+0.145000 0.0100000 0 7
+0.140000 0.0100000 0 7
+0.140000 0.00500000 0 7
+
+
+0.145000 0.00500000 0 7
+0.150000 0.00500000 0 7
+0.150000 0.0100000 0 7
+0.145000 0.0100000 0 7
+0.145000 0.00500000 0 7
+
+
+0.150000 0.00500000 0 7
+0.155000 0.00500000 0 7
+0.155000 0.0100000 0 7
+0.150000 0.0100000 0 7
+0.150000 0.00500000 0 7
+
+
+0.155000 0.00500000 0 7
+0.160000 0.00500000 0 7
+0.160000 0.0100000 0 7
+0.155000 0.0100000 0 7
+0.155000 0.00500000 0 7
+
+
+0.160000 0.00500000 0 7
+0.165000 0.00500000 0 7
+0.165000 0.0100000 0 7
+0.160000 0.0100000 0 7
+0.160000 0.00500000 0 7
+
+
+0.165000 0.00500000 0 7
+0.170000 0.00500000 0 7
+0.170000 0.0100000 0 7
+0.165000 0.0100000 0 7
+0.165000 0.00500000 0 7
+
+
+0.170000 0.00500000 0 7
+0.175000 0.00500000 0 7
+0.175000 0.0100000 0 7
+0.170000 0.0100000 0 7
+0.170000 0.00500000 0 7
+
+
+0.175000 0.00500000 0 7
+0.180000 0.00500000 0 7
+0.180000 0.0100000 0 7
+0.175000 0.0100000 0 7
+0.175000 0.00500000 0 7
+
+
+0.180000 0.00500000 0 7
+0.185000 0.00500000 0 7
+0.185000 0.0100000 0 7
+0.180000 0.0100000 0 7
+0.180000 0.00500000 0 7
+
+
+0.185000 0.00500000 0 7
+0.190000 0.00500000 0 7
+0.190000 0.0100000 0 7
+0.185000 0.0100000 0 7
+0.185000 0.00500000 0 7
+
+
+0.190000 0.00500000 0 7
+0.195000 0.00500000 0 7
+0.195000 0.0100000 0 7
+0.190000 0.0100000 0 7
+0.190000 0.00500000 0 7
+
+
+0.195000 0.00500000 0 7
+0.200000 0.00500000 0 7
+0.200000 0.0100000 0 7
+0.195000 0.0100000 0 7
+0.195000 0.00500000 0 7
+
+
+0.00000 0.0100000 0 7
+0.00500000 0.0100000 0 7
+0.00500000 0.0150000 0 7
+0.00000 0.0150000 0 7
+0.00000 0.0100000 0 7
+
+
+0.00500000 0.0100000 0 7
+0.0100000 0.0100000 0 7
+0.0100000 0.0150000 0 7
+0.00500000 0.0150000 0 7
+0.00500000 0.0100000 0 7
+
+
+0.0100000 0.0100000 0 7
+0.0150000 0.0100000 0 7
+0.0150000 0.0150000 0 7
+0.0100000 0.0150000 0 7
+0.0100000 0.0100000 0 7
+
+
+0.0150000 0.0100000 0 7
+0.0200000 0.0100000 0 7
+0.0200000 0.0150000 0 7
+0.0150000 0.0150000 0 7
+0.0150000 0.0100000 0 7
+
+
+0.0200000 0.0100000 0 7
+0.0250000 0.0100000 0 7
+0.0250000 0.0150000 0 7
+0.0200000 0.0150000 0 7
+0.0200000 0.0100000 0 7
+
+
+0.0250000 0.0100000 0 7
+0.0300000 0.0100000 0 7
+0.0300000 0.0150000 0 7
+0.0250000 0.0150000 0 7
+0.0250000 0.0100000 0 7
+
+
+0.0300000 0.0100000 0 7
+0.0350000 0.0100000 0 7
+0.0350000 0.0150000 0 7
+0.0300000 0.0150000 0 7
+0.0300000 0.0100000 0 7
+
+
+0.0350000 0.0100000 0 7
+0.0400000 0.0100000 0 7
+0.0400000 0.0150000 0 7
+0.0350000 0.0150000 0 7
+0.0350000 0.0100000 0 7
+
+
+0.0400000 0.0100000 0 7
+0.0450000 0.0100000 0 7
+0.0450000 0.0150000 0 7
+0.0400000 0.0150000 0 7
+0.0400000 0.0100000 0 7
+
+
+0.0450000 0.0100000 0 7
+0.0500000 0.0100000 0 7
+0.0500000 0.0150000 0 7
+0.0450000 0.0150000 0 7
+0.0450000 0.0100000 0 7
+
+
+0.0500000 0.0100000 0 7
+0.0550000 0.0100000 0 7
+0.0550000 0.0150000 0 7
+0.0500000 0.0150000 0 7
+0.0500000 0.0100000 0 7
+
+
+0.0550000 0.0100000 0 7
+0.0600000 0.0100000 0 7
+0.0600000 0.0150000 0 7
+0.0550000 0.0150000 0 7
+0.0550000 0.0100000 0 7
+
+
+0.0600000 0.0100000 0 7
+0.0650000 0.0100000 0 7
+0.0650000 0.0150000 0 7
+0.0600000 0.0150000 0 7
+0.0600000 0.0100000 0 7
+
+
+0.0650000 0.0100000 0 7
+0.0700000 0.0100000 0 7
+0.0700000 0.0150000 0 7
+0.0650000 0.0150000 0 7
+0.0650000 0.0100000 0 7
+
+
+0.0700000 0.0100000 0 7
+0.0750000 0.0100000 0 7
+0.0750000 0.0150000 0 7
+0.0700000 0.0150000 0 7
+0.0700000 0.0100000 0 7
+
+
+0.0750000 0.0100000 0 7
+0.0800000 0.0100000 0 7
+0.0800000 0.0150000 0 7
+0.0750000 0.0150000 0 7
+0.0750000 0.0100000 0 7
+
+
+0.0800000 0.0100000 0 7
+0.0850000 0.0100000 0 7
+0.0850000 0.0150000 0 7
+0.0800000 0.0150000 0 7
+0.0800000 0.0100000 0 7
+
+
+0.0850000 0.0100000 0 7
+0.0900000 0.0100000 0 7
+0.0900000 0.0150000 0 7
+0.0850000 0.0150000 0 7
+0.0850000 0.0100000 0 7
+
+
+0.0900000 0.0100000 0 7
+0.0950000 0.0100000 0 7
+0.0950000 0.0150000 0 7
+0.0900000 0.0150000 0 7
+0.0900000 0.0100000 0 7
+
+
+0.0950000 0.0100000 0 7
+0.100000 0.0100000 0 7
+0.100000 0.0150000 0 7
+0.0950000 0.0150000 0 7
+0.0950000 0.0100000 0 7
+
+
+0.100000 0.0100000 0 7
+0.105000 0.0100000 0 7
+0.105000 0.0150000 0 7
+0.100000 0.0150000 0 7
+0.100000 0.0100000 0 7
+
+
+0.105000 0.0100000 0 7
+0.110000 0.0100000 0 7
+0.110000 0.0150000 0 7
+0.105000 0.0150000 0 7
+0.105000 0.0100000 0 7
+
+
+0.110000 0.0100000 0 7
+0.115000 0.0100000 0 7
+0.115000 0.0150000 0 7
+0.110000 0.0150000 0 7
+0.110000 0.0100000 0 7
+
+
+0.115000 0.0100000 0 7
+0.120000 0.0100000 0 7
+0.120000 0.0150000 0 7
+0.115000 0.0150000 0 7
+0.115000 0.0100000 0 7
+
+
+0.120000 0.0100000 0 7
+0.125000 0.0100000 0 7
+0.125000 0.0150000 0 7
+0.120000 0.0150000 0 7
+0.120000 0.0100000 0 7
+
+
+0.125000 0.0100000 0 7
+0.130000 0.0100000 0 7
+0.130000 0.0150000 0 7
+0.125000 0.0150000 0 7
+0.125000 0.0100000 0 7
+
+
+0.130000 0.0100000 0 7
+0.135000 0.0100000 0 7
+0.135000 0.0150000 0 7
+0.130000 0.0150000 0 7
+0.130000 0.0100000 0 7
+
+
+0.135000 0.0100000 0 7
+0.140000 0.0100000 0 7
+0.140000 0.0150000 0 7
+0.135000 0.0150000 0 7
+0.135000 0.0100000 0 7
+
+
+0.140000 0.0100000 0 7
+0.145000 0.0100000 0 7
+0.145000 0.0150000 0 7
+0.140000 0.0150000 0 7
+0.140000 0.0100000 0 7
+
+
+0.145000 0.0100000 0 7
+0.150000 0.0100000 0 7
+0.150000 0.0150000 0 7
+0.145000 0.0150000 0 7
+0.145000 0.0100000 0 7
+
+
+0.150000 0.0100000 0 7
+0.155000 0.0100000 0 7
+0.155000 0.0150000 0 7
+0.150000 0.0150000 0 7
+0.150000 0.0100000 0 7
+
+
+0.155000 0.0100000 0 7
+0.160000 0.0100000 0 7
+0.160000 0.0150000 0 7
+0.155000 0.0150000 0 7
+0.155000 0.0100000 0 7
+
+
+0.160000 0.0100000 0 7
+0.165000 0.0100000 0 7
+0.165000 0.0150000 0 7
+0.160000 0.0150000 0 7
+0.160000 0.0100000 0 7
+
+
+0.165000 0.0100000 0 7
+0.170000 0.0100000 0 7
+0.170000 0.0150000 0 7
+0.165000 0.0150000 0 7
+0.165000 0.0100000 0 7
+
+
+0.170000 0.0100000 0 7
+0.175000 0.0100000 0 7
+0.175000 0.0150000 0 7
+0.170000 0.0150000 0 7
+0.170000 0.0100000 0 7
+
+
+0.175000 0.0100000 0 7
+0.180000 0.0100000 0 7
+0.180000 0.0150000 0 7
+0.175000 0.0150000 0 7
+0.175000 0.0100000 0 7
+
+
+0.180000 0.0100000 0 7
+0.185000 0.0100000 0 7
+0.185000 0.0150000 0 7
+0.180000 0.0150000 0 7
+0.180000 0.0100000 0 7
+
+
+0.185000 0.0100000 0 7
+0.190000 0.0100000 0 7
+0.190000 0.0150000 0 7
+0.185000 0.0150000 0 7
+0.185000 0.0100000 0 7
+
+
+0.190000 0.0100000 0 7
+0.195000 0.0100000 0 7
+0.195000 0.0150000 0 7
+0.190000 0.0150000 0 7
+0.190000 0.0100000 0 7
+
+
+0.195000 0.0100000 0 7
+0.200000 0.0100000 0 7
+0.200000 0.0150000 0 7
+0.195000 0.0150000 0 7
+0.195000 0.0100000 0 7
+
+
+0.00000 0.0150000 0 7
+0.00500000 0.0150000 0 7
+0.00500000 0.0200000 0 7
+0.00000 0.0200000 0 7
+0.00000 0.0150000 0 7
+
+
+0.00500000 0.0150000 0 7
+0.0100000 0.0150000 0 7
+0.0100000 0.0200000 0 7
+0.00500000 0.0200000 0 7
+0.00500000 0.0150000 0 7
+
+
+0.0100000 0.0150000 0 7
+0.0150000 0.0150000 0 7
+0.0150000 0.0200000 0 7
+0.0100000 0.0200000 0 7
+0.0100000 0.0150000 0 7
+
+
+0.0150000 0.0150000 0 7
+0.0200000 0.0150000 0 7
+0.0200000 0.0200000 0 7
+0.0150000 0.0200000 0 7
+0.0150000 0.0150000 0 7
+
+
+0.0200000 0.0150000 0 7
+0.0250000 0.0150000 0 7
+0.0250000 0.0200000 0 7
+0.0200000 0.0200000 0 7
+0.0200000 0.0150000 0 7
+
+
+0.0250000 0.0150000 0 7
+0.0300000 0.0150000 0 7
+0.0300000 0.0200000 0 7
+0.0250000 0.0200000 0 7
+0.0250000 0.0150000 0 7
+
+
+0.0300000 0.0150000 0 7
+0.0350000 0.0150000 0 7
+0.0350000 0.0200000 0 7
+0.0300000 0.0200000 0 7
+0.0300000 0.0150000 0 7
+
+
+0.0350000 0.0150000 0 7
+0.0400000 0.0150000 0 7
+0.0400000 0.0200000 0 7
+0.0350000 0.0200000 0 7
+0.0350000 0.0150000 0 7
+
+
+0.0400000 0.0150000 0 7
+0.0450000 0.0150000 0 7
+0.0450000 0.0200000 0 7
+0.0400000 0.0200000 0 7
+0.0400000 0.0150000 0 7
+
+
+0.0450000 0.0150000 0 7
+0.0500000 0.0150000 0 7
+0.0500000 0.0200000 0 7
+0.0450000 0.0200000 0 7
+0.0450000 0.0150000 0 7
+
+
+0.0500000 0.0150000 0 7
+0.0550000 0.0150000 0 7
+0.0550000 0.0200000 0 7
+0.0500000 0.0200000 0 7
+0.0500000 0.0150000 0 7
+
+
+0.0550000 0.0150000 0 7
+0.0600000 0.0150000 0 7
+0.0600000 0.0200000 0 7
+0.0550000 0.0200000 0 7
+0.0550000 0.0150000 0 7
+
+
+0.0600000 0.0150000 0 7
+0.0650000 0.0150000 0 7
+0.0650000 0.0200000 0 7
+0.0600000 0.0200000 0 7
+0.0600000 0.0150000 0 7
+
+
+0.0650000 0.0150000 0 7
+0.0700000 0.0150000 0 7
+0.0700000 0.0200000 0 7
+0.0650000 0.0200000 0 7
+0.0650000 0.0150000 0 7
+
+
+0.0700000 0.0150000 0 7
+0.0750000 0.0150000 0 7
+0.0750000 0.0200000 0 7
+0.0700000 0.0200000 0 7
+0.0700000 0.0150000 0 7
+
+
+0.0750000 0.0150000 0 7
+0.0800000 0.0150000 0 7
+0.0800000 0.0200000 0 7
+0.0750000 0.0200000 0 7
+0.0750000 0.0150000 0 7
+
+
+0.0800000 0.0150000 0 7
+0.0850000 0.0150000 0 7
+0.0850000 0.0200000 0 7
+0.0800000 0.0200000 0 7
+0.0800000 0.0150000 0 7
+
+
+0.0850000 0.0150000 0 7
+0.0900000 0.0150000 0 7
+0.0900000 0.0200000 0 7
+0.0850000 0.0200000 0 7
+0.0850000 0.0150000 0 7
+
+
+0.0900000 0.0150000 0 7
+0.0950000 0.0150000 0 7
+0.0950000 0.0200000 0 7
+0.0900000 0.0200000 0 7
+0.0900000 0.0150000 0 7
+
+
+0.0950000 0.0150000 0 7
+0.100000 0.0150000 0 7
+0.100000 0.0200000 0 7
+0.0950000 0.0200000 0 7
+0.0950000 0.0150000 0 7
+
+
+0.100000 0.0150000 0 7
+0.105000 0.0150000 0 7
+0.105000 0.0200000 0 7
+0.100000 0.0200000 0 7
+0.100000 0.0150000 0 7
+
+
+0.105000 0.0150000 0 7
+0.110000 0.0150000 0 7
+0.110000 0.0200000 0 7
+0.105000 0.0200000 0 7
+0.105000 0.0150000 0 7
+
+
+0.110000 0.0150000 0 7
+0.115000 0.0150000 0 7
+0.115000 0.0200000 0 7
+0.110000 0.0200000 0 7
+0.110000 0.0150000 0 7
+
+
+0.115000 0.0150000 0 7
+0.120000 0.0150000 0 7
+0.120000 0.0200000 0 7
+0.115000 0.0200000 0 7
+0.115000 0.0150000 0 7
+
+
+0.120000 0.0150000 0 7
+0.125000 0.0150000 0 7
+0.125000 0.0200000 0 7
+0.120000 0.0200000 0 7
+0.120000 0.0150000 0 7
+
+
+0.125000 0.0150000 0 7
+0.130000 0.0150000 0 7
+0.130000 0.0200000 0 7
+0.125000 0.0200000 0 7
+0.125000 0.0150000 0 7
+
+
+0.130000 0.0150000 0 7
+0.135000 0.0150000 0 7
+0.135000 0.0200000 0 7
+0.130000 0.0200000 0 7
+0.130000 0.0150000 0 7
+
+
+0.135000 0.0150000 0 7
+0.140000 0.0150000 0 7
+0.140000 0.0200000 0 7
+0.135000 0.0200000 0 7
+0.135000 0.0150000 0 7
+
+
+0.140000 0.0150000 0 7
+0.145000 0.0150000 0 7
+0.145000 0.0200000 0 7
+0.140000 0.0200000 0 7
+0.140000 0.0150000 0 7
+
+
+0.145000 0.0150000 0 7
+0.150000 0.0150000 0 7
+0.150000 0.0200000 0 7
+0.145000 0.0200000 0 7
+0.145000 0.0150000 0 7
+
+
+0.150000 0.0150000 0 7
+0.155000 0.0150000 0 7
+0.155000 0.0200000 0 7
+0.150000 0.0200000 0 7
+0.150000 0.0150000 0 7
+
+
+0.155000 0.0150000 0 7
+0.160000 0.0150000 0 7
+0.160000 0.0200000 0 7
+0.155000 0.0200000 0 7
+0.155000 0.0150000 0 7
+
+
+0.160000 0.0150000 0 7
+0.165000 0.0150000 0 7
+0.165000 0.0200000 0 7
+0.160000 0.0200000 0 7
+0.160000 0.0150000 0 7
+
+
+0.165000 0.0150000 0 7
+0.170000 0.0150000 0 7
+0.170000 0.0200000 0 7
+0.165000 0.0200000 0 7
+0.165000 0.0150000 0 7
+
+
+0.170000 0.0150000 0 7
+0.175000 0.0150000 0 7
+0.175000 0.0200000 0 7
+0.170000 0.0200000 0 7
+0.170000 0.0150000 0 7
+
+
+0.175000 0.0150000 0 7
+0.180000 0.0150000 0 7
+0.180000 0.0200000 0 7
+0.175000 0.0200000 0 7
+0.175000 0.0150000 0 7
+
+
+0.180000 0.0150000 0 7
+0.185000 0.0150000 0 7
+0.185000 0.0200000 0 7
+0.180000 0.0200000 0 7
+0.180000 0.0150000 0 7
+
+
+0.185000 0.0150000 0 7
+0.190000 0.0150000 0 7
+0.190000 0.0200000 0 7
+0.185000 0.0200000 0 7
+0.185000 0.0150000 0 7
+
+
+0.190000 0.0150000 0 7
+0.195000 0.0150000 0 7
+0.195000 0.0200000 0 7
+0.190000 0.0200000 0 7
+0.190000 0.0150000 0 7
+
+
+0.195000 0.0150000 0 7
+0.200000 0.0150000 0 7
+0.200000 0.0200000 0 7
+0.195000 0.0200000 0 7
+0.195000 0.0150000 0 7
+
+
+0.00000 0.0200000 0 7
+0.00500000 0.0200000 0 7
+0.00500000 0.0250000 0 7
+0.00000 0.0250000 0 7
+0.00000 0.0200000 0 7
+
+
+0.00500000 0.0200000 0 7
+0.0100000 0.0200000 0 7
+0.0100000 0.0250000 0 7
+0.00500000 0.0250000 0 7
+0.00500000 0.0200000 0 7
+
+
+0.0100000 0.0200000 0 7
+0.0150000 0.0200000 0 7
+0.0150000 0.0250000 0 7
+0.0100000 0.0250000 0 7
+0.0100000 0.0200000 0 7
+
+
+0.0150000 0.0200000 0 7
+0.0200000 0.0200000 0 7
+0.0200000 0.0250000 0 7
+0.0150000 0.0250000 0 7
+0.0150000 0.0200000 0 7
+
+
+0.0200000 0.0200000 0 7
+0.0250000 0.0200000 0 7
+0.0250000 0.0250000 0 7
+0.0200000 0.0250000 0 7
+0.0200000 0.0200000 0 7
+
+
+0.0250000 0.0200000 0 7
+0.0300000 0.0200000 0 7
+0.0300000 0.0250000 0 7
+0.0250000 0.0250000 0 7
+0.0250000 0.0200000 0 7
+
+
+0.0300000 0.0200000 0 7
+0.0350000 0.0200000 0 7
+0.0350000 0.0250000 0 7
+0.0300000 0.0250000 0 7
+0.0300000 0.0200000 0 7
+
+
+0.0350000 0.0200000 0 7
+0.0400000 0.0200000 0 7
+0.0400000 0.0250000 0 7
+0.0350000 0.0250000 0 7
+0.0350000 0.0200000 0 7
+
+
+0.0400000 0.0200000 0 7
+0.0450000 0.0200000 0 7
+0.0450000 0.0250000 0 7
+0.0400000 0.0250000 0 7
+0.0400000 0.0200000 0 7
+
+
+0.0450000 0.0200000 0 7
+0.0500000 0.0200000 0 7
+0.0500000 0.0250000 0 7
+0.0450000 0.0250000 0 7
+0.0450000 0.0200000 0 7
+
+
+0.0500000 0.0200000 0 7
+0.0550000 0.0200000 0 7
+0.0550000 0.0250000 0 7
+0.0500000 0.0250000 0 7
+0.0500000 0.0200000 0 7
+
+
+0.0550000 0.0200000 0 7
+0.0600000 0.0200000 0 7
+0.0600000 0.0250000 0 7
+0.0550000 0.0250000 0 7
+0.0550000 0.0200000 0 7
+
+
+0.0600000 0.0200000 0 7
+0.0650000 0.0200000 0 7
+0.0650000 0.0250000 0 7
+0.0600000 0.0250000 0 7
+0.0600000 0.0200000 0 7
+
+
+0.0650000 0.0200000 0 7
+0.0700000 0.0200000 0 7
+0.0700000 0.0250000 0 7
+0.0650000 0.0250000 0 7
+0.0650000 0.0200000 0 7
+
+
+0.0700000 0.0200000 0 7
+0.0750000 0.0200000 0 7
+0.0750000 0.0250000 0 7
+0.0700000 0.0250000 0 7
+0.0700000 0.0200000 0 7
+
+
+0.0750000 0.0200000 0 7
+0.0800000 0.0200000 0 7
+0.0800000 0.0250000 0 7
+0.0750000 0.0250000 0 7
+0.0750000 0.0200000 0 7
+
+
+0.0800000 0.0200000 0 7
+0.0850000 0.0200000 0 7
+0.0850000 0.0250000 0 7
+0.0800000 0.0250000 0 7
+0.0800000 0.0200000 0 7
+
+
+0.0850000 0.0200000 0 7
+0.0900000 0.0200000 0 7
+0.0900000 0.0250000 0 7
+0.0850000 0.0250000 0 7
+0.0850000 0.0200000 0 7
+
+
+0.0900000 0.0200000 0 7
+0.0950000 0.0200000 0 7
+0.0950000 0.0250000 0 7
+0.0900000 0.0250000 0 7
+0.0900000 0.0200000 0 7
+
+
+0.0950000 0.0200000 0 7
+0.100000 0.0200000 0 7
+0.100000 0.0250000 0 7
+0.0950000 0.0250000 0 7
+0.0950000 0.0200000 0 7
+
+
+0.100000 0.0200000 0 7
+0.105000 0.0200000 0 7
+0.105000 0.0250000 0 7
+0.100000 0.0250000 0 7
+0.100000 0.0200000 0 7
+
+
+0.105000 0.0200000 0 7
+0.110000 0.0200000 0 7
+0.110000 0.0250000 0 7
+0.105000 0.0250000 0 7
+0.105000 0.0200000 0 7
+
+
+0.110000 0.0200000 0 7
+0.115000 0.0200000 0 7
+0.115000 0.0250000 0 7
+0.110000 0.0250000 0 7
+0.110000 0.0200000 0 7
+
+
+0.115000 0.0200000 0 7
+0.120000 0.0200000 0 7
+0.120000 0.0250000 0 7
+0.115000 0.0250000 0 7
+0.115000 0.0200000 0 7
+
+
+0.120000 0.0200000 0 7
+0.125000 0.0200000 0 7
+0.125000 0.0250000 0 7
+0.120000 0.0250000 0 7
+0.120000 0.0200000 0 7
+
+
+0.125000 0.0200000 0 7
+0.130000 0.0200000 0 7
+0.130000 0.0250000 0 7
+0.125000 0.0250000 0 7
+0.125000 0.0200000 0 7
+
+
+0.130000 0.0200000 0 7
+0.135000 0.0200000 0 7
+0.135000 0.0250000 0 7
+0.130000 0.0250000 0 7
+0.130000 0.0200000 0 7
+
+
+0.135000 0.0200000 0 7
+0.140000 0.0200000 0 7
+0.140000 0.0250000 0 7
+0.135000 0.0250000 0 7
+0.135000 0.0200000 0 7
+
+
+0.140000 0.0200000 0 7
+0.145000 0.0200000 0 7
+0.145000 0.0250000 0 7
+0.140000 0.0250000 0 7
+0.140000 0.0200000 0 7
+
+
+0.145000 0.0200000 0 7
+0.150000 0.0200000 0 7
+0.150000 0.0250000 0 7
+0.145000 0.0250000 0 7
+0.145000 0.0200000 0 7
+
+
+0.150000 0.0200000 0 7
+0.155000 0.0200000 0 7
+0.155000 0.0250000 0 7
+0.150000 0.0250000 0 7
+0.150000 0.0200000 0 7
+
+
+0.155000 0.0200000 0 7
+0.160000 0.0200000 0 7
+0.160000 0.0250000 0 7
+0.155000 0.0250000 0 7
+0.155000 0.0200000 0 7
+
+
+0.160000 0.0200000 0 7
+0.165000 0.0200000 0 7
+0.165000 0.0250000 0 7
+0.160000 0.0250000 0 7
+0.160000 0.0200000 0 7
+
+
+0.165000 0.0200000 0 7
+0.170000 0.0200000 0 7
+0.170000 0.0250000 0 7
+0.165000 0.0250000 0 7
+0.165000 0.0200000 0 7
+
+
+0.170000 0.0200000 0 7
+0.175000 0.0200000 0 7
+0.175000 0.0250000 0 7
+0.170000 0.0250000 0 7
+0.170000 0.0200000 0 7
+
+
+0.175000 0.0200000 0 7
+0.180000 0.0200000 0 7
+0.180000 0.0250000 0 7
+0.175000 0.0250000 0 7
+0.175000 0.0200000 0 7
+
+
+0.180000 0.0200000 0 7
+0.185000 0.0200000 0 7
+0.185000 0.0250000 0 7
+0.180000 0.0250000 0 7
+0.180000 0.0200000 0 7
+
+
+0.185000 0.0200000 0 7
+0.190000 0.0200000 0 7
+0.190000 0.0250000 0 7
+0.185000 0.0250000 0 7
+0.185000 0.0200000 0 7
+
+
+0.190000 0.0200000 0 7
+0.195000 0.0200000 0 7
+0.195000 0.0250000 0 7
+0.190000 0.0250000 0 7
+0.190000 0.0200000 0 7
+
+
+0.195000 0.0200000 0 7
+0.200000 0.0200000 0 7
+0.200000 0.0250000 0 7
+0.195000 0.0250000 0 7
+0.195000 0.0200000 0 7
+
+
diff --git a/tests/grid/grid_in_vtk_2d_field_data/mesh b/tests/grid/grid_in_vtk_2d_field_data/mesh
new file mode 100644 (file)
index 0000000..b4a9006
--- /dev/null
@@ -0,0 +1,743 @@
+# vtk DataFile Version 3.0
+vtk output
+ASCII
+DATASET UNSTRUCTURED_GRID
+POINTS 246 float
+0 0 0 0.005 0 0 0.01 0 0 
+0.015 0 0 0.02 0 0 0.025 0 0 
+0.03 0 0 0.035 0 0 0.04 0 0 
+0.045 0 0 0.05 0 0 0.055 0 0 
+0.06 0 0 0.065 0 0 0.07 0 0 
+0.075 0 0 0.08 0 0 0.085 0 0 
+0.09 0 0 0.095 0 0 0.1 0 0 
+0.105 0 0 0.11 0 0 0.115 0 0 
+0.12 0 0 0.125 0 0 0.13 0 0 
+0.135 0 0 0.14 0 0 0.145 0 0 
+0.15 0 0 0.155 0 0 0.16 0 0 
+0.165 0 0 0.17 0 0 0.175 0 0 
+0.18 0 0 0.185 0 0 0.19 0 0 
+0.195 0 0 0.2 0 0 0 0.005 0 
+0.005 0.005 0 0.01 0.005 0 0.015 0.005 0 
+0.02 0.005 0 0.025 0.005 0 0.03 0.005 0 
+0.035 0.005 0 0.04 0.005 0 0.045 0.005 0 
+0.05 0.005 0 0.055 0.005 0 0.06 0.005 0 
+0.065 0.005 0 0.07 0.005 0 0.075 0.005 0 
+0.08 0.005 0 0.085 0.005 0 0.09 0.005 0 
+0.095 0.005 0 0.1 0.005 0 0.105 0.005 0 
+0.11 0.005 0 0.115 0.005 0 0.12 0.005 0 
+0.125 0.005 0 0.13 0.005 0 0.135 0.005 0 
+0.14 0.005 0 0.145 0.005 0 0.15 0.005 0 
+0.155 0.005 0 0.16 0.005 0 0.165 0.005 0 
+0.17 0.005 0 0.175 0.005 0 0.18 0.005 0 
+0.185 0.005 0 0.19 0.005 0 0.195 0.005 0 
+0.2 0.005 0 0 0.01 0 0.005 0.01 0 
+0.01 0.01 0 0.015 0.01 0 0.02 0.01 0 
+0.025 0.01 0 0.03 0.01 0 0.035 0.01 0 
+0.04 0.01 0 0.045 0.01 0 0.05 0.01 0 
+0.055 0.01 0 0.06 0.01 0 0.065 0.01 0 
+0.07 0.01 0 0.075 0.01 0 0.08 0.01 0 
+0.085 0.01 0 0.09 0.01 0 0.095 0.01 0 
+0.1 0.01 0 0.105 0.01 0 0.11 0.01 0 
+0.115 0.01 0 0.12 0.01 0 0.125 0.01 0 
+0.13 0.01 0 0.135 0.01 0 0.14 0.01 0 
+0.145 0.01 0 0.15 0.01 0 0.155 0.01 0 
+0.16 0.01 0 0.165 0.01 0 0.17 0.01 0 
+0.175 0.01 0 0.18 0.01 0 0.185 0.01 0 
+0.19 0.01 0 0.195 0.01 0 0.2 0.01 0 
+0 0.015 0 0.005 0.015 0 0.01 0.015 0 
+0.015 0.015 0 0.02 0.015 0 0.025 0.015 0 
+0.03 0.015 0 0.035 0.015 0 0.04 0.015 0 
+0.045 0.015 0 0.05 0.015 0 0.055 0.015 0 
+0.06 0.015 0 0.065 0.015 0 0.07 0.015 0 
+0.075 0.015 0 0.08 0.015 0 0.085 0.015 0 
+0.09 0.015 0 0.095 0.015 0 0.1 0.015 0 
+0.105 0.015 0 0.11 0.015 0 0.115 0.015 0 
+0.12 0.015 0 0.125 0.015 0 0.13 0.015 0 
+0.135 0.015 0 0.14 0.015 0 0.145 0.015 0 
+0.15 0.015 0 0.155 0.015 0 0.16 0.015 0 
+0.165 0.015 0 0.17 0.015 0 0.175 0.015 0 
+0.18 0.015 0 0.185 0.015 0 0.19 0.015 0 
+0.195 0.015 0 0.2 0.015 0 0 0.02 0 
+0.005 0.02 0 0.01 0.02 0 0.015 0.02 0 
+0.02 0.02 0 0.025 0.02 0 0.03 0.02 0 
+0.035 0.02 0 0.04 0.02 0 0.045 0.02 0 
+0.05 0.02 0 0.055 0.02 0 0.06 0.02 0 
+0.065 0.02 0 0.07 0.02 0 0.075 0.02 0 
+0.08 0.02 0 0.085 0.02 0 0.09 0.02 0 
+0.095 0.02 0 0.1 0.02 0 0.105 0.02 0 
+0.11 0.02 0 0.115 0.02 0 0.12 0.02 0 
+0.125 0.02 0 0.13 0.02 0 0.135 0.02 0 
+0.14 0.02 0 0.145 0.02 0 0.15 0.02 0 
+0.155 0.02 0 0.16 0.02 0 0.165 0.02 0 
+0.17 0.02 0 0.175 0.02 0 0.18 0.02 0 
+0.185 0.02 0 0.19 0.02 0 0.195 0.02 0 
+0.2 0.02 0 0 0.025 0 0.005 0.025 0 
+0.01 0.025 0 0.015 0.025 0 0.02 0.025 0 
+0.025 0.025 0 0.03 0.025 0 0.035 0.025 0 
+0.04 0.025 0 0.045 0.025 0 0.05 0.025 0 
+0.055 0.025 0 0.06 0.025 0 0.065 0.025 0 
+0.07 0.025 0 0.075 0.025 0 0.08 0.025 0 
+0.085 0.025 0 0.09 0.025 0 0.095 0.025 0 
+0.1 0.025 0 0.105 0.025 0 0.11 0.025 0 
+0.115 0.025 0 0.12 0.025 0 0.125 0.025 0 
+0.13 0.025 0 0.135 0.025 0 0.14 0.025 0 
+0.145 0.025 0 0.15 0.025 0 0.155 0.025 0 
+0.16 0.025 0 0.165 0.025 0 0.17 0.025 0 
+0.175 0.025 0 0.18 0.025 0 0.185 0.025 0 
+0.19 0.025 0 0.195 0.025 0 0.2 0.025 0 
+
+CELLS 290 1270
+4 0 1 42 41 
+4 1 2 43 42 
+4 2 3 44 43 
+4 3 4 45 44 
+4 4 5 46 45 
+4 5 6 47 46 
+4 6 7 48 47 
+4 7 8 49 48 
+4 8 9 50 49 
+4 9 10 51 50 
+4 10 11 52 51 
+4 11 12 53 52 
+4 12 13 54 53 
+4 13 14 55 54 
+4 14 15 56 55 
+4 15 16 57 56 
+4 16 17 58 57 
+4 17 18 59 58 
+4 18 19 60 59 
+4 19 20 61 60 
+4 20 21 62 61 
+4 21 22 63 62 
+4 22 23 64 63 
+4 23 24 65 64 
+4 24 25 66 65 
+4 25 26 67 66 
+4 26 27 68 67 
+4 27 28 69 68 
+4 28 29 70 69 
+4 29 30 71 70 
+4 30 31 72 71 
+4 31 32 73 72 
+4 32 33 74 73 
+4 33 34 75 74 
+4 34 35 76 75 
+4 35 36 77 76 
+4 36 37 78 77 
+4 37 38 79 78 
+4 38 39 80 79 
+4 39 40 81 80 
+4 41 42 83 82 
+4 42 43 84 83 
+4 43 44 85 84 
+4 44 45 86 85 
+4 45 46 87 86 
+4 46 47 88 87 
+4 47 48 89 88 
+4 48 49 90 89 
+4 49 50 91 90 
+4 50 51 92 91 
+4 51 52 93 92 
+4 52 53 94 93 
+4 53 54 95 94 
+4 54 55 96 95 
+4 55 56 97 96 
+4 56 57 98 97 
+4 57 58 99 98 
+4 58 59 100 99 
+4 59 60 101 100 
+4 60 61 102 101 
+4 61 62 103 102 
+4 62 63 104 103 
+4 63 64 105 104 
+4 64 65 106 105 
+4 65 66 107 106 
+4 66 67 108 107 
+4 67 68 109 108 
+4 68 69 110 109 
+4 69 70 111 110 
+4 70 71 112 111 
+4 71 72 113 112 
+4 72 73 114 113 
+4 73 74 115 114 
+4 74 75 116 115 
+4 75 76 117 116 
+4 76 77 118 117 
+4 77 78 119 118 
+4 78 79 120 119 
+4 79 80 121 120 
+4 80 81 122 121 
+4 82 83 124 123 
+4 83 84 125 124 
+4 84 85 126 125 
+4 85 86 127 126 
+4 86 87 128 127 
+4 87 88 129 128 
+4 88 89 130 129 
+4 89 90 131 130 
+4 90 91 132 131 
+4 91 92 133 132 
+4 92 93 134 133 
+4 93 94 135 134 
+4 94 95 136 135 
+4 95 96 137 136 
+4 96 97 138 137 
+4 97 98 139 138 
+4 98 99 140 139 
+4 99 100 141 140 
+4 100 101 142 141 
+4 101 102 143 142 
+4 102 103 144 143 
+4 103 104 145 144 
+4 104 105 146 145 
+4 105 106 147 146 
+4 106 107 148 147 
+4 107 108 149 148 
+4 108 109 150 149 
+4 109 110 151 150 
+4 110 111 152 151 
+4 111 112 153 152 
+4 112 113 154 153 
+4 113 114 155 154 
+4 114 115 156 155 
+4 115 116 157 156 
+4 116 117 158 157 
+4 117 118 159 158 
+4 118 119 160 159 
+4 119 120 161 160 
+4 120 121 162 161 
+4 121 122 163 162 
+4 123 124 165 164 
+4 124 125 166 165 
+4 125 126 167 166 
+4 126 127 168 167 
+4 127 128 169 168 
+4 128 129 170 169 
+4 129 130 171 170 
+4 130 131 172 171 
+4 131 132 173 172 
+4 132 133 174 173 
+4 133 134 175 174 
+4 134 135 176 175 
+4 135 136 177 176 
+4 136 137 178 177 
+4 137 138 179 178 
+4 138 139 180 179 
+4 139 140 181 180 
+4 140 141 182 181 
+4 141 142 183 182 
+4 142 143 184 183 
+4 143 144 185 184 
+4 144 145 186 185 
+4 145 146 187 186 
+4 146 147 188 187 
+4 147 148 189 188 
+4 148 149 190 189 
+4 149 150 191 190 
+4 150 151 192 191 
+4 151 152 193 192 
+4 152 153 194 193 
+4 153 154 195 194 
+4 154 155 196 195 
+4 155 156 197 196 
+4 156 157 198 197 
+4 157 158 199 198 
+4 158 159 200 199 
+4 159 160 201 200 
+4 160 161 202 201 
+4 161 162 203 202 
+4 162 163 204 203 
+4 164 165 206 205 
+4 165 166 207 206 
+4 166 167 208 207 
+4 167 168 209 208 
+4 168 169 210 209 
+4 169 170 211 210 
+4 170 171 212 211 
+4 171 172 213 212 
+4 172 173 214 213 
+4 173 174 215 214 
+4 174 175 216 215 
+4 175 176 217 216 
+4 176 177 218 217 
+4 177 178 219 218 
+4 178 179 220 219 
+4 179 180 221 220 
+4 180 181 222 221 
+4 181 182 223 222 
+4 182 183 224 223 
+4 183 184 225 224 
+4 184 185 226 225 
+4 185 186 227 226 
+4 186 187 228 227 
+4 187 188 229 228 
+4 188 189 230 229 
+4 189 190 231 230 
+4 190 191 232 231 
+4 191 192 233 232 
+4 192 193 234 233 
+4 193 194 235 234 
+4 194 195 236 235 
+4 195 196 237 236 
+4 196 197 238 237 
+4 197 198 239 238 
+4 198 199 240 239 
+4 199 200 241 240 
+4 200 201 242 241 
+4 201 202 243 242 
+4 202 203 244 243 
+4 203 204 245 244 
+2 0 1 
+2 1 2 
+2 2 3 
+2 3 4 
+2 4 5 
+2 5 6 
+2 6 7 
+2 7 8 
+2 8 9 
+2 9 10 
+2 10 11 
+2 11 12 
+2 12 13 
+2 13 14 
+2 14 15 
+2 15 16 
+2 16 17 
+2 17 18 
+2 18 19 
+2 19 20 
+2 20 21 
+2 21 22 
+2 22 23 
+2 23 24 
+2 24 25 
+2 25 26 
+2 26 27 
+2 27 28 
+2 28 29 
+2 29 30 
+2 30 31 
+2 31 32 
+2 32 33 
+2 33 34 
+2 34 35 
+2 35 36 
+2 36 37 
+2 37 38 
+2 38 39 
+2 39 40 
+2 40 81 
+2 81 122 
+2 122 163 
+2 163 204 
+2 204 245 
+2 205 206 
+2 206 207 
+2 207 208 
+2 208 209 
+2 209 210 
+2 210 211 
+2 211 212 
+2 212 213 
+2 213 214 
+2 214 215 
+2 215 216 
+2 216 217 
+2 217 218 
+2 218 219 
+2 219 220 
+2 220 221 
+2 221 222 
+2 222 223 
+2 223 224 
+2 224 225 
+2 225 226 
+2 226 227 
+2 227 228 
+2 228 229 
+2 229 230 
+2 230 231 
+2 231 232 
+2 232 233 
+2 233 234 
+2 234 235 
+2 235 236 
+2 236 237 
+2 237 238 
+2 238 239 
+2 239 240 
+2 240 241 
+2 241 242 
+2 242 243 
+2 243 244 
+2 244 245 
+2 0 41 
+2 41 82 
+2 82 123 
+2 123 164 
+2 164 205 
+
+CELL_TYPES 290
+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
+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
+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
+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
+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
+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
+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
+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
+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
+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 290
+SCALARS MaterialID int
+LOOKUP_TABLE default
+7 7 7 7 7 7 7 7 7 
+7 7 7 7 7 7 7 7 7 
+7 7 7 7 7 7 7 7 7 
+7 7 7 7 7 7 7 7 7 
+7 7 7 7 7 7 7 7 7 
+7 7 7 7 7 7 7 7 7 
+7 7 7 7 7 7 7 7 7 
+7 7 7 7 7 7 7 7 7 
+7 7 7 7 7 7 7 7 7 
+7 7 7 7 7 7 7 7 7 
+7 7 7 7 7 7 7 7 7 
+7 7 7 7 7 7 7 7 7 
+7 7 7 7 7 7 7 7 7 
+7 7 7 7 7 7 7 7 7 
+7 7 7 7 7 7 7 7 7 
+7 7 7 7 7 7 7 7 7 
+7 7 7 7 7 7 7 7 7 
+7 7 7 7 7 7 7 7 7 
+7 7 7 7 7 7 7 7 7 
+7 7 7 7 7 7 7 7 7 
+7 7 7 7 7 7 7 7 7 
+7 7 7 7 7 7 7 7 7 
+7 7 8 8 8 8 8 8 8 
+8 8 8 8 8 8 8 8 8 
+8 8 8 8 8 8 8 8 8 
+8 8 8 8 8 8 8 8 8 
+8 8 8 8 8 8 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 9 9 9 9 
+9 9 9 9 9 9 9 9 9 
+9 9 9 9 9 9 10 10 10 
+10 10 
+FIELD FieldData 1
+Density 1 290 double
+0.88145882781 0.57321203097 0.65060156795 0.25745226977 0.31518815979 0.5003121427 0.32432541089 0.52316281732 0.21556703044 
+0.63853905394 0.002585705313 0.33281425319 0.32248335897 0.70766398125 0.85688526252 0.33396434492 0.30038551868 0.76312020143 
+0.47766252247 0.71086569878 0.68995658557 0.52928002155 0.92633237013 0.34920480438 0.66803420076 0.27707641149 0.37500518107 
+0.19224206157 0.50246638055 0.53932874934 0.95566796378 0.75633412515 0.77998638029 0.4030782368 0.86082018113 0.97096133252 
+0.4008347453 0.10565140886 0.91503140265 0.061682980007 0.573855488 0.12675528238 0.69830136106 0.85702514583 0.21379444866 
+0.21078757815 0.78081495953 0.93674341802 0.6400066983 0.31627193617 0.4821814573 0.0084872740388 0.95687819705 0.34358063836 
+0.84604823622 0.45554190759 0.17988106554 0.29340525076 0.2238932404 0.006882145254 0.9837182919 0.92509142556 0.98349100515 
+0.012877109007 0.052698089791 0.88108753586 0.16102866814 0.58440940449 0.17482565373 0.24811201096 0.43514470448 0.31346108427 
+0.27062945614 0.13808567235 0.77127586905 0.1989674898 0.46209703693 0.10069413472 0.29663744821 0.96977867801 0.51730085011 
+0.59229437767 0.078149199072 0.56720700146 0.044427137889 0.13232718307 0.73245873414 0.5893071029 0.373575153 0.88043615567 
+0.61443107586 0.38048569888 0.98409722169 0.65468103178 0.17695893531 0.79145687575 0.90783651144 0.36350572214 0.81369706582 
+0.38436694638 0.048931165585 0.36070455896 0.051927847417 0.24724016188 0.025361753627 0.82226414995 0.87179935817 0.69803990454 
+0.21290580091 0.13096392704 0.16268657441 0.93901712128 0.90395771331 0.87967791036 0.85253719319 0.90227846139 0.65933664624 
+0.00034256663332 0.1947328042 0.24183328525 0.46380396961 0.63320478109 0.080281777016 0.041660212635 0.29033934886 0.39893775618 
+0.84269753272 0.099783043939 0.96464949995 0.36094316287 0.56265671021 0.12963718893 0.063142786752 0.35647913104 0.50354953849 
+0.84765293724 0.34838770419 0.79246440735 0.40710085779 0.63075150597 0.45937654448 0.057366678566 0.54061734904 0.45461567343 
+0.95388982647 0.21749774547 0.080499573464 0.88426273937 0.76345135875 0.92804997085 0.099507570484 0.6352890738 0.79889810541 
+0.93779803758 0.68141302874 0.010049664437 0.53100765371 0.27751883701 0.13781720744 0.13600583561 0.37974331707 0.39103952278 
+0.79088061289 0.74778302702 0.57439482129 0.080279023091 0.55324286929 0.76242524139 0.86214140643 0.31577821473 0.2349818622 
+0.93173470165 0.63404106884 0.33827440943 0.49801195343 0.4880989273 0.4967665714 0.071122761168 0.87562249794 0.88869522597 
+0.085715372402 0.92985895425 0.97802625872 0.86454900276 0.082147644111 0.95767587995 0.14166794163 0.68564205976 0.31065152273 
+0.40003686492 0.78826191553 0.029188504515 0.66928874973 0.6537370491 0.45093893774 0.78065226353 0.040325391145 0.52399085712 
+0.55019436084 0.92191146352 8 8 8 8 8 8 8 
+8 8 8 8 8 8 8 8 8 
+8 8 8 8 8 8 8 8 8 
+8 8 8 8 8 8 8 8 8 
+8 8 8 8 8 8 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 9 9 9 9 
+9 9 9 9 9 9 9 9 9 
+9 9 9 9 9 9 10 10 10 
+10 10 

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.