From fe892ec850c7ed23642e9c2dc1694ad2af2cafba Mon Sep 17 00:00:00 2001 From: rschulz Date: Fri, 12 May 2006 12:34:34 +0000 Subject: [PATCH] removed old find_active_cell_around point code and improved the new version of the code simultaneously. git-svn-id: https://svn.dealii.org/trunk@13105 0785d39b-7218-0410-832d-ea1e28bc413d --- deal.II/deal.II/include/grid/grid_tools.h | 162 +++------ deal.II/deal.II/source/grid/grid_tools.cc | 82 +---- deal.II/doc/news/changes.html | 11 + tests/bits/find_cell_4.cc | 5 +- tests/bits/find_cell_5.cc | 2 +- tests/bits/find_cell_5/cmp/generic | 3 + tests/bits/find_cell_alt_4/cmp/generic | 4 +- tests/bits/find_cell_alt_6/cmp/generic | 6 +- tests/bits/find_cell_alt_7.cc | 4 +- tests/bits/find_cell_alt_7/cmp/generic | 412 +++++++++++----------- 10 files changed, 301 insertions(+), 390 deletions(-) create mode 100644 tests/bits/find_cell_5/cmp/generic diff --git a/deal.II/deal.II/include/grid/grid_tools.h b/deal.II/deal.II/include/grid/grid_tools.h index 2b7506d6c1..768106a8b2 100644 --- a/deal.II/deal.II/include/grid/grid_tools.h +++ b/deal.II/deal.II/include/grid/grid_tools.h @@ -16,6 +16,7 @@ #include #include +#include #include #include #include @@ -236,92 +237,37 @@ class GridTools find_cells_adjacent_to_vertex(const Container &container, const unsigned int vertex); + /** * Find and return an iterator to * the active cell that surrounds - * a given point @p p. The + * a given point @p ref. The * type of the first parameter * may be either * Triangulation, - * DoFHandler, hp::DoFHandler, or + * DoFHandler, or * MGDoFHandler, i.e. we * can find the cell around a * point for iterators into each * of these classes. * - * The algorithm used in this - * function proceeds by first - * looking for the surrounding - * cell on the coarse grid, and - * then recursively checking its - * sibling cells. The complexity - * is thus O(M+log N) where - * @p M is the number of coarse - * grid cells, and @p N the - * total number of cells. - * - * There are cases where this - * function will not find a given - * point in space dimensions - * higher than one, even though - * it is inside the domain being - * discretized, or will find a - * point that is actually outside - * the domain. The reason for - * this is that we use piecewise - * (bi-,tri-)linear mappings of - * the unit cell to real - * cells. Thus, if a point is - * close to a convex boundary or - * on it, it may not be inside - * any of the cells since they - * have straight boundaries that - * lie entirely inside the - * domain. - * - * Another case for this is that - * a point may not be found even - * though it is actually in one - * of the cells. This may happen, - * if the point is not in one of - * the coarse grid cells, even - * though it is in one of the - * cells on finer levels of the - * triangulation. Note that this - * of course implies that mother - * and child cells do not exactly - * overlap, a case that is - * frequent along curved - * boundaries. In this latter - * case, a different algorithm - * may be used instead that uses - * a linear search over all - * active cells, rather than - * first searching for a coarse - * grid cell. Note, however, that - * such an algorithm has a - * significantly higher numerical - * cost than the logarithmic - * algorithm used here. + * This is solely a wrapper function + * for the @p interpolate function + * given below, + * providing backward compatibility. + * A Q1 mapping is used for the + * boundary, and the iterator to + * the cell in which the point + * resides is returned. * - * Lastly, if a point lies on the - * boundary of two or more cells, - * then the algorithm may return - * with any of these cells. While - * this is in general not really a - * problem, if may be a nuisance - * if the point lies at the - * boundary of cells with - * different refinement levels - * and one would rather like to - * evaluate a solution on the - * cell with more refinement. For - * this, more sophisticated - * algorithms would be necessary, - * though. + * It is recommended to use the + * other version of this function, + * as it simultaneously delivers the + * local coordinate of the given point + * without additional computational cost. */ template - static + inline static typename Container::active_cell_iterator find_active_cell_around_point (const Container &container, const Point &p); @@ -334,24 +280,36 @@ class GridTools * may be either * Triangulation, * DoFHandler, hp::DoFHandler, or - * MGDoFHandler, i.e. we + * MGDoFHandler, i.e., we * can find the cell around a * point for iterators into each * of these classes. * - * This function works with - * arbitrary boundary mappings, - * using a different algorithm than - * the version of this function above. * The algorithm used in this * function proceeds by first - * looking for the vertex that is - * closest to the given point, - * using find_closest_vertex(). - * Then, only in adjacent cells - * to this vertex it is checked - * whether or not the point is - * inside a given cell. + * looking for vertex located + * closest to the given point, see + * find_closest_vertex(). Secondly, + * all adjacent cells to this point + * are found in the mesh, see + * find_cells_adjacent_to_vertex(). + * Lastly, for each of these cells, + * it is tested whether the point is + * inside. This check is performed + * using arbitrary boundary mappings. + * Still, it is possible that due + * to roundoff errors, the point + * cannot be located exactly inside + * the unit cell. In this case, + * even points at a very small + * distance outside the unit cell + * are allowed. + * + * If a point lies on the + * boundary of two or more cells, + * then the algorithm tries to identify + * the cell that is of highest + * refinement level. * * The function returns an * iterator to the cell, as well @@ -361,28 +319,12 @@ class GridTools * might be located slightly * outside an actual unit cell, * due to numerical roundoff. - * - * If a point lies on the - * boundary of two or more cells, - * then the algorithm returns - * the cell (A) in which the local - * coordinate is exactly within the - * unit cell (however, for most - * cases, on the boundary the unit - * cell position will be located - * slightly outside the unit cell) - * or (B) the cell of highest - * refinement level; and if there - * are several cells of the same - * refinement level, then it returns - * (C) the one with the lowest distance - * to the actual unit cell. - * - * However, if you are trying - * to locate a vertex, and if the vertex - * can be matched exactly to a cell, - * it is not guaranteed that the most - * refined cell will be returned. + * Therefore, the point returned + * by this function should + * be projected onto the unit cell, + * using GeometryInfo::project_to_unit_cell. + * This is not automatically performed + * by the algorithm. */ template class Container> static @@ -644,6 +586,14 @@ void GridTools::transform (const Predicate &predicate, } +template +inline +typename Container::active_cell_iterator +GridTools::find_active_cell_around_point (const Container &container, + const Point &p) +{ + return find_active_cell_around_point(StaticMappingQ1::mapping, container, p).first; +} /*---------------------------- grid_tools.h ---------------------------*/ diff --git a/deal.II/deal.II/source/grid/grid_tools.cc b/deal.II/deal.II/source/grid/grid_tools.cc index 714871065e..e4e66ba9f3 100644 --- a/deal.II/deal.II/source/grid/grid_tools.cc +++ b/deal.II/deal.II/source/grid/grid_tools.cc @@ -554,53 +554,6 @@ GridTools::find_cells_adjacent_to_vertex(const Container &container, } -template -typename Container::active_cell_iterator -GridTools::find_active_cell_around_point (const Container &container, - const Point &p) -{ - // first find the coarse grid cell - // that contains the point. we can - // only do this by a linear search - typename Container::cell_iterator cell = container.begin(0); - for (; cell!=container.end(0); ++cell) - if (cell->point_inside (p)) - break; - - // make sure that we found a cell - // in the coarse grid that contains - // this point. for cases where this - // might happen unexpectedly, see - // the documentation of this - // function - AssertThrow (cell != container.end(0), - ExcPointNotFoundInCoarseGrid (p)); - - // now do the logarithmic part of - // the algorithm: go from child to - // grandchild - while (cell->has_children()) - { - const unsigned int n_children=cell->n_children(); - unsigned int c=0; - for (; cchild(c)->point_inside (p)) - break; - - // make sure we found a child - // cell - AssertThrow (c != n_children, ExcPointNotFound (p)); - - // then reset cell to the child - cell = cell->child(c); - } - - // now that we have a terminal - // cell, return it - return cell; -} - - template class Container> std::pair::active_cell_iterator, Point > GridTools::find_active_cell_around_point (const Mapping &mapping, @@ -609,7 +562,12 @@ GridTools::find_active_cell_around_point (const Mapping &mapping, { typedef typename Container::active_cell_iterator cell_iterator; - double best_distance = -1.; + // The best distance is set to the + // maximum allowable distance from + // the unit cell; we assume a + // max. deviation of 1e-10 + double best_distance = 1e-10; + int best_level = -1; std::pair > best_cell; // Find closest vertex and determine @@ -631,32 +589,20 @@ GridTools::find_active_cell_around_point (const Mapping &mapping, // the distance vector to the unit cell. double dist = GeometryInfo::distance_to_unit_cell(p_cell); - // If the point is strictly inside the - // unit cell, the cell can be directly - // returned. - if(dist == 0.0) - return std::make_pair(*cell, p_cell); - - // Otherwise, we will compare the new - // cell with a previously found one; - // If there is not a previous one, take - // the current one directly; if there is, - // only replace it if we have found a more - // refined cell or if we have found a cell - // of the same level, but the distance to - // the unit cell is smaller - else if( best_cell.first.state() != IteratorState::valid || - best_cell.first->level() < (*cell)->level() || - ( best_cell.first->level() == (*cell)->level() && - best_distance > dist ) ) + // We compare if the point is inside the + // unit cell (or at least not too far + // outside). If it is, it is also checked + // that the cell has a more refined state + if(dist <= best_distance + && (*cell)->level() > best_level) { best_distance = dist; + best_level = (*cell)->level(); best_cell = std::make_pair(*cell, p_cell); } } - Assert(best_cell.first.state() == IteratorState::valid, ExcInternalError()); - Assert(best_distance > 0.0, ExcInternalError()); + Assert(best_cell.first.state() == IteratorState::valid, ExcPointNotFound(p)); return best_cell; } diff --git a/deal.II/doc/news/changes.html b/deal.II/doc/news/changes.html index 50f155819d..45b36b6298 100644 --- a/deal.II/doc/news/changes.html +++ b/deal.II/doc/news/changes.html @@ -646,6 +646,17 @@ inconvenience this causes.

