From: Martin Kronbichler Date: Mon, 6 Apr 2020 06:56:48 +0000 (+0200) Subject: Add test case by Doug Shi-Dong X-Git-Tag: v9.2.0-rc1~283^2 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=refs%2Fpull%2F9827%2Fhead;p=dealii.git Add test case by Doug Shi-Dong --- diff --git a/tests/mappings/mapping_fe_field_08.cc b/tests/mappings/mapping_fe_field_08.cc new file mode 100644 index 0000000000..21c71d8844 --- /dev/null +++ b/tests/mappings/mapping_fe_field_08.cc @@ -0,0 +1,211 @@ +// --------------------------------------------------------------------- +// +// Copyright (C) 2017 - 2018 by the deal.II authors +// +// This file is part of the deal.II library. +// +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + + +// find_all_active_cells_around_point for a deformed shell mesh + +#include +#include + +#include +#include +#include +#include + +#include +#include + +#include + +#include "../tests.h" + + + +template +void +print_result(const Mapping & mapping, + const Triangulation &tria, + const Point p, + const double tolerance) +{ + deallog << "Testing " << dim << "D with point " << p << " tolerance " + << tolerance << std::endl; + auto c_p = + GridTools::find_all_active_cells_around_point(mapping, tria, p, tolerance); + for (auto i : c_p) + deallog << "Cell: " << i.first->id() << " unit point " << i.second + << std::endl; + deallog << std::endl; +} + + + +template +void +do_test(const Mapping &mapping, const Triangulation &tria) +{ + { + const double phi = 0.; + const double theta = 0.5 * numbers::PI; + for (unsigned int i = 0; i <= 4; ++i) + { + const double r = 0.8 + 0.2 * i / 4; + Point p; + p[0] = std::cos(phi) * std::sin(theta) * r; + p[1] = std::sin(phi) * std::sin(theta) * r; + if (dim == 3) + p[2] = std::cos(theta) * r; + print_result(mapping, tria, p, 1e-8); + } + } + { + const double phi = 0.25 * numbers::PI; + const double theta = 0.5 * numbers::PI; + for (unsigned int i = 0; i <= 4; ++i) + { + const double r = 0.8 + 0.2 * i / 4; + Point p; + p[0] = std::cos(phi) * std::sin(theta) * r; + p[1] = std::sin(phi) * std::sin(theta) * r; + if (dim == 3) + p[2] = std::cos(theta) * r; + print_result(mapping, tria, p, 1e-8); + print_result(mapping, tria, p, 1e-12); + } + } + { + const double phi = 0.3 * numbers::PI; + const double theta = 0.5 * numbers::PI; + for (unsigned int i = 0; i <= 4; ++i) + { + const double r = 0.8 + 0.2 * i / 4; + Point p; + p[0] = std::cos(phi) * std::sin(theta) * r; + p[1] = std::sin(phi) * std::sin(theta) * r; + if (dim == 3) + p[2] = std::cos(theta) * r; + print_result(mapping, tria, p, 1e-8); + } + } + { + const double phi = 0.5 * numbers::PI; + const double theta = 0.5 * numbers::PI; + for (unsigned int i = 0; i <= 4; ++i) + { + const double r = 0.8 + 0.2 * i / 4; + Point p; + p[0] = std::cos(phi) * std::sin(theta) * r; + p[1] = std::sin(phi) * std::sin(theta) * r; + if (dim == 3) + p[2] = std::cos(theta) * r; + print_result(mapping, tria, p, 1e-8); + } + } + { + const double phi = 0.75 * numbers::PI; + const double theta = 0.5 * numbers::PI; + for (unsigned int i = 0; i <= 4; ++i) + { + const double r = 0.8 + 0.2 * i / 4; + Point p; + p[0] = std::cos(phi) * std::sin(theta) * r; + p[1] = std::sin(phi) * std::sin(theta) * r; + if (dim == 3) + p[2] = std::cos(theta) * r; + print_result(mapping, tria, p, 1e-8); + } + } + if (dim == 3) + { + const double phi = 0.75 * numbers::PI; + const double theta = 0.; + for (unsigned int i = 0; i <= 4; ++i) + { + const double r = 0.8 + 0.2 * i / 4; + Point p; + p[0] = std::cos(phi) * std::sin(theta) * r; + p[1] = std::sin(phi) * std::sin(theta) * r; + if (dim == 3) + p[2] = std::cos(theta) * r; + print_result(mapping, tria, p, 1e-8); + } + } + if (dim == 3) + { + const double phi = 0.3 * numbers::PI; + const double theta = 0.1; + for (unsigned int i = 0; i <= 6; ++i) + { + const double r = 0.8 + 0.2 * i / 6; + Point p; + p[0] = std::cos(phi) * std::sin(theta) * r; + p[1] = std::sin(phi) * std::sin(theta) * r; + if (dim == 3) + p[2] = std::cos(theta) * r; + print_result(mapping, tria, p, 1e-8); + } + } +} + + + +template +void +test(unsigned int n_ref) +{ + Triangulation tria; + GridGenerator::hyper_shell(tria, Point(), 0.8, 1., dim == 2 ? 3 : 6); + tria.refine_global(n_ref); + const unsigned int fe_degree = dim == 2 ? 8 : 4; + MappingQGeneric mapping_q(fe_degree); + + FE_Q fe_q(fe_degree); + FESystem fe_system(fe_q, dim); + dealii::DoFHandler dofh; + dofh.initialize(tria, fe_system); + dofh.distribute_dofs(fe_system); + + const ComponentMask mask(dim, true); + Vector nodes; + nodes.reinit(dofh.n_dofs()); + + VectorTools::get_position_vector(dofh, nodes, mask); + MappingFEField, DoFHandler> mapping(dofh, + nodes, + mask); + + deallog << "Test with MappingQGeneric in " << dim << "D on " + << tria.n_active_cells() << " cells:" << std::endl; + do_test(mapping_q, tria); + deallog << std::endl; + deallog << "Test with MappingFEField in " << dim << "D on " + << tria.n_active_cells() << " cells:" << std::endl; + do_test(mapping, tria); + deallog << std::endl; +} + + + +int +main() +{ + initlog(); + deallog << std::setprecision(10); + + test<2, 2>(1); + test<2, 2>(2); + test<3, 3>(1); + test<3, 3>(2); +} diff --git a/tests/mappings/mapping_fe_field_08.output b/tests/mappings/mapping_fe_field_08.output new file mode 100644 index 0000000000..80ba511cb6 --- /dev/null +++ b/tests/mappings/mapping_fe_field_08.output @@ -0,0 +1,1529 @@ + +DEAL::Test with MappingQGeneric in 2D on 12 cells: +DEAL::Testing 2D with point 0.8000000000 0.000000000 tolerance 1.000000000e-08 +DEAL::Cell: 0_1:2 unit point 2.615834610e-20 1.000000000 +DEAL::Cell: 2_1:3 unit point 1.000000000 1.000000000 +DEAL:: +DEAL::Testing 2D with point 0.8500000000 0.000000000 tolerance 1.000000000e-08 +DEAL::Cell: 0_1:2 unit point 0.000000000 0.5000000000 +DEAL::Cell: 2_1:3 unit point 1.000000000 0.5000000000 +DEAL:: +DEAL::Testing 2D with point 0.9000000000 0.000000000 tolerance 1.000000000e-08 +DEAL::Cell: 0_1:0 unit point 7.697329190e-21 1.000000000 +DEAL::Cell: 0_1:2 unit point 0.000000000 2.609024108e-16 +DEAL::Cell: 2_1:1 unit point 1.000000000 1.000000000 +DEAL::Cell: 2_1:3 unit point 1.000000000 5.551115123e-16 +DEAL:: +DEAL::Testing 2D with point 0.9500000000 0.000000000 tolerance 1.000000000e-08 +DEAL::Cell: 0_1:0 unit point 0.000000000 0.5000000000 +DEAL::Cell: 2_1:1 unit point 1.000000000 0.5000000000 +DEAL:: +DEAL::Testing 2D with point 1.000000000 0.000000000 tolerance 1.000000000e-08 +DEAL::Cell: 0_1:0 unit point 0.000000000 0.000000000 +DEAL::Cell: 2_1:1 unit point 1.000000000 8.437694987e-16 +DEAL:: +DEAL::Testing 2D with point 0.5656854249 0.5656854249 tolerance 1.000000000e-08 +DEAL::Cell: 0_1:2 unit point 0.7500000000 1.000000000 +DEAL:: +DEAL::Testing 2D with point 0.5656854249 0.5656854249 tolerance 1.000000000e-12 +DEAL:: +DEAL::Testing 2D with point 0.6010407640 0.6010407640 tolerance 1.000000000e-08 +DEAL::Cell: 0_1:2 unit point 0.7500000000 0.5000000001 +DEAL:: +DEAL::Testing 2D with point 0.6010407640 0.6010407640 tolerance 1.000000000e-12 +DEAL::Cell: 0_1:2 unit point 0.7500000000 0.5000000001 +DEAL:: +DEAL::Testing 2D with point 0.6363961031 0.6363961031 tolerance 1.000000000e-08 +DEAL::Cell: 0_1:0 unit point 0.7500000000 1.000000000 +DEAL::Cell: 0_1:2 unit point 0.7500000000 8.800050870e-11 +DEAL:: +DEAL::Testing 2D with point 0.6363961031 0.6363961031 tolerance 1.000000000e-12 +DEAL::Cell: 0_1:2 unit point 0.7500000000 8.800050870e-11 +DEAL:: +DEAL::Testing 2D with point 0.6717514421 0.6717514421 tolerance 1.000000000e-08 +DEAL::Cell: 0_1:0 unit point 0.7500000000 0.5000000001 +DEAL:: +DEAL::Testing 2D with point 0.6717514421 0.6717514421 tolerance 1.000000000e-12 +DEAL::Cell: 0_1:0 unit point 0.7500000000 0.5000000001 +DEAL:: +DEAL::Testing 2D with point 0.7071067812 0.7071067812 tolerance 1.000000000e-08 +DEAL::Cell: 0_1:0 unit point 0.7500000000 9.777292816e-11 +DEAL:: +DEAL::Testing 2D with point 0.7071067812 0.7071067812 tolerance 1.000000000e-12 +DEAL::Cell: 0_1:0 unit point 0.7500000000 9.777292816e-11 +DEAL:: +DEAL::Testing 2D with point 0.4702282018 0.6472135955 tolerance 1.000000000e-08 +DEAL::Cell: 0_1:2 unit point 0.9000000000 0.9999999999 +DEAL:: +DEAL::Testing 2D with point 0.4996174644 0.6876644452 tolerance 1.000000000e-08 +DEAL::Cell: 0_1:2 unit point 0.9000000000 0.4999999999 +DEAL:: +DEAL::Testing 2D with point 0.5290067271 0.7281152949 tolerance 1.000000000e-08 +DEAL::Cell: 0_1:0 unit point 0.9000000000 0.9999999999 +DEAL::Cell: 0_1:2 unit point 0.9000000000 -1.207553287e-10 +DEAL:: +DEAL::Testing 2D with point 0.5583959897 0.7685661447 tolerance 1.000000000e-08 +DEAL::Cell: 0_1:0 unit point 0.9000000000 0.4999999999 +DEAL:: +DEAL::Testing 2D with point 0.5877852523 0.8090169944 tolerance 1.000000000e-08 +DEAL::Cell: 0_1:0 unit point 0.9000000000 -1.341796354e-10 +DEAL:: +DEAL::Testing 2D with point 4.898587197e-17 0.8000000000 tolerance 1.000000000e-08 +DEAL::Cell: 0_1:3 unit point 0.5000000000 1.000000000 +DEAL:: +DEAL::Testing 2D with point 5.204748896e-17 0.8500000000 tolerance 1.000000000e-08 +DEAL::Cell: 0_1:3 unit point 0.5000000000 0.5000000000 +DEAL:: +DEAL::Testing 2D with point 5.510910596e-17 0.9000000000 tolerance 1.000000000e-08 +DEAL::Cell: 0_1:1 unit point 0.5000000000 1.000000000 +DEAL::Cell: 0_1:3 unit point 0.5000000000 0.000000000 +DEAL:: +DEAL::Testing 2D with point 5.817072296e-17 0.9500000000 tolerance 1.000000000e-08 +DEAL::Cell: 0_1:1 unit point 0.5000000000 0.5000000000 +DEAL:: +DEAL::Testing 2D with point 6.123233996e-17 1.000000000 tolerance 1.000000000e-08 +DEAL::Cell: 0_1:1 unit point 0.5000000000 0.000000000 +DEAL:: +DEAL::Testing 2D with point -0.5656854249 0.5656854249 tolerance 1.000000000e-08 +DEAL::Cell: 1_1:2 unit point 0.2500000000 1.000000000 +DEAL:: +DEAL::Testing 2D with point -0.6010407640 0.6010407640 tolerance 1.000000000e-08 +DEAL::Cell: 1_1:2 unit point 0.2500000000 0.5000000001 +DEAL:: +DEAL::Testing 2D with point -0.6363961031 0.6363961031 tolerance 1.000000000e-08 +DEAL::Cell: 1_1:0 unit point 0.2500000000 1.000000000 +DEAL::Cell: 1_1:2 unit point 0.2500000000 8.799556923e-11 +DEAL:: +DEAL::Testing 2D with point -0.6717514421 0.6717514421 tolerance 1.000000000e-08 +DEAL::Cell: 1_1:0 unit point 0.2500000000 0.5000000001 +DEAL:: +DEAL::Testing 2D with point -0.7071067812 0.7071067812 tolerance 1.000000000e-08 +DEAL::Cell: 1_1:0 unit point 0.2500000000 9.776891669e-11 +DEAL:: +DEAL:: +DEAL::Test with MappingFEField in 2D on 12 cells: +DEAL::Testing 2D with point 0.8000000000 0.000000000 tolerance 1.000000000e-08 +DEAL::Cell: 0_1:2 unit point 0.000000000 1.000000000 +DEAL::Cell: 2_1:3 unit point 1.000000000 1.000000000 +DEAL:: +DEAL::Testing 2D with point 0.8500000000 0.000000000 tolerance 1.000000000e-08 +DEAL::Cell: 0_1:2 unit point 0.000000000 0.5000000000 +DEAL::Cell: 2_1:3 unit point 1.000000000 0.5000000000 +DEAL:: +DEAL::Testing 2D with point 0.9000000000 0.000000000 tolerance 1.000000000e-08 +DEAL::Cell: 0_1:0 unit point 0.000000000 1.000000000 +DEAL::Cell: 0_1:2 unit point 0.000000000 0.000000000 +DEAL::Cell: 2_1:1 unit point 1.000000000 1.000000000 +DEAL::Cell: 2_1:3 unit point 1.000000000 0.000000000 +DEAL:: +DEAL::Testing 2D with point 0.9500000000 0.000000000 tolerance 1.000000000e-08 +DEAL::Cell: 0_1:0 unit point 0.000000000 0.5000000000 +DEAL::Cell: 2_1:1 unit point 1.000000000 0.5000000000 +DEAL:: +DEAL::Testing 2D with point 1.000000000 0.000000000 tolerance 1.000000000e-08 +DEAL::Cell: 0_1:0 unit point 0.000000000 0.000000000 +DEAL::Cell: 2_1:1 unit point 1.000000000 0.000000000 +DEAL:: +DEAL::Testing 2D with point 0.5656854249 0.5656854249 tolerance 1.000000000e-08 +DEAL::Cell: 0_1:2 unit point 0.7500000000 1.000000000 +DEAL:: +DEAL::Testing 2D with point 0.5656854249 0.5656854249 tolerance 1.000000000e-12 +DEAL:: +DEAL::Testing 2D with point 0.6010407640 0.6010407640 tolerance 1.000000000e-08 +DEAL::Cell: 0_1:2 unit point 0.7500000000 0.5000000001 +DEAL:: +DEAL::Testing 2D with point 0.6010407640 0.6010407640 tolerance 1.000000000e-12 +DEAL::Cell: 0_1:2 unit point 0.7500000000 0.5000000001 +DEAL:: +DEAL::Testing 2D with point 0.6363961031 0.6363961031 tolerance 1.000000000e-08 +DEAL::Cell: 0_1:0 unit point 0.7500000000 1.000000000 +DEAL::Cell: 0_1:2 unit point 0.7500000000 8.800112591e-11 +DEAL:: +DEAL::Testing 2D with point 0.6363961031 0.6363961031 tolerance 1.000000000e-12 +DEAL::Cell: 0_1:2 unit point 0.7500000000 8.800112591e-11 +DEAL:: +DEAL::Testing 2D with point 0.6717514421 0.6717514421 tolerance 1.000000000e-08 +DEAL::Cell: 0_1:0 unit point 0.7500000000 0.5000000001 +DEAL:: +DEAL::Testing 2D with point 0.6717514421 0.6717514421 tolerance 1.000000000e-12 +DEAL::Cell: 0_1:0 unit point 0.7500000000 0.5000000001 +DEAL:: +DEAL::Testing 2D with point 0.7071067812 0.7071067812 tolerance 1.000000000e-08 +DEAL::Cell: 0_1:0 unit point 0.7500000000 9.777677427e-11 +DEAL:: +DEAL::Testing 2D with point 0.7071067812 0.7071067812 tolerance 1.000000000e-12 +DEAL::Cell: 0_1:0 unit point 0.7500000000 9.777677427e-11 +DEAL:: +DEAL::Testing 2D with point 0.4702282018 0.6472135955 tolerance 1.000000000e-08 +DEAL::Cell: 0_1:2 unit point 0.9000000000 0.9999999999 +DEAL:: +DEAL::Testing 2D with point 0.4996174644 0.6876644452 tolerance 1.000000000e-08 +DEAL::Cell: 0_1:2 unit point 0.9000000000 0.4999999999 +DEAL:: +DEAL::Testing 2D with point 0.5290067271 0.7281152949 tolerance 1.000000000e-08 +DEAL::Cell: 0_1:0 unit point 0.9000000000 0.9999999999 +DEAL::Cell: 0_1:2 unit point 0.9000000000 -1.207552326e-10 +DEAL:: +DEAL::Testing 2D with point 0.5583959897 0.7685661447 tolerance 1.000000000e-08 +DEAL::Cell: 0_1:0 unit point 0.9000000000 0.4999999999 +DEAL:: +DEAL::Testing 2D with point 0.5877852523 0.8090169944 tolerance 1.000000000e-08 +DEAL::Cell: 0_1:0 unit point 0.9000000000 -1.341786829e-10 +DEAL:: +DEAL::Testing 2D with point 4.898587197e-17 0.8000000000 tolerance 1.000000000e-08 +DEAL::Cell: 0_1:3 unit point 0.5000000000 1.000000000 +DEAL:: +DEAL::Testing 2D with point 5.204748896e-17 0.8500000000 tolerance 1.000000000e-08 +DEAL::Cell: 0_1:3 unit point 0.5000000000 0.5000000000 +DEAL:: +DEAL::Testing 2D with point 5.510910596e-17 0.9000000000 tolerance 1.000000000e-08 +DEAL::Cell: 0_1:1 unit point 0.5000000000 1.000000000 +DEAL::Cell: 0_1:3 unit point 0.5000000000 0.000000000 +DEAL:: +DEAL::Testing 2D with point 5.817072296e-17 0.9500000000 tolerance 1.000000000e-08 +DEAL::Cell: 0_1:1 unit point 0.5000000000 0.5000000000 +DEAL:: +DEAL::Testing 2D with point 6.123233996e-17 1.000000000 tolerance 1.000000000e-08 +DEAL::Cell: 0_1:1 unit point 0.5000000000 0.000000000 +DEAL:: +DEAL::Testing 2D with point -0.5656854249 0.5656854249 tolerance 1.000000000e-08 +DEAL::Cell: 1_1:2 unit point 0.2500000000 1.000000000 +DEAL:: +DEAL::Testing 2D with point -0.6010407640 0.6010407640 tolerance 1.000000000e-08 +DEAL::Cell: 1_1:2 unit point 0.2500000000 0.5000000001 +DEAL:: +DEAL::Testing 2D with point -0.6363961031 0.6363961031 tolerance 1.000000000e-08 +DEAL::Cell: 1_1:0 unit point 0.2500000000 1.000000000 +DEAL::Cell: 1_1:2 unit point 0.2500000000 8.799727545e-11 +DEAL:: +DEAL::Testing 2D with point -0.6717514421 0.6717514421 tolerance 1.000000000e-08 +DEAL::Cell: 1_1:0 unit point 0.2500000000 0.5000000001 +DEAL:: +DEAL::Testing 2D with point -0.7071067812 0.7071067812 tolerance 1.000000000e-08 +DEAL::Cell: 1_1:0 unit point 0.2500000000 9.777199125e-11 +DEAL:: +DEAL:: +DEAL::Test with MappingQGeneric in 2D on 48 cells: +DEAL::Testing 2D with point 0.8000000000 0.000000000 tolerance 1.000000000e-08 +DEAL::Cell: 0_2:22 unit point -5.001540069e-12 1.000000000 +DEAL::Cell: 2_2:33 unit point 1.000000000 1.000000000 +DEAL:: +DEAL::Testing 2D with point 0.8500000000 0.000000000 tolerance 1.000000000e-08 +DEAL::Cell: 0_2:20 unit point -3.726766057e-12 1.000000000 +DEAL::Cell: 0_2:22 unit point 0.000000000 0.000000000 +DEAL::Cell: 2_2:31 unit point 1.000000000 1.000000000 +DEAL::Cell: 2_2:33 unit point 1.000000000 0.000000000 +DEAL:: +DEAL::Testing 2D with point 0.9000000000 0.000000000 tolerance 1.000000000e-08 +DEAL::Cell: 0_2:02 unit point -2.822687563e-12 1.000000000 +DEAL::Cell: 0_2:20 unit point 0.000000000 9.050238874e-16 +DEAL::Cell: 2_2:13 unit point 1.000000000 1.000000000 +DEAL::Cell: 2_2:31 unit point 1.000000000 5.361568073e-16 +DEAL:: +DEAL::Testing 2D with point 0.9500000000 0.000000000 tolerance 1.000000000e-08 +DEAL::Cell: 0_2:00 unit point -2.169439843e-12 1.000000000 +DEAL::Cell: 0_2:02 unit point 0.000000000 0.000000000 +DEAL::Cell: 2_2:11 unit point 1.000000000 1.000000000 +DEAL::Cell: 2_2:13 unit point 1.000000000 0.000000000 +DEAL:: +DEAL::Testing 2D with point 1.000000000 0.000000000 tolerance 1.000000000e-08 +DEAL::Cell: 0_2:00 unit point 0.000000000 0.000000000 +DEAL::Cell: 2_2:11 unit point 1.000000000 4.813896397e-16 +DEAL:: +DEAL::Testing 2D with point 0.5656854249 0.5656854249 tolerance 1.000000000e-08 +DEAL::Cell: 0_2:23 unit point 0.5000000000 1.000000000 +DEAL:: +DEAL::Testing 2D with point 0.5656854249 0.5656854249 tolerance 1.000000000e-12 +DEAL::Cell: 0_2:23 unit point 0.5000000000 1.000000000 +DEAL:: +DEAL::Testing 2D with point 0.6010407640 0.6010407640 tolerance 1.000000000e-08 +DEAL::Cell: 0_2:21 unit point 0.5000000000 1.000000000 +DEAL::Cell: 0_2:23 unit point 0.5000000000 0.000000000 +DEAL:: +DEAL::Testing 2D with point 0.6010407640 0.6010407640 tolerance 1.000000000e-12 +DEAL::Cell: 0_2:21 unit point 0.5000000000 1.000000000 +DEAL::Cell: 0_2:23 unit point 0.5000000000 0.000000000 +DEAL:: +DEAL::Testing 2D with point 0.6363961031 0.6363961031 tolerance 1.000000000e-08 +DEAL::Cell: 0_2:03 unit point 0.5000000000 1.000000000 +DEAL::Cell: 0_2:21 unit point 0.5000000000 0.000000000 +DEAL:: +DEAL::Testing 2D with point 0.6363961031 0.6363961031 tolerance 1.000000000e-12 +DEAL::Cell: 0_2:03 unit point 0.5000000000 1.000000000 +DEAL::Cell: 0_2:21 unit point 0.5000000000 0.000000000 +DEAL:: +DEAL::Testing 2D with point 0.6717514421 0.6717514421 tolerance 1.000000000e-08 +DEAL::Cell: 0_2:01 unit point 0.5000000000 1.000000000 +DEAL::Cell: 0_2:03 unit point 0.5000000000 0.000000000 +DEAL:: +DEAL::Testing 2D with point 0.6717514421 0.6717514421 tolerance 1.000000000e-12 +DEAL::Cell: 0_2:01 unit point 0.5000000000 1.000000000 +DEAL::Cell: 0_2:03 unit point 0.5000000000 0.000000000 +DEAL:: +DEAL::Testing 2D with point 0.7071067812 0.7071067812 tolerance 1.000000000e-08 +DEAL::Cell: 0_2:01 unit point 0.5000000000 0.000000000 +DEAL:: +DEAL::Testing 2D with point 0.7071067812 0.7071067812 tolerance 1.000000000e-12 +DEAL::Cell: 0_2:01 unit point 0.5000000000 0.000000000 +DEAL:: +DEAL::Testing 2D with point 0.4702282018 0.6472135955 tolerance 1.000000000e-08 +DEAL::Cell: 0_2:23 unit point 0.8000000000 1.000000000 +DEAL:: +DEAL::Testing 2D with point 0.4996174644 0.6876644452 tolerance 1.000000000e-08 +DEAL::Cell: 0_2:21 unit point 0.8000000000 1.000000000 +DEAL::Cell: 0_2:23 unit point 0.8000000000 1.623596548e-13 +DEAL:: +DEAL::Testing 2D with point 0.5290067271 0.7281152949 tolerance 1.000000000e-08 +DEAL::Cell: 0_2:03 unit point 0.8000000000 1.000000000 +DEAL::Cell: 0_2:21 unit point 0.8000000000 1.671574120e-13 +DEAL:: +DEAL::Testing 2D with point 0.5583959897 0.7685661447 tolerance 1.000000000e-08 +DEAL::Cell: 0_2:01 unit point 0.8000000000 1.000000000 +DEAL::Cell: 0_2:03 unit point 0.8000000000 1.748909719e-13 +DEAL:: +DEAL::Testing 2D with point 0.5877852523 0.8090169944 tolerance 1.000000000e-08 +DEAL::Cell: 0_2:01 unit point 0.8000000000 1.835335269e-13 +DEAL:: +DEAL::Testing 2D with point 4.898587197e-17 0.8000000000 tolerance 1.000000000e-08 +DEAL::Cell: 0_2:32 unit point 1.000000000 1.000000000 +DEAL::Cell: 0_2:33 unit point -5.001141129e-12 1.000000000 +DEAL:: +DEAL::Testing 2D with point 5.204748896e-17 0.8500000000 tolerance 1.000000000e-08 +DEAL::Cell: 0_2:30 unit point 1.000000000 1.000000000 +DEAL::Cell: 0_2:31 unit point -3.725917909e-12 1.000000000 +DEAL::Cell: 0_2:32 unit point 1.000000000 1.595876115e-15 +DEAL::Cell: 0_2:33 unit point 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 2D with point 5.510910596e-17 0.9000000000 tolerance 1.000000000e-08 +DEAL::Cell: 0_2:12 unit point 1.000000000 1.000000000 +DEAL::Cell: 0_2:13 unit point -2.822394631e-12 1.000000000 +DEAL::Cell: 0_2:30 unit point 1.000000000 3.218224251e-15 +DEAL::Cell: 0_2:31 unit point 0.000000000 9.147935140e-16 +DEAL:: +DEAL::Testing 2D with point 5.817072296e-17 0.9500000000 tolerance 1.000000000e-08 +DEAL::Cell: 0_2:10 unit point 1.000000000 1.000000000 +DEAL::Cell: 0_2:11 unit point -2.168591698e-12 1.000000000 +DEAL::Cell: 0_2:12 unit point 1.000000000 8.753839575e-17 +DEAL::Cell: 0_2:13 unit point 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 2D with point 6.123233996e-17 1.000000000 tolerance 1.000000000e-08 +DEAL::Cell: 0_2:10 unit point 1.000000000 0.000000000 +DEAL::Cell: 0_2:11 unit point 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 2D with point -0.5656854249 0.5656854249 tolerance 1.000000000e-08 +DEAL::Cell: 1_2:22 unit point 0.5000000000 1.000000000 +DEAL:: +DEAL::Testing 2D with point -0.6010407640 0.6010407640 tolerance 1.000000000e-08 +DEAL::Cell: 1_2:20 unit point 0.5000000000 1.000000000 +DEAL::Cell: 1_2:22 unit point 0.5000000000 0.000000000 +DEAL:: +DEAL::Testing 2D with point -0.6363961031 0.6363961031 tolerance 1.000000000e-08 +DEAL::Cell: 1_2:02 unit point 0.5000000000 1.000000000 +DEAL::Cell: 1_2:20 unit point 0.5000000000 0.000000000 +DEAL:: +DEAL::Testing 2D with point -0.6717514421 0.6717514421 tolerance 1.000000000e-08 +DEAL::Cell: 1_2:00 unit point 0.5000000000 1.000000000 +DEAL::Cell: 1_2:02 unit point 0.5000000000 0.000000000 +DEAL:: +DEAL::Testing 2D with point -0.7071067812 0.7071067812 tolerance 1.000000000e-08 +DEAL::Cell: 1_2:00 unit point 0.5000000000 0.000000000 +DEAL:: +DEAL:: +DEAL::Test with MappingFEField in 2D on 48 cells: +DEAL::Testing 2D with point 0.8000000000 0.000000000 tolerance 1.000000000e-08 +DEAL::Cell: 0_2:22 unit point 0.000000000 1.000000000 +DEAL::Cell: 2_2:33 unit point 1.000000000 1.000000000 +DEAL:: +DEAL::Testing 2D with point 0.8500000000 0.000000000 tolerance 1.000000000e-08 +DEAL::Cell: 0_2:20 unit point 0.000000000 1.000000000 +DEAL::Cell: 0_2:22 unit point 0.000000000 0.000000000 +DEAL::Cell: 2_2:31 unit point 1.000000000 1.000000000 +DEAL::Cell: 2_2:33 unit point 1.000000000 0.000000000 +DEAL:: +DEAL::Testing 2D with point 0.9000000000 0.000000000 tolerance 1.000000000e-08 +DEAL::Cell: 0_2:02 unit point 0.000000000 1.000000000 +DEAL::Cell: 0_2:20 unit point 0.000000000 0.000000000 +DEAL::Cell: 2_2:13 unit point 1.000000000 1.000000000 +DEAL::Cell: 2_2:31 unit point 1.000000000 0.000000000 +DEAL:: +DEAL::Testing 2D with point 0.9500000000 0.000000000 tolerance 1.000000000e-08 +DEAL::Cell: 0_2:00 unit point 0.000000000 1.000000000 +DEAL::Cell: 0_2:02 unit point 0.000000000 0.000000000 +DEAL::Cell: 2_2:11 unit point 1.000000000 1.000000000 +DEAL::Cell: 2_2:13 unit point 1.000000000 0.000000000 +DEAL:: +DEAL::Testing 2D with point 1.000000000 0.000000000 tolerance 1.000000000e-08 +DEAL::Cell: 0_2:00 unit point 0.000000000 0.000000000 +DEAL::Cell: 2_2:11 unit point 1.000000000 0.000000000 +DEAL:: +DEAL::Testing 2D with point 0.5656854249 0.5656854249 tolerance 1.000000000e-08 +DEAL::Cell: 0_2:23 unit point 0.5000000000 1.000000000 +DEAL:: +DEAL::Testing 2D with point 0.5656854249 0.5656854249 tolerance 1.000000000e-12 +DEAL::Cell: 0_2:23 unit point 0.5000000000 1.000000000 +DEAL:: +DEAL::Testing 2D with point 0.6010407640 0.6010407640 tolerance 1.000000000e-08 +DEAL::Cell: 0_2:21 unit point 0.5000000000 1.000000000 +DEAL::Cell: 0_2:23 unit point 0.5000000000 0.000000000 +DEAL:: +DEAL::Testing 2D with point 0.6010407640 0.6010407640 tolerance 1.000000000e-12 +DEAL::Cell: 0_2:21 unit point 0.5000000000 1.000000000 +DEAL::Cell: 0_2:23 unit point 0.5000000000 0.000000000 +DEAL:: +DEAL::Testing 2D with point 0.6363961031 0.6363961031 tolerance 1.000000000e-08 +DEAL::Cell: 0_2:03 unit point 0.5000000000 1.000000000 +DEAL::Cell: 0_2:21 unit point 0.5000000000 0.000000000 +DEAL:: +DEAL::Testing 2D with point 0.6363961031 0.6363961031 tolerance 1.000000000e-12 +DEAL::Cell: 0_2:03 unit point 0.5000000000 1.000000000 +DEAL::Cell: 0_2:21 unit point 0.5000000000 0.000000000 +DEAL:: +DEAL::Testing 2D with point 0.6717514421 0.6717514421 tolerance 1.000000000e-08 +DEAL::Cell: 0_2:01 unit point 0.5000000000 1.000000000 +DEAL::Cell: 0_2:03 unit point 0.5000000000 0.000000000 +DEAL:: +DEAL::Testing 2D with point 0.6717514421 0.6717514421 tolerance 1.000000000e-12 +DEAL::Cell: 0_2:01 unit point 0.5000000000 1.000000000 +DEAL::Cell: 0_2:03 unit point 0.5000000000 0.000000000 +DEAL:: +DEAL::Testing 2D with point 0.7071067812 0.7071067812 tolerance 1.000000000e-08 +DEAL::Cell: 0_2:01 unit point 0.5000000000 0.000000000 +DEAL:: +DEAL::Testing 2D with point 0.7071067812 0.7071067812 tolerance 1.000000000e-12 +DEAL::Cell: 0_2:01 unit point 0.5000000000 0.000000000 +DEAL:: +DEAL::Testing 2D with point 0.4702282018 0.6472135955 tolerance 1.000000000e-08 +DEAL::Cell: 0_2:23 unit point 0.8000000000 1.000000000 +DEAL:: +DEAL::Testing 2D with point 0.4996174644 0.6876644452 tolerance 1.000000000e-08 +DEAL::Cell: 0_2:21 unit point 0.8000000000 1.000000000 +DEAL::Cell: 0_2:23 unit point 0.8000000000 1.501829666e-13 +DEAL:: +DEAL::Testing 2D with point 0.5290067271 0.7281152949 tolerance 1.000000000e-08 +DEAL::Cell: 0_2:03 unit point 0.8000000000 1.000000000 +DEAL::Cell: 0_2:21 unit point 0.8000000000 1.687173486e-13 +DEAL:: +DEAL::Testing 2D with point 0.5583959897 0.7685661447 tolerance 1.000000000e-08 +DEAL::Cell: 0_2:01 unit point 0.8000000000 1.000000000 +DEAL::Cell: 0_2:03 unit point 0.8000000000 1.606852536e-13 +DEAL:: +DEAL::Testing 2D with point 0.5877852523 0.8090169944 tolerance 1.000000000e-08 +DEAL::Cell: 0_2:01 unit point 0.8000000000 1.764882863e-13 +DEAL:: +DEAL::Testing 2D with point 4.898587197e-17 0.8000000000 tolerance 1.000000000e-08 +DEAL::Cell: 0_2:32 unit point 1.000000000 1.000000000 +DEAL::Cell: 0_2:33 unit point 4.177726643e-16 1.000000000 +DEAL:: +DEAL::Testing 2D with point 5.204748896e-17 0.8500000000 tolerance 1.000000000e-08 +DEAL::Cell: 0_2:30 unit point 1.000000000 1.000000000 +DEAL::Cell: 0_2:31 unit point 8.881784197e-16 1.000000000 +DEAL::Cell: 0_2:32 unit point 1.000000000 2.022714678e-15 +DEAL::Cell: 0_2:33 unit point 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 2D with point 5.510910596e-17 0.9000000000 tolerance 1.000000000e-08 +DEAL::Cell: 0_2:12 unit point 1.000000000 1.000000000 +DEAL::Cell: 0_2:13 unit point 3.087807787e-16 1.000000000 +DEAL::Cell: 0_2:30 unit point 1.000000000 2.960549557e-15 +DEAL::Cell: 0_2:31 unit point 3.067503618e-16 1.480613592e-15 +DEAL:: +DEAL::Testing 2D with point 5.817072296e-17 0.9500000000 tolerance 1.000000000e-08 +DEAL::Cell: 0_2:10 unit point 1.000000000 1.000000000 +DEAL::Cell: 0_2:11 unit point 8.881784197e-16 1.000000000 +DEAL::Cell: 0_2:12 unit point 1.000000000 3.997995511e-17 +DEAL::Cell: 0_2:13 unit point 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 2D with point 6.123233996e-17 1.000000000 tolerance 1.000000000e-08 +DEAL::Cell: 0_2:10 unit point 1.000000000 0.000000000 +DEAL::Cell: 0_2:11 unit point 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 2D with point -0.5656854249 0.5656854249 tolerance 1.000000000e-08 +DEAL::Cell: 1_2:22 unit point 0.5000000000 1.000000000 +DEAL:: +DEAL::Testing 2D with point -0.6010407640 0.6010407640 tolerance 1.000000000e-08 +DEAL::Cell: 1_2:20 unit point 0.5000000000 1.000000000 +DEAL::Cell: 1_2:22 unit point 0.5000000000 0.000000000 +DEAL:: +DEAL::Testing 2D with point -0.6363961031 0.6363961031 tolerance 1.000000000e-08 +DEAL::Cell: 1_2:02 unit point 0.5000000000 1.000000000 +DEAL::Cell: 1_2:20 unit point 0.5000000000 0.000000000 +DEAL:: +DEAL::Testing 2D with point -0.6717514421 0.6717514421 tolerance 1.000000000e-08 +DEAL::Cell: 1_2:00 unit point 0.5000000000 1.000000000 +DEAL::Cell: 1_2:02 unit point 0.5000000000 0.000000000 +DEAL:: +DEAL::Testing 2D with point -0.7071067812 0.7071067812 tolerance 1.000000000e-08 +DEAL::Cell: 1_2:00 unit point 0.5000000000 0.000000000 +DEAL:: +DEAL:: +DEAL::Test with MappingQGeneric in 3D on 48 cells: +DEAL::Testing 3D with point 0.8000000000 0.000000000 4.898587197e-17 tolerance 1.000000000e-08 +DEAL::Cell: 1_1:2 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 1_1:3 unit point 8.316724501e-17 1.000000000 1.000000000 +DEAL::Cell: 1_1:6 unit point 1.000000000 1.000000000 1.995086582e-16 +DEAL::Cell: 1_1:7 unit point 6.549475952e-17 1.000000000 1.995086582e-16 +DEAL:: +DEAL::Testing 3D with point 0.8500000000 0.000000000 5.204748896e-17 tolerance 1.000000000e-08 +DEAL::Cell: 1_1:2 unit point 1.000000000 0.5000000000 1.000000000 +DEAL::Cell: 1_1:3 unit point 5.583326324e-17 0.5000000000 1.000000000 +DEAL::Cell: 1_1:6 unit point 1.000000000 0.5000000000 2.103299393e-16 +DEAL::Cell: 1_1:7 unit point 4.056386525e-17 0.5000000000 2.103299393e-16 +DEAL:: +DEAL::Testing 3D with point 0.9000000000 0.000000000 5.510910596e-17 tolerance 1.000000000e-08 +DEAL::Cell: 1_1:0 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 1_1:1 unit point 2.842808497e-17 1.000000000 1.000000000 +DEAL::Cell: 1_1:2 unit point 1.000000000 0.000000000 1.000000000 +DEAL::Cell: 1_1:3 unit point 0.000000000 0.000000000 1.000000000 +DEAL::Cell: 1_1:4 unit point 1.000000000 1.000000000 1.691598917e-16 +DEAL::Cell: 1_1:5 unit point 1.733701011e-17 1.000000000 1.691598917e-16 +DEAL::Cell: 1_1:6 unit point 1.000000000 0.000000000 0.000000000 +DEAL::Cell: 1_1:7 unit point 0.000000000 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 3D with point 0.9500000000 0.000000000 5.817072296e-17 tolerance 1.000000000e-08 +DEAL::Cell: 1_1:0 unit point 1.000000000 0.5000000000 1.000000000 +DEAL::Cell: 1_1:1 unit point 1.425662795e-17 0.5000000000 1.000000000 +DEAL::Cell: 1_1:4 unit point 1.000000000 0.5000000000 1.245919028e-16 +DEAL::Cell: 1_1:5 unit point 6.773605124e-18 0.5000000000 1.245919028e-16 +DEAL:: +DEAL::Testing 3D with point 1.000000000 0.000000000 6.123233996e-17 tolerance 1.000000000e-08 +DEAL::Cell: 1_1:0 unit point 1.000000000 0.000000000 1.000000000 +DEAL::Cell: 1_1:1 unit point 0.000000000 0.000000000 1.000000000 +DEAL::Cell: 1_1:4 unit point 1.000000000 0.000000000 0.000000000 +DEAL::Cell: 1_1:5 unit point 0.000000000 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 3D with point 0.5656854249 0.5656854249 4.898587197e-17 tolerance 1.000000000e-08 +DEAL::Cell: 1_1:3 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 1_1:7 unit point 1.000000000 1.000000000 2.721177782e-16 +DEAL::Cell: 5_1:3 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_1:7 unit point 1.000000000 1.000000000 2.721177914e-16 +DEAL:: +DEAL::Testing 3D with point 0.5656854249 0.5656854249 4.898587197e-17 tolerance 1.000000000e-12 +DEAL::Cell: 1_1:3 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 1_1:7 unit point 1.000000000 1.000000000 2.721177782e-16 +DEAL::Cell: 5_1:3 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_1:7 unit point 1.000000000 1.000000000 2.721177914e-16 +DEAL:: +DEAL::Testing 3D with point 0.6010407640 0.6010407640 5.204748896e-17 tolerance 1.000000000e-08 +DEAL::Cell: 1_1:3 unit point 1.000000000 0.5000000000 1.000000000 +DEAL::Cell: 1_1:7 unit point 1.000000000 0.5000000000 -2.302438880e-13 +DEAL::Cell: 5_1:3 unit point 0.5000000000 1.000000000 1.000000000 +DEAL::Cell: 5_1:7 unit point 0.5000000000 1.000000000 -2.302324349e-13 +DEAL:: +DEAL::Testing 3D with point 0.6010407640 0.6010407640 5.204748896e-17 tolerance 1.000000000e-12 +DEAL::Cell: 1_1:3 unit point 1.000000000 0.5000000000 1.000000000 +DEAL::Cell: 1_1:7 unit point 1.000000000 0.5000000000 -2.302438880e-13 +DEAL::Cell: 5_1:3 unit point 0.5000000000 1.000000000 1.000000000 +DEAL::Cell: 5_1:7 unit point 0.5000000000 1.000000000 -2.302324349e-13 +DEAL:: +DEAL::Testing 3D with point 0.6363961031 0.6363961031 5.510910596e-17 tolerance 1.000000000e-08 +DEAL::Cell: 1_1:1 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 1_1:3 unit point 1.000000000 8.291137461e-14 1.000000000 +DEAL::Cell: 1_1:5 unit point 1.000000000 1.000000000 2.243377746e-16 +DEAL::Cell: 1_1:7 unit point 1.000000000 8.325190652e-14 -2.026718889e-14 +DEAL::Cell: 5_1:2 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_1:3 unit point 8.651126315e-14 1.000000000 1.000000000 +DEAL::Cell: 5_1:6 unit point 1.000000000 1.000000000 2.243377746e-16 +DEAL::Cell: 5_1:7 unit point 8.299488602e-14 1.000000000 -2.026718867e-14 +DEAL:: +DEAL::Testing 3D with point 0.6363961031 0.6363961031 5.510910596e-17 tolerance 1.000000000e-12 +DEAL::Cell: 1_1:1 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 1_1:3 unit point 1.000000000 8.291137461e-14 1.000000000 +DEAL::Cell: 1_1:5 unit point 1.000000000 1.000000000 2.243377746e-16 +DEAL::Cell: 1_1:7 unit point 1.000000000 8.325190652e-14 -2.026718889e-14 +DEAL::Cell: 5_1:2 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_1:3 unit point 8.651126315e-14 1.000000000 1.000000000 +DEAL::Cell: 5_1:6 unit point 1.000000000 1.000000000 2.243377746e-16 +DEAL::Cell: 5_1:7 unit point 8.299488602e-14 1.000000000 -2.026718867e-14 +DEAL:: +DEAL::Testing 3D with point 0.6717514421 0.6717514421 5.817072296e-17 tolerance 1.000000000e-08 +DEAL::Cell: 1_1:1 unit point 1.000000000 0.5000000000 1.000000000 +DEAL::Cell: 1_1:5 unit point 1.000000000 0.5000000000 -2.303071520e-13 +DEAL::Cell: 5_1:2 unit point 0.5000000000 1.000000000 1.000000000 +DEAL::Cell: 5_1:6 unit point 0.5000000000 1.000000000 -2.302845107e-13 +DEAL:: +DEAL::Testing 3D with point 0.6717514421 0.6717514421 5.817072296e-17 tolerance 1.000000000e-12 +DEAL::Cell: 1_1:1 unit point 1.000000000 0.5000000000 1.000000000 +DEAL::Cell: 1_1:5 unit point 1.000000000 0.5000000000 -2.303071520e-13 +DEAL::Cell: 5_1:2 unit point 0.5000000000 1.000000000 1.000000000 +DEAL::Cell: 5_1:6 unit point 0.5000000000 1.000000000 -2.302845107e-13 +DEAL:: +DEAL::Testing 3D with point 0.7071067812 0.7071067812 6.123233996e-17 tolerance 1.000000000e-08 +DEAL::Cell: 1_1:1 unit point 1.000000000 1.333597772e-13 1.000000000 +DEAL::Cell: 1_1:5 unit point 1.000000000 1.342825298e-13 -2.805376875e-14 +DEAL::Cell: 5_1:2 unit point 1.340889449e-13 1.000000000 1.000000000 +DEAL::Cell: 5_1:6 unit point 1.355853876e-13 1.000000000 -2.805376864e-14 +DEAL:: +DEAL::Testing 3D with point 0.7071067812 0.7071067812 6.123233996e-17 tolerance 1.000000000e-12 +DEAL::Cell: 1_1:1 unit point 1.000000000 1.333597772e-13 1.000000000 +DEAL::Cell: 1_1:5 unit point 1.000000000 1.342825298e-13 -2.805376875e-14 +DEAL::Cell: 5_1:2 unit point 1.340889449e-13 1.000000000 1.000000000 +DEAL::Cell: 5_1:6 unit point 1.355853876e-13 1.000000000 -2.805376864e-14 +DEAL:: +DEAL::Testing 3D with point 0.4702282018 0.6472135955 4.898587197e-17 tolerance 1.000000000e-08 +DEAL::Cell: 5_1:3 unit point 0.9999968212 0.8000025440 1.000000000 +DEAL::Cell: 5_1:7 unit point 0.9999968212 0.8000025440 4.690479115e-13 +DEAL:: +DEAL::Testing 3D with point 0.4996174644 0.6876644452 5.204748896e-17 tolerance 1.000000000e-08 +DEAL::Cell: 5_1:3 unit point 0.4999966225 0.8000025440 1.000000000 +DEAL::Cell: 5_1:7 unit point 0.4999966225 0.8000025440 1.911981009e-13 +DEAL:: +DEAL::Testing 3D with point 0.5290067271 0.7281152949 5.510910596e-17 tolerance 1.000000000e-08 +DEAL::Cell: 5_1:2 unit point 0.9999964238 0.8000025440 1.000000000 +DEAL::Cell: 5_1:6 unit point 0.9999964238 0.8000025440 3.928168842e-13 +DEAL:: +DEAL::Testing 3D with point 0.5583959897 0.7685661447 5.817072296e-17 tolerance 1.000000000e-08 +DEAL::Cell: 5_1:2 unit point 0.4999962252 0.8000025440 1.000000000 +DEAL::Cell: 5_1:6 unit point 0.4999962252 0.8000025440 1.911372576e-13 +DEAL:: +DEAL::Testing 3D with point 0.5877852523 0.8090169944 6.123233996e-17 tolerance 1.000000000e-08 +DEAL:: +DEAL::Testing 3D with point 4.898587197e-17 0.8000000000 4.898587197e-17 tolerance 1.000000000e-08 +DEAL::Cell: 5_1:1 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_1:3 unit point 1.000000000 1.920207223e-16 1.000000000 +DEAL::Cell: 5_1:5 unit point 1.000000000 1.000000000 1.597198735e-16 +DEAL::Cell: 5_1:7 unit point 1.000000000 1.751068315e-16 1.553421187e-16 +DEAL:: +DEAL::Testing 3D with point 5.204748896e-17 0.8500000000 5.204748896e-17 tolerance 1.000000000e-08 +DEAL::Cell: 5_1:1 unit point 0.5000000000 1.000000000 1.000000000 +DEAL::Cell: 5_1:3 unit point 0.5000000000 1.658600568e-16 1.000000000 +DEAL::Cell: 5_1:5 unit point 0.5000000000 1.000000000 1.529488129e-16 +DEAL::Cell: 5_1:7 unit point 0.5000000000 1.512461005e-16 1.491663409e-16 +DEAL:: +DEAL::Testing 3D with point 5.510910596e-17 0.9000000000 5.510910596e-17 tolerance 1.000000000e-08 +DEAL::Cell: 5_1:0 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_1:1 unit point 0.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_1:2 unit point 1.000000000 1.396756186e-16 1.000000000 +DEAL::Cell: 5_1:3 unit point 0.000000000 0.000000000 1.000000000 +DEAL::Cell: 5_1:4 unit point 1.000000000 1.000000000 1.463290067e-16 +DEAL::Cell: 5_1:5 unit point 0.000000000 1.000000000 0.000000000 +DEAL::Cell: 5_1:6 unit point 1.000000000 1.226410354e-16 1.191446750e-16 +DEAL::Cell: 5_1:7 unit point 0.000000000 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 3D with point 5.817072296e-17 0.9500000000 5.817072296e-17 tolerance 1.000000000e-08 +DEAL::Cell: 5_1:0 unit point 0.5000000000 1.000000000 1.000000000 +DEAL::Cell: 5_1:2 unit point 0.5000000000 1.179099317e-16 1.000000000 +DEAL::Cell: 5_1:4 unit point 0.5000000000 1.000000000 1.115946285e-16 +DEAL::Cell: 5_1:6 unit point 0.5000000000 1.064168910e-16 9.325366722e-17 +DEAL:: +DEAL::Testing 3D with point 6.123233996e-17 1.000000000 6.123233996e-17 tolerance 1.000000000e-08 +DEAL::Cell: 5_1:0 unit point 0.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_1:2 unit point 0.000000000 0.000000000 1.000000000 +DEAL::Cell: 5_1:4 unit point 0.000000000 1.000000000 0.000000000 +DEAL::Cell: 5_1:6 unit point 0.000000000 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 3D with point -0.5656854249 0.5656854249 4.898587197e-17 tolerance 1.000000000e-08 +DEAL::Cell: 3_1:3 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 3_1:7 unit point 1.000000000 1.000000000 2.721178708e-16 +DEAL::Cell: 5_1:1 unit point 1.000000000 7.418528941e-18 1.000000000 +DEAL::Cell: 5_1:5 unit point 1.000000000 6.477760567e-18 2.721177914e-16 +DEAL:: +DEAL::Testing 3D with point -0.6010407640 0.6010407640 5.204748896e-17 tolerance 1.000000000e-08 +DEAL::Cell: 3_1:3 unit point 0.5000000000 1.000000000 1.000000000 +DEAL::Cell: 3_1:7 unit point 0.5000000000 1.000000000 -2.302409805e-13 +DEAL::Cell: 5_1:1 unit point 0.5000000000 -1.160999988e-16 1.000000000 +DEAL::Cell: 5_1:5 unit point 0.5000000000 1.205109258e-16 -2.302580261e-13 +DEAL:: +DEAL::Testing 3D with point -0.6363961031 0.6363961031 5.510910596e-17 tolerance 1.000000000e-08 +DEAL::Cell: 3_1:2 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 3_1:3 unit point 8.535365319e-14 1.000000000 1.000000000 +DEAL::Cell: 3_1:6 unit point 1.000000000 1.000000000 2.072474158e-16 +DEAL::Cell: 3_1:7 unit point 9.051611889e-14 1.000000000 -2.028427915e-14 +DEAL::Cell: 5_1:0 unit point 1.000000000 6.558295379e-18 1.000000000 +DEAL::Cell: 5_1:1 unit point 8.611463129e-14 2.241168000e-16 1.000000000 +DEAL::Cell: 5_1:4 unit point 1.000000000 6.758804067e-18 2.072473629e-16 +DEAL::Cell: 5_1:5 unit point 8.845699323e-14 1.146943700e-16 -2.028427918e-14 +DEAL:: +DEAL::Testing 3D with point -0.6717514421 0.6717514421 5.817072296e-17 tolerance 1.000000000e-08 +DEAL::Cell: 3_1:2 unit point 0.5000000000 1.000000000 1.000000000 +DEAL::Cell: 3_1:6 unit point 0.5000000000 1.000000000 -2.302930560e-13 +DEAL::Cell: 5_1:0 unit point 0.5000000000 1.100165805e-16 1.000000000 +DEAL::Cell: 5_1:4 unit point 0.5000000000 1.080236803e-16 -2.303101021e-13 +DEAL:: +DEAL::Testing 3D with point -0.7071067812 0.7071067812 6.123233996e-17 tolerance 1.000000000e-08 +DEAL::Cell: 3_1:2 unit point 1.362563756e-13 1.000000000 1.000000000 +DEAL::Cell: 3_1:6 unit point 1.317768768e-13 1.000000000 -2.805376848e-14 +DEAL::Cell: 5_1:0 unit point 1.342694448e-13 1.025850906e-16 1.000000000 +DEAL::Cell: 5_1:4 unit point 1.343792345e-13 1.049005489e-16 -2.805376859e-14 +DEAL:: +DEAL::Testing 3D with point 0.000000000 0.000000000 0.8000000000 tolerance 1.000000000e-08 +DEAL::Cell: 2_1:2 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 2_1:3 unit point 8.316724501e-17 1.000000000 1.000000000 +DEAL::Cell: 2_1:6 unit point 1.000000000 1.000000000 1.228571626e-16 +DEAL::Cell: 2_1:7 unit point 6.549475952e-17 1.000000000 1.228571626e-16 +DEAL:: +DEAL::Testing 3D with point 0.000000000 0.000000000 0.8500000000 tolerance 1.000000000e-08 +DEAL::Cell: 2_1:2 unit point 1.000000000 0.5000000000 1.000000000 +DEAL::Cell: 2_1:3 unit point 5.583326324e-17 0.5000000000 1.000000000 +DEAL::Cell: 2_1:6 unit point 1.000000000 0.5000000000 1.336784437e-16 +DEAL::Cell: 2_1:7 unit point 4.056386525e-17 0.5000000000 1.336784437e-16 +DEAL:: +DEAL::Testing 3D with point 0.000000000 0.000000000 0.9000000000 tolerance 1.000000000e-08 +DEAL::Cell: 2_1:0 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 2_1:1 unit point 2.842808497e-17 1.000000000 1.000000000 +DEAL::Cell: 2_1:2 unit point 1.000000000 0.000000000 1.000000000 +DEAL::Cell: 2_1:3 unit point 0.000000000 0.000000000 1.000000000 +DEAL::Cell: 2_1:4 unit point 1.000000000 1.000000000 9.250839615e-17 +DEAL::Cell: 2_1:5 unit point 1.733701011e-17 1.000000000 9.250839615e-17 +DEAL::Cell: 2_1:6 unit point 1.000000000 0.000000000 0.000000000 +DEAL::Cell: 2_1:7 unit point 0.000000000 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 3D with point 0.000000000 0.000000000 0.9500000000 tolerance 1.000000000e-08 +DEAL::Cell: 2_1:0 unit point 1.000000000 0.5000000000 1.000000000 +DEAL::Cell: 2_1:1 unit point 1.425662795e-17 0.5000000000 1.000000000 +DEAL::Cell: 2_1:4 unit point 1.000000000 0.5000000000 4.794040722e-17 +DEAL::Cell: 2_1:5 unit point 6.773605124e-18 0.5000000000 4.794040722e-17 +DEAL:: +DEAL::Testing 3D with point 0.000000000 0.000000000 1.000000000 tolerance 1.000000000e-08 +DEAL::Cell: 2_1:0 unit point 1.000000000 0.000000000 1.000000000 +DEAL::Cell: 2_1:1 unit point 0.000000000 0.000000000 1.000000000 +DEAL::Cell: 2_1:4 unit point 1.000000000 0.000000000 0.000000000 +DEAL::Cell: 2_1:5 unit point 0.000000000 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 3D with point 0.04694448799 0.06461354454 0.7960033322 tolerance 1.000000000e-08 +DEAL:: +DEAL::Testing 3D with point 0.04890050833 0.06730577556 0.8291701377 tolerance 1.000000000e-08 +DEAL::Cell: 2_1:7 unit point 0.07446169019 0.6666971843 0.1025974553 +DEAL:: +DEAL::Testing 3D with point 0.05085652866 0.06999800658 0.8623369432 tolerance 1.000000000e-08 +DEAL::Cell: 2_1:7 unit point 0.07446169019 0.3333650717 0.1025974553 +DEAL:: +DEAL::Testing 3D with point 0.05281254899 0.07269023761 0.8955037488 tolerance 1.000000000e-08 +DEAL::Cell: 2_1:7 unit point 0.07446169019 3.295905733e-05 0.1025974553 +DEAL:: +DEAL::Testing 3D with point 0.05476856932 0.07538246863 0.9286705543 tolerance 1.000000000e-08 +DEAL::Cell: 2_1:5 unit point 0.07446169019 0.6667008464 0.1025974553 +DEAL:: +DEAL::Testing 3D with point 0.05672458966 0.07807469965 0.9618373598 tolerance 1.000000000e-08 +DEAL::Cell: 2_1:5 unit point 0.07446169019 0.3333687338 0.1025974553 +DEAL:: +DEAL::Testing 3D with point 0.05868060999 0.08076693067 0.9950041653 tolerance 1.000000000e-08 +DEAL::Cell: 2_1:5 unit point 0.07446169019 3.662117418e-05 0.1025974553 +DEAL:: +DEAL:: +DEAL::Test with MappingFEField in 3D on 48 cells: +DEAL::Testing 3D with point 0.8000000000 0.000000000 4.898587197e-17 tolerance 1.000000000e-08 +DEAL::Cell: 1_1:2 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 1_1:3 unit point 9.220996247e-17 1.000000000 1.000000000 +DEAL::Cell: 1_1:6 unit point 1.000000000 1.000000000 2.130962853e-16 +DEAL::Cell: 1_1:7 unit point 9.220996247e-17 1.000000000 2.130962853e-16 +DEAL:: +DEAL::Testing 3D with point 0.8500000000 0.000000000 5.204748896e-17 tolerance 1.000000000e-08 +DEAL::Cell: 1_1:2 unit point 1.000000000 0.5000000000 1.000000000 +DEAL::Cell: 1_1:3 unit point 6.006082511e-17 0.5000000000 1.000000000 +DEAL::Cell: 1_1:6 unit point 1.000000000 0.5000000000 2.270506525e-16 +DEAL::Cell: 1_1:7 unit point 6.006082511e-17 0.5000000000 2.270506525e-16 +DEAL:: +DEAL::Testing 3D with point 0.9000000000 0.000000000 5.510910596e-17 tolerance 1.000000000e-08 +DEAL::Cell: 1_1:0 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 1_1:1 unit point 3.148381412e-17 1.000000000 1.000000000 +DEAL::Cell: 1_1:2 unit point 1.000000000 0.000000000 1.000000000 +DEAL::Cell: 1_1:3 unit point 0.000000000 0.000000000 1.000000000 +DEAL::Cell: 1_1:4 unit point 1.000000000 1.000000000 2.394545345e-16 +DEAL::Cell: 1_1:5 unit point 3.148381412e-17 1.000000000 2.394545345e-16 +DEAL::Cell: 1_1:6 unit point 1.000000000 0.000000000 0.000000000 +DEAL::Cell: 1_1:7 unit point 0.000000000 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 3D with point 0.9500000000 0.000000000 5.817072296e-17 tolerance 1.000000000e-08 +DEAL::Cell: 1_1:0 unit point 1.000000000 0.5000000000 1.000000000 +DEAL::Cell: 1_1:1 unit point 1.491338563e-17 0.5000000000 1.000000000 +DEAL::Cell: 1_1:4 unit point 1.000000000 0.5000000000 1.695423542e-16 +DEAL::Cell: 1_1:5 unit point 1.491338563e-17 0.5000000000 1.695423542e-16 +DEAL:: +DEAL::Testing 3D with point 1.000000000 0.000000000 6.123233996e-17 tolerance 1.000000000e-08 +DEAL::Cell: 1_1:0 unit point 1.000000000 0.000000000 1.000000000 +DEAL::Cell: 1_1:1 unit point 0.000000000 0.000000000 1.000000000 +DEAL::Cell: 1_1:4 unit point 1.000000000 0.000000000 0.000000000 +DEAL::Cell: 1_1:5 unit point 0.000000000 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 3D with point 0.5656854249 0.5656854249 4.898587197e-17 tolerance 1.000000000e-08 +DEAL::Cell: 1_1:3 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 1_1:7 unit point 1.000000000 1.000000000 2.359223927e-16 +DEAL::Cell: 5_1:3 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_1:7 unit point 1.000000000 1.000000000 2.359223927e-16 +DEAL:: +DEAL::Testing 3D with point 0.5656854249 0.5656854249 4.898587197e-17 tolerance 1.000000000e-12 +DEAL::Cell: 1_1:3 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 1_1:7 unit point 1.000000000 1.000000000 2.359223927e-16 +DEAL::Cell: 5_1:3 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_1:7 unit point 1.000000000 1.000000000 2.359223927e-16 +DEAL:: +DEAL::Testing 3D with point 0.6010407640 0.6010407640 5.204748896e-17 tolerance 1.000000000e-08 +DEAL::Cell: 1_1:3 unit point 1.000000000 0.5000000000 1.000000000 +DEAL::Cell: 1_1:7 unit point 1.000000000 0.5000000000 2.194425197e-16 +DEAL::Cell: 5_1:3 unit point 0.5000000000 1.000000000 1.000000000 +DEAL::Cell: 5_1:7 unit point 0.5000000000 1.000000000 2.194425197e-16 +DEAL:: +DEAL::Testing 3D with point 0.6010407640 0.6010407640 5.204748896e-17 tolerance 1.000000000e-12 +DEAL::Cell: 1_1:3 unit point 1.000000000 0.5000000000 1.000000000 +DEAL::Cell: 1_1:7 unit point 1.000000000 0.5000000000 2.194425197e-16 +DEAL::Cell: 5_1:3 unit point 0.5000000000 1.000000000 1.000000000 +DEAL::Cell: 5_1:7 unit point 0.5000000000 1.000000000 2.194425197e-16 +DEAL:: +DEAL::Testing 3D with point 0.6363961031 0.6363961031 5.510910596e-17 tolerance 1.000000000e-08 +DEAL::Cell: 1_1:1 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 1_1:3 unit point 1.000000000 2.032210639e-15 1.000000000 +DEAL::Cell: 1_1:5 unit point 1.000000000 1.000000000 2.220446049e-16 +DEAL::Cell: 1_1:7 unit point 1.000000000 3.337272943e-15 2.022037052e-16 +DEAL::Cell: 5_1:2 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_1:3 unit point 4.547044663e-15 1.000000000 1.000000000 +DEAL::Cell: 5_1:6 unit point 1.000000000 1.000000000 2.220446049e-16 +DEAL::Cell: 5_1:7 unit point 2.706497557e-15 1.000000000 2.022037052e-16 +DEAL:: +DEAL::Testing 3D with point 0.6363961031 0.6363961031 5.510910596e-17 tolerance 1.000000000e-12 +DEAL::Cell: 1_1:1 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 1_1:3 unit point 1.000000000 2.032210639e-15 1.000000000 +DEAL::Cell: 1_1:5 unit point 1.000000000 1.000000000 2.220446049e-16 +DEAL::Cell: 1_1:7 unit point 1.000000000 3.337272943e-15 2.022037052e-16 +DEAL::Cell: 5_1:2 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_1:3 unit point 4.547044663e-15 1.000000000 1.000000000 +DEAL::Cell: 5_1:6 unit point 1.000000000 1.000000000 2.220446049e-16 +DEAL::Cell: 5_1:7 unit point 2.706497557e-15 1.000000000 2.022037052e-16 +DEAL:: +DEAL::Testing 3D with point 0.6717514421 0.6717514421 5.817072296e-17 tolerance 1.000000000e-08 +DEAL::Cell: 1_1:1 unit point 1.000000000 0.5000000000 1.000000000 +DEAL::Cell: 1_1:5 unit point 1.000000000 0.5000000000 1.634976876e-16 +DEAL::Cell: 5_1:2 unit point 0.5000000000 1.000000000 1.000000000 +DEAL::Cell: 5_1:6 unit point 0.5000000000 1.000000000 1.634976876e-16 +DEAL:: +DEAL::Testing 3D with point 0.6717514421 0.6717514421 5.817072296e-17 tolerance 1.000000000e-12 +DEAL::Cell: 1_1:1 unit point 1.000000000 0.5000000000 1.000000000 +DEAL::Cell: 1_1:5 unit point 1.000000000 0.5000000000 1.634976876e-16 +DEAL::Cell: 5_1:2 unit point 0.5000000000 1.000000000 1.000000000 +DEAL::Cell: 5_1:6 unit point 0.5000000000 1.000000000 1.634976876e-16 +DEAL:: +DEAL::Testing 3D with point 0.7071067812 0.7071067812 6.123233996e-17 tolerance 1.000000000e-08 +DEAL::Cell: 1_1:1 unit point 1.000000000 1.926828331e-17 1.000000000 +DEAL::Cell: 1_1:5 unit point 1.000000000 5.891370178e-17 1.283695372e-16 +DEAL::Cell: 5_1:2 unit point 9.073346811e-16 1.000000000 1.000000000 +DEAL::Cell: 5_1:6 unit point 6.325362313e-16 1.000000000 1.282611170e-16 +DEAL:: +DEAL::Testing 3D with point 0.7071067812 0.7071067812 6.123233996e-17 tolerance 1.000000000e-12 +DEAL::Cell: 1_1:1 unit point 1.000000000 1.926828331e-17 1.000000000 +DEAL::Cell: 1_1:5 unit point 1.000000000 5.891370178e-17 1.283695372e-16 +DEAL::Cell: 5_1:2 unit point 9.073346811e-16 1.000000000 1.000000000 +DEAL::Cell: 5_1:6 unit point 6.325362313e-16 1.000000000 1.282611170e-16 +DEAL:: +DEAL::Testing 3D with point 0.4702282018 0.6472135955 4.898587197e-17 tolerance 1.000000000e-08 +DEAL::Cell: 5_1:3 unit point 0.9999968212 0.8000025440 1.000000000 +DEAL::Cell: 5_1:7 unit point 0.9999968212 0.8000025440 2.008792695e-16 +DEAL:: +DEAL::Testing 3D with point 0.4996174644 0.6876644452 5.204748896e-17 tolerance 1.000000000e-08 +DEAL::Cell: 5_1:3 unit point 0.4999966225 0.8000025440 1.000000000 +DEAL::Cell: 5_1:7 unit point 0.4999966225 0.8000025440 1.934478834e-16 +DEAL:: +DEAL::Testing 3D with point 0.5290067271 0.7281152949 5.510910596e-17 tolerance 1.000000000e-08 +DEAL::Cell: 5_1:2 unit point 0.9999964238 0.8000025440 1.000000000 +DEAL::Cell: 5_1:6 unit point 0.9999964238 0.8000025440 1.872769778e-16 +DEAL:: +DEAL::Testing 3D with point 0.5583959897 0.7685661447 5.817072296e-17 tolerance 1.000000000e-08 +DEAL::Cell: 5_1:2 unit point 0.4999962252 0.8000025440 1.000000000 +DEAL::Cell: 5_1:6 unit point 0.4999962252 0.8000025440 1.326050376e-16 +DEAL:: +DEAL::Testing 3D with point 0.5877852523 0.8090169944 6.123233996e-17 tolerance 1.000000000e-08 +DEAL:: +DEAL::Testing 3D with point 4.898587197e-17 0.8000000000 4.898587197e-17 tolerance 1.000000000e-08 +DEAL::Cell: 5_1:1 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_1:3 unit point 1.000000000 2.130962853e-16 1.000000000 +DEAL::Cell: 5_1:5 unit point 1.000000000 1.000000000 1.773302312e-16 +DEAL::Cell: 5_1:7 unit point 1.000000000 2.130962853e-16 1.773302312e-16 +DEAL:: +DEAL::Testing 3D with point 5.204748896e-17 0.8500000000 5.204748896e-17 tolerance 1.000000000e-08 +DEAL::Cell: 5_1:1 unit point 0.5000000000 1.000000000 1.000000000 +DEAL::Cell: 5_1:3 unit point 0.5000000000 1.823271556e-16 1.000000000 +DEAL::Cell: 5_1:5 unit point 0.5000000000 1.000000000 1.693663803e-16 +DEAL::Cell: 5_1:7 unit point 0.5000000000 1.823271556e-16 1.693663803e-16 +DEAL:: +DEAL::Testing 3D with point 5.510910596e-17 0.9000000000 5.510910596e-17 tolerance 1.000000000e-08 +DEAL::Cell: 5_1:0 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_1:1 unit point 0.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_1:2 unit point 1.000000000 1.549768181e-16 1.000000000 +DEAL::Cell: 5_1:3 unit point 0.000000000 0.000000000 1.000000000 +DEAL::Cell: 5_1:4 unit point 1.000000000 1.000000000 1.622874016e-16 +DEAL::Cell: 5_1:5 unit point 0.000000000 1.000000000 0.000000000 +DEAL::Cell: 5_1:6 unit point 1.000000000 1.549768181e-16 1.622874016e-16 +DEAL::Cell: 5_1:7 unit point 0.000000000 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 3D with point 5.817072296e-17 0.9500000000 5.817072296e-17 tolerance 1.000000000e-08 +DEAL::Cell: 5_1:0 unit point 0.5000000000 1.000000000 1.000000000 +DEAL::Cell: 5_1:2 unit point 0.5000000000 1.295265938e-16 1.000000000 +DEAL::Cell: 5_1:4 unit point 0.5000000000 1.000000000 1.216731212e-16 +DEAL::Cell: 5_1:6 unit point 0.5000000000 1.295265938e-16 1.216731212e-16 +DEAL:: +DEAL::Testing 3D with point 6.123233996e-17 1.000000000 6.123233996e-17 tolerance 1.000000000e-08 +DEAL::Cell: 5_1:0 unit point 0.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_1:2 unit point 0.000000000 0.000000000 1.000000000 +DEAL::Cell: 5_1:4 unit point 0.000000000 1.000000000 0.000000000 +DEAL::Cell: 5_1:6 unit point 0.000000000 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 3D with point -0.5656854249 0.5656854249 4.898587197e-17 tolerance 1.000000000e-08 +DEAL::Cell: 3_1:3 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 3_1:7 unit point 1.000000000 1.000000000 2.359223927e-16 +DEAL::Cell: 5_1:1 unit point 1.000000000 1.425480995e-16 1.000000000 +DEAL::Cell: 5_1:5 unit point 1.000000000 1.429193036e-16 2.359223927e-16 +DEAL:: +DEAL::Testing 3D with point -0.6010407640 0.6010407640 5.204748896e-17 tolerance 1.000000000e-08 +DEAL::Cell: 3_1:3 unit point 0.5000000000 1.000000000 1.000000000 +DEAL::Cell: 3_1:7 unit point 0.5000000000 1.000000000 2.101183810e-16 +DEAL::Cell: 5_1:1 unit point 0.5000000000 1.343253031e-16 1.000000000 +DEAL::Cell: 5_1:5 unit point 0.5000000000 1.367510190e-16 2.101183810e-16 +DEAL:: +DEAL::Testing 3D with point -0.6363961031 0.6363961031 5.510910596e-17 tolerance 1.000000000e-08 +DEAL::Cell: 3_1:2 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 3_1:3 unit point 2.602040860e-15 1.000000000 1.000000000 +DEAL::Cell: 3_1:6 unit point 1.000000000 1.000000000 2.359223927e-16 +DEAL::Cell: 3_1:7 unit point 5.104387574e-15 1.000000000 1.836638480e-16 +DEAL::Cell: 5_1:0 unit point 1.000000000 1.269686775e-16 1.000000000 +DEAL::Cell: 5_1:1 unit point 3.767152979e-15 1.279105687e-16 1.000000000 +DEAL::Cell: 5_1:4 unit point 1.000000000 1.269686775e-16 1.665334537e-16 +DEAL::Cell: 5_1:5 unit point 2.384704246e-15 1.271245971e-16 1.837722682e-16 +DEAL:: +DEAL::Testing 3D with point -0.6717514421 0.6717514421 5.817072296e-17 tolerance 1.000000000e-08 +DEAL::Cell: 3_1:2 unit point 0.5000000000 1.000000000 1.000000000 +DEAL::Cell: 3_1:6 unit point 0.5000000000 1.000000000 1.552577511e-16 +DEAL::Cell: 5_1:0 unit point 0.5000000000 1.214242483e-16 1.000000000 +DEAL::Cell: 5_1:4 unit point 0.5000000000 1.219931377e-16 1.548240702e-16 +DEAL:: +DEAL::Testing 3D with point -0.7071067812 0.7071067812 6.123233996e-17 tolerance 1.000000000e-08 +DEAL::Cell: 3_1:2 unit point 1.533913562e-15 1.000000000 1.000000000 +DEAL::Cell: 3_1:6 unit point 8.648574058e-16 1.000000000 1.283695372e-16 +DEAL::Cell: 5_1:0 unit point 3.091164628e-16 1.171829068e-16 1.000000000 +DEAL::Cell: 5_1:4 unit point 1.422024753e-16 1.172685233e-16 1.285863777e-16 +DEAL:: +DEAL::Testing 3D with point 0.000000000 0.000000000 0.8000000000 tolerance 1.000000000e-08 +DEAL::Cell: 2_1:2 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 2_1:3 unit point 9.220996247e-17 1.000000000 1.000000000 +DEAL::Cell: 2_1:6 unit point 1.000000000 1.000000000 1.279760166e-16 +DEAL::Cell: 2_1:7 unit point 9.220996247e-17 1.000000000 1.279760166e-16 +DEAL:: +DEAL::Testing 3D with point 0.000000000 0.000000000 0.8500000000 tolerance 1.000000000e-08 +DEAL::Cell: 2_1:2 unit point 1.000000000 0.5000000000 1.000000000 +DEAL::Cell: 2_1:3 unit point 6.006082511e-17 0.5000000000 1.000000000 +DEAL::Cell: 2_1:6 unit point 1.000000000 0.5000000000 1.419303838e-16 +DEAL::Cell: 2_1:7 unit point 6.006082511e-17 0.5000000000 1.419303838e-16 +DEAL:: +DEAL::Testing 3D with point 0.000000000 0.000000000 0.9000000000 tolerance 1.000000000e-08 +DEAL::Cell: 2_1:0 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 2_1:1 unit point 3.148381412e-17 1.000000000 1.000000000 +DEAL::Cell: 2_1:2 unit point 1.000000000 0.000000000 1.000000000 +DEAL::Cell: 2_1:3 unit point 0.000000000 0.000000000 1.000000000 +DEAL::Cell: 2_1:4 unit point 1.000000000 1.000000000 1.543342657e-16 +DEAL::Cell: 2_1:5 unit point 3.148381412e-17 1.000000000 1.543342657e-16 +DEAL::Cell: 2_1:6 unit point 1.000000000 0.000000000 0.000000000 +DEAL::Cell: 2_1:7 unit point 0.000000000 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 3D with point 0.000000000 0.000000000 0.9500000000 tolerance 1.000000000e-08 +DEAL::Cell: 2_1:0 unit point 1.000000000 0.5000000000 1.000000000 +DEAL::Cell: 2_1:1 unit point 1.491338563e-17 0.5000000000 1.000000000 +DEAL::Cell: 2_1:4 unit point 1.000000000 0.5000000000 8.442208547e-17 +DEAL::Cell: 2_1:5 unit point 1.491338563e-17 0.5000000000 8.442208547e-17 +DEAL:: +DEAL::Testing 3D with point 0.000000000 0.000000000 1.000000000 tolerance 1.000000000e-08 +DEAL::Cell: 2_1:0 unit point 1.000000000 0.000000000 1.000000000 +DEAL::Cell: 2_1:1 unit point 0.000000000 0.000000000 1.000000000 +DEAL::Cell: 2_1:4 unit point 1.000000000 0.000000000 0.000000000 +DEAL::Cell: 2_1:5 unit point 0.000000000 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 3D with point 0.04694448799 0.06461354454 0.7960033322 tolerance 1.000000000e-08 +DEAL:: +DEAL::Testing 3D with point 0.04890050833 0.06730577556 0.8291701377 tolerance 1.000000000e-08 +DEAL::Cell: 2_1:7 unit point 0.07446169019 0.6666971843 0.1025974553 +DEAL:: +DEAL::Testing 3D with point 0.05085652866 0.06999800658 0.8623369432 tolerance 1.000000000e-08 +DEAL::Cell: 2_1:7 unit point 0.07446169019 0.3333650717 0.1025974553 +DEAL:: +DEAL::Testing 3D with point 0.05281254899 0.07269023761 0.8955037488 tolerance 1.000000000e-08 +DEAL::Cell: 2_1:7 unit point 0.07446169019 3.295905344e-05 0.1025974553 +DEAL:: +DEAL::Testing 3D with point 0.05476856932 0.07538246863 0.9286705543 tolerance 1.000000000e-08 +DEAL::Cell: 2_1:5 unit point 0.07446169019 0.6667008464 0.1025974553 +DEAL:: +DEAL::Testing 3D with point 0.05672458966 0.07807469965 0.9618373598 tolerance 1.000000000e-08 +DEAL::Cell: 2_1:5 unit point 0.07446169019 0.3333687338 0.1025974553 +DEAL:: +DEAL::Testing 3D with point 0.05868060999 0.08076693067 0.9950041653 tolerance 1.000000000e-08 +DEAL::Cell: 2_1:5 unit point 0.07446169019 3.662117048e-05 0.1025974553 +DEAL:: +DEAL:: +DEAL::Test with MappingQGeneric in 3D on 384 cells: +DEAL::Testing 3D with point 0.8000000000 0.000000000 4.898587197e-17 tolerance 1.000000000e-08 +DEAL::Cell: 1_2:27 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 1_2:36 unit point -8.454658402e-13 1.000000000 1.000000000 +DEAL::Cell: 1_2:63 unit point 1.000000000 1.000000000 -8.452443914e-13 +DEAL::Cell: 1_2:72 unit point -8.454658364e-13 1.000000000 -8.452443914e-13 +DEAL:: +DEAL::Testing 3D with point 0.8500000000 0.000000000 5.204748896e-17 tolerance 1.000000000e-08 +DEAL::Cell: 1_2:25 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 1_2:27 unit point 1.000000000 0.000000000 1.000000000 +DEAL::Cell: 1_2:34 unit point -1.429097249e-13 1.000000000 1.000000000 +DEAL::Cell: 1_2:36 unit point 0.000000000 0.000000000 1.000000000 +DEAL::Cell: 1_2:61 unit point 1.000000000 1.000000000 -1.426038209e-13 +DEAL::Cell: 1_2:63 unit point 1.000000000 0.000000000 0.000000000 +DEAL::Cell: 1_2:70 unit point -1.429097252e-13 1.000000000 -1.426038214e-13 +DEAL::Cell: 1_2:72 unit point 0.000000000 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 3D with point 0.9000000000 0.000000000 5.510910596e-17 tolerance 1.000000000e-08 +DEAL::Cell: 1_2:07 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 1_2:16 unit point -3.493059425e-15 1.000000000 1.000000000 +DEAL::Cell: 1_2:25 unit point 1.000000000 0.000000000 1.000000000 +DEAL::Cell: 1_2:34 unit point 0.000000000 0.000000000 1.000000000 +DEAL::Cell: 1_2:43 unit point 1.000000000 1.000000000 -3.112084413e-15 +DEAL::Cell: 1_2:52 unit point -3.493059266e-15 1.000000000 -3.112084440e-15 +DEAL::Cell: 1_2:61 unit point 1.000000000 0.000000000 0.000000000 +DEAL::Cell: 1_2:70 unit point 0.000000000 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 3D with point 0.9500000000 0.000000000 5.817072296e-17 tolerance 1.000000000e-08 +DEAL::Cell: 1_2:05 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 1_2:07 unit point 1.000000000 0.000000000 1.000000000 +DEAL::Cell: 1_2:14 unit point 2.730258905e-17 1.000000000 1.000000000 +DEAL::Cell: 1_2:16 unit point 0.000000000 0.000000000 1.000000000 +DEAL::Cell: 1_2:41 unit point 1.000000000 1.000000000 3.100239446e-16 +DEAL::Cell: 1_2:43 unit point 1.000000000 0.000000000 0.000000000 +DEAL::Cell: 1_2:50 unit point 2.721649297e-17 1.000000000 3.100239446e-16 +DEAL::Cell: 1_2:52 unit point 0.000000000 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 3D with point 1.000000000 0.000000000 6.123233996e-17 tolerance 1.000000000e-08 +DEAL::Cell: 1_2:05 unit point 1.000000000 0.000000000 1.000000000 +DEAL::Cell: 1_2:14 unit point 0.000000000 0.000000000 1.000000000 +DEAL::Cell: 1_2:41 unit point 1.000000000 0.000000000 0.000000000 +DEAL::Cell: 1_2:50 unit point 0.000000000 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 3D with point 0.5656854249 0.5656854249 4.898587197e-17 tolerance 1.000000000e-08 +DEAL::Cell: 1_2:37 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 1_2:73 unit point 1.000000000 1.000000000 4.493270750e-16 +DEAL::Cell: 5_2:37 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_2:73 unit point 1.000000000 1.000000000 4.493270753e-16 +DEAL:: +DEAL::Testing 3D with point 0.5656854249 0.5656854249 4.898587197e-17 tolerance 1.000000000e-12 +DEAL::Cell: 1_2:37 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 1_2:73 unit point 1.000000000 1.000000000 4.493270750e-16 +DEAL::Cell: 5_2:37 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_2:73 unit point 1.000000000 1.000000000 4.493270753e-16 +DEAL:: +DEAL::Testing 3D with point 0.6010407640 0.6010407640 5.204748896e-17 tolerance 1.000000000e-08 +DEAL::Cell: 1_2:35 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 1_2:37 unit point 1.000000000 1.046642500e-14 1.000000000 +DEAL::Cell: 1_2:71 unit point 1.000000000 1.000000000 4.122857622e-16 +DEAL::Cell: 1_2:73 unit point 1.000000000 8.489392195e-15 4.105557082e-16 +DEAL::Cell: 5_2:36 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_2:37 unit point 1.353234469e-14 1.000000000 1.000000000 +DEAL::Cell: 5_2:72 unit point 1.000000000 1.000000000 4.122857614e-16 +DEAL::Cell: 5_2:73 unit point 6.711834937e-15 1.000000000 4.105557073e-16 +DEAL:: +DEAL::Testing 3D with point 0.6010407640 0.6010407640 5.204748896e-17 tolerance 1.000000000e-12 +DEAL::Cell: 1_2:35 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 1_2:37 unit point 1.000000000 1.046642500e-14 1.000000000 +DEAL::Cell: 1_2:71 unit point 1.000000000 1.000000000 4.122857622e-16 +DEAL::Cell: 1_2:73 unit point 1.000000000 8.489392195e-15 4.105557082e-16 +DEAL::Cell: 5_2:36 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_2:37 unit point 1.353234469e-14 1.000000000 1.000000000 +DEAL::Cell: 5_2:72 unit point 1.000000000 1.000000000 4.122857614e-16 +DEAL::Cell: 5_2:73 unit point 6.711834937e-15 1.000000000 4.105557073e-16 +DEAL:: +DEAL::Testing 3D with point 0.6363961031 0.6363961031 5.510910596e-17 tolerance 1.000000000e-08 +DEAL::Cell: 1_2:17 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 1_2:35 unit point 1.000000000 4.179811031e-15 1.000000000 +DEAL::Cell: 1_2:53 unit point 1.000000000 1.000000000 3.793601567e-16 +DEAL::Cell: 1_2:71 unit point 1.000000000 -1.443925474e-15 3.774289196e-16 +DEAL::Cell: 5_2:27 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_2:36 unit point -5.106065339e-15 1.000000000 1.000000000 +DEAL::Cell: 5_2:63 unit point 1.000000000 1.000000000 3.793601565e-16 +DEAL::Cell: 5_2:72 unit point -7.061362667e-16 1.000000000 3.774289113e-16 +DEAL:: +DEAL::Testing 3D with point 0.6363961031 0.6363961031 5.510910596e-17 tolerance 1.000000000e-12 +DEAL::Cell: 1_2:17 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 1_2:35 unit point 1.000000000 4.179811031e-15 1.000000000 +DEAL::Cell: 1_2:53 unit point 1.000000000 1.000000000 3.793601567e-16 +DEAL::Cell: 1_2:71 unit point 1.000000000 -1.443925474e-15 3.774289196e-16 +DEAL::Cell: 5_2:27 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_2:36 unit point -5.106065339e-15 1.000000000 1.000000000 +DEAL::Cell: 5_2:63 unit point 1.000000000 1.000000000 3.793601565e-16 +DEAL::Cell: 5_2:72 unit point -7.061362667e-16 1.000000000 3.774289113e-16 +DEAL:: +DEAL::Testing 3D with point 0.6717514421 0.6717514421 5.817072296e-17 tolerance 1.000000000e-08 +DEAL::Cell: 1_2:15 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 1_2:17 unit point 1.000000000 4.238732068e-15 1.000000000 +DEAL::Cell: 1_2:51 unit point 1.000000000 1.000000000 3.065584908e-16 +DEAL::Cell: 1_2:53 unit point 1.000000000 6.596942996e-15 3.044325194e-16 +DEAL::Cell: 5_2:26 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_2:27 unit point 3.931993753e-15 1.000000000 1.000000000 +DEAL::Cell: 5_2:62 unit point 1.000000000 1.000000000 3.065584914e-16 +DEAL::Cell: 5_2:63 unit point 7.648954645e-15 1.000000000 3.044325194e-16 +DEAL:: +DEAL::Testing 3D with point 0.6717514421 0.6717514421 5.817072296e-17 tolerance 1.000000000e-12 +DEAL::Cell: 1_2:15 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 1_2:17 unit point 1.000000000 4.238732068e-15 1.000000000 +DEAL::Cell: 1_2:51 unit point 1.000000000 1.000000000 3.065584908e-16 +DEAL::Cell: 1_2:53 unit point 1.000000000 6.596942996e-15 3.044325194e-16 +DEAL::Cell: 5_2:26 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_2:27 unit point 3.931993753e-15 1.000000000 1.000000000 +DEAL::Cell: 5_2:62 unit point 1.000000000 1.000000000 3.065584914e-16 +DEAL::Cell: 5_2:63 unit point 7.648954645e-15 1.000000000 3.044325194e-16 +DEAL:: +DEAL::Testing 3D with point 0.7071067812 0.7071067812 6.123233996e-17 tolerance 1.000000000e-08 +DEAL::Cell: 1_2:15 unit point 1.000000000 -8.152343398e-15 1.000000000 +DEAL::Cell: 1_2:51 unit point 1.000000000 -3.867871011e-15 2.387232825e-16 +DEAL::Cell: 5_2:26 unit point -9.541863880e-15 1.000000000 1.000000000 +DEAL::Cell: 5_2:62 unit point -3.842094991e-15 1.000000000 2.387232858e-16 +DEAL:: +DEAL::Testing 3D with point 0.7071067812 0.7071067812 6.123233996e-17 tolerance 1.000000000e-12 +DEAL::Cell: 1_2:15 unit point 1.000000000 -8.152343398e-15 1.000000000 +DEAL::Cell: 1_2:51 unit point 1.000000000 -3.867871011e-15 2.387232825e-16 +DEAL::Cell: 5_2:26 unit point -9.541863880e-15 1.000000000 1.000000000 +DEAL::Cell: 5_2:62 unit point -3.842094991e-15 1.000000000 2.387232858e-16 +DEAL:: +DEAL::Testing 3D with point 0.4702282018 0.6472135955 4.898587197e-17 tolerance 1.000000000e-08 +DEAL::Cell: 5_2:37 unit point 0.9999999051 0.6000004612 1.000000000 +DEAL::Cell: 5_2:73 unit point 0.9999999051 0.6000004612 4.354350320e-16 +DEAL:: +DEAL::Testing 3D with point 0.4996174644 0.6876644452 5.204748896e-17 tolerance 1.000000000e-08 +DEAL::Cell: 5_2:36 unit point 0.9999998992 0.6000004612 1.000000000 +DEAL::Cell: 5_2:72 unit point 0.9999998992 0.6000004612 3.998080628e-16 +DEAL:: +DEAL::Testing 3D with point 0.5290067271 0.7281152949 5.510910596e-17 tolerance 1.000000000e-08 +DEAL::Cell: 5_2:27 unit point 0.9999998933 0.6000004612 1.000000000 +DEAL::Cell: 5_2:63 unit point 0.9999998933 0.6000004612 3.779498805e-16 +DEAL:: +DEAL::Testing 3D with point 0.5583959897 0.7685661447 5.817072296e-17 tolerance 1.000000000e-08 +DEAL::Cell: 5_2:26 unit point 0.9999998874 0.6000004612 1.000000000 +DEAL::Cell: 5_2:62 unit point 0.9999998874 0.6000004612 2.933214894e-16 +DEAL:: +DEAL::Testing 3D with point 0.5877852523 0.8090169944 6.123233996e-17 tolerance 1.000000000e-08 +DEAL:: +DEAL::Testing 3D with point 4.898587197e-17 0.8000000000 4.898587197e-17 tolerance 1.000000000e-08 +DEAL::Cell: 5_2:17 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_2:35 unit point 1.000000000 -8.452443910e-13 1.000000000 +DEAL::Cell: 5_2:53 unit point 1.000000000 1.000000000 -8.453099090e-13 +DEAL::Cell: 5_2:71 unit point 1.000000000 -8.452443912e-13 -8.453099086e-13 +DEAL:: +DEAL::Testing 3D with point 5.204748896e-17 0.8500000000 5.204748896e-17 tolerance 1.000000000e-08 +DEAL::Cell: 5_2:16 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_2:17 unit point 0.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_2:34 unit point 1.000000000 -1.426857480e-13 1.000000000 +DEAL::Cell: 5_2:35 unit point 0.000000000 0.000000000 1.000000000 +DEAL::Cell: 5_2:52 unit point 1.000000000 1.000000000 -1.427094908e-13 +DEAL::Cell: 5_2:53 unit point 0.000000000 1.000000000 0.000000000 +DEAL::Cell: 5_2:70 unit point 1.000000000 -1.426857482e-13 -1.427094908e-13 +DEAL::Cell: 5_2:71 unit point 0.000000000 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 3D with point 5.510910596e-17 0.9000000000 5.510910596e-17 tolerance 1.000000000e-08 +DEAL::Cell: 5_2:07 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_2:16 unit point 0.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_2:25 unit point 1.000000000 -3.266836433e-15 1.000000000 +DEAL::Cell: 5_2:34 unit point 0.000000000 0.000000000 1.000000000 +DEAL::Cell: 5_2:43 unit point 1.000000000 1.000000000 -3.253444312e-15 +DEAL::Cell: 5_2:52 unit point 0.000000000 1.000000000 0.000000000 +DEAL::Cell: 5_2:61 unit point 1.000000000 -3.266836592e-15 -3.253444630e-15 +DEAL::Cell: 5_2:70 unit point 0.000000000 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 3D with point 5.817072296e-17 0.9500000000 5.817072296e-17 tolerance 1.000000000e-08 +DEAL::Cell: 5_2:06 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_2:07 unit point 0.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_2:24 unit point 1.000000000 2.371285847e-16 1.000000000 +DEAL::Cell: 5_2:25 unit point 0.000000000 0.000000000 1.000000000 +DEAL::Cell: 5_2:42 unit point 1.000000000 1.000000000 2.227511764e-16 +DEAL::Cell: 5_2:43 unit point 0.000000000 1.000000000 0.000000000 +DEAL::Cell: 5_2:60 unit point 1.000000000 2.369963513e-16 2.225401541e-16 +DEAL::Cell: 5_2:61 unit point 0.000000000 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 3D with point 6.123233996e-17 1.000000000 6.123233996e-17 tolerance 1.000000000e-08 +DEAL::Cell: 5_2:06 unit point 0.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_2:24 unit point 0.000000000 0.000000000 1.000000000 +DEAL::Cell: 5_2:42 unit point 0.000000000 1.000000000 0.000000000 +DEAL::Cell: 5_2:60 unit point 0.000000000 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 3D with point -0.5656854249 0.5656854249 4.898587197e-17 tolerance 1.000000000e-08 +DEAL::Cell: 3_2:37 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 3_2:73 unit point 1.000000000 1.000000000 4.493270756e-16 +DEAL::Cell: 5_2:15 unit point 1.000000000 5.154549257e-16 1.000000000 +DEAL::Cell: 5_2:51 unit point 1.000000000 5.154931026e-16 4.493270755e-16 +DEAL:: +DEAL::Testing 3D with point -0.6010407640 0.6010407640 5.204748896e-17 tolerance 1.000000000e-08 +DEAL::Cell: 3_2:36 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 3_2:37 unit point 9.242569976e-15 1.000000000 1.000000000 +DEAL::Cell: 3_2:72 unit point 1.000000000 1.000000000 3.941914501e-16 +DEAL::Cell: 3_2:73 unit point 1.245540694e-14 1.000000000 3.924614011e-16 +DEAL::Cell: 5_2:14 unit point 1.000000000 4.856802003e-16 1.000000000 +DEAL::Cell: 5_2:15 unit point 7.571454253e-15 2.332256273e-16 1.000000000 +DEAL::Cell: 5_2:50 unit point 1.000000000 4.857232408e-16 3.941914514e-16 +DEAL::Cell: 5_2:51 unit point 1.415060991e-14 2.331600585e-16 3.924613920e-16 +DEAL:: +DEAL::Testing 3D with point -0.6363961031 0.6363961031 5.510910596e-17 tolerance 1.000000000e-08 +DEAL::Cell: 3_2:27 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 3_2:36 unit point 1.400567498e-15 1.000000000 1.000000000 +DEAL::Cell: 3_2:63 unit point 1.000000000 1.000000000 3.451820134e-16 +DEAL::Cell: 3_2:72 unit point -3.010282375e-15 1.000000000 3.432507729e-16 +DEAL::Cell: 5_2:05 unit point 1.000000000 4.592666962e-16 1.000000000 +DEAL::Cell: 5_2:14 unit point -7.168315977e-15 2.200443961e-16 1.000000000 +DEAL::Cell: 5_2:41 unit point 1.000000000 4.591495626e-16 3.451820137e-16 +DEAL::Cell: 5_2:50 unit point -1.522855047e-15 2.200267554e-16 3.432507746e-16 +DEAL:: +DEAL::Testing 3D with point -0.6717514421 0.6717514421 5.817072296e-17 tolerance 1.000000000e-08 +DEAL::Cell: 3_2:26 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 3_2:27 unit point 1.176580886e-14 1.000000000 1.000000000 +DEAL::Cell: 3_2:62 unit point 1.000000000 1.000000000 2.903688433e-16 +DEAL::Cell: 3_2:63 unit point -2.967705803e-16 1.000000000 2.882428668e-16 +DEAL::Cell: 5_2:04 unit point 1.000000000 4.354641077e-16 1.000000000 +DEAL::Cell: 5_2:05 unit point 1.925090310e-15 2.085360603e-16 1.000000000 +DEAL::Cell: 5_2:40 unit point 1.000000000 4.354432191e-16 2.903688438e-16 +DEAL::Cell: 5_2:41 unit point 2.259806175e-15 4.180691561e-16 2.882428709e-16 +DEAL:: +DEAL::Testing 3D with point -0.7071067812 0.7071067812 6.123233996e-17 tolerance 1.000000000e-08 +DEAL::Cell: 3_2:26 unit point -1.283003164e-14 1.000000000 1.000000000 +DEAL::Cell: 3_2:62 unit point -1.447991400e-15 1.000000000 2.387232784e-16 +DEAL::Cell: 5_2:04 unit point -2.065591497e-14 3.974525755e-16 1.000000000 +DEAL::Cell: 5_2:40 unit point -1.154717615e-14 3.975751353e-16 2.387232817e-16 +DEAL:: +DEAL::Testing 3D with point 0.000000000 0.000000000 0.8000000000 tolerance 1.000000000e-08 +DEAL::Cell: 2_2:27 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 2_2:36 unit point -8.454658383e-13 1.000000000 1.000000000 +DEAL::Cell: 2_2:63 unit point 1.000000000 1.000000000 -8.454003207e-13 +DEAL::Cell: 2_2:72 unit point -8.454658383e-13 1.000000000 -8.454003209e-13 +DEAL:: +DEAL::Testing 3D with point 0.000000000 0.000000000 0.8500000000 tolerance 1.000000000e-08 +DEAL::Cell: 2_2:25 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 2_2:27 unit point 1.000000000 0.000000000 1.000000000 +DEAL::Cell: 2_2:34 unit point -1.429097248e-13 1.000000000 1.000000000 +DEAL::Cell: 2_2:36 unit point 0.000000000 0.000000000 1.000000000 +DEAL::Cell: 2_2:61 unit point 1.000000000 1.000000000 -1.427597488e-13 +DEAL::Cell: 2_2:63 unit point 1.000000000 0.000000000 0.000000000 +DEAL::Cell: 2_2:70 unit point -1.429097249e-13 1.000000000 -1.427597497e-13 +DEAL::Cell: 2_2:72 unit point 0.000000000 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 3D with point 0.000000000 0.000000000 0.9000000000 tolerance 1.000000000e-08 +DEAL::Cell: 2_2:07 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 2_2:16 unit point -3.493059054e-15 1.000000000 1.000000000 +DEAL::Cell: 2_2:25 unit point 1.000000000 0.000000000 1.000000000 +DEAL::Cell: 2_2:34 unit point 0.000000000 0.000000000 1.000000000 +DEAL::Cell: 2_2:43 unit point 1.000000000 1.000000000 -3.268013729e-15 +DEAL::Cell: 2_2:52 unit point -3.493059610e-15 1.000000000 -3.268013517e-15 +DEAL::Cell: 2_2:61 unit point 1.000000000 0.000000000 0.000000000 +DEAL::Cell: 2_2:70 unit point 0.000000000 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 3D with point 0.000000000 0.000000000 0.9500000000 tolerance 1.000000000e-08 +DEAL::Cell: 2_2:05 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 2_2:07 unit point 1.000000000 0.000000000 1.000000000 +DEAL::Cell: 2_2:14 unit point 2.730258905e-17 1.000000000 1.000000000 +DEAL::Cell: 2_2:16 unit point 0.000000000 0.000000000 1.000000000 +DEAL::Cell: 2_2:41 unit point 1.000000000 1.000000000 1.541916780e-16 +DEAL::Cell: 2_2:43 unit point 1.000000000 0.000000000 0.000000000 +DEAL::Cell: 2_2:50 unit point 2.721649297e-17 1.000000000 1.541916780e-16 +DEAL::Cell: 2_2:52 unit point 0.000000000 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 3D with point 0.000000000 0.000000000 1.000000000 tolerance 1.000000000e-08 +DEAL::Cell: 2_2:05 unit point 1.000000000 0.000000000 1.000000000 +DEAL::Cell: 2_2:14 unit point 0.000000000 0.000000000 1.000000000 +DEAL::Cell: 2_2:41 unit point 1.000000000 0.000000000 0.000000000 +DEAL::Cell: 2_2:50 unit point 0.000000000 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 3D with point 0.04694448799 0.06461354454 0.7960033322 tolerance 1.000000000e-08 +DEAL::Cell: 2_2:72 unit point 0.1492717914 0.9999999828 0.2055238875 +DEAL:: +DEAL::Testing 3D with point 0.04890050833 0.06730577556 0.8291701377 tolerance 1.000000000e-08 +DEAL::Cell: 2_2:72 unit point 0.1492717914 0.3333333154 0.2055238875 +DEAL:: +DEAL::Testing 3D with point 0.05085652866 0.06999800658 0.8623369432 tolerance 1.000000000e-08 +DEAL::Cell: 2_2:70 unit point 0.1492717914 0.6666666480 0.2055238875 +DEAL:: +DEAL::Testing 3D with point 0.05281254899 0.07269023761 0.8955037488 tolerance 1.000000000e-08 +DEAL::Cell: 2_2:52 unit point 0.1492717914 0.9999999806 0.2055238875 +DEAL:: +DEAL::Testing 3D with point 0.05476856932 0.07538246863 0.9286705543 tolerance 1.000000000e-08 +DEAL::Cell: 2_2:52 unit point 0.1492717914 0.3333333133 0.2055238875 +DEAL:: +DEAL::Testing 3D with point 0.05672458966 0.07807469965 0.9618373598 tolerance 1.000000000e-08 +DEAL::Cell: 2_2:50 unit point 0.1492717914 0.6666666459 0.2055238875 +DEAL:: +DEAL::Testing 3D with point 0.05868060999 0.08076693067 0.9950041653 tolerance 1.000000000e-08 +DEAL:: +DEAL:: +DEAL::Test with MappingFEField in 3D on 384 cells: +DEAL::Testing 3D with point 0.8000000000 0.000000000 4.898587197e-17 tolerance 1.000000000e-08 +DEAL::Cell: 1_2:27 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 1_2:36 unit point 0.000000000 1.000000000 1.000000000 +DEAL::Cell: 1_2:63 unit point 1.000000000 1.000000000 0.000000000 +DEAL::Cell: 1_2:72 unit point 0.000000000 1.000000000 0.000000000 +DEAL:: +DEAL::Testing 3D with point 0.8500000000 0.000000000 5.204748896e-17 tolerance 1.000000000e-08 +DEAL::Cell: 1_2:25 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 1_2:27 unit point 1.000000000 0.000000000 1.000000000 +DEAL::Cell: 1_2:34 unit point 0.000000000 1.000000000 1.000000000 +DEAL::Cell: 1_2:36 unit point 0.000000000 0.000000000 1.000000000 +DEAL::Cell: 1_2:61 unit point 1.000000000 1.000000000 0.000000000 +DEAL::Cell: 1_2:63 unit point 1.000000000 0.000000000 0.000000000 +DEAL::Cell: 1_2:70 unit point 0.000000000 1.000000000 0.000000000 +DEAL::Cell: 1_2:72 unit point 0.000000000 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 3D with point 0.9000000000 0.000000000 5.510910596e-17 tolerance 1.000000000e-08 +DEAL::Cell: 1_2:07 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 1_2:16 unit point 0.000000000 1.000000000 1.000000000 +DEAL::Cell: 1_2:25 unit point 1.000000000 0.000000000 1.000000000 +DEAL::Cell: 1_2:34 unit point 0.000000000 0.000000000 1.000000000 +DEAL::Cell: 1_2:43 unit point 1.000000000 1.000000000 0.000000000 +DEAL::Cell: 1_2:52 unit point 0.000000000 1.000000000 0.000000000 +DEAL::Cell: 1_2:61 unit point 1.000000000 0.000000000 0.000000000 +DEAL::Cell: 1_2:70 unit point 0.000000000 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 3D with point 0.9500000000 0.000000000 5.817072296e-17 tolerance 1.000000000e-08 +DEAL::Cell: 1_2:05 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 1_2:07 unit point 1.000000000 0.000000000 1.000000000 +DEAL::Cell: 1_2:14 unit point 2.801656062e-17 1.000000000 1.000000000 +DEAL::Cell: 1_2:16 unit point 0.000000000 0.000000000 1.000000000 +DEAL::Cell: 1_2:41 unit point 1.000000000 1.000000000 3.185053858e-16 +DEAL::Cell: 1_2:43 unit point 1.000000000 0.000000000 0.000000000 +DEAL::Cell: 1_2:50 unit point 2.801656062e-17 1.000000000 3.185053858e-16 +DEAL::Cell: 1_2:52 unit point 0.000000000 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 3D with point 1.000000000 0.000000000 6.123233996e-17 tolerance 1.000000000e-08 +DEAL::Cell: 1_2:05 unit point 1.000000000 0.000000000 1.000000000 +DEAL::Cell: 1_2:14 unit point 0.000000000 0.000000000 1.000000000 +DEAL::Cell: 1_2:41 unit point 1.000000000 0.000000000 0.000000000 +DEAL::Cell: 1_2:50 unit point 0.000000000 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 3D with point 0.5656854249 0.5656854249 4.898587197e-17 tolerance 1.000000000e-08 +DEAL::Cell: 1_2:37 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 1_2:73 unit point 1.000000000 1.000000000 4.510281038e-16 +DEAL::Cell: 5_2:37 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_2:73 unit point 1.000000000 1.000000000 4.579669977e-16 +DEAL:: +DEAL::Testing 3D with point 0.5656854249 0.5656854249 4.898587197e-17 tolerance 1.000000000e-12 +DEAL::Cell: 1_2:37 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 1_2:73 unit point 1.000000000 1.000000000 4.510281038e-16 +DEAL::Cell: 5_2:37 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_2:73 unit point 1.000000000 1.000000000 4.579669977e-16 +DEAL:: +DEAL::Testing 3D with point 0.6010407640 0.6010407640 5.204748896e-17 tolerance 1.000000000e-08 +DEAL::Cell: 1_2:35 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 1_2:37 unit point 1.000000000 1.340787371e-15 1.000000000 +DEAL::Cell: 1_2:71 unit point 1.000000000 1.000000000 4.232725281e-16 +DEAL::Cell: 1_2:73 unit point 1.000000000 1.217238525e-15 4.189086144e-16 +DEAL::Cell: 5_2:36 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_2:37 unit point 0.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_2:72 unit point 1.000000000 1.000000000 4.302114220e-16 +DEAL::Cell: 5_2:73 unit point 0.000000000 1.000000000 4.188815093e-16 +DEAL:: +DEAL::Testing 3D with point 0.6010407640 0.6010407640 5.204748896e-17 tolerance 1.000000000e-12 +DEAL::Cell: 1_2:35 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 1_2:37 unit point 1.000000000 1.340787371e-15 1.000000000 +DEAL::Cell: 1_2:71 unit point 1.000000000 1.000000000 4.232725281e-16 +DEAL::Cell: 1_2:73 unit point 1.000000000 1.217238525e-15 4.189086144e-16 +DEAL::Cell: 5_2:36 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_2:37 unit point 0.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_2:72 unit point 1.000000000 1.000000000 4.302114220e-16 +DEAL::Cell: 5_2:73 unit point 0.000000000 1.000000000 4.188815093e-16 +DEAL:: +DEAL::Testing 3D with point 0.6363961031 0.6363961031 5.510910596e-17 tolerance 1.000000000e-08 +DEAL::Cell: 1_2:17 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 1_2:35 unit point 1.000000000 8.364953980e-15 1.000000000 +DEAL::Cell: 1_2:53 unit point 1.000000000 1.000000000 4.093947403e-16 +DEAL::Cell: 1_2:71 unit point 1.000000000 8.450354378e-16 3.854338723e-16 +DEAL::Cell: 5_2:27 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_2:36 unit point 9.017125406e-15 1.000000000 1.000000000 +DEAL::Cell: 5_2:63 unit point 1.000000000 1.000000000 4.232725281e-16 +DEAL::Cell: 5_2:72 unit point 3.623066799e-15 1.000000000 3.854203198e-16 +DEAL:: +DEAL::Testing 3D with point 0.6363961031 0.6363961031 5.510910596e-17 tolerance 1.000000000e-12 +DEAL::Cell: 1_2:17 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 1_2:35 unit point 1.000000000 8.364953980e-15 1.000000000 +DEAL::Cell: 1_2:53 unit point 1.000000000 1.000000000 4.093947403e-16 +DEAL::Cell: 1_2:71 unit point 1.000000000 8.450354378e-16 3.854338723e-16 +DEAL::Cell: 5_2:27 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_2:36 unit point 9.017125406e-15 1.000000000 1.000000000 +DEAL::Cell: 5_2:63 unit point 1.000000000 1.000000000 4.232725281e-16 +DEAL::Cell: 5_2:72 unit point 3.623066799e-15 1.000000000 3.854203198e-16 +DEAL:: +DEAL::Testing 3D with point 0.6717514421 0.6717514421 5.817072296e-17 tolerance 1.000000000e-08 +DEAL::Cell: 1_2:15 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 1_2:17 unit point 1.000000000 5.230467420e-15 1.000000000 +DEAL::Cell: 1_2:51 unit point 1.000000000 1.000000000 3.261280135e-16 +DEAL::Cell: 1_2:53 unit point 1.000000000 4.720330414e-15 3.114506266e-16 +DEAL::Cell: 5_2:26 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_2:27 unit point 6.150526269e-15 1.000000000 1.000000000 +DEAL::Cell: 5_2:62 unit point 1.000000000 1.000000000 3.400058013e-16 +DEAL::Cell: 5_2:63 unit point 4.367705547e-15 1.000000000 3.114912842e-16 +DEAL:: +DEAL::Testing 3D with point 0.6717514421 0.6717514421 5.817072296e-17 tolerance 1.000000000e-12 +DEAL::Cell: 1_2:15 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 1_2:17 unit point 1.000000000 5.230467420e-15 1.000000000 +DEAL::Cell: 1_2:51 unit point 1.000000000 1.000000000 3.261280135e-16 +DEAL::Cell: 1_2:53 unit point 1.000000000 4.720330414e-15 3.114506266e-16 +DEAL::Cell: 5_2:26 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_2:27 unit point 6.150526269e-15 1.000000000 1.000000000 +DEAL::Cell: 5_2:62 unit point 1.000000000 1.000000000 3.400058013e-16 +DEAL::Cell: 5_2:63 unit point 4.367705547e-15 1.000000000 3.114912842e-16 +DEAL:: +DEAL::Testing 3D with point 0.7071067812 0.7071067812 6.123233996e-17 tolerance 1.000000000e-08 +DEAL::Cell: 1_2:15 unit point 1.000000000 6.532623389e-16 1.000000000 +DEAL::Cell: 1_2:51 unit point 1.000000000 0.000000000 2.448806132e-16 +DEAL::Cell: 5_2:26 unit point 1.683607224e-15 1.000000000 1.000000000 +DEAL::Cell: 5_2:62 unit point 7.317719684e-16 1.000000000 2.449212708e-16 +DEAL:: +DEAL::Testing 3D with point 0.7071067812 0.7071067812 6.123233996e-17 tolerance 1.000000000e-12 +DEAL::Cell: 1_2:15 unit point 1.000000000 6.532623389e-16 1.000000000 +DEAL::Cell: 1_2:51 unit point 1.000000000 0.000000000 2.448806132e-16 +DEAL::Cell: 5_2:26 unit point 1.683607224e-15 1.000000000 1.000000000 +DEAL::Cell: 5_2:62 unit point 7.317719684e-16 1.000000000 2.449212708e-16 +DEAL:: +DEAL::Testing 3D with point 0.4702282018 0.6472135955 4.898587197e-17 tolerance 1.000000000e-08 +DEAL::Cell: 5_2:37 unit point 0.9999999051 0.6000004612 1.000000000 +DEAL::Cell: 5_2:73 unit point 0.9999999051 0.6000004612 4.126782931e-16 +DEAL:: +DEAL::Testing 3D with point 0.4996174644 0.6876644452 5.204748896e-17 tolerance 1.000000000e-08 +DEAL::Cell: 5_2:36 unit point 0.9999998992 0.6000004612 1.000000000 +DEAL::Cell: 5_2:72 unit point 0.9999998992 0.6000004612 3.720310446e-16 +DEAL:: +DEAL::Testing 3D with point 0.5290067271 0.7281152949 5.510910596e-17 tolerance 1.000000000e-08 +DEAL::Cell: 5_2:27 unit point 0.9999998933 0.6000004612 1.000000000 +DEAL::Cell: 5_2:63 unit point 0.9999998933 0.6000004612 3.570757076e-16 +DEAL:: +DEAL::Testing 3D with point 0.5583959897 0.7685661447 5.817072296e-17 tolerance 1.000000000e-08 +DEAL::Cell: 5_2:26 unit point 0.9999998874 0.6000004612 1.000000000 +DEAL::Cell: 5_2:62 unit point 0.9999998874 0.6000004612 2.796772657e-16 +DEAL:: +DEAL::Testing 3D with point 0.5877852523 0.8090169944 6.123233996e-17 tolerance 1.000000000e-08 +DEAL:: +DEAL::Testing 3D with point 4.898587197e-17 0.8000000000 4.898587197e-17 tolerance 1.000000000e-08 +DEAL::Cell: 5_2:17 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_2:35 unit point 1.000000000 0.000000000 1.000000000 +DEAL::Cell: 5_2:53 unit point 1.000000000 1.000000000 0.000000000 +DEAL::Cell: 5_2:71 unit point 1.000000000 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 3D with point 5.204748896e-17 0.8500000000 5.204748896e-17 tolerance 1.000000000e-08 +DEAL::Cell: 5_2:16 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_2:17 unit point 0.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_2:34 unit point 1.000000000 0.000000000 1.000000000 +DEAL::Cell: 5_2:35 unit point 0.000000000 0.000000000 1.000000000 +DEAL::Cell: 5_2:52 unit point 1.000000000 1.000000000 0.000000000 +DEAL::Cell: 5_2:53 unit point 0.000000000 1.000000000 0.000000000 +DEAL::Cell: 5_2:70 unit point 1.000000000 0.000000000 0.000000000 +DEAL::Cell: 5_2:71 unit point 0.000000000 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 3D with point 5.510910596e-17 0.9000000000 5.510910596e-17 tolerance 1.000000000e-08 +DEAL::Cell: 5_2:07 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_2:16 unit point 0.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_2:25 unit point 1.000000000 0.000000000 1.000000000 +DEAL::Cell: 5_2:34 unit point 0.000000000 0.000000000 1.000000000 +DEAL::Cell: 5_2:43 unit point 1.000000000 1.000000000 0.000000000 +DEAL::Cell: 5_2:52 unit point 0.000000000 1.000000000 0.000000000 +DEAL::Cell: 5_2:61 unit point 1.000000000 0.000000000 0.000000000 +DEAL::Cell: 5_2:70 unit point 0.000000000 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 3D with point 5.817072296e-17 0.9500000000 5.817072296e-17 tolerance 1.000000000e-08 +DEAL::Cell: 5_2:06 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_2:07 unit point 0.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_2:24 unit point 1.000000000 2.433310421e-16 1.000000000 +DEAL::Cell: 5_2:25 unit point 0.000000000 0.000000000 1.000000000 +DEAL::Cell: 5_2:42 unit point 1.000000000 1.000000000 2.285773639e-16 +DEAL::Cell: 5_2:43 unit point 0.000000000 1.000000000 0.000000000 +DEAL::Cell: 5_2:60 unit point 1.000000000 2.433310421e-16 2.285773639e-16 +DEAL::Cell: 5_2:61 unit point 0.000000000 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 3D with point 6.123233996e-17 1.000000000 6.123233996e-17 tolerance 1.000000000e-08 +DEAL::Cell: 5_2:06 unit point 0.000000000 1.000000000 1.000000000 +DEAL::Cell: 5_2:24 unit point 0.000000000 0.000000000 1.000000000 +DEAL::Cell: 5_2:42 unit point 0.000000000 1.000000000 0.000000000 +DEAL::Cell: 5_2:60 unit point 0.000000000 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 3D with point -0.5656854249 0.5656854249 4.898587197e-17 tolerance 1.000000000e-08 +DEAL::Cell: 3_2:37 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 3_2:73 unit point 1.000000000 1.000000000 4.579669977e-16 +DEAL::Cell: 5_2:15 unit point 1.000000000 2.576412964e-16 1.000000000 +DEAL::Cell: 5_2:51 unit point 1.000000000 2.576412964e-16 4.440892099e-16 +DEAL:: +DEAL::Testing 3D with point -0.6010407640 0.6010407640 5.204748896e-17 tolerance 1.000000000e-08 +DEAL::Cell: 3_2:36 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 3_2:37 unit point 2.887812669e-15 1.000000000 1.000000000 +DEAL::Cell: 3_2:72 unit point 1.000000000 1.000000000 3.816391647e-16 +DEAL::Cell: 3_2:73 unit point 0.000000000 1.000000000 4.005178350e-16 +DEAL::Cell: 5_2:14 unit point 1.000000000 2.424872955e-16 1.000000000 +DEAL::Cell: 5_2:15 unit point 0.000000000 2.427193263e-16 1.000000000 +DEAL::Cell: 5_2:50 unit point 1.000000000 2.419137231e-16 3.816391647e-16 +DEAL::Cell: 5_2:51 unit point 0.000000000 2.434556711e-16 4.005313876e-16 +DEAL:: +DEAL::Testing 3D with point -0.6363961031 0.6363961031 5.510910596e-17 tolerance 1.000000000e-08 +DEAL::Cell: 3_2:27 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 3_2:36 unit point 7.471231410e-15 1.000000000 1.000000000 +DEAL::Cell: 3_2:63 unit point 1.000000000 1.000000000 3.885780586e-16 +DEAL::Cell: 3_2:72 unit point 9.926251301e-15 1.000000000 3.506987452e-16 +DEAL::Cell: 5_2:05 unit point 1.000000000 2.290821601e-16 1.000000000 +DEAL::Cell: 5_2:14 unit point 1.007002086e-14 2.291999828e-16 1.000000000 +DEAL::Cell: 5_2:41 unit point 1.000000000 2.282147984e-16 3.885780586e-16 +DEAL::Cell: 5_2:50 unit point 8.444411254e-15 2.292011005e-16 3.507122977e-16 +DEAL:: +DEAL::Testing 3D with point -0.6717514421 0.6717514421 5.817072296e-17 tolerance 1.000000000e-08 +DEAL::Cell: 3_2:26 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 3_2:27 unit point 5.442260302e-15 1.000000000 1.000000000 +DEAL::Cell: 3_2:62 unit point 1.000000000 1.000000000 3.191891196e-16 +DEAL::Cell: 3_2:63 unit point 2.073335395e-15 1.000000000 2.949978586e-16 +DEAL::Cell: 5_2:04 unit point 1.000000000 2.172139652e-16 1.000000000 +DEAL::Cell: 5_2:05 unit point 2.659503345e-15 2.172386585e-16 1.000000000 +DEAL::Cell: 5_2:40 unit point 1.000000000 2.172009889e-16 3.191891196e-16 +DEAL::Cell: 5_2:41 unit point 4.380989029e-15 2.170775064e-16 2.950114111e-16 +DEAL:: +DEAL::Testing 3D with point -0.7071067812 0.7071067812 6.123233996e-17 tolerance 1.000000000e-08 +DEAL::Cell: 3_2:26 unit point 0.000000000 1.000000000 1.000000000 +DEAL::Cell: 3_2:62 unit point 1.261525940e-16 1.000000000 2.448941657e-16 +DEAL::Cell: 5_2:04 unit point 1.999908732e-15 2.076410867e-16 1.000000000 +DEAL::Cell: 5_2:40 unit point 0.000000000 2.056567573e-16 2.449212708e-16 +DEAL:: +DEAL::Testing 3D with point 0.000000000 0.000000000 0.8000000000 tolerance 1.000000000e-08 +DEAL::Cell: 2_2:27 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 2_2:36 unit point 0.000000000 1.000000000 1.000000000 +DEAL::Cell: 2_2:63 unit point 1.000000000 1.000000000 0.000000000 +DEAL::Cell: 2_2:72 unit point 0.000000000 1.000000000 0.000000000 +DEAL:: +DEAL::Testing 3D with point 0.000000000 0.000000000 0.8500000000 tolerance 1.000000000e-08 +DEAL::Cell: 2_2:25 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 2_2:27 unit point 1.000000000 0.000000000 1.000000000 +DEAL::Cell: 2_2:34 unit point 0.000000000 1.000000000 1.000000000 +DEAL::Cell: 2_2:36 unit point 0.000000000 0.000000000 1.000000000 +DEAL::Cell: 2_2:61 unit point 1.000000000 1.000000000 0.000000000 +DEAL::Cell: 2_2:63 unit point 1.000000000 0.000000000 0.000000000 +DEAL::Cell: 2_2:70 unit point 0.000000000 1.000000000 0.000000000 +DEAL::Cell: 2_2:72 unit point 0.000000000 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 3D with point 0.000000000 0.000000000 0.9000000000 tolerance 1.000000000e-08 +DEAL::Cell: 2_2:07 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 2_2:16 unit point 0.000000000 1.000000000 1.000000000 +DEAL::Cell: 2_2:25 unit point 1.000000000 0.000000000 1.000000000 +DEAL::Cell: 2_2:34 unit point 0.000000000 0.000000000 1.000000000 +DEAL::Cell: 2_2:43 unit point 1.000000000 1.000000000 0.000000000 +DEAL::Cell: 2_2:52 unit point 0.000000000 1.000000000 0.000000000 +DEAL::Cell: 2_2:61 unit point 1.000000000 0.000000000 0.000000000 +DEAL::Cell: 2_2:70 unit point 0.000000000 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 3D with point 0.000000000 0.000000000 0.9500000000 tolerance 1.000000000e-08 +DEAL::Cell: 2_2:05 unit point 1.000000000 1.000000000 1.000000000 +DEAL::Cell: 2_2:07 unit point 1.000000000 0.000000000 1.000000000 +DEAL::Cell: 2_2:14 unit point 2.801656062e-17 1.000000000 1.000000000 +DEAL::Cell: 2_2:16 unit point 0.000000000 0.000000000 1.000000000 +DEAL::Cell: 2_2:41 unit point 1.000000000 1.000000000 1.585968829e-16 +DEAL::Cell: 2_2:43 unit point 1.000000000 0.000000000 0.000000000 +DEAL::Cell: 2_2:50 unit point 2.801656062e-17 1.000000000 1.585968829e-16 +DEAL::Cell: 2_2:52 unit point 0.000000000 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 3D with point 0.000000000 0.000000000 1.000000000 tolerance 1.000000000e-08 +DEAL::Cell: 2_2:05 unit point 1.000000000 0.000000000 1.000000000 +DEAL::Cell: 2_2:14 unit point 0.000000000 0.000000000 1.000000000 +DEAL::Cell: 2_2:41 unit point 1.000000000 0.000000000 0.000000000 +DEAL::Cell: 2_2:50 unit point 0.000000000 0.000000000 0.000000000 +DEAL:: +DEAL::Testing 3D with point 0.04694448799 0.06461354454 0.7960033322 tolerance 1.000000000e-08 +DEAL::Cell: 2_2:72 unit point 0.1492717914 0.9999999828 0.2055238875 +DEAL:: +DEAL::Testing 3D with point 0.04890050833 0.06730577556 0.8291701377 tolerance 1.000000000e-08 +DEAL::Cell: 2_2:72 unit point 0.1492717914 0.3333333154 0.2055238875 +DEAL:: +DEAL::Testing 3D with point 0.05085652866 0.06999800658 0.8623369432 tolerance 1.000000000e-08 +DEAL::Cell: 2_2:70 unit point 0.1492717914 0.6666666480 0.2055238875 +DEAL:: +DEAL::Testing 3D with point 0.05281254899 0.07269023761 0.8955037488 tolerance 1.000000000e-08 +DEAL::Cell: 2_2:52 unit point 0.1492717914 0.9999999806 0.2055238875 +DEAL:: +DEAL::Testing 3D with point 0.05476856932 0.07538246863 0.9286705543 tolerance 1.000000000e-08 +DEAL::Cell: 2_2:52 unit point 0.1492717914 0.3333333133 0.2055238875 +DEAL:: +DEAL::Testing 3D with point 0.05672458966 0.07807469965 0.9618373598 tolerance 1.000000000e-08 +DEAL::Cell: 2_2:50 unit point 0.1492717914 0.6666666459 0.2055238875 +DEAL:: +DEAL::Testing 3D with point 0.05868060999 0.08076693067 0.9950041653 tolerance 1.000000000e-08 +DEAL:: +DEAL::