]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Implement writing time and cycle to VTK files. VTU format is still missing.
authorbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Sun, 12 May 2013 21:16:05 +0000 (21:16 +0000)
committerbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Sun, 12 May 2013 21:16:05 +0000 (21:16 +0000)
git-svn-id: https://svn.dealii.org/trunk@29500 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/include/deal.II/base/data_out_base.h
deal.II/source/base/data_out_base.cc
tests/base/data_out_base_vtk_cycle.cc [new file with mode: 0644]
tests/base/data_out_base_vtk_cycle/cmp/generic [new file with mode: 0644]
tests/base/data_out_base_vtk_time.cc [new file with mode: 0644]
tests/base/data_out_base_vtk_time/cmp/generic [new file with mode: 0644]
tests/base/data_out_base_vtk_time_and_cycle.cc [new file with mode: 0644]
tests/base/data_out_base_vtk_time_and_cycle/cmp/generic [new file with mode: 0644]

index 14ea5b84d483ce293d1560ea3d1bfed7c771597c..ec985fa6e01936740176cc3f90b16166865f890c 100644 (file)
@@ -21,6 +21,7 @@
 
 #include <vector>
 #include <string>
+#include <limits>
 
 #include <deal.II/base/mpi.h>
 
@@ -1186,34 +1187,54 @@ public:
   /**
    * Flags controlling the details
    * of output in VTK
-   * format. At present no flags
-   * are implemented.
+   * format.
    *
    * @ingroup output
    */
   struct VtkFlags
   {
-  private:
+  public:
     /**
-     * Dummy entry to suppress compiler
-     * warnings when copying an empty
-     * structure. Remove this member
-     * when adding the first flag to
-     * this structure (and remove the
-     * <tt>private</tt> as well).
+     * The time of the time step if this file is part of a
+     * time dependent simulation.
+     *
+     * The value of this variable is written into the output file according
+     * to the instructions provided in
+     * http://www.visitusers.org/index.php?title=Time_and_Cycle_in_VTK_files
+     * unless it is at its default value of std::numeric_limits<double>::min().
      */
-    int dummy;
+    double time;
+
+    /**
+     * The number of the time step if this file is part of a
+     * time dependent simulation, or the cycle within a nonlinear or other
+     * iteration.
+     *
+     * The value of this variable is written into the output file according
+     * to the instructions provided in
+     * http://www.visitusers.org/index.php?title=Time_and_Cycle_in_VTK_files
+     * unless it is at its default value of std::numeric_limits<unsigned int>::min().
+     */
+    unsigned int cycle;
 
-  public:
     /**
      * Default constructor.
      */
-    VtkFlags ();
+    VtkFlags (const double       time  = std::numeric_limits<double>::min(),
+              const unsigned int cycle = std::numeric_limits<unsigned int>::min());
 
     /**
-     * Declare all flags with name
+     * Declare the flags with name
      * and type as offered by this
      * class, for use in input files.
+     *
+     * Unlike the flags in many of the other classes similar to this one, we do
+     * not actually declare parameters for the #cycle and #time member variables
+     * of this class. The reason is that there wouldn't appear to be a case where
+     * one would want to declare these parameters in an input file. Rather, these
+     * are typically values that change during the course of a simulation and
+     * can only reasonably be set as part of the execution of a program, rather
+     * than a priori by a user who runs this program.
      */
     static void declare_parameters (ParameterHandler &prm);
 
@@ -1246,6 +1267,8 @@ public:
      */
     std::size_t memory_consumption () const;
   };
