From: Magdalena Schreter Date: Sat, 24 Sep 2022 08:06:45 +0000 (+0200) Subject: add merge function for duplicate points X-Git-Tag: v9.5.0-rc1~871^2~1 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=41d5f0f553b5aea14b1b76bfc06a536b5dbfe413;p=dealii.git add merge function for duplicate points --- diff --git a/source/grid/grid_tools.cc b/source/grid/grid_tools.cc index 60327d834f..6eb7200e6d 100644 --- a/source/grid/grid_tools.cc +++ b/source/grid/grid_tools.cc @@ -13,6 +13,7 @@ // // --------------------------------------------------------------------- +#include #include #include #include @@ -6647,6 +6648,151 @@ namespace GridTools + namespace internal + { + template + void + process_sub_cell( + const std::array & cut_line_table, + const ndarray &new_line_table, + const ndarray & line_to_vertex_table, + const std::vector & ls_values, + const std::vector> & points, + const std::vector & mask, + const double iso_level, + const double tolerance, + std::vector> & vertices, + std::vector> &cells, + const bool write_back_cell_data) + { + // inspired by https://graphics.stanford.edu/~mdfisher/MarchingCubes.html + + constexpr unsigned int X = static_cast(-1); + + // determine configuration + unsigned int configuration = 0; + for (unsigned int v = 0; v < n_vertices; ++v) + if (ls_values[mask[v]] < iso_level) + configuration |= (1 << v); + + // cell is not cut (nothing to do) + if (cut_line_table[configuration] == 0) + return; + + // helper function to determine where an edge (between index i and j) is + // cut - see also: http://paulbourke.net/geometry/polygonise/ + const auto interpolate = [&](const unsigned int i, const unsigned int j) { + if (std::abs(iso_level - ls_values[mask[i]]) < tolerance) + return points[mask[i]]; + if (std::abs(iso_level - ls_values[mask[j]]) < tolerance) + return points[mask[j]]; + if (std::abs(ls_values[mask[i]] - ls_values[mask[j]]) < tolerance) + return points[mask[i]]; + + const double mu = (iso_level - ls_values[mask[i]]) / + (ls_values[mask[j]] - ls_values[mask[i]]); + + return Point(points[mask[i]] + + mu * (points[mask[j]] - points[mask[i]])); + }; + + // determine the position where edges are cut (if they are cut) + std::array, n_lines> vertex_list_all; + for (unsigned int l = 0; l < n_lines; ++l) + if (cut_line_table[configuration] & (1 << l)) + vertex_list_all[l] = + interpolate(line_to_vertex_table[l][0], line_to_vertex_table[l][1]); + + // merge duplicate vertices if possible + unsigned int local_vertex_count = 0; + std::array, n_lines> vertex_list_reduced; + std::array local_remap; + std::fill(local_remap.begin(), local_remap.end(), X); + for (int i = 0; new_line_table[configuration][i] != X; ++i) + if (local_remap[new_line_table[configuration][i]] == X) + { + vertex_list_reduced[local_vertex_count] = + vertex_list_all[new_line_table[configuration][i]]; + local_remap[new_line_table[configuration][i]] = local_vertex_count; + local_vertex_count++; + } + + // write back vertices + const unsigned int n_vertices_old = vertices.size(); + for (unsigned int i = 0; i < local_vertex_count; ++i) + vertices.push_back(vertex_list_reduced[i]); + + // write back cells + if (write_back_cell_data && dim > 1) + { + for (unsigned int i = 0; new_line_table[configuration][i] != X; + i += n_sub_vertices) + { + cells.resize(cells.size() + 1); + cells.back().vertices.resize(n_sub_vertices); + + for (unsigned int v = 0; v < n_sub_vertices; ++v) + cells.back().vertices[v] = + local_remap[new_line_table[configuration][i + v]] + + n_vertices_old; + } + } + } + + + + template + void + merge_duplicate_points(std::vector> &vertices, + std::vector> &cells) + { + if (vertices.size() == 0) + return; + + // 1) map point to local vertex index + std::map, unsigned int, FloatingPointComparator> + map_point_to_local_vertex_index(FloatingPointComparator(1e-10)); + + // 2) initialize map with existing points uniquely + for (unsigned int i = 0; i < vertices.size(); ++i) + map_point_to_local_vertex_index[vertices[i]] = i; + + // no duplicate points are found + if (map_point_to_local_vertex_index.size() == vertices.size()) + return; + + // 3) remove duplicate entries from vertices + vertices.resize(map_point_to_local_vertex_index.size()); + { + unsigned int j = 0; + for (const auto &p : map_point_to_local_vertex_index) + vertices[j++] = p.first; + } + + // 4) renumber vertices in CellData object + if (cells.size() > 0) + { + map_point_to_local_vertex_index.clear(); + // initialize map with unique points + for (unsigned int i = 0; i < vertices.size(); ++i) + map_point_to_local_vertex_index[vertices[i]] = i; + + // overwrite vertex indices in CellData object + for (auto &cell : cells) + for (auto &v : cell.vertices) + v = map_point_to_local_vertex_index[vertices[v]]; + } + } + } // namespace internal + + + template MarchingCubeAlgorithm::MarchingCubeAlgorithm( const Mapping & mapping, @@ -6716,6 +6862,8 @@ namespace GridTools for (const auto &cell : background_dof_handler.active_cell_iterators() | IteratorFilters::LocallyOwnedCell()) process_cell(cell, ls_vector, iso_level, vertices, cells); + + internal::merge_duplicate_points(vertices, cells); } template @@ -6729,6 +6877,10 @@ namespace GridTools for (const auto &cell : background_dof_handler.active_cell_iterators() | IteratorFilters::LocallyOwnedCell()) process_cell(cell, ls_vector, iso_level, vertices); + + // This vector is just a placeholder to reuse the process_cell function. + std::vector> dummy_cells; + internal::merge_duplicate_points(vertices, dummy_cells); } @@ -6878,106 +7030,6 @@ namespace GridTools - namespace internal - { - template - void - process_sub_cell( - const std::array & cut_line_table, - const ndarray &new_line_table, - const ndarray & line_to_vertex_table, - const std::vector & ls_values, - const std::vector> & points, - const std::vector & mask, - const double iso_level, - const double tolerance, - std::vector> & vertices, - std::vector> &cells, - const bool write_back_cell_data) - { - // inspired by https://graphics.stanford.edu/~mdfisher/MarchingCubes.html - - constexpr unsigned int X = static_cast(-1); - - // determine configuration - unsigned int configuration = 0; - for (unsigned int v = 0; v < n_vertices; ++v) - if (ls_values[mask[v]] < iso_level) - configuration |= (1 << v); - - // cell is not cut (nothing to do) - if (cut_line_table[configuration] == 0) - return; - - // helper function to determine where an edge (between index i and j) is - // cut - see also: http://paulbourke.net/geometry/polygonise/ - const auto interpolate = [&](const unsigned int i, const unsigned int j) { - if (std::abs(iso_level - ls_values[mask[i]]) < tolerance) - return points[mask[i]]; - if (std::abs(iso_level - ls_values[mask[j]]) < tolerance) - return points[mask[j]]; - if (std::abs(ls_values[mask[i]] - ls_values[mask[j]]) < tolerance) - return points[mask[i]]; - - const double mu = (iso_level - ls_values[mask[i]]) / - (ls_values[mask[j]] - ls_values[mask[i]]); - - return Point(points[mask[i]] + - mu * (points[mask[j]] - points[mask[i]])); - }; - - // determine the position where edges are cut (if they are cut) - std::array, n_lines> vertex_list_all; - for (unsigned int l = 0; l < n_lines; ++l) - if (cut_line_table[configuration] & (1 << l)) - vertex_list_all[l] = - interpolate(line_to_vertex_table[l][0], line_to_vertex_table[l][1]); - - // merge duplicate vertices if possible - unsigned int local_vertex_count = 0; - std::array, n_lines> vertex_list_reduced; - std::array local_remap; - std::fill(local_remap.begin(), local_remap.end(), X); - for (int i = 0; new_line_table[configuration][i] != X; ++i) - if (local_remap[new_line_table[configuration][i]] == X) - { - vertex_list_reduced[local_vertex_count] = - vertex_list_all[new_line_table[configuration][i]]; - local_remap[new_line_table[configuration][i]] = local_vertex_count; - local_vertex_count++; - } - - // write back vertices - const unsigned int n_vertices_old = vertices.size(); - for (unsigned int i = 0; i < local_vertex_count; ++i) - vertices.push_back(vertex_list_reduced[i]); - - // write back cells - if (write_back_cell_data && dim > 1) - { - for (unsigned int i = 0; new_line_table[configuration][i] != X; - i += n_sub_vertices) - { - cells.resize(cells.size() + 1); - cells.back().vertices.resize(n_sub_vertices); - - for (unsigned int v = 0; v < n_sub_vertices; ++v) - cells.back().vertices[v] = - local_remap[new_line_table[configuration][i + v]] + - n_vertices_old; - } - } - } - } // namespace internal - - - template void MarchingCubeAlgorithm::process_sub_cell( diff --git a/tests/grid/grid_generator_marching_cube_algorithm_02.with_p4est=true.mpirun=1.output b/tests/grid/grid_generator_marching_cube_algorithm_02.with_p4est=true.mpirun=1.output index a02ac59bf0..c5e6c9c6ff 100644 --- a/tests/grid/grid_generator_marching_cube_algorithm_02.with_p4est=true.mpirun=1.output +++ b/tests/grid/grid_generator_marching_cube_algorithm_02.with_p4est=true.mpirun=1.output @@ -4,788 +4,398 @@ DEAL:0::point found: -7.000000e-01 DEAL:0::point found: 7.000000e-01 DEAL:0::dim=1 iso level: 0.000000e+00 DEAL:0::point found: -7.500000e-01 -DEAL:0::point found: -7.500000e-01 -DEAL:0::point found: 7.500000e-01 DEAL:0::point found: 7.500000e-01 DEAL:0::dim=1 iso level: 5.000000e-02 DEAL:0::point found: -8.000000e-01 DEAL:0::point found: 8.000000e-01 DEAL:0::dim=2 iso level: -5.000000e-02 -DEAL:0::point found: -3.750000e-01 -5.906490e-01 -DEAL:0::point found: -4.149887e-01 -5.625000e-01 -DEAL:0::point found: -5.625000e-01 -4.149887e-01 -DEAL:0::point found: -5.906490e-01 -3.750000e-01 -DEAL:0::point found: -4.687500e-01 -5.189236e-01 -DEAL:0::point found: -5.189236e-01 -4.687500e-01 -DEAL:0::point found: -4.687500e-01 -5.189236e-01 -DEAL:0::point found: -4.149887e-01 -5.625000e-01 -DEAL:0::point found: -5.625000e-01 -4.149887e-01 -DEAL:0::point found: -5.189236e-01 -4.687500e-01 -DEAL:0::point found: -1.875000e-01 -6.743534e-01 -DEAL:0::point found: -2.396049e-01 -6.562500e-01 -DEAL:0::point found: -3.750000e-01 -5.906490e-01 -DEAL:0::point found: -2.812500e-01 -6.408476e-01 -DEAL:0::point found: -2.812500e-01 -6.408476e-01 -DEAL:0::point found: -2.396049e-01 -6.562500e-01 -DEAL:0::point found: -1.875000e-01 -6.743534e-01 -DEAL:0::point found: -9.375000e-02 -6.936670e-01 -DEAL:0::point found: -9.375000e-02 -6.936670e-01 -DEAL:0::point found: 0.000000e+00 -7.000000e-01 -DEAL:0::point found: -5.906490e-01 -3.750000e-01 -DEAL:0::point found: -6.408476e-01 -2.812500e-01 -DEAL:0::point found: -6.562500e-01 -2.396049e-01 -DEAL:0::point found: -6.743534e-01 -1.875000e-01 -DEAL:0::point found: -6.562500e-01 -2.396049e-01 -DEAL:0::point found: -6.408476e-01 -2.812500e-01 -DEAL:0::point found: -6.743534e-01 -1.875000e-01 -DEAL:0::point found: -6.936670e-01 -9.375000e-02 -DEAL:0::point found: -6.936670e-01 -9.375000e-02 -DEAL:0::point found: -7.000000e-01 0.000000e+00 -DEAL:0::point found: 0.000000e+00 -7.000000e-01 -DEAL:0::point found: 9.375000e-02 -6.936670e-01 -DEAL:0::point found: 9.375000e-02 -6.936670e-01 -DEAL:0::point found: 1.875000e-01 -6.743534e-01 -DEAL:0::point found: 1.875000e-01 -6.743534e-01 -DEAL:0::point found: 2.396049e-01 -6.562500e-01 -DEAL:0::point found: 2.396049e-01 -6.562500e-01 -DEAL:0::point found: 2.812500e-01 -6.408476e-01 -DEAL:0::point found: 2.812500e-01 -6.408476e-01 -DEAL:0::point found: 3.750000e-01 -5.906490e-01 -DEAL:0::point found: 3.750000e-01 -5.906490e-01 -DEAL:0::point found: 4.149887e-01 -5.625000e-01 -DEAL:0::point found: 4.149887e-01 -5.625000e-01 -DEAL:0::point found: 4.687500e-01 -5.189236e-01 -DEAL:0::point found: 4.687500e-01 -5.189236e-01 -DEAL:0::point found: 5.189236e-01 -4.687500e-01 -DEAL:0::point found: 5.189236e-01 -4.687500e-01 -DEAL:0::point found: 5.625000e-01 -4.149887e-01 -DEAL:0::point found: 5.625000e-01 -4.149887e-01 -DEAL:0::point found: 5.906490e-01 -3.750000e-01 -DEAL:0::point found: 5.906490e-01 -3.750000e-01 -DEAL:0::point found: 6.408476e-01 -2.812500e-01 -DEAL:0::point found: 6.408476e-01 -2.812500e-01 -DEAL:0::point found: 6.562500e-01 -2.396049e-01 -DEAL:0::point found: 6.562500e-01 -2.396049e-01 -DEAL:0::point found: 6.743534e-01 -1.875000e-01 -DEAL:0::point found: 6.743534e-01 -1.875000e-01 -DEAL:0::point found: 6.936670e-01 -9.375000e-02 -DEAL:0::point found: 6.936670e-01 -9.375000e-02 -DEAL:0::point found: 7.000000e-01 0.000000e+00 DEAL:0::point found: -7.000000e-01 0.000000e+00 +DEAL:0::point found: -6.936670e-01 -9.375000e-02 DEAL:0::point found: -6.936670e-01 9.375000e-02 -DEAL:0::point found: -6.936670e-01 9.375000e-02 -DEAL:0::point found: -6.743534e-01 1.875000e-01 -DEAL:0::point found: -6.562500e-01 2.396049e-01 +DEAL:0::point found: -6.743534e-01 -1.875000e-01 DEAL:0::point found: -6.743534e-01 1.875000e-01 +DEAL:0::point found: -6.562500e-01 -2.396049e-01 DEAL:0::point found: -6.562500e-01 2.396049e-01 +DEAL:0::point found: -6.408476e-01 -2.812500e-01 DEAL:0::point found: -6.408476e-01 2.812500e-01 -DEAL:0::point found: -6.408476e-01 2.812500e-01 -DEAL:0::point found: -5.906490e-01 3.750000e-01 -DEAL:0::point found: -5.625000e-01 4.149887e-01 +DEAL:0::point found: -5.906490e-01 -3.750000e-01 DEAL:0::point found: -5.906490e-01 3.750000e-01 +DEAL:0::point found: -5.625000e-01 -4.149887e-01 DEAL:0::point found: -5.625000e-01 4.149887e-01 +DEAL:0::point found: -5.189236e-01 -4.687500e-01 DEAL:0::point found: -5.189236e-01 4.687500e-01 +DEAL:0::point found: -4.687500e-01 -5.189236e-01 DEAL:0::point found: -4.687500e-01 5.189236e-01 -DEAL:0::point found: -5.189236e-01 4.687500e-01 -DEAL:0::point found: -4.687500e-01 5.189236e-01 -DEAL:0::point found: -4.149887e-01 5.625000e-01 -DEAL:0::point found: -3.750000e-01 5.906490e-01 +DEAL:0::point found: -4.149887e-01 -5.625000e-01 DEAL:0::point found: -4.149887e-01 5.625000e-01 +DEAL:0::point found: -3.750000e-01 -5.906490e-01 DEAL:0::point found: -3.750000e-01 5.906490e-01 +DEAL:0::point found: -2.812500e-01 -6.408476e-01 DEAL:0::point found: -2.812500e-01 6.408476e-01 -DEAL:0::point found: -2.812500e-01 6.408476e-01 -DEAL:0::point found: -2.396049e-01 6.562500e-01 -DEAL:0::point found: -1.875000e-01 6.743534e-01 +DEAL:0::point found: -2.396049e-01 -6.562500e-01 DEAL:0::point found: -2.396049e-01 6.562500e-01 +DEAL:0::point found: -1.875000e-01 -6.743534e-01 DEAL:0::point found: -1.875000e-01 6.743534e-01 +DEAL:0::point found: -9.375000e-02 -6.936670e-01 DEAL:0::point found: -9.375000e-02 6.936670e-01 -DEAL:0::point found: -9.375000e-02 6.936670e-01 -DEAL:0::point found: 0.000000e+00 7.000000e-01 -DEAL:0::point found: 7.000000e-01 0.000000e+00 -DEAL:0::point found: 6.936670e-01 9.375000e-02 -DEAL:0::point found: 6.936670e-01 9.375000e-02 -DEAL:0::point found: 6.743534e-01 1.875000e-01 -DEAL:0::point found: 6.562500e-01 2.396049e-01 -DEAL:0::point found: 6.408476e-01 2.812500e-01 -DEAL:0::point found: 6.562500e-01 2.396049e-01 -DEAL:0::point found: 6.743534e-01 1.875000e-01 -DEAL:0::point found: 6.408476e-01 2.812500e-01 -DEAL:0::point found: 5.906490e-01 3.750000e-01 +DEAL:0::point found: 0.000000e+00 -7.000000e-01 DEAL:0::point found: 0.000000e+00 7.000000e-01 +DEAL:0::point found: 9.375000e-02 -6.936670e-01 DEAL:0::point found: 9.375000e-02 6.936670e-01 -DEAL:0::point found: 9.375000e-02 6.936670e-01 +DEAL:0::point found: 1.875000e-01 -6.743534e-01 DEAL:0::point found: 1.875000e-01 6.743534e-01 -DEAL:0::point found: 2.812500e-01 6.408476e-01 +DEAL:0::point found: 2.396049e-01 -6.562500e-01 DEAL:0::point found: 2.396049e-01 6.562500e-01 +DEAL:0::point found: 2.812500e-01 -6.408476e-01 DEAL:0::point found: 2.812500e-01 6.408476e-01 +DEAL:0::point found: 3.750000e-01 -5.906490e-01 DEAL:0::point found: 3.750000e-01 5.906490e-01 -DEAL:0::point found: 1.875000e-01 6.743534e-01 -DEAL:0::point found: 2.396049e-01 6.562500e-01 -DEAL:0::point found: 5.625000e-01 4.149887e-01 -DEAL:0::point found: 5.189236e-01 4.687500e-01 -DEAL:0::point found: 4.687500e-01 5.189236e-01 +DEAL:0::point found: 4.149887e-01 -5.625000e-01 DEAL:0::point found: 4.149887e-01 5.625000e-01 +DEAL:0::point found: 4.687500e-01 -5.189236e-01 DEAL:0::point found: 4.687500e-01 5.189236e-01 +DEAL:0::point found: 5.189236e-01 -4.687500e-01 DEAL:0::point found: 5.189236e-01 4.687500e-01 +DEAL:0::point found: 5.625000e-01 -4.149887e-01 DEAL:0::point found: 5.625000e-01 4.149887e-01 +DEAL:0::point found: 5.906490e-01 -3.750000e-01 DEAL:0::point found: 5.906490e-01 3.750000e-01 -DEAL:0::point found: 3.750000e-01 5.906490e-01 -DEAL:0::point found: 4.149887e-01 5.625000e-01 +DEAL:0::point found: 6.408476e-01 -2.812500e-01 +DEAL:0::point found: 6.408476e-01 2.812500e-01 +DEAL:0::point found: 6.562500e-01 -2.396049e-01 +DEAL:0::point found: 6.562500e-01 2.396049e-01 +DEAL:0::point found: 6.743534e-01 -1.875000e-01 +DEAL:0::point found: 6.743534e-01 1.875000e-01 +DEAL:0::point found: 6.936670e-01 -9.375000e-02 +DEAL:0::point found: 6.936670e-01 9.375000e-02 +DEAL:0::point found: 7.000000e-01 0.000000e+00 DEAL:0::dim=2 iso level: 0.000000e+00 -DEAL:0::point found: -4.687500e-01 -5.852856e-01 -DEAL:0::point found: -4.957721e-01 -5.625000e-01 -DEAL:0::point found: -4.218750e-01 -6.200027e-01 -DEAL:0::point found: -4.368649e-01 -6.093750e-01 -DEAL:0::point found: -4.218750e-01 -6.200027e-01 -DEAL:0::point found: -3.750000e-01 -6.494646e-01 -DEAL:0::point found: -4.687500e-01 -5.852856e-01 -DEAL:0::point found: -4.368649e-01 -6.093750e-01 -DEAL:0::point found: -5.625000e-01 -4.957721e-01 -DEAL:0::point found: -5.852856e-01 -4.687500e-01 -DEAL:0::point found: -6.093750e-01 -4.368649e-01 +DEAL:0::point found: -7.500000e-01 0.000000e+00 +DEAL:0::point found: -7.485333e-01 -4.687500e-02 +DEAL:0::point found: -7.485333e-01 4.687500e-02 +DEAL:0::point found: -7.441149e-01 -9.375000e-02 +DEAL:0::point found: -7.441149e-01 9.375000e-02 +DEAL:0::point found: -7.366873e-01 -1.406250e-01 +DEAL:0::point found: -7.366873e-01 1.406250e-01 +DEAL:0::point found: -7.261608e-01 -1.875000e-01 +DEAL:0::point found: -7.261608e-01 1.875000e-01 +DEAL:0::point found: -7.124152e-01 -2.343750e-01 +DEAL:0::point found: -7.124152e-01 2.343750e-01 +DEAL:0::point found: -7.031250e-01 -2.600683e-01 +DEAL:0::point found: -7.031250e-01 2.600683e-01 +DEAL:0::point found: -6.952364e-01 -2.812500e-01 +DEAL:0::point found: -6.952364e-01 2.812500e-01 +DEAL:0::point found: -6.743408e-01 -3.281250e-01 +DEAL:0::point found: -6.743408e-01 3.281250e-01 +DEAL:0::point found: -6.562500e-01 -3.626352e-01 +DEAL:0::point found: -6.562500e-01 3.626352e-01 +DEAL:0::point found: -6.494646e-01 -3.750000e-01 +DEAL:0::point found: -6.494646e-01 3.750000e-01 DEAL:0::point found: -6.200027e-01 -4.218750e-01 +DEAL:0::point found: -6.200027e-01 4.218750e-01 DEAL:0::point found: -6.093750e-01 -4.368649e-01 +DEAL:0::point found: -6.093750e-01 4.368649e-01 DEAL:0::point found: -5.852856e-01 -4.687500e-01 -DEAL:0::point found: -6.200027e-01 -4.218750e-01 -DEAL:0::point found: -6.494646e-01 -3.750000e-01 -DEAL:0::point found: -5.156250e-01 -5.444101e-01 +DEAL:0::point found: -5.852856e-01 4.687500e-01 +DEAL:0::point found: -5.625000e-01 -4.957721e-01 +DEAL:0::point found: -5.625000e-01 4.957721e-01 DEAL:0::point found: -5.444101e-01 -5.156250e-01 +DEAL:0::point found: -5.444101e-01 5.156250e-01 DEAL:0::point found: -5.156250e-01 -5.444101e-01 +DEAL:0::point found: -5.156250e-01 5.444101e-01 DEAL:0::point found: -4.957721e-01 -5.625000e-01 -DEAL:0::point found: -5.625000e-01 -4.957721e-01 -DEAL:0::point found: -5.444101e-01 -5.156250e-01 -DEAL:0::point found: -3.281250e-01 -6.743408e-01 +DEAL:0::point found: -4.957721e-01 5.625000e-01 +DEAL:0::point found: -4.687500e-01 -5.852856e-01 +DEAL:0::point found: -4.687500e-01 5.852856e-01 +DEAL:0::point found: -4.368649e-01 -6.093750e-01 +DEAL:0::point found: -4.368649e-01 6.093750e-01 +DEAL:0::point found: -4.218750e-01 -6.200027e-01 +DEAL:0::point found: -4.218750e-01 6.200027e-01 +DEAL:0::point found: -3.750000e-01 -6.494646e-01 +DEAL:0::point found: -3.750000e-01 6.494646e-01 DEAL:0::point found: -3.626352e-01 -6.562500e-01 +DEAL:0::point found: -3.626352e-01 6.562500e-01 DEAL:0::point found: -3.281250e-01 -6.743408e-01 +DEAL:0::point found: -3.281250e-01 6.743408e-01 DEAL:0::point found: -2.812500e-01 -6.952364e-01 -DEAL:0::point found: -2.343750e-01 -7.124152e-01 +DEAL:0::point found: -2.812500e-01 6.952364e-01 DEAL:0::point found: -2.600683e-01 -7.031250e-01 +DEAL:0::point found: -2.600683e-01 7.031250e-01 DEAL:0::point found: -2.343750e-01 -7.124152e-01 +DEAL:0::point found: -2.343750e-01 7.124152e-01 DEAL:0::point found: -1.875000e-01 -7.261608e-01 -DEAL:0::point found: -2.812500e-01 -6.952364e-01 -DEAL:0::point found: -2.600683e-01 -7.031250e-01 -DEAL:0::point found: -3.750000e-01 -6.494646e-01 -DEAL:0::point found: -3.626352e-01 -6.562500e-01 -DEAL:0::point found: -1.875000e-01 -7.261608e-01 -DEAL:0::point found: -1.406250e-01 -7.366873e-01 +DEAL:0::point found: -1.875000e-01 7.261608e-01 DEAL:0::point found: -1.406250e-01 -7.366873e-01 +DEAL:0::point found: -1.406250e-01 7.366873e-01 DEAL:0::point found: -9.375000e-02 -7.441149e-01 -DEAL:0::point found: -9.375000e-02 -7.441149e-01 -DEAL:0::point found: -4.687500e-02 -7.485333e-01 +DEAL:0::point found: -9.375000e-02 7.441149e-01 DEAL:0::point found: -4.687500e-02 -7.485333e-01 +DEAL:0::point found: -4.687500e-02 7.485333e-01 DEAL:0::point found: 0.000000e+00 -7.500000e-01 -DEAL:0::point found: -6.562500e-01 -3.626352e-01 -DEAL:0::point found: -6.743408e-01 -3.281250e-01 -DEAL:0::point found: -6.743408e-01 -3.281250e-01 -DEAL:0::point found: -6.952364e-01 -2.812500e-01 -DEAL:0::point found: -6.562500e-01 -3.626352e-01 -DEAL:0::point found: -6.494646e-01 -3.750000e-01 -DEAL:0::point found: -7.031250e-01 -2.600683e-01 -DEAL:0::point found: -7.124152e-01 -2.343750e-01 -DEAL:0::point found: -7.031250e-01 -2.600683e-01 -DEAL:0::point found: -6.952364e-01 -2.812500e-01 -DEAL:0::point found: -7.124152e-01 -2.343750e-01 -DEAL:0::point found: -7.261608e-01 -1.875000e-01 -DEAL:0::point found: -7.261608e-01 -1.875000e-01 -DEAL:0::point found: -7.366873e-01 -1.406250e-01 -DEAL:0::point found: -7.366873e-01 -1.406250e-01 -DEAL:0::point found: -7.441149e-01 -9.375000e-02 -DEAL:0::point found: -7.441149e-01 -9.375000e-02 -DEAL:0::point found: -7.485333e-01 -4.687500e-02 -DEAL:0::point found: -7.485333e-01 -4.687500e-02 -DEAL:0::point found: -7.500000e-01 0.000000e+00 -DEAL:0::point found: 0.000000e+00 -7.500000e-01 -DEAL:0::point found: 4.687500e-02 -7.485333e-01 +DEAL:0::point found: 0.000000e+00 7.500000e-01 DEAL:0::point found: 4.687500e-02 -7.485333e-01 +DEAL:0::point found: 4.687500e-02 7.485333e-01 DEAL:0::point found: 9.375000e-02 -7.441149e-01 -DEAL:0::point found: 9.375000e-02 -7.441149e-01 -DEAL:0::point found: 1.406250e-01 -7.366873e-01 +DEAL:0::point found: 9.375000e-02 7.441149e-01 DEAL:0::point found: 1.406250e-01 -7.366873e-01 +DEAL:0::point found: 1.406250e-01 7.366873e-01 DEAL:0::point found: 1.875000e-01 -7.261608e-01 -DEAL:0::point found: 1.875000e-01 -7.261608e-01 -DEAL:0::point found: 2.343750e-01 -7.124152e-01 +DEAL:0::point found: 1.875000e-01 7.261608e-01 DEAL:0::point found: 2.343750e-01 -7.124152e-01 +DEAL:0::point found: 2.343750e-01 7.124152e-01 DEAL:0::point found: 2.600683e-01 -7.031250e-01 -DEAL:0::point found: 2.600683e-01 -7.031250e-01 -DEAL:0::point found: 2.812500e-01 -6.952364e-01 +DEAL:0::point found: 2.600683e-01 7.031250e-01 DEAL:0::point found: 2.812500e-01 -6.952364e-01 +DEAL:0::point found: 2.812500e-01 6.952364e-01 DEAL:0::point found: 3.281250e-01 -6.743408e-01 -DEAL:0::point found: 3.281250e-01 -6.743408e-01 -DEAL:0::point found: 3.626352e-01 -6.562500e-01 +DEAL:0::point found: 3.281250e-01 6.743408e-01 DEAL:0::point found: 3.626352e-01 -6.562500e-01 +DEAL:0::point found: 3.626352e-01 6.562500e-01 DEAL:0::point found: 3.750000e-01 -6.494646e-01 -DEAL:0::point found: 3.750000e-01 -6.494646e-01 -DEAL:0::point found: 4.218750e-01 -6.200027e-01 +DEAL:0::point found: 3.750000e-01 6.494646e-01 DEAL:0::point found: 4.218750e-01 -6.200027e-01 +DEAL:0::point found: 4.218750e-01 6.200027e-01 DEAL:0::point found: 4.368649e-01 -6.093750e-01 -DEAL:0::point found: 4.368649e-01 -6.093750e-01 -DEAL:0::point found: 4.687500e-01 -5.852856e-01 +DEAL:0::point found: 4.368649e-01 6.093750e-01 DEAL:0::point found: 4.687500e-01 -5.852856e-01 +DEAL:0::point found: 4.687500e-01 5.852856e-01 DEAL:0::point found: 4.957721e-01 -5.625000e-01 -DEAL:0::point found: 4.957721e-01 -5.625000e-01 -DEAL:0::point found: 5.156250e-01 -5.444101e-01 +DEAL:0::point found: 4.957721e-01 5.625000e-01 DEAL:0::point found: 5.156250e-01 -5.444101e-01 +DEAL:0::point found: 5.156250e-01 5.444101e-01 DEAL:0::point found: 5.444101e-01 -5.156250e-01 -DEAL:0::point found: 5.444101e-01 -5.156250e-01 +DEAL:0::point found: 5.444101e-01 5.156250e-01 DEAL:0::point found: 5.625000e-01 -4.957721e-01 -DEAL:0::point found: 5.625000e-01 -4.957721e-01 -DEAL:0::point found: 5.852856e-01 -4.687500e-01 +DEAL:0::point found: 5.625000e-01 4.957721e-01 DEAL:0::point found: 5.852856e-01 -4.687500e-01 +DEAL:0::point found: 5.852856e-01 4.687500e-01 DEAL:0::point found: 6.093750e-01 -4.368649e-01 -DEAL:0::point found: 6.093750e-01 -4.368649e-01 -DEAL:0::point found: 6.200027e-01 -4.218750e-01 +DEAL:0::point found: 6.093750e-01 4.368649e-01 DEAL:0::point found: 6.200027e-01 -4.218750e-01 +DEAL:0::point found: 6.200027e-01 4.218750e-01 DEAL:0::point found: 6.494646e-01 -3.750000e-01 -DEAL:0::point found: 6.494646e-01 -3.750000e-01 -DEAL:0::point found: 6.562500e-01 -3.626352e-01 +DEAL:0::point found: 6.494646e-01 3.750000e-01 DEAL:0::point found: 6.562500e-01 -3.626352e-01 +DEAL:0::point found: 6.562500e-01 3.626352e-01 DEAL:0::point found: 6.743408e-01 -3.281250e-01 -DEAL:0::point found: 6.743408e-01 -3.281250e-01 -DEAL:0::point found: 6.952364e-01 -2.812500e-01 +DEAL:0::point found: 6.743408e-01 3.281250e-01 DEAL:0::point found: 6.952364e-01 -2.812500e-01 +DEAL:0::point found: 6.952364e-01 2.812500e-01 DEAL:0::point found: 7.031250e-01 -2.600683e-01 -DEAL:0::point found: 7.031250e-01 -2.600683e-01 -DEAL:0::point found: 7.124152e-01 -2.343750e-01 +DEAL:0::point found: 7.031250e-01 2.600683e-01 DEAL:0::point found: 7.124152e-01 -2.343750e-01 +DEAL:0::point found: 7.124152e-01 2.343750e-01 DEAL:0::point found: 7.261608e-01 -1.875000e-01 -DEAL:0::point found: 7.261608e-01 -1.875000e-01 -DEAL:0::point found: 7.366873e-01 -1.406250e-01 +DEAL:0::point found: 7.261608e-01 1.875000e-01 DEAL:0::point found: 7.366873e-01 -1.406250e-01 +DEAL:0::point found: 7.366873e-01 1.406250e-01 DEAL:0::point found: 7.441149e-01 -9.375000e-02 -DEAL:0::point found: 7.441149e-01 -9.375000e-02 -DEAL:0::point found: 7.485333e-01 -4.687500e-02 +DEAL:0::point found: 7.441149e-01 9.375000e-02 DEAL:0::point found: 7.485333e-01 -4.687500e-02 -DEAL:0::point found: 7.500000e-01 0.000000e+00 -DEAL:0::point found: -7.500000e-01 0.000000e+00 -DEAL:0::point found: -7.485333e-01 4.687500e-02 -DEAL:0::point found: -7.485333e-01 4.687500e-02 -DEAL:0::point found: -7.441149e-01 9.375000e-02 -DEAL:0::point found: -7.441149e-01 9.375000e-02 -DEAL:0::point found: -7.366873e-01 1.406250e-01 -DEAL:0::point found: -7.366873e-01 1.406250e-01 -DEAL:0::point found: -7.261608e-01 1.875000e-01 -DEAL:0::point found: -7.261608e-01 1.875000e-01 -DEAL:0::point found: -7.124152e-01 2.343750e-01 -DEAL:0::point found: -7.031250e-01 2.600683e-01 -DEAL:0::point found: -7.124152e-01 2.343750e-01 -DEAL:0::point found: -7.031250e-01 2.600683e-01 -DEAL:0::point found: -6.952364e-01 2.812500e-01 -DEAL:0::point found: -6.952364e-01 2.812500e-01 -DEAL:0::point found: -6.743408e-01 3.281250e-01 -DEAL:0::point found: -6.562500e-01 3.626352e-01 -DEAL:0::point found: -6.743408e-01 3.281250e-01 -DEAL:0::point found: -6.562500e-01 3.626352e-01 -DEAL:0::point found: -6.494646e-01 3.750000e-01 -DEAL:0::point found: -6.494646e-01 3.750000e-01 -DEAL:0::point found: -6.200027e-01 4.218750e-01 -DEAL:0::point found: -6.093750e-01 4.368649e-01 -DEAL:0::point found: -6.200027e-01 4.218750e-01 -DEAL:0::point found: -6.093750e-01 4.368649e-01 -DEAL:0::point found: -5.852856e-01 4.687500e-01 -DEAL:0::point found: -5.625000e-01 4.957721e-01 -DEAL:0::point found: -5.852856e-01 4.687500e-01 -DEAL:0::point found: -5.625000e-01 4.957721e-01 -DEAL:0::point found: -5.444101e-01 5.156250e-01 -DEAL:0::point found: -5.156250e-01 5.444101e-01 -DEAL:0::point found: -5.444101e-01 5.156250e-01 -DEAL:0::point found: -5.156250e-01 5.444101e-01 -DEAL:0::point found: -4.957721e-01 5.625000e-01 -DEAL:0::point found: -4.687500e-01 5.852856e-01 -DEAL:0::point found: -4.957721e-01 5.625000e-01 -DEAL:0::point found: -4.687500e-01 5.852856e-01 -DEAL:0::point found: -4.368649e-01 6.093750e-01 -DEAL:0::point found: -4.218750e-01 6.200027e-01 -DEAL:0::point found: -4.368649e-01 6.093750e-01 -DEAL:0::point found: -4.218750e-01 6.200027e-01 -DEAL:0::point found: -3.750000e-01 6.494646e-01 -DEAL:0::point found: -3.750000e-01 6.494646e-01 -DEAL:0::point found: -3.626352e-01 6.562500e-01 -DEAL:0::point found: -3.281250e-01 6.743408e-01 -DEAL:0::point found: -3.626352e-01 6.562500e-01 -DEAL:0::point found: -3.281250e-01 6.743408e-01 -DEAL:0::point found: -2.812500e-01 6.952364e-01 -DEAL:0::point found: -2.812500e-01 6.952364e-01 -DEAL:0::point found: -2.600683e-01 7.031250e-01 -DEAL:0::point found: -2.343750e-01 7.124152e-01 -DEAL:0::point found: -2.600683e-01 7.031250e-01 -DEAL:0::point found: -2.343750e-01 7.124152e-01 -DEAL:0::point found: -1.875000e-01 7.261608e-01 -DEAL:0::point found: -1.875000e-01 7.261608e-01 -DEAL:0::point found: -1.406250e-01 7.366873e-01 -DEAL:0::point found: -1.406250e-01 7.366873e-01 -DEAL:0::point found: -9.375000e-02 7.441149e-01 -DEAL:0::point found: -9.375000e-02 7.441149e-01 -DEAL:0::point found: -4.687500e-02 7.485333e-01 -DEAL:0::point found: -4.687500e-02 7.485333e-01 -DEAL:0::point found: 0.000000e+00 7.500000e-01 -DEAL:0::point found: 7.500000e-01 0.000000e+00 -DEAL:0::point found: 7.485333e-01 4.687500e-02 DEAL:0::point found: 7.485333e-01 4.687500e-02 -DEAL:0::point found: 7.441149e-01 9.375000e-02 -DEAL:0::point found: 7.441149e-01 9.375000e-02 -DEAL:0::point found: 7.366873e-01 1.406250e-01 -DEAL:0::point found: 7.366873e-01 1.406250e-01 -DEAL:0::point found: 7.261608e-01 1.875000e-01 -DEAL:0::point found: 7.261608e-01 1.875000e-01 -DEAL:0::point found: 7.124152e-01 2.343750e-01 -DEAL:0::point found: 7.031250e-01 2.600683e-01 -DEAL:0::point found: 6.952364e-01 2.812500e-01 -DEAL:0::point found: 7.031250e-01 2.600683e-01 -DEAL:0::point found: 7.124152e-01 2.343750e-01 -DEAL:0::point found: 6.562500e-01 3.626352e-01 -DEAL:0::point found: 6.494646e-01 3.750000e-01 -DEAL:0::point found: 6.952364e-01 2.812500e-01 -DEAL:0::point found: 6.743408e-01 3.281250e-01 -DEAL:0::point found: 6.562500e-01 3.626352e-01 -DEAL:0::point found: 6.743408e-01 3.281250e-01 -DEAL:0::point found: 0.000000e+00 7.500000e-01 -DEAL:0::point found: 4.687500e-02 7.485333e-01 -DEAL:0::point found: 4.687500e-02 7.485333e-01 -DEAL:0::point found: 9.375000e-02 7.441149e-01 -DEAL:0::point found: 9.375000e-02 7.441149e-01 -DEAL:0::point found: 1.406250e-01 7.366873e-01 -DEAL:0::point found: 1.406250e-01 7.366873e-01 -DEAL:0::point found: 1.875000e-01 7.261608e-01 -DEAL:0::point found: 3.750000e-01 6.494646e-01 -DEAL:0::point found: 3.626352e-01 6.562500e-01 -DEAL:0::point found: 2.812500e-01 6.952364e-01 -DEAL:0::point found: 2.600683e-01 7.031250e-01 -DEAL:0::point found: 1.875000e-01 7.261608e-01 -DEAL:0::point found: 2.343750e-01 7.124152e-01 -DEAL:0::point found: 2.343750e-01 7.124152e-01 -DEAL:0::point found: 2.600683e-01 7.031250e-01 -DEAL:0::point found: 2.812500e-01 6.952364e-01 -DEAL:0::point found: 3.281250e-01 6.743408e-01 -DEAL:0::point found: 3.281250e-01 6.743408e-01 -DEAL:0::point found: 3.626352e-01 6.562500e-01 -DEAL:0::point found: 5.625000e-01 4.957721e-01 -DEAL:0::point found: 5.444101e-01 5.156250e-01 -DEAL:0::point found: 5.156250e-01 5.444101e-01 -DEAL:0::point found: 4.957721e-01 5.625000e-01 -DEAL:0::point found: 5.156250e-01 5.444101e-01 -DEAL:0::point found: 5.444101e-01 5.156250e-01 -DEAL:0::point found: 6.494646e-01 3.750000e-01 -DEAL:0::point found: 6.200027e-01 4.218750e-01 -DEAL:0::point found: 6.093750e-01 4.368649e-01 -DEAL:0::point found: 5.852856e-01 4.687500e-01 -DEAL:0::point found: 6.093750e-01 4.368649e-01 -DEAL:0::point found: 6.200027e-01 4.218750e-01 -DEAL:0::point found: 5.625000e-01 4.957721e-01 -DEAL:0::point found: 5.852856e-01 4.687500e-01 -DEAL:0::point found: 4.687500e-01 5.852856e-01 -DEAL:0::point found: 4.368649e-01 6.093750e-01 -DEAL:0::point found: 3.750000e-01 6.494646e-01 -DEAL:0::point found: 4.218750e-01 6.200027e-01 -DEAL:0::point found: 4.218750e-01 6.200027e-01 -DEAL:0::point found: 4.368649e-01 6.093750e-01 -DEAL:0::point found: 4.687500e-01 5.852856e-01 -DEAL:0::point found: 4.957721e-01 5.625000e-01 +DEAL:0::point found: 7.500000e-01 0.000000e+00 DEAL:0::dim=2 iso level: 5.000000e-02 -DEAL:0::point found: -2.500000e-01 -7.599207e-01 -DEAL:0::point found: -2.782530e-01 -7.500000e-01 -DEAL:0::point found: -2.500000e-01 -7.599207e-01 -DEAL:0::point found: -2.187500e-01 -7.695005e-01 -DEAL:0::point found: -2.187500e-01 -7.695005e-01 -DEAL:0::point found: -1.875000e-01 -7.777135e-01 -DEAL:0::point found: -1.562500e-01 -7.845906e-01 -DEAL:0::point found: -1.715099e-01 -7.812500e-01 -DEAL:0::point found: -1.562500e-01 -7.845906e-01 -DEAL:0::point found: -1.250000e-01 -7.901709e-01 -DEAL:0::point found: -1.250000e-01 -7.901709e-01 -DEAL:0::point found: -9.375000e-02 -7.944858e-01 -DEAL:0::point found: -1.875000e-01 -7.777135e-01 -DEAL:0::point found: -1.715099e-01 -7.812500e-01 -DEAL:0::point found: -9.375000e-02 -7.944858e-01 -DEAL:0::point found: -6.250000e-02 -7.975538e-01 -DEAL:0::point found: -6.250000e-02 -7.975538e-01 -DEAL:0::point found: -3.125000e-02 -7.993891e-01 -DEAL:0::point found: -3.125000e-02 -7.993891e-01 -DEAL:0::point found: 0.000000e+00 -8.000000e-01 -DEAL:0::point found: -7.500000e-01 -2.782530e-01 -DEAL:0::point found: -7.599207e-01 -2.500000e-01 -DEAL:0::point found: -7.599207e-01 -2.500000e-01 -DEAL:0::point found: -7.695005e-01 -2.187500e-01 -DEAL:0::point found: -7.695005e-01 -2.187500e-01 -DEAL:0::point found: -7.777135e-01 -1.875000e-01 -DEAL:0::point found: -7.812500e-01 -1.715099e-01 -DEAL:0::point found: -7.845906e-01 -1.562500e-01 -DEAL:0::point found: -7.812500e-01 -1.715099e-01 -DEAL:0::point found: -7.777135e-01 -1.875000e-01 -DEAL:0::point found: -7.845906e-01 -1.562500e-01 -DEAL:0::point found: -7.901709e-01 -1.250000e-01 -DEAL:0::point found: -7.901709e-01 -1.250000e-01 -DEAL:0::point found: -7.944858e-01 -9.375000e-02 -DEAL:0::point found: -7.944858e-01 -9.375000e-02 -DEAL:0::point found: -7.975538e-01 -6.250000e-02 -DEAL:0::point found: -7.975538e-01 -6.250000e-02 -DEAL:0::point found: -7.993891e-01 -3.125000e-02 -DEAL:0::point found: -7.993891e-01 -3.125000e-02 DEAL:0::point found: -8.000000e-01 0.000000e+00 -DEAL:0::point found: -5.625000e-01 -5.687859e-01 -DEAL:0::point found: -5.687859e-01 -5.625000e-01 -DEAL:0::point found: -4.062500e-01 -6.891652e-01 -DEAL:0::point found: -4.090071e-01 -6.875000e-01 -DEAL:0::point found: -4.062500e-01 -6.891652e-01 -DEAL:0::point found: -3.750000e-01 -7.066284e-01 -DEAL:0::point found: -4.375000e-01 -6.697182e-01 -DEAL:0::point found: -4.573651e-01 -6.562500e-01 -DEAL:0::point found: -4.375000e-01 -6.697182e-01 -DEAL:0::point found: -4.090071e-01 -6.875000e-01 -DEAL:0::point found: -4.687500e-01 -6.482349e-01 -DEAL:0::point found: -4.993626e-01 -6.250000e-01 -DEAL:0::point found: -5.312500e-01 -5.980996e-01 -DEAL:0::point found: -5.360895e-01 -5.937500e-01 -DEAL:0::point found: -5.312500e-01 -5.980996e-01 -DEAL:0::point found: -5.000000e-01 -6.244950e-01 -DEAL:0::point found: -5.000000e-01 -6.244950e-01 -DEAL:0::point found: -4.993626e-01 -6.250000e-01 -DEAL:0::point found: -5.625000e-01 -5.687859e-01 -DEAL:0::point found: -5.360895e-01 -5.937500e-01 -DEAL:0::point found: -4.687500e-01 -6.482349e-01 -DEAL:0::point found: -4.573651e-01 -6.562500e-01 -DEAL:0::point found: -5.937500e-01 -5.360895e-01 -DEAL:0::point found: -5.980996e-01 -5.312500e-01 -DEAL:0::point found: -5.937500e-01 -5.360895e-01 -DEAL:0::point found: -5.687859e-01 -5.625000e-01 -DEAL:0::point found: -5.980996e-01 -5.312500e-01 -DEAL:0::point found: -6.244950e-01 -5.000000e-01 -DEAL:0::point found: -6.250000e-01 -4.993626e-01 -DEAL:0::point found: -6.482349e-01 -4.687500e-01 -DEAL:0::point found: -6.250000e-01 -4.993626e-01 -DEAL:0::point found: -6.244950e-01 -5.000000e-01 -DEAL:0::point found: -6.562500e-01 -4.573651e-01 -DEAL:0::point found: -6.697182e-01 -4.375000e-01 -DEAL:0::point found: -6.875000e-01 -4.090071e-01 -DEAL:0::point found: -6.891652e-01 -4.062500e-01 -DEAL:0::point found: -6.875000e-01 -4.090071e-01 -DEAL:0::point found: -6.697182e-01 -4.375000e-01 -DEAL:0::point found: -6.891652e-01 -4.062500e-01 -DEAL:0::point found: -7.066284e-01 -3.750000e-01 -DEAL:0::point found: -6.562500e-01 -4.573651e-01 -DEAL:0::point found: -6.482349e-01 -4.687500e-01 -DEAL:0::point found: -3.437500e-01 -7.223697e-01 -DEAL:0::point found: -3.510815e-01 -7.187500e-01 -DEAL:0::point found: -3.437500e-01 -7.223697e-01 -DEAL:0::point found: -3.125000e-01 -7.364149e-01 -DEAL:0::point found: -3.125000e-01 -7.364149e-01 -DEAL:0::point found: -2.812500e-01 -7.489288e-01 -DEAL:0::point found: -3.750000e-01 -7.066284e-01 -DEAL:0::point found: -3.510815e-01 -7.187500e-01 -DEAL:0::point found: -2.812500e-01 -7.489288e-01 -DEAL:0::point found: -2.782530e-01 -7.500000e-01 -DEAL:0::point found: -7.187500e-01 -3.510815e-01 -DEAL:0::point found: -7.223697e-01 -3.437500e-01 -DEAL:0::point found: -7.187500e-01 -3.510815e-01 -DEAL:0::point found: -7.066284e-01 -3.750000e-01 -DEAL:0::point found: -7.223697e-01 -3.437500e-01 -DEAL:0::point found: -7.364149e-01 -3.125000e-01 -DEAL:0::point found: -7.364149e-01 -3.125000e-01 -DEAL:0::point found: -7.489288e-01 -2.812500e-01 -DEAL:0::point found: -7.500000e-01 -2.782530e-01 -DEAL:0::point found: -7.489288e-01 -2.812500e-01 -DEAL:0::point found: 0.000000e+00 -8.000000e-01 -DEAL:0::point found: 3.125000e-02 -7.993891e-01 -DEAL:0::point found: 3.125000e-02 -7.993891e-01 -DEAL:0::point found: 6.250000e-02 -7.975538e-01 -DEAL:0::point found: 6.250000e-02 -7.975538e-01 -DEAL:0::point found: 9.375000e-02 -7.944858e-01 -DEAL:0::point found: 9.375000e-02 -7.944858e-01 -DEAL:0::point found: 1.250000e-01 -7.901709e-01 -DEAL:0::point found: 1.250000e-01 -7.901709e-01 -DEAL:0::point found: 1.562500e-01 -7.845906e-01 -DEAL:0::point found: 1.562500e-01 -7.845906e-01 -DEAL:0::point found: 1.715099e-01 -7.812500e-01 -DEAL:0::point found: 1.715099e-01 -7.812500e-01 -DEAL:0::point found: 1.875000e-01 -7.777135e-01 -DEAL:0::point found: 1.875000e-01 -7.777135e-01 -DEAL:0::point found: 2.187500e-01 -7.695005e-01 -DEAL:0::point found: 2.187500e-01 -7.695005e-01 -DEAL:0::point found: 2.500000e-01 -7.599207e-01 -DEAL:0::point found: 2.500000e-01 -7.599207e-01 -DEAL:0::point found: 2.782530e-01 -7.500000e-01 -DEAL:0::point found: 2.782530e-01 -7.500000e-01 -DEAL:0::point found: 2.812500e-01 -7.489288e-01 -DEAL:0::point found: 2.812500e-01 -7.489288e-01 -DEAL:0::point found: 3.125000e-01 -7.364149e-01 -DEAL:0::point found: 3.125000e-01 -7.364149e-01 -DEAL:0::point found: 3.437500e-01 -7.223697e-01 -DEAL:0::point found: 3.437500e-01 -7.223697e-01 -DEAL:0::point found: 3.510815e-01 -7.187500e-01 -DEAL:0::point found: 3.510815e-01 -7.187500e-01 -DEAL:0::point found: 3.750000e-01 -7.066284e-01 -DEAL:0::point found: 3.750000e-01 -7.066284e-01 -DEAL:0::point found: 4.062500e-01 -6.891652e-01 -DEAL:0::point found: 4.062500e-01 -6.891652e-01 -DEAL:0::point found: 4.090071e-01 -6.875000e-01 -DEAL:0::point found: 4.090071e-01 -6.875000e-01 -DEAL:0::point found: 4.375000e-01 -6.697182e-01 -DEAL:0::point found: 4.375000e-01 -6.697182e-01 -DEAL:0::point found: 4.573651e-01 -6.562500e-01 -DEAL:0::point found: 4.573651e-01 -6.562500e-01 -DEAL:0::point found: 4.687500e-01 -6.482349e-01 -DEAL:0::point found: 4.687500e-01 -6.482349e-01 -DEAL:0::point found: 4.993626e-01 -6.250000e-01 -DEAL:0::point found: 4.993626e-01 -6.250000e-01 -DEAL:0::point found: 5.000000e-01 -6.244950e-01 -DEAL:0::point found: 5.000000e-01 -6.244950e-01 -DEAL:0::point found: 5.312500e-01 -5.980996e-01 -DEAL:0::point found: 5.312500e-01 -5.980996e-01 -DEAL:0::point found: 5.360895e-01 -5.937500e-01 -DEAL:0::point found: 5.360895e-01 -5.937500e-01 -DEAL:0::point found: 5.625000e-01 -5.687859e-01 -DEAL:0::point found: 5.625000e-01 -5.687859e-01 -DEAL:0::point found: 5.687859e-01 -5.625000e-01 -DEAL:0::point found: 5.687859e-01 -5.625000e-01 -DEAL:0::point found: 5.937500e-01 -5.360895e-01 -DEAL:0::point found: 5.937500e-01 -5.360895e-01 -DEAL:0::point found: 5.980996e-01 -5.312500e-01 -DEAL:0::point found: 5.980996e-01 -5.312500e-01 -DEAL:0::point found: 6.244950e-01 -5.000000e-01 -DEAL:0::point found: 6.244950e-01 -5.000000e-01 -DEAL:0::point found: 6.250000e-01 -4.993626e-01 -DEAL:0::point found: 6.250000e-01 -4.993626e-01 -DEAL:0::point found: 6.482349e-01 -4.687500e-01 -DEAL:0::point found: 6.482349e-01 -4.687500e-01 -DEAL:0::point found: 6.562500e-01 -4.573651e-01 -DEAL:0::point found: 6.562500e-01 -4.573651e-01 -DEAL:0::point found: 6.697182e-01 -4.375000e-01 -DEAL:0::point found: 6.697182e-01 -4.375000e-01 -DEAL:0::point found: 6.875000e-01 -4.090071e-01 -DEAL:0::point found: 6.875000e-01 -4.090071e-01 -DEAL:0::point found: 6.891652e-01 -4.062500e-01 -DEAL:0::point found: 6.891652e-01 -4.062500e-01 -DEAL:0::point found: 7.066284e-01 -3.750000e-01 -DEAL:0::point found: 7.066284e-01 -3.750000e-01 -DEAL:0::point found: 7.187500e-01 -3.510815e-01 -DEAL:0::point found: 7.187500e-01 -3.510815e-01 -DEAL:0::point found: 7.223697e-01 -3.437500e-01 -DEAL:0::point found: 7.223697e-01 -3.437500e-01 -DEAL:0::point found: 7.364149e-01 -3.125000e-01 -DEAL:0::point found: 7.364149e-01 -3.125000e-01 -DEAL:0::point found: 7.489288e-01 -2.812500e-01 -DEAL:0::point found: 7.489288e-01 -2.812500e-01 -DEAL:0::point found: 7.500000e-01 -2.782530e-01 -DEAL:0::point found: 7.500000e-01 -2.782530e-01 -DEAL:0::point found: 7.599207e-01 -2.500000e-01 -DEAL:0::point found: 7.599207e-01 -2.500000e-01 -DEAL:0::point found: 7.695005e-01 -2.187500e-01 -DEAL:0::point found: 7.695005e-01 -2.187500e-01 -DEAL:0::point found: 7.777135e-01 -1.875000e-01 -DEAL:0::point found: 7.777135e-01 -1.875000e-01 -DEAL:0::point found: 7.812500e-01 -1.715099e-01 -DEAL:0::point found: 7.812500e-01 -1.715099e-01 -DEAL:0::point found: 7.845906e-01 -1.562500e-01 -DEAL:0::point found: 7.845906e-01 -1.562500e-01 -DEAL:0::point found: 7.901709e-01 -1.250000e-01 -DEAL:0::point found: 7.901709e-01 -1.250000e-01 -DEAL:0::point found: 7.944858e-01 -9.375000e-02 -DEAL:0::point found: 7.944858e-01 -9.375000e-02 -DEAL:0::point found: 7.975538e-01 -6.250000e-02 -DEAL:0::point found: 7.975538e-01 -6.250000e-02 -DEAL:0::point found: 7.993891e-01 -3.125000e-02 -DEAL:0::point found: 7.993891e-01 -3.125000e-02 -DEAL:0::point found: 8.000000e-01 0.000000e+00 -DEAL:0::point found: -8.000000e-01 0.000000e+00 -DEAL:0::point found: -7.993891e-01 3.125000e-02 +DEAL:0::point found: -7.993891e-01 -3.125000e-02 DEAL:0::point found: -7.993891e-01 3.125000e-02 +DEAL:0::point found: -7.975538e-01 -6.250000e-02 DEAL:0::point found: -7.975538e-01 6.250000e-02 -DEAL:0::point found: -7.975538e-01 6.250000e-02 -DEAL:0::point found: -7.944858e-01 9.375000e-02 +DEAL:0::point found: -7.944858e-01 -9.375000e-02 DEAL:0::point found: -7.944858e-01 9.375000e-02 +DEAL:0::point found: -7.901709e-01 -1.250000e-01 DEAL:0::point found: -7.901709e-01 1.250000e-01 -DEAL:0::point found: -7.901709e-01 1.250000e-01 -DEAL:0::point found: -7.845906e-01 1.562500e-01 -DEAL:0::point found: -7.812500e-01 1.715099e-01 +DEAL:0::point found: -7.845906e-01 -1.562500e-01 DEAL:0::point found: -7.845906e-01 1.562500e-01 +DEAL:0::point found: -7.812500e-01 -1.715099e-01 DEAL:0::point found: -7.812500e-01 1.715099e-01 +DEAL:0::point found: -7.777135e-01 -1.875000e-01 DEAL:0::point found: -7.777135e-01 1.875000e-01 -DEAL:0::point found: -7.777135e-01 1.875000e-01 -DEAL:0::point found: -7.695005e-01 2.187500e-01 +DEAL:0::point found: -7.695005e-01 -2.187500e-01 DEAL:0::point found: -7.695005e-01 2.187500e-01 +DEAL:0::point found: -7.599207e-01 -2.500000e-01 DEAL:0::point found: -7.599207e-01 2.500000e-01 +DEAL:0::point found: -7.500000e-01 -2.782530e-01 DEAL:0::point found: -7.500000e-01 2.782530e-01 -DEAL:0::point found: -7.599207e-01 2.500000e-01 -DEAL:0::point found: -7.500000e-01 2.782530e-01 -DEAL:0::point found: -7.489288e-01 2.812500e-01 +DEAL:0::point found: -7.489288e-01 -2.812500e-01 DEAL:0::point found: -7.489288e-01 2.812500e-01 +DEAL:0::point found: -7.364149e-01 -3.125000e-01 DEAL:0::point found: -7.364149e-01 3.125000e-01 -DEAL:0::point found: -7.364149e-01 3.125000e-01 -DEAL:0::point found: -7.223697e-01 3.437500e-01 -DEAL:0::point found: -7.187500e-01 3.510815e-01 +DEAL:0::point found: -7.223697e-01 -3.437500e-01 DEAL:0::point found: -7.223697e-01 3.437500e-01 +DEAL:0::point found: -7.187500e-01 -3.510815e-01 DEAL:0::point found: -7.187500e-01 3.510815e-01 +DEAL:0::point found: -7.066284e-01 -3.750000e-01 DEAL:0::point found: -7.066284e-01 3.750000e-01 -DEAL:0::point found: -7.066284e-01 3.750000e-01 -DEAL:0::point found: -6.891652e-01 4.062500e-01 -DEAL:0::point found: -6.875000e-01 4.090071e-01 +DEAL:0::point found: -6.891652e-01 -4.062500e-01 DEAL:0::point found: -6.891652e-01 4.062500e-01 +DEAL:0::point found: -6.875000e-01 -4.090071e-01 DEAL:0::point found: -6.875000e-01 4.090071e-01 +DEAL:0::point found: -6.697182e-01 -4.375000e-01 DEAL:0::point found: -6.697182e-01 4.375000e-01 +DEAL:0::point found: -6.562500e-01 -4.573651e-01 DEAL:0::point found: -6.562500e-01 4.573651e-01 -DEAL:0::point found: -6.697182e-01 4.375000e-01 -DEAL:0::point found: -6.562500e-01 4.573651e-01 -DEAL:0::point found: -6.482349e-01 4.687500e-01 -DEAL:0::point found: -6.250000e-01 4.993626e-01 +DEAL:0::point found: -6.482349e-01 -4.687500e-01 DEAL:0::point found: -6.482349e-01 4.687500e-01 +DEAL:0::point found: -6.250000e-01 -4.993626e-01 DEAL:0::point found: -6.250000e-01 4.993626e-01 +DEAL:0::point found: -6.244950e-01 -5.000000e-01 DEAL:0::point found: -6.244950e-01 5.000000e-01 -DEAL:0::point found: -6.244950e-01 5.000000e-01 -DEAL:0::point found: -5.980996e-01 5.312500e-01 -DEAL:0::point found: -5.937500e-01 5.360895e-01 +DEAL:0::point found: -5.980996e-01 -5.312500e-01 DEAL:0::point found: -5.980996e-01 5.312500e-01 +DEAL:0::point found: -5.937500e-01 -5.360895e-01 DEAL:0::point found: -5.937500e-01 5.360895e-01 +DEAL:0::point found: -5.687859e-01 -5.625000e-01 DEAL:0::point found: -5.687859e-01 5.625000e-01 +DEAL:0::point found: -5.625000e-01 -5.687859e-01 DEAL:0::point found: -5.625000e-01 5.687859e-01 -DEAL:0::point found: -5.687859e-01 5.625000e-01 -DEAL:0::point found: -5.625000e-01 5.687859e-01 -DEAL:0::point found: -5.360895e-01 5.937500e-01 -DEAL:0::point found: -5.312500e-01 5.980996e-01 +DEAL:0::point found: -5.360895e-01 -5.937500e-01 DEAL:0::point found: -5.360895e-01 5.937500e-01 +DEAL:0::point found: -5.312500e-01 -5.980996e-01 DEAL:0::point found: -5.312500e-01 5.980996e-01 +DEAL:0::point found: -5.000000e-01 -6.244950e-01 DEAL:0::point found: -5.000000e-01 6.244950e-01 -DEAL:0::point found: -5.000000e-01 6.244950e-01 -DEAL:0::point found: -4.993626e-01 6.250000e-01 -DEAL:0::point found: -4.687500e-01 6.482349e-01 +DEAL:0::point found: -4.993626e-01 -6.250000e-01 DEAL:0::point found: -4.993626e-01 6.250000e-01 +DEAL:0::point found: -4.687500e-01 -6.482349e-01 DEAL:0::point found: -4.687500e-01 6.482349e-01 +DEAL:0::point found: -4.573651e-01 -6.562500e-01 DEAL:0::point found: -4.573651e-01 6.562500e-01 +DEAL:0::point found: -4.375000e-01 -6.697182e-01 DEAL:0::point found: -4.375000e-01 6.697182e-01 -DEAL:0::point found: -4.573651e-01 6.562500e-01 -DEAL:0::point found: -4.375000e-01 6.697182e-01 -DEAL:0::point found: -4.090071e-01 6.875000e-01 -DEAL:0::point found: -4.062500e-01 6.891652e-01 +DEAL:0::point found: -4.090071e-01 -6.875000e-01 DEAL:0::point found: -4.090071e-01 6.875000e-01 +DEAL:0::point found: -4.062500e-01 -6.891652e-01 DEAL:0::point found: -4.062500e-01 6.891652e-01 +DEAL:0::point found: -3.750000e-01 -7.066284e-01 DEAL:0::point found: -3.750000e-01 7.066284e-01 -DEAL:0::point found: -3.750000e-01 7.066284e-01 -DEAL:0::point found: -3.510815e-01 7.187500e-01 -DEAL:0::point found: -3.437500e-01 7.223697e-01 +DEAL:0::point found: -3.510815e-01 -7.187500e-01 DEAL:0::point found: -3.510815e-01 7.187500e-01 +DEAL:0::point found: -3.437500e-01 -7.223697e-01 DEAL:0::point found: -3.437500e-01 7.223697e-01 +DEAL:0::point found: -3.125000e-01 -7.364149e-01 DEAL:0::point found: -3.125000e-01 7.364149e-01 -DEAL:0::point found: -3.125000e-01 7.364149e-01 -DEAL:0::point found: -2.812500e-01 7.489288e-01 +DEAL:0::point found: -2.812500e-01 -7.489288e-01 DEAL:0::point found: -2.812500e-01 7.489288e-01 +DEAL:0::point found: -2.782530e-01 -7.500000e-01 DEAL:0::point found: -2.782530e-01 7.500000e-01 +DEAL:0::point found: -2.500000e-01 -7.599207e-01 DEAL:0::point found: -2.500000e-01 7.599207e-01 -DEAL:0::point found: -2.782530e-01 7.500000e-01 -DEAL:0::point found: -2.500000e-01 7.599207e-01 -DEAL:0::point found: -2.187500e-01 7.695005e-01 +DEAL:0::point found: -2.187500e-01 -7.695005e-01 DEAL:0::point found: -2.187500e-01 7.695005e-01 +DEAL:0::point found: -1.875000e-01 -7.777135e-01 DEAL:0::point found: -1.875000e-01 7.777135e-01 -DEAL:0::point found: -1.875000e-01 7.777135e-01 -DEAL:0::point found: -1.715099e-01 7.812500e-01 -DEAL:0::point found: -1.562500e-01 7.845906e-01 +DEAL:0::point found: -1.715099e-01 -7.812500e-01 DEAL:0::point found: -1.715099e-01 7.812500e-01 +DEAL:0::point found: -1.562500e-01 -7.845906e-01 DEAL:0::point found: -1.562500e-01 7.845906e-01 +DEAL:0::point found: -1.250000e-01 -7.901709e-01 DEAL:0::point found: -1.250000e-01 7.901709e-01 -DEAL:0::point found: -1.250000e-01 7.901709e-01 -DEAL:0::point found: -9.375000e-02 7.944858e-01 +DEAL:0::point found: -9.375000e-02 -7.944858e-01 DEAL:0::point found: -9.375000e-02 7.944858e-01 +DEAL:0::point found: -6.250000e-02 -7.975538e-01 DEAL:0::point found: -6.250000e-02 7.975538e-01 -DEAL:0::point found: -6.250000e-02 7.975538e-01 -DEAL:0::point found: -3.125000e-02 7.993891e-01 +DEAL:0::point found: -3.125000e-02 -7.993891e-01 DEAL:0::point found: -3.125000e-02 7.993891e-01 +DEAL:0::point found: 0.000000e+00 -8.000000e-01 DEAL:0::point found: 0.000000e+00 8.000000e-01 -DEAL:0::point found: 7.500000e-01 2.782530e-01 -DEAL:0::point found: 7.489288e-01 2.812500e-01 -DEAL:0::point found: 7.489288e-01 2.812500e-01 -DEAL:0::point found: 7.364149e-01 3.125000e-01 -DEAL:0::point found: 7.364149e-01 3.125000e-01 -DEAL:0::point found: 7.223697e-01 3.437500e-01 -DEAL:0::point found: 7.187500e-01 3.510815e-01 -DEAL:0::point found: 7.066284e-01 3.750000e-01 -DEAL:0::point found: 7.187500e-01 3.510815e-01 -DEAL:0::point found: 7.223697e-01 3.437500e-01 -DEAL:0::point found: 2.812500e-01 7.489288e-01 +DEAL:0::point found: 3.125000e-02 -7.993891e-01 +DEAL:0::point found: 3.125000e-02 7.993891e-01 +DEAL:0::point found: 6.250000e-02 -7.975538e-01 +DEAL:0::point found: 6.250000e-02 7.975538e-01 +DEAL:0::point found: 9.375000e-02 -7.944858e-01 +DEAL:0::point found: 9.375000e-02 7.944858e-01 +DEAL:0::point found: 1.250000e-01 -7.901709e-01 +DEAL:0::point found: 1.250000e-01 7.901709e-01 +DEAL:0::point found: 1.562500e-01 -7.845906e-01 +DEAL:0::point found: 1.562500e-01 7.845906e-01 +DEAL:0::point found: 1.715099e-01 -7.812500e-01 +DEAL:0::point found: 1.715099e-01 7.812500e-01 +DEAL:0::point found: 1.875000e-01 -7.777135e-01 +DEAL:0::point found: 1.875000e-01 7.777135e-01 +DEAL:0::point found: 2.187500e-01 -7.695005e-01 +DEAL:0::point found: 2.187500e-01 7.695005e-01 +DEAL:0::point found: 2.500000e-01 -7.599207e-01 +DEAL:0::point found: 2.500000e-01 7.599207e-01 +DEAL:0::point found: 2.782530e-01 -7.500000e-01 DEAL:0::point found: 2.782530e-01 7.500000e-01 -DEAL:0::point found: 3.750000e-01 7.066284e-01 -DEAL:0::point found: 3.510815e-01 7.187500e-01 +DEAL:0::point found: 2.812500e-01 -7.489288e-01 DEAL:0::point found: 2.812500e-01 7.489288e-01 +DEAL:0::point found: 3.125000e-01 -7.364149e-01 DEAL:0::point found: 3.125000e-01 7.364149e-01 -DEAL:0::point found: 3.125000e-01 7.364149e-01 -DEAL:0::point found: 3.437500e-01 7.223697e-01 +DEAL:0::point found: 3.437500e-01 -7.223697e-01 DEAL:0::point found: 3.437500e-01 7.223697e-01 +DEAL:0::point found: 3.510815e-01 -7.187500e-01 DEAL:0::point found: 3.510815e-01 7.187500e-01 -DEAL:0::point found: 6.562500e-01 4.573651e-01 -DEAL:0::point found: 6.482349e-01 4.687500e-01 -DEAL:0::point found: 7.066284e-01 3.750000e-01 -DEAL:0::point found: 6.891652e-01 4.062500e-01 -DEAL:0::point found: 6.875000e-01 4.090071e-01 -DEAL:0::point found: 6.697182e-01 4.375000e-01 -DEAL:0::point found: 6.875000e-01 4.090071e-01 -DEAL:0::point found: 6.891652e-01 4.062500e-01 -DEAL:0::point found: 6.562500e-01 4.573651e-01 -DEAL:0::point found: 6.697182e-01 4.375000e-01 -DEAL:0::point found: 6.250000e-01 4.993626e-01 -DEAL:0::point found: 6.244950e-01 5.000000e-01 -DEAL:0::point found: 6.250000e-01 4.993626e-01 -DEAL:0::point found: 6.482349e-01 4.687500e-01 -DEAL:0::point found: 6.244950e-01 5.000000e-01 -DEAL:0::point found: 5.980996e-01 5.312500e-01 -DEAL:0::point found: 5.937500e-01 5.360895e-01 -DEAL:0::point found: 5.687859e-01 5.625000e-01 -DEAL:0::point found: 5.937500e-01 5.360895e-01 -DEAL:0::point found: 5.980996e-01 5.312500e-01 -DEAL:0::point found: 4.687500e-01 6.482349e-01 +DEAL:0::point found: 3.750000e-01 -7.066284e-01 +DEAL:0::point found: 3.750000e-01 7.066284e-01 +DEAL:0::point found: 4.062500e-01 -6.891652e-01 +DEAL:0::point found: 4.062500e-01 6.891652e-01 +DEAL:0::point found: 4.090071e-01 -6.875000e-01 +DEAL:0::point found: 4.090071e-01 6.875000e-01 +DEAL:0::point found: 4.375000e-01 -6.697182e-01 +DEAL:0::point found: 4.375000e-01 6.697182e-01 +DEAL:0::point found: 4.573651e-01 -6.562500e-01 DEAL:0::point found: 4.573651e-01 6.562500e-01 -DEAL:0::point found: 5.625000e-01 5.687859e-01 -DEAL:0::point found: 5.360895e-01 5.937500e-01 -DEAL:0::point found: 5.000000e-01 6.244950e-01 +DEAL:0::point found: 4.687500e-01 -6.482349e-01 +DEAL:0::point found: 4.687500e-01 6.482349e-01 +DEAL:0::point found: 4.993626e-01 -6.250000e-01 DEAL:0::point found: 4.993626e-01 6.250000e-01 +DEAL:0::point found: 5.000000e-01 -6.244950e-01 DEAL:0::point found: 5.000000e-01 6.244950e-01 +DEAL:0::point found: 5.312500e-01 -5.980996e-01 DEAL:0::point found: 5.312500e-01 5.980996e-01 -DEAL:0::point found: 5.312500e-01 5.980996e-01 +DEAL:0::point found: 5.360895e-01 -5.937500e-01 DEAL:0::point found: 5.360895e-01 5.937500e-01 -DEAL:0::point found: 4.687500e-01 6.482349e-01 -DEAL:0::point found: 4.993626e-01 6.250000e-01 -DEAL:0::point found: 4.375000e-01 6.697182e-01 -DEAL:0::point found: 4.090071e-01 6.875000e-01 -DEAL:0::point found: 4.375000e-01 6.697182e-01 -DEAL:0::point found: 4.573651e-01 6.562500e-01 -DEAL:0::point found: 3.750000e-01 7.066284e-01 -DEAL:0::point found: 4.062500e-01 6.891652e-01 -DEAL:0::point found: 4.062500e-01 6.891652e-01 -DEAL:0::point found: 4.090071e-01 6.875000e-01 +DEAL:0::point found: 5.625000e-01 -5.687859e-01 DEAL:0::point found: 5.625000e-01 5.687859e-01 +DEAL:0::point found: 5.687859e-01 -5.625000e-01 DEAL:0::point found: 5.687859e-01 5.625000e-01 -DEAL:0::point found: 8.000000e-01 0.000000e+00 -DEAL:0::point found: 7.993891e-01 3.125000e-02 -DEAL:0::point found: 7.993891e-01 3.125000e-02 -DEAL:0::point found: 7.975538e-01 6.250000e-02 -DEAL:0::point found: 7.975538e-01 6.250000e-02 -DEAL:0::point found: 7.944858e-01 9.375000e-02 -DEAL:0::point found: 7.944858e-01 9.375000e-02 -DEAL:0::point found: 7.901709e-01 1.250000e-01 -DEAL:0::point found: 7.901709e-01 1.250000e-01 -DEAL:0::point found: 7.845906e-01 1.562500e-01 -DEAL:0::point found: 7.812500e-01 1.715099e-01 +DEAL:0::point found: 5.937500e-01 -5.360895e-01 +DEAL:0::point found: 5.937500e-01 5.360895e-01 +DEAL:0::point found: 5.980996e-01 -5.312500e-01 +DEAL:0::point found: 5.980996e-01 5.312500e-01 +DEAL:0::point found: 6.244950e-01 -5.000000e-01 +DEAL:0::point found: 6.244950e-01 5.000000e-01 +DEAL:0::point found: 6.250000e-01 -4.993626e-01 +DEAL:0::point found: 6.250000e-01 4.993626e-01 +DEAL:0::point found: 6.482349e-01 -4.687500e-01 +DEAL:0::point found: 6.482349e-01 4.687500e-01 +DEAL:0::point found: 6.562500e-01 -4.573651e-01 +DEAL:0::point found: 6.562500e-01 4.573651e-01 +DEAL:0::point found: 6.697182e-01 -4.375000e-01 +DEAL:0::point found: 6.697182e-01 4.375000e-01 +DEAL:0::point found: 6.875000e-01 -4.090071e-01 +DEAL:0::point found: 6.875000e-01 4.090071e-01 +DEAL:0::point found: 6.891652e-01 -4.062500e-01 +DEAL:0::point found: 6.891652e-01 4.062500e-01 +DEAL:0::point found: 7.066284e-01 -3.750000e-01 +DEAL:0::point found: 7.066284e-01 3.750000e-01 +DEAL:0::point found: 7.187500e-01 -3.510815e-01 +DEAL:0::point found: 7.187500e-01 3.510815e-01 +DEAL:0::point found: 7.223697e-01 -3.437500e-01 +DEAL:0::point found: 7.223697e-01 3.437500e-01 +DEAL:0::point found: 7.364149e-01 -3.125000e-01 +DEAL:0::point found: 7.364149e-01 3.125000e-01 +DEAL:0::point found: 7.489288e-01 -2.812500e-01 +DEAL:0::point found: 7.489288e-01 2.812500e-01 +DEAL:0::point found: 7.500000e-01 -2.782530e-01 +DEAL:0::point found: 7.500000e-01 2.782530e-01 +DEAL:0::point found: 7.599207e-01 -2.500000e-01 +DEAL:0::point found: 7.599207e-01 2.500000e-01 +DEAL:0::point found: 7.695005e-01 -2.187500e-01 +DEAL:0::point found: 7.695005e-01 2.187500e-01 +DEAL:0::point found: 7.777135e-01 -1.875000e-01 DEAL:0::point found: 7.777135e-01 1.875000e-01 +DEAL:0::point found: 7.812500e-01 -1.715099e-01 DEAL:0::point found: 7.812500e-01 1.715099e-01 +DEAL:0::point found: 7.845906e-01 -1.562500e-01 DEAL:0::point found: 7.845906e-01 1.562500e-01 -DEAL:0::point found: 7.777135e-01 1.875000e-01 -DEAL:0::point found: 7.695005e-01 2.187500e-01 -DEAL:0::point found: 7.695005e-01 2.187500e-01 -DEAL:0::point found: 7.599207e-01 2.500000e-01 -DEAL:0::point found: 7.500000e-01 2.782530e-01 -DEAL:0::point found: 7.599207e-01 2.500000e-01 -DEAL:0::point found: 0.000000e+00 8.000000e-01 -DEAL:0::point found: 3.125000e-02 7.993891e-01 -DEAL:0::point found: 3.125000e-02 7.993891e-01 -DEAL:0::point found: 6.250000e-02 7.975538e-01 -DEAL:0::point found: 6.250000e-02 7.975538e-01 -DEAL:0::point found: 9.375000e-02 7.944858e-01 -DEAL:0::point found: 1.875000e-01 7.777135e-01 -DEAL:0::point found: 1.715099e-01 7.812500e-01 -DEAL:0::point found: 9.375000e-02 7.944858e-01 -DEAL:0::point found: 1.250000e-01 7.901709e-01 -DEAL:0::point found: 1.250000e-01 7.901709e-01 -DEAL:0::point found: 1.562500e-01 7.845906e-01 -DEAL:0::point found: 1.562500e-01 7.845906e-01 -DEAL:0::point found: 1.715099e-01 7.812500e-01 -DEAL:0::point found: 1.875000e-01 7.777135e-01 -DEAL:0::point found: 2.187500e-01 7.695005e-01 -DEAL:0::point found: 2.187500e-01 7.695005e-01 -DEAL:0::point found: 2.500000e-01 7.599207e-01 -DEAL:0::point found: 2.500000e-01 7.599207e-01 -DEAL:0::point found: 2.782530e-01 7.500000e-01 +DEAL:0::point found: 7.901709e-01 -1.250000e-01 +DEAL:0::point found: 7.901709e-01 1.250000e-01 +DEAL:0::point found: 7.944858e-01 -9.375000e-02 +DEAL:0::point found: 7.944858e-01 9.375000e-02 +DEAL:0::point found: 7.975538e-01 -6.250000e-02 +DEAL:0::point found: 7.975538e-01 6.250000e-02 +DEAL:0::point found: 7.993891e-01 -3.125000e-02 +DEAL:0::point found: 7.993891e-01 3.125000e-02 +DEAL:0::point found: 8.000000e-01 0.000000e+00