]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
new tests.
authorwolf <wolf@0785d39b-7218-0410-832d-ea1e28bc413d>
Mon, 25 Jul 2005 20:39:15 +0000 (20:39 +0000)
committerwolf <wolf@0785d39b-7218-0410-832d-ea1e28bc413d>
Mon, 25 Jul 2005 20:39:15 +0000 (20:39 +0000)
git-svn-id: https://svn.dealii.org/trunk@11199 0785d39b-7218-0410-832d-ea1e28bc413d

tests/bits/Makefile
tests/bits/christian_1.cc [new file with mode: 0644]
tests/bits/christian_2.cc [new file with mode: 0644]
tests/results/i686-pc-linux-gnu+gcc3.2/bits/christian_1.output [new file with mode: 0644]
tests/results/i686-pc-linux-gnu+gcc3.2/bits/christian_2.output [new file with mode: 0644]

index a258b02ecaf41aee9b252e66fc7119335a6e51aa..86cbc8c7f4e2eaf4276164c6ec85431126788aca 100644 (file)
@@ -68,7 +68,8 @@ tests_x = geometry_info_* \
          fe_q_3d* \
           rt_* \
          nedelec_* \
-         get_fe_from_name
+         get_fe_from_name \
+         christian_*
 
 # tests for the hp branch:
 #        fe_collection_*
