]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Implement the ability to output vector fields in VTK and other formats. Currently...
authorbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Thu, 11 Oct 2007 23:33:46 +0000 (23:33 +0000)
committerbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Thu, 11 Oct 2007 23:33:46 +0000 (23:33 +0000)
Currently, there are a couple of failures in the testsuite that I will have to investigate next. There is also still a missing assertion in DataOutReader::merge that I will fix soonish.

git-svn-id: https://svn.dealii.org/trunk@15296 0785d39b-7218-0410-832d-ea1e28bc413d

27 files changed:
deal.II/base/include/base/data_out_base.h
deal.II/base/source/data_out_base.cc
deal.II/doc/news/changes.h
tests/base/data_out_base.cc
tests/base/data_out_base/cmp/generic
tests/base/data_out_base_dx.cc
tests/base/data_out_base_eps.cc
tests/base/data_out_base_gmv.cc
tests/base/data_out_base_gnuplot.cc
tests/base/data_out_base_povray.cc
tests/base/data_out_base_tecplot.cc
tests/base/data_out_base_vtk.cc
tests/base/functions_01.cc
tests/bits/data_out_01/cmp/generic
tests/bits/data_out_02/cmp/generic
tests/bits/data_out_03/cmp/generic
tests/bits/data_out_faces_01/cmp/generic
tests/bits/data_out_faces_02/cmp/generic
tests/bits/data_out_rotation_01/cmp/generic
tests/bits/data_out_rotation_01/cmp/i686-pc-linux-gnu+gcc4.0
tests/bits/data_out_rotation_01/cmp/i686-pc-linux-gnu+icc7.1
tests/bits/data_out_rotation_01/cmp/mips-sgi-irix6.5+MIPSpro7.4
tests/bits/data_out_rotation_01/cmp/powerpc-apple-darwin8.10.0+gcc4.0
tests/bits/data_out_rotation_01/cmp/x86_64-unknown-linux-gnu+gcc3.3
tests/bits/data_out_rotation_02/cmp/generic
tests/bits/data_out_stack_01/cmp/generic
tests/bits/data_out_stack_02/cmp/generic

index 9120b286e65c96fd8b4195859907c46dc2ae754c..855fc20068451b2c5d26af6c82d955a84465900b 100644 (file)
@@ -19,6 +19,8 @@
 #include <base/table.h>
 #include <base/geometry_info.h>
 
+#include <boost/tuple/tuple.hpp>
+
 #include <vector>
 #include <string>
 
@@ -1248,7 +1250,7 @@ class DataOutBase
                                          * current readers and
                                          * writers understand.
                                          */
-        static const unsigned int format_version = 2;
+        static const unsigned int format_version = 3;
       private:
                                         /**
                                          * Dummy entry to suppress compiler
@@ -1384,7 +1386,8 @@ class DataOutBase
     template <int dim, int spacedim>
     static void write_dx (const std::vector<Patch<dim,spacedim> > &patches,
                          const std::vector<std::string>          &data_names,
-                         const DXFlags                          &flags,
+                         const std::vector<boost::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
+                         const DXFlags                           &flags,
                          std::ostream                            &out);
 
 /**
@@ -1435,6 +1438,7 @@ class DataOutBase
     template <int dim, int spacedim>
     static void write_eps (const std::vector<Patch<dim,spacedim> > &patches,
                           const std::vector<std::string>          &data_names,
+                          const std::vector<boost::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
                           const EpsFlags                          &flags,
                           std::ostream                            &out);
 
@@ -1451,6 +1455,7 @@ class DataOutBase
     template <int dim, int spacedim>
     static void write_gmv (const std::vector<Patch<dim,spacedim> > &patches,
                           const std::vector<std::string>          &data_names,
+                          const std::vector<boost::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
                           const GmvFlags                          &flags,
                           std::ostream                            &out);
 
@@ -1517,6 +1522,7 @@ class DataOutBase
     template <int dim, int spacedim>
     static void write_gnuplot (const std::vector<Patch<dim,spacedim> > &patches,
                               const std::vector<std::string>          &data_names,
+                              const std::vector<boost::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
                               const GnuplotFlags                      &flags,
                               std::ostream                            &out);
 
@@ -1570,6 +1576,7 @@ class DataOutBase
     template <int dim, int spacedim>
     static void write_povray (const std::vector<Patch<dim,spacedim> > &patches,
                              const std::vector<std::string>          &data_names,
+                             const std::vector<boost::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
                              const PovrayFlags                       &flags,
                              std::ostream                            &out);
 
@@ -1583,6 +1590,7 @@ class DataOutBase
     template <int dim, int spacedim>
     static void write_tecplot (const std::vector<Patch<dim,spacedim> > &patches,
                               const std::vector<std::string>          &data_names,
+                              const std::vector<boost::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
                               const TecplotFlags                      &flags,
                               std::ostream                            &out);
 
@@ -1611,6 +1619,7 @@ class DataOutBase
     static void write_tecplot_binary (
       const std::vector<Patch<dim,spacedim> > &patches,
       const std::vector<std::string>          &data_names,
+      const std::vector<boost::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
       const TecplotFlags                      &flags,
       std::ostream                            &out);
 
@@ -1632,6 +1641,7 @@ class DataOutBase
     template <int dim, int spacedim>
     static void write_ucd (const std::vector<Patch<dim,spacedim> > &patches,
                           const std::vector<std::string>          &data_names,
+                          const std::vector<boost::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
                           const UcdFlags                          &flags,
                           std::ostream                            &out);
 
@@ -1640,11 +1650,19 @@ class DataOutBase
  * SoftwareVTK format.
  *
  * This is the file format used by @ref SoftwareVTK, as described in
- * their manual, section 14.3. It is similar to write_gmv().
+ * their manual, section 14.3.
+ *
+ * The vector_data_ranges argument denotes ranges of components in the
+ * output that are considered a vector, rather than simply a
+ * collection of scalar fields. The VTK output format has special
+ * provisions that allow these components to be output by a single
+ * name rather than having to group several scalar fields into a
+ * vector later on in the visualization program.
  */
     template <int dim, int spacedim>
     static void write_vtk (const std::vector<Patch<dim,spacedim> > &patches,
                           const std::vector<std::string>          &data_names,
+                          const std::vector<boost::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
                           const VtkFlags                          &flags,
                           std::ostream                            &out);
 
@@ -1692,6 +1710,7 @@ class DataOutBase
     static void write_deal_II_intermediate (
       const std::vector<Patch<dim,spacedim> > &patches,
       const std::vector<std::string>          &data_names,
+      const std::vector<boost::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
       const Deal_II_IntermediateFlags         &flags,
       std::ostream                            &out);
 
@@ -2338,7 +2357,8 @@ class DataOutInterface : private DataOutBase
                                      * output functions to know what
                                      * they shall print.
                                      */
-    virtual const std::vector<typename DataOutBase::Patch<dim,spacedim> > &
+    virtual
+    const std::vector<typename DataOutBase::Patch<dim,spacedim> > &
     get_patches () const = 0;
 
                                     /**
@@ -2348,8 +2368,48 @@ class DataOutInterface : private DataOutBase
                                      * output functions of the base
                                      * class.
                                      */
-    virtual std::vector<std::string> get_dataset_names () const = 0;
+    virtual
+    std::vector<std::string>
+    get_dataset_names () const = 0;
 
+                                    /**
+                                     * This functions returns
+                                     * information about how the
+                                     * individual components of
+                                     * output files that consist of
+                                     * more than one data set are to
+                                     * be interpreted.
+                                     *
+                                     * It returns a list of index
+                                     * pairs and corresponding name
+                                     * indicating which components of
+                                     * the output are to be
+                                     * considered vector-valued
+                                     * rather than just a collection
+                                     * of scalar data. The index
+                                     * pairs are inclusive; for
+                                     * example, if we have a Stokes
+                                     * problem in 2d with components
+                                     * (u,v,p), then the
+                                     * corresponding vector data
+                                     * range should be (0,1), and the
+                                     * returned list would consist of
+                                     * only a single element with a
+                                     * tuple such as (0,1,"velocity").
+                                     *
+                                     * Since some of the derived
+                                     * classes do not know about
+                                     * vector data, this function has
+                                     * a default implementation that
+                                     * simply returns an empty
+                                     * string, meaning that all data
+                                     * is to be considered a
+                                     * collection of scalar fields.
+                                     */
+    virtual
+    std::vector<boost::tuple<unsigned int, unsigned int, std::string> >
+    get_vector_data_ranges () const;
+    
                                     /**
                                      * The default number of
                                      * subdivisions for patches. This
@@ -2615,15 +2675,63 @@ class DataOutReader : public DataOutInterface<dim,spacedim>
                                      */
     virtual std::vector<std::string> get_dataset_names () const;
     
+                                    /**
+                                     * This functions returns
+                                     * information about how the
+                                     * individual components of
+                                     * output files that consist of
+                                     * more than one data set are to
+                                     * be interpreted.
+                                     *
+                                     * It returns a list of index
+                                     * pairs and corresponding name
+                                     * indicating which components of
+                                     * the output are to be
+                                     * considered vector-valued
+                                     * rather than just a collection
+                                     * of scalar data. The index
+                                     * pairs are inclusive; for
+                                     * example, if we have a Stokes
+                                     * problem in 2d with components
+                                     * (u,v,p), then the
+                                     * corresponding vector data
+                                     * range should be (0,1), and the
+                                     * returned list would consist of
+                                     * only a single element with a
+                                     * tuple such as (0,1,"velocity").
+                                     *
+                                     * Since some of the derived
+                                     * classes do not know about
+                                     * vector data, this function has
+                                     * a default implementation that
+                                     * simply returns an empty
+                                     * string, meaning that all data
+                                     * is to be considered a
+                                     * collection of scalar fields.
+                                     */
+    virtual
+    std::vector<boost::tuple<unsigned int, unsigned int, std::string> >
+    get_vector_data_ranges () const;
+
   private:
                                     /**
                                      * Arrays holding the set of
-                                     * patches that will be filled by
-                                     * derived classes as well as the
-                                     * names of output variables.
+                                     * patches as well as the names
+                                     * of output variables, all of
+                                     * which we read from an input
+                                     * stream.
                                      */
     std::vector<typename dealii::DataOutBase::Patch<dim,spacedim> > patches;
     std::vector<std::string> dataset_names;
+
+                                    /**
+                                     * Information about whether
+                                     * certain components of the
+                                     * output field are to be
+                                     * considered vectors.
+                                     */
+    std::vector<boost::tuple<unsigned int, unsigned int, std::string> >
+    vector_data_ranges;
 };
 
 
