]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Add a second nedelec test, checking interface constraints for these strange elements...
authorwolf <wolf@0785d39b-7218-0410-832d-ea1e28bc413d>
Fri, 13 Sep 2002 21:58:51 +0000 (21:58 +0000)
committerwolf <wolf@0785d39b-7218-0410-832d-ea1e28bc413d>
Fri, 13 Sep 2002 21:58:51 +0000 (21:58 +0000)
git-svn-id: https://svn.dealii.org/trunk@6420 0785d39b-7218-0410-832d-ea1e28bc413d

tests/fe/Makefile
tests/fe/nedelec_2.cc [new file with mode: 0644]
tests/fe/nedelec_2.checked [new file with mode: 0644]

index 91ea09a5d9d38a75c3bb42167b9f83b4422f7ce2..fc4b15c5288a77ed5842b2abf9b97391b4da2cc6 100644 (file)
@@ -31,6 +31,7 @@ mapping.exe             : mapping.go             $(libraries)
 mapping_c1.exe          : mapping_c1.go          $(libraries)
 mapping_q1_eulerian.exe : mapping_q1_eulerian.go $(libraries)
 nedelec.exe             : nedelec.go             $(libraries)
+nedelec_2.exe           : nedelec_2.go           $(libraries)
 non_primitive_1.exe     : non_primitive_1.go     $(libraries)
 numbering.exe           : numbering.go           $(libraries)
 shapes.exe              : shapes.go              $(libraries)
@@ -39,7 +40,7 @@ transfer.exe          : transfer.go            $(libraries)
 tests = derivatives fe_data_test fe_traits fe_tools_test mapping \
         mapping_c1 shapes numbering mapping_q1_eulerian \
         transfer internals \
-        non_primitive_1 nedelec
+        non_primitive_1 nedelec nedelec_2
 
 ############################################################
 