+
+
   /**
    * Flags controlling the details
    * of output in deal.II
index ec51c103f8c4d7a518bfeec6af09b4a3ad9d14ef..f5a7448b64573537287fd8cffc77c2800b8d733e 100644 (file)
@@ -2176,7 +2176,11 @@ DataOutBase::TecplotFlags::memory_consumption () const
 
 
 
-DataOutBase::VtkFlags::VtkFlags ()
+DataOutBase::VtkFlags::VtkFlags (const double time,
+                                 const unsigned int cycle)
+  :
+  time (time),
+  cycle (cycle)
 {}
 
 
@@ -3657,13 +3661,13 @@ void DataOutBase::write_eps (const std::vector<Patch<dim,spacedim> > &patches,
                                        patch->data.n_rows()));
                 const double color_values[4]
                   = { patch->data.n_rows() != 0 ?
-                      patch->data(flags.color_vector,i1*d1 + i2*d2)       : 1,
+                      patch->data(flags.color_vector,i1 *d1 + i2 *d2)       : 1,
 
                       patch->data.n_rows() != 0 ?
-                      patch->data(flags.color_vector,(i1+1)*d1 + i2*d2)   : 1,
+                      patch->data(flags.color_vector,(i1+1)*d1 + i2 *d2)   : 1,
 
                       patch->data.n_rows() != 0 ?
-                      patch->data(flags.color_vector,i1*d1 + (i2+1)*d2)     : 1,
+                      patch->data(flags.color_vector,i1 *d1 + (i2+1)*d2)     : 1,
 
                       patch->data.n_rows() != 0 ?
                       patch->data(flags.color_vector,(i1+1)*d1 + (i2+1)*d2) : 1
@@ -4648,26 +4652,48 @@ DataOutBase::write_vtk (const std::vector<Patch<dim,spacedim> > &patches,
 
   ///////////////////////
   // preamble
-  if (true)
-    {
-      std::time_t  time1= std::time (0);
-      std::tm     *time = std::localtime(&time1);
-      out << "# vtk DataFile Version 3.0"
-          << '\n'
-          << "#This file was generated by the deal.II library on "
-          << time->tm_year+1900 << "/"
-          << time->tm_mon+1 << "/"
-          << time->tm_mday << " at "
-          << time->tm_hour << ":"
-          << std::setw(2) << time->tm_min << ":"
-          << std::setw(2) << time->tm_sec
-          << '\n'
-          << "ASCII"
-          << '\n'
-          << "DATASET UNSTRUCTURED_GRID\n"
-          << '\n';
-    }
+  {
+    std::time_t  time1= std::time (0);
+    std::tm     *time = std::localtime(&time1);
+    out << "# vtk DataFile Version 3.0"
+        << '\n'
+        << "#This file was generated by the deal.II library on "
+        << time->tm_year+1900 << "/"
+        << time->tm_mon+1 << "/"
+        << time->tm_mday << " at "
+        << time->tm_hour << ":"
+        << std::setw(2) << time->tm_min << ":"
+        << std::setw(2) << time->tm_sec
+        << '\n'
+        << "ASCII"
+        << '\n';
+    // now output the data header
+    out << "DATASET UNSTRUCTURED_GRID\n"
+        << '\n';
+}
 
+  // if desired, output time and cycle of the simulation, following
+  // the instructions at
+  // http://www.visitusers.org/index.php?title=Time_and_Cycle_in_VTK_files
+  {
+    const unsigned int
+    n_metadata = ((flags.cycle != std::numeric_limits<unsigned int>::min() ? 1 : 0)
+                  +
+                  (flags.time != std::numeric_limits<double>::min() ? 1 : 0));
+    if (n_metadata > 0)
+      out << "FIELD FieldData " << n_metadata << "\n";
+
+    if (flags.cycle != std::numeric_limits<unsigned int>::min())
+      {
+        out << "CYCLE 1 1 int\n"
+            << flags.cycle << "\n";
+      }
+    if (flags.time != std::numeric_limits<double>::min())
+      {
+        out << "TIME 1 1 double\n"
+            << flags.time << "\n";
+      }
+  }
 
   // first count the number of cells
   // and cells for later use
@@ -5938,7 +5964,7 @@ void DataOutBase::write_hdf5_parallel (const std::vector<Patch<dim,spacedim> > &
 #ifndef DEAL_II_COMPILER_SUPPORTS_MPI
   // verify that there are indeed
   // patches to be written out. most
-  // of the times, people just forget 
+  // of the times, people just forget
   // to call build_patches when there
   // are no patches, so a warning is
   // in order. that said, the
@@ -5975,15 +6001,18 @@ void DataOutBase::write_hdf5_parallel (const std::vector<Patch<dim,spacedim> > &
 #endif
 #endif
 
-  if (empty_proc) {
-    local_node_cell_count[0] = local_node_cell_count[1] = 0;
-  } else {
-    compute_sizes<dim,spacedim>(patches, local_node_cell_count[0], local_node_cell_count[1]);
+  if (empty_proc)
+    {
+      local_node_cell_count[0] = local_node_cell_count[1] = 0;
+    }
+  else
+    {
+      compute_sizes<dim,spacedim>(patches, local_node_cell_count[0], local_node_cell_count[1]);
 
-    data_vectors = Table<2,double> (n_data_sets, local_node_cell_count[0]);
-    void (*fun_ptr) (const std::vector<Patch<dim,spacedim> > &, Table<2,double> &) = &DataOutBase::template write_gmv_reorder_data_vectors<dim,spacedim>;
-    reorder_task = Threads::new_task (fun_ptr, patches, data_vectors);
-  }
+      data_vectors = Table<2,double> (n_data_sets, local_node_cell_count[0]);
+      void (*fun_ptr) (const std::vector<Patch<dim,spacedim> > &, Table<2,double> &) = &DataOutBase::template write_gmv_reorder_data_vectors<dim,spacedim>;
+      reorder_task = Threads::new_task (fun_ptr, patches, data_vectors);
+    }
 
   // Create file access properties
   plist_id = H5Pcreate(H5P_FILE_ACCESS);
diff --git a/tests/base/data_out_base_vtk_cycle.cc b/tests/base/data_out_base_vtk_cycle.cc
new file mode 100644 (file)
index 0000000..6d42c1f
--- /dev/null
@@ -0,0 +1,89 @@
+//-----------------------------------------------------------------------------
+//    $Id$
+//    Version: $Name$ 
+//
+//    Copyright (C) 2006, 2007, 2013 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//-----------------------------------------------------------------------------
+
+// like data_out_base_vtk, but output cycle as well
+
+
+#include "../tests.h"
+#include <deal.II/base/data_out_base.h>
+#include <deal.II/base/logstream.h>
+
+#include <vector>
+#include <iomanip>
+#include <fstream>
+#include <string>
+#include <stdio.h>
+
+#include "patches.h"
+
+// Output data on repetitions of the unit hypercube
+
+// define this as 1 to get output into a separate file for each testcase
+#define SEPARATE_FILES 0
+
+
+template <int dim, int spacedim>
+void check(DataOutBase::VtkFlags flags,
+          std::ostream& out)
+{
+  const unsigned int np = 4;
+  
+  std::vector<DataOutBase::Patch<dim, spacedim> > patches(np);
+  
+  create_patches(patches);
+  
+  std::vector<std::string> names(5);
+  names[0] = "x1";
+  names[1] = "x2";
+  names[2] = "x3";
+  names[3] = "x4";
+  names[4] = "i";
+  std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > vectors;
+  DataOutBase::write_vtk(patches, names, vectors, flags, out);
+}
+
+
+template<int dim, int spacedim>
+void check_all(std::ostream& log)
+{
+#if SEPARATE_FILES == 0
+  std::ostream& out = log;
+#endif
+  
+  char name[100];
+  DataOutBase::VtkFlags flags;
+
+  flags.cycle = 42;
+  
+  if (true) {
+    sprintf(name, "data_out_base_vtk_cycle/%d%d.vtk", dim, spacedim);
+#if SEPARATE_FILES==1
+    std::ofstream out(name);
+#else
+       out << "==============================\n"
+           << name
+           << "\n==============================\n";
+#endif
+    check<dim,spacedim>(flags, out);
+  }
+}
+
+int main()
+{
+  std::ofstream logfile("data_out_base_vtk_cycle/output");
+  check_all<1,1>(logfile);
+  check_all<1,2>(logfile);
+  check_all<2,2>(logfile);
+  check_all<2,3>(logfile);
+  check_all<3,3>(logfile);
+}
diff --git a/tests/base/data_out_base_vtk_cycle/cmp/generic b/tests/base/data_out_base_vtk_cycle/cmp/generic
new file mode 100644 (file)
index 0000000..4ea2ca1
--- /dev/null
@@ -0,0 +1,705 @@
+==============================
+data_out_base_vtk_cycle/11.vtk
+==============================
+# vtk DataFile Version 3.0
+#This file was generated 
+ASCII
+DATASET UNSTRUCTURED_GRID
+
+FIELD FieldData 1
+CYCLE 1 1 int
+42
+POINTS 14 double
+0 0 0
+1 0 0
+1 0 0
+1.5 0 0
+2 0 0
+2 0 0
+2.33333 0 0
+2.66667 0 0
+3 0 0
+3 0 0
+3.25 0 0
+3.5 0 0
+3.75 0 0
+4 0 0
+
+CELLS 10 30
+2      0       1
+2      2       3
+2      3       4
+2      5       6
+2      6       7
+2      7       8
+2      9       10
+2      10      11
+2      11      12
+2      12      13
+
+CELL_TYPES 10
+ 3 3 3 3 3 3 3 3 3 3
+POINT_DATA 14
+SCALARS x1 double 1
+LOOKUP_TABLE default
+0 1 1 1.5 2 2 2.33333 2.66667 3 3 3.25 3.5 3.75 4 
+SCALARS x2 double 1
+LOOKUP_TABLE default
+0 0 1 1 1 2 2 2 2 3 3 3 3 3 
+SCALARS x3 double 1
+LOOKUP_TABLE default
+0 0 1 1 1 2 2 2 2 3 3 3 3 3 
+SCALARS x4 double 1
+LOOKUP_TABLE default
+0 0 1 1 1 2 2 2 2 3 3 3 3 3 
+SCALARS i double 1
+LOOKUP_TABLE default
+0 1 0 1 2 0 1 2 3 0 1 2 3 4 
+==============================
+data_out_base_vtk_cycle/12.vtk
+==============================
+# vtk DataFile Version 3.0
+#This file was generated 
+ASCII
+DATASET UNSTRUCTURED_GRID
+
+FIELD FieldData 1
+CYCLE 1 1 int
+42
+POINTS 14 double
+0 0 0
+1 1 0
+1 1 0
+1.5 1.5 0
+2 2 0
+2 2 0
+2.33333 2.33333 0
+2.66667 2.66667 0
+3 3 0
+3 3 0
+3.25 3.25 0
+3.5 3.5 0
+3.75 3.75 0
+4 4 0
+
+CELLS 10 30
+2      0       1
+2      2       3
+2      3       4
+2      5       6
+2      6       7
+2      7       8
+2      9       10
+2      10      11
+2      11      12
+2      12      13
+
+CELL_TYPES 10
+ 3 3 3 3 3 3 3 3 3 3
+POINT_DATA 14
+SCALARS x1 double 1
+LOOKUP_TABLE default
+0 1 1 1.5 2 2 2.33333 2.66667 3 3 3.25 3.5 3.75 4 
+SCALARS x2 double 1
+LOOKUP_TABLE default
+0 0 1 1 1 2 2 2 2 3 3 3 3 3 
+SCALARS x3 double 1
+LOOKUP_TABLE default
+0 0 1 1 1 2 2 2 2 3 3 3 3 3 
+SCALARS x4 double 1
+LOOKUP_TABLE default
+0 0 1 1 1 2 2 2 2 3 3 3 3 3 
+SCALARS i double 1
+LOOKUP_TABLE default
+0 1 0 1 2 0 1 2 3 0 1 2 3 4 
+==============================
+data_out_base_vtk_cycle/22.vtk
+==============================
+# vtk DataFile Version 3.0
+#This file was generated 
+ASCII
+DATASET UNSTRUCTURED_GRID
+
+FIELD FieldData 1
+CYCLE 1 1 int
+42
+POINTS 54 double
+0 0 0
+1 0 0
+0 1 0
+1 1 0
+1 1 0
+1.5 1 0
+2 1 0
+1 1.5 0
+1.5 1.5 0
+2 1.5 0
+1 2 0
+1.5 2 0
+2 2 0
+2 2 0
+2.33333 2 0
+2.66667 2 0
+3 2 0
+2 2.33333 0
+2.33333 2.33333 0
+2.66667 2.33333 0
+3 2.33333 0
+2 2.66667 0
+2.33333 2.66667 0
+2.66667 2.66667 0
+3 2.66667 0
+2 3 0
+2.33333 3 0
+2.66667 3 0
+3 3 0
+3 3 0
+3.25 3 0
+3.5 3 0
+3.75 3 0
+4 3 0
+3 3.25 0
+3.25 3.25 0
+3.5 3.25 0
+3.75 3.25 0
+4 3.25 0
+3 3.5 0
+3.25 3.5 0
+3.5 3.5 0
+3.75 3.5 0
+4 3.5 0
+3 3.75 0
+3.25 3.75 0
+3.5 3.75 0
+3.75 3.75 0
+4 3.75 0
+3 4 0
+3.25 4 0
+3.5 4 0
+3.75 4 0
+4 4 0
+
+CELLS 30 150
+4      0       1       3       2
+4      4       5       8       7
+4      5       6       9       8
+4      7       8       11      10
+4      8       9       12      11
+4      13      14      18      17
+4      14      15      19      18
+4      15      16      20      19
+4      17      18      22      21
+4      18      19      23      22
+4      19      20      24      23
+4      21      22      26      25
+4      22      23      27      26
+4      23      24      28      27
+4      29      30      35      34
+4      30      31      36      35
+4      31      32      37      36
+4      32      33      38      37
+4      34      35      40      39
+4      35      36      41      40
+4      36      37      42      41
+4      37      38      43      42
+4      39      40      45      44
+4      40      41      46      45
+4      41      42      47      46
+4      42      43      48      47
+4      44      45      50      49
+4      45      46      51      50
+4      46      47      52      51
+4      47      48      53      52
+
+CELL_TYPES 30
+ 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
+POINT_DATA 54
+SCALARS x1 double 1
+LOOKUP_TABLE default
+0 1 0 1 1 1.5 2 1 1.5 2 1 1.5 2 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 
+SCALARS x2 double 1
+LOOKUP_TABLE default
+0 0 1 1 1 1 1 1.5 1.5 1.5 2 2 2 2 2 2 2 2.33333 2.33333 2.33333 2.33333 2.66667 2.66667 2.66667 2.66667 3 3 3 3 3 3 3 3 3 3.25 3.25 3.25 3.25 3.25 3.5 3.5 3.5 3.5 3.5 3.75 3.75 3.75 3.75 3.75 4 4 4 4 4 
+SCALARS x3 double 1
+LOOKUP_TABLE default
+0 0 0 0 1 1 1 1 1 1 1 1 1 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 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 
+SCALARS x4 double 1
+LOOKUP_TABLE default
+0 0 0 0 1 1 1 1 1 1 1 1 1 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 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 
+SCALARS i double 1
+LOOKUP_TABLE default
+0 1 2 3 0 1 2 3 4 5 6 7 8 0 1 2 3 4 5 6 7 8 9 10 11 12 13 14 15 0 1 2 3 4 5 6 7 8 9 10 11 12 13 14 15 16 17 18 19 20 21 22 23 24 
+==============================
+data_out_base_vtk_cycle/23.vtk
+==============================
+# vtk DataFile Version 3.0
+#This file was generated 
+ASCII
+DATASET UNSTRUCTURED_GRID
+
+FIELD FieldData 1
+CYCLE 1 1 int
+42
+POINTS 54 double
+0 0 0
+1 0 1
+0 1 2
+1 1 3
+1 1 1
+1.5 1 1.5
+2 1 2
+1 1.5 2
+1.5 1.5 2.5
+2 1.5 3
+1 2 3
+1.5 2 3.5
+2 2 4
+2 2 2
+2.33333 2 2.33333
+2.66667 2 2.66667
+3 2 3
+2 2.33333 2.66667
+2.33333 2.33333 3
+2.66667 2.33333 3.33333
+3 2.33333 3.66667
+2 2.66667 3.33333
+2.33333 2.66667 3.66667
+2.66667 2.66667 4
+3 2.66667 4.33333
+2 3 4
+2.33333 3 4.33333
+2.66667 3 4.66667
+3 3 5
+3 3 3
+3.25 3 3.25
+3.5 3 3.5
+3.75 3 3.75
+4 3 4
+3 3.25 3.5
+3.25 3.25 3.75
+3.5 3.25 4
+3.75 3.25 4.25
+4 3.25 4.5
+3 3.5 4
+3.25 3.5 4.25
+3.5 3.5 4.5
+3.75 3.5 4.75
+4 3.5 5
+3 3.75 4.5
+3.25 3.75 4.75
+3.5 3.75 5
+3.75 3.75 5.25
+4 3.75 5.5
+3 4 5
+3.25 4 5.25
+3.5 4 5.5
+3.75 4 5.75
+4 4 6
+
+CELLS 30 150
+4      0       1       3       2
+4      4       5       8       7
+4      5       6       9       8
+4      7       8       11      10
+4      8       9       12      11
+4      13      14      18      17
+4      14      15      19      18
+4      15      16      20      19
+4      17      18      22      21
+4      18      19      23      22
+4      19      20      24      23
+4      21      22      26      25
+4      22      23      27      26
+4      23      24      28      27
+4      29      30      35      34
+4      30      31      36      35
+4      31      32      37      36
+4      32      33      38      37
+4      34      35      40      39
+4      35      36      41      40
+4      36      37      42      41
+4      37      38      43      42
+4      39      40      45      44
+4      40      41      46      45
+4      41      42      47      46
+4      42      43      48      47
+4      44      45      50      49
+4      45      46      51      50
+4      46      47      52      51
+4      47      48      53      52
+
+CELL_TYPES 30
+ 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
+POINT_DATA 54
+SCALARS x1 double 1
+LOOKUP_TABLE default
+0 1 0 1 1 1.5 2 1 1.5 2 1 1.5 2 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 
+SCALARS x2 double 1
+LOOKUP_TABLE default
+0 0 1 1 1 1 1 1.5 1.5 1.5 2 2 2 2 2 2 2 2.33333 2.33333 2.33333 2.33333 2.66667 2.66667 2.66667 2.66667 3 3 3 3 3 3 3 3 3 3.25 3.25 3.25 3.25 3.25 3.5 3.5 3.5 3.5 3.5 3.75 3.75 3.75 3.75 3.75 4 4 4 4 4 
+SCALARS x3 double 1
+LOOKUP_TABLE default
+0 0 0 0 1 1 1 1 1 1 1 1 1 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 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 
+SCALARS x4 double 1
+LOOKUP_TABLE default
+0 0 0 0 1 1 1 1 1 1 1 1 1 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 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 
+SCALARS i double 1
+LOOKUP_TABLE default
+0 1 2 3 0 1 2 3 4 5 6 7 8 0 1 2 3 4 5 6 7 8 9 10 11 12 13 14 15 0 1 2 3 4 5 6 7 8 9 10 11 12 13 14 15 16 17 18 19 20 21 22 23 24 
+==============================
+data_out_base_vtk_cycle/33.vtk
+==============================
+# vtk DataFile Version 3.0
+#This file was generated 
+ASCII
+DATASET UNSTRUCTURED_GRID
+
+FIELD FieldData 1
+CYCLE 1 1 int
+42
+POINTS 224 double
+0 0 0
+1 0 0
+0 1 0
+1 1 0
+0 0 1
+1 0 1
+0 1 1
+1 1 1
+1 1 1
+1.5 1 1
+2 1 1
+1 1.5 1
+1.5 1.5 1
+2 1.5 1
+1 2 1
+1.5 2 1
+2 2 1
+1 1 1.5
+1.5 1 1.5
+2 1 1.5
+1 1.5 1.5
+1.5 1.5 1.5
+2 1.5 1.5
+1 2 1.5
+1.5 2 1.5
+2 2 1.5
+1 1 2
+1.5 1 2
+2 1 2
+1 1.5 2
+1.5 1.5 2
+2 1.5 2
+1 2 2
+1.5 2 2
+2 2 2
+2 2 2
+2.33333 2 2
+2.66667 2 2
+3 2 2
+2 2.33333 2
+2.33333 2.33333 2
+2.66667 2.33333 2
+3 2.33333 2
+2 2.66667 2
+2.33333 2.66667 2
+2.66667 2.66667 2
+3 2.66667 2
+2 3 2
+2.33333 3 2
+2.66667 3 2
+3 3 2
+2 2 2.33333
+2.33333 2 2.33333
+2.66667 2 2.33333
+3 2 2.33333
+2 2.33333 2.33333
+2.33333 2.33333 2.33333
+2.66667 2.33333 2.33333
+3 2.33333 2.33333
+2 2.66667 2.33333
+2.33333 2.66667 2.33333
+2.66667 2.66667 2.33333
+3 2.66667 2.33333
+2 3 2.33333
+2.33333 3 2.33333
+2.66667 3 2.33333
+3 3 2.33333
+2 2 2.66667
+2.33333 2 2.66667
+2.66667 2 2.66667
+3 2 2.66667
+2 2.33333 2.66667
+2.33333 2.33333 2.66667
+2.66667 2.33333 2.66667
+3 2.33333 2.66667
+2 2.66667 2.66667
+2.33333 2.66667 2.66667
+2.66667 2.66667 2.66667
+3 2.66667 2.66667
+2 3 2.66667
+2.33333 3 2.66667
+2.66667 3 2.66667
+3 3 2.66667
+2 2 3
+2.33333 2 3
+2.66667 2 3
+3 2 3
+2 2.33333 3
+2.33333 2.33333 3
+2.66667 2.33333 3
+3 2.33333 3
+2 2.66667 3
+2.33333 2.66667 3
+2.66667 2.66667 3
+3 2.66667 3
+2 3 3
+2.33333 3 3
+2.66667 3 3
+3 3 3
+3 3 3
+3.25 3 3
+3.5 3 3
+3.75 3 3
+4 3 3
+3 3.25 3
+3.25 3.25 3
+3.5 3.25 3
+3.75 3.25 3
+4 3.25 3
+3 3.5 3
+3.25 3.5 3
+3.5 3.5 3
+3.75 3.5 3
+4 3.5 3
+3 3.75 3
+3.25 3.75 3
+3.5 3.75 3
+3.75 3.75 3
+4 3.75 3
+3 4 3
+3.25 4 3
+3.5 4 3
+3.75 4 3
+4 4 3
+3 3 3.25
+3.25 3 3.25
+3.5 3 3.25
+3.75 3 3.25
+4 3 3.25
+3 3.25 3.25
+3.25 3.25 3.25
+3.5 3.25 3.25
+3.75 3.25 3.25
+4 3.25 3.25
+3 3.5 3.25
+3.25 3.5 3.25
+3.5 3.5 3.25
+3.75 3.5 3.25
+4 3.5 3.25
+3 3.75 3.25
+3.25 3.75 3.25
+3.5 3.75 3.25
+3.75 3.75 3.25
+4 3.75 3.25
+3 4 3.25
+3.25 4 3.25
+3.5 4 3.25
+3.75 4 3.25
+4 4 3.25
+3 3 3.5
+3.25 3 3.5
+3.5 3 3.5
+3.75 3 3.5
+4 3 3.5
+3 3.25 3.5
+3.25 3.25 3.5
+3.5 3.25 3.5
+3.75 3.25 3.5
+4 3.25 3.5
+3 3.5 3.5
+3.25 3.5 3.5
+3.5 3.5 3.5
+3.75 3.5 3.5
+4 3.5 3.5
+3 3.75 3.5
+3.25 3.75 3.5
+3.5 3.75 3.5
+3.75 3.75 3.5
+4 3.75 3.5
+3 4 3.5
+3.25 4 3.5
+3.5 4 3.5
+3.75 4 3.5
+4 4 3.5
+3 3 3.75
+3.25 3 3.75
+3.5 3 3.75
+3.75 3 3.75
+4 3 3.75
+3 3.25 3.75
+3.25 3.25 3.75
+3.5 3.25 3.75
+3.75 3.25 3.75
+4 3.25 3.75
+3 3.5 3.75
+3.25 3.5 3.75
+3.5 3.5 3.75
+3.75 3.5 3.75
+4 3.5 3.75
+3 3.75 3.75
+3.25 3.75 3.75
+3.5 3.75 3.75
+3.75 3.75 3.75
+4 3.75 3.75
+3 4 3.75
+3.25 4 3.75
+3.5 4 3.75
+3.75 4 3.75
+4 4 3.75
+3 3 4
+3.25 3 4
+3.5 3 4
+3.75 3 4
+4 3 4
+3 3.25 4
+3.25 3.25 4
+3.5 3.25 4
+3.75 3.25 4
+4 3.25 4
+3 3.5 4
+3.25 3.5 4
+3.5 3.5 4
+3.75 3.5 4
+4 3.5 4
+3 3.75 4
+3.25 3.75 4
+3.5 3.75 4
+3.75 3.75 4
+4 3.75 4
+3 4 4
+3.25 4 4
+3.5 4 4
+3.75 4 4
+4 4 4
+
+CELLS 100 900
+8      0       1       3       2       4       5       7       6
+8      8       9       12      11      17      18      21      20
+8      9       10      13      12      18      19      22      21
+8      11      12      15      14      20      21      24      23
+8      12      13      16      15      21      22      25      24
+8      17      18      21      20      26      27      30      29
+8      18      19      22      21      27      28      31      30
+8      20      21      24      23      29      30      33      32
+8      21      22      25      24      30      31      34      33
+8      35      36      40      39      51      52      56      55
+8      36      37      41      40      52      53      57      56
+8      37      38      42      41      53      54      58      57
+8      39      40      44      43      55      56      60      59
+8      40      41      45      44      56      57      61      60
+8      41      42      46      45      57      58      62      61
+8      43      44      48      47      59      60      64      63
+8      44      45      49      48      60      61      65      64
+8      45      46      50      49      61      62      66      65
+8      51      52      56      55      67      68      72      71
+8      52      53      57      56      68      69      73      72
+8      53      54      58      57      69      70      74      73
+8      55      56      60      59      71      72      76      75
+8      56      57      61      60      72      73      77      76
+8      57      58      62      61      73      74      78      77
+8      59      60      64      63      75      76      80      79
+8      60      61      65      64      76      77      81      80
+8      61      62      66      65      77      78      82      81
+8      67      68      72      71      83      84      88      87
+8      68      69      73      72      84      85      89      88
+8      69      70      74      73      85      86      90      89
+8      71      72      76      75      87      88      92      91
+8      72      73      77      76      88      89      93      92
+8      73      74      78      77      89      90      94      93
+8      75      76      80      79      91      92      96      95
+8      76      77      81      80      92      93      97      96
+8      77      78      82      81      93      94      98      97
+8      99      100     105     104     124     125     130     129
+8      100     101     106     105     125     126     131     130
+8      101     102     107     106     126     127     132     131
+8      102     103     108     107     127     128     133     132
+8      104     105     110     109     129     130     135     134
+8      105     106     111     110     130     131     136     135
+8      106     107     112     111     131     132     137     136
+8      107     108     113     112     132     133     138     137
+8      109     110     115     114     134     135     140     139
+8      110     111     116     115     135     136     141     140
+8      111     112     117     116     136     137     142     141
+8      112     113     118     117     137     138     143     142
+8      114     115     120     119     139     140     145     144
+8      115     116     121     120     140     141     146     145
+8      116     117     122     121     141     142     147     146
+8      117     118     123     122     142     143     148     147
+8      124     125     130     129     149     150     155     154
+8      125     126     131     130     150     151     156     155
+8      126     127     132     131     151     152     157     156
+8      127     128     133     132     152     153     158     157
+8      129     130     135     134     154     155     160     159
+8      130     131     136     135     155     156     161     160
+8      131     132     137     136     156     157     162     161
+8      132     133     138     137     157     158     163     162
+8      134     135     140     139     159     160     165     164
+8      135     136     141     140     160     161     166     165
+8      136     137     142     141     161     162     167     166
+8      137     138     143     142     162     163     168     167
+8      139     140     145     144     164     165     170     169
+8      140     141     146     145     165     166     171     170
+8      141     142     147     146     166     167     172     171
+8      142     143     148     147     167     168     173     172
+8      149     150     155     154     174     175     180     179
+8      150     151     156     155     175     176     181     180
+8      151     152     157     156     176     177     182     181
+8      152     153     158     157     177     178     183     182
+8      154     155     160     159     179     180     185     184
+8      155     156     161     160     180     181     186     185
+8      156     157     162     161     181     182     187     186
+8      157     158     163     162     182     183     188     187
+8      159     160     165     164     184     185     190     189
+8      160     161     166     165     185     186     191     190
+8      161     162     167     166     186     187     192     191
+8      162     163     168     167     187     188     193     192
+8      164     165     170     169     189     190     195     194
+8      165     166     171     170     190     191     196     195
+8      166     167     172     171     191     192     197     196
+8      167     168     173     172     192     193     198     197
+8      174     175     180     179     199     200     205     204
+8      175     176     181     180     200     201     206     205
+8      176     177     182     181     201     202     207     206
+8      177     178     183     182     202     203     208     207
+8      179     180     185     184     204     205     210     209
+8      180     181     186     185     205     206     211     210
+8      181     182     187     186     206     207     212     211
+8      182     183     188     187     207     208     213     212
+8      184     185     190     189     209     210     215     214
+8      185     186     191     190     210     211     216     215
+8      186     187     192     191     211     212     217     216
+8      187     188     193     192     212     213     218     217
+8      189     190     195     194     214     215     220     219
+8      190     191     196     195     215     216     221     220
+8      191     192     197     196     216     217     222     221
+8      192     193     198     197     217     218     223     222
+
+CELL_TYPES 100
+ 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12
+POINT_DATA 224
+SCALARS x1 double 1
+LOOKUP_TABLE default
+0 1 0 1 0 1 0 1 1 1.5 2 1 1.5 2 1 1.5 2 1 1.5 2 1 1.5 2 1 1.5 2 1 1.5 2 1 1.5 2 1 1.5 2 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 
+SCALARS x2 double 1
+LOOKUP_TABLE default
+0 0 1 1 0 0 1 1 1 1 1 1.5 1.5 1.5 2 2 2 1 1 1 1.5 1.5 1.5 2 2 2 1 1 1 1.5 1.5 1.5 2 2 2 2 2 2 2 2.33333 2.33333 2.33333 2.33333 2.66667 2.66667 2.66667 2.66667 3 3 3 3 2 2 2 2 2.33333 2.33333 2.33333 2.33333 2.66667 2.66667 2.66667 2.66667 3 3 3 3 2 2 2 2 2.33333 2.33333 2.33333 2.33333 2.66667 2.66667 2.66667 2.66667 3 3 3 3 2 2 2 2 2.33333 2.33333 2.33333 2.33333 2.66667 2.66667 2.66667 2.66667 3 3 3 3 3 3 3 3 3 3.25 3.25 3.25 3.25 3.25 3.5 3.5 3.5 3.5 3.5 3.75 3.75 3.75 3.75 3.75 4 4 4 4 4 3 3 3 3 3 3.25 3.25 3.25 3.25 3.25 3.5 3.5 3.5 3.5 3.5 3.75 3.75 3.75 3.75 3.75 4 4 4 4 4 3 3 3 3 3 3.25 3.25 3.25 3.25 3.25 3.5 3.5 3.5 3.5 3.5 3.75 3.75 3.75 3.75 3.75 4 4 4 4 4 3 3 3 3 3 3.25 3.25 3.25 3.25 3.25 3.5 3.5 3.5 3.5 3.5 3.75 3.75 3.75 3.75 3.75 4 4 4 4 4 3 3 3 3 3 3.25 3.25 3.25 3.25 3.25 3.5 3.5 3.5 3.5 3.5 3.75 3.75 3.75 3.75 3.75 4 4 4 4 4 
+SCALARS x3 double 1
+LOOKUP_TABLE default
+0 0 0 0 1 1 1 1 1 1 1 1 1 1 1 1 1 1.5 1.5 1.5 1.5 1.5 1.5 1.5 1.5 1.5 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2.33333 2.33333 2.33333 2.33333 2.33333 2.33333 2.33333 2.33333 2.33333 2.33333 2.33333 2.33333 2.33333 2.33333 2.33333 2.33333 2.66667 2.66667 2.66667 2.66667 2.66667 2.66667 2.66667 2.66667 2.66667 2.66667 2.66667 2.66667 2.66667 2.66667 2.66667 2.66667 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.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 4 4 4 4 4 4 4 4 4 4 4 4 4 4 4 4 4 4 4 4 4 4 4 4 4 
+SCALARS x4 double 1
+LOOKUP_TABLE default
+0 0 0 0 0 0 0 0 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 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 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 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 
+SCALARS i double 1
+LOOKUP_TABLE default
+0 1 2 3 4 5 6 7 0 1 2 3 4 5 6 7 8 9 10 11 12 13 14 15 16 17 18 19 20 21 22 23 24 25 26 0 1 2 3 4 5 6 7 8 9 10 11 12 13 14 15 16 17 18 19 20 21 22 23 24 25 26 27 28 29 30 31 32 33 34 35 36 37 38 39 40 41 42 43 44 45 46 47 48 49 50 51 52 53 54 55 56 57 58 59 60 61 62 63 0 1 2 3 4 5 6 7 8 9 10 11 12 13 14 15 16 17 18 19 20 21 22 23 24 25 26 27 28 29 30 31 32 33 34 35 36 37 38 39 40 41 42 43 44 45 46 47 48 49 50 51 52 53 54 55 56 57 58 59 60 61 62 63 64 65 66 67 68 69 70 71 72 73 74 75 76 77 78 79 80 81 82 83 84 85 86 87 88 89 90 91 92 93 94 95 96 97 98 99 100 101 102 103 104 105 106 107 108 109 110 111 112 113 114 115 116 117 118 119 120 121 122 123 124 
diff --git a/tests/base/data_out_base_vtk_time.cc b/tests/base/data_out_base_vtk_time.cc
new file mode 100644 (file)
index 0000000..9f47288
--- /dev/null
@@ -0,0 +1,89 @@
+//-----------------------------------------------------------------------------
+//    $Id$
+//    Version: $Name$ 
+//
+//    Copyright (C) 2006, 2007, 2013 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//-----------------------------------------------------------------------------
+
+// like data_out_base_vtk, but output time as well
+
+
+#include "../tests.h"
+#include <deal.II/base/data_out_base.h>
+#include <deal.II/base/logstream.h>
+
+#include <vector>
+#include <iomanip>
+#include <fstream>
+#include <string>
+#include <stdio.h>
+
+#include "patches.h"
+
+// Output data on repetitions of the unit hypercube
+
+// define this as 1 to get output into a separate file for each testcase
+#define SEPARATE_FILES 0
+
+
+template <int dim, int spacedim>
+void check(DataOutBase::VtkFlags flags,
+          std::ostream& out)
+{
+  const unsigned int np = 4;
+  
+  std::vector<DataOutBase::Patch<dim, spacedim> > patches(np);
+  
+  create_patches(patches);
+  
+  std::vector<std::string> names(5);
+  names[0] = "x1";
+  names[1] = "x2";
+  names[2] = "x3";
+  names[3] = "x4";
+  names[4] = "i";
+  std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > vectors;
+  DataOutBase::write_vtk(patches, names, vectors, flags, out);
+}
+
+
+template<int dim, int spacedim>
+void check_all(std::ostream& log)
+{
+#if SEPARATE_FILES == 0
+  std::ostream& out = log;
+#endif
+  
+  char name[100];
+  DataOutBase::VtkFlags flags;
+
+  flags.time = numbers::PI;
+  
+  if (true) {
+    sprintf(name, "data_out_base_vtk_time/%d%d.vtk", dim, spacedim);
+#if SEPARATE_FILES==1
+    std::ofstream out(name);
+#else
+       out << "==============================\n"
+           << name
+           << "\n==============================\n";
+#endif
+    check<dim,spacedim>(flags, out);
+  }
+}
+
+int main()
+{
+  std::ofstream logfile("data_out_base_vtk_time/output");
+  check_all<1,1>(logfile);
+  check_all<1,2>(logfile);
+  check_all<2,2>(logfile);
+  check_all<2,3>(logfile);
+  check_all<3,3>(logfile);
+}
diff --git a/tests/base/data_out_base_vtk_time/cmp/generic b/tests/base/data_out_base_vtk_time/cmp/generic
new file mode 100644 (file)
index 0000000..671d824
--- /dev/null
@@ -0,0 +1,705 @@
+==============================
+data_out_base_vtk_time/11.vtk
+==============================
+# vtk DataFile Version 3.0
+#This file was generated 
+ASCII
+DATASET UNSTRUCTURED_GRID
+
+FIELD FieldData 1
+TIME 1 1 double
+3.14159
+POINTS 14 double
+0 0 0
+1 0 0
+1 0 0
+1.5 0 0
+2 0 0
+2 0 0
+2.33333 0 0
+2.66667 0 0
+3 0 0
+3 0 0
+3.25 0 0
+3.5 0 0
+3.75 0 0
+4 0 0
+
+CELLS 10 30
+2      0       1
+2      2       3
+2      3       4
+2      5       6
+2      6       7
+2      7       8
+2      9       10
+2      10      11
+2      11      12
+2      12      13
+
+CELL_TYPES 10
+ 3 3 3 3 3 3 3 3 3 3
+POINT_DATA 14
+SCALARS x1 double 1
+LOOKUP_TABLE default
+0 1 1 1.5 2 2 2.33333 2.66667 3 3 3.25 3.5 3.75 4 
+SCALARS x2 double 1
+LOOKUP_TABLE default
+0 0 1 1 1 2 2 2 2 3 3 3 3 3 
+SCALARS x3 double 1
+LOOKUP_TABLE default
+0 0 1 1 1 2 2 2 2 3 3 3 3 3 
+SCALARS x4 double 1
+LOOKUP_TABLE default
+0 0 1 1 1 2 2 2 2 3 3 3 3 3 
+SCALARS i double 1
+LOOKUP_TABLE default
+0 1 0 1 2 0 1 2 3 0 1 2 3 4 
+==============================
+data_out_base_vtk_time/12.vtk
+==============================
+# vtk DataFile Version 3.0
+#This file was generated 
+ASCII
+DATASET UNSTRUCTURED_GRID
+
+FIELD FieldData 1
+TIME 1 1 double
+3.14159
+POINTS 14 double
+0 0 0
+1 1 0
+1 1 0
+1.5 1.5 0
+2 2 0
+2 2 0
+2.33333 2.33333 0
+2.66667 2.66667 0
+3 3 0
+3 3 0
+3.25 3.25 0
+3.5 3.5 0
+3.75 3.75 0
+4 4 0
+
+CELLS 10 30
+2      0       1
+2      2       3
+2      3       4
+2      5       6
+2      6       7
+2      7       8
+2      9       10
+2      10      11
+2      11      12
+2      12      13
+
+CELL_TYPES 10
+ 3 3 3 3 3 3 3 3 3 3
+POINT_DATA 14
+SCALARS x1 double 1
+LOOKUP_TABLE default
+0 1 1 1.5 2 2 2.33333 2.66667 3 3 3.25 3.5 3.75 4 
+SCALARS x2 double 1
+LOOKUP_TABLE default
+0 0 1 1 1 2 2 2 2 3 3 3 3 3 
+SCALARS x3 double 1
+LOOKUP_TABLE default
+0 0 1 1 1 2 2 2 2 3 3 3 3 3 
+SCALARS x4 double 1
+LOOKUP_TABLE default
+0 0 1 1 1 2 2 2 2 3 3 3 3 3 
+SCALARS i double 1
+LOOKUP_TABLE default
+0 1 0 1 2 0 1 2 3 0 1 2 3 4 
+==============================
+data_out_base_vtk_time/22.vtk
+==============================
+# vtk DataFile Version 3.0
+#This file was generated 
+ASCII
+DATASET UNSTRUCTURED_GRID
+
+FIELD FieldData 1
+TIME 1 1 double
+3.14159
+POINTS 54 double
+0 0 0
+1 0 0
+0 1 0
+1 1 0
+1 1 0
+1.5 1 0
+2 1 0
+1 1.5 0
+1.5 1.5 0
+2 1.5 0
+1 2 0
+1.5 2 0
+2 2 0
+2 2 0
+2.33333 2 0
+2.66667 2 0
+3 2 0
+2 2.33333 0
+2.33333 2.33333 0
+2.66667 2.33333 0
+3 2.33333 0
+2 2.66667 0
+2.33333 2.66667 0
+2.66667 2.66667 0
+3 2.66667 0
+2 3 0
+2.33333 3 0
+2.66667 3 0
+3 3 0
+3 3 0
+3.25 3 0
+3.5 3 0
+3.75 3 0
+4 3 0
+3 3.25 0
+3.25 3.25 0
+3.5 3.25 0
+3.75 3.25 0
+4 3.25 0
+3 3.5 0
+3.25 3.5 0
+3.5 3.5 0
+3.75 3.5 0
+4 3.5 0
+3 3.75 0
+3.25 3.75 0
+3.5 3.75 0
+3.75 3.75 0
+4 3.75 0
+3 4 0
+3.25 4 0
+3.5 4 0
+3.75 4 0
+4 4 0
+
+CELLS 30 150
+4      0       1       3       2
+4      4       5       8       7
+4      5       6       9       8
+4      7       8       11      10
+4      8       9       12      11
+4      13      14      18      17
+4      14      15      19      18
+4      15      16      20      19
+4      17      18      22      21
+4      18      19      23      22
+4      19      20      24      23
+4      21      22      26      25
+4      22      23      27      26
+4      23      24      28      27
+4      29      30      35      34
+4      30      31      36      35
+4      31      32      37      36
+4      32      33      38      37
+4      34      35      40      39
+4      35      36      41      40
+4      36      37      42      41
+4      37      38      43      42
+4      39      40      45      44
+4      40      41      46      45
+4      41      42      47      46
+4      42      43      48      47
+4      44      45      50      49
+4      45      46      51      50
+4      46      47      52      51
+4      47      48      53      52
+
+CELL_TYPES 30
+ 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
+POINT_DATA 54
+SCALARS x1 double 1
+LOOKUP_TABLE default
+0 1 0 1 1 1.5 2 1 1.5 2 1 1.5 2 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 
+SCALARS x2 double 1
+LOOKUP_TABLE default
+0 0 1 1 1 1 1 1.5 1.5 1.5 2 2 2 2 2 2 2 2.33333 2.33333 2.33333 2.33333 2.66667 2.66667 2.66667 2.66667 3 3 3 3 3 3 3 3 3 3.25 3.25 3.25 3.25 3.25 3.5 3.5 3.5 3.5 3.5 3.75 3.75 3.75 3.75 3.75 4 4 4 4 4 
+SCALARS x3 double 1
+LOOKUP_TABLE default
+0 0 0 0 1 1 1 1 1 1 1 1 1 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 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 
+SCALARS x4 double 1
+LOOKUP_TABLE default
+0 0 0 0 1 1 1 1 1 1 1 1 1 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 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 
+SCALARS i double 1
+LOOKUP_TABLE default
+0 1 2 3 0 1 2 3 4 5 6 7 8 0 1 2 3 4 5 6 7 8 9 10 11 12 13 14 15 0 1 2 3 4 5 6 7 8 9 10 11 12 13 14 15 16 17 18 19 20 21 22 23 24 
+==============================
+data_out_base_vtk_time/23.vtk
+==============================
+# vtk DataFile Version 3.0
+#This file was generated 
+ASCII
+DATASET UNSTRUCTURED_GRID
+
+FIELD FieldData 1
+TIME 1 1 double
+3.14159
+POINTS 54 double
+0 0 0
+1 0 1
+0 1 2
+1 1 3
+1 1 1
+1.5 1 1.5
+2 1 2
+1 1.5 2
+1.5 1.5 2.5
+2 1.5 3
+1 2 3
+1.5 2 3.5
+2 2 4
+2 2 2
+2.33333 2 2.33333
+2.66667 2 2.66667
+3 2 3
+2 2.33333 2.66667
+2.33333 2.33333 3
+2.66667 2.33333 3.33333
+3 2.33333 3.66667
+2 2.66667 3.33333
+2.33333 2.66667 3.66667
+2.66667 2.66667 4
+3 2.66667 4.33333
+2 3 4
+2.33333 3 4.33333
+2.66667 3 4.66667
+3 3 5
+3 3 3
+3.25 3 3.25
+3.5 3 3.5
+3.75 3 3.75
+4 3 4
+3 3.25 3.5
+3.25 3.25 3.75
+3.5 3.25 4
+3.75 3.25 4.25
+4 3.25 4.5
+3 3.5 4
+3.25 3.5 4.25
+3.5 3.5 4.5
+3.75 3.5 4.75
+4 3.5 5
+3 3.75 4.5
+3.25 3.75 4.75
+3.5 3.75 5
+3.75 3.75 5.25
+4 3.75 5.5
+3 4 5
+3.25 4 5.25
+3.5 4 5.5
+3.75 4 5.75
+4 4 6
+
+CELLS 30 150
+4      0       1       3       2
+4      4       5       8       7
+4      5       6       9       8
+4      7       8       11      10
+4      8       9       12      11
+4      13      14      18      17
+4      14      15      19      18
+4      15      16      20      19
+4      17      18      22      21
+4      18      19      23      22
+4      19      20      24      23
+4      21      22      26      25
+4      22      23      27      26
+4      23      24      28      27
+4      29      30      35      34
+4      30      31      36      35
+4      31      32      37      36
+4      32      33      38      37
+4      34      35      40      39
+4      35      36      41      40
+4      36      37      42      41
+4      37      38      43      42
+4      39      40      45      44
+4      40      41      46      45
+4      41      42      47      46
+4      42      43      48      47
+4      44      45      50      49
+4      45      46      51      50
+4      46      47      52      51
+4      47      48      53      52
+
+CELL_TYPES 30
+ 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
+POINT_DATA 54
+SCALARS x1 double 1
+LOOKUP_TABLE default
+0 1 0 1 1 1.5 2 1 1.5 2 1 1.5 2 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 
+SCALARS x2 double 1
+LOOKUP_TABLE default
+0 0 1 1 1 1 1 1.5 1.5 1.5 2 2 2 2 2 2 2 2.33333 2.33333 2.33333 2.33333 2.66667 2.66667 2.66667 2.66667 3 3 3 3 3 3 3 3 3 3.25 3.25 3.25 3.25 3.25 3.5 3.5 3.5 3.5 3.5 3.75 3.75 3.75 3.75 3.75 4 4 4 4 4 
+SCALARS x3 double 1
+LOOKUP_TABLE default
+0 0 0 0 1 1 1 1 1 1 1 1 1 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 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 
+SCALARS x4 double 1
+LOOKUP_TABLE default
+0 0 0 0 1 1 1 1 1 1 1 1 1 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 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 
+SCALARS i double 1
+LOOKUP_TABLE default
+0 1 2 3 0 1 2 3 4 5 6 7 8 0 1 2 3 4 5 6 7 8 9 10 11 12 13 14 15 0 1 2 3 4 5 6 7 8 9 10 11 12 13 14 15 16 17 18 19 20 21 22 23 24 
+==============================
+data_out_base_vtk_time/33.vtk
+==============================
+# vtk DataFile Version 3.0
+#This file was generated 
+ASCII
+DATASET UNSTRUCTURED_GRID
+
+FIELD FieldData 1
+TIME 1 1 double
+3.14159
+POINTS 224 double
+0 0 0
+1 0 0
+0 1 0
+1 1 0
+0 0 1
+1 0 1
+0 1 1
+1 1 1
+1 1 1
+1.5 1 1
+2 1 1
+1 1.5 1
+1.5 1.5 1
+2 1.5 1
+1 2 1
+1.5 2 1
+2 2 1
+1 1 1.5
+1.5 1 1.5
+2 1 1.5
+1 1.5 1.5
+1.5 1.5 1.5
+2 1.5 1.5
+1 2 1.5
+1.5 2 1.5
+2 2 1.5
+1 1 2
+1.5 1 2
+2 1 2
+1 1.5 2
+1.5 1.5 2
+2 1.5 2
+1 2 2
+1.5 2 2
+2 2 2
+2 2 2
+2.33333 2 2
+2.66667 2 2
+3 2 2
+2 2.33333 2
+2.33333 2.33333 2
+2.66667 2.33333 2
+3 2.33333 2
+2 2.66667 2
+2.33333 2.66667 2
+2.66667 2.66667 2
+3 2.66667 2
+2 3 2
+2.33333 3 2
+2.66667 3 2
+3 3 2
+2 2 2.33333
+2.33333 2 2.33333
+2.66667 2 2.33333
+3 2 2.33333
+2 2.33333 2.33333
+2.33333 2.33333 2.33333
+2.66667 2.33333 2.33333
+3 2.33333 2.33333
+2 2.66667 2.33333
+2.33333 2.66667 2.33333
+2.66667 2.66667 2.33333
+3 2.66667 2.33333
+2 3 2.33333
+2.33333 3 2.33333
+2.66667 3 2.33333
+3 3 2.33333
+2 2 2.66667
+2.33333 2 2.66667
+2.66667 2 2.66667
+3 2 2.66667
+2 2.33333 2.66667
+2.33333 2.33333 2.66667
+2.66667 2.33333 2.66667
+3 2.33333 2.66667
+2 2.66667 2.66667
+2.33333 2.66667 2.66667
+2.66667 2.66667 2.66667
+3 2.66667 2.66667
+2 3 2.66667
+2.33333 3 2.66667
+2.66667 3 2.66667
+3 3 2.66667
+2 2 3
+2.33333 2 3
+2.66667 2 3
+3 2 3
+2 2.33333 3
+2.33333 2.33333 3
+2.66667 2.33333 3
+3 2.33333 3
+2 2.66667 3
+2.33333 2.66667 3
+2.66667 2.66667 3
+3 2.66667 3
+2 3 3
+2.33333 3 3
+2.66667 3 3
+3 3 3
+3 3 3
+3.25 3 3
+3.5 3 3
+3.75 3 3
+4 3 3
+3 3.25 3
+3.25 3.25 3
+3.5 3.25 3
+3.75 3.25 3
+4 3.25 3
+3 3.5 3
+3.25 3.5 3
+3.5 3.5 3
+3.75 3.5 3
+4 3.5 3
+3 3.75 3
+3.25 3.75 3
+3.5 3.75 3
+3.75 3.75 3
+4 3.75 3
+3 4 3
+3.25 4 3
+3.5 4 3
+3.75 4 3
+4 4 3
+3 3 3.25
+3.25 3 3.25
+3.5 3 3.25
+3.75 3 3.25
+4 3 3.25
+3 3.25 3.25
+3.25 3.25 3.25
+3.5 3.25 3.25
+3.75 3.25 3.25
+4 3.25 3.25
+3 3.5 3.25
+3.25 3.5 3.25
+3.5 3.5 3.25
+3.75 3.5 3.25
+4 3.5 3.25
+3 3.75 3.25
+3.25 3.75 3.25
+3.5 3.75 3.25
+3.75 3.75 3.25
+4 3.75 3.25
+3 4 3.25
+3.25 4 3.25
+3.5 4 3.25
+3.75 4 3.25
+4 4 3.25
+3 3 3.5
+3.25 3 3.5
+3.5 3 3.5
+3.75 3 3.5
+4 3 3.5
+3 3.25 3.5
+3.25 3.25 3.5
+3.5 3.25 3.5
+3.75 3.25 3.5
+4 3.25 3.5
+3 3.5 3.5
+3.25 3.5 3.5
+3.5 3.5 3.5
+3.75 3.5 3.5
+4 3.5 3.5
+3 3.75 3.5
+3.25 3.75 3.5
+3.5 3.75 3.5
+3.75 3.75 3.5
+4 3.75 3.5
+3 4 3.5
+3.25 4 3.5
+3.5 4 3.5
+3.75 4 3.5
+4 4 3.5
+3 3 3.75
+3.25 3 3.75
+3.5 3 3.75
+3.75 3 3.75
+4 3 3.75
+3 3.25 3.75
+3.25 3.25 3.75
+3.5 3.25 3.75
+3.75 3.25 3.75
+4 3.25 3.75
+3 3.5 3.75
+3.25 3.5 3.75
+3.5 3.5 3.75
+3.75 3.5 3.75
+4 3.5 3.75
+3 3.75 3.75
+3.25 3.75 3.75
+3.5 3.75 3.75
+3.75 3.75 3.75
+4 3.75 3.75
+3 4 3.75
+3.25 4 3.75
+3.5 4 3.75
+3.75 4 3.75
+4 4 3.75
+3 3 4
+3.25 3 4
+3.5 3 4
+3.75 3 4
+4 3 4
+3 3.25 4
+3.25 3.25 4
+3.5 3.25 4
+3.75 3.25 4
+4 3.25 4
+3 3.5 4
+3.25 3.5 4
+3.5 3.5 4
+3.75 3.5 4
+4 3.5 4
+3 3.75 4
+3.25 3.75 4
+3.5 3.75 4
+3.75 3.75 4
+4 3.75 4
+3 4 4
+3.25 4 4
+3.5 4 4
+3.75 4 4
+4 4 4
+
+CELLS 100 900
+8      0       1       3       2       4       5       7       6
+8      8       9       12      11      17      18      21      20
+8      9       10      13      12      18      19      22      21
+8      11      12      15      14      20      21      24      23
+8      12      13      16      15      21      22      25      24
+8      17      18      21      20      26      27      30      29
+8      18      19      22      21      27      28      31      30
+8      20      21      24      23      29      30      33      32
+8      21      22      25      24      30      31      34      33
+8      35      36      40      39      51      52      56      55
+8      36      37      41      40      52      53      57      56
+8      37      38      42      41      53      54      58      57
+8      39      40      44      43      55      56      60      59
+8      40      41      45      44      56      57      61      60
+8      41      42      46      45      57      58      62      61
+8      43      44      48      47      59      60      64      63
+8      44      45      49      48      60      61      65      64
+8      45      46      50      49      61      62      66      65
+8      51      52      56      55      67      68      72      71
+8      52      53      57      56      68      69      73      72
+8      53      54      58      57      69      70      74      73
+8      55      56      60      59      71      72      76      75
+8      56      57      61      60      72      73      77      76
+8      57      58      62      61      73      74      78      77
+8      59      60      64      63      75      76      80      79
+8      60      61      65      64      76      77      81      80
+8      61      62      66      65      77      78      82      81
+8      67      68      72      71      83      84      88      87
+8      68      69      73      72      84      85      89      88
+8      69      70      74      73      85      86      90      89
+8      71      72      76      75      87      88      92      91
+8      72      73      77      76      88      89      93      92
+8      73      74      78      77      89      90      94      93
+8      75      76      80      79      91      92      96      95
+8      76      77      81      80      92      93      97      96
+8      77      78      82      81      93      94      98      97
+8      99      100     105     104     124     125     130     129
+8      100     101     106     105     125     126     131     130
+8      101     102     107     106     126     127     132     131
+8      102     103     108     107     127     128     133     132
+8      104     105     110     109     129     130     135     134
+8      105     106     111     110     130     131     136     135
+8      106     107     112     111     131     132     137     136
+8      107     108     113     112     132     133     138     137
+8      109     110     115     114     134     135     140     139
+8      110     111     116     115     135     136     141     140
+8      111     112     117     116     136     137     142     141
+8      112     113     118     117     137     138     143     142
+8      114     115     120     119     139     140     145     144
+8      115     116     121     120     140     141     146     145
+8      116     117     122     121     141     142     147     146
+8      117     118     123     122     142     143     148     147
+8      124     125     130     129     149     150     155     154
+8      125     126     131     130     150     151     156     155
+8      126     127     132     131     151     152     157     156
+8      127     128     133     132     152     153     158     157
+8      129     130     135     134     154     155     160     159
+8      130     131     136     135     155     156     161     160
+8      131     132     137     136     156     157     162     161
+8      132     133     138     137     157     158     163     162
+8      134     135     140     139     159     160     165     164
+8      135     136     141     140     160     161     166     165
+8      136     137     142     141     161     162     167     166
+8      137     138     143     142     162     163     168     167
+8      139     140     145     144     164     165     170     169
+8      140     141     146     145     165     166     171     170
+8      141     142     147     146     166     167     172     171
+8      142     143     148     147     167     168     173     172
+8      149     150     155     154     174     175     180     179
+8      150     151     156     155     175     176     181     180
+8      151     152     157     156     176     177     182     181
+8      152     153     158     157     177     178     183     182
+8      154     155     160     159     179     180     185     184
+8      155     156     161     160     180     181     186     185
+8      156     157     162     161     181     182     187     186
+8      157     158     163     162     182     183     188     187
+8      159     160     165     164     184     185     190     189
+8      160     161     166     165     185     186     191     190
+8      161     162     167     166     186     187     192     191
+8      162     163     168     167     187     188     193     192
+8      164     165     170     169     189     190     195     194
+8      165     166     171     170     190     191     196     195
+8      166     167     172     171     191     192     197     196
+8      167     168     173     172     192     193     198     197
+8      174     175     180     179     199     200     205     204
+8      175     176     181     180     200     201     206     205
+8      176     177     182     181     201     202     207     206
+8      177     178     183     182     202     203     208     207
+8      179     180     185     184     204     205     210     209
+8      180     181     186     185     205     206     211     210
+8      181     182     187     186     206     207     212     211
+8      182     183     188     187     207     208     213     212
+8      184     185     190     189     209     210     215     214
+8      185     186     191     190     210     211     216     215
+8      186     187     192     191     211     212     217     216
+8      187     188     193     192     212     213     218     217
+8      189     190     195     194     214     215     220     219
+8      190     191     196     195     215     216     221     220
+8      191     192     197     196     216     217     222     221
+8      192     193     198     197     217     218     223     222
+
+CELL_TYPES 100
+ 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12
+POINT_DATA 224
+SCALARS x1 double 1
+LOOKUP_TABLE default
+0 1 0 1 0 1 0 1 1 1.5 2 1 1.5 2 1 1.5 2 1 1.5 2 1 1.5 2 1 1.5 2 1 1.5 2 1 1.5 2 1 1.5 2 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 
+SCALARS x2 double 1
+LOOKUP_TABLE default
+0 0 1 1 0 0 1 1 1 1 1 1.5 1.5 1.5 2 2 2 1 1 1 1.5 1.5 1.5 2 2 2 1 1 1 1.5 1.5 1.5 2 2 2 2 2 2 2 2.33333 2.33333 2.33333 2.33333 2.66667 2.66667 2.66667 2.66667 3 3 3 3 2 2 2 2 2.33333 2.33333 2.33333 2.33333 2.66667 2.66667 2.66667 2.66667 3 3 3 3 2 2 2 2 2.33333 2.33333 2.33333 2.33333 2.66667 2.66667 2.66667 2.66667 3 3 3 3 2 2 2 2 2.33333 2.33333 2.33333 2.33333 2.66667 2.66667 2.66667 2.66667 3 3 3 3 3 3 3 3 3 3.25 3.25 3.25 3.25 3.25 3.5 3.5 3.5 3.5 3.5 3.75 3.75 3.75 3.75 3.75 4 4 4 4 4 3 3 3 3 3 3.25 3.25 3.25 3.25 3.25 3.5 3.5 3.5 3.5 3.5 3.75 3.75 3.75 3.75 3.75 4 4 4 4 4 3 3 3 3 3 3.25 3.25 3.25 3.25 3.25 3.5 3.5 3.5 3.5 3.5 3.75 3.75 3.75 3.75 3.75 4 4 4 4 4 3 3 3 3 3 3.25 3.25 3.25 3.25 3.25 3.5 3.5 3.5 3.5 3.5 3.75 3.75 3.75 3.75 3.75 4 4 4 4 4 3 3 3 3 3 3.25 3.25 3.25 3.25 3.25 3.5 3.5 3.5 3.5 3.5 3.75 3.75 3.75 3.75 3.75 4 4 4 4 4 
+SCALARS x3 double 1
+LOOKUP_TABLE default
+0 0 0 0 1 1 1 1 1 1 1 1 1 1 1 1 1 1.5 1.5 1.5 1.5 1.5 1.5 1.5 1.5 1.5 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2.33333 2.33333 2.33333 2.33333 2.33333 2.33333 2.33333 2.33333 2.33333 2.33333 2.33333 2.33333 2.33333 2.33333 2.33333 2.33333 2.66667 2.66667 2.66667 2.66667 2.66667 2.66667 2.66667 2.66667 2.66667 2.66667 2.66667 2.66667 2.66667 2.66667 2.66667 2.66667 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.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 4 4 4 4 4 4 4 4 4 4 4 4 4 4 4 4 4 4 4 4 4 4 4 4 4 
+SCALARS x4 double 1
+LOOKUP_TABLE default
+0 0 0 0 0 0 0 0 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 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 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 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 
+SCALARS i double 1
+LOOKUP_TABLE default
+0 1 2 3 4 5 6 7 0 1 2 3 4 5 6 7 8 9 10 11 12 13 14 15 16 17 18 19 20 21 22 23 24 25 26 0 1 2 3 4 5 6 7 8 9 10 11 12 13 14 15 16 17 18 19 20 21 22 23 24 25 26 27 28 29 30 31 32 33 34 35 36 37 38 39 40 41 42 43 44 45 46 47 48 49 50 51 52 53 54 55 56 57 58 59 60 61 62 63 0 1 2 3 4 5 6 7 8 9 10 11 12 13 14 15 16 17 18 19 20 21 22 23 24 25 26 27 28 29 30 31 32 33 34 35 36 37 38 39 40 41 42 43 44 45 46 47 48 49 50 51 52 53 54 55 56 57 58 59 60 61 62 63 64 65 66 67 68 69 70 71 72 73 74 75 76 77 78 79 80 81 82 83 84 85 86 87 88 89 90 91 92 93 94 95 96 97 98 99 100 101 102 103 104 105 106 107 108 109 110 111 112 113 114 115 116 117 118 119 120 121 122 123 124 
diff --git a/tests/base/data_out_base_vtk_time_and_cycle.cc b/tests/base/data_out_base_vtk_time_and_cycle.cc
new file mode 100644 (file)
index 0000000..75a6a8d
--- /dev/null
@@ -0,0 +1,90 @@
+//-----------------------------------------------------------------------------
+//    $Id$
+//    Version: $Name$ 
+//
+//    Copyright (C) 2006, 2007, 2013 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//-----------------------------------------------------------------------------
+
+// like data_out_base_vtk, but output time and cycle as well
+
+
+#include "../tests.h"
+#include <deal.II/base/data_out_base.h>
+#include <deal.II/base/logstream.h>
+
+#include <vector>
+#include <iomanip>
+#include <fstream>
+#include <string>
+#include <stdio.h>
+
+#include "patches.h"
+
+// Output data on repetitions of the unit hypercube
+
+// define this as 1 to get output into a separate file for each testcase
+#define SEPARATE_FILES 0
+
+
+template <int dim, int spacedim>
+void check(DataOutBase::VtkFlags flags,
+          std::ostream& out)
+{
+  const unsigned int np = 4;
+  
+  std::vector<DataOutBase::Patch<dim, spacedim> > patches(np);
+  
+  create_patches(patches);
+  
+  std::vector<std::string> names(5);
+  names[0] = "x1";
+  names[1] = "x2";
+  names[2] = "x3";
+  names[3] = "x4";
+  names[4] = "i";
+  std::vector<std_cxx1x::tuple<unsigned int, unsigned int, std::string> > vectors;
+  DataOutBase::write_vtk(patches, names, vectors, flags, out);
+}
+
+
+template<int dim, int spacedim>
+void check_all(std::ostream& log)
+{
+#if SEPARATE_FILES == 0
+  std::ostream& out = log;
+#endif
+  
+  char name[100];
+  DataOutBase::VtkFlags flags;
+
+  flags.time = numbers::PI;
+  flags.cycle = 42;
+  
+  if (true) {
+    sprintf(name, "data_out_base_vtk_time_and_cycle/%d%d.vtk", dim, spacedim);
+#if SEPARATE_FILES==1
+    std::ofstream out(name);
+#else
+       out << "==============================\n"
+           << name
+           << "\n==============================\n";
+#endif
+    check<dim,spacedim>(flags, out);
+  }
+}
+
+int main()
+{
+  std::ofstream logfile("data_out_base_vtk_time_and_cycle/output");
+  check_all<1,1>(logfile);
+  check_all<1,2>(logfile);
+  check_all<2,2>(logfile);
+  check_all<2,3>(logfile);
+  check_all<3,3>(logfile);
+}
diff --git a/tests/base/data_out_base_vtk_time_and_cycle/cmp/generic b/tests/base/data_out_base_vtk_time_and_cycle/cmp/generic
new file mode 100644 (file)
index 0000000..9e84e47
--- /dev/null
@@ -0,0 +1,715 @@
+==============================
+data_out_base_vtk_time_and_cycle/11.vtk
+==============================
+# vtk DataFile Version 3.0
+#This file was generated 
+ASCII
+DATASET UNSTRUCTURED_GRID
+
+FIELD FieldData 2
+CYCLE 1 1 int
+42
+TIME 1 1 double
+3.14159
+POINTS 14 double
+0 0 0
+1 0 0
+1 0 0
+1.5 0 0
+2 0 0
+2 0 0
+2.33333 0 0
+2.66667 0 0
+3 0 0
+3 0 0
+3.25 0 0
+3.5 0 0
+3.75 0 0
+4 0 0
+
+CELLS 10 30
+2      0       1
+2      2       3
+2      3       4
+2      5       6
+2      6       7
+2      7       8
+2      9       10
+2      10      11
+2      11      12
+2      12      13
+
+CELL_TYPES 10
+ 3 3 3 3 3 3 3 3 3 3
+POINT_DATA 14
+SCALARS x1 double 1
+LOOKUP_TABLE default
+0 1 1 1.5 2 2 2.33333 2.66667 3 3 3.25 3.5 3.75 4 
+SCALARS x2 double 1
+LOOKUP_TABLE default
+0 0 1 1 1 2 2 2 2 3 3 3 3 3 
+SCALARS x3 double 1
+LOOKUP_TABLE default
+0 0 1 1 1 2 2 2 2 3 3 3 3 3 
+SCALARS x4 double 1
+LOOKUP_TABLE default
+0 0 1 1 1 2 2 2 2 3 3 3 3 3 
+SCALARS i double 1
+LOOKUP_TABLE default
+0 1 0 1 2 0 1 2 3 0 1 2 3 4 
+==============================
+data_out_base_vtk_time_and_cycle/12.vtk
+==============================
+# vtk DataFile Version 3.0
+#This file was generated 
+ASCII
+DATASET UNSTRUCTURED_GRID
+
+FIELD FieldData 2
+CYCLE 1 1 int
+42
+TIME 1 1 double
+3.14159
+POINTS 14 double
+0 0 0
+1 1 0
+1 1 0
+1.5 1.5 0
+2 2 0
+2 2 0
+2.33333 2.33333 0
+2.66667 2.66667 0
+3 3 0
+3 3 0
+3.25 3.25 0
+3.5 3.5 0
+3.75 3.75 0
+4 4 0
+
+CELLS 10 30
+2      0       1
+2      2       3
+2      3       4
+2      5       6
+2      6       7
+2      7       8
+2      9       10
+2      10      11
+2      11      12
+2      12      13
+
+CELL_TYPES 10
+ 3 3 3 3 3 3 3 3 3 3
+POINT_DATA 14
+SCALARS x1 double 1
+LOOKUP_TABLE default
+0 1 1 1.5 2 2 2.33333 2.66667 3 3 3.25 3.5 3.75 4 
+SCALARS x2 double 1
+LOOKUP_TABLE default
+0 0 1 1 1 2 2 2 2 3 3 3 3 3 
+SCALARS x3 double 1
+LOOKUP_TABLE default
+0 0 1 1 1 2 2 2 2 3 3 3 3 3 
+SCALARS x4 double 1
+LOOKUP_TABLE default
+0 0 1 1 1 2 2 2 2 3 3 3 3 3 
+SCALARS i double 1
+LOOKUP_TABLE default
+0 1 0 1 2 0 1 2 3 0 1 2 3 4 
+==============================
+data_out_base_vtk_time_and_cycle/22.vtk
+==============================
+# vtk DataFile Version 3.0
+#This file was generated 
+ASCII
+DATASET UNSTRUCTURED_GRID
+
+FIELD FieldData 2
+CYCLE 1 1 int
+42
+TIME 1 1 double
+3.14159
+POINTS 54 double
+0 0 0
+1 0 0
+0 1 0
+1 1 0
+1 1 0
+1.5 1 0
+2 1 0
+1 1.5 0
+1.5 1.5 0
+2 1.5 0
+1 2 0
+1.5 2 0
+2 2 0
+2 2 0
+2.33333 2 0
+2.66667 2 0
+3 2 0
+2 2.33333 0
+2.33333 2.33333 0
+2.66667 2.33333 0
+3 2.33333 0
+2 2.66667 0
+2.33333 2.66667 0
+2.66667 2.66667 0
+3 2.66667 0
+2 3 0
+2.33333 3 0
+2.66667 3 0
+3 3 0
+3 3 0
+3.25 3 0
+3.5 3 0
+3.75 3 0
+4 3 0
+3 3.25 0
+3.25 3.25 0
+3.5 3.25 0
+3.75 3.25 0
+4 3.25 0
+3 3.5 0
+3.25 3.5 0
+3.5 3.5 0
+3.75 3.5 0
+4 3.5 0
+3 3.75 0
+3.25 3.75 0
+3.5 3.75 0
+3.75 3.75 0
+4 3.75 0
+3 4 0
+3.25 4 0
+3.5 4 0
+3.75 4 0
+4 4 0
+
+CELLS 30 150
+4      0       1       3       2
+4      4       5       8       7
+4      5       6       9       8
+4      7       8       11      10
+4      8       9       12      11
+4      13      14      18      17
+4      14      15      19      18
+4      15      16      20      19
+4      17      18      22      21
+4      18      19      23      22
+4      19      20      24      23
+4      21      22      26      25
+4      22      23      27      26
+4      23      24      28      27
+4      29      30      35      34
+4      30      31      36      35
+4      31      32      37      36
+4      32      33      38      37
+4      34      35      40      39
+4      35      36      41      40
+4      36      37      42      41
+4      37      38      43      42
+4      39      40      45      44
+4      40      41      46      45
+4      41      42      47      46
+4      42      43      48      47
+4      44      45      50      49
+4      45      46      51      50
+4      46      47      52      51
+4      47      48      53      52
+
+CELL_TYPES 30
+ 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
+POINT_DATA 54
+SCALARS x1 double 1
+LOOKUP_TABLE default
+0 1 0 1 1 1.5 2 1 1.5 2 1 1.5 2 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 
+SCALARS x2 double 1
+LOOKUP_TABLE default
+0 0 1 1 1 1 1 1.5 1.5 1.5 2 2 2 2 2 2 2 2.33333 2.33333 2.33333 2.33333 2.66667 2.66667 2.66667 2.66667 3 3 3 3 3 3 3 3 3 3.25 3.25 3.25 3.25 3.25 3.5 3.5 3.5 3.5 3.5 3.75 3.75 3.75 3.75 3.75 4 4 4 4 4 
+SCALARS x3 double 1
+LOOKUP_TABLE default
+0 0 0 0 1 1 1 1 1 1 1 1 1 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 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 
+SCALARS x4 double 1
+LOOKUP_TABLE default
+0 0 0 0 1 1 1 1 1 1 1 1 1 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 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 
+SCALARS i double 1
+LOOKUP_TABLE default
+0 1 2 3 0 1 2 3 4 5 6 7 8 0 1 2 3 4 5 6 7 8 9 10 11 12 13 14 15 0 1 2 3 4 5 6 7 8 9 10 11 12 13 14 15 16 17 18 19 20 21 22 23 24 
+==============================
+data_out_base_vtk_time_and_cycle/23.vtk
+==============================
+# vtk DataFile Version 3.0
+#This file was generated 
+ASCII
+DATASET UNSTRUCTURED_GRID
+
+FIELD FieldData 2
+CYCLE 1 1 int
+42
+TIME 1 1 double
+3.14159
+POINTS 54 double
+0 0 0
+1 0 1
+0 1 2
+1 1 3
+1 1 1
+1.5 1 1.5
+2 1 2
+1 1.5 2
+1.5 1.5 2.5
+2 1.5 3
+1 2 3
+1.5 2 3.5
+2 2 4
+2 2 2
+2.33333 2 2.33333
+2.66667 2 2.66667
+3 2 3
+2 2.33333 2.66667
+2.33333 2.33333 3
+2.66667 2.33333 3.33333
+3 2.33333 3.66667
+2 2.66667 3.33333
+2.33333 2.66667 3.66667
+2.66667 2.66667 4
+3 2.66667 4.33333
+2 3 4
+2.33333 3 4.33333
+2.66667 3 4.66667
+3 3 5
+3 3 3
+3.25 3 3.25
+3.5 3 3.5
+3.75 3 3.75
+4 3 4
+3 3.25 3.5
+3.25 3.25 3.75
+3.5 3.25 4
+3.75 3.25 4.25
+4 3.25 4.5
+3 3.5 4
+3.25 3.5 4.25
+3.5 3.5 4.5
+3.75 3.5 4.75
+4 3.5 5
+3 3.75 4.5
+3.25 3.75 4.75
+3.5 3.75 5
+3.75 3.75 5.25
+4 3.75 5.5
+3 4 5
+3.25 4 5.25
+3.5 4 5.5
+3.75 4 5.75
+4 4 6
+
+CELLS 30 150
+4      0       1       3       2
+4      4       5       8       7
+4      5       6       9       8
+4      7       8       11      10
+4      8       9       12      11
+4      13      14      18      17
+4      14      15      19      18
+4      15      16      20      19
+4      17      18      22      21
+4      18      19      23      22
+4      19      20      24      23
+4      21      22      26      25
+4      22      23      27      26
+4      23      24      28      27
+4      29      30      35      34
+4      30      31      36      35
+4      31      32      37      36
+4      32      33      38      37
+4      34      35      40      39
+4      35      36      41      40
+4      36      37      42      41
+4      37      38      43      42
+4      39      40      45      44
+4      40      41      46      45
+4      41      42      47      46
+4      42      43      48      47
+4      44      45      50      49
+4      45      46      51      50
+4      46      47      52      51
+4      47      48      53      52
+
+CELL_TYPES 30
+ 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
+POINT_DATA 54
+SCALARS x1 double 1
+LOOKUP_TABLE default
+0 1 0 1 1 1.5 2 1 1.5 2 1 1.5 2 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 
+SCALARS x2 double 1
+LOOKUP_TABLE default
+0 0 1 1 1 1 1 1.5 1.5 1.5 2 2 2 2 2 2 2 2.33333 2.33333 2.33333 2.33333 2.66667 2.66667 2.66667 2.66667 3 3 3 3 3 3 3 3 3 3.25 3.25 3.25 3.25 3.25 3.5 3.5 3.5 3.5 3.5 3.75 3.75 3.75 3.75 3.75 4 4 4 4 4 
+SCALARS x3 double 1
+LOOKUP_TABLE default
+0 0 0 0 1 1 1 1 1 1 1 1 1 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 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 
+SCALARS x4 double 1
+LOOKUP_TABLE default
+0 0 0 0 1 1 1 1 1 1 1 1 1 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 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 
+SCALARS i double 1
+LOOKUP_TABLE default
+0 1 2 3 0 1 2 3 4 5 6 7 8 0 1 2 3 4 5 6 7 8 9 10 11 12 13 14 15 0 1 2 3 4 5 6 7 8 9 10 11 12 13 14 15 16 17 18 19 20 21 22 23 24 
+==============================
+data_out_base_vtk_time_and_cycle/33.vtk
+==============================
+# vtk DataFile Version 3.0
+#This file was generated 
+ASCII
+DATASET UNSTRUCTURED_GRID
+
+FIELD FieldData 2
+CYCLE 1 1 int
+42
+TIME 1 1 double
+3.14159
+POINTS 224 double
+0 0 0
+1 0 0
+0 1 0
+1 1 0
+0 0 1
+1 0 1
+0 1 1
+1 1 1
+1 1 1
+1.5 1 1
+2 1 1
+1 1.5 1
+1.5 1.5 1
+2 1.5 1
+1 2 1
+1.5 2 1
+2 2 1
+1 1 1.5
+1.5 1 1.5
+2 1 1.5
+1 1.5 1.5
+1.5 1.5 1.5
+2 1.5 1.5
+1 2 1.5
+1.5 2 1.5
+2 2 1.5
+1 1 2
+1.5 1 2
+2 1 2
+1 1.5 2
+1.5 1.5 2
+2 1.5 2
+1 2 2
+1.5 2 2
+2 2 2
+2 2 2
+2.33333 2 2
+2.66667 2 2
+3 2 2
+2 2.33333 2
+2.33333 2.33333 2
+2.66667 2.33333 2
+3 2.33333 2
+2 2.66667 2
+2.33333 2.66667 2
+2.66667 2.66667 2
+3 2.66667 2
+2 3 2
+2.33333 3 2
+2.66667 3 2
+3 3 2
+2 2 2.33333
+2.33333 2 2.33333
+2.66667 2 2.33333
+3 2 2.33333
+2 2.33333 2.33333
+2.33333 2.33333 2.33333
+2.66667 2.33333 2.33333
+3 2.33333 2.33333
+2 2.66667 2.33333
+2.33333 2.66667 2.33333
+2.66667 2.66667 2.33333
+3 2.66667 2.33333
+2 3 2.33333
+2.33333 3 2.33333
+2.66667 3 2.33333
+3 3 2.33333
+2 2 2.66667
+2.33333 2 2.66667
+2.66667 2 2.66667
+3 2 2.66667
+2 2.33333 2.66667
+2.33333 2.33333 2.66667
+2.66667 2.33333 2.66667
+3 2.33333 2.66667
+2 2.66667 2.66667
+2.33333 2.66667 2.66667
+2.66667 2.66667 2.66667
+3 2.66667 2.66667
+2 3 2.66667
+2.33333 3 2.66667
+2.66667 3 2.66667
+3 3 2.66667
+2 2 3
+2.33333 2 3
+2.66667 2 3
+3 2 3
+2 2.33333 3
+2.33333 2.33333 3
+2.66667 2.33333 3
+3 2.33333 3
+2 2.66667 3
+2.33333 2.66667 3
+2.66667 2.66667 3
+3 2.66667 3
+2 3 3
+2.33333 3 3
+2.66667 3 3
+3 3 3
+3 3 3
+3.25 3 3
+3.5 3 3
+3.75 3 3
+4 3 3
+3 3.25 3
+3.25 3.25 3
+3.5 3.25 3
+3.75 3.25 3
+4 3.25 3
+3 3.5 3
+3.25 3.5 3
+3.5 3.5 3
+3.75 3.5 3
+4 3.5 3
+3 3.75 3
+3.25 3.75 3
+3.5 3.75 3
+3.75 3.75 3
+4 3.75 3
+3 4 3
+3.25 4 3
+3.5 4 3
+3.75 4 3
+4 4 3
+3 3 3.25
+3.25 3 3.25
+3.5 3 3.25
+3.75 3 3.25
+4 3 3.25
+3 3.25 3.25
+3.25 3.25 3.25
+3.5 3.25 3.25
+3.75 3.25 3.25
+4 3.25 3.25
+3 3.5 3.25
+3.25 3.5 3.25
+3.5 3.5 3.25
+3.75 3.5 3.25
+4 3.5 3.25
+3 3.75 3.25
+3.25 3.75 3.25
+3.5 3.75 3.25
+3.75 3.75 3.25
+4 3.75 3.25
+3 4 3.25
+3.25 4 3.25
+3.5 4 3.25
+3.75 4 3.25
+4 4 3.25
+3 3 3.5
+3.25 3 3.5
+3.5 3 3.5
+3.75 3 3.5
+4 3 3.5
+3 3.25 3.5
+3.25 3.25 3.5
+3.5 3.25 3.5
+3.75 3.25 3.5
+4 3.25 3.5
+3 3.5 3.5
+3.25 3.5 3.5
+3.5 3.5 3.5
+3.75 3.5 3.5
+4 3.5 3.5
+3 3.75 3.5
+3.25 3.75 3.5
+3.5 3.75 3.5
+3.75 3.75 3.5
+4 3.75 3.5
+3 4 3.5
+3.25 4 3.5
+3.5 4 3.5
+3.75 4 3.5
+4 4 3.5
+3 3 3.75
+3.25 3 3.75
+3.5 3 3.75
+3.75 3 3.75
+4 3 3.75
+3 3.25 3.75
+3.25 3.25 3.75
+3.5 3.25 3.75
+3.75 3.25 3.75
+4 3.25 3.75
+3 3.5 3.75
+3.25 3.5 3.75
+3.5 3.5 3.75
+3.75 3.5 3.75
+4 3.5 3.75
+3 3.75 3.75
+3.25 3.75 3.75
+3.5 3.75 3.75
+3.75 3.75 3.75
+4 3.75 3.75
+3 4 3.75
+3.25 4 3.75
+3.5 4 3.75
+3.75 4 3.75
+4 4 3.75
+3 3 4
+3.25 3 4
+3.5 3 4
+3.75 3 4
+4 3 4
+3 3.25 4
+3.25 3.25 4
+3.5 3.25 4
+3.75 3.25 4
+4 3.25 4
+3 3.5 4
+3.25 3.5 4
+3.5 3.5 4
+3.75 3.5 4
+4 3.5 4
+3 3.75 4
+3.25 3.75 4
+3.5 3.75 4
+3.75 3.75 4
+4 3.75 4
+3 4 4
+3.25 4 4
+3.5 4 4
+3.75 4 4
+4 4 4
+
+CELLS 100 900
+8      0       1       3       2       4       5       7       6
+8      8       9       12      11      17      18      21      20
+8      9       10      13      12      18      19      22      21
+8      11      12      15      14      20      21      24      23
+8      12      13      16      15      21      22      25      24
+8      17      18      21      20      26      27      30      29
+8      18      19      22      21      27      28      31      30
+8      20      21      24      23      29      30      33      32
+8      21      22      25      24      30      31      34      33
+8      35      36      40      39      51      52      56      55
+8      36      37      41      40      52      53      57      56
+8      37      38      42      41      53      54      58      57
+8      39      40      44      43      55      56      60      59
+8      40      41      45      44      56      57      61      60
+8      41      42      46      45      57      58      62      61
+8      43      44      48      47      59      60      64      63
+8      44      45      49      48      60      61      65      64
+8      45      46      50      49      61      62      66      65
+8      51      52      56      55      67      68      72      71
+8      52      53      57      56      68      69      73      72
+8      53      54      58      57      69      70      74      73
+8      55      56      60      59      71      72      76      75
+8      56      57      61      60      72      73      77      76
+8      57      58      62      61      73      74      78      77
+8      59      60      64      63      75      76      80      79
+8      60      61      65      64      76      77      81      80
+8      61      62      66      65      77      78      82      81
+8      67      68      72      71      83      84      88      87
+8      68      69      73      72      84      85      89      88
+8      69      70      74      73      85      86      90      89
+8      71      72      76      75      87      88      92      91
+8      72      73      77      76      88      89      93      92
+8      73      74      78      77      89      90      94      93
+8      75      76      80      79      91      92      96      95
+8      76      77      81      80      92      93      97      96
+8      77      78      82      81      93      94      98      97
+8      99      100     105     104     124     125     130     129
+8      100     101     106     105     125     126     131     130
+8      101     102     107     106     126     127     132     131
+8      102     103     108     107     127     128     133     132
+8      104     105     110     109     129     130     135     134
+8      105     106     111     110     130     131     136     135
+8      106     107     112     111     131     132     137     136
+8      107     108     113     112     132     133     138     137
+8      109     110     115     114     134     135     140     139
+8      110     111     116     115     135     136     141     140
+8      111     112     117     116     136     137     142     141
+8      112     113     118     117     137     138     143     142
+8      114     115     120     119     139     140     145     144
+8      115     116     121     120     140     141     146     145
+8      116     117     122     121     141     142     147     146
+8      117     118     123     122     142     143     148     147
+8      124     125     130     129     149     150     155     154
+8      125     126     131     130     150     151     156     155
+8      126     127     132     131     151     152     157     156
+8      127     128     133     132     152     153     158     157
+8      129     130     135     134     154     155     160     159
+8      130     131     136     135     155     156     161     160
+8      131     132     137     136     156     157     162     161
+8      132     133     138     137     157     158     163     162
+8      134     135     140     139     159     160     165     164
+8      135     136     141     140     160     161     166     165
+8      136     137     142     141     161     162     167     166
+8      137     138     143     142     162     163     168     167
+8      139     140     145     144     164     165     170     169
+8      140     141     146     145     165     166     171     170
+8      141     142     147     146     166     167     172     171
+8      142     143     148     147     167     168     173     172
+8      149     150     155     154     174     175     180     179
+8      150     151     156     155     175     176     181     180
+8      151     152     157     156     176     177     182     181
+8      152     153     158     157     177     178     183     182
+8      154     155     160     159     179     180     185     184
+8      155     156     161     160     180     181     186     185
+8      156     157     162     161     181     182     187     186
+8      157     158     163     162     182     183     188     187
+8      159     160     165     164     184     185     190     189
+8      160     161     166     165     185     186     191     190
+8      161     162     167     166     186     187     192     191
+8      162     163     168     167     187     188     193     192
+8      164     165     170     169     189     190     195     194
+8      165     166     171     170     190     191     196     195
+8      166     167     172     171     191     192     197     196
+8      167     168     173     172     192     193     198     197
+8      174     175     180     179     199     200     205     204
+8      175     176     181     180     200     201     206     205
+8      176     177     182     181     201     202     207     206
+8      177     178     183     182     202     203     208     207
+8      179     180     185     184     204     205     210     209
+8      180     181     186     185     205     206     211     210
+8      181     182     187     186     206     207     212     211
+8      182     183     188     187     207     208     213     212
+8      184     185     190     189     209     210     215     214
+8      185     186     191     190     210     211     216     215
+8      186     187     192     191     211     212     217     216
+8      187     188     193     192     212     213     218     217
+8      189     190     195     194     214     215     220     219
+8      190     191     196     195     215     216     221     220
+8      191     192     197     196     216     217     222     221
+8      192     193     198     197     217     218     223     222
+
+CELL_TYPES 100
+ 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12 12
+POINT_DATA 224
+SCALARS x1 double 1
+LOOKUP_TABLE default
+0 1 0 1 0 1 0 1 1 1.5 2 1 1.5 2 1 1.5 2 1 1.5 2 1 1.5 2 1 1.5 2 1 1.5 2 1 1.5 2 1 1.5 2 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 2 2.33333 2.66667 3 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 3 3.25 3.5 3.75 4 
+SCALARS x2 double 1
+LOOKUP_TABLE default
+0 0 1 1 0 0 1 1 1 1 1 1.5 1.5 1.5 2 2 2 1 1 1 1.5 1.5 1.5 2 2 2 1 1 1 1.5 1.5 1.5 2 2 2 2 2 2 2 2.33333 2.33333 2.33333 2.33333 2.66667 2.66667 2.66667 2.66667 3 3 3 3 2 2 2 2 2.33333 2.33333 2.33333 2.33333 2.66667 2.66667 2.66667 2.66667 3 3 3 3 2 2 2 2 2.33333 2.33333 2.33333 2.33333 2.66667 2.66667 2.66667 2.66667 3 3 3 3 2 2 2 2 2.33333 2.33333 2.33333 2.33333 2.66667 2.66667 2.66667 2.66667 3 3 3 3 3 3 3 3 3 3.25 3.25 3.25 3.25 3.25 3.5 3.5 3.5 3.5 3.5 3.75 3.75 3.75 3.75 3.75 4 4 4 4 4 3 3 3 3 3 3.25 3.25 3.25 3.25 3.25 3.5 3.5 3.5 3.5 3.5 3.75 3.75 3.75 3.75 3.75 4 4 4 4 4 3 3 3 3 3 3.25 3.25 3.25 3.25 3.25 3.5 3.5 3.5 3.5 3.5 3.75 3.75 3.75 3.75 3.75 4 4 4 4 4 3 3 3 3 3 3.25 3.25 3.25 3.25 3.25 3.5 3.5 3.5 3.5 3.5 3.75 3.75 3.75 3.75 3.75 4 4 4 4 4 3 3 3 3 3 3.25 3.25 3.25 3.25 3.25 3.5 3.5 3.5 3.5 3.5 3.75 3.75 3.75 3.75 3.75 4 4 4 4 4 
+SCALARS x3 double 1
+LOOKUP_TABLE default
+0 0 0 0 1 1 1 1 1 1 1 1 1 1 1 1 1 1.5 1.5 1.5 1.5 1.5 1.5 1.5 1.5 1.5 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2.33333 2.33333 2.33333 2.33333 2.33333 2.33333 2.33333 2.33333 2.33333 2.33333 2.33333 2.33333 2.33333 2.33333 2.33333 2.33333 2.66667 2.66667 2.66667 2.66667 2.66667 2.66667 2.66667 2.66667 2.66667 2.66667 2.66667 2.66667 2.66667 2.66667 2.66667 2.66667 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.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.25 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.5 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 3.75 4 4 4 4 4 4 4 4 4 4 4 4 4 4 4 4 4 4 4 4 4 4 4 4 4 
+SCALARS x4 double 1
+LOOKUP_TABLE default
+0 0 0 0 0 0 0 0 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 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 2 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 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 
+SCALARS i double 1
+LOOKUP_TABLE default
+0 1 2 3 4 5 6 7 0 1 2 3 4 5 6 7 8 9 10 11 12 13 14 15 16 17 18 19 20 21 22 23 24 25 26 0 1 2 3 4 5 6 7 8 9 10 11 12 13 14 15 16 17 18 19 20 21 22 23 24 25 26 27 28 29 30 31 32 33 34 35 36 37 38 39 40 41 42 43 44 45 46 47 48 49 50 51 52 53 54 55 56 57 58 59 60 61 62 63 0 1 2 3 4 5 6 7 8 9 10 11 12 13 14 15 16 17 18 19 20 21 22 23 24 25 26 27 28 29 30 31 32 33 34 35 36 37 38 39 40 41 42 43 44 45 46 47 48 49 50 51 52 53 54 55 56 57 58 59 60 61 62 63 64 65 66 67 68 69 70 71 72 73 74 75 76 77 78 79 80 81 82 83 84 85 86 87 88 89 90 91 92 93 94 95 96 97 98 99 100 101 102 103 104 105 106 107 108 109 110 111 112 113 114 115 116 117 118 119 120 121 122 123 124 

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.