diff --git a/tests/bits/christian_1.cc b/tests/bits/christian_1.cc
new file mode 100644 (file)
index 0000000..2b46ced
--- /dev/null
@@ -0,0 +1,192 @@
+//----------------------------  christian_1.cc  ---------------------------
+//    $Id$
+//    Version: $Name$ 
+//
+//    Copyright (C) 2005 by the deal.II authors and Christian Kamm
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  christian_1.cc  ---------------------------
+
+// check intergrid transfer
+
+#include "../tests.h"
+#include <base/function_derivative.h>
+#include <base/quadrature_lib.h>
+#include <lac/vector.h>
+#include <grid/grid_generator.h>
+#include <fe/fe.h>
+#include <fe/fe_q.h>
+#include <dofs/dof_handler.h>
+#include <dofs/dof_constraints.h>
+#include <dofs/dof_tools.h>
+#include <numerics/data_out.h>
+#include <numerics/vectors.h>
+#include <numerics/data_out_stack.h>
+#include <fstream>
+#include <iostream>
+
+#include <grid/intergrid_map.h>
+#include <dofs/dof_handler.h>
+
+namespace DoFToolsEx
+{
+  /// transfers solution between differently refined grids
+  template <int dim, class InVector, class OutVector>
+  void transfer(const DoFHandler<dim>& source_dof, const InVector& source_vector, const DoFHandler<dim>& target_dof, OutVector& target_vector);
+}
+
+/**
+ * Detailed desc.
+ * Does it make sense to have InVector and OutVector templates? Shouldn't just one Vector be enough?
+ * 
+ * @param
+ * 
+ */
+template <int dim, class InVector, class OutVector>
+void
+DoFToolsEx::transfer(const DoFHandler<dim>& source_dof, const InVector& source_vector, const DoFHandler<dim>& target_dof, OutVector& target_vector)
+{
+  // any sanity tests? Trias derived from same coarse grid?
+  
+  // build mappings between the cells
+  InterGridMap<DoFHandler, dim> source2target, target2source;
+  source2target.make_mapping(source_dof, target_dof);
+  target2source.make_mapping(target_dof, source_dof);
+  
+  // setup temporary vector
+  InVector local_dofs(source_dof.get_fe().dofs_per_cell);
+  
+  // iterate over all active source cells
+  typedef typename DoFHandler<dim>::active_cell_iterator cell_iterator;
+  cell_iterator cell = source_dof.begin_active(), endc = source_dof.end();
+  for(; cell != endc; ++cell)
+  {
+    if(cell->level() == source2target[cell]->level())
+    {
+      // cell has not been coarsend, but possibly been refined
+      cell->get_dof_values(source_vector, local_dofs);
+      source2target[cell]->set_dof_values_by_interpolation(local_dofs, target_vector);
+    }
+    else
+    {
+      // the source cell has been coarsened
+      Assert(cell->level() > source2target[cell]->level(), ExcInternalError());
+      target2source[ source2target[cell] ]->get_interpolated_dof_values(source_vector, local_dofs);
+      source2target[cell]->set_dof_values(local_dofs, target_vector);
+    }
+  }
+  
+  // handle hanging node constraints inside or outside of this function?
+}
+
+
+class TestFunction : public Function<2>
+{
+  public:
+    TestFunction() : Function<2>() {};
+    virtual double value(const Point<2> &p,
+           const unsigned int) const
+    { return std::sin(3.14159*p(0))*std::sin(3.14159*p(1)); };
+};
+
+int main()
+{
+  std::ofstream logfile("christian_1.output");
+  deallog.attach(logfile);
+  deallog.depth_console(0);
+  deallog.threshold_double(1.e-10);
+
+
+                                   // build test-case trias
+  Triangulation<2> tria;
+  Triangulation<2> refined_tria;
+  Triangulation<2> coarse_tria;
+  Triangulation<2> both_tria;
+
+  // make grids
+  GridGenerator::hyper_cube(tria, 0, 1);
+  tria.refine_global(2);
+  GridGenerator::hyper_cube(refined_tria, 0, 1);
+  refined_tria.refine_global(3);
+  GridGenerator::hyper_cube(coarse_tria, 0, 1);
+  coarse_tria.refine_global(1);
+  GridGenerator::hyper_cube(both_tria, 0, 1);
+  both_tria.refine_global(2);
+  Triangulation<2>::active_cell_iterator it = both_tria.begin_active();
+  it->set_refine_flag();
+  (++it)->set_refine_flag();
+  for(int i = 1; i < 8; ++i, ++it);
+  it->set_coarsen_flag();
+  (++it)->set_coarsen_flag();
+  (++it)->set_coarsen_flag();
+  (++it)->set_coarsen_flag();
+  both_tria.execute_coarsening_and_refinement();
+
+  // finite element
+  FE_Q<2> fe(1);
+  // dof handlers
+  DoFHandler<2> dof(tria), refined_dof(refined_tria), coarse_dof(coarse_tria), both_dof(both_tria);
+  dof.distribute_dofs(fe);
+  refined_dof.distribute_dofs(fe);
+  coarse_dof.distribute_dofs(fe);
+  both_dof.distribute_dofs(fe);
+
+  // interpolate test function onto tria
+  Vector<double> sol(dof.n_dofs());
+  TestFunction test_function;
+  VectorTools::interpolate(dof, test_function, sol);
+
+  // setup solution vectors
+  Vector<double> refined_sol(refined_dof.n_dofs()), coarse_sol(coarse_dof.n_dofs()), both_sol(both_dof.n_dofs());
+  
+  // transfer solutions
+  DoFToolsEx::transfer(dof, sol, refined_dof, refined_sol);
+  DoFToolsEx::transfer(dof, sol, coarse_dof, coarse_sol);
+  DoFToolsEx::transfer(dof, sol, both_dof, both_sol);
+  
+  // handle hanging nodes
+  ConstraintMatrix both_constraints;
+  DoFTools::make_hanging_node_constraints(both_dof, both_constraints);
+  both_constraints.close();
+  both_constraints.distribute(both_sol);
+  
+  // reference output using DataOut to create seperate files
+  DataOut<2> data_out;
+  data_out.attach_dof_handler(dof);
+  data_out.add_data_vector(sol, "base");
+  data_out.build_patches();
+  data_out.write_gnuplot(logfile);
+
+  data_out.clear();
+  data_out.attach_dof_handler(refined_dof);
+  data_out.add_data_vector(refined_sol, "refined");
+  data_out.build_patches();
+  data_out.write_gnuplot(logfile);
+
+  data_out.clear();
+  data_out.attach_dof_handler(coarse_dof);
+  data_out.add_data_vector(coarse_sol, "coarse");
+  data_out.build_patches();
+  data_out.write_gnuplot(logfile);
+
+  data_out.clear();
+  data_out.attach_dof_handler(both_dof);
+  data_out.add_data_vector(both_sol, "both");
+  data_out.build_patches();
+  data_out.write_gnuplot(logfile);
+
+  // test output using DataOutStack
+  DataOutStack<2> data_out_stack;
+  data_out_stack.declare_data_vector("dof", DataOutStack<2>::dof_vector);
+  data_out_stack.new_parameter_value(0.,0.);
+  data_out_stack.attach_dof_handler(dof);
+  data_out_stack.add_data_vector(sol, "dof");
+  data_out_stack.build_patches();
+  data_out_stack.finish_parameter_value();
+  data_out_stack.write_gnuplot(logfile);
+}
diff --git a/tests/bits/christian_2.cc b/tests/bits/christian_2.cc
new file mode 100644 (file)
index 0000000..7b0c292
--- /dev/null
@@ -0,0 +1,54 @@
+//----------------------------  christian_2.cc  ---------------------------
+//    $Id$
+//    Version: $Name$ 
+//
+//    Copyright (C) 2005 by the deal.II authors and Christian Kamm
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  christian_2.cc  ---------------------------
+
+// check one aspect of DataOutStack in 2+1d
+
+#include "../tests.h"
+#include <lac/vector.h>
+#include <grid/grid_generator.h>
+#include <fe/fe_q.h>
+#include <dofs/dof_handler.h>
+#include <numerics/data_out_stack.h>
+#include <fstream>
+#include <iostream>
+
+
+int main()
+{
+  std::ofstream logfile("christian_2.output");
+  deallog.attach(logfile);
+  deallog.depth_console(0);
+  deallog.threshold_double(1.e-10);
+
+  Triangulation<2> tria;
+  GridGenerator::hyper_cube(tria, 0, 1);
+  FE_Q<2> fe(1);
+  DoFHandler<2> dof(tria);
+  dof.distribute_dofs(fe);
+
+  Vector<double> sol(dof.n_dofs());
+  for (unsigned int i=0; i<dof.n_dofs(); ++i)
+    sol(i) = i;
+
+                                   // test output using DataOutStack
+  DataOutStack<2> data_out_stack;
+  data_out_stack.declare_data_vector("dof", DataOutStack<2>::dof_vector);
+  data_out_stack.new_parameter_value(2.5,1.);
+  data_out_stack.attach_dof_handler(dof);
+  data_out_stack.add_data_vector(sol, "dof");
+  data_out_stack.build_patches();
+  data_out_stack.finish_parameter_value();
+
+  data_out_stack.write_gnuplot(logfile);
+}
diff --git a/tests/results/i686-pc-linux-gnu+gcc3.2/bits/christian_1.output b/tests/results/i686-pc-linux-gnu+gcc3.2/bits/christian_1.output
new file mode 100644 (file)
index 0000000..b06add8
--- /dev/null
@@ -0,0 +1,1525 @@
+
+# This file was generated by the deal.II library.
+
+
+#
+# For a description of the GNUPLOT format see the GNUPLOT manual.
+#
+# <x> <y> <base> 
+0.00000 0.00000 0.00000 
+0.00000 0.250000 0.00000 
+
+0.250000 0.00000 0.00000 
+0.250000 0.250000 0.499999 
+
+
+0.250000 0.00000 0.00000 
+0.250000 0.250000 0.499999 
+
+0.500000 0.00000 0.00000 
+0.500000 0.250000 0.707106 
+
+
+0.250000 0.250000 0.499999 
+0.250000 0.500000 0.707106 
+
+0.500000 0.250000 0.707106 
+0.500000 0.500000 1.00000 
+
+
+0.00000 0.250000 0.00000 
+0.00000 0.500000 0.00000 
+
+0.250000 0.250000 0.499999 
+0.250000 0.500000 0.707106 
+
+
+0.500000 0.00000 0.00000 
+0.500000 0.250000 0.707106 
+
+0.750000 0.00000 0.00000 
+0.750000 0.250000 0.500001 
+
+
+0.750000 0.00000 0.00000 
+0.750000 0.250000 0.500001 
+
+1.00000 0.00000 0.00000 
+1.00000 0.250000 1.87637e-06 
+
+
+0.750000 0.250000 0.500001 
+0.750000 0.500000 0.707108 
+
+1.00000 0.250000 1.87637e-06 
+1.00000 0.500000 2.65359e-06 
+
+
+0.500000 0.250000 0.707106 
+0.500000 0.500000 1.00000 
+
+0.750000 0.250000 0.500001 
+0.750000 0.500000 0.707108 
+
+
+0.500000 0.500000 1.00000 
+0.500000 0.750000 0.707108 
+
+0.750000 0.500000 0.707108 
+0.750000 0.750000 0.500002 
+
+
+0.750000 0.500000 0.707108 
+0.750000 0.750000 0.500002 
+
+1.00000 0.500000 2.65359e-06 
+1.00000 0.750000 1.87638e-06 
+
+
+0.750000 0.750000 0.500002 
+0.750000 1.00000 1.87638e-06 
+
+1.00000 0.750000 1.87638e-06 
+1.00000 1.00000 7.04154e-12 
+
+
+0.500000 0.750000 0.707108 
+0.500000 1.00000 2.65359e-06 
+
+0.750000 0.750000 0.500002 
+0.750000 1.00000 1.87638e-06 
+
+
+0.00000 0.500000 0.00000 
+0.00000 0.750000 0.00000 
+
+0.250000 0.500000 0.707106 
+0.250000 0.750000 0.500001 
+
+
+0.250000 0.500000 0.707106 
+0.250000 0.750000 0.500001 
+
+0.500000 0.500000 1.00000 
+0.500000 0.750000 0.707108 
+
+
+0.250000 0.750000 0.500001 
+0.250000 1.00000 1.87637e-06 
+
+0.500000 0.750000 0.707108 
+0.500000 1.00000 2.65359e-06 
+
+
+0.00000 0.750000 0.00000 
+0.00000 1.00000 0.00000 
+
+0.250000 0.750000 0.500001 
+0.250000 1.00000 1.87637e-06 
+
+
+# This file was generated by the deal.II library.
+
+
+#
+# For a description of the GNUPLOT format see the GNUPLOT manual.
+#
+# <x> <y> <refined> 
+0.00000 0.00000 0.00000 
+0.00000 0.125000 0.00000 
+
+0.125000 0.00000 0.00000 
+0.125000 0.125000 0.125000 
+
+
+0.125000 0.00000 0.00000 
+0.125000 0.125000 0.125000 
+
+0.250000 0.00000 0.00000 
+0.250000 0.125000 0.250000 
+
+
+0.125000 0.125000 0.125000 
+0.125000 0.250000 0.250000 
+
+0.250000 0.125000 0.250000 
+0.250000 0.250000 0.499999 
+
+
+0.00000 0.125000 0.00000 
+0.00000 0.250000 0.00000 
+
+0.125000 0.125000 0.125000 
+0.125000 0.250000 0.250000 
+
+
+0.250000 0.00000 0.00000 
+0.250000 0.125000 0.250000 
+
+0.375000 0.00000 0.00000 
+0.375000 0.125000 0.301776 
+
+
+0.375000 0.00000 0.00000 
+0.375000 0.125000 0.301776 
+
+0.500000 0.00000 0.00000 
+0.500000 0.125000 0.353553 
+
+
+0.375000 0.125000 0.301776 
+0.375000 0.250000 0.603553 
+
+0.500000 0.125000 0.353553 
+0.500000 0.250000 0.707106 
+
+
+0.250000 0.125000 0.250000 
+0.250000 0.250000 0.499999 
+
+0.375000 0.125000 0.301776 
+0.375000 0.250000 0.603553 
+
+
+0.250000 0.250000 0.499999 
+0.250000 0.375000 0.603553 
+
+0.375000 0.250000 0.603553 
+0.375000 0.375000 0.728553 
+
+
+0.375000 0.250000 0.603553 
+0.375000 0.375000 0.728553 
+
+0.500000 0.250000 0.707106 
+0.500000 0.375000 0.853553 
+
+
+0.375000 0.375000 0.728553 
+0.375000 0.500000 0.853553 
+
+0.500000 0.375000 0.853553 
+0.500000 0.500000 1.00000 
+
+
+0.250000 0.375000 0.603553 
+0.250000 0.500000 0.707106 
+
+0.375000 0.375000 0.728553 
+0.375000 0.500000 0.853553 
+
+
+0.00000 0.250000 0.00000 
+0.00000 0.375000 0.00000 
+
+0.125000 0.250000 0.250000 
+0.125000 0.375000 0.301776 
+
+
+0.125000 0.250000 0.250000 
+0.125000 0.375000 0.301776 
+
+0.250000 0.250000 0.499999 
+0.250000 0.375000 0.603553 
+
+
+0.125000 0.375000 0.301776 
+0.125000 0.500000 0.353553 
+
+0.250000 0.375000 0.603553 
+0.250000 0.500000 0.707106 
+
+
+0.00000 0.375000 0.00000 
+0.00000 0.500000 0.00000 
+
+0.125000 0.375000 0.301776 
+0.125000 0.500000 0.353553 
+
+
+0.500000 0.00000 0.00000 
+0.500000 0.125000 0.353553 
+
+0.625000 0.00000 0.00000 
+0.625000 0.125000 0.301777 
+
+
+0.625000 0.00000 0.00000 
+0.625000 0.125000 0.301777 
+
+0.750000 0.00000 0.00000 
+0.750000 0.125000 0.250000 
+
+
+0.625000 0.125000 0.301777 
+0.625000 0.250000 0.603553 
+
+0.750000 0.125000 0.250000 
+0.750000 0.250000 0.500001 
+
+
+0.500000 0.125000 0.353553 
+0.500000 0.250000 0.707106 
+
+0.625000 0.125000 0.301777 
+0.625000 0.250000 0.603553 
+
+
+0.750000 0.00000 0.00000 
+0.750000 0.125000 0.250000 
+
+0.875000 0.00000 0.00000 
+0.875000 0.125000 0.125001 
+
+
+0.875000 0.00000 0.00000 
+0.875000 0.125000 0.125001 
+
+1.00000 0.00000 0.00000 
+1.00000 0.125000 9.38185e-07 
+
+
+0.875000 0.125000 0.125001 
+0.875000 0.250000 0.250001 
+
+1.00000 0.125000 9.38185e-07 
+1.00000 0.250000 1.87637e-06 
+
+
+0.750000 0.125000 0.250000 
+0.750000 0.250000 0.500001 
+
+0.875000 0.125000 0.125001 
+0.875000 0.250000 0.250001 
+
+
+0.750000 0.250000 0.500001 
+0.750000 0.375000 0.603554 
+
+0.875000 0.250000 0.250001 
+0.875000 0.375000 0.301778 
+
+
+0.875000 0.250000 0.250001 
+0.875000 0.375000 0.301778 
+
+1.00000 0.250000 1.87637e-06 
+1.00000 0.375000 2.26498e-06 
+
+
+0.875000 0.375000 0.301778 
+0.875000 0.500000 0.353555 
+
+1.00000 0.375000 2.26498e-06 
+1.00000 0.500000 2.65359e-06 
+
+
+0.750000 0.375000 0.603554 
+0.750000 0.500000 0.707108 
+
+0.875000 0.375000 0.301778 
+0.875000 0.500000 0.353555 
+
+
+0.500000 0.250000 0.707106 
+0.500000 0.375000 0.853553 
+
+0.625000 0.250000 0.603553 
+0.625000 0.375000 0.728554 
+
+
+0.625000 0.250000 0.603553 
+0.625000 0.375000 0.728554 
+
+0.750000 0.250000 0.500001 
+0.750000 0.375000 0.603554 
+
+
+0.625000 0.375000 0.728554 
+0.625000 0.500000 0.853554 
+
+0.750000 0.375000 0.603554 
+0.750000 0.500000 0.707108 
+
+
+0.500000 0.375000 0.853553 
+0.500000 0.500000 1.00000 
+
+0.625000 0.375000 0.728554 
+0.625000 0.500000 0.853554 
+
+
+0.500000 0.500000 1.00000 
+0.500000 0.625000 0.853554 
+
+0.625000 0.500000 0.853554 
+0.625000 0.625000 0.728555 
+
+
+0.625000 0.500000 0.853554 
+0.625000 0.625000 0.728555 
+
+0.750000 0.500000 0.707108 
+0.750000 0.625000 0.603555 
+
+
+0.625000 0.625000 0.728555 
+0.625000 0.750000 0.603555 
+
+0.750000 0.625000 0.603555 
+0.750000 0.750000 0.500002 
+
+
+0.500000 0.625000 0.853554 
+0.500000 0.750000 0.707108 
+
+0.625000 0.625000 0.728555 
+0.625000 0.750000 0.603555 
+
+
+0.750000 0.500000 0.707108 
+0.750000 0.625000 0.603555 
+
+0.875000 0.500000 0.353555 
+0.875000 0.625000 0.301779 
+
+
+0.875000 0.500000 0.353555 
+0.875000 0.625000 0.301779 
+
+1.00000 0.500000 2.65359e-06 
+1.00000 0.625000 2.26498e-06 
+
+
+0.875000 0.625000 0.301779 
+0.875000 0.750000 0.250002 
+
+1.00000 0.625000 2.26498e-06 
+1.00000 0.750000 1.87638e-06 
+
+
+0.750000 0.625000 0.603555 
+0.750000 0.750000 0.500002 
+
+0.875000 0.625000 0.301779 
+0.875000 0.750000 0.250002 
+
+
+0.750000 0.750000 0.500002 
+0.750000 0.875000 0.250002 
+
+0.875000 0.750000 0.250002 
+0.875000 0.875000 0.125001 
+
+
+0.875000 0.750000 0.250002 
+0.875000 0.875000 0.125001 
+
+1.00000 0.750000 1.87638e-06 
+1.00000 0.875000 9.38191e-07 
+
+
+0.875000 0.875000 0.125001 
+0.875000 1.00000 9.38191e-07 
+
+1.00000 0.875000 9.38191e-07 
+1.00000 1.00000 7.04154e-12 
+
+
+0.750000 0.875000 0.250002 
+0.750000 1.00000 1.87638e-06 
+
+0.875000 0.875000 0.125001 
+0.875000 1.00000 9.38191e-07 
+
+
+0.500000 0.750000 0.707108 
+0.500000 0.875000 0.353555 
+
+0.625000 0.750000 0.603555 
+0.625000 0.875000 0.301779 
+
+
+0.625000 0.750000 0.603555 
+0.625000 0.875000 0.301779 
+
+0.750000 0.750000 0.500002 
+0.750000 0.875000 0.250002 
+
+
+0.625000 0.875000 0.301779 
+0.625000 1.00000 2.26498e-06 
+
+0.750000 0.875000 0.250002 
+0.750000 1.00000 1.87638e-06 
+
+
+0.500000 0.875000 0.353555 
+0.500000 1.00000 2.65359e-06 
+
+0.625000 0.875000 0.301779 
+0.625000 1.00000 2.26498e-06 
+
+
+0.00000 0.500000 0.00000 
+0.00000 0.625000 0.00000 
+
+0.125000 0.500000 0.353553 
+0.125000 0.625000 0.301777 
+
+
+0.125000 0.500000 0.353553 
+0.125000 0.625000 0.301777 
+
+0.250000 0.500000 0.707106 
+0.250000 0.625000 0.603553 
+
+
+0.125000 0.625000 0.301777 
+0.125000 0.750000 0.250000 
+
+0.250000 0.625000 0.603553 
+0.250000 0.750000 0.500001 
+
+
+0.00000 0.625000 0.00000 
+0.00000 0.750000 0.00000 
+
+0.125000 0.625000 0.301777 
+0.125000 0.750000 0.250000 
+
+
+0.250000 0.500000 0.707106 
+0.250000 0.625000 0.603553 
+
+0.375000 0.500000 0.853553 
+0.375000 0.625000 0.728554 
+
+
+0.375000 0.500000 0.853553 
+0.375000 0.625000 0.728554 
+
+0.500000 0.500000 1.00000 
+0.500000 0.625000 0.853554 
+
+
+0.375000 0.625000 0.728554 
+0.375000 0.750000 0.603554 
+
+0.500000 0.625000 0.853554 
+0.500000 0.750000 0.707108 
+
+
+0.250000 0.625000 0.603553 
+0.250000 0.750000 0.500001 
+
+0.375000 0.625000 0.728554 
+0.375000 0.750000 0.603554 
+
+
+0.250000 0.750000 0.500001 
+0.250000 0.875000 0.250001 
+
+0.375000 0.750000 0.603554 
+0.375000 0.875000 0.301778 
+
+
+0.375000 0.750000 0.603554 
+0.375000 0.875000 0.301778 
+
+0.500000 0.750000 0.707108 
+0.500000 0.875000 0.353555 
+
+
+0.375000 0.875000 0.301778 
+0.375000 1.00000 2.26498e-06 
+
+0.500000 0.875000 0.353555 
+0.500000 1.00000 2.65359e-06 
+
+
+0.250000 0.875000 0.250001 
+0.250000 1.00000 1.87637e-06 
+
+0.375000 0.875000 0.301778 
+0.375000 1.00000 2.26498e-06 
+
+
+0.00000 0.750000 0.00000 
+0.00000 0.875000 0.00000 
+
+0.125000 0.750000 0.250000 
+0.125000 0.875000 0.125001 
+
+
+0.125000 0.750000 0.250000 
+0.125000 0.875000 0.125001 
+
+0.250000 0.750000 0.500001 
+0.250000 0.875000 0.250001 
+
+
+0.125000 0.875000 0.125001 
+0.125000 1.00000 9.38185e-07 
+
+0.250000 0.875000 0.250001 
+0.250000 1.00000 1.87637e-06 
+
+
+0.00000 0.875000 0.00000 
+0.00000 1.00000 0.00000 
+
+0.125000 0.875000 0.125001 
+0.125000 1.00000 9.38185e-07 
+
+
+# This file was generated by the deal.II library.
+
+
+#
+# For a description of the GNUPLOT format see the GNUPLOT manual.
+#
+# <x> <y> <coarse> 
+0.00000 0.00000 0.00000 
+0.00000 0.500000 0.00000 
+
+0.500000 0.00000 0.00000 
+0.500000 0.500000 1.00000 
+
+
+0.500000 0.00000 0.00000 
+0.500000 0.500000 1.00000 
+
+1.00000 0.00000 0.00000 
+1.00000 0.500000 2.65359e-06 
+
+
+0.500000 0.500000 1.00000 
+0.500000 1.00000 2.65359e-06 
+
+1.00000 0.500000 2.65359e-06 
+1.00000 1.00000 7.04154e-12 
+
+
+0.00000 0.500000 0.00000 
+0.00000 1.00000 0.00000 
+
+0.500000 0.500000 1.00000 
+0.500000 1.00000 2.65359e-06 
+
+
+# This file was generated by the deal.II library.
+
+
+#
+# For a description of the GNUPLOT format see the GNUPLOT manual.
+#
+# <x> <y> <both> 
+0.500000 0.500000 1.00000 
+0.500000 1.00000 2.65359e-06 
+
+1.00000 0.500000 2.65359e-06 
+1.00000 1.00000 7.04154e-12 
+
+
+0.250000 0.250000 0.499999 
+0.250000 0.500000 0.707106 
+
+0.500000 0.250000 0.707106 
+0.500000 0.500000 1.00000 
+
+
+0.00000 0.250000 0.00000 
+0.00000 0.500000 0.00000 
+
+0.250000 0.250000 0.499999 
+0.250000 0.500000 0.707106 
+
+
+0.500000 0.00000 0.00000 
+0.500000 0.250000 0.707106 
+
+0.750000 0.00000 0.00000 
+0.750000 0.250000 0.500001 
+
+
+0.750000 0.00000 0.00000 
+0.750000 0.250000 0.500001 
+
+1.00000 0.00000 0.00000 
+1.00000 0.250000 1.87637e-06 
+
+
+0.750000 0.250000 0.500001 
+0.750000 0.500000 0.500001 
+
+1.00000 0.250000 1.87637e-06 
+1.00000 0.500000 2.65359e-06 
+
+
+0.500000 0.250000 0.707106 
+0.500000 0.500000 1.00000 
+
+0.750000 0.250000 0.500001 
+0.750000 0.500000 0.500001 
+
+
+0.00000 0.500000 0.00000 
+0.00000 0.750000 0.00000 
+
+0.250000 0.500000 0.707106 
+0.250000 0.750000 0.500001 
+
+
+0.250000 0.500000 0.707106 
+0.250000 0.750000 0.500001 
+
+0.500000 0.500000 1.00000 
+0.500000 0.750000 0.500001 
+
+
+0.250000 0.750000 0.500001 
+0.250000 1.00000 1.87637e-06 
+
+0.500000 0.750000 0.500001 
+0.500000 1.00000 2.65359e-06 
+
+
+0.00000 0.750000 0.00000 
+0.00000 1.00000 0.00000 
+
+0.250000 0.750000 0.500001 
+0.250000 1.00000 1.87637e-06 
+
+
+0.00000 0.00000 0.00000 
+0.00000 0.125000 0.00000 
+
+0.125000 0.00000 0.00000 
+0.125000 0.125000 0.125000 
+
+
+0.125000 0.00000 0.00000 
+0.125000 0.125000 0.125000 
+
+0.250000 0.00000 0.00000 
+0.250000 0.125000 0.250000 
+
+
+0.125000 0.125000 0.125000 
+0.125000 0.250000 0.250000 
+
+0.250000 0.125000 0.250000 
+0.250000 0.250000 0.499999 
+
+
+0.00000 0.125000 0.00000 
+0.00000 0.250000 0.00000 
+
+0.125000 0.125000 0.125000 
+0.125000 0.250000 0.250000 
+
+
+0.250000 0.00000 0.00000 
+0.250000 0.125000 0.250000 
+
+0.375000 0.00000 0.00000 
+0.375000 0.125000 0.301776 
+
+
+0.375000 0.00000 0.00000 
+0.375000 0.125000 0.301776 
+
+0.500000 0.00000 0.00000 
+0.500000 0.125000 0.353553 
+
+
+0.375000 0.125000 0.301776 
+0.375000 0.250000 0.603553 
+
+0.500000 0.125000 0.353553 
+0.500000 0.250000 0.707106 
+
+
+0.250000 0.125000 0.250000 
+0.250000 0.250000 0.499999 
+
+0.375000 0.125000 0.301776 
+0.375000 0.250000 0.603553 
+
+
+# This file was generated by the deal.II library.
+
+
+#
+# For a description of the GNUPLOT format see the GNUPLOT manual.
+#
+# <x> <y> <z> <dof> 
+0.00000 0.00000 0.00000 0.00000
+0.250000 0.00000 0.00000 0.00000
+
+
+0.00000 0.00000 0.00000 0.00000
+0.00000 0.250000 0.00000 0.00000
+
+
+0.00000 0.00000 0.00000 0.00000
+0.00000 0.00000 0.00000 0.00000
+
+
+0.00000 0.00000 0.00000 0.00000
+0.250000 0.00000 0.00000 0.00000
+
+
+0.00000 0.00000 0.00000 0.00000
+0.00000 0.250000 0.00000 0.00000
+
+
+0.00000 0.250000 0.00000 0.00000
+0.250000 0.250000 0.00000 0.499999
+
+
+0.00000 0.250000 0.00000 0.00000
+0.00000 0.250000 0.00000 0.00000
+
+
+0.00000 0.250000 0.00000 0.00000
+0.250000 0.250000 0.00000 0.499999
+
+
+0.250000 0.00000 0.00000 0.00000
+0.250000 0.250000 0.00000 0.499999
+
+
+0.250000 0.00000 0.00000 0.00000
+0.250000 0.00000 0.00000 0.00000
+
+
+0.250000 0.00000 0.00000 0.00000
+0.250000 0.250000 0.00000 0.499999
+
+
+0.250000 0.250000 0.00000 0.499999
+0.250000 0.250000 0.00000 0.499999
+
+
+0.250000 0.00000 0.00000 0.00000
+0.500000 0.00000 0.00000 0.00000
+
+
+0.250000 0.00000 0.00000 0.00000
+0.250000 0.250000 0.00000 0.499999
+
+
+0.250000 0.00000 0.00000 0.00000
+0.250000 0.00000 0.00000 0.00000
+
+
+0.250000 0.00000 0.00000 0.00000
+0.500000 0.00000 0.00000 0.00000
+
+
+0.250000 0.00000 0.00000 0.00000
+0.250000 0.250000 0.00000 0.499999
+
+
+0.250000 0.250000 0.00000 0.499999
+0.500000 0.250000 0.00000 0.707106
+
+
+0.250000 0.250000 0.00000 0.499999
+0.250000 0.250000 0.00000 0.499999
+
+
+0.250000 0.250000 0.00000 0.499999
+0.500000 0.250000 0.00000 0.707106
+
+
+0.500000 0.00000 0.00000 0.00000
+0.500000 0.250000 0.00000 0.707106
+
+
+0.500000 0.00000 0.00000 0.00000
+0.500000 0.00000 0.00000 0.00000
+
+
+0.500000 0.00000 0.00000 0.00000
+0.500000 0.250000 0.00000 0.707106
+
+
+0.500000 0.250000 0.00000 0.707106
+0.500000 0.250000 0.00000 0.707106
+
+
+0.250000 0.250000 0.00000 0.499999
+0.500000 0.250000 0.00000 0.707106
+
+
+0.250000 0.250000 0.00000 0.499999
+0.250000 0.500000 0.00000 0.707106
+
+
+0.250000 0.250000 0.00000 0.499999
+0.250000 0.250000 0.00000 0.499999
+
+
+0.250000 0.250000 0.00000 0.499999
+0.500000 0.250000 0.00000 0.707106
+
+
+0.250000 0.250000 0.00000 0.499999
+0.250000 0.500000 0.00000 0.707106
+
+
+0.250000 0.500000 0.00000 0.707106
+0.500000 0.500000 0.00000 1.00000
+
+
+0.250000 0.500000 0.00000 0.707106
+0.250000 0.500000 0.00000 0.707106
+
+
+0.250000 0.500000 0.00000 0.707106
+0.500000 0.500000 0.00000 1.00000
+
+
+0.500000 0.250000 0.00000 0.707106
+0.500000 0.500000 0.00000 1.00000
+
+
+0.500000 0.250000 0.00000 0.707106
+0.500000 0.250000 0.00000 0.707106
+
+
+0.500000 0.250000 0.00000 0.707106
+0.500000 0.500000 0.00000 1.00000
+
+
+0.500000 0.500000 0.00000 1.00000
+0.500000 0.500000 0.00000 1.00000
+
+
+0.00000 0.250000 0.00000 0.00000
+0.250000 0.250000 0.00000 0.499999
+
+
+0.00000 0.250000 0.00000 0.00000
+0.00000 0.500000 0.00000 0.00000
+
+
+0.00000 0.250000 0.00000 0.00000
+0.00000 0.250000 0.00000 0.00000
+
+
+0.00000 0.250000 0.00000 0.00000
+0.250000 0.250000 0.00000 0.499999
+
+
+0.00000 0.250000 0.00000 0.00000
+0.00000 0.500000 0.00000 0.00000
+
+
+0.00000 0.500000 0.00000 0.00000
+0.250000 0.500000 0.00000 0.707106
+
+
+0.00000 0.500000 0.00000 0.00000
+0.00000 0.500000 0.00000 0.00000
+
+
+0.00000 0.500000 0.00000 0.00000
+0.250000 0.500000 0.00000 0.707106
+
+
+0.250000 0.250000 0.00000 0.499999
+0.250000 0.500000 0.00000 0.707106
+
+
+0.250000 0.250000 0.00000 0.499999
+0.250000 0.250000 0.00000 0.499999
+
+
+0.250000 0.250000 0.00000 0.499999
+0.250000 0.500000 0.00000 0.707106
+
+
+0.250000 0.500000 0.00000 0.707106
+0.250000 0.500000 0.00000 0.707106
+
+
+0.500000 0.00000 0.00000 0.00000
+0.750000 0.00000 0.00000 0.00000
+
+
+0.500000 0.00000 0.00000 0.00000
+0.500000 0.250000 0.00000 0.707106
+
+
+0.500000 0.00000 0.00000 0.00000
+0.500000 0.00000 0.00000 0.00000
+
+
+0.500000 0.00000 0.00000 0.00000
+0.750000 0.00000 0.00000 0.00000
+
+
+0.500000 0.00000 0.00000 0.00000
+0.500000 0.250000 0.00000 0.707106
+
+
+0.500000 0.250000 0.00000 0.707106
+0.750000 0.250000 0.00000 0.500001
+
+
+0.500000 0.250000 0.00000 0.707106
+0.500000 0.250000 0.00000 0.707106
+
+
+0.500000 0.250000 0.00000 0.707106
+0.750000 0.250000 0.00000 0.500001
+
+
+0.750000 0.00000 0.00000 0.00000
+0.750000 0.250000 0.00000 0.500001
+
+
+0.750000 0.00000 0.00000 0.00000
+0.750000 0.00000 0.00000 0.00000
+
+
+0.750000 0.00000 0.00000 0.00000
+0.750000 0.250000 0.00000 0.500001
+
+
+0.750000 0.250000 0.00000 0.500001
+0.750000 0.250000 0.00000 0.500001
+
+
+0.750000 0.00000 0.00000 0.00000
+1.00000 0.00000 0.00000 0.00000
+
+
+0.750000 0.00000 0.00000 0.00000
+0.750000 0.250000 0.00000 0.500001
+
+
+0.750000 0.00000 0.00000 0.00000
+0.750000 0.00000 0.00000 0.00000
+
+
+0.750000 0.00000 0.00000 0.00000
+1.00000 0.00000 0.00000 0.00000
+
+
+0.750000 0.00000 0.00000 0.00000
+0.750000 0.250000 0.00000 0.500001
+
+
+0.750000 0.250000 0.00000 0.500001
+1.00000 0.250000 0.00000 1.87637e-06
+
+
+0.750000 0.250000 0.00000 0.500001
+0.750000 0.250000 0.00000 0.500001
+
+
+0.750000 0.250000 0.00000 0.500001
+1.00000 0.250000 0.00000 1.87637e-06
+
+
+1.00000 0.00000 0.00000 0.00000
+1.00000 0.250000 0.00000 1.87637e-06
+
+
+1.00000 0.00000 0.00000 0.00000
+1.00000 0.00000 0.00000 0.00000
+
+
+1.00000 0.00000 0.00000 0.00000
+1.00000 0.250000 0.00000 1.87637e-06
+
+
+1.00000 0.250000 0.00000 1.87637e-06
+1.00000 0.250000 0.00000 1.87637e-06
+
+
+0.750000 0.250000 0.00000 0.500001
+1.00000 0.250000 0.00000 1.87637e-06
+
+
+0.750000 0.250000 0.00000 0.500001
+0.750000 0.500000 0.00000 0.707108
+
+
+0.750000 0.250000 0.00000 0.500001
+0.750000 0.250000 0.00000 0.500001
+
+
+0.750000 0.250000 0.00000 0.500001
+1.00000 0.250000 0.00000 1.87637e-06
+
+
+0.750000 0.250000 0.00000 0.500001
+0.750000 0.500000 0.00000 0.707108
+
+
+0.750000 0.500000 0.00000 0.707108
+1.00000 0.500000 0.00000 2.65359e-06
+
+
+0.750000 0.500000 0.00000 0.707108
+0.750000 0.500000 0.00000 0.707108
+
+
+0.750000 0.500000 0.00000 0.707108
+1.00000 0.500000 0.00000 2.65359e-06
+
+
+1.00000 0.250000 0.00000 1.87637e-06
+1.00000 0.500000 0.00000 2.65359e-06
+
+
+1.00000 0.250000 0.00000 1.87637e-06
+1.00000 0.250000 0.00000 1.87637e-06
+
+
+1.00000 0.250000 0.00000 1.87637e-06
+1.00000 0.500000 0.00000 2.65359e-06
+
+
+1.00000 0.500000 0.00000 2.65359e-06
+1.00000 0.500000 0.00000 2.65359e-06
+
+
+0.500000 0.250000 0.00000 0.707106
+0.750000 0.250000 0.00000 0.500001
+
+
+0.500000 0.250000 0.00000 0.707106
+0.500000 0.500000 0.00000 1.00000
+
+
+0.500000 0.250000 0.00000 0.707106
+0.500000 0.250000 0.00000 0.707106
+
+
+0.500000 0.250000 0.00000 0.707106
+0.750000 0.250000 0.00000 0.500001
+
+
+0.500000 0.250000 0.00000 0.707106
+0.500000 0.500000 0.00000 1.00000
+
+
+0.500000 0.500000 0.00000 1.00000
+0.750000 0.500000 0.00000 0.707108
+
+
+0.500000 0.500000 0.00000 1.00000
+0.500000 0.500000 0.00000 1.00000
+
+
+0.500000 0.500000 0.00000 1.00000
+0.750000 0.500000 0.00000 0.707108
+
+
+0.750000 0.250000 0.00000 0.500001
+0.750000 0.500000 0.00000 0.707108
+
+
+0.750000 0.250000 0.00000 0.500001
+0.750000 0.250000 0.00000 0.500001
+
+
+0.750000 0.250000 0.00000 0.500001
+0.750000 0.500000 0.00000 0.707108
+
+
+0.750000 0.500000 0.00000 0.707108
+0.750000 0.500000 0.00000 0.707108
+
+
+0.500000 0.500000 0.00000 1.00000
+0.750000 0.500000 0.00000 0.707108
+
+
+0.500000 0.500000 0.00000 1.00000
+0.500000 0.750000 0.00000 0.707108
+
+
+0.500000 0.500000 0.00000 1.00000
+0.500000 0.500000 0.00000 1.00000
+
+
+0.500000 0.500000 0.00000 1.00000
+0.750000 0.500000 0.00000 0.707108
+
+
+0.500000 0.500000 0.00000 1.00000
+0.500000 0.750000 0.00000 0.707108
+
+
+0.500000 0.750000 0.00000 0.707108
+0.750000 0.750000 0.00000 0.500002
+
+
+0.500000 0.750000 0.00000 0.707108
+0.500000 0.750000 0.00000 0.707108
+
+
+0.500000 0.750000 0.00000 0.707108
+0.750000 0.750000 0.00000 0.500002
+
+
+0.750000 0.500000 0.00000 0.707108
+0.750000 0.750000 0.00000 0.500002
+
+
+0.750000 0.500000 0.00000 0.707108
+0.750000 0.500000 0.00000 0.707108
+
+
+0.750000 0.500000 0.00000 0.707108
+0.750000 0.750000 0.00000 0.500002
+
+
+0.750000 0.750000 0.00000 0.500002
+0.750000 0.750000 0.00000 0.500002
+
+
+0.750000 0.500000 0.00000 0.707108
+1.00000 0.500000 0.00000 2.65359e-06
+
+
+0.750000 0.500000 0.00000 0.707108
+0.750000 0.750000 0.00000 0.500002
+
+
+0.750000 0.500000 0.00000 0.707108
+0.750000 0.500000 0.00000 0.707108
+
+
+0.750000 0.500000 0.00000 0.707108
+1.00000 0.500000 0.00000 2.65359e-06
+
+
+0.750000 0.500000 0.00000 0.707108
+0.750000 0.750000 0.00000 0.500002
+
+
+0.750000 0.750000 0.00000 0.500002
+1.00000 0.750000 0.00000 1.87638e-06
+
+
+0.750000 0.750000 0.00000 0.500002
+0.750000 0.750000 0.00000 0.500002
+
+
+0.750000 0.750000 0.00000 0.500002
+1.00000 0.750000 0.00000 1.87638e-06
+
+
+1.00000 0.500000 0.00000 2.65359e-06
+1.00000 0.750000 0.00000 1.87638e-06
+
+
+1.00000 0.500000 0.00000 2.65359e-06
+1.00000 0.500000 0.00000 2.65359e-06
+
+
+1.00000 0.500000 0.00000 2.65359e-06
+1.00000 0.750000 0.00000 1.87638e-06
+
+
+1.00000 0.750000 0.00000 1.87638e-06
+1.00000 0.750000 0.00000 1.87638e-06
+
+
+0.750000 0.750000 0.00000 0.500002
+1.00000 0.750000 0.00000 1.87638e-06
+
+
+0.750000 0.750000 0.00000 0.500002
+0.750000 1.00000 0.00000 1.87638e-06
+
+
+0.750000 0.750000 0.00000 0.500002
+0.750000 0.750000 0.00000 0.500002
+
+
+0.750000 0.750000 0.00000 0.500002
+1.00000 0.750000 0.00000 1.87638e-06
+
+
+0.750000 0.750000 0.00000 0.500002
+0.750000 1.00000 0.00000 1.87638e-06
+
+
+0.750000 1.00000 0.00000 1.87638e-06
+1.00000 1.00000 0.00000 7.04154e-12
+
+
+0.750000 1.00000 0.00000 1.87638e-06
+0.750000 1.00000 0.00000 1.87638e-06
+
+
+0.750000 1.00000 0.00000 1.87638e-06
+1.00000 1.00000 0.00000 7.04154e-12
+
+
+1.00000 0.750000 0.00000 1.87638e-06
+1.00000 1.00000 0.00000 7.04154e-12
+
+
+1.00000 0.750000 0.00000 1.87638e-06
+1.00000 0.750000 0.00000 1.87638e-06
+
+
+1.00000 0.750000 0.00000 1.87638e-06
+1.00000 1.00000 0.00000 7.04154e-12
+
+
+1.00000 1.00000 0.00000 7.04154e-12
+1.00000 1.00000 0.00000 7.04154e-12
+
+
+0.500000 0.750000 0.00000 0.707108
+0.750000 0.750000 0.00000 0.500002
+
+
+0.500000 0.750000 0.00000 0.707108
+0.500000 1.00000 0.00000 2.65359e-06
+
+
+0.500000 0.750000 0.00000 0.707108
+0.500000 0.750000 0.00000 0.707108
+
+
+0.500000 0.750000 0.00000 0.707108
+0.750000 0.750000 0.00000 0.500002
+
+
+0.500000 0.750000 0.00000 0.707108
+0.500000 1.00000 0.00000 2.65359e-06
+
+
+0.500000 1.00000 0.00000 2.65359e-06
+0.750000 1.00000 0.00000 1.87638e-06
+
+
+0.500000 1.00000 0.00000 2.65359e-06
+0.500000 1.00000 0.00000 2.65359e-06
+
+
+0.500000 1.00000 0.00000 2.65359e-06
+0.750000 1.00000 0.00000 1.87638e-06
+
+
+0.750000 0.750000 0.00000 0.500002
+0.750000 1.00000 0.00000 1.87638e-06
+
+
+0.750000 0.750000 0.00000 0.500002
+0.750000 0.750000 0.00000 0.500002
+
+
+0.750000 0.750000 0.00000 0.500002
+0.750000 1.00000 0.00000 1.87638e-06
+
+
+0.750000 1.00000 0.00000 1.87638e-06
+0.750000 1.00000 0.00000 1.87638e-06
+
+
+0.00000 0.500000 0.00000 0.00000
+0.250000 0.500000 0.00000 0.707106
+
+
+0.00000 0.500000 0.00000 0.00000
+0.00000 0.750000 0.00000 0.00000
+
+
+0.00000 0.500000 0.00000 0.00000
+0.00000 0.500000 0.00000 0.00000
+
+
+0.00000 0.500000 0.00000 0.00000
+0.250000 0.500000 0.00000 0.707106
+
+
+0.00000 0.500000 0.00000 0.00000
+0.00000 0.750000 0.00000 0.00000
+
+
+0.00000 0.750000 0.00000 0.00000
+0.250000 0.750000 0.00000 0.500001
+
+
+0.00000 0.750000 0.00000 0.00000
+0.00000 0.750000 0.00000 0.00000
+
+
+0.00000 0.750000 0.00000 0.00000
+0.250000 0.750000 0.00000 0.500001
+
+
+0.250000 0.500000 0.00000 0.707106
+0.250000 0.750000 0.00000 0.500001
+
+
+0.250000 0.500000 0.00000 0.707106
+0.250000 0.500000 0.00000 0.707106
+
+
+0.250000 0.500000 0.00000 0.707106
+0.250000 0.750000 0.00000 0.500001
+
+
+0.250000 0.750000 0.00000 0.500001
+0.250000 0.750000 0.00000 0.500001
+
+
+0.250000 0.500000 0.00000 0.707106
+0.500000 0.500000 0.00000 1.00000
+
+
+0.250000 0.500000 0.00000 0.707106
+0.250000 0.750000 0.00000 0.500001
+
+
+0.250000 0.500000 0.00000 0.707106
+0.250000 0.500000 0.00000 0.707106
+
+
+0.250000 0.500000 0.00000 0.707106
+0.500000 0.500000 0.00000 1.00000
+
+
+0.250000 0.500000 0.00000 0.707106
+0.250000 0.750000 0.00000 0.500001
+
+
+0.250000 0.750000 0.00000 0.500001
+0.500000 0.750000 0.00000 0.707108
+
+
+0.250000 0.750000 0.00000 0.500001
+0.250000 0.750000 0.00000 0.500001
+
+
+0.250000 0.750000 0.00000 0.500001
+0.500000 0.750000 0.00000 0.707108
+
+
+0.500000 0.500000 0.00000 1.00000
+0.500000 0.750000 0.00000 0.707108
+
+
+0.500000 0.500000 0.00000 1.00000
+0.500000 0.500000 0.00000 1.00000
+
+
+0.500000 0.500000 0.00000 1.00000
+0.500000 0.750000 0.00000 0.707108
+
+
+0.500000 0.750000 0.00000 0.707108
+0.500000 0.750000 0.00000 0.707108
+
+
+0.250000 0.750000 0.00000 0.500001
+0.500000 0.750000 0.00000 0.707108
+
+
+0.250000 0.750000 0.00000 0.500001
+0.250000 1.00000 0.00000 1.87637e-06
+
+
+0.250000 0.750000 0.00000 0.500001
+0.250000 0.750000 0.00000 0.500001
+
+
+0.250000 0.750000 0.00000 0.500001
+0.500000 0.750000 0.00000 0.707108
+
+
+0.250000 0.750000 0.00000 0.500001
+0.250000 1.00000 0.00000 1.87637e-06
+
+
+0.250000 1.00000 0.00000 1.87637e-06
+0.500000 1.00000 0.00000 2.65359e-06
+
+
+0.250000 1.00000 0.00000 1.87637e-06
+0.250000 1.00000 0.00000 1.87637e-06
+
+
+0.250000 1.00000 0.00000 1.87637e-06
+0.500000 1.00000 0.00000 2.65359e-06
+
+
+0.500000 0.750000 0.00000 0.707108
+0.500000 1.00000 0.00000 2.65359e-06
+
+
+0.500000 0.750000 0.00000 0.707108
+0.500000 0.750000 0.00000 0.707108
+
+
+0.500000 0.750000 0.00000 0.707108
+0.500000 1.00000 0.00000 2.65359e-06
+
+
+0.500000 1.00000 0.00000 2.65359e-06
+0.500000 1.00000 0.00000 2.65359e-06
+
+
+0.00000 0.750000 0.00000 0.00000
+0.250000 0.750000 0.00000 0.500001
+
+
+0.00000 0.750000 0.00000 0.00000
+0.00000 1.00000 0.00000 0.00000
+
+
+0.00000 0.750000 0.00000 0.00000
+0.00000 0.750000 0.00000 0.00000
+
+
+0.00000 0.750000 0.00000 0.00000
+0.250000 0.750000 0.00000 0.500001
+
+
+0.00000 0.750000 0.00000 0.00000
+0.00000 1.00000 0.00000 0.00000
+
+
+0.00000 1.00000 0.00000 0.00000
+0.250000 1.00000 0.00000 1.87637e-06
+
+
+0.00000 1.00000 0.00000 0.00000
+0.00000 1.00000 0.00000 0.00000
+
+
+0.00000 1.00000 0.00000 0.00000
+0.250000 1.00000 0.00000 1.87637e-06
+
+
+0.250000 0.750000 0.00000 0.500001
+0.250000 1.00000 0.00000 1.87637e-06
+
+
+0.250000 0.750000 0.00000 0.500001
+0.250000 0.750000 0.00000 0.500001
+
+
+0.250000 0.750000 0.00000 0.500001
+0.250000 1.00000 0.00000 1.87637e-06
+
+
+0.250000 1.00000 0.00000 1.87637e-06
+0.250000 1.00000 0.00000 1.87637e-06
+
+
diff --git a/tests/results/i686-pc-linux-gnu+gcc3.2/bits/christian_2.output b/tests/results/i686-pc-linux-gnu+gcc3.2/bits/christian_2.output
new file mode 100644 (file)
index 0000000..e3513a4
--- /dev/null
@@ -0,0 +1,56 @@
+
+# This file was generated by the deal.II library.
+
+
+#
+# For a description of the GNUPLOT format see the GNUPLOT manual.
+#
+# <x> <y> <z> <dof> 
+0.00000 0.00000 1.50000 0.00000
+1.00000 0.00000 1.50000 1.00000
+
+
+0.00000 0.00000 1.50000 0.00000
+0.00000 1.00000 1.50000 3.00000
+
+
+0.00000 0.00000 1.50000 0.00000
+0.00000 0.00000 2.50000 0.00000
+
+
+0.00000 0.00000 2.50000 0.00000
+1.00000 0.00000 2.50000 1.00000
+
+
+0.00000 0.00000 2.50000 0.00000
+0.00000 1.00000 2.50000 3.00000
+
+
+0.00000 1.00000 1.50000 3.00000
+1.00000 1.00000 1.50000 2.00000
+
+
+0.00000 1.00000 1.50000 3.00000
+0.00000 1.00000 2.50000 3.00000
+
+
+0.00000 1.00000 2.50000 3.00000
+1.00000 1.00000 2.50000 2.00000
+
+
+1.00000 0.00000 1.50000 1.00000
+1.00000 1.00000 1.50000 2.00000
+
+
+1.00000 0.00000 1.50000 1.00000
+1.00000 0.00000 2.50000 1.00000
+
+
+1.00000 0.00000 2.50000 1.00000
+1.00000 1.00000 2.50000 2.00000
+
+
+1.00000 1.00000 1.50000 2.00000
+1.00000 1.00000 2.50000 2.00000
+
+

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.