diff --git a/tests/fe/nedelec_2.cc b/tests/fe/nedelec_2.cc
new file mode 100644 (file)
index 0000000..7622306
--- /dev/null
@@ -0,0 +1,120 @@
+// $Id$
+// (c) Wolfgang Bangerth
+//
+// Some more tests with the Nedelec element, basically using
+// multi-element triangulations and check whether interface conditions
+// are ok
+
+#include <base/quadrature_lib.h>
+#include <base/logstream.h>
+#include <lac/vector.h>
+#include <grid/tria.h>
+#include <grid/tria_iterator.h>
+#include <dofs/dof_accessor.h>
+#include <dofs/dof_constraints.h>
+#include <dofs/dof_tools.h>
+#include <grid/grid_generator.h>
+#include <grid/grid_tools.h>
+#include <fe/fe_nedelec.h>
+#include <fe/fe_values.h>
+
+#include <vector>
+#include <fstream>
+#include <string>
+
+#define PRECISION 2
+
+
+template <int dim>
+void
+plot (const Triangulation<dim> &tr)
+{
+  deallog << dim << "d, "
+          << tr.n_active_cells() << " CELLS" << std::endl;
+
+  FE_Nedelec<dim> fe_ned(1);
+  
+  DoFHandler<dim> dof(tr);
+  dof.distribute_dofs(fe_ned);
+
+                                   // generate some numbers for the
+                                   // degrees of freedom on this mesh
+  Vector<double> values (dof.n_dofs());
+  for (unsigned int i=0; i<values.size(); ++i)
+    values(i) = i;
+                                   // then make sure that hanging node
+                                   // constraints are taken care of
+  ConstraintMatrix cm;
+  DoFTools::make_hanging_node_constraints (dof, cm);
+  cm.close ();
+  cm.distribute (values);
+
+  QTrapez<dim> quadrature;
+  std::vector<Vector<double> > shape_values (quadrature.n_quadrature_points,
+                                             Vector<double>(dim));
+  FEValues<dim> fe(fe_ned, quadrature,
+                   update_values|update_q_points);
+
+  for (typename DoFHandler<dim>::active_cell_iterator
+         c = dof.begin_active();
+       c!=dof.end(); ++c)
+    {
+      deallog << "  CELL " << c << std::endl;
+      fe.reinit(c);
+      fe.get_function_values (values, shape_values);
+
+      for (unsigned int q=0; q<quadrature.n_quadrature_points; ++q)
+        {
+          deallog << "    q=" << q
+                  << ", xq=" << fe.quadrature_point(q)
+                  << ", f=[";
+          for (unsigned int d=0; d<dim; ++d)
+            deallog << (d==0 ? "" : " ")
+                    << shape_values[q](d);
+          
+          deallog << "]" << std::endl;
+        };
+                
+      deallog << std::endl;
+    }
+};
+
+
+
+template<int dim>
+inline void
+check ()
+{
+  FE_Nedelec<dim> fe_ned(1);
+  Triangulation<dim> tr;
+  GridGenerator::hyper_cube(tr, 0., 1.);
+
+                                   // first everything on a
+                                   // once-refined grid
+  tr.refine_global (1);
+  plot (tr);
+
+                                   // then same with one cell refined
+  tr.begin_active()->set_refine_flag ();
+  tr.execute_coarsening_and_refinement ();
+  plot (tr);
+};
+
+
+int
+main()
+{
+  std::ofstream logfile ("nedelec_2.output");
+  logfile.precision (PRECISION);
+  logfile.setf(std::ios::fixed);  
+  deallog.attach(logfile);
+  deallog.depth_console(0);
+  
+  check<2>();
+  check<3>();
+  
+  return 0;
+}
+
+
+
diff --git a/tests/fe/nedelec_2.checked b/tests/fe/nedelec_2.checked
new file mode 100644 (file)
index 0000000..b29efa8
--- /dev/null
@@ -0,0 +1,301 @@
+
+DEAL::2d, 4 CELLS
+DEAL::  CELL 1.0
+DEAL::    q=0, xq=0.00 0.00, f=[0.00 6.00]
+DEAL::    q=1, xq=0.00 0.50, f=[4.00 6.00]
+DEAL::    q=2, xq=0.50 0.00, f=[0.00 2.00]
+DEAL::    q=3, xq=0.50 0.50, f=[4.00 2.00]
+DEAL::
+DEAL::  CELL 1.1
+DEAL::    q=0, xq=0.50 0.00, f=[8.00 2.00]
+DEAL::    q=1, xq=0.50 0.50, f=[12.00 2.00]
+DEAL::    q=2, xq=1.00 0.00, f=[8.00 10.00]
+DEAL::    q=3, xq=1.00 0.50, f=[12.00 10.00]
+DEAL::
+DEAL::  CELL 1.2
+DEAL::    q=0, xq=0.50 0.50, f=[12.00 18.00]
+DEAL::    q=1, xq=0.50 1.00, f=[16.00 18.00]
+DEAL::    q=2, xq=1.00 0.50, f=[12.00 14.00]
+DEAL::    q=3, xq=1.00 1.00, f=[16.00 14.00]
+DEAL::
+DEAL::  CELL 1.3
+DEAL::    q=0, xq=0.00 0.50, f=[4.00 22.00]
+DEAL::    q=1, xq=0.00 1.00, f=[20.00 22.00]
+DEAL::    q=2, xq=0.50 0.50, f=[4.00 18.00]
+DEAL::    q=3, xq=0.50 1.00, f=[20.00 18.00]
+DEAL::
+DEAL::2d, 7 CELLS
+DEAL::  CELL 1.1
+DEAL::    q=0, xq=0.50 0.00, f=[0.00 6.00]
+DEAL::    q=1, xq=0.50 0.50, f=[4.00 6.00]
+DEAL::    q=2, xq=1.00 0.00, f=[0.00 2.00]
+DEAL::    q=3, xq=1.00 0.50, f=[4.00 2.00]
+DEAL::
+DEAL::  CELL 1.2
+DEAL::    q=0, xq=0.50 0.50, f=[4.00 12.00]
+DEAL::    q=1, xq=0.50 1.00, f=[10.00 12.00]
+DEAL::    q=2, xq=1.00 0.50, f=[4.00 8.00]
+DEAL::    q=3, xq=1.00 1.00, f=[10.00 8.00]
+DEAL::
+DEAL::  CELL 1.3
+DEAL::    q=0, xq=0.00 0.50, f=[14.00 18.00]
+DEAL::    q=1, xq=0.00 1.00, f=[16.00 18.00]
+DEAL::    q=2, xq=0.50 0.50, f=[14.00 12.00]
+DEAL::    q=3, xq=0.50 1.00, f=[16.00 12.00]
+DEAL::
+DEAL::  CELL 2.0
+DEAL::    q=0, xq=0.00 0.00, f=[40.00 52.00]
+DEAL::    q=1, xq=0.00 0.25, f=[48.00 52.00]
+DEAL::    q=2, xq=0.25 0.00, f=[40.00 44.00]
+DEAL::    q=3, xq=0.25 0.25, f=[48.00 44.00]
+DEAL::
+DEAL::  CELL 2.1
+DEAL::    q=0, xq=0.25 0.00, f=[56.00 44.00]
+DEAL::    q=1, xq=0.25 0.25, f=[64.00 44.00]
+DEAL::    q=2, xq=0.50 0.00, f=[56.00 6.00]
+DEAL::    q=3, xq=0.50 0.25, f=[64.00 6.00]
+DEAL::
+DEAL::  CELL 2.2
+DEAL::    q=0, xq=0.25 0.25, f=[64.00 76.00]
+DEAL::    q=1, xq=0.25 0.50, f=[14.00 76.00]
+DEAL::    q=2, xq=0.50 0.25, f=[64.00 6.00]
+DEAL::    q=3, xq=0.50 0.50, f=[14.00 6.00]
+DEAL::
+DEAL::  CELL 2.3
+DEAL::    q=0, xq=0.00 0.25, f=[48.00 84.00]
+DEAL::    q=1, xq=0.00 0.50, f=[14.00 84.00]
+DEAL::    q=2, xq=0.25 0.25, f=[48.00 76.00]
+DEAL::    q=3, xq=0.25 0.50, f=[14.00 76.00]
+DEAL::
+DEAL::3d, 8 CELLS
+DEAL::  CELL 1.0
+DEAL::    q=0, xq=0.00 0.00 0.00, f=[0.00 16.00 6.00]
+DEAL::    q=1, xq=0.00 0.00 0.50, f=[4.00 22.00 6.00]
+DEAL::    q=2, xq=0.00 0.50 0.00, f=[8.00 16.00 14.00]
+DEAL::    q=3, xq=0.00 0.50 0.50, f=[12.00 22.00 14.00]
+DEAL::    q=4, xq=0.50 0.00 0.00, f=[0.00 18.00 2.00]
+DEAL::    q=5, xq=0.50 0.00 0.50, f=[4.00 20.00 2.00]
+DEAL::    q=6, xq=0.50 0.50 0.00, f=[8.00 18.00 10.00]
+DEAL::    q=7, xq=0.50 0.50 0.50, f=[12.00 20.00 10.00]
+DEAL::
+DEAL::  CELL 1.1
+DEAL::    q=0, xq=0.50 0.00 0.00, f=[24.00 18.00 2.00]
+DEAL::    q=1, xq=0.50 0.00 0.50, f=[28.00 20.00 2.00]
+DEAL::    q=2, xq=0.50 0.50 0.00, f=[30.00 18.00 10.00]
+DEAL::    q=3, xq=0.50 0.50 0.50, f=[34.00 20.00 10.00]
+DEAL::    q=4, xq=1.00 0.00 0.00, f=[24.00 36.00 26.00]
+DEAL::    q=5, xq=1.00 0.00 0.50, f=[28.00 38.00 26.00]
+DEAL::    q=6, xq=1.00 0.50 0.00, f=[30.00 36.00 32.00]
+DEAL::    q=7, xq=1.00 0.50 0.50, f=[34.00 38.00 32.00]
+DEAL::
+DEAL::  CELL 1.2
+DEAL::    q=0, xq=0.50 0.00 0.50, f=[28.00 20.00 44.00]
+DEAL::    q=1, xq=0.50 0.00 1.00, f=[42.00 54.00 44.00]
+DEAL::    q=2, xq=0.50 0.50 0.50, f=[34.00 20.00 50.00]
+DEAL::    q=3, xq=0.50 0.50 1.00, f=[48.00 54.00 50.00]
+DEAL::    q=4, xq=1.00 0.00 0.50, f=[28.00 38.00 40.00]
+DEAL::    q=5, xq=1.00 0.00 1.00, f=[42.00 52.00 40.00]
+DEAL::    q=6, xq=1.00 0.50 0.50, f=[34.00 38.00 46.00]
+DEAL::    q=7, xq=1.00 0.50 1.00, f=[48.00 52.00 46.00]
+DEAL::
+DEAL::  CELL 1.3
+DEAL::    q=0, xq=0.00 0.00 0.50, f=[4.00 22.00 58.00]
+DEAL::    q=1, xq=0.00 0.00 1.00, f=[56.00 64.00 58.00]
+DEAL::    q=2, xq=0.00 0.50 0.50, f=[12.00 22.00 62.00]
+DEAL::    q=3, xq=0.00 0.50 1.00, f=[60.00 64.00 62.00]
+DEAL::    q=4, xq=0.50 0.00 0.50, f=[4.00 20.00 44.00]
+DEAL::    q=5, xq=0.50 0.00 1.00, f=[56.00 54.00 44.00]
+DEAL::    q=6, xq=0.50 0.50 0.50, f=[12.00 20.00 50.00]
+DEAL::    q=7, xq=0.50 0.50 1.00, f=[60.00 54.00 50.00]
+DEAL::
+DEAL::  CELL 1.4
+DEAL::    q=0, xq=0.00 0.50 0.00, f=[8.00 74.00 14.00]
+DEAL::    q=1, xq=0.00 0.50 0.50, f=[12.00 80.00 14.00]
+DEAL::    q=2, xq=0.00 1.00 0.00, f=[66.00 74.00 72.00]
+DEAL::    q=3, xq=0.00 1.00 0.50, f=[70.00 80.00 72.00]
+DEAL::    q=4, xq=0.50 0.50 0.00, f=[8.00 76.00 10.00]
+DEAL::    q=5, xq=0.50 0.50 0.50, f=[12.00 78.00 10.00]
+DEAL::    q=6, xq=0.50 1.00 0.00, f=[66.00 76.00 68.00]
+DEAL::    q=7, xq=0.50 1.00 0.50, f=[70.00 78.00 68.00]
+DEAL::
+DEAL::  CELL 1.5
+DEAL::    q=0, xq=0.50 0.50 0.00, f=[30.00 76.00 10.00]
+DEAL::    q=1, xq=0.50 0.50 0.50, f=[34.00 78.00 10.00]
+DEAL::    q=2, xq=0.50 1.00 0.00, f=[82.00 76.00 68.00]
+DEAL::    q=3, xq=0.50 1.00 0.50, f=[86.00 78.00 68.00]
+DEAL::    q=4, xq=1.00 0.50 0.00, f=[30.00 88.00 32.00]
+DEAL::    q=5, xq=1.00 0.50 0.50, f=[34.00 90.00 32.00]
+DEAL::    q=6, xq=1.00 1.00 0.00, f=[82.00 88.00 84.00]
+DEAL::    q=7, xq=1.00 1.00 0.50, f=[86.00 90.00 84.00]
+DEAL::
+DEAL::  CELL 1.6
+DEAL::    q=0, xq=0.50 0.50 0.50, f=[34.00 78.00 50.00]
+DEAL::    q=1, xq=0.50 0.50 1.00, f=[48.00 100.00 50.00]
+DEAL::    q=2, xq=0.50 1.00 0.50, f=[86.00 78.00 96.00]
+DEAL::    q=3, xq=0.50 1.00 1.00, f=[94.00 100.00 96.00]
+DEAL::    q=4, xq=1.00 0.50 0.50, f=[34.00 90.00 46.00]
+DEAL::    q=5, xq=1.00 0.50 1.00, f=[48.00 98.00 46.00]
+DEAL::    q=6, xq=1.00 1.00 0.50, f=[86.00 90.00 92.00]
+DEAL::    q=7, xq=1.00 1.00 1.00, f=[94.00 98.00 92.00]
+DEAL::
+DEAL::  CELL 1.7
+DEAL::    q=0, xq=0.00 0.50 0.50, f=[12.00 80.00 62.00]
+DEAL::    q=1, xq=0.00 0.50 1.00, f=[60.00 106.00 62.00]
+DEAL::    q=2, xq=0.00 1.00 0.50, f=[70.00 80.00 104.00]
+DEAL::    q=3, xq=0.00 1.00 1.00, f=[102.00 106.00 104.00]
+DEAL::    q=4, xq=0.50 0.50 0.50, f=[12.00 78.00 50.00]
+DEAL::    q=5, xq=0.50 0.50 1.00, f=[60.00 100.00 50.00]
+DEAL::    q=6, xq=0.50 1.00 0.50, f=[70.00 78.00 96.00]
+DEAL::    q=7, xq=0.50 1.00 1.00, f=[102.00 100.00 96.00]
+DEAL::
+DEAL::3d, 15 CELLS
+DEAL::  CELL 1.1
+DEAL::    q=0, xq=0.50 0.00 0.00, f=[0.00 16.00 6.00]
+DEAL::    q=1, xq=0.50 0.00 0.50, f=[4.00 22.00 6.00]
+DEAL::    q=2, xq=0.50 0.50 0.00, f=[8.00 16.00 14.00]
+DEAL::    q=3, xq=0.50 0.50 0.50, f=[12.00 22.00 14.00]
+DEAL::    q=4, xq=1.00 0.00 0.00, f=[0.00 18.00 2.00]
+DEAL::    q=5, xq=1.00 0.00 0.50, f=[4.00 20.00 2.00]
+DEAL::    q=6, xq=1.00 0.50 0.00, f=[8.00 18.00 10.00]
+DEAL::    q=7, xq=1.00 0.50 0.50, f=[12.00 20.00 10.00]
+DEAL::
+DEAL::  CELL 1.2
+DEAL::    q=0, xq=0.50 0.00 0.50, f=[4.00 22.00 28.00]
+DEAL::    q=1, xq=0.50 0.00 1.00, f=[26.00 38.00 28.00]
+DEAL::    q=2, xq=0.50 0.50 0.50, f=[12.00 22.00 34.00]
+DEAL::    q=3, xq=0.50 0.50 1.00, f=[32.00 38.00 34.00]
+DEAL::    q=4, xq=1.00 0.00 0.50, f=[4.00 20.00 24.00]
+DEAL::    q=5, xq=1.00 0.00 1.00, f=[26.00 36.00 24.00]
+DEAL::    q=6, xq=1.00 0.50 0.50, f=[12.00 20.00 30.00]
+DEAL::    q=7, xq=1.00 0.50 1.00, f=[32.00 36.00 30.00]
+DEAL::
+DEAL::  CELL 1.3
+DEAL::    q=0, xq=0.00 0.00 0.50, f=[40.00 52.00 44.00]
+DEAL::    q=1, xq=0.00 0.00 1.00, f=[42.00 54.00 44.00]
+DEAL::    q=2, xq=0.00 0.50 0.50, f=[46.00 52.00 50.00]
+DEAL::    q=3, xq=0.00 0.50 1.00, f=[48.00 54.00 50.00]
+DEAL::    q=4, xq=0.50 0.00 0.50, f=[40.00 22.00 28.00]
+DEAL::    q=5, xq=0.50 0.00 1.00, f=[42.00 38.00 28.00]
+DEAL::    q=6, xq=0.50 0.50 0.50, f=[46.00 22.00 34.00]
+DEAL::    q=7, xq=0.50 0.50 1.00, f=[48.00 38.00 34.00]
+DEAL::
+DEAL::  CELL 1.4
+DEAL::    q=0, xq=0.00 0.50 0.00, f=[56.00 68.00 58.00]
+DEAL::    q=1, xq=0.00 0.50 0.50, f=[46.00 74.00 58.00]
+DEAL::    q=2, xq=0.00 1.00 0.00, f=[60.00 68.00 66.00]
+DEAL::    q=3, xq=0.00 1.00 0.50, f=[64.00 74.00 66.00]
+DEAL::    q=4, xq=0.50 0.50 0.00, f=[56.00 70.00 14.00]
+DEAL::    q=5, xq=0.50 0.50 0.50, f=[46.00 72.00 14.00]
+DEAL::    q=6, xq=0.50 1.00 0.00, f=[60.00 70.00 62.00]
+DEAL::    q=7, xq=0.50 1.00 0.50, f=[64.00 72.00 62.00]
+DEAL::
+DEAL::  CELL 1.5
+DEAL::    q=0, xq=0.50 0.50 0.00, f=[8.00 70.00 14.00]
+DEAL::    q=1, xq=0.50 0.50 0.50, f=[12.00 72.00 14.00]
+DEAL::    q=2, xq=0.50 1.00 0.00, f=[76.00 70.00 62.00]
+DEAL::    q=3, xq=0.50 1.00 0.50, f=[80.00 72.00 62.00]
+DEAL::    q=4, xq=1.00 0.50 0.00, f=[8.00 82.00 10.00]
+DEAL::    q=5, xq=1.00 0.50 0.50, f=[12.00 84.00 10.00]
+DEAL::    q=6, xq=1.00 1.00 0.00, f=[76.00 82.00 78.00]
+DEAL::    q=7, xq=1.00 1.00 0.50, f=[80.00 84.00 78.00]
+DEAL::
+DEAL::  CELL 1.6
+DEAL::    q=0, xq=0.50 0.50 0.50, f=[12.00 72.00 34.00]
+DEAL::    q=1, xq=0.50 0.50 1.00, f=[32.00 94.00 34.00]
+DEAL::    q=2, xq=0.50 1.00 0.50, f=[80.00 72.00 90.00]
+DEAL::    q=3, xq=0.50 1.00 1.00, f=[88.00 94.00 90.00]
+DEAL::    q=4, xq=1.00 0.50 0.50, f=[12.00 84.00 30.00]
+DEAL::    q=5, xq=1.00 0.50 1.00, f=[32.00 92.00 30.00]
+DEAL::    q=6, xq=1.00 1.00 0.50, f=[80.00 84.00 86.00]
+DEAL::    q=7, xq=1.00 1.00 1.00, f=[88.00 92.00 86.00]
+DEAL::
+DEAL::  CELL 1.7
+DEAL::    q=0, xq=0.00 0.50 0.50, f=[46.00 74.00 50.00]
+DEAL::    q=1, xq=0.00 0.50 1.00, f=[48.00 100.00 50.00]
+DEAL::    q=2, xq=0.00 1.00 0.50, f=[64.00 74.00 98.00]
+DEAL::    q=3, xq=0.00 1.00 1.00, f=[96.00 100.00 98.00]
+DEAL::    q=4, xq=0.50 0.50 0.50, f=[46.00 72.00 34.00]
+DEAL::    q=5, xq=0.50 0.50 1.00, f=[48.00 94.00 34.00]
+DEAL::    q=6, xq=0.50 1.00 0.50, f=[64.00 72.00 90.00]
+DEAL::    q=7, xq=0.50 1.00 1.00, f=[96.00 94.00 90.00]
+DEAL::
+DEAL::  CELL 2.0
+DEAL::    q=0, xq=0.00 0.00 0.00, f=[204.00 236.00 216.00]
+DEAL::    q=1, xq=0.00 0.00 0.25, f=[212.00 248.00 216.00]
+DEAL::    q=2, xq=0.00 0.25 0.00, f=[220.00 236.00 232.00]
+DEAL::    q=3, xq=0.00 0.25 0.25, f=[228.00 248.00 232.00]
+DEAL::    q=4, xq=0.25 0.00 0.00, f=[204.00 240.00 208.00]
+DEAL::    q=5, xq=0.25 0.00 0.25, f=[212.00 244.00 208.00]
+DEAL::    q=6, xq=0.25 0.25 0.00, f=[220.00 240.00 224.00]
+DEAL::    q=7, xq=0.25 0.25 0.25, f=[228.00 244.00 224.00]
+DEAL::
+DEAL::  CELL 2.1
+DEAL::    q=0, xq=0.25 0.00 0.00, f=[252.00 240.00 208.00]
+DEAL::    q=1, xq=0.25 0.00 0.25, f=[260.00 244.00 208.00]
+DEAL::    q=2, xq=0.25 0.25 0.00, f=[264.00 240.00 224.00]
+DEAL::    q=3, xq=0.25 0.25 0.25, f=[272.00 244.00 224.00]
+DEAL::    q=4, xq=0.50 0.00 0.00, f=[252.00 16.00 6.00]
+DEAL::    q=5, xq=0.50 0.00 0.25, f=[260.00 19.00 6.00]
+DEAL::    q=6, xq=0.50 0.25 0.00, f=[264.00 16.00 10.00]
+DEAL::    q=7, xq=0.50 0.25 0.25, f=[272.00 19.00 10.00]
+DEAL::
+DEAL::  CELL 2.2
+DEAL::    q=0, xq=0.25 0.00 0.25, f=[260.00 244.00 292.00]
+DEAL::    q=1, xq=0.25 0.00 0.50, f=[40.00 37.00 292.00]
+DEAL::    q=2, xq=0.25 0.25 0.25, f=[272.00 244.00 304.00]
+DEAL::    q=3, xq=0.25 0.25 0.50, f=[43.00 37.00 304.00]
+DEAL::    q=4, xq=0.50 0.00 0.25, f=[260.00 19.00 6.00]
+DEAL::    q=5, xq=0.50 0.00 0.50, f=[40.00 22.00 6.00]
+DEAL::    q=6, xq=0.50 0.25 0.25, f=[272.00 19.00 10.00]
+DEAL::    q=7, xq=0.50 0.25 0.50, f=[43.00 22.00 10.00]
+DEAL::
+DEAL::  CELL 2.3
+DEAL::    q=0, xq=0.00 0.00 0.25, f=[212.00 248.00 320.00]
+DEAL::    q=1, xq=0.00 0.00 0.50, f=[40.00 52.00 320.00]
+DEAL::    q=2, xq=0.00 0.25 0.25, f=[228.00 248.00 328.00]
+DEAL::    q=3, xq=0.00 0.25 0.50, f=[43.00 52.00 328.00]
+DEAL::    q=4, xq=0.25 0.00 0.25, f=[212.00 244.00 292.00]
+DEAL::    q=5, xq=0.25 0.00 0.50, f=[40.00 37.00 292.00]
+DEAL::    q=6, xq=0.25 0.25 0.25, f=[228.00 244.00 304.00]
+DEAL::    q=7, xq=0.25 0.25 0.50, f=[43.00 37.00 304.00]
+DEAL::
+DEAL::  CELL 2.4
+DEAL::    q=0, xq=0.00 0.25 0.00, f=[220.00 352.00 232.00]
+DEAL::    q=1, xq=0.00 0.25 0.25, f=[228.00 364.00 232.00]
+DEAL::    q=2, xq=0.00 0.50 0.00, f=[56.00 352.00 58.00]
+DEAL::    q=3, xq=0.00 0.50 0.25, f=[51.00 364.00 58.00]
+DEAL::    q=4, xq=0.25 0.25 0.00, f=[220.00 356.00 224.00]
+DEAL::    q=5, xq=0.25 0.25 0.25, f=[228.00 360.00 224.00]
+DEAL::    q=6, xq=0.25 0.50 0.00, f=[56.00 356.00 36.00]
+DEAL::    q=7, xq=0.25 0.50 0.25, f=[51.00 360.00 36.00]
+DEAL::
+DEAL::  CELL 2.5
+DEAL::    q=0, xq=0.25 0.25 0.00, f=[264.00 356.00 224.00]
+DEAL::    q=1, xq=0.25 0.25 0.25, f=[272.00 360.00 224.00]
+DEAL::    q=2, xq=0.25 0.50 0.00, f=[56.00 356.00 36.00]
+DEAL::    q=3, xq=0.25 0.50 0.25, f=[51.00 360.00 36.00]
+DEAL::    q=4, xq=0.50 0.25 0.00, f=[264.00 16.00 10.00]
+DEAL::    q=5, xq=0.50 0.25 0.25, f=[272.00 19.00 10.00]
+DEAL::    q=6, xq=0.50 0.50 0.00, f=[56.00 16.00 14.00]
+DEAL::    q=7, xq=0.50 0.50 0.25, f=[51.00 19.00 14.00]
+DEAL::
+DEAL::  CELL 2.6
+DEAL::    q=0, xq=0.25 0.25 0.25, f=[272.00 360.00 304.00]
+DEAL::    q=1, xq=0.25 0.25 0.50, f=[43.00 37.00 304.00]
+DEAL::    q=2, xq=0.25 0.50 0.25, f=[51.00 360.00 36.00]
+DEAL::    q=3, xq=0.25 0.50 0.50, f=[46.00 37.00 36.00]
+DEAL::    q=4, xq=0.50 0.25 0.25, f=[272.00 19.00 10.00]
+DEAL::    q=5, xq=0.50 0.25 0.50, f=[43.00 22.00 10.00]
+DEAL::    q=6, xq=0.50 0.50 0.25, f=[51.00 19.00 14.00]
+DEAL::    q=7, xq=0.50 0.50 0.50, f=[46.00 22.00 14.00]
+DEAL::
+DEAL::  CELL 2.7
+DEAL::    q=0, xq=0.00 0.25 0.25, f=[228.00 364.00 328.00]
+DEAL::    q=1, xq=0.00 0.25 0.50, f=[43.00 52.00 328.00]
+DEAL::    q=2, xq=0.00 0.50 0.25, f=[51.00 364.00 58.00]
+DEAL::    q=3, xq=0.00 0.50 0.50, f=[46.00 52.00 58.00]
+DEAL::    q=4, xq=0.25 0.25 0.25, f=[228.00 360.00 304.00]
+DEAL::    q=5, xq=0.25 0.25 0.50, f=[43.00 37.00 304.00]
+DEAL::    q=6, xq=0.25 0.50 0.25, f=[51.00 360.00 36.00]
+DEAL::    q=7, xq=0.25 0.50 0.50, f=[46.00 37.00 36.00]
+DEAL::

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.