]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Patch by Mihai: Also extend the ability to deal with explicit FE spaces to set_dof_va...
authorbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 21 Jan 2014 03:45:06 +0000 (03:45 +0000)
committerbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 21 Jan 2014 03:45:06 +0000 (03:45 +0000)
git-svn-id: https://svn.dealii.org/trunk@32268 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/doc/news/changes.h
deal.II/include/deal.II/dofs/dof_accessor.h
deal.II/source/dofs/dof_accessor_set.cc
tests/hp/set_dof_values_by_interpolation_01.debug.output
tests/hp/set_dof_values_by_interpolation_02.cc [new file with mode: 0644]
tests/hp/set_dof_values_by_interpolation_02.output [new file with mode: 0644]
tests/hp/set_dof_values_by_interpolation_03.cc [new file with mode: 0644]
tests/hp/set_dof_values_by_interpolation_03.output [new file with mode: 0644]

index c58ef940bd7e6e5dcd896877497632f1bf0ef01c..c21e09c3341b5af530625e8b080e5c51a2661010 100644 (file)
@@ -105,13 +105,14 @@ inconvenience this causes.
   space. Doing so now raises an exception.
   <br>
   However, there are legitimate cases where one may want to interpolate
-  from children to a parent's finite element space. Since in the hp
+  from children to a parent's finite element space or the other way around.
+  Since in the hp
   case no finite element space is naturally associated with an inactive
   cell, it is now possible to pass an explicit finite element index
-  argument to the function specifying which element of an hp::FECollection
+  argument to these functions specifying which element of an hp::FECollection
   object describes the space onto which you want to interpolate.
   <br>
-  (Wolfgang Bangerth, 2014/01/18)
+  (Mihai, Wolfgang Bangerth, 2014/01/18)
   </li>
 
   <li> Fixed: The methods IndexSet::do_compress() and
index 885eeff0ee48104db1f3a737d684b5591b92c58b..12c1313156add6146619990bec2ea1982aacc626 100644 (file)
@@ -1448,7 +1448,7 @@ public:
    * cells.
    *
    * In principle, it works as follows: if the cell pointed to by this
-   * object is terminal, then the dof values are set in the global
+   * object is terminal (i.e., has no children), then the dof values are set in the global
    * data vector by calling the set_dof_values() function; otherwise,
    * the values are prolonged to each of the children and this
    * function is called for each of them.
@@ -1467,6 +1467,22 @@ public:
    * requirements are not taken care of and must be enforced by the
    * user afterward.
    *
+   * If the cell is part of a hp::DoFHandler object, cells only have an
+   * associated finite element space if they are active. However, this
+   * function is supposed to also work on inactive cells
+   * with children. Consequently, it carries a third argument that can be
+   * used in the hp context that denotes the finite element space we are
+   * supposed to interpret the input vector of this function in.
+   * If the cell is active, this function
+   * then interpolates the input vector interpreted as an element of the space described
+   * by the <code>fe_index</code>th element of the hp::FECollection associated
+   * with the hp::DoFHandler of which this cell is a part of, and interpolates
+   * it into the space that is associated with this cell. On the other hand, if the cell
+   * is not active, then we first perform this interpolation from this cell
+   * to its children using the given <code>fe_index</code> until we end
+   * up on an active cell, at which point we follow the procedure outlined
+   * at the beginning of the paragraph.
+   *
    * It is assumed that both vectors already have the right size
    * beforehand. This function relies on the existence of a natural
    * interpolation property of finite element spaces of a cell to its
@@ -1477,17 +1493,10 @@ public:
    * element class for a description of what the prolongation matrices
    * represent in this case.
    *
-   * Unlike the set_dof_values() function, this function is associated
-   * to cells rather than to lines, quads, and hexes, since
-   * interpolation is presently only provided for cells by the finite
-   * element objects.
-   *
-   * The output vector may be either a Vector<float>, Vector<double>,
-   * or a BlockVector<double>, or a PETSc vector if deal.II is
-   * compiled to support these libraries. It is in the responsibility
-   * of the caller to assure that the types of the numbers stored in
-   * input and output vectors are compatible and with similar
-   * accuracy.
+   * @note Unlike the get_dof_values() function, this function is only available
+   * on cells, rather than on lines, quads, and hexes, since interpolation
+   * is presently only provided for cells by the finite element
+   * classes.
    */
   template <class OutputVector, typename number>
   void set_dof_values_by_interpolation (const Vector<number> &local_values,
index bfbedda11c1ca668e54f07f4823e375f4625b3c8..dde264f574b2d3f3d07273c2c8d1146f1fa60894 100644 (file)
 DEAL_II_NAMESPACE_OPEN
 
 
-
 template <class DH, bool lda>
 template <class OutputVector, typename number>
 void
 DoFCellAccessor<DH,lda>::
 set_dof_values_by_interpolation (const Vector<number> &local_values,
-                                 OutputVector         &values,
-                                 const unsigned int fe_index) const
-{
-  if (!this->has_children())
-    // if this cell has no children: simply set the values on this cell
-    this->set_dof_values (local_values, values);
-  else
-    // otherwise distribute them to the children
+    OutputVector         &values,
+    const unsigned int fe_index) const
     {
-      // we are on a non-active cell. these do not have any finite
-      // element associated with them in the hp context (in the non-hp
-      // context, we can simply assume that the FE space to from which we
-      // want to interpolate is the same as for all elements in the
-      // mesh). consequently, we cannot interpolate to children's FE
-      // space from this cell's (unknown) FE space unless an explicit
-      // fe_index is given
-      Assert ((dynamic_cast<DoFHandler<DH::dimension,DH::space_dimension>*>
-               (this->dof_handler)
-               != 0)
-              ||
-              (fe_index != DH::default_fe_index),
-              ExcMessage ("You cannot call this function on non-active cells "
-                          "of hp::DoFHandler objects unless you provide an explicit "
-                          "finite element index because they do not have naturally "
-                          "associated finite element spaces associated: degrees "
-                          "of freedom are only distributed on active cells for which "
-                          "the active_fe_index has been set."));
-
-      const unsigned int dofs_per_cell = this->get_fe().dofs_per_cell;
-
-      Assert (this->dof_handler != 0,
-             typename BaseClass::ExcInvalidObject());
-      Assert (&this->get_fe() != 0,
-             typename BaseClass::ExcInvalidObject());
-      Assert (local_values.size() == dofs_per_cell,
-             typename BaseClass::ExcVectorDoesNotMatch());
-      Assert (values.size() == this->dof_handler->n_dofs(),
-             typename BaseClass::ExcVectorDoesNotMatch());
-
-      Vector<number> tmp(dofs_per_cell);
-
-      for (unsigned int child=0; child<this->n_children(); ++child)
-        {
-          Assert (this->child(child)->get_fe().dofs_per_cell == dofs_per_cell,
-                  ExcNotImplemented());
-
-          // prolong the given data to the present cell. FullMatrix only wants
-          // us to call vmult if the matrix size is actually non-zero, so
-          // check that case
-          if (tmp.size() > 0)
-            {
-              this->get_fe().get_prolongation_matrix(child, this->refinement_case())
-              .vmult (tmp, local_values);
-
-              this->child(child)->set_dof_values_by_interpolation (tmp, values);
-            }
-        }
+    if (!this->has_children())
+      {
+        if ((dynamic_cast<DoFHandler<DH::dimension,DH::space_dimension>*>
+        (this->dof_handler)
+        != 0)
+            ||
+            (fe_index == this->active_fe_index())
+            ||
+            (fe_index == DH::default_fe_index))
+          // simply set the values on this cell
+          this->set_dof_values (local_values, values);
+        else
+          {
+            Assert (local_values.size() == this->dof_handler->get_fe()[fe_index].dofs_per_cell,
+                ExcMessage ("Incorrect size of local_values vector.") );
+
+            FullMatrix<double> interpolation (this->get_fe().dofs_per_cell, this->dof_handler->get_fe()[fe_index].dofs_per_cell);
+
+            this->get_fe().get_interpolation_matrix (this->dof_handler->get_fe()[fe_index],
+                interpolation);
+
+            Vector<number> tmp (this->get_fe().dofs_per_cell);
+            interpolation.vmult (tmp, local_values);
+
+            //now set the dof values in the global vector
+            this->set_dof_values (tmp, values);
+          }
+      }
+    else
+      // otherwise distribute them to the children
+      {
+        Assert ((dynamic_cast<DoFHandler<DH::dimension,DH::space_dimension>*>
+        (this->dof_handler)
+        != 0)
+            ||
+            (fe_index != DH::default_fe_index),
+            ExcMessage ("You cannot call this function on non-active cells "
+                "of hp::DoFHandler objects unless you provide an explicit "
+                "finite element index because they do not have naturally "
+                "associated finite element spaces associated: degrees "
+                "of freedom are only distributed on active cells for which "
+                "the active_fe_index has been set."));
+
+        const FiniteElement<dim,spacedim> &fe            = this->get_dof_handler().get_fe()[fe_index];
+        const unsigned int                 dofs_per_cell = fe.dofs_per_cell;
+
+        //const unsigned int dofs_per_cell = this->get_fe().dofs_per_cell;
+
+        Assert (this->dof_handler != 0,
+                typename BaseClass::ExcInvalidObject());
+        Assert (&this->get_fe() != 0,
+                typename BaseClass::ExcInvalidObject());
+        Assert (local_values.size() == dofs_per_cell,
+                typename BaseClass::ExcVectorDoesNotMatch());
+        Assert (values.size() == this->dof_handler->n_dofs(),
+                typename BaseClass::ExcVectorDoesNotMatch());
+
+        Vector<number> tmp(dofs_per_cell);
+
+        for (unsigned int child=0; child<this->n_children(); ++child)
+          {
+            fe.get_prolongation_matrix(child, this->refinement_case()).vmult (tmp, local_values);
+            this->child(child)->set_dof_values_by_interpolation (tmp, values, fe_index);
+          }
+      }
     }
-}
-
 
 
 // --------------------------------------------------------------------------