deal.II

    +
  1. + Changed: The old version of GridTools::find_active_cell_around_point has been replaced + by a wrapper function for backward compatibility. The wrapper calls the + new version of this function, and it is highly recommended to use the new + version as it automatically delivers also the local coordinate of the + point (so it can save some computation time in most cases as you don't have + to calculate that again). +
    + (Ralf B. Schulz, 2006/05/12) +

  2. Improved: The functions VectorTools::point_value and VectorTools:: - - +#include void check (Triangulation<3> &tria) { @@ -42,7 +41,7 @@ void check (Triangulation<3> &tria) deallog << "<" << cell->vertex(v) << "> "; deallog << std::endl; - Assert (p.distance (cell->center()) < cell->diameter()/2, + Assert (p.distance (cell->center()) < cell->diameter()/2+1e-10, ExcInternalError()); } diff --git a/tests/bits/find_cell_5.cc b/tests/bits/find_cell_5.cc index f5946c32dc..9bc0072b57 100644 --- a/tests/bits/find_cell_5.cc +++ b/tests/bits/find_cell_5.cc @@ -42,7 +42,7 @@ void check (Triangulation<3> &tria) deallog << "<" << cell->vertex(v) << "> "; deallog << std::endl; - Assert (p.distance (cell->center()) < cell->diameter()/2, + Assert (p.distance (cell->center()) < cell->diameter()/2+1e-10, ExcInternalError()); } diff --git a/tests/bits/find_cell_5/cmp/generic b/tests/bits/find_cell_5/cmp/generic new file mode 100644 index 0000000000..13b00480e4 --- /dev/null +++ b/tests/bits/find_cell_5/cmp/generic @@ -0,0 +1,3 @@ + +DEAL::3.455 +DEAL::<0.625000 0.625000 0.625000> <0.750000 0.625000 0.625000> <0.625000 0.750000 0.625000> <0.750000 0.750000 0.625000> diff --git a/tests/bits/find_cell_alt_4/cmp/generic b/tests/bits/find_cell_alt_4/cmp/generic index 943ccd8e97..509909a6c9 100644 --- a/tests/bits/find_cell_alt_4/cmp/generic +++ b/tests/bits/find_cell_alt_4/cmp/generic @@ -1,3 +1,3 @@ -DEAL::3.72 -DEAL::<0.750000 0.00000 0.00000> <0.875000 0.00000 0.00000> <0.750000 0.125000 0.00000> <0.875000 0.125000 0.00000> [ -3.33067e-16 0.00000 5.55112e-17] +DEAL::3.65 +DEAL::<0.625000 0.00000 0.00000> <0.750000 0.00000 0.00000> <0.625000 0.125000 0.00000> <0.750000 0.125000 0.00000> [ 1.00000 0.00000 5.55112e-17] diff --git a/tests/bits/find_cell_alt_6/cmp/generic b/tests/bits/find_cell_alt_6/cmp/generic index dab7ccfba1..7a23ffcc19 100644 --- a/tests/bits/find_cell_alt_6/cmp/generic +++ b/tests/bits/find_cell_alt_6/cmp/generic @@ -3,11 +3,11 @@ DEAL::Vertex <0.00000 0.00000> found in cell <0.00000 0.00000> <0.250000 0.00000 DEAL::Vertex <1.00000 0.00000> found in cell <0.500000 0.00000> <1.00000 0.00000> <0.500000 0.500000> <1.00000 0.500000> [local: 1.00000 0.00000] DEAL::Vertex <0.00000 1.00000> found in cell <0.00000 0.500000> <0.500000 0.500000> <0.00000 1.00000> <0.500000 1.00000> [local: 0.00000 1.00000] DEAL::Vertex <1.00000 1.00000> found in cell <0.500000 0.500000> <1.00000 0.500000> <0.500000 1.00000> <1.00000 1.00000> [local: 1.00000 1.00000] -DEAL::Vertex <0.500000 0.00000> found in cell <0.500000 0.00000> <1.00000 0.00000> <0.500000 0.500000> <1.00000 0.500000> [local: 0.00000 0.00000] -DEAL::Vertex <0.00000 0.500000> found in cell <0.00000 0.500000> <0.500000 0.500000> <0.00000 1.00000> <0.500000 1.00000> [local: 0.00000 0.00000] +DEAL::Vertex <0.500000 0.00000> found in cell <0.250000 0.00000> <0.500000 0.00000> <0.250000 0.250000> <0.500000 0.250000> [local: 1.00000 0.00000] +DEAL::Vertex <0.00000 0.500000> found in cell <0.00000 0.250000> <0.250000 0.250000> <0.00000 0.500000> <0.250000 0.500000> [local: 0.00000 1.00000] DEAL::Vertex <1.00000 0.500000> found in cell <0.500000 0.00000> <1.00000 0.00000> <0.500000 0.500000> <1.00000 0.500000> [local: 1.00000 1.00000] DEAL::Vertex <0.500000 1.00000> found in cell <0.00000 0.500000> <0.500000 0.500000> <0.00000 1.00000> <0.500000 1.00000> [local: 1.00000 1.00000] -DEAL::Vertex <0.500000 0.500000> found in cell <0.500000 0.00000> <1.00000 0.00000> <0.500000 0.500000> <1.00000 0.500000> [local: 0.00000 1.00000] +DEAL::Vertex <0.500000 0.500000> found in cell <0.250000 0.250000> <0.500000 0.250000> <0.250000 0.500000> <0.500000 0.500000> [local: 1.00000 1.00000] DEAL::Vertex <0.250000 0.00000> found in cell <0.00000 0.00000> <0.250000 0.00000> <0.00000 0.250000> <0.250000 0.250000> [local: 1.00000 0.00000] DEAL::Vertex <0.00000 0.250000> found in cell <0.00000 0.00000> <0.250000 0.00000> <0.00000 0.250000> <0.250000 0.250000> [local: 0.00000 1.00000] DEAL::Vertex <0.500000 0.250000> found in cell <0.250000 0.00000> <0.500000 0.00000> <0.250000 0.250000> <0.500000 0.250000> [local: 1.00000 1.00000] diff --git a/tests/bits/find_cell_alt_7.cc b/tests/bits/find_cell_alt_7.cc index 2c1c536adc..3ed761dc1e 100644 --- a/tests/bits/find_cell_alt_7.cc +++ b/tests/bits/find_cell_alt_7.cc @@ -49,7 +49,9 @@ void check (Triangulation<2> &tria) deallog << "<" << cell.first->vertex(v) << "> "; deallog << "[ " << cell.second << "] "; - deallog << std::endl; + // Now transform back and check distance + Point<2> pp = map.transform_unit_to_real_cell(cell.first, GeometryInfo<2>::project_to_unit_cell(cell.second)); + deallog << (pp-p).square() << std::endl; Assert (GeometryInfo<2>::distance_to_unit_cell(cell.second) < 1e-10, ExcInternalError()); diff --git a/tests/bits/find_cell_alt_7/cmp/generic b/tests/bits/find_cell_alt_7/cmp/generic index 36e8a2cfc4..49f3613be4 100644 --- a/tests/bits/find_cell_alt_7/cmp/generic +++ b/tests/bits/find_cell_alt_7/cmp/generic @@ -1,401 +1,401 @@ +DEAL::2.66 +DEAL::<-0.382683 0.923880> <-0.305418 0.694720> <0.00000 1.00000> <0.00000 0.768306> [ 4.31605e-08 1.00000] 0 DEAL::2.72 -DEAL::<0.00000 1.00000> <0.00000 0.768306> <0.382683 0.923880> <0.305418 0.694720> [ 4.31603e-08 1.26953e-19] -DEAL::2.72 -DEAL::<0.00000 1.00000> <0.00000 0.768306> <0.382683 0.923880> <0.305418 0.694720> [ 1.84097e-08 0.0800000] +DEAL::<0.00000 1.00000> <0.00000 0.768306> <0.382683 0.923880> <0.305418 0.694720> [ 1.84097e-08 0.0800000] 0 DEAL::2.72 -DEAL::<0.00000 1.00000> <0.00000 0.768306> <0.382683 0.923880> <0.305418 0.694720> [ 3.03924e-08 0.160000] +DEAL::<0.00000 1.00000> <0.00000 0.768306> <0.382683 0.923880> <0.305418 0.694720> [ 3.03924e-08 0.160000] 0 DEAL::2.72 -DEAL::<0.00000 1.00000> <0.00000 0.768306> <0.382683 0.923880> <0.305418 0.694720> [ 4.02042e-08 0.240000] +DEAL::<0.00000 1.00000> <0.00000 0.768306> <0.382683 0.923880> <0.305418 0.694720> [ 4.02042e-08 0.240000] 0 DEAL::2.72 -DEAL::<0.00000 1.00000> <0.00000 0.768306> <0.382683 0.923880> <0.305418 0.694720> [ 4.01470e-08 0.320000] +DEAL::<0.00000 1.00000> <0.00000 0.768306> <0.382683 0.923880> <0.305418 0.694720> [ 4.01470e-08 0.320000] 0 DEAL::2.72 -DEAL::<0.00000 1.00000> <0.00000 0.768306> <0.382683 0.923880> <0.305418 0.694720> [ 3.46843e-08 0.400000] +DEAL::<0.00000 1.00000> <0.00000 0.768306> <0.382683 0.923880> <0.305418 0.694720> [ 3.46843e-08 0.400000] 0 DEAL::2.72 -DEAL::<0.00000 1.00000> <0.00000 0.768306> <0.382683 0.923880> <0.305418 0.694720> [ 3.06912e-08 0.480000] +DEAL::<0.00000 1.00000> <0.00000 0.768306> <0.382683 0.923880> <0.305418 0.694720> [ 3.06912e-08 0.480000] 0 DEAL::2.72 -DEAL::<0.00000 1.00000> <0.00000 0.768306> <0.382683 0.923880> <0.305418 0.694720> [ 3.20211e-08 0.560000] +DEAL::<0.00000 1.00000> <0.00000 0.768306> <0.382683 0.923880> <0.305418 0.694720> [ 3.20211e-08 0.560000] 0 DEAL::2.72 -DEAL::<0.00000 1.00000> <0.00000 0.768306> <0.382683 0.923880> <0.305418 0.694720> [ 3.72814e-08 0.640000] +DEAL::<0.00000 1.00000> <0.00000 0.768306> <0.382683 0.923880> <0.305418 0.694720> [ 3.72814e-08 0.640000] 0 DEAL::2.72 -DEAL::<0.00000 1.00000> <0.00000 0.768306> <0.382683 0.923880> <0.305418 0.694720> [ 4.06545e-08 0.720000] +DEAL::<0.00000 1.00000> <0.00000 0.768306> <0.382683 0.923880> <0.305418 0.694720> [ 4.06545e-08 0.720000] 0 DEAL::2.72 -DEAL::<0.00000 1.00000> <0.00000 0.768306> <0.382683 0.923880> <0.305418 0.694720> [ 3.57302e-08 0.800000] +DEAL::<0.00000 1.00000> <0.00000 0.768306> <0.382683 0.923880> <0.305418 0.694720> [ 3.57302e-08 0.800000] 0 DEAL::2.72 -DEAL::<0.00000 1.00000> <0.00000 0.768306> <0.382683 0.923880> <0.305418 0.694720> [ 2.26696e-08 0.880000] +DEAL::<0.00000 1.00000> <0.00000 0.768306> <0.382683 0.923880> <0.305418 0.694720> [ 2.26696e-08 0.880000] 0 DEAL::2.72 -DEAL::<0.00000 1.00000> <0.00000 0.768306> <0.382683 0.923880> <0.305418 0.694720> [ 2.08588e-08 0.960000] +DEAL::<0.00000 1.00000> <0.00000 0.768306> <0.382683 0.923880> <0.305418 0.694720> [ 2.08588e-08 0.960000] 0 DEAL::2.74 -DEAL::<0.382683 0.923880> <0.305418 0.694720> <0.707107 0.707107> <0.603553 0.603553> [ 2.11655e-08 0.0400000] +DEAL::<0.382683 0.923880> <0.305418 0.694720> <0.707107 0.707107> <0.603553 0.603553> [ 2.11655e-08 0.0400000] 0 DEAL::2.74 -DEAL::<0.382683 0.923880> <0.305418 0.694720> <0.707107 0.707107> <0.603553 0.603553> [ 2.36330e-08 0.120000] +DEAL::<0.382683 0.923880> <0.305418 0.694720> <0.707107 0.707107> <0.603553 0.603553> [ 2.36330e-08 0.120000] 0 DEAL::2.74 -DEAL::<0.382683 0.923880> <0.305418 0.694720> <0.707107 0.707107> <0.603553 0.603553> [ 3.82243e-08 0.200000] +DEAL::<0.382683 0.923880> <0.305418 0.694720> <0.707107 0.707107> <0.603553 0.603553> [ 3.82243e-08 0.200000] 0 DEAL::2.74 -DEAL::<0.382683 0.923880> <0.305418 0.694720> <0.707107 0.707107> <0.603553 0.603553> [ 4.46313e-08 0.280000] +DEAL::<0.382683 0.923880> <0.305418 0.694720> <0.707107 0.707107> <0.603553 0.603553> [ 4.46313e-08 0.280000] 0 DEAL::2.74 -DEAL::<0.382683 0.923880> <0.305418 0.694720> <0.707107 0.707107> <0.603553 0.603553> [ 4.20239e-08 0.360000] +DEAL::<0.382683 0.923880> <0.305418 0.694720> <0.707107 0.707107> <0.603553 0.603553> [ 4.20239e-08 0.360000] 0 DEAL::2.74 -DEAL::<0.382683 0.923880> <0.305418 0.694720> <0.707107 0.707107> <0.603553 0.603553> [ 3.70938e-08 0.440000] +DEAL::<0.382683 0.923880> <0.305418 0.694720> <0.707107 0.707107> <0.603553 0.603553> [ 3.70938e-08 0.440000] 0 DEAL::2.74 -DEAL::<0.382683 0.923880> <0.305418 0.694720> <0.707107 0.707107> <0.603553 0.603553> [ 3.65795e-08 0.520000] +DEAL::<0.382683 0.923880> <0.305418 0.694720> <0.707107 0.707107> <0.603553 0.603553> [ 3.65795e-08 0.520000] 0 DEAL::2.74 -DEAL::<0.382683 0.923880> <0.305418 0.694720> <0.707107 0.707107> <0.603553 0.603553> [ 4.25986e-08 0.600000] +DEAL::<0.382683 0.923880> <0.305418 0.694720> <0.707107 0.707107> <0.603553 0.603553> [ 4.25986e-08 0.600000] 0 DEAL::2.74 -DEAL::<0.382683 0.923880> <0.305418 0.694720> <0.707107 0.707107> <0.603553 0.603553> [ 5.09321e-08 0.680000] +DEAL::<0.382683 0.923880> <0.305418 0.694720> <0.707107 0.707107> <0.603553 0.603553> [ 5.09321e-08 0.680000] 0 DEAL::2.74 -DEAL::<0.382683 0.923880> <0.305418 0.694720> <0.707107 0.707107> <0.603553 0.603553> [ 5.28968e-08 0.760000] +DEAL::<0.382683 0.923880> <0.305418 0.694720> <0.707107 0.707107> <0.603553 0.603553> [ 5.28968e-08 0.760000] 0 DEAL::2.74 -DEAL::<0.382683 0.923880> <0.305418 0.694720> <0.707107 0.707107> <0.603553 0.603553> [ 4.17687e-08 0.840000] +DEAL::<0.382683 0.923880> <0.305418 0.694720> <0.707107 0.707107> <0.603553 0.603553> [ 4.17687e-08 0.840000] 0 DEAL::2.74 -DEAL::<0.382683 0.923880> <0.305418 0.694720> <0.707107 0.707107> <0.603553 0.603553> [ 2.67834e-08 0.920000] +DEAL::<0.382683 0.923880> <0.305418 0.694720> <0.707107 0.707107> <0.603553 0.603553> [ 2.67834e-08 0.920000] 0 DEAL::2.53 -DEAL::<0.923880 0.382683> <0.707107 0.707107> <0.694720 0.305418> <0.603553 0.603553> [ 1.00000 6.82846e-08] +DEAL::<0.923880 0.382683> <0.707107 0.707107> <0.694720 0.305418> <0.603553 0.603553> [ 1.00000 6.82846e-08] 0 DEAL::2.53 -DEAL::<0.923880 0.382683> <0.707107 0.707107> <0.694720 0.305418> <0.603553 0.603553> [ 0.920000 2.67834e-08] +DEAL::<0.923880 0.382683> <0.707107 0.707107> <0.694720 0.305418> <0.603553 0.603553> [ 0.920000 2.67834e-08] 0 DEAL::2.53 -DEAL::<0.923880 0.382683> <0.707107 0.707107> <0.694720 0.305418> <0.603553 0.603553> [ 0.840000 4.17688e-08] +DEAL::<0.923880 0.382683> <0.707107 0.707107> <0.694720 0.305418> <0.603553 0.603553> [ 0.840000 4.17688e-08] 0 DEAL::2.53 -DEAL::<0.923880 0.382683> <0.707107 0.707107> <0.694720 0.305418> <0.603553 0.603553> [ 0.760000 5.28969e-08] +DEAL::<0.923880 0.382683> <0.707107 0.707107> <0.694720 0.305418> <0.603553 0.603553> [ 0.760000 5.28969e-08] 0 DEAL::2.53 -DEAL::<0.923880 0.382683> <0.707107 0.707107> <0.694720 0.305418> <0.603553 0.603553> [ 0.680000 5.09321e-08] +DEAL::<0.923880 0.382683> <0.707107 0.707107> <0.694720 0.305418> <0.603553 0.603553> [ 0.680000 5.09321e-08] 0 DEAL::2.53 -DEAL::<0.923880 0.382683> <0.707107 0.707107> <0.694720 0.305418> <0.603553 0.603553> [ 0.600000 4.25986e-08] +DEAL::<0.923880 0.382683> <0.707107 0.707107> <0.694720 0.305418> <0.603553 0.603553> [ 0.600000 4.25986e-08] 0 DEAL::2.53 -DEAL::<0.923880 0.382683> <0.707107 0.707107> <0.694720 0.305418> <0.603553 0.603553> [ 0.520000 3.65795e-08] +DEAL::<0.923880 0.382683> <0.707107 0.707107> <0.694720 0.305418> <0.603553 0.603553> [ 0.520000 3.65795e-08] 0 DEAL::2.53 -DEAL::<0.923880 0.382683> <0.707107 0.707107> <0.694720 0.305418> <0.603553 0.603553> [ 0.440000 3.70938e-08] +DEAL::<0.923880 0.382683> <0.707107 0.707107> <0.694720 0.305418> <0.603553 0.603553> [ 0.440000 3.70938e-08] 0 DEAL::2.53 -DEAL::<0.923880 0.382683> <0.707107 0.707107> <0.694720 0.305418> <0.603553 0.603553> [ 0.360000 4.20239e-08] +DEAL::<0.923880 0.382683> <0.707107 0.707107> <0.694720 0.305418> <0.603553 0.603553> [ 0.360000 4.20239e-08] 0 DEAL::2.53 -DEAL::<0.923880 0.382683> <0.707107 0.707107> <0.694720 0.305418> <0.603553 0.603553> [ 0.280000 4.46313e-08] +DEAL::<0.923880 0.382683> <0.707107 0.707107> <0.694720 0.305418> <0.603553 0.603553> [ 0.280000 4.46313e-08] 0 DEAL::2.53 -DEAL::<0.923880 0.382683> <0.707107 0.707107> <0.694720 0.305418> <0.603553 0.603553> [ 0.200000 3.82243e-08] +DEAL::<0.923880 0.382683> <0.707107 0.707107> <0.694720 0.305418> <0.603553 0.603553> [ 0.200000 3.82243e-08] 0 DEAL::2.53 -DEAL::<0.923880 0.382683> <0.707107 0.707107> <0.694720 0.305418> <0.603553 0.603553> [ 0.120000 2.36330e-08] +DEAL::<0.923880 0.382683> <0.707107 0.707107> <0.694720 0.305418> <0.603553 0.603553> [ 0.120000 2.36330e-08] 0 DEAL::2.53 -DEAL::<0.923880 0.382683> <0.707107 0.707107> <0.694720 0.305418> <0.603553 0.603553> [ 0.0400000 2.11655e-08] -DEAL::2.52 -DEAL::<1.00000 0.00000> <0.923880 0.382683> <0.768306 0.00000> <0.694720 0.305418> [ 0.960000 2.08588e-08] +DEAL::<0.923880 0.382683> <0.707107 0.707107> <0.694720 0.305418> <0.603553 0.603553> [ 0.0400000 2.11655e-08] 0 DEAL::2.52 -DEAL::<1.00000 0.00000> <0.923880 0.382683> <0.768306 0.00000> <0.694720 0.305418> [ 0.880000 2.26696e-08] +DEAL::<1.00000 0.00000> <0.923880 0.382683> <0.768306 0.00000> <0.694720 0.305418> [ 0.960000 2.08588e-08] 0 DEAL::2.52 -DEAL::<1.00000 0.00000> <0.923880 0.382683> <0.768306 0.00000> <0.694720 0.305418> [ 0.800000 3.57301e-08] +DEAL::<1.00000 0.00000> <0.923880 0.382683> <0.768306 0.00000> <0.694720 0.305418> [ 0.880000 2.26696e-08] 0 DEAL::2.52 -DEAL::<1.00000 0.00000> <0.923880 0.382683> <0.768306 0.00000> <0.694720 0.305418> [ 0.720000 4.06546e-08] +DEAL::<1.00000 0.00000> <0.923880 0.382683> <0.768306 0.00000> <0.694720 0.305418> [ 0.800000 3.57301e-08] 0 DEAL::2.52 -DEAL::<1.00000 0.00000> <0.923880 0.382683> <0.768306 0.00000> <0.694720 0.305418> [ 0.640000 3.72813e-08] +DEAL::<1.00000 0.00000> <0.923880 0.382683> <0.768306 0.00000> <0.694720 0.305418> [ 0.720000 4.06546e-08] 0 DEAL::2.52 -DEAL::<1.00000 0.00000> <0.923880 0.382683> <0.768306 0.00000> <0.694720 0.305418> [ 0.560000 3.20211e-08] +DEAL::<1.00000 0.00000> <0.923880 0.382683> <0.768306 0.00000> <0.694720 0.305418> [ 0.640000 3.72813e-08] 0 DEAL::2.52 -DEAL::<1.00000 0.00000> <0.923880 0.382683> <0.768306 0.00000> <0.694720 0.305418> [ 0.480000 3.06912e-08] +DEAL::<1.00000 0.00000> <0.923880 0.382683> <0.768306 0.00000> <0.694720 0.305418> [ 0.560000 3.20211e-08] 0 DEAL::2.52 -DEAL::<1.00000 0.00000> <0.923880 0.382683> <0.768306 0.00000> <0.694720 0.305418> [ 0.400000 3.46843e-08] +DEAL::<1.00000 0.00000> <0.923880 0.382683> <0.768306 0.00000> <0.694720 0.305418> [ 0.480000 3.06912e-08] 0 DEAL::2.52 -DEAL::<1.00000 0.00000> <0.923880 0.382683> <0.768306 0.00000> <0.694720 0.305418> [ 0.320000 4.01470e-08] +DEAL::<1.00000 0.00000> <0.923880 0.382683> <0.768306 0.00000> <0.694720 0.305418> [ 0.400000 3.46843e-08] 0 DEAL::2.52 -DEAL::<1.00000 0.00000> <0.923880 0.382683> <0.768306 0.00000> <0.694720 0.305418> [ 0.240000 4.02042e-08] +DEAL::<1.00000 0.00000> <0.923880 0.382683> <0.768306 0.00000> <0.694720 0.305418> [ 0.320000 4.01470e-08] 0 DEAL::2.52 -DEAL::<1.00000 0.00000> <0.923880 0.382683> <0.768306 0.00000> <0.694720 0.305418> [ 0.160000 3.03924e-08] +DEAL::<1.00000 0.00000> <0.923880 0.382683> <0.768306 0.00000> <0.694720 0.305418> [ 0.240000 4.02042e-08] 0 DEAL::2.52 -DEAL::<1.00000 0.00000> <0.923880 0.382683> <0.768306 0.00000> <0.694720 0.305418> [ 0.0800000 1.84097e-08] +DEAL::<1.00000 0.00000> <0.923880 0.382683> <0.768306 0.00000> <0.694720 0.305418> [ 0.160000 3.03924e-08] 0 DEAL::2.52 -DEAL::<1.00000 0.00000> <0.923880 0.382683> <0.768306 0.00000> <0.694720 0.305418> [ 1.60129e-16 4.31603e-08] +DEAL::<1.00000 0.00000> <0.923880 0.382683> <0.768306 0.00000> <0.694720 0.305418> [ 0.0800000 1.84097e-08] 0 DEAL::2.49 -DEAL::<0.923880 -0.382683> <1.00000 0.00000> <0.694720 -0.305418> <0.768306 0.00000> [ 0.920000 1.84097e-08] +DEAL::<0.923880 -0.382683> <1.00000 0.00000> <0.694720 -0.305418> <0.768306 0.00000> [ 1.00000 4.31605e-08] 0 DEAL::2.49 -DEAL::<0.923880 -0.382683> <1.00000 0.00000> <0.694720 -0.305418> <0.768306 0.00000> [ 0.840000 3.03924e-08] +DEAL::<0.923880 -0.382683> <1.00000 0.00000> <0.694720 -0.305418> <0.768306 0.00000> [ 0.920000 1.84097e-08] 0 DEAL::2.49 -DEAL::<0.923880 -0.382683> <1.00000 0.00000> <0.694720 -0.305418> <0.768306 0.00000> [ 0.760000 4.02042e-08] +DEAL::<0.923880 -0.382683> <1.00000 0.00000> <0.694720 -0.305418> <0.768306 0.00000> [ 0.840000 3.03924e-08] 0 DEAL::2.49 -DEAL::<0.923880 -0.382683> <1.00000 0.00000> <0.694720 -0.305418> <0.768306 0.00000> [ 0.680000 4.01470e-08] +DEAL::<0.923880 -0.382683> <1.00000 0.00000> <0.694720 -0.305418> <0.768306 0.00000> [ 0.760000 4.02042e-08] 0 DEAL::2.49 -DEAL::<0.923880 -0.382683> <1.00000 0.00000> <0.694720 -0.305418> <0.768306 0.00000> [ 0.600000 3.46844e-08] +DEAL::<0.923880 -0.382683> <1.00000 0.00000> <0.694720 -0.305418> <0.768306 0.00000> [ 0.680000 4.01470e-08] 0 DEAL::2.49 -DEAL::<0.923880 -0.382683> <1.00000 0.00000> <0.694720 -0.305418> <0.768306 0.00000> [ 0.520000 3.06912e-08] +DEAL::<0.923880 -0.382683> <1.00000 0.00000> <0.694720 -0.305418> <0.768306 0.00000> [ 0.600000 3.46844e-08] 0 DEAL::2.49 -DEAL::<0.923880 -0.382683> <1.00000 0.00000> <0.694720 -0.305418> <0.768306 0.00000> [ 0.440000 3.20211e-08] +DEAL::<0.923880 -0.382683> <1.00000 0.00000> <0.694720 -0.305418> <0.768306 0.00000> [ 0.520000 3.06912e-08] 0 DEAL::2.49 -DEAL::<0.923880 -0.382683> <1.00000 0.00000> <0.694720 -0.305418> <0.768306 0.00000> [ 0.360000 3.72813e-08] +DEAL::<0.923880 -0.382683> <1.00000 0.00000> <0.694720 -0.305418> <0.768306 0.00000> [ 0.440000 3.20211e-08] 0 DEAL::2.49 -DEAL::<0.923880 -0.382683> <1.00000 0.00000> <0.694720 -0.305418> <0.768306 0.00000> [ 0.280000 4.06545e-08] +DEAL::<0.923880 -0.382683> <1.00000 0.00000> <0.694720 -0.305418> <0.768306 0.00000> [ 0.360000 3.72813e-08] 0 DEAL::2.49 -DEAL::<0.923880 -0.382683> <1.00000 0.00000> <0.694720 -0.305418> <0.768306 0.00000> [ 0.200000 3.57301e-08] +DEAL::<0.923880 -0.382683> <1.00000 0.00000> <0.694720 -0.305418> <0.768306 0.00000> [ 0.280000 4.06545e-08] 0 DEAL::2.49 -DEAL::<0.923880 -0.382683> <1.00000 0.00000> <0.694720 -0.305418> <0.768306 0.00000> [ 0.120000 2.26695e-08] +DEAL::<0.923880 -0.382683> <1.00000 0.00000> <0.694720 -0.305418> <0.768306 0.00000> [ 0.200000 3.57301e-08] 0 DEAL::2.49 -DEAL::<0.923880 -0.382683> <1.00000 0.00000> <0.694720 -0.305418> <0.768306 0.00000> [ 0.0400000 2.08586e-08] -DEAL::2.48 -DEAL::<0.707107 -0.707107> <0.923880 -0.382683> <0.603553 -0.603553> <0.694720 -0.305418> [ 0.960000 2.11657e-08] +DEAL::<0.923880 -0.382683> <1.00000 0.00000> <0.694720 -0.305418> <0.768306 0.00000> [ 0.120000 2.26695e-08] 0 +DEAL::2.49 +DEAL::<0.923880 -0.382683> <1.00000 0.00000> <0.694720 -0.305418> <0.768306 0.00000> [ 0.0400000 2.08586e-08] 0 DEAL::2.48 -DEAL::<0.707107 -0.707107> <0.923880 -0.382683> <0.603553 -0.603553> <0.694720 -0.305418> [ 0.880000 2.36331e-08] +DEAL::<0.707107 -0.707107> <0.923880 -0.382683> <0.603553 -0.603553> <0.694720 -0.305418> [ 0.960000 2.11657e-08] 0 DEAL::2.48 -DEAL::<0.707107 -0.707107> <0.923880 -0.382683> <0.603553 -0.603553> <0.694720 -0.305418> [ 0.800000 3.82244e-08] +DEAL::<0.707107 -0.707107> <0.923880 -0.382683> <0.603553 -0.603553> <0.694720 -0.305418> [ 0.880000 2.36331e-08] 0 DEAL::2.48 -DEAL::<0.707107 -0.707107> <0.923880 -0.382683> <0.603553 -0.603553> <0.694720 -0.305418> [ 0.720000 4.46313e-08] +DEAL::<0.707107 -0.707107> <0.923880 -0.382683> <0.603553 -0.603553> <0.694720 -0.305418> [ 0.800000 3.82244e-08] 0 DEAL::2.48 -DEAL::<0.707107 -0.707107> <0.923880 -0.382683> <0.603553 -0.603553> <0.694720 -0.305418> [ 0.640000 4.20239e-08] +DEAL::<0.707107 -0.707107> <0.923880 -0.382683> <0.603553 -0.603553> <0.694720 -0.305418> [ 0.720000 4.46313e-08] 0 DEAL::2.48 -DEAL::<0.707107 -0.707107> <0.923880 -0.382683> <0.603553 -0.603553> <0.694720 -0.305418> [ 0.560000 3.70938e-08] +DEAL::<0.707107 -0.707107> <0.923880 -0.382683> <0.603553 -0.603553> <0.694720 -0.305418> [ 0.640000 4.20239e-08] 0 DEAL::2.48 -DEAL::<0.707107 -0.707107> <0.923880 -0.382683> <0.603553 -0.603553> <0.694720 -0.305418> [ 0.480000 3.65795e-08] +DEAL::<0.707107 -0.707107> <0.923880 -0.382683> <0.603553 -0.603553> <0.694720 -0.305418> [ 0.560000 3.70938e-08] 0 DEAL::2.48 -DEAL::<0.707107 -0.707107> <0.923880 -0.382683> <0.603553 -0.603553> <0.694720 -0.305418> [ 0.400000 4.25986e-08] +DEAL::<0.707107 -0.707107> <0.923880 -0.382683> <0.603553 -0.603553> <0.694720 -0.305418> [ 0.480000 3.65795e-08] 0 DEAL::2.48 -DEAL::<0.707107 -0.707107> <0.923880 -0.382683> <0.603553 -0.603553> <0.694720 -0.305418> [ 0.320000 5.09321e-08] +DEAL::<0.707107 -0.707107> <0.923880 -0.382683> <0.603553 -0.603553> <0.694720 -0.305418> [ 0.400000 4.25986e-08] 0 DEAL::2.48 -DEAL::<0.707107 -0.707107> <0.923880 -0.382683> <0.603553 -0.603553> <0.694720 -0.305418> [ 0.240000 5.28968e-08] +DEAL::<0.707107 -0.707107> <0.923880 -0.382683> <0.603553 -0.603553> <0.694720 -0.305418> [ 0.320000 5.09321e-08] 0 DEAL::2.48 -DEAL::<0.707107 -0.707107> <0.923880 -0.382683> <0.603553 -0.603553> <0.694720 -0.305418> [ 0.160000 4.17686e-08] +DEAL::<0.707107 -0.707107> <0.923880 -0.382683> <0.603553 -0.603553> <0.694720 -0.305418> [ 0.240000 5.28968e-08] 0 DEAL::2.48 -DEAL::<0.707107 -0.707107> <0.923880 -0.382683> <0.603553 -0.603553> <0.694720 -0.305418> [ 0.0800000 2.67832e-08] +DEAL::<0.707107 -0.707107> <0.923880 -0.382683> <0.603553 -0.603553> <0.694720 -0.305418> [ 0.160000 4.17686e-08] 0 DEAL::2.48 -DEAL::<0.707107 -0.707107> <0.923880 -0.382683> <0.603553 -0.603553> <0.694720 -0.305418> [ 2.71333e-16 6.82843e-08] +DEAL::<0.707107 -0.707107> <0.923880 -0.382683> <0.603553 -0.603553> <0.694720 -0.305418> [ 0.0800000 2.67832e-08] 0 DEAL::2.5 -DEAL::<0.382683 -0.923880> <0.707107 -0.707107> <0.305418 -0.694720> <0.603553 -0.603553> [ 0.920000 2.67832e-08] +DEAL::<0.382683 -0.923880> <0.707107 -0.707107> <0.305418 -0.694720> <0.603553 -0.603553> [ 1.00000 6.82846e-08] 0 DEAL::2.5 -DEAL::<0.382683 -0.923880> <0.707107 -0.707107> <0.305418 -0.694720> <0.603553 -0.603553> [ 0.840000 4.17687e-08] +DEAL::<0.382683 -0.923880> <0.707107 -0.707107> <0.305418 -0.694720> <0.603553 -0.603553> [ 0.920000 2.67832e-08] 0 DEAL::2.5 -DEAL::<0.382683 -0.923880> <0.707107 -0.707107> <0.305418 -0.694720> <0.603553 -0.603553> [ 0.760000 5.28968e-08] +DEAL::<0.382683 -0.923880> <0.707107 -0.707107> <0.305418 -0.694720> <0.603553 -0.603553> [ 0.840000 4.17687e-08] 0 DEAL::2.5 -DEAL::<0.382683 -0.923880> <0.707107 -0.707107> <0.305418 -0.694720> <0.603553 -0.603553> [ 0.680000 5.09321e-08] +DEAL::<0.382683 -0.923880> <0.707107 -0.707107> <0.305418 -0.694720> <0.603553 -0.603553> [ 0.760000 5.28968e-08] 0 DEAL::2.5 -DEAL::<0.382683 -0.923880> <0.707107 -0.707107> <0.305418 -0.694720> <0.603553 -0.603553> [ 0.600000 4.25986e-08] +DEAL::<0.382683 -0.923880> <0.707107 -0.707107> <0.305418 -0.694720> <0.603553 -0.603553> [ 0.680000 5.09321e-08] 0 DEAL::2.5 -DEAL::<0.382683 -0.923880> <0.707107 -0.707107> <0.305418 -0.694720> <0.603553 -0.603553> [ 0.520000 3.65795e-08] +DEAL::<0.382683 -0.923880> <0.707107 -0.707107> <0.305418 -0.694720> <0.603553 -0.603553> [ 0.600000 4.25986e-08] 0 DEAL::2.5 -DEAL::<0.382683 -0.923880> <0.707107 -0.707107> <0.305418 -0.694720> <0.603553 -0.603553> [ 0.440000 3.70938e-08] +DEAL::<0.382683 -0.923880> <0.707107 -0.707107> <0.305418 -0.694720> <0.603553 -0.603553> [ 0.520000 3.65795e-08] 0 DEAL::2.5 -DEAL::<0.382683 -0.923880> <0.707107 -0.707107> <0.305418 -0.694720> <0.603553 -0.603553> [ 0.360000 4.20239e-08] +DEAL::<0.382683 -0.923880> <0.707107 -0.707107> <0.305418 -0.694720> <0.603553 -0.603553> [ 0.440000 3.70938e-08] 0 DEAL::2.5 -DEAL::<0.382683 -0.923880> <0.707107 -0.707107> <0.305418 -0.694720> <0.603553 -0.603553> [ 0.280000 4.46313e-08] +DEAL::<0.382683 -0.923880> <0.707107 -0.707107> <0.305418 -0.694720> <0.603553 -0.603553> [ 0.360000 4.20239e-08] 0 DEAL::2.5 -DEAL::<0.382683 -0.923880> <0.707107 -0.707107> <0.305418 -0.694720> <0.603553 -0.603553> [ 0.200000 3.82243e-08] +DEAL::<0.382683 -0.923880> <0.707107 -0.707107> <0.305418 -0.694720> <0.603553 -0.603553> [ 0.280000 4.46313e-08] 0 DEAL::2.5 -DEAL::<0.382683 -0.923880> <0.707107 -0.707107> <0.305418 -0.694720> <0.603553 -0.603553> [ 0.120000 2.36330e-08] +DEAL::<0.382683 -0.923880> <0.707107 -0.707107> <0.305418 -0.694720> <0.603553 -0.603553> [ 0.200000 3.82243e-08] 0 DEAL::2.5 -DEAL::<0.382683 -0.923880> <0.707107 -0.707107> <0.305418 -0.694720> <0.603553 -0.603553> [ 0.0400000 2.11655e-08] -DEAL::2.4 -DEAL::<0.00000 -1.00000> <0.382683 -0.923880> <0.00000 -0.768306> <0.305418 -0.694720> [ 0.960000 2.08588e-08] +DEAL::<0.382683 -0.923880> <0.707107 -0.707107> <0.305418 -0.694720> <0.603553 -0.603553> [ 0.120000 2.36330e-08] 0 +DEAL::2.5 +DEAL::<0.382683 -0.923880> <0.707107 -0.707107> <0.305418 -0.694720> <0.603553 -0.603553> [ 0.0400000 2.11655e-08] 0 DEAL::2.4 -DEAL::<0.00000 -1.00000> <0.382683 -0.923880> <0.00000 -0.768306> <0.305418 -0.694720> [ 0.880000 2.26696e-08] +DEAL::<0.00000 -1.00000> <0.382683 -0.923880> <0.00000 -0.768306> <0.305418 -0.694720> [ 0.960000 2.08588e-08] 0 DEAL::2.4 -DEAL::<0.00000 -1.00000> <0.382683 -0.923880> <0.00000 -0.768306> <0.305418 -0.694720> [ 0.800000 3.57301e-08] +DEAL::<0.00000 -1.00000> <0.382683 -0.923880> <0.00000 -0.768306> <0.305418 -0.694720> [ 0.880000 2.26696e-08] 0 DEAL::2.4 -DEAL::<0.00000 -1.00000> <0.382683 -0.923880> <0.00000 -0.768306> <0.305418 -0.694720> [ 0.720000 4.06545e-08] +DEAL::<0.00000 -1.00000> <0.382683 -0.923880> <0.00000 -0.768306> <0.305418 -0.694720> [ 0.800000 3.57301e-08] 0 DEAL::2.4 -DEAL::<0.00000 -1.00000> <0.382683 -0.923880> <0.00000 -0.768306> <0.305418 -0.694720> [ 0.640000 3.72814e-08] +DEAL::<0.00000 -1.00000> <0.382683 -0.923880> <0.00000 -0.768306> <0.305418 -0.694720> [ 0.720000 4.06545e-08] 0 DEAL::2.4 -DEAL::<0.00000 -1.00000> <0.382683 -0.923880> <0.00000 -0.768306> <0.305418 -0.694720> [ 0.560000 3.20211e-08] +DEAL::<0.00000 -1.00000> <0.382683 -0.923880> <0.00000 -0.768306> <0.305418 -0.694720> [ 0.640000 3.72814e-08] 0 DEAL::2.4 -DEAL::<0.00000 -1.00000> <0.382683 -0.923880> <0.00000 -0.768306> <0.305418 -0.694720> [ 0.480000 3.06912e-08] +DEAL::<0.00000 -1.00000> <0.382683 -0.923880> <0.00000 -0.768306> <0.305418 -0.694720> [ 0.560000 3.20211e-08] 0 DEAL::2.4 -DEAL::<0.00000 -1.00000> <0.382683 -0.923880> <0.00000 -0.768306> <0.305418 -0.694720> [ 0.400000 3.46843e-08] +DEAL::<0.00000 -1.00000> <0.382683 -0.923880> <0.00000 -0.768306> <0.305418 -0.694720> [ 0.480000 3.06912e-08] 0 DEAL::2.4 -DEAL::<0.00000 -1.00000> <0.382683 -0.923880> <0.00000 -0.768306> <0.305418 -0.694720> [ 0.320000 4.01470e-08] +DEAL::<0.00000 -1.00000> <0.382683 -0.923880> <0.00000 -0.768306> <0.305418 -0.694720> [ 0.400000 3.46843e-08] 0 DEAL::2.4 -DEAL::<0.00000 -1.00000> <0.382683 -0.923880> <0.00000 -0.768306> <0.305418 -0.694720> [ 0.240000 4.02041e-08] +DEAL::<0.00000 -1.00000> <0.382683 -0.923880> <0.00000 -0.768306> <0.305418 -0.694720> [ 0.320000 4.01470e-08] 0 DEAL::2.4 -DEAL::<0.00000 -1.00000> <0.382683 -0.923880> <0.00000 -0.768306> <0.305418 -0.694720> [ 0.160000 3.03924e-08] +DEAL::<0.00000 -1.00000> <0.382683 -0.923880> <0.00000 -0.768306> <0.305418 -0.694720> [ 0.240000 4.02041e-08] 0 DEAL::2.4 -DEAL::<0.00000 -1.00000> <0.382683 -0.923880> <0.00000 -0.768306> <0.305418 -0.694720> [ 0.0800000 1.84097e-08] +DEAL::<0.00000 -1.00000> <0.382683 -0.923880> <0.00000 -0.768306> <0.305418 -0.694720> [ 0.160000 3.03924e-08] 0 DEAL::2.4 -DEAL::<0.00000 -1.00000> <0.382683 -0.923880> <0.00000 -0.768306> <0.305418 -0.694720> [ 3.20132e-16 4.31603e-08] +DEAL::<0.00000 -1.00000> <0.382683 -0.923880> <0.00000 -0.768306> <0.305418 -0.694720> [ 0.0800000 1.84097e-08] 0 +DEAL::2.1 +DEAL::<-0.382683 -0.923880> <0.00000 -1.00000> <-0.305418 -0.694720> <0.00000 -0.768306> [ 1.00000 4.31605e-08] 0 DEAL::2.1 -DEAL::<-0.382683 -0.923880> <0.00000 -1.00000> <-0.305418 -0.694720> <0.00000 -0.768306> [ 0.920000 1.84098e-08] +DEAL::<-0.382683 -0.923880> <0.00000 -1.00000> <-0.305418 -0.694720> <0.00000 -0.768306> [ 0.920000 1.84098e-08] 0 DEAL::2.1 -DEAL::<-0.382683 -0.923880> <0.00000 -1.00000> <-0.305418 -0.694720> <0.00000 -0.768306> [ 0.840000 3.03925e-08] +DEAL::<-0.382683 -0.923880> <0.00000 -1.00000> <-0.305418 -0.694720> <0.00000 -0.768306> [ 0.840000 3.03925e-08] 0 DEAL::2.1 -DEAL::<-0.382683 -0.923880> <0.00000 -1.00000> <-0.305418 -0.694720> <0.00000 -0.768306> [ 0.760000 4.02042e-08] +DEAL::<-0.382683 -0.923880> <0.00000 -1.00000> <-0.305418 -0.694720> <0.00000 -0.768306> [ 0.760000 4.02042e-08] 0 DEAL::2.1 -DEAL::<-0.382683 -0.923880> <0.00000 -1.00000> <-0.305418 -0.694720> <0.00000 -0.768306> [ 0.680000 4.01471e-08] +DEAL::<-0.382683 -0.923880> <0.00000 -1.00000> <-0.305418 -0.694720> <0.00000 -0.768306> [ 0.680000 4.01471e-08] 0 DEAL::2.1 -DEAL::<-0.382683 -0.923880> <0.00000 -1.00000> <-0.305418 -0.694720> <0.00000 -0.768306> [ 0.600000 3.46844e-08] +DEAL::<-0.382683 -0.923880> <0.00000 -1.00000> <-0.305418 -0.694720> <0.00000 -0.768306> [ 0.600000 3.46844e-08] 0 DEAL::2.1 -DEAL::<-0.382683 -0.923880> <0.00000 -1.00000> <-0.305418 -0.694720> <0.00000 -0.768306> [ 0.520000 3.06912e-08] +DEAL::<-0.382683 -0.923880> <0.00000 -1.00000> <-0.305418 -0.694720> <0.00000 -0.768306> [ 0.520000 3.06912e-08] 0 DEAL::2.1 -DEAL::<-0.382683 -0.923880> <0.00000 -1.00000> <-0.305418 -0.694720> <0.00000 -0.768306> [ 0.440000 3.20211e-08] +DEAL::<-0.382683 -0.923880> <0.00000 -1.00000> <-0.305418 -0.694720> <0.00000 -0.768306> [ 0.440000 3.20211e-08] 0 DEAL::2.1 -DEAL::<-0.382683 -0.923880> <0.00000 -1.00000> <-0.305418 -0.694720> <0.00000 -0.768306> [ 0.360000 3.72813e-08] +DEAL::<-0.382683 -0.923880> <0.00000 -1.00000> <-0.305418 -0.694720> <0.00000 -0.768306> [ 0.360000 3.72813e-08] 0 DEAL::2.1 -DEAL::<-0.382683 -0.923880> <0.00000 -1.00000> <-0.305418 -0.694720> <0.00000 -0.768306> [ 0.280000 4.06545e-08] +DEAL::<-0.382683 -0.923880> <0.00000 -1.00000> <-0.305418 -0.694720> <0.00000 -0.768306> [ 0.280000 4.06545e-08] 0 DEAL::2.1 -DEAL::<-0.382683 -0.923880> <0.00000 -1.00000> <-0.305418 -0.694720> <0.00000 -0.768306> [ 0.200000 3.57301e-08] +DEAL::<-0.382683 -0.923880> <0.00000 -1.00000> <-0.305418 -0.694720> <0.00000 -0.768306> [ 0.200000 3.57301e-08] 0 DEAL::2.1 -DEAL::<-0.382683 -0.923880> <0.00000 -1.00000> <-0.305418 -0.694720> <0.00000 -0.768306> [ 0.120000 2.26695e-08] +DEAL::<-0.382683 -0.923880> <0.00000 -1.00000> <-0.305418 -0.694720> <0.00000 -0.768306> [ 0.120000 2.26695e-08] 0 DEAL::2.1 -DEAL::<-0.382683 -0.923880> <0.00000 -1.00000> <-0.305418 -0.694720> <0.00000 -0.768306> [ 0.0400000 2.08586e-08] +DEAL::<-0.382683 -0.923880> <0.00000 -1.00000> <-0.305418 -0.694720> <0.00000 -0.768306> [ 0.0400000 2.08586e-08] 0 DEAL::2.0 -DEAL::<-0.707107 -0.707107> <-0.382683 -0.923880> <-0.603553 -0.603553> <-0.305418 -0.694720> [ 0.960000 2.11656e-08] +DEAL::<-0.707107 -0.707107> <-0.382683 -0.923880> <-0.603553 -0.603553> <-0.305418 -0.694720> [ 0.960000 2.11656e-08] 0 DEAL::2.0 -DEAL::<-0.707107 -0.707107> <-0.382683 -0.923880> <-0.603553 -0.603553> <-0.305418 -0.694720> [ 0.880000 2.36332e-08] +DEAL::<-0.707107 -0.707107> <-0.382683 -0.923880> <-0.603553 -0.603553> <-0.305418 -0.694720> [ 0.880000 2.36332e-08] 0 DEAL::2.0 -DEAL::<-0.707107 -0.707107> <-0.382683 -0.923880> <-0.603553 -0.603553> <-0.305418 -0.694720> [ 0.800000 3.82244e-08] +DEAL::<-0.707107 -0.707107> <-0.382683 -0.923880> <-0.603553 -0.603553> <-0.305418 -0.694720> [ 0.800000 3.82244e-08] 0 DEAL::2.0 -DEAL::<-0.707107 -0.707107> <-0.382683 -0.923880> <-0.603553 -0.603553> <-0.305418 -0.694720> [ 0.720000 4.46314e-08] +DEAL::<-0.707107 -0.707107> <-0.382683 -0.923880> <-0.603553 -0.603553> <-0.305418 -0.694720> [ 0.720000 4.46314e-08] 0 DEAL::2.0 -DEAL::<-0.707107 -0.707107> <-0.382683 -0.923880> <-0.603553 -0.603553> <-0.305418 -0.694720> [ 0.640000 4.20239e-08] +DEAL::<-0.707107 -0.707107> <-0.382683 -0.923880> <-0.603553 -0.603553> <-0.305418 -0.694720> [ 0.640000 4.20239e-08] 0 DEAL::2.0 -DEAL::<-0.707107 -0.707107> <-0.382683 -0.923880> <-0.603553 -0.603553> <-0.305418 -0.694720> [ 0.560000 3.70938e-08] +DEAL::<-0.707107 -0.707107> <-0.382683 -0.923880> <-0.603553 -0.603553> <-0.305418 -0.694720> [ 0.560000 3.70938e-08] 0 DEAL::2.0 -DEAL::<-0.707107 -0.707107> <-0.382683 -0.923880> <-0.603553 -0.603553> <-0.305418 -0.694720> [ 0.480000 3.65795e-08] +DEAL::<-0.707107 -0.707107> <-0.382683 -0.923880> <-0.603553 -0.603553> <-0.305418 -0.694720> [ 0.480000 3.65795e-08] 0 DEAL::2.0 -DEAL::<-0.707107 -0.707107> <-0.382683 -0.923880> <-0.603553 -0.603553> <-0.305418 -0.694720> [ 0.400000 4.25986e-08] +DEAL::<-0.707107 -0.707107> <-0.382683 -0.923880> <-0.603553 -0.603553> <-0.305418 -0.694720> [ 0.400000 4.25986e-08] 0 DEAL::2.0 -DEAL::<-0.707107 -0.707107> <-0.382683 -0.923880> <-0.603553 -0.603553> <-0.305418 -0.694720> [ 0.320000 5.09320e-08] +DEAL::<-0.707107 -0.707107> <-0.382683 -0.923880> <-0.603553 -0.603553> <-0.305418 -0.694720> [ 0.320000 5.09320e-08] 0 DEAL::2.0 -DEAL::<-0.707107 -0.707107> <-0.382683 -0.923880> <-0.603553 -0.603553> <-0.305418 -0.694720> [ 0.240000 5.28968e-08] +DEAL::<-0.707107 -0.707107> <-0.382683 -0.923880> <-0.603553 -0.603553> <-0.305418 -0.694720> [ 0.240000 5.28968e-08] 0 DEAL::2.0 -DEAL::<-0.707107 -0.707107> <-0.382683 -0.923880> <-0.603553 -0.603553> <-0.305418 -0.694720> [ 0.160000 4.17686e-08] +DEAL::<-0.707107 -0.707107> <-0.382683 -0.923880> <-0.603553 -0.603553> <-0.305418 -0.694720> [ 0.160000 4.17686e-08] 0 DEAL::2.0 -DEAL::<-0.707107 -0.707107> <-0.382683 -0.923880> <-0.603553 -0.603553> <-0.305418 -0.694720> [ 0.0800000 2.67832e-08] +DEAL::<-0.707107 -0.707107> <-0.382683 -0.923880> <-0.603553 -0.603553> <-0.305418 -0.694720> [ 0.0800000 2.67832e-08] 0 DEAL::2.0 -DEAL::<-0.707107 -0.707107> <-0.382683 -0.923880> <-0.603553 -0.603553> <-0.305418 -0.694720> [ 3.44180e-16 6.82843e-08] +DEAL::<-0.707107 -0.707107> <-0.382683 -0.923880> <-0.603553 -0.603553> <-0.305418 -0.694720> [ 3.44180e-16 6.82843e-08] 0 DEAL::2.16 -DEAL::<-0.707107 -0.707107> <-0.603553 -0.603553> <-0.923880 -0.382683> <-0.694720 -0.305418> [ 2.67832e-08 0.0800000] +DEAL::<-0.707107 -0.707107> <-0.603553 -0.603553> <-0.923880 -0.382683> <-0.694720 -0.305418> [ 2.67832e-08 0.0800000] 0 DEAL::2.16 -DEAL::<-0.707107 -0.707107> <-0.603553 -0.603553> <-0.923880 -0.382683> <-0.694720 -0.305418> [ 4.17686e-08 0.160000] +DEAL::<-0.707107 -0.707107> <-0.603553 -0.603553> <-0.923880 -0.382683> <-0.694720 -0.305418> [ 4.17686e-08 0.160000] 0 DEAL::2.16 -DEAL::<-0.707107 -0.707107> <-0.603553 -0.603553> <-0.923880 -0.382683> <-0.694720 -0.305418> [ 5.28968e-08 0.240000] +DEAL::<-0.707107 -0.707107> <-0.603553 -0.603553> <-0.923880 -0.382683> <-0.694720 -0.305418> [ 5.28968e-08 0.240000] 0 DEAL::2.16 -DEAL::<-0.707107 -0.707107> <-0.603553 -0.603553> <-0.923880 -0.382683> <-0.694720 -0.305418> [ 5.09320e-08 0.320000] +DEAL::<-0.707107 -0.707107> <-0.603553 -0.603553> <-0.923880 -0.382683> <-0.694720 -0.305418> [ 5.09320e-08 0.320000] 0 DEAL::2.16 -DEAL::<-0.707107 -0.707107> <-0.603553 -0.603553> <-0.923880 -0.382683> <-0.694720 -0.305418> [ 4.25986e-08 0.400000] +DEAL::<-0.707107 -0.707107> <-0.603553 -0.603553> <-0.923880 -0.382683> <-0.694720 -0.305418> [ 4.25986e-08 0.400000] 0 DEAL::2.16 -DEAL::<-0.707107 -0.707107> <-0.603553 -0.603553> <-0.923880 -0.382683> <-0.694720 -0.305418> [ 3.65795e-08 0.480000] +DEAL::<-0.707107 -0.707107> <-0.603553 -0.603553> <-0.923880 -0.382683> <-0.694720 -0.305418> [ 3.65795e-08 0.480000] 0 DEAL::2.16 -DEAL::<-0.707107 -0.707107> <-0.603553 -0.603553> <-0.923880 -0.382683> <-0.694720 -0.305418> [ 3.70938e-08 0.560000] +DEAL::<-0.707107 -0.707107> <-0.603553 -0.603553> <-0.923880 -0.382683> <-0.694720 -0.305418> [ 3.70938e-08 0.560000] 0 DEAL::2.16 -DEAL::<-0.707107 -0.707107> <-0.603553 -0.603553> <-0.923880 -0.382683> <-0.694720 -0.305418> [ 4.20239e-08 0.640000] +DEAL::<-0.707107 -0.707107> <-0.603553 -0.603553> <-0.923880 -0.382683> <-0.694720 -0.305418> [ 4.20239e-08 0.640000] 0 DEAL::2.16 -DEAL::<-0.707107 -0.707107> <-0.603553 -0.603553> <-0.923880 -0.382683> <-0.694720 -0.305418> [ 4.46313e-08 0.720000] +DEAL::<-0.707107 -0.707107> <-0.603553 -0.603553> <-0.923880 -0.382683> <-0.694720 -0.305418> [ 4.46313e-08 0.720000] 0 DEAL::2.16 -DEAL::<-0.707107 -0.707107> <-0.603553 -0.603553> <-0.923880 -0.382683> <-0.694720 -0.305418> [ 3.82244e-08 0.800000] +DEAL::<-0.707107 -0.707107> <-0.603553 -0.603553> <-0.923880 -0.382683> <-0.694720 -0.305418> [ 3.82244e-08 0.800000] 0 DEAL::2.16 -DEAL::<-0.707107 -0.707107> <-0.603553 -0.603553> <-0.923880 -0.382683> <-0.694720 -0.305418> [ 2.36331e-08 0.880000] +DEAL::<-0.707107 -0.707107> <-0.603553 -0.603553> <-0.923880 -0.382683> <-0.694720 -0.305418> [ 2.36331e-08 0.880000] 0 DEAL::2.16 -DEAL::<-0.707107 -0.707107> <-0.603553 -0.603553> <-0.923880 -0.382683> <-0.694720 -0.305418> [ 2.11658e-08 0.960000] +DEAL::<-0.707107 -0.707107> <-0.603553 -0.603553> <-0.923880 -0.382683> <-0.694720 -0.305418> [ 2.11658e-08 0.960000] 0 DEAL::2.18 -DEAL::<-0.923880 -0.382683> <-0.694720 -0.305418> <-1.00000 0.00000> <-0.768306 0.00000> [ 2.08586e-08 0.0400000] +DEAL::<-0.923880 -0.382683> <-0.694720 -0.305418> <-1.00000 0.00000> <-0.768306 0.00000> [ 2.08586e-08 0.0400000] 0 DEAL::2.18 -DEAL::<-0.923880 -0.382683> <-0.694720 -0.305418> <-1.00000 0.00000> <-0.768306 0.00000> [ 2.26695e-08 0.120000] +DEAL::<-0.923880 -0.382683> <-0.694720 -0.305418> <-1.00000 0.00000> <-0.768306 0.00000> [ 2.26695e-08 0.120000] 0 DEAL::2.18 -DEAL::<-0.923880 -0.382683> <-0.694720 -0.305418> <-1.00000 0.00000> <-0.768306 0.00000> [ 3.57301e-08 0.200000] +DEAL::<-0.923880 -0.382683> <-0.694720 -0.305418> <-1.00000 0.00000> <-0.768306 0.00000> [ 3.57301e-08 0.200000] 0 DEAL::2.18 -DEAL::<-0.923880 -0.382683> <-0.694720 -0.305418> <-1.00000 0.00000> <-0.768306 0.00000> [ 4.06545e-08 0.280000] +DEAL::<-0.923880 -0.382683> <-0.694720 -0.305418> <-1.00000 0.00000> <-0.768306 0.00000> [ 4.06545e-08 0.280000] 0 DEAL::2.18 -DEAL::<-0.923880 -0.382683> <-0.694720 -0.305418> <-1.00000 0.00000> <-0.768306 0.00000> [ 3.72813e-08 0.360000] +DEAL::<-0.923880 -0.382683> <-0.694720 -0.305418> <-1.00000 0.00000> <-0.768306 0.00000> [ 3.72813e-08 0.360000] 0 DEAL::2.18 -DEAL::<-0.923880 -0.382683> <-0.694720 -0.305418> <-1.00000 0.00000> <-0.768306 0.00000> [ 3.20211e-08 0.440000] +DEAL::<-0.923880 -0.382683> <-0.694720 -0.305418> <-1.00000 0.00000> <-0.768306 0.00000> [ 3.20211e-08 0.440000] 0 DEAL::2.18 -DEAL::<-0.923880 -0.382683> <-0.694720 -0.305418> <-1.00000 0.00000> <-0.768306 0.00000> [ 3.06912e-08 0.520000] +DEAL::<-0.923880 -0.382683> <-0.694720 -0.305418> <-1.00000 0.00000> <-0.768306 0.00000> [ 3.06912e-08 0.520000] 0 DEAL::2.18 -DEAL::<-0.923880 -0.382683> <-0.694720 -0.305418> <-1.00000 0.00000> <-0.768306 0.00000> [ 3.46843e-08 0.600000] +DEAL::<-0.923880 -0.382683> <-0.694720 -0.305418> <-1.00000 0.00000> <-0.768306 0.00000> [ 3.46843e-08 0.600000] 0 DEAL::2.18 -DEAL::<-0.923880 -0.382683> <-0.694720 -0.305418> <-1.00000 0.00000> <-0.768306 0.00000> [ 4.01471e-08 0.680000] +DEAL::<-0.923880 -0.382683> <-0.694720 -0.305418> <-1.00000 0.00000> <-0.768306 0.00000> [ 4.01471e-08 0.680000] 0 DEAL::2.18 -DEAL::<-0.923880 -0.382683> <-0.694720 -0.305418> <-1.00000 0.00000> <-0.768306 0.00000> [ 4.02042e-08 0.760000] +DEAL::<-0.923880 -0.382683> <-0.694720 -0.305418> <-1.00000 0.00000> <-0.768306 0.00000> [ 4.02042e-08 0.760000] 0 DEAL::2.18 -DEAL::<-0.923880 -0.382683> <-0.694720 -0.305418> <-1.00000 0.00000> <-0.768306 0.00000> [ 3.03924e-08 0.840000] +DEAL::<-0.923880 -0.382683> <-0.694720 -0.305418> <-1.00000 0.00000> <-0.768306 0.00000> [ 3.03924e-08 0.840000] 0 DEAL::2.18 -DEAL::<-0.923880 -0.382683> <-0.694720 -0.305418> <-1.00000 0.00000> <-0.768306 0.00000> [ 1.84097e-08 0.920000] -DEAL::2.24 -DEAL::<-1.00000 0.00000> <-0.768306 0.00000> <-0.923880 0.382683> <-0.694720 0.305418> [ 4.31603e-08 -4.79881e-16] +DEAL::<-0.923880 -0.382683> <-0.694720 -0.305418> <-1.00000 0.00000> <-0.768306 0.00000> [ 1.84097e-08 0.920000] 0 +DEAL::2.18 +DEAL::<-0.923880 -0.382683> <-0.694720 -0.305418> <-1.00000 0.00000> <-0.768306 0.00000> [ 4.31605e-08 1.00000] 0 DEAL::2.24 -DEAL::<-1.00000 0.00000> <-0.768306 0.00000> <-0.923880 0.382683> <-0.694720 0.305418> [ 1.84097e-08 0.0800000] +DEAL::<-1.00000 0.00000> <-0.768306 0.00000> <-0.923880 0.382683> <-0.694720 0.305418> [ 1.84097e-08 0.0800000] 0 DEAL::2.24 -DEAL::<-1.00000 0.00000> <-0.768306 0.00000> <-0.923880 0.382683> <-0.694720 0.305418> [ 3.03924e-08 0.160000] +DEAL::<-1.00000 0.00000> <-0.768306 0.00000> <-0.923880 0.382683> <-0.694720 0.305418> [ 3.03924e-08 0.160000] 0 DEAL::2.24 -DEAL::<-1.00000 0.00000> <-0.768306 0.00000> <-0.923880 0.382683> <-0.694720 0.305418> [ 4.02041e-08 0.240000] +DEAL::<-1.00000 0.00000> <-0.768306 0.00000> <-0.923880 0.382683> <-0.694720 0.305418> [ 4.02041e-08 0.240000] 0 DEAL::2.24 -DEAL::<-1.00000 0.00000> <-0.768306 0.00000> <-0.923880 0.382683> <-0.694720 0.305418> [ 4.01470e-08 0.320000] +DEAL::<-1.00000 0.00000> <-0.768306 0.00000> <-0.923880 0.382683> <-0.694720 0.305418> [ 4.01470e-08 0.320000] 0 DEAL::2.24 -DEAL::<-1.00000 0.00000> <-0.768306 0.00000> <-0.923880 0.382683> <-0.694720 0.305418> [ 3.46843e-08 0.400000] +DEAL::<-1.00000 0.00000> <-0.768306 0.00000> <-0.923880 0.382683> <-0.694720 0.305418> [ 3.46843e-08 0.400000] 0 DEAL::2.24 -DEAL::<-1.00000 0.00000> <-0.768306 0.00000> <-0.923880 0.382683> <-0.694720 0.305418> [ 3.06912e-08 0.480000] +DEAL::<-1.00000 0.00000> <-0.768306 0.00000> <-0.923880 0.382683> <-0.694720 0.305418> [ 3.06912e-08 0.480000] 0 DEAL::2.24 -DEAL::<-1.00000 0.00000> <-0.768306 0.00000> <-0.923880 0.382683> <-0.694720 0.305418> [ 3.20211e-08 0.560000] +DEAL::<-1.00000 0.00000> <-0.768306 0.00000> <-0.923880 0.382683> <-0.694720 0.305418> [ 3.20211e-08 0.560000] 0 DEAL::2.24 -DEAL::<-1.00000 0.00000> <-0.768306 0.00000> <-0.923880 0.382683> <-0.694720 0.305418> [ 3.72814e-08 0.640000] +DEAL::<-1.00000 0.00000> <-0.768306 0.00000> <-0.923880 0.382683> <-0.694720 0.305418> [ 3.72814e-08 0.640000] 0 DEAL::2.24 -DEAL::<-1.00000 0.00000> <-0.768306 0.00000> <-0.923880 0.382683> <-0.694720 0.305418> [ 4.06545e-08 0.720000] +DEAL::<-1.00000 0.00000> <-0.768306 0.00000> <-0.923880 0.382683> <-0.694720 0.305418> [ 4.06545e-08 0.720000] 0 DEAL::2.24 -DEAL::<-1.00000 0.00000> <-0.768306 0.00000> <-0.923880 0.382683> <-0.694720 0.305418> [ 3.57302e-08 0.800000] +DEAL::<-1.00000 0.00000> <-0.768306 0.00000> <-0.923880 0.382683> <-0.694720 0.305418> [ 3.57302e-08 0.800000] 0 DEAL::2.24 -DEAL::<-1.00000 0.00000> <-0.768306 0.00000> <-0.923880 0.382683> <-0.694720 0.305418> [ 2.26697e-08 0.880000] +DEAL::<-1.00000 0.00000> <-0.768306 0.00000> <-0.923880 0.382683> <-0.694720 0.305418> [ 2.26697e-08 0.880000] 0 DEAL::2.24 -DEAL::<-1.00000 0.00000> <-0.768306 0.00000> <-0.923880 0.382683> <-0.694720 0.305418> [ 2.08587e-08 0.960000] +DEAL::<-1.00000 0.00000> <-0.768306 0.00000> <-0.923880 0.382683> <-0.694720 0.305418> [ 2.08587e-08 0.960000] 0 DEAL::2.26 -DEAL::<-0.923880 0.382683> <-0.694720 0.305418> <-0.707107 0.707107> <-0.603553 0.603553> [ 2.11655e-08 0.0400000] +DEAL::<-0.923880 0.382683> <-0.694720 0.305418> <-0.707107 0.707107> <-0.603553 0.603553> [ 2.11655e-08 0.0400000] 0 DEAL::2.26 -DEAL::<-0.923880 0.382683> <-0.694720 0.305418> <-0.707107 0.707107> <-0.603553 0.603553> [ 2.36330e-08 0.120000] +DEAL::<-0.923880 0.382683> <-0.694720 0.305418> <-0.707107 0.707107> <-0.603553 0.603553> [ 2.36330e-08 0.120000] 0 DEAL::2.26 -DEAL::<-0.923880 0.382683> <-0.694720 0.305418> <-0.707107 0.707107> <-0.603553 0.603553> [ 3.82243e-08 0.200000] +DEAL::<-0.923880 0.382683> <-0.694720 0.305418> <-0.707107 0.707107> <-0.603553 0.603553> [ 3.82243e-08 0.200000] 0 DEAL::2.26 -DEAL::<-0.923880 0.382683> <-0.694720 0.305418> <-0.707107 0.707107> <-0.603553 0.603553> [ 4.46313e-08 0.280000] +DEAL::<-0.923880 0.382683> <-0.694720 0.305418> <-0.707107 0.707107> <-0.603553 0.603553> [ 4.46313e-08 0.280000] 0 DEAL::2.26 -DEAL::<-0.923880 0.382683> <-0.694720 0.305418> <-0.707107 0.707107> <-0.603553 0.603553> [ 4.20239e-08 0.360000] +DEAL::<-0.923880 0.382683> <-0.694720 0.305418> <-0.707107 0.707107> <-0.603553 0.603553> [ 4.20239e-08 0.360000] 0 DEAL::2.26 -DEAL::<-0.923880 0.382683> <-0.694720 0.305418> <-0.707107 0.707107> <-0.603553 0.603553> [ 3.70938e-08 0.440000] +DEAL::<-0.923880 0.382683> <-0.694720 0.305418> <-0.707107 0.707107> <-0.603553 0.603553> [ 3.70938e-08 0.440000] 0 DEAL::2.26 -DEAL::<-0.923880 0.382683> <-0.694720 0.305418> <-0.707107 0.707107> <-0.603553 0.603553> [ 3.65795e-08 0.520000] +DEAL::<-0.923880 0.382683> <-0.694720 0.305418> <-0.707107 0.707107> <-0.603553 0.603553> [ 3.65795e-08 0.520000] 0 DEAL::2.26 -DEAL::<-0.923880 0.382683> <-0.694720 0.305418> <-0.707107 0.707107> <-0.603553 0.603553> [ 4.25986e-08 0.600000] +DEAL::<-0.923880 0.382683> <-0.694720 0.305418> <-0.707107 0.707107> <-0.603553 0.603553> [ 4.25986e-08 0.600000] 0 DEAL::2.26 -DEAL::<-0.923880 0.382683> <-0.694720 0.305418> <-0.707107 0.707107> <-0.603553 0.603553> [ 5.09321e-08 0.680000] +DEAL::<-0.923880 0.382683> <-0.694720 0.305418> <-0.707107 0.707107> <-0.603553 0.603553> [ 5.09321e-08 0.680000] 0 DEAL::2.26 -DEAL::<-0.923880 0.382683> <-0.694720 0.305418> <-0.707107 0.707107> <-0.603553 0.603553> [ 5.28969e-08 0.760000] +DEAL::<-0.923880 0.382683> <-0.694720 0.305418> <-0.707107 0.707107> <-0.603553 0.603553> [ 5.28969e-08 0.760000] 0 DEAL::2.26 -DEAL::<-0.923880 0.382683> <-0.694720 0.305418> <-0.707107 0.707107> <-0.603553 0.603553> [ 4.17687e-08 0.840000] +DEAL::<-0.923880 0.382683> <-0.694720 0.305418> <-0.707107 0.707107> <-0.603553 0.603553> [ 4.17687e-08 0.840000] 0 DEAL::2.26 -DEAL::<-0.923880 0.382683> <-0.694720 0.305418> <-0.707107 0.707107> <-0.603553 0.603553> [ 2.67835e-08 0.920000] -DEAL::2.64 -DEAL::<-0.707107 0.707107> <-0.603553 0.603553> <-0.382683 0.923880> <-0.305418 0.694720> [ 6.82843e-08 -5.24473e-16] +DEAL::<-0.923880 0.382683> <-0.694720 0.305418> <-0.707107 0.707107> <-0.603553 0.603553> [ 2.67835e-08 0.920000] 0 +DEAL::2.26 +DEAL::<-0.923880 0.382683> <-0.694720 0.305418> <-0.707107 0.707107> <-0.603553 0.603553> [ 6.82845e-08 1.00000] 0 DEAL::2.64 -DEAL::<-0.707107 0.707107> <-0.603553 0.603553> <-0.382683 0.923880> <-0.305418 0.694720> [ 2.67832e-08 0.0800000] +DEAL::<-0.707107 0.707107> <-0.603553 0.603553> <-0.382683 0.923880> <-0.305418 0.694720> [ 2.67832e-08 0.0800000] 0 DEAL::2.64 -DEAL::<-0.707107 0.707107> <-0.603553 0.603553> <-0.382683 0.923880> <-0.305418 0.694720> [ 4.17686e-08 0.160000] +DEAL::<-0.707107 0.707107> <-0.603553 0.603553> <-0.382683 0.923880> <-0.305418 0.694720> [ 4.17686e-08 0.160000] 0 DEAL::2.64 -DEAL::<-0.707107 0.707107> <-0.603553 0.603553> <-0.382683 0.923880> <-0.305418 0.694720> [ 5.28968e-08 0.240000] +DEAL::<-0.707107 0.707107> <-0.603553 0.603553> <-0.382683 0.923880> <-0.305418 0.694720> [ 5.28968e-08 0.240000] 0 DEAL::2.64 -DEAL::<-0.707107 0.707107> <-0.603553 0.603553> <-0.382683 0.923880> <-0.305418 0.694720> [ 5.09320e-08 0.320000] +DEAL::<-0.707107 0.707107> <-0.603553 0.603553> <-0.382683 0.923880> <-0.305418 0.694720> [ 5.09320e-08 0.320000] 0 DEAL::2.64 -DEAL::<-0.707107 0.707107> <-0.603553 0.603553> <-0.382683 0.923880> <-0.305418 0.694720> [ 4.25986e-08 0.400000] +DEAL::<-0.707107 0.707107> <-0.603553 0.603553> <-0.382683 0.923880> <-0.305418 0.694720> [ 4.25986e-08 0.400000] 0 DEAL::2.64 -DEAL::<-0.707107 0.707107> <-0.603553 0.603553> <-0.382683 0.923880> <-0.305418 0.694720> [ 3.65795e-08 0.480000] +DEAL::<-0.707107 0.707107> <-0.603553 0.603553> <-0.382683 0.923880> <-0.305418 0.694720> [ 3.65795e-08 0.480000] 0 DEAL::2.64 -DEAL::<-0.707107 0.707107> <-0.603553 0.603553> <-0.382683 0.923880> <-0.305418 0.694720> [ 3.70938e-08 0.560000] +DEAL::<-0.707107 0.707107> <-0.603553 0.603553> <-0.382683 0.923880> <-0.305418 0.694720> [ 3.70938e-08 0.560000] 0 DEAL::2.64 -DEAL::<-0.707107 0.707107> <-0.603553 0.603553> <-0.382683 0.923880> <-0.305418 0.694720> [ 4.20239e-08 0.640000] +DEAL::<-0.707107 0.707107> <-0.603553 0.603553> <-0.382683 0.923880> <-0.305418 0.694720> [ 4.20239e-08 0.640000] 0 DEAL::2.64 -DEAL::<-0.707107 0.707107> <-0.603553 0.603553> <-0.382683 0.923880> <-0.305418 0.694720> [ 4.46314e-08 0.720000] +DEAL::<-0.707107 0.707107> <-0.603553 0.603553> <-0.382683 0.923880> <-0.305418 0.694720> [ 4.46314e-08 0.720000] 0 DEAL::2.64 -DEAL::<-0.707107 0.707107> <-0.603553 0.603553> <-0.382683 0.923880> <-0.305418 0.694720> [ 3.82244e-08 0.800000] +DEAL::<-0.707107 0.707107> <-0.603553 0.603553> <-0.382683 0.923880> <-0.305418 0.694720> [ 3.82244e-08 0.800000] 0 DEAL::2.64 -DEAL::<-0.707107 0.707107> <-0.603553 0.603553> <-0.382683 0.923880> <-0.305418 0.694720> [ 2.36332e-08 0.880000] +DEAL::<-0.707107 0.707107> <-0.603553 0.603553> <-0.382683 0.923880> <-0.305418 0.694720> [ 2.36332e-08 0.880000] 0 DEAL::2.64 -DEAL::<-0.707107 0.707107> <-0.603553 0.603553> <-0.382683 0.923880> <-0.305418 0.694720> [ 2.11657e-08 0.960000] +DEAL::<-0.707107 0.707107> <-0.603553 0.603553> <-0.382683 0.923880> <-0.305418 0.694720> [ 2.11657e-08 0.960000] 0 DEAL::2.66 -DEAL::<-0.382683 0.923880> <-0.305418 0.694720> <0.00000 1.00000> <0.00000 0.768306> [ 2.08586e-08 0.0400000] +DEAL::<-0.382683 0.923880> <-0.305418 0.694720> <0.00000 1.00000> <0.00000 0.768306> [ 2.08586e-08 0.0400000] 0 DEAL::2.66 -DEAL::<-0.382683 0.923880> <-0.305418 0.694720> <0.00000 1.00000> <0.00000 0.768306> [ 2.26695e-08 0.120000] +DEAL::<-0.382683 0.923880> <-0.305418 0.694720> <0.00000 1.00000> <0.00000 0.768306> [ 2.26695e-08 0.120000] 0 DEAL::2.66 -DEAL::<-0.382683 0.923880> <-0.305418 0.694720> <0.00000 1.00000> <0.00000 0.768306> [ 3.57301e-08 0.200000] +DEAL::<-0.382683 0.923880> <-0.305418 0.694720> <0.00000 1.00000> <0.00000 0.768306> [ 3.57301e-08 0.200000] 0 DEAL::2.66 -DEAL::<-0.382683 0.923880> <-0.305418 0.694720> <0.00000 1.00000> <0.00000 0.768306> [ 4.06545e-08 0.280000] +DEAL::<-0.382683 0.923880> <-0.305418 0.694720> <0.00000 1.00000> <0.00000 0.768306> [ 4.06545e-08 0.280000] 0 DEAL::2.66 -DEAL::<-0.382683 0.923880> <-0.305418 0.694720> <0.00000 1.00000> <0.00000 0.768306> [ 3.72813e-08 0.360000] +DEAL::<-0.382683 0.923880> <-0.305418 0.694720> <0.00000 1.00000> <0.00000 0.768306> [ 3.72813e-08 0.360000] 0 DEAL::2.66 -DEAL::<-0.382683 0.923880> <-0.305418 0.694720> <0.00000 1.00000> <0.00000 0.768306> [ 3.20211e-08 0.440000] +DEAL::<-0.382683 0.923880> <-0.305418 0.694720> <0.00000 1.00000> <0.00000 0.768306> [ 3.20211e-08 0.440000] 0 DEAL::2.66 -DEAL::<-0.382683 0.923880> <-0.305418 0.694720> <0.00000 1.00000> <0.00000 0.768306> [ 3.06912e-08 0.520000] +DEAL::<-0.382683 0.923880> <-0.305418 0.694720> <0.00000 1.00000> <0.00000 0.768306> [ 3.06912e-08 0.520000] 0 DEAL::2.66 -DEAL::<-0.382683 0.923880> <-0.305418 0.694720> <0.00000 1.00000> <0.00000 0.768306> [ 3.46844e-08 0.600000] +DEAL::<-0.382683 0.923880> <-0.305418 0.694720> <0.00000 1.00000> <0.00000 0.768306> [ 3.46844e-08 0.600000] 0 DEAL::2.66 -DEAL::<-0.382683 0.923880> <-0.305418 0.694720> <0.00000 1.00000> <0.00000 0.768306> [ 4.01471e-08 0.680000] +DEAL::<-0.382683 0.923880> <-0.305418 0.694720> <0.00000 1.00000> <0.00000 0.768306> [ 4.01471e-08 0.680000] 0 DEAL::2.66 -DEAL::<-0.382683 0.923880> <-0.305418 0.694720> <0.00000 1.00000> <0.00000 0.768306> [ 4.02041e-08 0.760000] +DEAL::<-0.382683 0.923880> <-0.305418 0.694720> <0.00000 1.00000> <0.00000 0.768306> [ 4.02041e-08 0.760000] 0 DEAL::2.66 -DEAL::<-0.382683 0.923880> <-0.305418 0.694720> <0.00000 1.00000> <0.00000 0.768306> [ 3.03924e-08 0.840000] +DEAL::<-0.382683 0.923880> <-0.305418 0.694720> <0.00000 1.00000> <0.00000 0.768306> [ 3.03924e-08 0.840000] 0 DEAL::2.66 -DEAL::<-0.382683 0.923880> <-0.305418 0.694720> <0.00000 1.00000> <0.00000 0.768306> [ 1.84098e-08 0.920000] +DEAL::<-0.382683 0.923880> <-0.305418 0.694720> <0.00000 1.00000> <0.00000 0.768306> [ 1.84098e-08 0.920000] 0 -- 2.39.5