]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
New test that currently fails. On meshes with non-standard face_orientation, face_fli...
authorleicht <leicht@0785d39b-7218-0410-832d-ea1e28bc413d>
Thu, 11 Oct 2007 13:12:31 +0000 (13:12 +0000)
committerleicht <leicht@0785d39b-7218-0410-832d-ea1e28bc413d>
Thu, 11 Oct 2007 13:12:31 +0000 (13:12 +0000)
git-svn-id: https://svn.dealii.org/trunk@15287 0785d39b-7218-0410-832d-ea1e28bc413d

tests/bits/mesh_3d_21.cc [new file with mode: 0644]
tests/bits/mesh_3d_21/cmp/generic [new file with mode: 0644]

diff --git a/tests/bits/mesh_3d_21.cc b/tests/bits/mesh_3d_21.cc
new file mode 100644 (file)
index 0000000..9c689ec
--- /dev/null
@@ -0,0 +1,161 @@
+//----------------------------  mesh_3d_21.cc  ---------------------------
+//    $Id$
+//    Version: $Name$ 
+//
+//    Copyright (C) 2003, 2004, 2005 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  mesh_3d_21.cc  ---------------------------
+
+
+// check, that we find our way back from fine cells over coarser neighbors to
+// the fine cell agaion and vice versa
+
+#include "../tests.h"
+#include "mesh_3d.h"
+
+#include <base/logstream.h>
+#include <lac/vector.h>
+#include <grid/tria.h>
+#include <grid/tria_accessor.h>
+#include <grid/tria_iterator.h>
+#include <grid/grid_reordering.h>
+#include <grid/grid_generator.h>
+#include <dofs/dof_handler.h>
+#include <dofs/dof_accessor.h>
+#include <fe/fe_q.h>
+#include <fe/fe_values.h>
+
+#include <fstream>
+
+
+void check_this (Triangulation<3> &tria)
+{
+  FE_Q<3> fe(1);
+  DoFHandler<3> dof_handler (tria);
+  dof_handler.distribute_dofs (fe);
+  
+  DoFHandler<3>::active_cell_iterator cell = dof_handler.begin_active();
+  for (; cell!=dof_handler.end(); ++cell)
+    for (unsigned int face_no=0; face_no<GeometryInfo<3>::faces_per_cell;
+         ++face_no)
+      if (!cell->at_boundary(face_no))
+       if (cell->neighbor(face_no)->has_children())
+                                          // we are coarser than the neighbor
+         for (unsigned int subface_no=0;
+              subface_no<GeometryInfo<3>::subfaces_per_face;
+              ++subface_no)
+           {
+                                              // get an iterator
+                                              // pointing to the cell
+                                              // behind the present
+                                              // subface
+             const unsigned int neighbor_neighbor
+               = cell->neighbor_of_neighbor (face_no);
+             
+             const DoFHandler<3>::active_cell_iterator neighbor_child
+               = cell->neighbor_child_on_subface(face_no,subface_no);
+
+                                              // make sure, that we find the
+                                              // way back
+             const unsigned int our_face_no=neighbor_child->neighbor_of_coarser_neighbor(neighbor_neighbor).first;
+             const unsigned int our_subface_no=neighbor_child->neighbor_of_coarser_neighbor(neighbor_neighbor).second;
+             
+             Assert (our_face_no==face_no, ExcInternalError());
+             Assert (our_subface_no==subface_no, ExcInternalError());
+             deallog << "from coarse to fine and back: OK" <<std::endl;
+           }            
+       else if (cell->neighbor(face_no)->level()<cell->level())
+                                          // the neighbor is coarser
+         {
+           const unsigned int neighbor_face_no=cell->neighbor_of_coarser_neighbor(face_no).first;
+           const unsigned int neighbor_subface_no=cell->neighbor_of_coarser_neighbor(face_no).second;
+
+                                            // try to find the way back to our cell
+           const DoFHandler<3>::active_cell_iterator our_cell=cell->neighbor(face_no)->neighbor_child_on_subface(neighbor_face_no,
+                                                                                                                 neighbor_subface_no);
+           Assert (our_cell==cell, ExcInternalError());
+           deallog << "from fine to coarse and back: OK" <<std::endl;
+         }
+  
+         
+}
+
+
+
+void check (Triangulation<3> &tria)
+{
+  (++tria.begin_active())->set_refine_flag ();
+  tria.execute_coarsening_and_refinement ();
+  
+  deallog << "Initial check" << std::endl;
+  check_this (tria);
+  
+  for (unsigned int r=0; r<2; ++r)
+    {
+      tria.refine_global (1);
+      deallog << "Check " << r << std::endl;
+      check_this (tria);
+    }
+
+  coarsen_global (tria);
+  deallog << "Check " << 1 << std::endl;
+  check_this (tria);
+  
+  tria.refine_global (1);
+  deallog << "Check " << 2 << std::endl;
+  check_this (tria);
+}
+
+
+int main () 
+{
+  std::ofstream logfile("mesh_3d_21/output");
+  deallog.attach(logfile);
+  deallog.depth_console(0);
+  deallog.threshold_double(1.e-10);
+
+  {  
+    Triangulation<3> coarse_grid;
+    create_two_cubes (coarse_grid);
+    check (coarse_grid);
+  }
+  
+  {
+    Triangulation<3> coarse_grid;
+    create_two_cubes_rotation (coarse_grid,1);
+    check (coarse_grid);
+  }
+
+  {
+    Triangulation<3> coarse_grid;
+    create_two_cubes_rotation (coarse_grid,2);
+    check (coarse_grid);
+  }
+
+  {
+    Triangulation<3> coarse_grid;
+    create_two_cubes_rotation (coarse_grid,3);
+    check (coarse_grid);
+  }
+
+  {  
+    Triangulation<3> coarse_grid;
+    create_L_shape (coarse_grid);
+    check (coarse_grid);
+  }
+  
+  {  
+    Triangulation<3> coarse_grid;
+    GridGenerator::hyper_ball (coarse_grid);
+    check (coarse_grid);
+  }
+  
+}
+
+  
+  
diff --git a/tests/bits/mesh_3d_21/cmp/generic b/tests/bits/mesh_3d_21/cmp/generic
new file mode 100644 (file)
index 0000000..3d2d9dd
--- /dev/null
@@ -0,0 +1,3639 @@
+
+DEAL::Initial check
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::Check 0
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::Check 1
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::Check 1
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::Check 2
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::Initial check
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::Check 0
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::Check 1
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::Check 1
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::Check 2
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::Initial check
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::Check 0
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::Check 1
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::Check 1
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::Check 2
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::Initial check
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::Check 0
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::Check 1
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::Check 1
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::Check 2
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::Initial check
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::Check 0
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::Check 1
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::Check 1
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::Check 2
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::Initial check
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::Check 0
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::Check 1
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::Check 1
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::Check 2
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from coarse to fine and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK
+DEAL::from fine to coarse and back: OK

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.