index 2aca68e01e025de70bd0bb6f1ff1b45aad501a5b..ba7953b18d8d3a9ee17a31ddf3f4bb8eb6bc78ae 100644 (file)
@@ -1,7 +1,7 @@
 
 DEAL::Yes, exception!
-DEAL::ExcMessage ("You cannot call this function on non-active cells " "of hp::DoFHandler objects because they do not have " "associated finite element spaces associated: degrees " "of freedom are only distributed on active cells for which " "the active_fe_index has been set.")
+DEAL::ExcMessage ("You cannot call this function on non-active cells " "of hp::DoFHandler objects unless you provide an explicit " "finite element index because they do not have naturally " "associated finite element spaces associated: degrees " "of freedom are only distributed on active cells for which " "the active_fe_index has been set.")
 DEAL::Yes, exception!
-DEAL::ExcMessage ("You cannot call this function on non-active cells " "of hp::DoFHandler objects because they do not have " "associated finite element spaces associated: degrees " "of freedom are only distributed on active cells for which " "the active_fe_index has been set.")
+DEAL::ExcMessage ("You cannot call this function on non-active cells " "of hp::DoFHandler objects unless you provide an explicit " "finite element index because they do not have naturally " "associated finite element spaces associated: degrees " "of freedom are only distributed on active cells for which " "the active_fe_index has been set.")
 DEAL::Yes, exception!