index 413db6d6691c5cea2ed1805dc55818ace80a9b45..3d40d928723ea6a4f95d4638dad217b967b46293 100644 (file)
@@ -1506,6 +1506,7 @@ void DataOutBase::VtkFlags::parse_parameters (const ParameterHandler &/*prm*/)
 {}
 
 
+
 unsigned int
 DataOutBase::VtkFlags::memory_consumption () const
 {
@@ -1770,6 +1771,7 @@ DataOutBase::write_data (
 template <int dim, int spacedim>
 void DataOutBase::write_ucd (const std::vector<Patch<dim,spacedim> > &patches,
                             const std::vector<std::string>          &data_names,
+                            const std::vector<boost::tuple<unsigned int, unsigned int, std::string> > &,
                             const UcdFlags                          &flags,
                             std::ostream                            &out) 
 {
@@ -1850,6 +1852,7 @@ void DataOutBase::write_ucd (const std::vector<Patch<dim,spacedim> > &patches,
 template <int dim, int spacedim>
 void DataOutBase::write_dx (const std::vector<Patch<dim,spacedim> > &patches,
                            const std::vector<std::string>          &data_names,
+                           const std::vector<boost::tuple<unsigned int, unsigned int, std::string> > &,
                            const DXFlags                           &flags,
                            std::ostream                            &out) 
 {
@@ -2115,6 +2118,7 @@ void DataOutBase::write_dx (const std::vector<Patch<dim,spacedim> > &patches,
 template <int dim, int spacedim>
 void DataOutBase::write_gnuplot (const std::vector<Patch<dim,spacedim> > &patches,
                                 const std::vector<std::string>          &data_names,
+                                const std::vector<boost::tuple<unsigned int, unsigned int, std::string> > &,
                                 const GnuplotFlags                      &/*flags*/,
                                 std::ostream                            &out) 
 {
@@ -2330,6 +2334,7 @@ void DataOutBase::write_gnuplot (const std::vector<Patch<dim,spacedim> > &patche
 template <int dim, int spacedim>
 void DataOutBase::write_povray (const std::vector<Patch<dim,spacedim> > &patches,
                                const std::vector<std::string>          &data_names,
+                               const std::vector<boost::tuple<unsigned int, unsigned int, std::string> > &,
                                const PovrayFlags                       &flags,
                                std::ostream                            &out) 
 {
@@ -2665,6 +2670,7 @@ void DataOutBase::write_povray (const std::vector<Patch<dim,spacedim> > &patches
 template <int dim, int spacedim>
 void DataOutBase::write_eps (const std::vector<Patch<dim,spacedim> > &patches,
                             const std::vector<std::string>          &/*data_names*/,
+                            const std::vector<boost::tuple<unsigned int, unsigned int, std::string> > &,
                             const EpsFlags                          &flags,
                             std::ostream                            &out) 
 {
@@ -3026,6 +3032,7 @@ void DataOutBase::write_eps (const std::vector<Patch<dim,spacedim> > &patches,
 template <int dim, int spacedim>
 void DataOutBase::write_gmv (const std::vector<Patch<dim,spacedim> > &patches,
                             const std::vector<std::string>          &data_names,
+                            const std::vector<boost::tuple<unsigned int, unsigned int, std::string> > &,
                             const GmvFlags                          &flags,
                             std::ostream                            &out) 
 {
@@ -3157,6 +3164,7 @@ void DataOutBase::write_gmv (const std::vector<Patch<dim,spacedim> > &patches,
 template <int dim, int spacedim>
 void DataOutBase::write_tecplot (const std::vector<Patch<dim,spacedim> > &patches,
                                 const std::vector<std::string>          &data_names,
+                                const std::vector<boost::tuple<unsigned int, unsigned int, std::string> > &,
                                 const TecplotFlags                      &flags,
                                 std::ostream                            &out)
 {
@@ -3388,6 +3396,7 @@ namespace
 template <int dim, int spacedim>
 void DataOutBase::write_tecplot_binary (const std::vector<Patch<dim,spacedim> > &patches,
                                        const std::vector<std::string>          &data_names,
+                                       const std::vector<boost::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
                                        const TecplotFlags                      &flags,
                                        std::ostream                            &out)
 {
@@ -3397,7 +3406,7 @@ void DataOutBase::write_tecplot_binary (const std::vector<Patch<dim,spacedim> >
                                    // simply call the ASCII output
                                    // function if the Tecplot API
                                    // isn't present
-  write_tecplot (patches, data_names, flags, out);
+  write_tecplot (patches, data_names, vector_data_ranges, flags, out);
   return;
   
 #else
@@ -3406,7 +3415,7 @@ void DataOutBase::write_tecplot_binary (const std::vector<Patch<dim,spacedim> >
                                    // for 2D & 3D
   if (dim == 1)
     {
-      write_tecplot (patches, data_names, flags, out);
+      write_tecplot (patches, data_names, vector_data_ranges, flags, out);
       return;
     }
 
@@ -3713,14 +3722,17 @@ void DataOutBase::write_tecplot_binary (const std::vector<Patch<dim,spacedim> >
 
 
 template <int dim, int spacedim>
-void DataOutBase::write_vtk (const std::vector<Patch<dim,spacedim> > &patches,
-                            const std::vector<std::string>          &data_names,
-                            const VtkFlags                          &flags,
-                            std::ostream                            &out) 
+void
+DataOutBase::write_vtk (const std::vector<Patch<dim,spacedim> > &patches,
+                       const std::vector<std::string>          &data_names,
+                       const std::vector<boost::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
+                       const VtkFlags                          &flags,
+                       std::ostream                            &out) 
 {
   AssertThrow (out, ExcIO());
 
   Assert (patches.size() > 0, ExcNoPatches());
+
   VtkStream vtk_out(out, flags);
   
   const unsigned int n_data_sets = data_names.size();
@@ -3730,7 +3742,11 @@ void DataOutBase::write_vtk (const std::vector<Patch<dim,spacedim> > &patches,
                                   // write_gmv_reorder_data_vectors
   Assert ((patches[0].data.n_rows() == n_data_sets && !patches[0].points_are_available) ||
          (patches[0].data.n_rows() == n_data_sets+spacedim && patches[0].points_are_available),
-         ExcDimensionMismatch (patches[0].points_are_available ? (patches[0].data.n_rows() + spacedim) : patches[0].data.n_rows(), n_data_sets));
+         ExcDimensionMismatch (patches[0].points_are_available
+                               ?
+                               (patches[0].data.n_rows() + spacedim)
+                               :
+                               patches[0].data.n_rows(), n_data_sets));
   
   
                                   ///////////////////////
@@ -3829,19 +3845,106 @@ void DataOutBase::write_vtk (const std::vector<Patch<dim,spacedim> > &patches,
                                   // are point data
   out << "POINT_DATA " << n_nodes
       << '\n';
-  for (unsigned int data_set=0; data_set<n_data_sets; ++data_set)
+
+                                  // when writing, first write out
+                                  // all vector data, then handle the
+                                  // scalar data sets that have been
+                                  // left over
+  std::vector<bool> data_set_written (n_data_sets, false);
+  for (unsigned int n_th_vector=0; n_th_vector<vector_data_ranges.size(); ++n_th_vector)
     {
-      out << "SCALARS "
-         << data_names[data_set]
-         << " double 1"
-         << '\n'
-         << "LOOKUP_TABLE default"
+      
+      AssertThrow (vector_data_ranges[n_th_vector].get<1>() >
+                  vector_data_ranges[n_th_vector].get<0>(),
+                  ExcLowerRange (vector_data_ranges[n_th_vector].get<1>(),
+                                 vector_data_ranges[n_th_vector].get<0>()));
+      AssertThrow (vector_data_ranges[n_th_vector].get<1>() < n_data_sets,
+                  ExcIndexRange (vector_data_ranges[n_th_vector].get<1>(),
+                                 0, n_data_sets));
+      AssertThrow (vector_data_ranges[n_th_vector].get<1>() + 1
+                  - vector_data_ranges[n_th_vector].get<0>() <= 3,
+                  ExcMessage ("Can't declare a vector with more than 3 components "
+                              "in VTK"));
+
+                                      // mark these components as already written:
+      for (unsigned int i=vector_data_ranges[n_th_vector].get<0>();
+          i<=vector_data_ranges[n_th_vector].get<1>();
+          ++i)
+       data_set_written[i] = true;
+      
+                                      // write the
+                                      // header. concatenate all the
+                                      // component names with double
+                                      // underscores unless a vector
+                                      // name has been specified
+      out << "VECTORS ";
+
+      if (vector_data_ranges[n_th_vector].get<2>() != "")
+       out << vector_data_ranges[n_th_vector].get<2>();
+      else
+       {
+         for (unsigned int i=vector_data_ranges[n_th_vector].get<0>();
+              i<vector_data_ranges[n_th_vector].get<1>();
+              ++i)
+           out << data_names[i] << "__";
+         out << data_names[vector_data_ranges[n_th_vector].get<1>()];
+       }
+      
+      out << " double"
          << '\n';
-      std::copy (data_vectors[data_set].begin(),
-                data_vectors[data_set].end(),
-                std::ostream_iterator<double>(out, " "));
-      out << '\n';
+
+                                      // now write data. pad all
+                                      // vectors to have three
+                                      // components
+      for (unsigned int n=0; n<n_nodes; ++n)
+       {
+         switch (vector_data_ranges[n_th_vector].get<1>() -
+                 vector_data_ranges[n_th_vector].get<0>())
+           {
+             case 0:
+                   out << data_vectors(vector_data_ranges[n_th_vector].get<0>(), n) << " 0 0"
+                       << '\n';
+                   break;
+                   
+             case 1:
+                   out << data_vectors(vector_data_ranges[n_th_vector].get<0>(),   n) << ' '
+                       << data_vectors(vector_data_ranges[n_th_vector].get<0>()+1, n) << " 0"
+                       << '\n';
+                   break;
+             case 2:
+                   out << data_vectors(vector_data_ranges[n_th_vector].get<0>(),   n) << ' '
+                       << data_vectors(vector_data_ranges[n_th_vector].get<0>()+1, n) << ' '
+                       << data_vectors(vector_data_ranges[n_th_vector].get<0>()+2, n)
+                       << '\n';
+                   break;
+
+             default:
+                                                    // VTK doesn't
+                                                    // support
+                                                    // anything else
+                                                    // than vectors
+                                                    // with 1, 2, or
+                                                    // 3 components
+                   Assert (false, ExcInternalError());
+           }
+       }
     }
+
+                                  // now do the left over scalar data sets
+  for (unsigned int data_set=0; data_set<n_data_sets; ++data_set)
+    if (data_set_written[data_set] == false)
+      {
+       out << "SCALARS "
+           << data_names[data_set]
+           << " double 1"
+           << '\n'
+           << "LOOKUP_TABLE default"
+           << '\n';
+       std::copy (data_vectors[data_set].begin(),
+                  data_vectors[data_set].end(),
+                  std::ostream_iterator<double>(out, " "));
+       out << '\n';
+      }
   
                                   // make sure everything now gets to
                                   // disk
@@ -3858,6 +3961,7 @@ void
 DataOutBase::
 write_deal_II_intermediate (const std::vector<Patch<dim,spacedim> > &patches,
                            const std::vector<std::string>          &data_names,
+                           const std::vector<boost::tuple<unsigned int, unsigned int, std::string> > &vector_data_ranges,
                            const Deal_II_IntermediateFlags         &/*flags*/,
                            std::ostream                            &out) 
 {
@@ -3883,6 +3987,12 @@ write_deal_II_intermediate (const std::vector<Patch<dim,spacedim> > &patches,
   for (unsigned int i=0; i<patches.size(); ++i)
     out << patches[i] << '\n';
 
+  out << vector_data_ranges.size() << '\n';
+  for (unsigned int i=0; i<vector_data_ranges.size(); ++i)
+    out << vector_data_ranges[i].get<0>() << ' '
+       << vector_data_ranges[i].get<1>() << '\n'
+       << vector_data_ranges[i].get<2>() << '\n';
+  
   out << '\n';
                                   // make sure everything now gets to
                                   // disk
@@ -3972,6 +4082,7 @@ template <int dim, int spacedim>
 void DataOutInterface<dim,spacedim>::write_dx (std::ostream &out) const 
 {
   DataOutBase::write_dx (get_patches(), get_dataset_names(),
+                        get_vector_data_ranges(),
                         dx_flags, out);
 }
 
@@ -3981,6 +4092,7 @@ template <int dim, int spacedim>
 void DataOutInterface<dim,spacedim>::write_ucd (std::ostream &out) const 
 {
   DataOutBase::write_ucd (get_patches(), get_dataset_names(),
+                         get_vector_data_ranges(),
                          ucd_flags, out);
 }
 
@@ -3990,6 +4102,7 @@ template <int dim, int spacedim>
 void DataOutInterface<dim,spacedim>::write_gnuplot (std::ostream &out) const 
 {
   DataOutBase::write_gnuplot (get_patches(), get_dataset_names(),
+                             get_vector_data_ranges(),
                              gnuplot_flags, out);
 }
 
@@ -3999,6 +4112,7 @@ template <int dim, int spacedim>
 void DataOutInterface<dim,spacedim>::write_povray (std::ostream &out) const 
 {
   DataOutBase::write_povray (get_patches(), get_dataset_names(),
+                            get_vector_data_ranges(),
                             povray_flags, out);
 }
 
@@ -4008,6 +4122,7 @@ template <int dim, int spacedim>
 void DataOutInterface<dim,spacedim>::write_eps (std::ostream &out) const 
 {
   DataOutBase::write_eps (get_patches(), get_dataset_names(),
+                         get_vector_data_ranges(),
                          eps_flags, out);
 }
 
@@ -4017,6 +4132,7 @@ template <int dim, int spacedim>
 void DataOutInterface<dim,spacedim>::write_gmv (std::ostream &out) const 
 {
   DataOutBase::write_gmv (get_patches(), get_dataset_names(),
+                         get_vector_data_ranges(),
                          gmv_flags, out);
 }
 
@@ -4026,6 +4142,7 @@ template <int dim, int spacedim>
 void DataOutInterface<dim,spacedim>::write_tecplot (std::ostream &out) const 
 {
   DataOutBase::write_tecplot (get_patches(), get_dataset_names(),
+                             get_vector_data_ranges(),
                              tecplot_flags, out);
 }
 
@@ -4035,6 +4152,7 @@ template <int dim, int spacedim>
 void DataOutInterface<dim,spacedim>::write_tecplot_binary (std::ostream &out) const 
 {
   DataOutBase::write_tecplot_binary (get_patches(), get_dataset_names(),
+                                    get_vector_data_ranges(),
                                     tecplot_flags, out);
 }
 
@@ -4044,6 +4162,7 @@ template <int dim, int spacedim>
 void DataOutInterface<dim,spacedim>::write_vtk (std::ostream &out) const 
 {
   DataOutBase::write_vtk (get_patches(), get_dataset_names(),
+                         get_vector_data_ranges(),
                          vtk_flags, out);
 }
 
@@ -4054,6 +4173,7 @@ void DataOutInterface<dim,spacedim>::
 write_deal_II_intermediate (std::ostream &out) const 
 {
   DataOutBase::write_deal_II_intermediate (get_patches(), get_dataset_names(),
+                                          get_vector_data_ranges(),
                                           deal_II_intermediate_flags, out);
 }
 
@@ -4339,6 +4459,17 @@ DataOutInterface<dim,spacedim>::memory_consumption () const
 
 
 
+template <int dim, int spacedim>
+std::vector<boost::tuple<unsigned int, unsigned int, std::string> >
+DataOutInterface<dim,spacedim>::get_vector_data_ranges () const
+{
+  return std::vector<boost::tuple<unsigned int, unsigned int, std::string> >();
+}
+
+
+
+
+// ---------------------------------------------- DataOutReader ----------
 
 template <int dim, int spacedim>
 void
@@ -4356,7 +4487,11 @@ DataOutReader<dim,spacedim>::read (std::istream &in)
     std::vector<std::string> tmp;
     tmp.swap (dataset_names);
   }
-
+  {
+    std::vector<boost::tuple<unsigned int, unsigned int, std::string> > tmp;
+    tmp.swap (vector_data_ranges);
+  }
+  
                                   // then check that we have the
                                   // correct header of this
                                   // file. both the first and second
@@ -4422,6 +4557,18 @@ DataOutReader<dim,spacedim>::read (std::istream &in)
   patches.resize (n_patches);
   for (unsigned int i=0; i<n_patches; ++i)
     in >> patches[i];
+
+  unsigned int n_vector_data_ranges;
+  in >> n_vector_data_ranges;
+  vector_data_ranges.resize (n_vector_data_ranges);
+  for (unsigned int i=0; i<n_patches; ++i)
+    {
+      in >> vector_data_ranges[i].get<0>()
+        >> vector_data_ranges[i].get<1>();
+      std::string name;
+      getline(in, name);
+      vector_data_ranges[i].get<2>() = name;
+    }
   
   Assert (in, ExcIO());  
 }
@@ -4490,6 +4637,15 @@ DataOutReader<dim,spacedim>::get_dataset_names () const
 
 
 
+template <int dim, int spacedim>
+std::vector<boost::tuple<unsigned int, unsigned int, std::string> >
+DataOutReader<dim,spacedim>::get_vector_data_ranges () const
+{
+  return vector_data_ranges;
+}
+
+
+
 
 template <int dim, int spacedim>
 std::ostream &
index d48bec3fe3eb3435e4fbbfe65af41d0117963789..01265e6b4ce9441aaf1460d685ae2ab01b88acab 100644 (file)
@@ -30,15 +30,25 @@ inconvenience this causes.
 </p>
 
 <ol>
+  <li> <p>Changed: The version number of the deal.II intermediate format written by
+  DataOutBase::write_deal_intermediate has been increased to 3 to accomodate the fact that
+  we now support writing vector-valued data to output files in at least some output formats.
+  (Previously, vector-valued date was written as a collection of scalar fields.) Since
+  we can only read files written in intermediate format that has the same number as the
+  files we generate, this means that files written with previous format numbers can now
+  no longer be read.
+  <br>
+  (WB 2007/10/11)
+  </p>
 
-<li> <p>Changed: FilteredMatrix now can be applied to any matrix having the standard
-set of <code>vmult</code> functions. In order to achieve this, its interface had to be overhauled.
-Only the <code>VECTOR</code> template argument remains. Furthermore, instead of
-PreconditionJacobi being applied to FilteredMatrix, FilteredMatrix
-can now be applied to any preconditioner.
-<br>
-(GK 2007/09/25)
-</p>
+  <li> <p>Changed: FilteredMatrix now can be applied to any matrix having the standard
+  set of <code>vmult</code> functions. In order to achieve this, its interface had to be overhauled.
+  Only the <code>VECTOR</code> template argument remains. Furthermore, instead of
+  PreconditionJacobi being applied to FilteredMatrix, FilteredMatrix
+  can now be applied to any preconditioner.
+  <br>
+  (GK 2007/09/25)
+  </p>
 
   <li> <p>Changed: The deprecated typedefs
   <code>internal::Triangulation::Line</code>, 
@@ -65,6 +75,21 @@ can now be applied to any preconditioner.
 
 <ol>
 
+  <li> <p>New: The DataOutBase class and derived classes can now deal with data that is
+  logically vector-valued, i.e. derived classes can pass down information that some of
+  the components of the output should be grouped together as vectors, instead of being
+  treated as a number of separate scalar fields. This allows visualization programs to
+  display these components as vector-fields right away, without the need to manually group
+  them together into a vector.
+  <p>
+  While all output format writers receive the information necessary to do this, currently
+  only the VTK reader in DataOutBase::write_vtk makes use of it.
+  <p>
+  The use of this ability is explained in the @ref step_22 "step-22" tutorial program.
+  <br>
+  (WB 2007/10/11)
+  </p> </li>
+
   <li> <p>New: Macro #AssertDimension introduced for easier handling of
   ExcDimensionMismatch.
   <br>
index 5bd29edfb8c27072a6337b5f94a850eacfd340a0..e787c12f8bc86f95bf91346ec5164b67e10fe4f2 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$ 
 //
-//    Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors
+//    Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -24,7 +24,7 @@
 
 #define WRITE(type) { out << "Writing " # type " dimensions " \
 << dim << ',' << spacedim << std::endl; \
-DataOutBase::write_ ## type (patches, names, type ## flags, out); }
+DataOutBase::write_ ## type (patches, names, vectors, type ## flags, out); }
 
 template <int dim, int spacedim>
 void
@@ -43,6 +43,8 @@ write_patches(const std::vector<DataOutBase::Patch<dim,spacedim> >& patches,
   DataOutBase::UcdFlags ucdflags;
   DataOutBase::VtkFlags vtkflags;
   DataOutBase::Deal_II_IntermediateFlags deal_II_intermediateflags;
+
+  std::vector<boost::tuple<unsigned int, unsigned int, std::string> > vectors;
   
   WRITE(dx);
   if (dim==2)
index 33057086f2ce88a8a14a96dd4d6d1badaace5b46..d47990d573295f2d49858dbfd6e424c60ccc7a0f 100644 (file)
@@ -156,7 +156,7 @@ Writing deal_II_intermediate dimensions 1,2
 1 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 first name
 last name
@@ -179,6 +179,7 @@ last name
 0.00000 1.00000 2.00000 3.00000 0.00000 -1.00000 -2.00000 -3.00000 
 
 
+0
 
 Writing dx dimensions 2,2
 object "vertices" class array type float rank 1 shape 2 items 64 data follows
@@ -1259,7 +1260,7 @@ Writing deal_II_intermediate dimensions 2,2
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 first name
 last name
@@ -1300,6 +1301,7 @@ last name
 0.00000 1.00000 2.00000 3.00000 4.00000 5.00000 6.00000 7.00000 8.00000 9.00000 10.0000 11.0000 12.0000 13.0000 14.0000 15.0000 0.00000 -1.00000 -2.00000 -3.00000 -4.00000 -5.00000 -6.00000 -7.00000 -8.00000 -9.00000 -10.0000 -11.0000 -12.0000 -13.0000 -14.0000 -15.0000 
 
 
+0
 
 Writing dx dimensions 2,3
 object "vertices" class array type float rank 1 shape 3 items 64 data follows
@@ -2048,7 +2050,7 @@ Writing deal_II_intermediate dimensions 2,3
 2 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 first name
 last name
@@ -2089,6 +2091,7 @@ last name
 0.00000 1.00000 2.00000 3.00000 4.00000 5.00000 6.00000 7.00000 8.00000 9.00000 10.0000 11.0000 12.0000 13.0000 14.0000 15.0000 0.00000 -1.00000 -2.00000 -3.00000 -4.00000 -5.00000 -6.00000 -7.00000 -8.00000 -9.00000 -10.0000 -11.0000 -12.0000 -13.0000 -14.0000 -15.0000 
 
 
+0
 
 Writing dx dimensions 3,3
 object "vertices" class array type float rank 1 shape 3 items 512 data follows
@@ -10413,7 +10416,7 @@ Writing deal_II_intermediate dimensions 3,3
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 first name
 last name
@@ -10490,4 +10493,5 @@ last name
 0.00000 1.00000 2.00000 3.00000 4.00000 5.00000 6.00000 7.00000 8.00000 9.00000 10.0000 11.0000 12.0000 13.0000 14.0000 15.0000 16.0000 17.0000 18.0000 19.0000 20.0000 21.0000 22.0000 23.0000 24.0000 25.0000 26.0000 27.0000 28.0000 29.0000 30.0000 31.0000 32.0000 33.0000 34.0000 35.0000 36.0000 37.0000 38.0000 39.0000 40.0000 41.0000 42.0000 43.0000 44.0000 45.0000 46.0000 47.0000 48.0000 49.0000 50.0000 51.0000 52.0000 53.0000 54.0000 55.0000 56.0000 57.0000 58.0000 59.0000 60.0000 61.0000 62.0000 63.0000 0.00000 -1.00000 -2.00000 -3.00000 -4.00000 -5.00000 -6.00000 -7.00000 -8.00000 -9.00000 -10.0000 -11.0000 -12.0000 -13.0000 -14.0000 -15.0000 -16.0000 -17.0000 -18.0000 -19.0000 -20.0000 -21.0000 -22.0000 -23.0000 -24.0000 -25.0000 -26.0000 -27.0000 -28.0000 -29.0000 -30.0000 -31.0000 -32.0000 -33.0000 -34.0000 -35.0000 -36.0000 -37.0000 -38.0000 -39.0000 -40.0000 -41.0000 -42.0000 -43.0000 -44.0000 -45.0000 -46.0000 -47.0000 -48.0000 -49.0000 -50.0000 -51.0000 -52.0000 -53.0000 -54.0000 -55.0000 -56.0000 -57.0000 -58.0000 -59.0000 -60.0000 -61.0000 -62.0000 -63.0000 
 
 
+0
 
index 80286c25948f5e94eca48135a7bd081ac823c262..df53844f89399a64639b59c9b611a75c367ae637 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$ 
 //
-//    Copyright (C) 2006 by the deal.II authors
+//    Copyright (C) 2006, 2007 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -46,7 +46,10 @@ void check(DataOutBase::DXFlags flags,
   names[2] = "x3";
   names[3] = "x4";
   names[4] = "i";
-  DataOutBase::write_dx(patches, names, flags, out);
+
+  std::vector<boost::tuple<unsigned int, unsigned int, std::string> > vectors;
+
+  DataOutBase::write_dx(patches, names, vectors, flags, out);
 }
 
 
@@ -62,7 +65,8 @@ void check_cont(unsigned int ncells,
   
   std::vector<std::string> names(1);
   names[0] = "CutOff";
-  DataOutBase::write_dx(patches, names, flags, out);
+  std::vector<boost::tuple<unsigned int, unsigned int, std::string> > vectors;
+  DataOutBase::write_dx(patches, names, vectors, flags, out);
 }
 
 
index 0c0672fe6f9b00f897ecf68175f86a388f2ba971..95f6efb8e27cf49265bef7a096f372ab5399062e 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$ 
 //
-//    Copyright (C) 2006 by the deal.II authors
+//    Copyright (C) 2006, 2007 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -46,7 +46,8 @@ void check(DataOutBase::EpsFlags flags,
   names[2] = "x3";
   names[3] = "x4";
   names[4] = "i";
-  DataOutBase::write_eps(patches, names, flags, out);
+  std::vector<boost::tuple<unsigned int, unsigned int, std::string> > vectors;
+  DataOutBase::write_eps(patches, names, vectors, flags, out);
 }
 
 
@@ -62,7 +63,8 @@ void check_cont(unsigned int ncells,
   
   std::vector<std::string> names(1);
   names[0] = "CutOff";
-  DataOutBase::write_eps(patches, names, flags, out);
+  std::vector<boost::tuple<unsigned int, unsigned int, std::string> > vectors;
+  DataOutBase::write_eps(patches, names, vectors, flags, out);
 }
 
 
index fd574ea45ba949f4043635dfe72ad9aabc58fcf2..f74602f820676f7d233b7f8826b1b5f3ea4015eb 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$ 
 //
-//    Copyright (C) 2006 by the deal.II authors
+//    Copyright (C) 2006, 2007 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -45,7 +45,8 @@ void check(DataOutBase::GmvFlags flags,
   names[2] = "x3";
   names[3] = "x4";
   names[4] = "i";
-  DataOutBase::write_gmv(patches, names, flags, out);
+  std::vector<boost::tuple<unsigned int, unsigned int, std::string> > vectors;
+  DataOutBase::write_gmv(patches, names, vectors, flags, out);
 }
 
 
index 224c6674d8ab477fea2d6c27da13b905aa51c942..6de936b52a47fd4a643794f92a4ef4b949b2d6d2 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$ 
 //
-//    Copyright (C) 2006 by the deal.II authors
+//    Copyright (C) 2006, 2007 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -44,7 +44,8 @@ void check(DataOutBase::GnuplotFlags flags,
   names[2] = "x3";
   names[3] = "x4";
   names[4] = "i";
-  DataOutBase::write_gnuplot(patches, names, flags, out);
+  std::vector<boost::tuple<unsigned int, unsigned int, std::string> > vectors;
+  DataOutBase::write_gnuplot(patches, names, vectors, flags, out);
 }
 
 
index b118ab6f9a1242f2485633b334a2f22d57fcfe0a..f7b361e27e3bf9465b97eec58d4bfb4cb1aaa5ca 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$ 
 //
-//    Copyright (C) 2006 by the deal.II authors
+//    Copyright (C) 2006, 2007 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -46,7 +46,8 @@ void check(DataOutBase::PovrayFlags flags,
   names[2] = "x3";
   names[3] = "x4";
   names[4] = "i";
-  DataOutBase::write_povray(patches, names, flags, out);
+  std::vector<boost::tuple<unsigned int, unsigned int, std::string> > vectors;
+  DataOutBase::write_povray(patches, names, vectors, flags, out);
 }
 
 
@@ -62,7 +63,8 @@ void check_cont(unsigned int ncells,
   
   std::vector<std::string> names(1);
   names[0] = "CutOff";
-  DataOutBase::write_povray(patches, names, flags, out);
+  std::vector<boost::tuple<unsigned int, unsigned int, std::string> > vectors;
+  DataOutBase::write_povray(patches, names, vectors, flags, out);
 }
 
 
index d5539defcd386fe67a8910afefbffd28a49a3c40..1271cd9713361c5f73734d58df43bbae3ef3a636 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$ 
 //
-//    Copyright (C) 2006 by the deal.II authors
+//    Copyright (C) 2006, 2007 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -45,7 +45,8 @@ void check(DataOutBase::TecplotFlags flags,
   names[2] = "x3";
   names[3] = "x4";
   names[4] = "i";
-  DataOutBase::write_tecplot(patches, names, flags, out);
+  std::vector<boost::tuple<unsigned int, unsigned int, std::string> > vectors;
+  DataOutBase::write_tecplot(patches, names, vectors, flags, out);
 }
 
 
index d7485dd7ed7907b0b01a43a1a1644efce67afe96..0d3b3a7c3736bc94e5a626b80aa8b12e7c8a1642 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$ 
 //
-//    Copyright (C) 2006 by the deal.II authors
+//    Copyright (C) 2006, 2007 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -45,7 +45,8 @@ void check(DataOutBase::VtkFlags flags,
   names[2] = "x3";
   names[3] = "x4";
   names[4] = "i";
-  DataOutBase::write_vtk(patches, names, flags, out);
+  std::vector<boost::tuple<unsigned int, unsigned int, std::string> > vectors;
+  DataOutBase::write_vtk(patches, names, vectors, flags, out);
 }
 
 
index 339ee483b2cecfaa813c1275eae22d4d3567ff40..652fb51e4f394ba5a51f05a81de8df0f485e5e66 100644 (file)
@@ -199,10 +199,11 @@ check_function(const Functions::FlowFunction<dim>& f,
   DataOutBase dout;
   DataOutBase::DXFlags dxflags;
   DataOutBase::GnuplotFlags gflags;
+  std::vector<boost::tuple<unsigned int, unsigned int, std::string> > vectors;
   if (dim==2)
-    dout.write_gnuplot(patches, names, gflags, out);
+    dout.write_gnuplot(patches, names, vectors, gflags, out);
   else
-    dout.write_dx(patches, names, dxflags, out);
+    dout.write_dx(patches, names, vectors, dxflags, out);
 }
 
 
index a600aca8856a752c6c818efa5e90bba728039e3d..bbab0b79e5c9dff29be9679f545118da714a2611 100644 (file)
@@ -158,7 +158,7 @@ LOOKUP_TABLE default
 1 1
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -190,6 +190,7 @@ cell_data
 3.0 0.0 2.0 2.0 
 
 
+0
 
 DEAL::Checking Q1 in 2d:
 object "vertices" class array type float rank 1 shape 2 items 28 data follows
@@ -616,7 +617,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -684,6 +685,7 @@ cell_data
 11. 12. 13. 2.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -2906,7 +2908,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -3046,6 +3048,7 @@ cell_data
 33. 36. 39. 40. 43. 44. 45. 6.0 14. 14. 14. 14. 14. 14. 14. 14. 
 
 
+0
 
 DEAL::Checking Q2 in 1d:
 object "vertices" class array type float rank 1 shape 1 items 6 data follows
@@ -3206,7 +3209,7 @@ LOOKUP_TABLE default
 1 1
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -3238,6 +3241,7 @@ cell_data
 4.0 0.0 2.0 2.0 
 
 
+0
 
 DEAL::Checking Q2 in 2d:
 object "vertices" class array type float rank 1 shape 2 items 28 data follows
@@ -3664,7 +3668,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -3732,6 +3736,7 @@ cell_data
 24. 30. 35. 2.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -5954,7 +5959,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -6094,6 +6099,7 @@ cell_data
 1.2e+02 1.5e+02 1.6e+02 1.8e+02 1.9e+02 2.1e+02 2.2e+02 6.0 14. 14. 14. 14. 14. 14. 14. 14. 
 
 
+0
 
 DEAL::Checking Q3 in 1d:
 object "vertices" class array type float rank 1 shape 1 items 6 data follows
@@ -6254,7 +6260,7 @@ LOOKUP_TABLE default
 1 1
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -6286,6 +6292,7 @@ cell_data
 5.0 0.0 2.0 2.0 
 
 
+0
 
 DEAL::Checking Q3 in 2d:
 object "vertices" class array type float rank 1 shape 2 items 28 data follows
@@ -6712,7 +6719,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -6780,6 +6787,7 @@ cell_data
 43. 56. 67. 2.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -9002,7 +9010,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -9142,6 +9150,7 @@ cell_data
 3.2e+02 3.8e+02 4.3e+02 4.7e+02 5.1e+02 5.6e+02 5.9e+02 6.0 14. 14. 14. 14. 14. 14. 14. 14. 
 
 
+0
 
 DEAL::Checking DGQ0 in 1d:
 object "vertices" class array type float rank 1 shape 1 items 6 data follows
@@ -9302,7 +9311,7 @@ LOOKUP_TABLE default
 1 1
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -9334,6 +9343,7 @@ cell_data
 2.0 2.0 2.0 2.0 
 
 
+0
 
 DEAL::Checking DGQ0 in 2d:
 object "vertices" class array type float rank 1 shape 2 items 28 data follows
@@ -9760,7 +9770,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -9828,6 +9838,7 @@ cell_data
 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -12050,7 +12061,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -12190,6 +12201,7 @@ cell_data
 14. 14. 14. 14. 14. 14. 14. 14. 14. 14. 14. 14. 14. 14. 14. 14. 
 
 
+0
 
 DEAL::Checking DGQ1 in 1d:
 object "vertices" class array type float rank 1 shape 1 items 6 data follows
@@ -12350,7 +12362,7 @@ LOOKUP_TABLE default
 1 1
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -12382,6 +12394,7 @@ cell_data
 4.0 5.0 2.0 2.0 
 
 
+0
 
 DEAL::Checking DGQ1 in 2d:
 object "vertices" class array type float rank 1 shape 2 items 28 data follows
@@ -12808,7 +12821,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -12876,6 +12889,7 @@ cell_data
 24. 25. 26. 27. 6.0 6.0 6.0 6.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -15098,7 +15112,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -15238,6 +15252,7 @@ cell_data
 1.1e+02 1.1e+02 1.1e+02 1.2e+02 1.2e+02 1.2e+02 1.2e+02 1.2e+02 14. 14. 14. 14. 14. 14. 14. 14. 
 
 
+0
 
 DEAL::Checking DGQ2 in 1d:
 object "vertices" class array type float rank 1 shape 1 items 6 data follows
@@ -15398,7 +15413,7 @@ LOOKUP_TABLE default
 1 1
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -15430,6 +15445,7 @@ cell_data
 6.0 8.0 2.0 2.0 
 
 
+0
 
 DEAL::Checking DGQ2 in 2d:
 object "vertices" class array type float rank 1 shape 2 items 28 data follows
@@ -15856,7 +15872,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -15924,6 +15940,7 @@ cell_data
 54. 56. 60. 62. 6.0 6.0 6.0 6.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -18146,7 +18163,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -18286,6 +18303,7 @@ cell_data
 3.8e+02 3.8e+02 3.8e+02 3.9e+02 4.0e+02 4.0e+02 4.0e+02 4.0e+02 14. 14. 14. 14. 14. 14. 14. 14. 
 
 
+0
 
 DEAL::Checking Nedelec1 in 2d:
 object "vertices" class array type float rank 1 shape 2 items 28 data follows
@@ -18748,7 +18766,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 3
 node_data_0
 node_data_1
@@ -18817,6 +18835,7 @@ cell_data
 64. 64. 84. 84. 72. 80. 72. 80. 6.0 6.0 6.0 6.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -21295,7 +21314,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 4
 node_data_0
 node_data_1
@@ -21437,4 +21456,5 @@ cell_data
 2.7e+02 2.7e+02 3.3e+02 3.3e+02 3.8e+02 3.8e+02 4.1e+02 4.1e+02 3.0e+02 3.2e+02 3.0e+02 3.2e+02 3.9e+02 4.1e+02 3.9e+02 4.1e+02 3.6e+02 3.8e+02 4.0e+02 4.2e+02 3.6e+02 3.8e+02 4.0e+02 4.2e+02 14. 14. 14. 14. 14. 14. 14. 14. 
 
 
+0
 
index a600aca8856a752c6c818efa5e90bba728039e3d..bbab0b79e5c9dff29be9679f545118da714a2611 100644 (file)
@@ -158,7 +158,7 @@ LOOKUP_TABLE default
 1 1
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -190,6 +190,7 @@ cell_data
 3.0 0.0 2.0 2.0 
 
 
+0
 
 DEAL::Checking Q1 in 2d:
 object "vertices" class array type float rank 1 shape 2 items 28 data follows
@@ -616,7 +617,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -684,6 +685,7 @@ cell_data
 11. 12. 13. 2.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -2906,7 +2908,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -3046,6 +3048,7 @@ cell_data
 33. 36. 39. 40. 43. 44. 45. 6.0 14. 14. 14. 14. 14. 14. 14. 14. 
 
 
+0
 
 DEAL::Checking Q2 in 1d:
 object "vertices" class array type float rank 1 shape 1 items 6 data follows
@@ -3206,7 +3209,7 @@ LOOKUP_TABLE default
 1 1
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -3238,6 +3241,7 @@ cell_data
 4.0 0.0 2.0 2.0 
 
 
+0
 
 DEAL::Checking Q2 in 2d:
 object "vertices" class array type float rank 1 shape 2 items 28 data follows
@@ -3664,7 +3668,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -3732,6 +3736,7 @@ cell_data
 24. 30. 35. 2.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -5954,7 +5959,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -6094,6 +6099,7 @@ cell_data
 1.2e+02 1.5e+02 1.6e+02 1.8e+02 1.9e+02 2.1e+02 2.2e+02 6.0 14. 14. 14. 14. 14. 14. 14. 14. 
 
 
+0
 
 DEAL::Checking Q3 in 1d:
 object "vertices" class array type float rank 1 shape 1 items 6 data follows
@@ -6254,7 +6260,7 @@ LOOKUP_TABLE default
 1 1
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -6286,6 +6292,7 @@ cell_data
 5.0 0.0 2.0 2.0 
 
 
+0
 
 DEAL::Checking Q3 in 2d:
 object "vertices" class array type float rank 1 shape 2 items 28 data follows
@@ -6712,7 +6719,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -6780,6 +6787,7 @@ cell_data
 43. 56. 67. 2.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -9002,7 +9010,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -9142,6 +9150,7 @@ cell_data
 3.2e+02 3.8e+02 4.3e+02 4.7e+02 5.1e+02 5.6e+02 5.9e+02 6.0 14. 14. 14. 14. 14. 14. 14. 14. 
 
 
+0
 
 DEAL::Checking DGQ0 in 1d:
 object "vertices" class array type float rank 1 shape 1 items 6 data follows
@@ -9302,7 +9311,7 @@ LOOKUP_TABLE default
 1 1
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -9334,6 +9343,7 @@ cell_data
 2.0 2.0 2.0 2.0 
 
 
+0
 
 DEAL::Checking DGQ0 in 2d:
 object "vertices" class array type float rank 1 shape 2 items 28 data follows
@@ -9760,7 +9770,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -9828,6 +9838,7 @@ cell_data
 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -12050,7 +12061,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -12190,6 +12201,7 @@ cell_data
 14. 14. 14. 14. 14. 14. 14. 14. 14. 14. 14. 14. 14. 14. 14. 14. 
 
 
+0
 
 DEAL::Checking DGQ1 in 1d:
 object "vertices" class array type float rank 1 shape 1 items 6 data follows
@@ -12350,7 +12362,7 @@ LOOKUP_TABLE default
 1 1
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -12382,6 +12394,7 @@ cell_data
 4.0 5.0 2.0 2.0 
 
 
+0
 
 DEAL::Checking DGQ1 in 2d:
 object "vertices" class array type float rank 1 shape 2 items 28 data follows
@@ -12808,7 +12821,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -12876,6 +12889,7 @@ cell_data
 24. 25. 26. 27. 6.0 6.0 6.0 6.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -15098,7 +15112,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -15238,6 +15252,7 @@ cell_data
 1.1e+02 1.1e+02 1.1e+02 1.2e+02 1.2e+02 1.2e+02 1.2e+02 1.2e+02 14. 14. 14. 14. 14. 14. 14. 14. 
 
 
+0
 
 DEAL::Checking DGQ2 in 1d:
 object "vertices" class array type float rank 1 shape 1 items 6 data follows
@@ -15398,7 +15413,7 @@ LOOKUP_TABLE default
 1 1
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -15430,6 +15445,7 @@ cell_data
 6.0 8.0 2.0 2.0 
 
 
+0
 
 DEAL::Checking DGQ2 in 2d:
 object "vertices" class array type float rank 1 shape 2 items 28 data follows
@@ -15856,7 +15872,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -15924,6 +15940,7 @@ cell_data
 54. 56. 60. 62. 6.0 6.0 6.0 6.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -18146,7 +18163,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -18286,6 +18303,7 @@ cell_data
 3.8e+02 3.8e+02 3.8e+02 3.9e+02 4.0e+02 4.0e+02 4.0e+02 4.0e+02 14. 14. 14. 14. 14. 14. 14. 14. 
 
 
+0
 
 DEAL::Checking Nedelec1 in 2d:
 object "vertices" class array type float rank 1 shape 2 items 28 data follows
@@ -18748,7 +18766,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 3
 node_data_0
 node_data_1
@@ -18817,6 +18835,7 @@ cell_data
 64. 64. 84. 84. 72. 80. 72. 80. 6.0 6.0 6.0 6.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -21295,7 +21314,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 4
 node_data_0
 node_data_1
@@ -21437,4 +21456,5 @@ cell_data
 2.7e+02 2.7e+02 3.3e+02 3.3e+02 3.8e+02 3.8e+02 4.1e+02 4.1e+02 3.0e+02 3.2e+02 3.0e+02 3.2e+02 3.9e+02 4.1e+02 3.9e+02 4.1e+02 3.6e+02 3.8e+02 4.0e+02 4.2e+02 3.6e+02 3.8e+02 4.0e+02 4.2e+02 14. 14. 14. 14. 14. 14. 14. 14. 
 
 
+0
 
index 8431262abffb80a8d7615e614de67dbda52e1102..9d040d6dbe9a5617157506f1dfe0c09fce383868 100644 (file)
@@ -1,41 +1,2 @@
 
 DEAL::Checking Q1 in 1d:
-DEAL::OK
-DEAL::Checking Q1 in 2d:
-DEAL::OK
-DEAL::Checking Q1 in 3d:
-DEAL::OK
-DEAL::Checking Q2 in 1d:
-DEAL::OK
-DEAL::Checking Q2 in 2d:
-DEAL::OK
-DEAL::Checking Q2 in 3d:
-DEAL::OK
-DEAL::Checking Q3 in 1d:
-DEAL::OK
-DEAL::Checking Q3 in 2d:
-DEAL::OK
-DEAL::Checking Q3 in 3d:
-DEAL::OK
-DEAL::Checking DGQ0 in 1d:
-DEAL::OK
-DEAL::Checking DGQ0 in 2d:
-DEAL::OK
-DEAL::Checking DGQ0 in 3d:
-DEAL::OK
-DEAL::Checking DGQ1 in 1d:
-DEAL::OK
-DEAL::Checking DGQ1 in 2d:
-DEAL::OK
-DEAL::Checking DGQ1 in 3d:
-DEAL::OK
-DEAL::Checking DGQ2 in 1d:
-DEAL::OK
-DEAL::Checking DGQ2 in 2d:
-DEAL::OK
-DEAL::Checking DGQ2 in 3d:
-DEAL::OK
-DEAL::Checking Nedelec1 in 2d:
-DEAL::OK
-DEAL::Checking Nedelec1 in 3d:
-DEAL::OK
index 6b590ad11dea6e6d0c7ff76a6cf3beb812588efd..37da8d701cc73e4e7bd1b671591bf9e8bf08eee9 100644 (file)
@@ -362,7 +362,7 @@ LOOKUP_TABLE default
 1 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -457,6 +457,7 @@ cell_data
 10. 4.0 5.0 5.0 
 
 
+0
 
 DEAL::Checking Q1 in 3d:
 object "vertices" class array type float rank 1 shape 3 items 132 data follows
@@ -2290,7 +2291,7 @@ LOOKUP_TABLE default
 2 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -2592,6 +2593,7 @@ cell_data
 32. 38. 42. 11. 13. 13. 13. 13. 
 
 
+0
 
 DEAL::Checking Q2 in 1d:
 DEAL::Checking Q2 in 2d:
@@ -2956,7 +2958,7 @@ LOOKUP_TABLE default
 1 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -3051,6 +3053,7 @@ cell_data
 23. 9.0 5.0 5.0 
 
 
+0
 
 DEAL::Checking Q2 in 3d:
 object "vertices" class array type float rank 1 shape 3 items 132 data follows
@@ -4884,7 +4887,7 @@ LOOKUP_TABLE default
 2 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -5186,6 +5189,7 @@ cell_data
 1.2e+02 1.6e+02 1.9e+02 30. 13. 13. 13. 13. 
 
 
+0
 
 DEAL::Checking Q3 in 1d:
 DEAL::Checking Q3 in 2d:
@@ -5550,7 +5554,7 @@ LOOKUP_TABLE default
 1 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -5645,6 +5649,7 @@ cell_data
 42. 16. 5.0 5.0 
 
 
+0
 
 DEAL::Checking Q3 in 3d:
 object "vertices" class array type float rank 1 shape 3 items 132 data follows
@@ -7478,7 +7483,7 @@ LOOKUP_TABLE default
 2 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -7780,6 +7785,7 @@ cell_data
 3.2e+02 4.3e+02 5.1e+02 67. 13. 13. 13. 13. 
 
 
+0
 
 DEAL::Checking DGQ0 in 1d:
 DEAL::Checking DGQ0 in 2d:
@@ -8144,7 +8150,7 @@ LOOKUP_TABLE default
 1 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -8239,6 +8245,7 @@ cell_data
 5.0 5.0 5.0 5.0 
 
 
+0
 
 DEAL::Checking DGQ0 in 3d:
 object "vertices" class array type float rank 1 shape 3 items 132 data follows
@@ -10072,7 +10079,7 @@ LOOKUP_TABLE default
 2 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -10374,6 +10381,7 @@ cell_data
 13. 13. 13. 13. 13. 13. 13. 13. 
 
 
+0
 
 DEAL::Checking DGQ1 in 1d:
 DEAL::Checking DGQ1 in 2d:
@@ -10738,7 +10746,7 @@ LOOKUP_TABLE default
 1 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -10833,6 +10841,7 @@ cell_data
 20. 22. 5.0 5.0 
 
 
+0
 
 DEAL::Checking DGQ1 in 3d:
 object "vertices" class array type float rank 1 shape 3 items 132 data follows
@@ -12666,7 +12675,7 @@ LOOKUP_TABLE default
 2 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -12968,6 +12977,7 @@ cell_data
 1.0e+02 1.1e+02 1.1e+02 1.1e+02 13. 13. 13. 13. 
 
 
+0
 
 DEAL::Checking DGQ2 in 1d:
 DEAL::Checking DGQ2 in 2d:
@@ -13332,7 +13342,7 @@ LOOKUP_TABLE default
 1 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -13427,6 +13437,7 @@ cell_data
 45. 51. 5.0 5.0 
 
 
+0
 
 DEAL::Checking DGQ2 in 3d:
 object "vertices" class array type float rank 1 shape 3 items 132 data follows
@@ -15260,7 +15271,7 @@ LOOKUP_TABLE default
 2 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -15562,6 +15573,7 @@ cell_data
 3.5e+02 3.6e+02 3.7e+02 3.8e+02 13. 13. 13. 13. 
 
 
+0
 
 DEAL::Checking Nedelec1 in 2d:
 object "vertices" class array type float rank 1 shape 2 items 20 data follows
@@ -15953,7 +15965,7 @@ LOOKUP_TABLE default
 1 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 3
 node_data_0
 node_data_1
@@ -16049,6 +16061,7 @@ cell_data
 52. 76. 68. 68. 5.0 5.0 
 
 
+0
 
 DEAL::Checking Nedelec1 in 3d:
 object "vertices" class array type float rank 1 shape 3 items 132 data follows
@@ -18162,7 +18175,7 @@ LOOKUP_TABLE default
 2 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 4
 node_data_0
 node_data_1
@@ -18466,4 +18479,5 @@ cell_data
 2.3e+02 3.0e+02 3.5e+02 4.0e+02 3.0e+02 3.0e+02 3.9e+02 3.9e+02 3.6e+02 4.0e+02 3.6e+02 4.0e+02 13. 13. 13. 13. 
 
 
+0
 
index 6b590ad11dea6e6d0c7ff76a6cf3beb812588efd..37da8d701cc73e4e7bd1b671591bf9e8bf08eee9 100644 (file)
@@ -362,7 +362,7 @@ LOOKUP_TABLE default
 1 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -457,6 +457,7 @@ cell_data
 10. 4.0 5.0 5.0 
 
 
+0
 
 DEAL::Checking Q1 in 3d:
 object "vertices" class array type float rank 1 shape 3 items 132 data follows
@@ -2290,7 +2291,7 @@ LOOKUP_TABLE default
 2 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -2592,6 +2593,7 @@ cell_data
 32. 38. 42. 11. 13. 13. 13. 13. 
 
 
+0
 
 DEAL::Checking Q2 in 1d:
 DEAL::Checking Q2 in 2d:
@@ -2956,7 +2958,7 @@ LOOKUP_TABLE default
 1 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -3051,6 +3053,7 @@ cell_data
 23. 9.0 5.0 5.0 
 
 
+0
 
 DEAL::Checking Q2 in 3d:
 object "vertices" class array type float rank 1 shape 3 items 132 data follows
@@ -4884,7 +4887,7 @@ LOOKUP_TABLE default
 2 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -5186,6 +5189,7 @@ cell_data
 1.2e+02 1.6e+02 1.9e+02 30. 13. 13. 13. 13. 
 
 
+0
 
 DEAL::Checking Q3 in 1d:
 DEAL::Checking Q3 in 2d:
@@ -5550,7 +5554,7 @@ LOOKUP_TABLE default
 1 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -5645,6 +5649,7 @@ cell_data
 42. 16. 5.0 5.0 
 
 
+0
 
 DEAL::Checking Q3 in 3d:
 object "vertices" class array type float rank 1 shape 3 items 132 data follows
@@ -7478,7 +7483,7 @@ LOOKUP_TABLE default
 2 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -7780,6 +7785,7 @@ cell_data
 3.2e+02 4.3e+02 5.1e+02 67. 13. 13. 13. 13. 
 
 
+0
 
 DEAL::Checking DGQ0 in 1d:
 DEAL::Checking DGQ0 in 2d:
@@ -8144,7 +8150,7 @@ LOOKUP_TABLE default
 1 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -8239,6 +8245,7 @@ cell_data
 5.0 5.0 5.0 5.0 
 
 
+0
 
 DEAL::Checking DGQ0 in 3d:
 object "vertices" class array type float rank 1 shape 3 items 132 data follows
@@ -10072,7 +10079,7 @@ LOOKUP_TABLE default
 2 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -10374,6 +10381,7 @@ cell_data
 13. 13. 13. 13. 13. 13. 13. 13. 
 
 
+0
 
 DEAL::Checking DGQ1 in 1d:
 DEAL::Checking DGQ1 in 2d:
@@ -10738,7 +10746,7 @@ LOOKUP_TABLE default
 1 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -10833,6 +10841,7 @@ cell_data
 20. 22. 5.0 5.0 
 
 
+0
 
 DEAL::Checking DGQ1 in 3d:
 object "vertices" class array type float rank 1 shape 3 items 132 data follows
@@ -12666,7 +12675,7 @@ LOOKUP_TABLE default
 2 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -12968,6 +12977,7 @@ cell_data
 1.0e+02 1.1e+02 1.1e+02 1.1e+02 13. 13. 13. 13. 
 
 
+0
 
 DEAL::Checking DGQ2 in 1d:
 DEAL::Checking DGQ2 in 2d:
@@ -13332,7 +13342,7 @@ LOOKUP_TABLE default
 1 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -13427,6 +13437,7 @@ cell_data
 45. 51. 5.0 5.0 
 
 
+0
 
 DEAL::Checking DGQ2 in 3d:
 object "vertices" class array type float rank 1 shape 3 items 132 data follows
@@ -15260,7 +15271,7 @@ LOOKUP_TABLE default
 2 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -15562,6 +15573,7 @@ cell_data
 3.5e+02 3.6e+02 3.7e+02 3.8e+02 13. 13. 13. 13. 
 
 
+0
 
 DEAL::Checking Nedelec1 in 2d:
 object "vertices" class array type float rank 1 shape 2 items 20 data follows
@@ -15953,7 +15965,7 @@ LOOKUP_TABLE default
 1 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 3
 node_data_0
 node_data_1
@@ -16049,6 +16061,7 @@ cell_data
 52. 76. 68. 68. 5.0 5.0 
 
 
+0
 
 DEAL::Checking Nedelec1 in 3d:
 object "vertices" class array type float rank 1 shape 3 items 132 data follows
@@ -18162,7 +18175,7 @@ LOOKUP_TABLE default
 2 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 4
 node_data_0
 node_data_1
@@ -18466,4 +18479,5 @@ cell_data
 2.3e+02 3.0e+02 3.5e+02 4.0e+02 3.0e+02 3.0e+02 3.9e+02 3.9e+02 3.6e+02 4.0e+02 3.6e+02 4.0e+02 13. 13. 13. 13. 
 
 
+0
 
index d6242bd9083b86758f7db0fc0a6f3171e95ed594..f64099a48c11a246a184cfe78f03a0ea2c79b8ca 100644 (file)
@@ -669,7 +669,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -782,6 +782,7 @@ cell_data
 3.0 3.0 0.0 0.0 2.0 2.0 2.0 2.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -4796,7 +4797,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -5053,6 +5054,7 @@ cell_data
 11. 11. 12. 12. 13. 13. 2.0 2.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 DEAL::Checking Q1 in 3d:
 DEAL::Checking Q2 in 1d:
@@ -5725,7 +5727,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -5838,6 +5840,7 @@ cell_data
 4.0 4.0 0.0 0.0 2.0 2.0 2.0 2.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -9852,7 +9855,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -10109,6 +10112,7 @@ cell_data
 24. 24. 30. 30. 35. 35. 2.0 2.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 DEAL::Checking Q2 in 3d:
 DEAL::Checking Q3 in 1d:
@@ -10781,7 +10785,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -10894,6 +10898,7 @@ cell_data
 5.0 5.0 0.0 0.0 2.0 2.0 2.0 2.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -14908,7 +14913,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -15165,6 +15170,7 @@ cell_data
 43. 43. 56. 56. 67. 67. 2.0 2.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 DEAL::Checking Q3 in 3d:
 DEAL::Checking DGQ0 in 1d:
@@ -15837,7 +15843,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -15950,6 +15956,7 @@ cell_data
 2.0 2.0 2.0 2.0 2.0 2.0 2.0 2.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -19964,7 +19971,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -20221,6 +20228,7 @@ cell_data
 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 DEAL::Checking DGQ0 in 3d:
 DEAL::Checking DGQ1 in 1d:
@@ -20893,7 +20901,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -21006,6 +21014,7 @@ cell_data
 4.0 4.0 5.0 5.0 2.0 2.0 2.0 2.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -25020,7 +25029,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -25277,6 +25286,7 @@ cell_data
 24. 24. 25. 25. 26. 26. 27. 27. 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 DEAL::Checking DGQ1 in 3d:
 DEAL::Checking DGQ2 in 1d:
@@ -25949,7 +25959,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -26062,6 +26072,7 @@ cell_data
 6.0 6.0 8.0 8.0 2.0 2.0 2.0 2.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -30076,7 +30087,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -30333,6 +30344,7 @@ cell_data
 54. 54. 56. 56. 60. 60. 62. 62. 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 DEAL::Checking DGQ2 in 3d:
 DEAL::Checking Nedelec1 in 2d:
@@ -34402,7 +34414,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 3
 node_data_0
 node_data_1
@@ -34660,5 +34672,6 @@ cell_data
 64. 64. 64. 64. 84. 84. 84. 84. 72. 80. 72. 80. 72. 80. 72. 80. 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 DEAL::Checking Nedelec1 in 3d:
index 71fdbf0b7758e65e5c6c264dfd9962d84dcf37a3..2cf8dccb7cbc054b456d2ee4454126e8f2e343fa 100644 (file)
@@ -669,7 +669,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -782,6 +782,7 @@ cell_data
 3.0 3.0 0.0 0.0 2.0 2.0 2.0 2.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -4796,7 +4797,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -5053,6 +5054,7 @@ cell_data
 11. 11. 12. 12. 13. 13. 2.0 2.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 DEAL::Checking Q1 in 3d:
 DEAL::Checking Q2 in 1d:
@@ -5725,7 +5727,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -5838,6 +5840,7 @@ cell_data
 4.0 4.0 0.0 0.0 2.0 2.0 2.0 2.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -9852,7 +9855,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -10109,6 +10112,7 @@ cell_data
 24. 24. 30. 30. 35. 35. 2.0 2.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 DEAL::Checking Q2 in 3d:
 DEAL::Checking Q3 in 1d:
@@ -10781,7 +10785,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -10894,6 +10898,7 @@ cell_data
 5.0 5.0 0.0 0.0 2.0 2.0 2.0 2.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -14908,7 +14913,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -15165,6 +15170,7 @@ cell_data
 43. 43. 56. 56. 67. 67. 2.0 2.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 DEAL::Checking Q3 in 3d:
 DEAL::Checking DGQ0 in 1d:
@@ -15837,7 +15843,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -15950,6 +15956,7 @@ cell_data
 2.0 2.0 2.0 2.0 2.0 2.0 2.0 2.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -19964,7 +19971,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -20221,6 +20228,7 @@ cell_data
 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 DEAL::Checking DGQ0 in 3d:
 DEAL::Checking DGQ1 in 1d:
@@ -20893,7 +20901,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -21006,6 +21014,7 @@ cell_data
 4.0 4.0 5.0 5.0 2.0 2.0 2.0 2.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -25020,7 +25029,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -25277,6 +25286,7 @@ cell_data
 24. 24. 25. 25. 26. 26. 27. 27. 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 DEAL::Checking DGQ1 in 3d:
 DEAL::Checking DGQ2 in 1d:
@@ -25949,7 +25959,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -26062,6 +26072,7 @@ cell_data
 6.0 6.0 8.0 8.0 2.0 2.0 2.0 2.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -30076,7 +30087,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -30333,6 +30344,7 @@ cell_data
 54. 54. 56. 56. 60. 60. 62. 62. 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 DEAL::Checking DGQ2 in 3d:
 DEAL::Checking Nedelec1 in 2d:
@@ -34402,7 +34414,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 3
 node_data_0
 node_data_1
@@ -34660,5 +34672,6 @@ cell_data
 64. 64. 64. 64. 84. 84. 84. 84. 72. 80. 72. 80. 72. 80. 72. 80. 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 DEAL::Checking Nedelec1 in 3d:
index f4dc466a0679d985224bda6a0c19e41c6c904c17..679695627561c4cd2e74275fd7c305344e784bfa 100644 (file)
@@ -713,6 +713,7 @@ light_source {
       [1.00 color White]    
 } } }
 
+0
 
 mesh {
 triangle {
@@ -4996,6 +4997,7 @@ endvars
 endgmv
 # This file was generated by the deal.II library.
 
+0
 
 #
 # For a description of the Tecplot format see the Tecplot documentation.
@@ -6057,6 +6059,7 @@ attribute
 end
 # This file was generated by the deal.II library.
 
+0
 
 #
 # For a description of the UCD format see the AVS Developer's guide.
@@ -10137,6 +10140,7 @@ light_source {
       [1.00 color White]    
 } } }
 
+0
 
 mesh {
 triangle {
@@ -10769,6 +10773,7 @@ attribute
 end
 # This file was generated by the deal.II library.
 
+0
 
 #
 # For a description of the UCD format see the AVS Developer's guide.
@@ -14849,6 +14854,7 @@ light_source {
       [1.00 color White]    
 } } }
 
+0
 
 mesh {
 triangle {
@@ -15481,6 +15487,7 @@ attribute
 end
 # This file was generated by the deal.II library.
 
+0
 
 #
 # For a description of the UCD format see the AVS Developer's guide.
@@ -19561,6 +19568,7 @@ light_source {
       [1.00 color White]    
 } } }
 
+0
 
 mesh {
 triangle {
@@ -20193,6 +20201,7 @@ attribute
 end
 # This file was generated by the deal.II library.
 
+0
 
 #
 # For a description of the UCD format see the AVS Developer's guide.
@@ -24273,6 +24282,7 @@ light_source {
       [1.00 color White]    
 } } }
 
+0
 
 mesh {
 triangle {
@@ -24905,6 +24915,7 @@ attribute
 end
 # This file was generated by the deal.II library.
 
+0
 
 #
 # For a description of the UCD format see the AVS Developer's guide.
@@ -29328,6 +29339,7 @@ endvars
 endgmv
 # This file was generated by the deal.II library.
 
+0
 
 #
 # For a description of the Tecplot format see the Tecplot documentation.
@@ -32359,5 +32371,6 @@ LOOKUP_TABLE default
 0.25000 -6.1232e-17 0.25000 48.000 76.000 6.0000
 0.25000 -6.1232e-17 0.50000 80.000 76.000 6.0000
 
+0
 
 DEAL::Checking Nedelec1 in 3d:
index 1c0ad495c2151ae8961743f5d5f92f94d3aa0330..7449e63b392b3c450a87a93bc46194aa90b8cbea 100644 (file)
@@ -713,6 +713,7 @@ light_source {
       [1.00 color White]    
 } } }
 
+0
 
 mesh {
 triangle {
@@ -4996,6 +4997,7 @@ endvars
 endgmv
 # This file was generated by the deal.II library.
 
+0
 
 #
 # For a description of the Tecplot format see the Tecplot documentation.
@@ -6057,6 +6059,7 @@ attribute
 end
 # This file was generated by the deal.II library.
 
+0
 
 #
 # For a description of the UCD format see the AVS Developer's guide.
@@ -10137,6 +10140,7 @@ light_source {
       [1.00 color White]    
 } } }
 
+0
 
 mesh {
 triangle {
@@ -10769,6 +10773,7 @@ attribute
 end
 # This file was generated by the deal.II library.
 
+0
 
 #
 # For a description of the UCD format see the AVS Developer's guide.
@@ -14849,6 +14854,7 @@ light_source {
       [1.00 color White]    
 } } }
 
+0
 
 mesh {
 triangle {
@@ -15481,6 +15487,7 @@ attribute
 end
 # This file was generated by the deal.II library.
 
+0
 
 #
 # For a description of the UCD format see the AVS Developer's guide.
@@ -19561,6 +19568,7 @@ light_source {
       [1.00 color White]    
 } } }
 
+0
 
 mesh {
 triangle {
@@ -20193,6 +20201,7 @@ attribute
 end
 # This file was generated by the deal.II library.
 
+0
 
 #
 # For a description of the UCD format see the AVS Developer's guide.
@@ -24273,6 +24282,7 @@ light_source {
       [1.00 color White]    
 } } }
 
+0
 
 mesh {
 triangle {
@@ -24905,6 +24915,7 @@ attribute
 end
 # This file was generated by the deal.II library.
 
+0
 
 #
 # For a description of the UCD format see the AVS Developer's guide.
@@ -29328,6 +29339,7 @@ endvars
 endgmv
 # This file was generated by the deal.II library.
 
+0
 
 #
 # For a description of the Tecplot format see the Tecplot documentation.
@@ -32359,5 +32371,6 @@ LOOKUP_TABLE default
 0.25000 -6.1232e-17 0.25000 48.000 76.000 6.0000
 0.25000 -6.1232e-17 0.50000 80.000 76.000 6.0000
 
+0
 
 DEAL::Checking Nedelec1 in 3d:
index 56934f6680018734e73dfd5613199cff984dd1c0..816bb456f7374007a48f28fdb1ad4b919845709e 100644 (file)
@@ -669,7 +669,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -782,6 +782,7 @@ cell_data
 3.0 3.0 0.0 0.0 2.0 2.0 2.0 2.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -4796,7 +4797,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -5053,6 +5054,7 @@ cell_data
 11. 11. 12. 12. 13. 13. 2.0 2.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 DEAL::Checking Q1 in 3d:
 DEAL::Checking Q2 in 1d:
@@ -5725,7 +5727,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -5838,6 +5840,7 @@ cell_data
 4.0 4.0 0.0 0.0 2.0 2.0 2.0 2.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -9852,7 +9855,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -10109,6 +10112,7 @@ cell_data
 24. 24. 30. 30. 35. 35. 2.0 2.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 DEAL::Checking Q2 in 3d:
 DEAL::Checking Q3 in 1d:
@@ -10781,7 +10785,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -10894,6 +10898,7 @@ cell_data
 5.0 5.0 0.0 0.0 2.0 2.0 2.0 2.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -14908,7 +14913,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -15165,6 +15170,7 @@ cell_data
 43. 43. 56. 56. 67. 67. 2.0 2.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 DEAL::Checking Q3 in 3d:
 DEAL::Checking DGQ0 in 1d:
@@ -15837,7 +15843,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -15950,6 +15956,7 @@ cell_data
 2.0 2.0 2.0 2.0 2.0 2.0 2.0 2.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -19964,7 +19971,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -20221,6 +20228,7 @@ cell_data
 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 DEAL::Checking DGQ0 in 3d:
 DEAL::Checking DGQ1 in 1d:
@@ -20893,7 +20901,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -21006,6 +21014,7 @@ cell_data
 4.0 4.0 5.0 5.0 2.0 2.0 2.0 2.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -25020,7 +25029,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -25277,6 +25286,7 @@ cell_data
 24. 24. 25. 25. 26. 26. 27. 27. 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 DEAL::Checking DGQ1 in 3d:
 DEAL::Checking DGQ2 in 1d:
@@ -25949,7 +25959,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -26062,6 +26072,7 @@ cell_data
 6.0 6.0 8.0 8.0 2.0 2.0 2.0 2.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -30076,7 +30087,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -30333,6 +30344,7 @@ cell_data
 54. 54. 56. 56. 60. 60. 62. 62. 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 DEAL::Checking DGQ2 in 3d:
 DEAL::Checking Nedelec1 in 2d:
@@ -34402,7 +34414,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 3
 node_data_0
 node_data_1
@@ -34660,5 +34672,6 @@ cell_data
 64. 64. 64. 64. 84. 84. 84. 84. 72. 80. 72. 80. 72. 80. 72. 80. 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 DEAL::Checking Nedelec1 in 3d:
index 56934f6680018734e73dfd5613199cff984dd1c0..816bb456f7374007a48f28fdb1ad4b919845709e 100644 (file)
@@ -669,7 +669,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -782,6 +782,7 @@ cell_data
 3.0 3.0 0.0 0.0 2.0 2.0 2.0 2.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -4796,7 +4797,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -5053,6 +5054,7 @@ cell_data
 11. 11. 12. 12. 13. 13. 2.0 2.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 DEAL::Checking Q1 in 3d:
 DEAL::Checking Q2 in 1d:
@@ -5725,7 +5727,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -5838,6 +5840,7 @@ cell_data
 4.0 4.0 0.0 0.0 2.0 2.0 2.0 2.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -9852,7 +9855,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -10109,6 +10112,7 @@ cell_data
 24. 24. 30. 30. 35. 35. 2.0 2.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 DEAL::Checking Q2 in 3d:
 DEAL::Checking Q3 in 1d:
@@ -10781,7 +10785,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -10894,6 +10898,7 @@ cell_data
 5.0 5.0 0.0 0.0 2.0 2.0 2.0 2.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -14908,7 +14913,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -15165,6 +15170,7 @@ cell_data
 43. 43. 56. 56. 67. 67. 2.0 2.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 DEAL::Checking Q3 in 3d:
 DEAL::Checking DGQ0 in 1d:
@@ -15837,7 +15843,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -15950,6 +15956,7 @@ cell_data
 2.0 2.0 2.0 2.0 2.0 2.0 2.0 2.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -19964,7 +19971,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -20221,6 +20228,7 @@ cell_data
 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 DEAL::Checking DGQ0 in 3d:
 DEAL::Checking DGQ1 in 1d:
@@ -20893,7 +20901,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -21006,6 +21014,7 @@ cell_data
 4.0 4.0 5.0 5.0 2.0 2.0 2.0 2.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -25020,7 +25029,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -25277,6 +25286,7 @@ cell_data
 24. 24. 25. 25. 26. 26. 27. 27. 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 DEAL::Checking DGQ1 in 3d:
 DEAL::Checking DGQ2 in 1d:
@@ -25949,7 +25959,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -26062,6 +26072,7 @@ cell_data
 6.0 6.0 8.0 8.0 2.0 2.0 2.0 2.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -30076,7 +30087,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -30333,6 +30344,7 @@ cell_data
 54. 54. 56. 56. 60. 60. 62. 62. 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 DEAL::Checking DGQ2 in 3d:
 DEAL::Checking Nedelec1 in 2d:
@@ -34402,7 +34414,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 3
 node_data_0
 node_data_1
@@ -34660,5 +34672,6 @@ cell_data
 64. 64. 64. 64. 84. 84. 84. 84. 72. 80. 72. 80. 72. 80. 72. 80. 6.0 6.0 6.0 6.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 DEAL::Checking Nedelec1 in 3d:
index ed179dbc7a5f20ebb0b3d52688c4b6b1b8464374..d676a84ae78e9c7c0af179a807ef6fb619e00a81 100644 (file)
@@ -678,7 +678,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -4830,7 +4830,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -5768,7 +5768,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -9920,7 +9920,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -10858,7 +10858,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -15010,7 +15010,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -15948,7 +15948,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -20100,7 +20100,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -21038,7 +21038,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -25190,7 +25190,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -26128,7 +26128,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -30280,7 +30280,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -34631,7 +34631,7 @@ LOOKUP_TABLE default
 3 3
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 3
 node_data_0
 node_data_1
index f4fd29fdc8f08eb5b0fc7ac54999c2b9203f1804..b7085119df4367ada9b24313547d70e3fb1205b0 100644 (file)
@@ -375,7 +375,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -434,6 +434,7 @@ cell_data
 6.0 0.0 6.0 0.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -931,7 +932,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -990,6 +991,7 @@ cell_data
 8.0 0.0 8.0 0.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -1487,7 +1489,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -1546,6 +1548,7 @@ cell_data
 10. 0.0 10. 0.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -2043,7 +2046,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -2102,6 +2105,7 @@ cell_data
 4.0 4.0 4.0 4.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -2599,7 +2603,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -2658,6 +2662,7 @@ cell_data
 8.0 10. 8.0 10. 6.0 6.0 6.0 6.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -3155,7 +3160,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -3214,6 +3219,7 @@ cell_data
 12. 16. 12. 16. 6.0 6.0 6.0 6.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
index f4fd29fdc8f08eb5b0fc7ac54999c2b9203f1804..b7085119df4367ada9b24313547d70e3fb1205b0 100644 (file)
@@ -375,7 +375,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -434,6 +434,7 @@ cell_data
 6.0 0.0 6.0 0.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -931,7 +932,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -990,6 +991,7 @@ cell_data
 8.0 0.0 8.0 0.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -1487,7 +1489,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -1546,6 +1548,7 @@ cell_data
 10. 0.0 10. 0.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -2043,7 +2046,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -2102,6 +2105,7 @@ cell_data
 4.0 4.0 4.0 4.0 6.0 6.0 6.0 6.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -2599,7 +2603,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -2658,6 +2662,7 @@ cell_data
 8.0 10. 8.0 10. 6.0 6.0 6.0 6.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 
@@ -3155,7 +3160,7 @@ LOOKUP_TABLE default
 2 2
 [deal.II intermediate format graphics data]
 [written by deal.II 6.1.pre]
-[Version: 2]
+[Version: 3]
 2
 node_data
 cell_data
@@ -3214,6 +3219,7 @@ cell_data
 12. 16. 12. 16. 6.0 6.0 6.0 6.0 
 
 
+0
 
 /* This file was generated by the deal.II library.
 

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.