-DEAL::ExcMessage ("You cannot call this function on non-active cells " "of hp::DoFHandler objects because they do not have " "associated finite element spaces associated: degrees " "of freedom are only distributed on active cells for which " "the active_fe_index has been set.")
+DEAL::ExcMessage ("You cannot call this function on non-active cells " "of hp::DoFHandler objects unless you provide an explicit " "finite element index because they do not have naturally " "associated finite element spaces associated: degrees " "of freedom are only distributed on active cells for which " "the active_fe_index has been set.")
diff --git a/tests/hp/set_dof_values_by_interpolation_02.cc b/tests/hp/set_dof_values_by_interpolation_02.cc
new file mode 100644 (file)
index 0000000..ed7d5d8
--- /dev/null
@@ -0,0 +1,117 @@
+// ---------------------------------------------------------------------
+// $Id$
+//
+// Copyright (C) 1998 - 2014 by the deal.II authors
+//
+// This file is part of the deal.II library.
+//
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
+
+// cell->set_dof_values_by_interpolation can not work properly in the hp
+// context when called on non-active cells because these do not have a
+// finite element associated with them
+//
+// this test verifies that if we call the function on active cells with no
+// explicitly given fe_index that we get the same result as from
+// cell->set_dof_values, and that if we call it with an fe_index for a Q1
+// element that we simply get the vertex dof values set on the space of that
+// cell
+
+#include "../tests.h"
+#include <deal.II/base/quadrature_lib.h>
+#include <deal.II/base/logstream.h>
+#include <deal.II/lac/vector.h>
+#include <deal.II/grid/tria.h>
+#include <deal.II/grid/tria_iterator.h>
+#include <deal.II/dofs/dof_accessor.h>
+#include <deal.II/hp/dof_handler.h>
+#include <deal.II/grid/grid_generator.h>
+#include <deal.II/grid/grid_tools.h>
+#include <deal.II/fe/fe_q.h>
+
+#include <vector>
+#include <fstream>
+#include <string>
+
+#define PRECISION 2
+
+
+
+
+template <int dim>
+void test ()
+{
+  // create a hp::DoFHandler with different finite elements on the
+  // cells. note that we assign active_fe_indices also to inactive
+  // elements
+  Triangulation<dim> tr;
+  GridGenerator::hyper_cube(tr, 0., 1.);
+  tr.refine_global (2);
+
+  hp::FECollection<dim> fe;
+  for (unsigned int i=1; i<5; ++i)
+    fe.push_back (FE_Q<dim>(i));
+
+  hp::DoFHandler<dim> dof_handler(tr);
+  for (typename hp::DoFHandler<dim>::cell_iterator cell=dof_handler.begin();
+       cell!=dof_handler.end(); ++cell)
+    cell->set_active_fe_index (cell->index() % fe.size());
+
+  dof_handler.distribute_dofs (fe);
+
+  // create a mostly arbitrary FE field
+  Vector<double> solution1(dof_handler.n_dofs());
+  Vector<double> solution2(dof_handler.n_dofs());
+
+  // do the test
+  for (typename hp::DoFHandler<dim>::active_cell_iterator cell=dof_handler.begin_active();
+       cell!=dof_handler.end(); ++cell)
+    {
+      solution1 = 0;
+      solution2 = 0;
+      
+      // set values without specifying an explicit fe_index
+      Vector<double> local (cell->get_fe().dofs_per_cell);
+      for (unsigned int i=0; i<local.size(); ++i)
+       local(i) = i;
+      
+      cell->set_dof_values_by_interpolation (local, solution1);
+
+      // then do the same with the "correct", local fe_index
+      cell->set_dof_values_by_interpolation (local, solution2,
+                                            cell->active_fe_index());
+
+      // now verify correctness
+      Assert (solution1 == solution2, ExcInternalError());
+    }
+  deallog << "OK" << std::endl;
+}
+
+
+int
+main()
+{
+  std::ofstream logfile ("output");
+  logfile.precision (PRECISION);
+  logfile.setf(std::ios::fixed);
+  deallog.attach(logfile);
+  deallog.depth_console(0);
+  deallog.threshold_double(1.e-10);
+
+  test<1>();
+  test<2>();
+  test<3>();
+
+  return 0;
+}
+
+
+
diff --git a/tests/hp/set_dof_values_by_interpolation_02.output b/tests/hp/set_dof_values_by_interpolation_02.output
new file mode 100644 (file)
index 0000000..fb71de2
--- /dev/null
@@ -0,0 +1,4 @@
+
+DEAL::OK
+DEAL::OK
+DEAL::OK
diff --git a/tests/hp/set_dof_values_by_interpolation_03.cc b/tests/hp/set_dof_values_by_interpolation_03.cc
new file mode 100644 (file)
index 0000000..fbcdb04
--- /dev/null
@@ -0,0 +1,109 @@
+// ---------------------------------------------------------------------
+// $Id$
+//
+// Copyright (C) 1998 - 2014 by the deal.II authors
+//
+// This file is part of the deal.II library.
+//
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
+
+// cell->set_dof_values_by_interpolation can not work properly in the hp
+// context when called on non-active cells because these do not have a
+// finite element associated with them
+//
+// this test verifies that if we call the function on active cells with an
+// explicitly given fe_index that we can interpolate from parents to the
+// children
+
+#include "../tests.h"
+#include <deal.II/base/quadrature_lib.h>
+#include <deal.II/base/logstream.h>
+#include <deal.II/lac/vector.h>
+#include <deal.II/grid/tria.h>
+#include <deal.II/grid/tria_iterator.h>
+#include <deal.II/dofs/dof_accessor.h>
+#include <deal.II/hp/dof_handler.h>
+#include <deal.II/grid/grid_generator.h>
+#include <deal.II/grid/grid_tools.h>
+#include <deal.II/fe/fe_q.h>
+
+#include <vector>
+#include <fstream>
+#include <string>
+
+
+template <int dim>
+void test ()
+{
+  deallog << dim << "D" << std::endl;
+  
+  // create a hp::DoFHandler with different finite elements on the
+  // cells. note that we assign active_fe_indices also to inactive
+  // elements
+  Triangulation<dim> tr;
+  GridGenerator::hyper_cube(tr, 0., 1.);
+  tr.refine_global (2);
+
+  hp::FECollection<dim> fe;
+  for (unsigned int i=1; i<5; ++i)
+    fe.push_back (FE_Q<dim>(i));
+
+  hp::DoFHandler<dim> dof_handler(tr);
+  for (typename hp::DoFHandler<dim>::cell_iterator cell=dof_handler.begin();
+       cell!=dof_handler.end(); ++cell)
+    cell->set_active_fe_index (cell->index() % fe.size());
+
+  dof_handler.distribute_dofs (fe);
+
+  Vector<double> solution(dof_handler.n_dofs());
+
+  // do the test where we set data on the coarsest cell with an
+  // explicit Q1 space
+  typename hp::DoFHandler<dim>::cell_iterator cell=dof_handler.begin(0);
+  Vector<double> local (fe[0].dofs_per_cell);
+  for (unsigned int i=0; i<local.size(); ++i)
+    local(i) = i;
+  cell->set_dof_values_by_interpolation (local, solution,
+                                        0);
+
+  // for comparison purposes, also output the values of DoFs on all cells
+  for (typename hp::DoFHandler<dim>::active_cell_iterator cell=dof_handler.begin_active();
+       cell!=dof_handler.end(); ++cell)
+    {
+      Vector<double> x (cell->get_fe().dofs_per_cell);
+      cell->get_dof_values (solution, x);
+      deallog << "cell =" << cell << ":  ";
+      for (unsigned int i=0; i<x.size(); ++i)
+       deallog << x[i] << ' ';
+      deallog << std::endl;
+    }
+}
+
+
+int
+main()
+{
+  std::ofstream logfile ("output");
+  logfile.precision (1);
+  logfile.setf(std::ios::fixed);
+  deallog.attach(logfile);
+  deallog.depth_console(0);
+  deallog.threshold_double(1.e-10);
+
+  test<1>();
+  test<2>();
+  test<3>();
+
+  return 0;
+}
+
+
+
diff --git a/tests/hp/set_dof_values_by_interpolation_03.output b/tests/hp/set_dof_values_by_interpolation_03.output
new file mode 100644 (file)
index 0000000..e3cf799
--- /dev/null
@@ -0,0 +1,88 @@
+
+DEAL::1D
+DEAL::cell =2.0:  0 0.250000 
+DEAL::cell =2.1:  0.250000 0.500000 0.375000 
+DEAL::cell =2.2:  0.500000 0.750000 0.583333 0.666667 
+DEAL::cell =2.3:  0.750000 1.00000 0.812500 0.875000 0.937500 
+DEAL::2D
+DEAL::cell =2.0:  0 0.250000 0.500000 0.750000 
+DEAL::cell =2.1:  0.250000 0.500000 0.750000 1.00000 0.500000 0.750000 0.375000 0.875000 0.625000 
+DEAL::cell =2.2:  0.500000 0.750000 1.00000 1.25000 0.666667 0.833333 0.916667 1.08333 0.583333 0.666667 1.08333 1.16667 0.750000 0.833333 0.916667 1.00000 
+DEAL::cell =2.3:  0.750000 1.00000 1.25000 1.50000 0.875000 1.00000 1.12500 1.12500 1.25000 1.37500 0.812500 0.875000 0.937500 1.31250 1.37500 1.43750 0.937500 1.00000 1.06250 1.06250 1.12500 1.18750 1.18750 1.25000 1.31250 
+DEAL::cell =2.4:  0.500000 0.750000 1.00000 1.25000 
+DEAL::cell =2.5:  0.750000 1.00000 1.25000 1.50000 1.00000 1.25000 0.875000 1.37500 1.12500 
+DEAL::cell =2.6:  1.00000 1.25000 1.50000 1.75000 1.16667 1.33333 1.41667 1.58333 1.08333 1.16667 1.58333 1.66667 1.25000 1.33333 1.41667 1.50000 
+DEAL::cell =2.7:  1.25000 1.50000 1.75000 2.00000 1.37500 1.50000 1.62500 1.62500 1.75000 1.87500 1.31250 1.37500 1.43750 1.81250 1.87500 1.93750 1.43750 1.50000 1.56250 1.56250 1.62500 1.68750 1.68750 1.75000 1.81250 
+DEAL::cell =2.8:  1.00000 1.25000 1.50000 1.75000 
+DEAL::cell =2.9:  1.25000 1.50000 1.75000 2.00000 1.50000 1.75000 1.37500 1.87500 1.62500 
+DEAL::cell =2.10:  1.50000 1.75000 2.00000 2.25000 1.66667 1.83333 1.91667 2.08333 1.58333 1.66667 2.08333 2.16667 1.75000 1.83333 1.91667 2.00000 
+DEAL::cell =2.11:  1.75000 2.00000 2.25000 2.50000 1.87500 2.00000 2.12500 2.12500 2.25000 2.37500 1.81250 1.87500 1.93750 2.31250 2.37500 2.43750 1.93750 2.00000 2.06250 2.06250 2.12500 2.18750 2.18750 2.25000 2.31250 
+DEAL::cell =2.12:  1.50000 1.75000 2.00000 2.25000 
+DEAL::cell =2.13:  1.75000 2.00000 2.25000 2.50000 2.00000 2.25000 1.87500 2.37500 2.12500 
+DEAL::cell =2.14:  2.00000 2.25000 2.50000 2.75000 2.16667 2.33333 2.41667 2.58333 2.08333 2.16667 2.58333 2.66667 2.25000 2.33333 2.41667 2.50000 
+DEAL::cell =2.15:  2.25000 2.50000 2.75000 3.00000 2.37500 2.50000 2.62500 2.62500 2.75000 2.87500 2.31250 2.37500 2.43750 2.81250 2.87500 2.93750 2.43750 2.50000 2.56250 2.56250 2.62500 2.68750 2.68750 2.75000 2.81250 
+DEAL::3D
+DEAL::cell =2.0:  0 0.250000 0.500000 0.750000 1.00000 1.25000 1.50000 1.75000 
+DEAL::cell =2.1:  0.250000 0.500000 0.750000 1.00000 1.25000 1.50000 1.75000 2.00000 0.500000 0.750000 0.375000 0.875000 1.50000 1.75000 1.37500 1.87500 0.750000 1.00000 1.25000 1.50000 1.00000 1.25000 0.875000 1.37500 0.625000 1.62500 1.12500 
+DEAL::cell =2.2:  0.500000 0.750000 1.00000 1.25000 1.50000 1.75000 2.00000 2.25000 0.666667 0.833333 0.916667 1.08333 0.583333 0.666667 1.08333 1.16667 1.66667 1.83333 1.91667 2.08333 1.58333 1.66667 2.08333 2.16667 0.833333 1.16667 1.08333 1.41667 1.33333 1.66667 1.58333 1.91667 1.00000 1.16667 1.33333 1.50000 1.25000 1.41667 1.58333 1.75000 0.916667 1.25000 1.00000 1.33333 1.41667 1.75000 1.50000 1.83333 0.750000 0.833333 0.916667 1.00000 1.75000 1.83333 1.91667 2.00000 1.08333 1.16667 1.25000 1.33333 1.41667 1.50000 1.58333 1.66667 
+DEAL::cell =2.3:  0.750000 1.00000 1.25000 1.50000 1.75000 2.00000 2.25000 2.50000 0.875000 1.00000 1.12500 1.12500 1.25000 1.37500 0.812500 0.875000 0.937500 1.31250 1.37500 1.43750 1.87500 2.00000 2.12500 2.12500 2.25000 2.37500 1.81250 1.87500 1.93750 2.31250 2.37500 2.43750 1.00000 1.25000 1.50000 1.25000 1.50000 1.75000 1.50000 1.75000 2.00000 1.75000 2.00000 2.25000 1.12500 1.25000 1.37500 1.37500 1.50000 1.62500 1.62500 1.75000 1.87500 1.37500 1.50000 1.62500 1.62500 1.75000 1.87500 1.87500 2.00000 2.12500 1.06250 1.31250 1.56250 1.12500 1.37500 1.62500 1.18750 1.43750 1.68750 1.56250 1.81250 2.06250 1.62500 1.87500 2.12500 1.68750 1.93750 2.18750 0.937500 1.00000 1.06250 1.06250 1.12500 1.18750 1.18750 1.25000 1.31250 1.93750 2.00000 2.06250 2.06250 2.12500 2.18750 2.18750 2.25000 2.31250 1.18750 1.25000 1.31250 1.31250 1.37500 1.43750 1.43750 1.50000 1.56250 1.43750 1.50000 1.56250 1.56250 1.62500 1.68750 1.68750 1.75000 1.81250 1.68750 1.75000 1.81250 1.81250 1.87500 1.93750 1.93750 2.00000 2.06250 
+DEAL::cell =2.4:  1.00000 1.25000 1.50000 1.75000 2.00000 2.25000 2.50000 2.75000 
+DEAL::cell =2.5:  1.25000 1.50000 1.75000 2.00000 2.25000 2.50000 2.75000 3.00000 1.50000 1.75000 1.37500 1.87500 2.50000 2.75000 2.37500 2.87500 1.75000 2.00000 2.25000 2.50000 2.00000 2.25000 1.87500 2.37500 1.62500 2.62500 2.12500 
+DEAL::cell =2.6:  1.50000 1.75000 2.00000 2.25000 2.50000 2.75000 3.00000 3.25000 1.66667 1.83333 1.91667 2.08333 1.58333 1.66667 2.08333 2.16667 2.66667 2.83333 2.91667 3.08333 2.58333 2.66667 3.08333 3.16667 1.83333 2.16667 2.08333 2.41667 2.33333 2.66667 2.58333 2.91667 2.00000 2.16667 2.33333 2.50000 2.25000 2.41667 2.58333 2.75000 1.91667 2.25000 2.00000 2.33333 2.41667 2.75000 2.50000 2.83333 1.75000 1.83333 1.91667 2.00000 2.75000 2.83333 2.91667 3.00000 2.08333 2.16667 2.25000 2.33333 2.41667 2.50000 2.58333 2.66667 
+DEAL::cell =2.7:  1.75000 2.00000 2.25000 2.50000 2.75000 3.00000 3.25000 3.50000 1.87500 2.00000 2.12500 2.12500 2.25000 2.37500 1.81250 1.87500 1.93750 2.31250 2.37500 2.43750 2.87500 3.00000 3.12500 3.12500 3.25000 3.37500 2.81250 2.87500 2.93750 3.31250 3.37500 3.43750 2.00000 2.25000 2.50000 2.25000 2.50000 2.75000 2.50000 2.75000 3.00000 2.75000 3.00000 3.25000 2.12500 2.25000 2.37500 2.37500 2.50000 2.62500 2.62500 2.75000 2.87500 2.37500 2.50000 2.62500 2.62500 2.75000 2.87500 2.87500 3.00000 3.12500 2.06250 2.31250 2.56250 2.12500 2.37500 2.62500 2.18750 2.43750 2.68750 2.56250 2.81250 3.06250 2.62500 2.87500 3.12500 2.68750 2.93750 3.18750 1.93750 2.00000 2.06250 2.06250 2.12500 2.18750 2.18750 2.25000 2.31250 2.93750 3.00000 3.06250 3.06250 3.12500 3.18750 3.18750 3.25000 3.31250 2.18750 2.25000 2.31250 2.31250 2.37500 2.43750 2.43750 2.50000 2.56250 2.43750 2.50000 2.56250 2.56250 2.62500 2.68750 2.68750 2.75000 2.81250 2.68750 2.75000 2.81250 2.81250 2.87500 2.93750 2.93750 3.00000 3.06250 
+DEAL::cell =2.8:  0.500000 0.750000 1.00000 1.25000 1.50000 1.75000 2.00000 2.25000 
+DEAL::cell =2.9:  0.750000 1.00000 1.25000 1.50000 1.75000 2.00000 2.25000 2.50000 1.00000 1.25000 0.875000 1.37500 2.00000 2.25000 1.87500 2.37500 1.25000 1.50000 1.75000 2.00000 1.50000 1.75000 1.37500 1.87500 1.12500 2.12500 1.62500 
+DEAL::cell =2.10:  1.00000 1.25000 1.50000 1.75000 2.00000 2.25000 2.50000 2.75000 1.16667 1.33333 1.41667 1.58333 1.08333 1.16667 1.58333 1.66667 2.16667 2.33333 2.41667 2.58333 2.08333 2.16667 2.58333 2.66667 1.33333 1.66667 1.58333 1.91667 1.83333 2.16667 2.08333 2.41667 1.50000 1.66667 1.83333 2.00000 1.75000 1.91667 2.08333 2.25000 1.41667 1.75000 1.50000 1.83333 1.91667 2.25000 2.00000 2.33333 1.25000 1.33333 1.41667 1.50000 2.25000 2.33333 2.41667 2.50000 1.58333 1.66667 1.75000 1.83333 1.91667 2.00000 2.08333 2.16667 
+DEAL::cell =2.11:  1.25000 1.50000 1.75000 2.00000 2.25000 2.50000 2.75000 3.00000 1.37500 1.50000 1.62500 1.62500 1.75000 1.87500 1.31250 1.37500 1.43750 1.81250 1.87500 1.93750 2.37500 2.50000 2.62500 2.62500 2.75000 2.87500 2.31250 2.37500 2.43750 2.81250 2.87500 2.93750 1.50000 1.75000 2.00000 1.75000 2.00000 2.25000 2.00000 2.25000 2.50000 2.25000 2.50000 2.75000 1.62500 1.75000 1.87500 1.87500 2.00000 2.12500 2.12500 2.25000 2.37500 1.87500 2.00000 2.12500 2.12500 2.25000 2.37500 2.37500 2.50000 2.62500 1.56250 1.81250 2.06250 1.62500 1.87500 2.12500 1.68750 1.93750 2.18750 2.06250 2.31250 2.56250 2.12500 2.37500 2.62500 2.18750 2.43750 2.68750 1.43750 1.50000 1.56250 1.56250 1.62500 1.68750 1.68750 1.75000 1.81250 2.43750 2.50000 2.56250 2.56250 2.62500 2.68750 2.68750 2.75000 2.81250 1.68750 1.75000 1.81250 1.81250 1.87500 1.93750 1.93750 2.00000 2.06250 1.93750 2.00000 2.06250 2.06250 2.12500 2.18750 2.18750 2.25000 2.31250 2.18750 2.25000 2.31250 2.31250 2.37500 2.43750 2.43750 2.50000 2.56250 
+DEAL::cell =2.12:  1.50000 1.75000 2.00000 2.25000 2.50000 2.75000 3.00000 3.25000 
+DEAL::cell =2.13:  1.75000 2.00000 2.25000 2.50000 2.75000 3.00000 3.25000 3.50000 2.00000 2.25000 1.87500 2.37500 3.00000 3.25000 2.87500 3.37500 2.25000 2.50000 2.75000 3.00000 2.50000 2.75000 2.37500 2.87500 2.12500 3.12500 2.62500 
+DEAL::cell =2.14:  2.00000 2.25000 2.50000 2.75000 3.00000 3.25000 3.50000 3.75000 2.16667 2.33333 2.41667 2.58333 2.08333 2.16667 2.58333 2.66667 3.16667 3.33333 3.41667 3.58333 3.08333 3.16667 3.58333 3.66667 2.33333 2.66667 2.58333 2.91667 2.83333 3.16667 3.08333 3.41667 2.50000 2.66667 2.83333 3.00000 2.75000 2.91667 3.08333 3.25000 2.41667 2.75000 2.50000 2.83333 2.91667 3.25000 3.00000 3.33333 2.25000 2.33333 2.41667 2.50000 3.25000 3.33333 3.41667 3.50000 2.58333 2.66667 2.75000 2.83333 2.91667 3.00000 3.08333 3.16667 
+DEAL::cell =2.15:  2.25000 2.50000 2.75000 3.00000 3.25000 3.50000 3.75000 4.00000 2.37500 2.50000 2.62500 2.62500 2.75000 2.87500 2.31250 2.37500 2.43750 2.81250 2.87500 2.93750 3.37500 3.50000 3.62500 3.62500 3.75000 3.87500 3.31250 3.37500 3.43750 3.81250 3.87500 3.93750 2.50000 2.75000 3.00000 2.75000 3.00000 3.25000 3.00000 3.25000 3.50000 3.25000 3.50000 3.75000 2.62500 2.75000 2.87500 2.87500 3.00000 3.12500 3.12500 3.25000 3.37500 2.87500 3.00000 3.12500 3.12500 3.25000 3.37500 3.37500 3.50000 3.62500 2.56250 2.81250 3.06250 2.62500 2.87500 3.12500 2.68750 2.93750 3.18750 3.06250 3.31250 3.56250 3.12500 3.37500 3.62500 3.18750 3.43750 3.68750 2.43750 2.50000 2.56250 2.56250 2.62500 2.68750 2.68750 2.75000 2.81250 3.43750 3.50000 3.56250 3.56250 3.62500 3.68750 3.68750 3.75000 3.81250 2.68750 2.75000 2.81250 2.81250 2.87500 2.93750 2.93750 3.00000 3.06250 2.93750 3.00000 3.06250 3.06250 3.12500 3.18750 3.18750 3.25000 3.31250 3.18750 3.25000 3.31250 3.31250 3.37500 3.43750 3.43750 3.50000 3.56250 
+DEAL::cell =2.16:  1.00000 1.25000 1.50000 1.75000 2.00000 2.25000 2.50000 2.75000 
+DEAL::cell =2.17:  1.25000 1.50000 1.75000 2.00000 2.25000 2.50000 2.75000 3.00000 1.50000 1.75000 1.37500 1.87500 2.50000 2.75000 2.37500 2.87500 1.75000 2.00000 2.25000 2.50000 2.00000 2.25000 1.87500 2.37500 1.62500 2.62500 2.12500 
+DEAL::cell =2.18:  1.50000 1.75000 2.00000 2.25000 2.50000 2.75000 3.00000 3.25000 1.66667 1.83333 1.91667 2.08333 1.58333 1.66667 2.08333 2.16667 2.66667 2.83333 2.91667 3.08333 2.58333 2.66667 3.08333 3.16667 1.83333 2.16667 2.08333 2.41667 2.33333 2.66667 2.58333 2.91667 2.00000 2.16667 2.33333 2.50000 2.25000 2.41667 2.58333 2.75000 1.91667 2.25000 2.00000 2.33333 2.41667 2.75000 2.50000 2.83333 1.75000 1.83333 1.91667 2.00000 2.75000 2.83333 2.91667 3.00000 2.08333 2.16667 2.25000 2.33333 2.41667 2.50000 2.58333 2.66667 
+DEAL::cell =2.19:  1.75000 2.00000 2.25000 2.50000 2.75000 3.00000 3.25000 3.50000 1.87500 2.00000 2.12500 2.12500 2.25000 2.37500 1.81250 1.87500 1.93750 2.31250 2.37500 2.43750 2.87500 3.00000 3.12500 3.12500 3.25000 3.37500 2.81250 2.87500 2.93750 3.31250 3.37500 3.43750 2.00000 2.25000 2.50000 2.25000 2.50000 2.75000 2.50000 2.75000 3.00000 2.75000 3.00000 3.25000 2.12500 2.25000 2.37500 2.37500 2.50000 2.62500 2.62500 2.75000 2.87500 2.37500 2.50000 2.62500 2.62500 2.75000 2.87500 2.87500 3.00000 3.12500 2.06250 2.31250 2.56250 2.12500 2.37500 2.62500 2.18750 2.43750 2.68750 2.56250 2.81250 3.06250 2.62500 2.87500 3.12500 2.68750 2.93750 3.18750 1.93750 2.00000 2.06250 2.06250 2.12500 2.18750 2.18750 2.25000 2.31250 2.93750 3.00000 3.06250 3.06250 3.12500 3.18750 3.18750 3.25000 3.31250 2.18750 2.25000 2.31250 2.31250 2.37500 2.43750 2.43750 2.50000 2.56250 2.43750 2.50000 2.56250 2.56250 2.62500 2.68750 2.68750 2.75000 2.81250 2.68750 2.75000 2.81250 2.81250 2.87500 2.93750 2.93750 3.00000 3.06250 
+DEAL::cell =2.20:  2.00000 2.25000 2.50000 2.75000 3.00000 3.25000 3.50000 3.75000 
+DEAL::cell =2.21:  2.25000 2.50000 2.75000 3.00000 3.25000 3.50000 3.75000 4.00000 2.50000 2.75000 2.37500 2.87500 3.50000 3.75000 3.37500 3.87500 2.75000 3.00000 3.25000 3.50000 3.00000 3.25000 2.87500 3.37500 2.62500 3.62500 3.12500 
+DEAL::cell =2.22:  2.50000 2.75000 3.00000 3.25000 3.50000 3.75000 4.00000 4.25000 2.66667 2.83333 2.91667 3.08333 2.58333 2.66667 3.08333 3.16667 3.66667 3.83333 3.91667 4.08333 3.58333 3.66667 4.08333 4.16667 2.83333 3.16667 3.08333 3.41667 3.33333 3.66667 3.58333 3.91667 3.00000 3.16667 3.33333 3.50000 3.25000 3.41667 3.58333 3.75000 2.91667 3.25000 3.00000 3.33333 3.41667 3.75000 3.50000 3.83333 2.75000 2.83333 2.91667 3.00000 3.75000 3.83333 3.91667 4.00000 3.08333 3.16667 3.25000 3.33333 3.41667 3.50000 3.58333 3.66667 
+DEAL::cell =2.23:  2.75000 3.00000 3.25000 3.50000 3.75000 4.00000 4.25000 4.50000 2.87500 3.00000 3.12500 3.12500 3.25000 3.37500 2.81250 2.87500 2.93750 3.31250 3.37500 3.43750 3.87500 4.00000 4.12500 4.12500 4.25000 4.37500 3.81250 3.87500 3.93750 4.31250 4.37500 4.43750 3.00000 3.25000 3.50000 3.25000 3.50000 3.75000 3.50000 3.75000 4.00000 3.75000 4.00000 4.25000 3.12500 3.25000 3.37500 3.37500 3.50000 3.62500 3.62500 3.75000 3.87500 3.37500 3.50000 3.62500 3.62500 3.75000 3.87500 3.87500 4.00000 4.12500 3.06250 3.31250 3.56250 3.12500 3.37500 3.62500 3.18750 3.43750 3.68750 3.56250 3.81250 4.06250 3.62500 3.87500 4.12500 3.68750 3.93750 4.18750 2.93750 3.00000 3.06250 3.06250 3.12500 3.18750 3.18750 3.25000 3.31250 3.93750 4.00000 4.06250 4.06250 4.12500 4.18750 4.18750 4.25000 4.31250 3.18750 3.25000 3.31250 3.31250 3.37500 3.43750 3.43750 3.50000 3.56250 3.43750 3.50000 3.56250 3.56250 3.62500 3.68750 3.68750 3.75000 3.81250 3.68750 3.75000 3.81250 3.81250 3.87500 3.93750 3.93750 4.00000 4.06250 
+DEAL::cell =2.24:  1.50000 1.75000 2.00000 2.25000 2.50000 2.75000 3.00000 3.25000 
+DEAL::cell =2.25:  1.75000 2.00000 2.25000 2.50000 2.75000 3.00000 3.25000 3.50000 2.00000 2.25000 1.87500 2.37500 3.00000 3.25000 2.87500 3.37500 2.25000 2.50000 2.75000 3.00000 2.50000 2.75000 2.37500 2.87500 2.12500 3.12500 2.62500 
+DEAL::cell =2.26:  2.00000 2.25000 2.50000 2.75000 3.00000 3.25000 3.50000 3.75000 2.16667 2.33333 2.41667 2.58333 2.08333 2.16667 2.58333 2.66667 3.16667 3.33333 3.41667 3.58333 3.08333 3.16667 3.58333 3.66667 2.33333 2.66667 2.58333 2.91667 2.83333 3.16667 3.08333 3.41667 2.50000 2.66667 2.83333 3.00000 2.75000 2.91667 3.08333 3.25000 2.41667 2.75000 2.50000 2.83333 2.91667 3.25000 3.00000 3.33333 2.25000 2.33333 2.41667 2.50000 3.25000 3.33333 3.41667 3.50000 2.58333 2.66667 2.75000 2.83333 2.91667 3.00000 3.08333 3.16667 
+DEAL::cell =2.27:  2.25000 2.50000 2.75000 3.00000 3.25000 3.50000 3.75000 4.00000 2.37500 2.50000 2.62500 2.62500 2.75000 2.87500 2.31250 2.37500 2.43750 2.81250 2.87500 2.93750 3.37500 3.50000 3.62500 3.62500 3.75000 3.87500 3.31250 3.37500 3.43750 3.81250 3.87500 3.93750 2.50000 2.75000 3.00000 2.75000 3.00000 3.25000 3.00000 3.25000 3.50000 3.25000 3.50000 3.75000 2.62500 2.75000 2.87500 2.87500 3.00000 3.12500 3.12500 3.25000 3.37500 2.87500 3.00000 3.12500 3.12500 3.25000 3.37500 3.37500 3.50000 3.62500 2.56250 2.81250 3.06250 2.62500 2.87500 3.12500 2.68750 2.93750 3.18750 3.06250 3.31250 3.56250 3.12500 3.37500 3.62500 3.18750 3.43750 3.68750 2.43750 2.50000 2.56250 2.56250 2.62500 2.68750 2.68750 2.75000 2.81250 3.43750 3.50000 3.56250 3.56250 3.62500 3.68750 3.68750 3.75000 3.81250 2.68750 2.75000 2.81250 2.81250 2.87500 2.93750 2.93750 3.00000 3.06250 2.93750 3.00000 3.06250 3.06250 3.12500 3.18750 3.18750 3.25000 3.31250 3.18750 3.25000 3.31250 3.31250 3.37500 3.43750 3.43750 3.50000 3.56250 
+DEAL::cell =2.28:  2.50000 2.75000 3.00000 3.25000 3.50000 3.75000 4.00000 4.25000 
+DEAL::cell =2.29:  2.75000 3.00000 3.25000 3.50000 3.75000 4.00000 4.25000 4.50000 3.00000 3.25000 2.87500 3.37500 4.00000 4.25000 3.87500 4.37500 3.25000 3.50000 3.75000 4.00000 3.50000 3.75000 3.37500 3.87500 3.12500 4.12500 3.62500 
+DEAL::cell =2.30:  3.00000 3.25000 3.50000 3.75000 4.00000 4.25000 4.50000 4.75000 3.16667 3.33333 3.41667 3.58333 3.08333 3.16667 3.58333 3.66667 4.16667 4.33333 4.41667 4.58333 4.08333 4.16667 4.58333 4.66667 3.33333 3.66667 3.58333 3.91667 3.83333 4.16667 4.08333 4.41667 3.50000 3.66667 3.83333 4.00000 3.75000 3.91667 4.08333 4.25000 3.41667 3.75000 3.50000 3.83333 3.91667 4.25000 4.00000 4.33333 3.25000 3.33333 3.41667 3.50000 4.25000 4.33333 4.41667 4.50000 3.58333 3.66667 3.75000 3.83333 3.91667 4.00000 4.08333 4.16667 
+DEAL::cell =2.31:  3.25000 3.50000 3.75000 4.00000 4.25000 4.50000 4.75000 5.00000 3.37500 3.50000 3.62500 3.62500 3.75000 3.87500 3.31250 3.37500 3.43750 3.81250 3.87500 3.93750 4.37500 4.50000 4.62500 4.62500 4.75000 4.87500 4.31250 4.37500 4.43750 4.81250 4.87500 4.93750 3.50000 3.75000 4.00000 3.75000 4.00000 4.25000 4.00000 4.25000 4.50000 4.25000 4.50000 4.75000 3.62500 3.75000 3.87500 3.87500 4.00000 4.12500 4.12500 4.25000 4.37500 3.87500 4.00000 4.12500 4.12500 4.25000 4.37500 4.37500 4.50000 4.62500 3.56250 3.81250 4.06250 3.62500 3.87500 4.12500 3.68750 3.93750 4.18750 4.06250 4.31250 4.56250 4.12500 4.37500 4.62500 4.18750 4.43750 4.68750 3.43750 3.50000 3.56250 3.56250 3.62500 3.68750 3.68750 3.75000 3.81250 4.43750 4.50000 4.56250 4.56250 4.62500 4.68750 4.68750 4.75000 4.81250 3.68750 3.75000 3.81250 3.81250 3.87500 3.93750 3.93750 4.00000 4.06250 3.93750 4.00000 4.06250 4.06250 4.12500 4.18750 4.18750 4.25000 4.31250 4.18750 4.25000 4.31250 4.31250 4.37500 4.43750 4.43750 4.50000 4.56250 
+DEAL::cell =2.32:  2.00000 2.25000 2.50000 2.75000 3.00000 3.25000 3.50000 3.75000 
+DEAL::cell =2.33:  2.25000 2.50000 2.75000 3.00000 3.25000 3.50000 3.75000 4.00000 2.50000 2.75000 2.37500 2.87500 3.50000 3.75000 3.37500 3.87500 2.75000 3.00000 3.25000 3.50000 3.00000 3.25000 2.87500 3.37500 2.62500 3.62500 3.12500 
+DEAL::cell =2.34:  2.50000 2.75000 3.00000 3.25000 3.50000 3.75000 4.00000 4.25000 2.66667 2.83333 2.91667 3.08333 2.58333 2.66667 3.08333 3.16667 3.66667 3.83333 3.91667 4.08333 3.58333 3.66667 4.08333 4.16667 2.83333 3.16667 3.08333 3.41667 3.33333 3.66667 3.58333 3.91667 3.00000 3.16667 3.33333 3.50000 3.25000 3.41667 3.58333 3.75000 2.91667 3.25000 3.00000 3.33333 3.41667 3.75000 3.50000 3.83333 2.75000 2.83333 2.91667 3.00000 3.75000 3.83333 3.91667 4.00000 3.08333 3.16667 3.25000 3.33333 3.41667 3.50000 3.58333 3.66667 
+DEAL::cell =2.35:  2.75000 3.00000 3.25000 3.50000 3.75000 4.00000 4.25000 4.50000 2.87500 3.00000 3.12500 3.12500 3.25000 3.37500 2.81250 2.87500 2.93750 3.31250 3.37500 3.43750 3.87500 4.00000 4.12500 4.12500 4.25000 4.37500 3.81250 3.87500 3.93750 4.31250 4.37500 4.43750 3.00000 3.25000 3.50000 3.25000 3.50000 3.75000 3.50000 3.75000 4.00000 3.75000 4.00000 4.25000 3.12500 3.25000 3.37500 3.37500 3.50000 3.62500 3.62500 3.75000 3.87500 3.37500 3.50000 3.62500 3.62500 3.75000 3.87500 3.87500 4.00000 4.12500 3.06250 3.31250 3.56250 3.12500 3.37500 3.62500 3.18750 3.43750 3.68750 3.56250 3.81250 4.06250 3.62500 3.87500 4.12500 3.68750 3.93750 4.18750 2.93750 3.00000 3.06250 3.06250 3.12500 3.18750 3.18750 3.25000 3.31250 3.93750 4.00000 4.06250 4.06250 4.12500 4.18750 4.18750 4.25000 4.31250 3.18750 3.25000 3.31250 3.31250 3.37500 3.43750 3.43750 3.50000 3.56250 3.43750 3.50000 3.56250 3.56250 3.62500 3.68750 3.68750 3.75000 3.81250 3.68750 3.75000 3.81250 3.81250 3.87500 3.93750 3.93750 4.00000 4.06250 
+DEAL::cell =2.36:  3.00000 3.25000 3.50000 3.75000 4.00000 4.25000 4.50000 4.75000 
+DEAL::cell =2.37:  3.25000 3.50000 3.75000 4.00000 4.25000 4.50000 4.75000 5.00000 3.50000 3.75000 3.37500 3.87500 4.50000 4.75000 4.37500 4.87500 3.75000 4.00000 4.25000 4.50000 4.00000 4.25000 3.87500 4.37500 3.62500 4.62500 4.12500 
+DEAL::cell =2.38:  3.50000 3.75000 4.00000 4.25000 4.50000 4.75000 5.00000 5.25000 3.66667 3.83333 3.91667 4.08333 3.58333 3.66667 4.08333 4.16667 4.66667 4.83333 4.91667 5.08333 4.58333 4.66667 5.08333 5.16667 3.83333 4.16667 4.08333 4.41667 4.33333 4.66667 4.58333 4.91667 4.00000 4.16667 4.33333 4.50000 4.25000 4.41667 4.58333 4.75000 3.91667 4.25000 4.00000 4.33333 4.41667 4.75000 4.50000 4.83333 3.75000 3.83333 3.91667 4.00000 4.75000 4.83333 4.91667 5.00000 4.08333 4.16667 4.25000 4.33333 4.41667 4.50000 4.58333 4.66667 
+DEAL::cell =2.39:  3.75000 4.00000 4.25000 4.50000 4.75000 5.00000 5.25000 5.50000 3.87500 4.00000 4.12500 4.12500 4.25000 4.37500 3.81250 3.87500 3.93750 4.31250 4.37500 4.43750 4.87500 5.00000 5.12500 5.12500 5.25000 5.37500 4.81250 4.87500 4.93750 5.31250 5.37500 5.43750 4.00000 4.25000 4.50000 4.25000 4.50000 4.75000 4.50000 4.75000 5.00000 4.75000 5.00000 5.25000 4.12500 4.25000 4.37500 4.37500 4.50000 4.62500 4.62500 4.75000 4.87500 4.37500 4.50000 4.62500 4.62500 4.75000 4.87500 4.87500 5.00000 5.12500 4.06250 4.31250 4.56250 4.12500 4.37500 4.62500 4.18750 4.43750 4.68750 4.56250 4.81250 5.06250 4.62500 4.87500 5.12500 4.68750 4.93750 5.18750 3.93750 4.00000 4.06250 4.06250 4.12500 4.18750 4.18750 4.25000 4.31250 4.93750 5.00000 5.06250 5.06250 5.12500 5.18750 5.18750 5.25000 5.31250 4.18750 4.25000 4.31250 4.31250 4.37500 4.43750 4.43750 4.50000 4.56250 4.43750 4.50000 4.56250 4.56250 4.62500 4.68750 4.68750 4.75000 4.81250 4.68750 4.75000 4.81250 4.81250 4.87500 4.93750 4.93750 5.00000 5.06250 
+DEAL::cell =2.40:  2.50000 2.75000 3.00000 3.25000 3.50000 3.75000 4.00000 4.25000 
+DEAL::cell =2.41:  2.75000 3.00000 3.25000 3.50000 3.75000 4.00000 4.25000 4.50000 3.00000 3.25000 2.87500 3.37500 4.00000 4.25000 3.87500 4.37500 3.25000 3.50000 3.75000 4.00000 3.50000 3.75000 3.37500 3.87500 3.12500 4.12500 3.62500 
+DEAL::cell =2.42:  3.00000 3.25000 3.50000 3.75000 4.00000 4.25000 4.50000 4.75000 3.16667 3.33333 3.41667 3.58333 3.08333 3.16667 3.58333 3.66667 4.16667 4.33333 4.41667 4.58333 4.08333 4.16667 4.58333 4.66667 3.33333 3.66667 3.58333 3.91667 3.83333 4.16667 4.08333 4.41667 3.50000 3.66667 3.83333 4.00000 3.75000 3.91667 4.08333 4.25000 3.41667 3.75000 3.50000 3.83333 3.91667 4.25000 4.00000 4.33333 3.25000 3.33333 3.41667 3.50000 4.25000 4.33333 4.41667 4.50000 3.58333 3.66667 3.75000 3.83333 3.91667 4.00000 4.08333 4.16667 
+DEAL::cell =2.43:  3.25000 3.50000 3.75000 4.00000 4.25000 4.50000 4.75000 5.00000 3.37500 3.50000 3.62500 3.62500 3.75000 3.87500 3.31250 3.37500 3.43750 3.81250 3.87500 3.93750 4.37500 4.50000 4.62500 4.62500 4.75000 4.87500 4.31250 4.37500 4.43750 4.81250 4.87500 4.93750 3.50000 3.75000 4.00000 3.75000 4.00000 4.25000 4.00000 4.25000 4.50000 4.25000 4.50000 4.75000 3.62500 3.75000 3.87500 3.87500 4.00000 4.12500 4.12500 4.25000 4.37500 3.87500 4.00000 4.12500 4.12500 4.25000 4.37500 4.37500 4.50000 4.62500 3.56250 3.81250 4.06250 3.62500 3.87500 4.12500 3.68750 3.93750 4.18750 4.06250 4.31250 4.56250 4.12500 4.37500 4.62500 4.18750 4.43750 4.68750 3.43750 3.50000 3.56250 3.56250 3.62500 3.68750 3.68750 3.75000 3.81250 4.43750 4.50000 4.56250 4.56250 4.62500 4.68750 4.68750 4.75000 4.81250 3.68750 3.75000 3.81250 3.81250 3.87500 3.93750 3.93750 4.00000 4.06250 3.93750 4.00000 4.06250 4.06250 4.12500 4.18750 4.18750 4.25000 4.31250 4.18750 4.25000 4.31250 4.31250 4.37500 4.43750 4.43750 4.50000 4.56250 
+DEAL::cell =2.44:  3.50000 3.75000 4.00000 4.25000 4.50000 4.75000 5.00000 5.25000 
+DEAL::cell =2.45:  3.75000 4.00000 4.25000 4.50000 4.75000 5.00000 5.25000 5.50000 4.00000 4.25000 3.87500 4.37500 5.00000 5.25000 4.87500 5.37500 4.25000 4.50000 4.75000 5.00000 4.50000 4.75000 4.37500 4.87500 4.12500 5.12500 4.62500 
+DEAL::cell =2.46:  4.00000 4.25000 4.50000 4.75000 5.00000 5.25000 5.50000 5.75000 4.16667 4.33333 4.41667 4.58333 4.08333 4.16667 4.58333 4.66667 5.16667 5.33333 5.41667 5.58333 5.08333 5.16667 5.58333 5.66667 4.33333 4.66667 4.58333 4.91667 4.83333 5.16667 5.08333 5.41667 4.50000 4.66667 4.83333 5.00000 4.75000 4.91667 5.08333 5.25000 4.41667 4.75000 4.50000 4.83333 4.91667 5.25000 5.00000 5.33333 4.25000 4.33333 4.41667 4.50000 5.25000 5.33333 5.41667 5.50000 4.58333 4.66667 4.75000 4.83333 4.91667 5.00000 5.08333 5.16667 
+DEAL::cell =2.47:  4.25000 4.50000 4.75000 5.00000 5.25000 5.50000 5.75000 6.00000 4.37500 4.50000 4.62500 4.62500 4.75000 4.87500 4.31250 4.37500 4.43750 4.81250 4.87500 4.93750 5.37500 5.50000 5.62500 5.62500 5.75000 5.87500 5.31250 5.37500 5.43750 5.81250 5.87500 5.93750 4.50000 4.75000 5.00000 4.75000 5.00000 5.25000 5.00000 5.25000 5.50000 5.25000 5.50000 5.75000 4.62500 4.75000 4.87500 4.87500 5.00000 5.12500 5.12500 5.25000 5.37500 4.87500 5.00000 5.12500 5.12500 5.25000 5.37500 5.37500 5.50000 5.62500 4.56250 4.81250 5.06250 4.62500 4.87500 5.12500 4.68750 4.93750 5.18750 5.06250 5.31250 5.56250 5.12500 5.37500 5.62500 5.18750 5.43750 5.68750 4.43750 4.50000 4.56250 4.56250 4.62500 4.68750 4.68750 4.75000 4.81250 5.43750 5.50000 5.56250 5.56250 5.62500 5.68750 5.68750 5.75000 5.81250 4.68750 4.75000 4.81250 4.81250 4.87500 4.93750 4.93750 5.00000 5.06250 4.93750 5.00000 5.06250 5.06250 5.12500 5.18750 5.18750 5.25000 5.31250 5.18750 5.25000 5.31250 5.31250 5.37500 5.43750 5.43750 5.50000 5.56250 
+DEAL::cell =2.48:  3.00000 3.25000 3.50000 3.75000 4.00000 4.25000 4.50000 4.75000 
+DEAL::cell =2.49:  3.25000 3.50000 3.75000 4.00000 4.25000 4.50000 4.75000 5.00000 3.50000 3.75000 3.37500 3.87500 4.50000 4.75000 4.37500 4.87500 3.75000 4.00000 4.25000 4.50000 4.00000 4.25000 3.87500 4.37500 3.62500 4.62500 4.12500 
+DEAL::cell =2.50:  3.50000 3.75000 4.00000 4.25000 4.50000 4.75000 5.00000 5.25000 3.66667 3.83333 3.91667 4.08333 3.58333 3.66667 4.08333 4.16667 4.66667 4.83333 4.91667 5.08333 4.58333 4.66667 5.08333 5.16667 3.83333 4.16667 4.08333 4.41667 4.33333 4.66667 4.58333 4.91667 4.00000 4.16667 4.33333 4.50000 4.25000 4.41667 4.58333 4.75000 3.91667 4.25000 4.00000 4.33333 4.41667 4.75000 4.50000 4.83333 3.75000 3.83333 3.91667 4.00000 4.75000 4.83333 4.91667 5.00000 4.08333 4.16667 4.25000 4.33333 4.41667 4.50000 4.58333 4.66667 
+DEAL::cell =2.51:  3.75000 4.00000 4.25000 4.50000 4.75000 5.00000 5.25000 5.50000 3.87500 4.00000 4.12500 4.12500 4.25000 4.37500 3.81250 3.87500 3.93750 4.31250 4.37500 4.43750 4.87500 5.00000 5.12500 5.12500 5.25000 5.37500 4.81250 4.87500 4.93750 5.31250 5.37500 5.43750 4.00000 4.25000 4.50000 4.25000 4.50000 4.75000 4.50000 4.75000 5.00000 4.75000 5.00000 5.25000 4.12500 4.25000 4.37500 4.37500 4.50000 4.62500 4.62500 4.75000 4.87500 4.37500 4.50000 4.62500 4.62500 4.75000 4.87500 4.87500 5.00000 5.12500 4.06250 4.31250 4.56250 4.12500 4.37500 4.62500 4.18750 4.43750 4.68750 4.56250 4.81250 5.06250 4.62500 4.87500 5.12500 4.68750 4.93750 5.18750 3.93750 4.00000 4.06250 4.06250 4.12500 4.18750 4.18750 4.25000 4.31250 4.93750 5.00000 5.06250 5.06250 5.12500 5.18750 5.18750 5.25000 5.31250 4.18750 4.25000 4.31250 4.31250 4.37500 4.43750 4.43750 4.50000 4.56250 4.43750 4.50000 4.56250 4.56250 4.62500 4.68750 4.68750 4.75000 4.81250 4.68750 4.75000 4.81250 4.81250 4.87500 4.93750 4.93750 5.00000 5.06250 
+DEAL::cell =2.52:  4.00000 4.25000 4.50000 4.75000 5.00000 5.25000 5.50000 5.75000 
+DEAL::cell =2.53:  4.25000 4.50000 4.75000 5.00000 5.25000 5.50000 5.75000 6.00000 4.50000 4.75000 4.37500 4.87500 5.50000 5.75000 5.37500 5.87500 4.75000 5.00000 5.25000 5.50000 5.00000 5.25000 4.87500 5.37500 4.62500 5.62500 5.12500 
+DEAL::cell =2.54:  4.50000 4.75000 5.00000 5.25000 5.50000 5.75000 6.00000 6.25000 4.66667 4.83333 4.91667 5.08333 4.58333 4.66667 5.08333 5.16667 5.66667 5.83333 5.91667 6.08333 5.58333 5.66667 6.08333 6.16667 4.83333 5.16667 5.08333 5.41667 5.33333 5.66667 5.58333 5.91667 5.00000 5.16667 5.33333 5.50000 5.25000 5.41667 5.58333 5.75000 4.91667 5.25000 5.00000 5.33333 5.41667 5.75000 5.50000 5.83333 4.75000 4.83333 4.91667 5.00000 5.75000 5.83333 5.91667 6.00000 5.08333 5.16667 5.25000 5.33333 5.41667 5.50000 5.58333 5.66667 
+DEAL::cell =2.55:  4.75000 5.00000 5.25000 5.50000 5.75000 6.00000 6.25000 6.50000 4.87500 5.00000 5.12500 5.12500 5.25000 5.37500 4.81250 4.87500 4.93750 5.31250 5.37500 5.43750 5.87500 6.00000 6.12500 6.12500 6.25000 6.37500 5.81250 5.87500 5.93750 6.31250 6.37500 6.43750 5.00000 5.25000 5.50000 5.25000 5.50000 5.75000 5.50000 5.75000 6.00000 5.75000 6.00000 6.25000 5.12500 5.25000 5.37500 5.37500 5.50000 5.62500 5.62500 5.75000 5.87500 5.37500 5.50000 5.62500 5.62500 5.75000 5.87500 5.87500 6.00000 6.12500 5.06250 5.31250 5.56250 5.12500 5.37500 5.62500 5.18750 5.43750 5.68750 5.56250 5.81250 6.06250 5.62500 5.87500 6.12500 5.68750 5.93750 6.18750 4.93750 5.00000 5.06250 5.06250 5.12500 5.18750 5.18750 5.25000 5.31250 5.93750 6.00000 6.06250 6.06250 6.12500 6.18750 6.18750 6.25000 6.31250 5.18750 5.25000 5.31250 5.31250 5.37500 5.43750 5.43750 5.50000 5.56250 5.43750 5.50000 5.56250 5.56250 5.62500 5.68750 5.68750 5.75000 5.81250 5.68750 5.75000 5.81250 5.81250 5.87500 5.93750 5.93750 6.00000 6.06250 
+DEAL::cell =2.56:  3.50000 3.75000 4.00000 4.25000 4.50000 4.75000 5.00000 5.25000 
+DEAL::cell =2.57:  3.75000 4.00000 4.25000 4.50000 4.75000 5.00000 5.25000 5.50000 4.00000 4.25000 3.87500 4.37500 5.00000 5.25000 4.87500 5.37500 4.25000 4.50000 4.75000 5.00000 4.50000 4.75000 4.37500 4.87500 4.12500 5.12500 4.62500 
+DEAL::cell =2.58:  4.00000 4.25000 4.50000 4.75000 5.00000 5.25000 5.50000 5.75000 4.16667 4.33333 4.41667 4.58333 4.08333 4.16667 4.58333 4.66667 5.16667 5.33333 5.41667 5.58333 5.08333 5.16667 5.58333 5.66667 4.33333 4.66667 4.58333 4.91667 4.83333 5.16667 5.08333 5.41667 4.50000 4.66667 4.83333 5.00000 4.75000 4.91667 5.08333 5.25000 4.41667 4.75000 4.50000 4.83333 4.91667 5.25000 5.00000 5.33333 4.25000 4.33333 4.41667 4.50000 5.25000 5.33333 5.41667 5.50000 4.58333 4.66667 4.75000 4.83333 4.91667 5.00000 5.08333 5.16667 
+DEAL::cell =2.59:  4.25000 4.50000 4.75000 5.00000 5.25000 5.50000 5.75000 6.00000 4.37500 4.50000 4.62500 4.62500 4.75000 4.87500 4.31250 4.37500 4.43750 4.81250 4.87500 4.93750 5.37500 5.50000 5.62500 5.62500 5.75000 5.87500 5.31250 5.37500 5.43750 5.81250 5.87500 5.93750 4.50000 4.75000 5.00000 4.75000 5.00000 5.25000 5.00000 5.25000 5.50000 5.25000 5.50000 5.75000 4.62500 4.75000 4.87500 4.87500 5.00000 5.12500 5.12500 5.25000 5.37500 4.87500 5.00000 5.12500 5.12500 5.25000 5.37500 5.37500 5.50000 5.62500 4.56250 4.81250 5.06250 4.62500 4.87500 5.12500 4.68750 4.93750 5.18750 5.06250 5.31250 5.56250 5.12500 5.37500 5.62500 5.18750 5.43750 5.68750 4.43750 4.50000 4.56250 4.56250 4.62500 4.68750 4.68750 4.75000 4.81250 5.43750 5.50000 5.56250 5.56250 5.62500 5.68750 5.68750 5.75000 5.81250 4.68750 4.75000 4.81250 4.81250 4.87500 4.93750 4.93750 5.00000 5.06250 4.93750 5.00000 5.06250 5.06250 5.12500 5.18750 5.18750 5.25000 5.31250 5.18750 5.25000 5.31250 5.31250 5.37500 5.43750 5.43750 5.50000 5.56250 
+DEAL::cell =2.60:  4.50000 4.75000 5.00000 5.25000 5.50000 5.75000 6.00000 6.25000 
+DEAL::cell =2.61:  4.75000 5.00000 5.25000 5.50000 5.75000 6.00000 6.25000 6.50000 5.00000 5.25000 4.87500 5.37500 6.00000 6.25000 5.87500 6.37500 5.25000 5.50000 5.75000 6.00000 5.50000 5.75000 5.37500 5.87500 5.12500 6.12500 5.62500 
+DEAL::cell =2.62:  5.00000 5.25000 5.50000 5.75000 6.00000 6.25000 6.50000 6.75000 5.16667 5.33333 5.41667 5.58333 5.08333 5.16667 5.58333 5.66667 6.16667 6.33333 6.41667 6.58333 6.08333 6.16667 6.58333 6.66667 5.33333 5.66667 5.58333 5.91667 5.83333 6.16667 6.08333 6.41667 5.50000 5.66667 5.83333 6.00000 5.75000 5.91667 6.08333 6.25000 5.41667 5.75000 5.50000 5.83333 5.91667 6.25000 6.00000 6.33333 5.25000 5.33333 5.41667 5.50000 6.25000 6.33333 6.41667 6.50000 5.58333 5.66667 5.75000 5.83333 5.91667 6.00000 6.08333 6.16667 
+DEAL::cell =2.63:  5.25000 5.50000 5.75000 6.00000 6.25000 6.50000 6.75000 7.00000 5.37500 5.50000 5.62500 5.62500 5.75000 5.87500 5.31250 5.37500 5.43750 5.81250 5.87500 5.93750 6.37500 6.50000 6.62500 6.62500 6.75000 6.87500 6.31250 6.37500 6.43750 6.81250 6.87500 6.93750 5.50000 5.75000 6.00000 5.75000 6.00000 6.25000 6.00000 6.25000 6.50000 6.25000 6.50000 6.75000 5.62500 5.75000 5.87500 5.87500 6.00000 6.12500 6.12500 6.25000 6.37500 5.87500 6.00000 6.12500 6.12500 6.25000 6.37500 6.37500 6.50000 6.62500 5.56250 5.81250 6.06250 5.62500 5.87500 6.12500 5.68750 5.93750 6.18750 6.06250 6.31250 6.56250 6.12500 6.37500 6.62500 6.18750 6.43750 6.68750 5.43750 5.50000 5.56250 5.56250 5.62500 5.68750 5.68750 5.75000 5.81250 6.43750 6.50000 6.56250 6.56250 6.62500 6.68750 6.68750 6.75000 6.81250 5.68750 5.75000 5.81250 5.81250 5.87500 5.93750 5.93750 6.00000 6.06250 5.93750 6.00000 6.06250 6.06250 6.12500 6.18750 6.18750 6.25000 6.31250 6.18750 6.25000 6.31250 6.31250 6.37500 6.43750 6.43750 6.50000 6.56250 

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.