From c9c90cc7471ba34166507537dc60535c3234b65c Mon Sep 17 00:00:00 2001 From: Martin Kronbichler Date: Thu, 4 May 2023 11:14:29 +0200 Subject: [PATCH] Reduce operation count in polynomial evaluation --- include/deal.II/base/polynomial.h | 36 +- tests/fe/rt_8.cc | 9 +- tests/fe/rt_8.output | 178 ++-- .../mapping_q_real_to_unit_internal.cc | 2 +- .../mapping_q_real_to_unit_internal.output | 896 +++++++++--------- 5 files changed, 557 insertions(+), 564 deletions(-) diff --git a/include/deal.II/base/polynomial.h b/include/deal.II/base/polynomial.h index 397a7d2c54..5142a074fc 100644 --- a/include/deal.II/base/polynomial.h +++ b/include/deal.II/base/polynomial.h @@ -875,7 +875,7 @@ namespace Polynomials { default: for (unsigned int e = 0; e < n_entries; ++e) - values[0][e] = 1.; + values[0][e] = weight; for (unsigned int k = 1; k <= n_derivatives; ++k) for (unsigned int e = 0; e < n_entries; ++e) values[k][e] = 0.; @@ -897,20 +897,14 @@ namespace Polynomials for (unsigned int e = 0; e < n_entries; ++e) values[0][e] *= v[e]; } - // finally, multiply by the weight in the Lagrange - // denominator. Could be done instead of setting values[0] = 1 - // above, but that gives different accumulation of round-off - // errors (multiplication is not associative) compared to when we - // computed the weight, and hence a basis function might not be - // exactly one at the center point, which is nice to have. We also - // multiply derivatives by k! to transform the product p_n = - // p^(n)(x)/k! into the actual form of the derivative + // finally, multiply derivatives by k! to transform the product + // p_n = p^(n)(x)/k! into the actual form of the derivative { - number k_factorial = 1; - for (unsigned int k = 0; k <= n_derivatives; ++k) + number k_factorial = 2; + for (unsigned int k = 2; k <= n_derivatives; ++k) { for (unsigned int e = 0; e < n_entries; ++e) - values[k][e] *= k_factorial * weight; + values[k][e] *= k_factorial; k_factorial *= static_cast(k + 1); } } @@ -925,13 +919,13 @@ namespace Polynomials { std::array value; for (unsigned int e = 0; e < n_entries; ++e) - value[e] = 1.; + value[e] = weight; for (unsigned int i = 0; i < n_supp; ++i) for (unsigned int e = 0; e < n_entries; ++e) value[e] *= (x[e] - lagrange_support_points[i]); for (unsigned int e = 0; e < n_entries; ++e) - values[0][e] = weight * value[e]; + values[0][e] = value[e]; break; } @@ -939,7 +933,7 @@ namespace Polynomials { std::array value, derivative = {}; for (unsigned int e = 0; e < n_entries; ++e) - value[e] = 1.; + value[e] = weight; for (unsigned int i = 0; i < n_supp; ++i) for (unsigned int e = 0; e < n_entries; ++e) { @@ -950,8 +944,8 @@ namespace Polynomials for (unsigned int e = 0; e < n_entries; ++e) { - values[0][e] = weight * value[e]; - values[1][e] = weight * derivative[e]; + values[0][e] = value[e]; + values[1][e] = derivative[e]; } break; } @@ -961,7 +955,7 @@ namespace Polynomials std::array value, derivative = {}, second = {}; for (unsigned int e = 0; e < n_entries; ++e) - value[e] = 1.; + value[e] = weight; for (unsigned int i = 0; i < n_supp; ++i) for (unsigned int e = 0; e < n_entries; ++e) { @@ -973,9 +967,9 @@ namespace Polynomials for (unsigned int e = 0; e < n_entries; ++e) { - values[0][e] = weight * value[e]; - values[1][e] = weight * derivative[e]; - values[2][e] = static_cast(2) * weight * second[e]; + values[0][e] = value[e]; + values[1][e] = derivative[e]; + values[2][e] = static_cast(2) * second[e]; } break; } diff --git a/tests/fe/rt_8.cc b/tests/fe/rt_8.cc index 6a68f5d938..1820c28a5a 100644 --- a/tests/fe/rt_8.cc +++ b/tests/fe/rt_8.cc @@ -39,7 +39,7 @@ #include "../tests.h" -#define PRECISION 8 +#define PRECISION 10 template @@ -50,15 +50,14 @@ test(const unsigned int degree) Triangulation tr; GridGenerator::hyper_cube(tr, 0., 1.); - DoFHandler dof(tr); - typename DoFHandler::cell_iterator c = dof.begin(); + DoFHandler dof(tr); dof.distribute_dofs(fe_rt); QTrapezoid<1> q_trapez; const unsigned int div = 4; QIterated q(q_trapez, div); FEValues fe(fe_rt, q, update_values | update_JxW_values); - fe.reinit(c); + fe.reinit(dof.begin_active()); const unsigned int dofs_per_cell = fe_rt.dofs_per_cell; FullMatrix mass_matrix(dofs_per_cell, dofs_per_cell); @@ -79,7 +78,7 @@ test(const unsigned int degree) mass_matrix(i, j) = 0; mass_matrix.print_formatted(deallog.get_file_stream(), 3, false, 0, " ", 1); - SolverControl solver_control(dofs_per_cell, 1e-8); + SolverControl solver_control(dofs_per_cell, 1e-9); PrimitiveVectorMemory<> vector_memory; SolverCG<> cg(solver_control, vector_memory); diff --git a/tests/fe/rt_8.output b/tests/fe/rt_8.output index a7ef1cb61d..7e0e5d6477 100644 --- a/tests/fe/rt_8.output +++ b/tests/fe/rt_8.output @@ -1,93 +1,93 @@ -0.344 0.156 -0.156 0.344 - 0.344 0.156 - 0.156 0.344 -DEAL:cg::Starting value 1.45334241 -DEAL:cg::Convergence step 2 value 0 +0.344 0.156 +0.156 0.344 + 0.344 0.156 + 0.156 0.344 +DEAL:cg::Starting value 1.4533424147 +DEAL:cg::Convergence step 2 value 0.0000000000 DEAL::Degree=0: 2 iterations to obtain convergence. -0.174 -0.014 -0.129 - 0.196 -0.015 -0.145 --0.014 0.174 -0.129 - -0.015 0.196 -0.145 - 0.174 -0.014 -0.129 - 0.196 -0.015 -0.145 - -0.014 0.174 -0.129 - -0.015 0.196 -0.145 --0.129 -0.129 1.195 - -0.129 -0.129 1.195 - -0.145 -0.145 1.345 - -0.145 -0.145 1.345 -DEAL:cg::Starting value 2.17322562 -DEAL:cg::Convergence step 6 value 0 +0.174 -0.014 -0.129 + 0.196 -0.015 -0.145 +-0.014 0.174 -0.129 + -0.015 0.196 -0.145 + 0.174 -0.014 -0.129 + 0.196 -0.015 -0.145 + -0.014 0.174 -0.129 + -0.015 0.196 -0.145 +-0.129 -0.129 1.195 + -0.129 -0.129 1.195 + -0.145 -0.145 1.345 + -0.145 -0.145 1.345 +DEAL:cg::Starting value 2.1732256211 +DEAL:cg::Convergence step 6 value 0.0000000000 DEAL::Degree=1: 6 iterations to obtain convergence. -0.167 0.023 -0.006 -0.001 -0.129 0.178 -0.018 0.025 - 0.187 -0.007 -0.145 0.200 -0.023 0.267 -0.001 -0.010 -0.018 0.025 -0.206 0.284 --0.006 -0.001 0.167 0.023 -0.129 -0.178 -0.018 -0.025 - -0.007 0.187 -0.145 -0.200 --0.001 -0.010 0.023 0.267 -0.018 -0.025 -0.206 -0.284 - 0.167 0.023 -0.006 -0.001 -0.129 -0.018 0.178 0.025 - 0.187 -0.007 -0.145 0.200 - 0.023 0.267 -0.001 -0.010 -0.018 -0.206 0.025 0.284 - -0.006 -0.001 0.167 0.023 -0.129 -0.018 -0.178 -0.025 - -0.007 0.187 -0.145 -0.200 - -0.001 -0.010 0.023 0.267 -0.018 -0.206 -0.025 -0.284 --0.129 -0.018 -0.129 -0.018 1.195 0.167 - -0.129 -0.018 -0.129 -0.018 1.195 0.167 -0.178 0.025 -0.178 -0.025 1.318 0.184 - -0.145 -0.145 1.345 - -0.145 -0.145 1.345 - -0.018 -0.206 -0.018 -0.206 0.167 1.914 - 0.200 -0.200 1.483 - 0.178 0.025 -0.178 -0.025 1.318 0.184 --0.018 -0.206 -0.018 -0.206 0.167 1.914 - 0.200 -0.200 1.483 -0.025 0.284 -0.025 -0.284 0.184 2.111 - 0.025 0.284 -0.025 -0.284 0.184 2.111 -DEAL:cg::Starting value 2.69691872 -DEAL:cg::Convergence step 12 value 0 +0.167 0.023 -0.006 -0.001 -0.129 0.178 -0.018 0.025 + 0.187 -0.007 -0.145 0.200 +0.023 0.267 -0.001 -0.010 -0.018 0.025 -0.206 0.284 +-0.006 -0.001 0.167 0.023 -0.129 -0.178 -0.018 -0.025 + -0.007 0.187 -0.145 -0.200 +-0.001 -0.010 0.023 0.267 -0.018 -0.025 -0.206 -0.284 + 0.167 0.023 -0.006 -0.001 -0.129 -0.018 0.178 0.025 + 0.187 -0.007 -0.145 0.200 + 0.023 0.267 -0.001 -0.010 -0.018 -0.206 0.025 0.284 + -0.006 -0.001 0.167 0.023 -0.129 -0.018 -0.178 -0.025 + -0.007 0.187 -0.145 -0.200 + -0.001 -0.010 0.023 0.267 -0.018 -0.206 -0.025 -0.284 +-0.129 -0.018 -0.129 -0.018 1.195 0.167 + -0.129 -0.018 -0.129 -0.018 1.195 0.167 +0.178 0.025 -0.178 -0.025 1.318 0.184 + -0.145 -0.145 1.345 + -0.145 -0.145 1.345 + -0.018 -0.206 -0.018 -0.206 0.167 1.914 + 0.200 -0.200 1.483 + 0.178 0.025 -0.178 -0.025 1.318 0.184 +-0.018 -0.206 -0.018 -0.206 0.167 1.914 + 0.200 -0.200 1.483 +0.025 0.284 -0.025 -0.284 0.184 2.111 + 0.025 0.284 -0.025 -0.284 0.184 2.111 +DEAL:cg::Starting value 2.6969187164 +DEAL:cg::Convergence step 12 value 0.0000000000 DEAL::Degree=2: 12 iterations to obtain convergence. -0.168 0.024 -0.005 -0.001 -0.064 0.178 -0.118 -0.009 0.025 -0.017 - 0.189 0.108 -0.005 -0.003 -0.072 0.200 -0.133 -0.041 0.114 -0.076 -0.024 0.269 -0.001 -0.008 -0.009 0.025 -0.017 -0.102 0.284 -0.189 - 0.108 0.407 -0.003 -0.011 -0.041 0.114 -0.076 -0.155 0.430 -0.286 --0.005 -0.001 0.168 0.024 -0.064 -0.178 -0.118 -0.009 -0.025 -0.017 - -0.005 -0.003 0.189 0.108 -0.072 -0.200 -0.133 -0.041 -0.114 -0.076 --0.001 -0.008 0.024 0.269 -0.009 -0.025 -0.017 -0.102 -0.284 -0.189 - -0.003 -0.011 0.108 0.407 -0.041 -0.114 -0.076 -0.155 -0.430 -0.286 - 0.168 0.024 -0.005 -0.001 -0.064 -0.009 0.178 0.025 -0.118 -0.017 - 0.189 0.108 -0.005 -0.003 -0.072 -0.041 0.200 0.114 -0.133 -0.076 - 0.024 0.269 -0.001 -0.008 -0.009 -0.102 0.025 0.284 -0.017 -0.189 - 0.108 0.407 -0.003 -0.011 -0.041 -0.155 0.114 0.430 -0.076 -0.286 - -0.005 -0.001 0.168 0.024 -0.064 -0.009 -0.178 -0.025 -0.118 -0.017 - -0.005 -0.003 0.189 0.108 -0.072 -0.041 -0.200 -0.114 -0.133 -0.076 - -0.001 -0.008 0.024 0.269 -0.009 -0.102 -0.025 -0.284 -0.017 -0.189 - -0.003 -0.011 0.108 0.407 -0.041 -0.155 -0.114 -0.430 -0.076 -0.286 --0.064 -0.009 -0.064 -0.009 0.928 -0.069 0.130 -0.010 - -0.064 -0.009 -0.064 -0.009 0.928 0.130 -0.069 -0.010 -0.178 0.025 -0.178 -0.025 1.318 0.184 - -0.072 -0.041 -0.072 -0.041 1.045 0.598 -0.078 -0.045 --0.118 -0.017 -0.118 -0.017 -0.069 1.024 -0.010 0.143 - -0.009 -0.102 -0.009 -0.102 0.130 1.487 -0.010 -0.111 - -0.072 -0.041 -0.072 -0.041 1.045 -0.078 0.598 -0.045 - -0.041 -0.155 -0.041 -0.155 0.598 2.247 -0.045 -0.168 - 0.200 0.114 -0.200 -0.114 1.483 0.850 - 0.178 0.025 -0.178 -0.025 1.318 0.184 - -0.133 -0.076 -0.133 -0.076 -0.078 1.152 -0.045 0.660 - 0.200 0.114 -0.200 -0.114 1.483 0.850 --0.009 -0.102 -0.009 -0.102 0.130 -0.010 1.487 -0.111 - 0.025 0.284 -0.025 -0.284 0.184 2.111 -0.025 0.284 -0.025 -0.284 0.184 2.111 - 0.114 0.430 -0.114 -0.430 0.850 3.190 --0.017 -0.189 -0.017 -0.189 -0.010 0.143 -0.111 1.641 - -0.118 -0.017 -0.118 -0.017 -0.069 -0.010 1.024 0.143 - -0.041 -0.155 -0.041 -0.155 0.598 -0.045 2.247 -0.168 - -0.133 -0.076 -0.133 -0.076 -0.078 -0.045 1.152 0.660 - 0.114 0.430 -0.114 -0.430 0.850 3.190 - -0.017 -0.189 -0.017 -0.189 -0.010 -0.111 0.143 1.641 - -0.076 -0.286 -0.076 -0.286 -0.045 0.660 -0.168 2.479 - -0.076 -0.286 -0.076 -0.286 -0.045 -0.168 0.660 2.479 -DEAL:cg::Starting value 3.81366348 -DEAL:cg::Convergence step 21 value 0.00000000 -DEAL::Degree=3: 21 iterations to obtain convergence. +0.168 0.024 -0.005 -0.001 -0.064 0.178 -0.118 -0.009 0.025 -0.017 + 0.189 0.108 -0.005 -0.003 -0.072 0.200 -0.133 -0.041 0.114 -0.076 +0.024 0.269 -0.001 -0.008 -0.009 0.025 -0.017 -0.102 0.284 -0.189 + 0.108 0.407 -0.003 -0.011 -0.041 0.114 -0.076 -0.155 0.430 -0.286 +-0.005 -0.001 0.168 0.024 -0.064 -0.178 -0.118 -0.009 -0.025 -0.017 + -0.005 -0.003 0.189 0.108 -0.072 -0.200 -0.133 -0.041 -0.114 -0.076 +-0.001 -0.008 0.024 0.269 -0.009 -0.025 -0.017 -0.102 -0.284 -0.189 + -0.003 -0.011 0.108 0.407 -0.041 -0.114 -0.076 -0.155 -0.430 -0.286 + 0.168 0.024 -0.005 -0.001 -0.064 -0.009 0.178 0.025 -0.118 -0.017 + 0.189 0.108 -0.005 -0.003 -0.072 -0.041 0.200 0.114 -0.133 -0.076 + 0.024 0.269 -0.001 -0.008 -0.009 -0.102 0.025 0.284 -0.017 -0.189 + 0.108 0.407 -0.003 -0.011 -0.041 -0.155 0.114 0.430 -0.076 -0.286 + -0.005 -0.001 0.168 0.024 -0.064 -0.009 -0.178 -0.025 -0.118 -0.017 + -0.005 -0.003 0.189 0.108 -0.072 -0.041 -0.200 -0.114 -0.133 -0.076 + -0.001 -0.008 0.024 0.269 -0.009 -0.102 -0.025 -0.284 -0.017 -0.189 + -0.003 -0.011 0.108 0.407 -0.041 -0.155 -0.114 -0.430 -0.076 -0.286 +-0.064 -0.009 -0.064 -0.009 0.928 -0.069 0.130 -0.010 + -0.064 -0.009 -0.064 -0.009 0.928 0.130 -0.069 -0.010 +0.178 0.025 -0.178 -0.025 1.318 0.184 + -0.072 -0.041 -0.072 -0.041 1.045 0.598 -0.078 -0.045 +-0.118 -0.017 -0.118 -0.017 -0.069 1.024 -0.010 0.143 + -0.009 -0.102 -0.009 -0.102 0.130 1.487 -0.010 -0.111 + -0.072 -0.041 -0.072 -0.041 1.045 -0.078 0.598 -0.045 + -0.041 -0.155 -0.041 -0.155 0.598 2.247 -0.045 -0.168 + 0.200 0.114 -0.200 -0.114 1.483 0.850 + 0.178 0.025 -0.178 -0.025 1.318 0.184 + -0.133 -0.076 -0.133 -0.076 -0.078 1.152 -0.045 0.660 + 0.200 0.114 -0.200 -0.114 1.483 0.850 +-0.009 -0.102 -0.009 -0.102 0.130 -0.010 1.487 -0.111 + 0.025 0.284 -0.025 -0.284 0.184 2.111 +0.025 0.284 -0.025 -0.284 0.184 2.111 + 0.114 0.430 -0.114 -0.430 0.850 3.190 +-0.017 -0.189 -0.017 -0.189 -0.010 0.143 -0.111 1.641 + -0.118 -0.017 -0.118 -0.017 -0.069 -0.010 1.024 0.143 + -0.041 -0.155 -0.041 -0.155 0.598 -0.045 2.247 -0.168 + -0.133 -0.076 -0.133 -0.076 -0.078 -0.045 1.152 0.660 + 0.114 0.430 -0.114 -0.430 0.850 3.190 + -0.017 -0.189 -0.017 -0.189 -0.010 -0.111 0.143 1.641 + -0.076 -0.286 -0.076 -0.286 -0.045 0.660 -0.168 2.479 + -0.076 -0.286 -0.076 -0.286 -0.045 -0.168 0.660 2.479 +DEAL:cg::Starting value 3.8136634795 +DEAL:cg::Convergence step 22 value 0.0000000000 +DEAL::Degree=3: 22 iterations to obtain convergence. diff --git a/tests/mappings/mapping_q_real_to_unit_internal.cc b/tests/mappings/mapping_q_real_to_unit_internal.cc index cc593b7ed0..4b3644bf2d 100644 --- a/tests/mappings/mapping_q_real_to_unit_internal.cc +++ b/tests/mappings/mapping_q_real_to_unit_internal.cc @@ -132,6 +132,6 @@ main() initlog(); deallog << std::setprecision(10); - test<2, 2>(6, 1); + test<2, 2>(5, 1); test<3, 3>(4, 0); } diff --git a/tests/mappings/mapping_q_real_to_unit_internal.output b/tests/mappings/mapping_q_real_to_unit_internal.output index ef468b6093..c5339ebba5 100644 --- a/tests/mappings/mapping_q_real_to_unit_internal.output +++ b/tests/mappings/mapping_q_real_to_unit_internal.output @@ -5,48 +5,48 @@ DEAL:: DEAL::Testing on cell 0_1:1 with center 5.817072296e-17 0.9500000000 DEAL::Start MappingQ::do_transform_real_to_unit_cell for real point [ -0.1498310826 0.7854420410 ] DEAL::Newton iteration 0 for unit point guess 0.6577169290 0.9304965238 -DEAL:: delta=-0.01964393136 -1.075627827 +DEAL:: delta=-0.01964396697 -1.075632255 DEAL:: step_length=1.000000000 -DEAL:: ||f || =0.1091688320 -DEAL:: ||f*|| =0.002220292789 -DEAL:: ||f*||_A =0.002879917271 -DEAL::Newton iteration 1 for unit point guess 0.6773608604 2.006124351 -DEAL:: delta=-0.002639886633 0.002146340306 +DEAL:: ||f || =0.1091690351 +DEAL:: ||f*|| =0.002220303333 +DEAL:: ||f*||_A =0.002879970000 +DEAL::Newton iteration 1 for unit point guess 0.6773608960 2.006128778 +DEAL:: delta=-0.002639902825 0.002146435538 DEAL:: step_length=1.000000000 -DEAL:: ||f || =0.002220292789 -DEAL:: ||f*|| =3.111971807e-06 -DEAL:: ||f*||_A =3.056237858e-05 -DEAL::Newton iteration 2 for unit point guess 0.6800007470 2.003978011 -DEAL:: delta=7.153587774e-07 3.053779297e-05 +DEAL:: ||f || =0.002220303333 +DEAL:: ||f*|| =3.112200993e-06 +DEAL:: ||f*||_A =3.056467320e-05 +DEAL::Newton iteration 2 for unit point guess 0.6800007988 2.003982343 +DEAL:: delta=7.154242143e-07 3.054008404e-05 DEAL:: step_length=1.000000000 -DEAL:: ||f || =3.111971807e-06 -DEAL:: ||f*|| =3.788501474e-12 -DEAL:: ||f*||_A =2.740859243e-11 -DEAL::Iteration converged for p_unit = [ 0.6800000317 2.003947473 ] and iteration error 1.148138274e-11 +DEAL:: ||f || =3.112200993e-06 +DEAL:: ||f*|| =2.229657924e-12 +DEAL:: ||f*||_A =3.365828166e-12 +DEAL::Iteration converged for p_unit = [ 0.6800000834 2.003951803 ] and iteration error 3.365828166e-12 DEAL:: DEAL::Testing on cell 0_1:2 with center 0.7361215932 0.4250000000 DEAL:: DEAL::Testing on cell 0_1:3 with center 5.204748896e-17 0.8500000000 DEAL::Start MappingQ::do_transform_real_to_unit_cell for real point [ -0.1498310826 0.7854420410 ] DEAL::Newton iteration 0 for unit point guess 0.6762718619 -0.06950347624 -DEAL:: delta=-0.003286901688 -1.073511888 +DEAL:: delta=-0.003286945564 -1.073516223 DEAL:: step_length=1.000000000 -DEAL:: ||f || =0.1073965686 -DEAL:: ||f*|| =0.0003695425182 -DEAL:: ||f*||_A =0.0003919325980 -DEAL::Newton iteration 1 for unit point guess 0.6795587635 1.004008412 -DEAL:: delta=-0.0004412714742 6.008501488e-05 +DEAL:: ||f || =0.1073970152 +DEAL:: ||f*|| =0.0003695480664 +DEAL:: ||f*||_A =0.0003919397833 +DEAL::Newton iteration 1 for unit point guess 0.6795588074 1.004012747 +DEAL:: delta=-0.0004412793292 6.009041334e-05 DEAL:: step_length=1.000000000 -DEAL:: ||f || =0.0003695425182 -DEAL:: ||f*|| =8.541647246e-08 -DEAL:: ||f*||_A =8.537238341e-07 -DEAL::Newton iteration 2 for unit point guess 0.6800000350 1.003948327 -DEAL:: delta=3.347866293e-09 8.537045902e-07 +DEAL:: ||f || =0.0003695480664 +DEAL:: ||f*|| =8.542519741e-08 +DEAL:: ||f*||_A =8.538106952e-07 +DEAL::Newton iteration 2 for unit point guess 0.6800000867 1.003952657 +DEAL:: delta=3.349108959e-09 8.537914413e-07 DEAL:: step_length=1.000000000 -DEAL:: ||f || =8.541647246e-08 -DEAL:: ||f*|| =3.248706834e-16 -DEAL:: ||f*||_A =6.445890195e-16 -DEAL::Iteration converged for p_unit = [ 0.6800000317 1.003947473 ] and iteration error 6.445890195e-16 +DEAL:: ||f || =8.542519741e-08 +DEAL:: ||f*|| =3.554447979e-16 +DEAL:: ||f*||_A =1.702934975e-15 +DEAL::Iteration converged for p_unit = [ 0.6800000834 1.003951803 ] and iteration error 1.702934975e-15 DEAL:: DEAL::Testing on cell 1_1:0 with center -0.8227241336 0.4750000000 DEAL:: @@ -55,30 +55,30 @@ DEAL:: DEAL::Testing on cell 1_1:2 with center -0.7361215932 0.4250000000 DEAL::Start MappingQ::do_transform_real_to_unit_cell for real point [ -0.1498310826 0.7854420410 ] DEAL::Newton iteration 0 for unit point guess -0.2121143758 2.966937436 -DEAL:: delta=0.1426653570 1.911921755 -DEAL:: step_length=1.000000000 -DEAL:: ||f || =0.2113822431 -DEAL:: ||f*|| =0.02949335977 -DEAL:: ||f*||_A =0.09899499581 -DEAL::Newton iteration 1 for unit point guess -0.3547797328 1.055015681 -DEAL:: delta=-0.03501372831 0.04561257848 -DEAL:: step_length=1.000000000 -DEAL:: ||f || =0.02949335977 -DEAL:: ||f*|| =0.0005592232069 -DEAL:: ||f*||_A =0.005362688543 -DEAL::Newton iteration 2 for unit point guess -0.3197660045 1.009403103 -DEAL:: delta=0.0002139315453 0.005297327998 -DEAL:: step_length=1.000000000 -DEAL:: ||f || =0.0005592232069 -DEAL:: ||f*|| =1.204134891e-07 -DEAL:: ||f*||_A =2.454543637e-07 -DEAL::Newton iteration 3 for unit point guess -0.3199799360 1.004105775 -DEAL:: delta=-1.417819978e-07 2.000356573e-07 -DEAL:: step_length=1.000000000 -DEAL:: ||f || =1.204134891e-07 -DEAL:: ||f*|| =2.222006752e-14 -DEAL:: ||f*||_A =2.166173466e-13 -DEAL::Iteration converged for p_unit = [ -0.3199797942 1.004105575 ] and iteration error 2.166173466e-13 +DEAL:: delta=0.1428269454 1.910786093 +DEAL:: step_length=1.000000000 +DEAL:: ||f || =0.2113630350 +DEAL:: ||f*|| =0.02939566809 +DEAL:: ||f*||_A =0.09840128796 +DEAL::Newton iteration 1 for unit point guess -0.3549413212 1.056151343 +DEAL:: delta=-0.03499552745 0.04542821488 +DEAL:: step_length=1.000000000 +DEAL:: ||f || =0.02939566809 +DEAL:: ||f*|| =0.0005546602569 +DEAL:: ||f*||_A =0.005289702080 +DEAL::Newton iteration 2 for unit point guess -0.3199457938 1.010723128 +DEAL:: delta=0.0002224320518 0.005222131186 +DEAL:: step_length=1.000000000 +DEAL:: ||f || =0.0005546602569 +DEAL:: ||f*|| =1.230502541e-07 +DEAL:: ||f*||_A =2.585712372e-07 +DEAL::Newton iteration 3 for unit point guess -0.3201682258 1.005500997 +DEAL:: delta=-1.450147907e-07 2.137399440e-07 +DEAL:: step_length=1.000000000 +DEAL:: ||f || =1.230502541e-07 +DEAL:: ||f*|| =3.041495692e-14 +DEAL:: ||f*||_A =2.745011312e-13 +DEAL::Iteration converged for p_unit = [ -0.3201680808 1.005500783 ] and iteration error 2.745011312e-13 DEAL:: DEAL::Testing on cell 1_1:3 with center -0.7361215932 -0.4250000000 DEAL:: @@ -97,48 +97,48 @@ DEAL:: DEAL::Testing on cell 0_1:1 with center 5.817072296e-17 0.9500000000 DEAL::Start MappingQ::do_transform_real_to_unit_cell for real point [ -0.1591955252 0.8345321686 ] DEAL::Newton iteration 0 for unit point guess 0.6675742371 0.3636525565 -DEAL:: delta=-0.01095479005 -1.141260873 +DEAL:: delta=-0.01095483010 -1.141265517 DEAL:: step_length=1.000000000 -DEAL:: ||f || =0.1146602330 -DEAL:: ||f*|| =0.001310641447 -DEAL:: ||f*||_A =0.001412896728 -DEAL::Newton iteration 1 for unit point guess 0.6785290271 1.504913430 -DEAL:: delta=-0.001471128494 0.0007091597193 +DEAL:: ||f || =0.1146605902 +DEAL:: ||f*|| =0.001310649040 +DEAL:: ||f*||_A =0.001412918580 +DEAL::Newton iteration 1 for unit point guess 0.6785290672 1.504918074 +DEAL:: delta=-0.001471140194 0.0007092022461 DEAL:: step_length=1.000000000 -DEAL:: ||f || =0.001310641447 -DEAL:: ||f*|| =1.014013058e-06 -DEAL:: ||f*||_A =1.008239954e-05 -DEAL::Newton iteration 2 for unit point guess 0.6800001556 1.504204270 -DEAL:: delta=1.239681334e-07 1.007997142e-05 +DEAL:: ||f || =0.001310649040 +DEAL:: ||f*|| =1.014095085e-06 +DEAL:: ||f*||_A =1.008321659e-05 +DEAL::Newton iteration 2 for unit point guess 0.6800002074 1.504208871 +DEAL:: delta=1.239861490e-07 1.008078795e-05 DEAL:: step_length=1.000000000 -DEAL:: ||f || =1.014013058e-06 -DEAL:: ||f*|| =1.507011618e-13 -DEAL:: ||f*||_A =7.591076711e-13 -DEAL::Iteration converged for p_unit = [ 0.6800000317 1.504194190 ] and iteration error 7.591076711e-13 +DEAL:: ||f || =1.014095085e-06 +DEAL:: ||f*|| =1.386423758e-13 +DEAL:: ||f*||_A =1.559814094e-13 +DEAL::Iteration converged for p_unit = [ 0.6800000834 1.504198790 ] and iteration error 1.559814094e-13 DEAL:: DEAL::Testing on cell 0_1:2 with center 0.7361215932 0.4250000000 DEAL:: DEAL::Testing on cell 0_1:3 with center 5.204748896e-17 0.8500000000 DEAL::Start MappingQ::do_transform_real_to_unit_cell for real point [ -0.1591955252 0.8345321686 ] DEAL::Newton iteration 0 for unit point guess 0.6872888532 -0.6363474435 -DEAL:: delta=0.006426066544 -1.140789116 +DEAL:: delta=0.006426017190 -1.140793731 DEAL:: step_length=1.000000000 -DEAL:: ||f || =0.1142630680 -DEAL:: ||f*|| =0.0007679627763 -DEAL:: ||f*||_A =0.0007847271769 -DEAL::Newton iteration 1 for unit point guess 0.6808627867 0.5044416722 -DEAL:: delta=0.0008627800205 0.0002440148084 +DEAL:: ||f || =0.1142636757 +DEAL:: ||f*|| =0.0007679580847 +DEAL:: ||f*||_A =0.0007847275395 +DEAL::Newton iteration 1 for unit point guess 0.6808628360 0.5044462878 +DEAL:: delta=0.0008627776427 0.0002440296658 DEAL:: step_length=1.000000000 -DEAL:: ||f || =0.0007679627763 -DEAL:: ||f*|| =3.474553337e-07 -DEAL:: ||f*||_A =3.467706923e-06 -DEAL::Newton iteration 2 for unit point guess 0.6800000067 0.5041976574 -DEAL:: delta=-2.501310696e-08 3.467419581e-06 +DEAL:: ||f || =0.0007679580847 +DEAL:: ||f*|| =3.474771909e-07 +DEAL:: ||f*||_A =3.467922424e-06 +DEAL::Newton iteration 2 for unit point guess 0.6800000584 0.5042022581 +DEAL:: delta=-2.501107288e-08 3.467635105e-06 DEAL:: step_length=1.000000000 -DEAL:: ||f || =3.474553337e-07 -DEAL:: ||f*|| =9.047849370e-15 -DEAL:: ||f*||_A =1.100561459e-14 -DEAL::Iteration converged for p_unit = [ 0.6800000317 0.5041941900 ] and iteration error 1.100561459e-14 +DEAL:: ||f || =3.474771909e-07 +DEAL:: ||f*|| =9.112117853e-15 +DEAL:: ||f*||_A =1.026587554e-14 +DEAL::Iteration converged for p_unit = [ 0.6800000834 0.5041987905 ] and iteration error 1.026587554e-14 DEAL:: DEAL::Testing on cell 1_1:0 with center -0.8227241336 0.4750000000 DEAL:: @@ -147,30 +147,30 @@ DEAL:: DEAL::Testing on cell 1_1:2 with center -0.7361215932 0.4250000000 DEAL::Start MappingQ::do_transform_real_to_unit_cell for real point [ -0.1591955252 0.8345321686 ] DEAL::Newton iteration 0 for unit point guess -0.2566215243 2.589871026 -DEAL:: delta=0.08391429211 2.066838582 -DEAL:: step_length=1.000000000 -DEAL:: ||f || =0.2142321563 -DEAL:: ||f*|| =0.01836658888 -DEAL:: ||f*||_A =0.04233118992 -DEAL::Newton iteration 1 for unit point guess -0.3405358164 0.5230324443 -DEAL:: delta=-0.02059922789 0.01670588372 -DEAL:: step_length=1.000000000 -DEAL:: ||f || =0.01836658888 -DEAL:: ||f*|| =0.0002001773455 -DEAL:: ||f*||_A =0.001972573883 -DEAL::Newton iteration 2 for unit point guess -0.3199365885 0.5063265606 -DEAL:: delta=4.321573419e-05 0.001964378823 -DEAL:: step_length=1.000000000 -DEAL:: ||f || =0.0002001773455 -DEAL:: ||f*|| =8.935714830e-09 -DEAL:: ||f*||_A =1.324212245e-08 -DEAL::Newton iteration 3 for unit point guess -0.3199798042 0.5043621818 -DEAL:: delta=-9.994417072e-09 8.680457238e-09 -DEAL:: step_length=1.000000000 -DEAL:: ||f || =8.935714830e-09 -DEAL:: ||f*|| =1.649391282e-14 -DEAL:: ||f*||_A =1.559421775e-13 -DEAL::Iteration converged for p_unit = [ -0.3199797942 0.5043621731 ] and iteration error 1.559421775e-13 +DEAL:: delta=0.08412187149 2.065428662 +DEAL:: step_length=1.000000000 +DEAL:: ||f || =0.2141878653 +DEAL:: ||f*|| =0.01834158587 +DEAL:: ||f*||_A =0.04219690985 +DEAL::Newton iteration 1 for unit point guess -0.3407433958 0.5244423639 +DEAL:: delta=-0.02062157465 0.01665380903 +DEAL:: step_length=1.000000000 +DEAL:: ||f || =0.01834158587 +DEAL:: ||f*|| =0.0001987919725 +DEAL:: ||f*||_A =0.001952722842 +DEAL::Newton iteration 2 for unit point guess -0.3201218211 0.5077885549 +DEAL:: delta=4.627025726e-05 0.001943962843 +DEAL:: step_length=1.000000000 +DEAL:: ||f || =0.0001987919725 +DEAL:: ||f*|| =9.443372298e-09 +DEAL:: ||f*||_A =1.444801461e-08 +DEAL::Newton iteration 3 for unit point guess -0.3201680914 0.5058445920 +DEAL:: delta=-1.057703052e-08 9.835297187e-09 +DEAL:: step_length=1.000000000 +DEAL:: ||f || =9.443372298e-09 +DEAL:: ||f*|| =5.074642300e-15 +DEAL:: ||f*||_A =3.363305123e-14 +DEAL::Iteration converged for p_unit = [ -0.3201680808 0.5058445822 ] and iteration error 3.363305123e-14 DEAL:: DEAL::Testing on cell 1_1:3 with center -0.7361215932 -0.4250000000 DEAL:: @@ -189,48 +189,48 @@ DEAL:: DEAL::Testing on cell 0_1:1 with center 5.817072296e-17 0.9500000000 DEAL::Start MappingQ::do_transform_real_to_unit_cell for real point [ -0.1685599679 0.8836222961 ] DEAL::Newton iteration 0 for unit point guess 0.6774315452 -0.2031914108 -DEAL:: delta=-0.002264482121 -1.207664857 +DEAL:: delta=-0.002264526527 -1.207669732 DEAL:: step_length=1.000000000 -DEAL:: ||f || =0.1207907202 -DEAL:: ||f*|| =0.0002863941104 -DEAL:: ||f*||_A =0.0002692200273 -DEAL::Newton iteration 1 for unit point guess 0.6796960273 1.004473446 -DEAL:: delta=-0.0003040054862 3.208354056e-05 +DEAL:: ||f || =0.1207912384 +DEAL:: ||f*|| =0.0002864001918 +DEAL:: ||f*||_A =0.0002692265626 +DEAL::Newton iteration 1 for unit point guess 0.6796960717 1.004478321 +DEAL:: delta=-0.0003040128115 3.208687188e-05 DEAL:: step_length=1.000000000 -DEAL:: ||f || =0.0002863941104 -DEAL:: ||f*|| =4.559590788e-08 -DEAL:: ||f*||_A =4.558469666e-07 -DEAL::Newton iteration 2 for unit point guess 0.6800000328 1.004441363 -DEAL:: delta=1.094817903e-09 4.558424284e-07 +DEAL:: ||f || =0.0002864001918 +DEAL:: ||f*|| =4.560114854e-08 +DEAL:: ||f*||_A =4.558991550e-07 +DEAL::Newton iteration 2 for unit point guess 0.6800000845 1.004446234 +DEAL:: delta=1.095378257e-09 4.558946137e-07 DEAL:: step_length=1.000000000 -DEAL:: ||f || =4.559590788e-08 -DEAL:: ||f*|| =3.342213889e-16 -DEAL:: ||f*||_A =3.323891971e-15 -DEAL::Iteration converged for p_unit = [ 0.6800000317 1.004440907 ] and iteration error 3.323891971e-15 +DEAL:: ||f || =4.560114854e-08 +DEAL:: ||f*|| =3.330669074e-16 +DEAL:: ||f*||_A =3.272350710e-15 +DEAL::Iteration converged for p_unit = [ 0.6800000834 1.004445778 ] and iteration error 3.272350710e-15 DEAL:: DEAL::Testing on cell 0_1:2 with center 0.7361215932 0.4250000000 DEAL:: DEAL::Testing on cell 0_1:3 with center 5.204748896e-17 0.8500000000 DEAL::Start MappingQ::do_transform_real_to_unit_cell for real point [ -0.1685599679 0.8836222961 ] DEAL::Newton iteration 0 for unit point guess 0.6983058446 -1.203191411 -DEAL:: delta=0.01613817896 -1.209285116 +DEAL:: delta=0.01613812237 -1.209290123 DEAL:: step_length=1.000000000 -DEAL:: ||f || =0.1221516894 -DEAL:: ||f*|| =0.002048430510 -DEAL:: ||f*||_A =0.002304452959 -DEAL::Newton iteration 1 for unit point guess 0.6821676656 0.006093705159 -DEAL:: delta=0.002168030427 0.001629622718 +DEAL:: ||f || =0.1221524499 +DEAL:: ||f*|| =0.002048427935 +DEAL:: ||f*||_A =0.002304514146 +DEAL::Newton iteration 1 for unit point guess 0.6821677222 0.006098711986 +DEAL:: delta=0.002168035294 0.001629756762 DEAL:: step_length=1.000000000 -DEAL:: ||f || =0.002048430510 -DEAL:: ||f*|| =2.347437841e-06 -DEAL:: ||f*||_A =2.318708838e-05 -DEAL::Newton iteration 2 for unit point guess 0.6799996352 0.004464082441 -DEAL:: delta=-3.964683108e-07 2.317537274e-05 +DEAL:: ||f || =0.002048427935 +DEAL:: ||f*|| =2.347613751e-06 +DEAL:: ||f*||_A =2.318879655e-05 +DEAL::Newton iteration 2 for unit point guess 0.6799996869 0.004468955224 +DEAL:: delta=-3.964790128e-07 2.317708016e-05 DEAL:: step_length=1.000000000 -DEAL:: ||f || =2.347437841e-06 -DEAL:: ||f*|| =9.653109564e-13 -DEAL:: ||f*||_A =1.283078594e-12 -DEAL::Iteration converged for p_unit = [ 0.6800000317 0.004440907068 ] and iteration error 1.283078594e-12 +DEAL:: ||f || =2.347613751e-06 +DEAL:: ||f*|| =9.653535797e-13 +DEAL:: ||f*||_A =1.280398958e-12 +DEAL::Iteration converged for p_unit = [ 0.6800000834 0.004445778144 ] and iteration error 1.280398958e-12 DEAL:: DEAL::Testing on cell 1_1:0 with center -0.8227241336 0.4750000000 DEAL:: @@ -239,30 +239,30 @@ DEAL:: DEAL::Testing on cell 1_1:2 with center -0.7361215932 0.4250000000 DEAL::Start MappingQ::do_transform_real_to_unit_cell for real point [ -0.1685599679 0.8836222961 ] DEAL::Newton iteration 0 for unit point guess -0.3011286728 2.212804616 -DEAL:: delta=0.02498309303 2.206435877 -DEAL:: step_length=1.000000000 -DEAL:: ||f || =0.2213639846 -DEAL:: ||f*|| =0.005779652792 -DEAL:: ||f*||_A =0.008680805434 -DEAL::Newton iteration 1 for unit point guess -0.3261117658 0.006368738978 -DEAL:: delta=-0.006133082500 0.001564846074 -DEAL:: step_length=1.000000000 -DEAL:: ||f || =0.005779652792 -DEAL:: ||f*|| =1.854230964e-05 -DEAL:: ||f*||_A =0.0001851872833 -DEAL::Newton iteration 2 for unit point guess -0.3199786833 0.004803892903 -DEAL:: delta=1.110956659e-06 0.0001851213856 -DEAL:: step_length=1.000000000 -DEAL:: ||f || =1.854230964e-05 -DEAL:: ||f*|| =2.154698296e-11 -DEAL:: ||f*||_A =2.365437919e-11 -DEAL::Newton iteration 3 for unit point guess -0.3199797943 0.004618771518 -DEAL:: delta=-2.285969181e-11 6.077798003e-12 -DEAL:: step_length=1.000000000 -DEAL:: ||f || =2.154698296e-11 -DEAL:: ||f*|| =2.839959666e-14 -DEAL:: ||f*||_A =1.313874113e-13 -DEAL::Iteration converged for p_unit = [ -0.3199797942 0.004618771512 ] and iteration error 1.313874113e-13 +DEAL:: delta=0.02522519775 2.204850894 +DEAL:: step_length=1.000000000 +DEAL:: ||f || =0.2212724323 +DEAL:: ||f*|| =0.005818395579 +DEAL:: ||f*||_A =0.008752605987 +DEAL::Newton iteration 1 for unit point guess -0.3263538705 0.007953721427 +DEAL:: delta=-0.006187188740 0.001579180612 +DEAL:: step_length=1.000000000 +DEAL:: ||f || =0.005818395579 +DEAL:: ||f*|| =1.866811823e-05 +DEAL:: ||f*||_A =0.0001862443601 +DEAL::Newton iteration 2 for unit point guess -0.3201666818 0.006374540815 +DEAL:: delta=1.399061982e-06 0.0001861596436 +DEAL:: step_length=1.000000000 +DEAL:: ||f || =1.866811823e-05 +DEAL:: ||f*|| =2.723946617e-11 +DEAL:: ||f*||_A =3.048835514e-11 +DEAL::Newton iteration 3 for unit point guess -0.3201680808 0.006188381171 +DEAL:: delta=-2.895106466e-11 9.556857911e-12 +DEAL:: step_length=1.000000000 +DEAL:: ||f || =2.723946617e-11 +DEAL:: ||f*|| =6.807984993e-15 +DEAL:: ||f*||_A =6.201992820e-14 +DEAL::Iteration converged for p_unit = [ -0.3201680808 0.006188381162 ] and iteration error 6.201992820e-14 DEAL:: DEAL::Testing on cell 1_1:3 with center -0.7361215932 -0.4250000000 DEAL:: @@ -281,112 +281,112 @@ DEAL:: DEAL::Testing on cell 0_1:1 with center 5.817072296e-17 0.9500000000 DEAL::Start MappingQ::do_transform_real_to_unit_cell for real point [ -0.1779244106 0.9327124237 ] DEAL::Newton iteration 0 for unit point guess 0.6872888532 -0.7700353780 -DEAL:: delta=0.006426066546 -1.274999600 +DEAL:: delta=0.006426017190 -1.275004758 DEAL:: step_length=1.000000000 -DEAL:: ||f || =0.1277057819 -DEAL:: ||f*|| =0.0008583113363 -DEAL:: ||f*||_A =0.0007905789081 -DEAL::Newton iteration 1 for unit point guess 0.6808627867 0.5049642219 -DEAL:: delta=0.0008627800186 0.0002727224076 +DEAL:: ||f || =0.1277064611 +DEAL:: ||f*|| =0.0008583060946 +DEAL:: ||f*||_A =0.0007905799797 +DEAL::Newton iteration 1 for unit point guess 0.6808628360 0.5049693805 +DEAL:: delta=0.0008627776426 0.0002727390419 DEAL:: step_length=1.000000000 -DEAL:: ||f || =0.0008583113363 -DEAL:: ||f*|| =3.883324299e-07 -DEAL:: ||f*||_A =3.875652877e-06 -DEAL::Newton iteration 2 for unit point guess 0.6800000067 0.5046914995 -DEAL:: delta=-2.501310465e-08 3.875351278e-06 +DEAL:: ||f || =0.0008583060946 +DEAL:: ||f*|| =3.883568601e-07 +DEAL:: ||f*||_A =3.875893750e-06 +DEAL::Newton iteration 2 for unit point guess 0.6800000584 0.5046966414 +DEAL:: delta=-2.501107322e-08 3.875592173e-06 DEAL:: step_length=1.000000000 -DEAL:: ||f || =3.883324299e-07 -DEAL:: ||f*|| =1.021710599e-14 -DEAL:: ||f*||_A =1.031033643e-14 -DEAL::Iteration converged for p_unit = [ 0.6800000317 0.5046876241 ] and iteration error 1.031033643e-14 +DEAL:: ||f || =3.883568601e-07 +DEAL:: ||f*|| =1.015793398e-14 +DEAL:: ||f*||_A =1.042774065e-14 +DEAL::Iteration converged for p_unit = [ 0.6800000834 0.5046927658 ] and iteration error 1.042774065e-14 DEAL:: DEAL::Testing on cell 0_1:2 with center 0.7361215932 0.4250000000 DEAL:: DEAL::Testing on cell 0_1:3 with center 5.204748896e-17 0.8500000000 DEAL::Start MappingQ::do_transform_real_to_unit_cell for real point [ -0.1779244106 0.9327124237 ] DEAL::Newton iteration 0 for unit point guess 0.7093228359 -1.770035378 -DEAL:: delta=0.02584814311 -1.279199239 -DEAL:: step_length=1.000000000 -DEAL:: ||f || =0.1311997489 -DEAL:: ||f*|| =0.003483086008 -DEAL:: ||f*||_A =0.004640017051 -DEAL::Newton iteration 1 for unit point guess 0.6834746928 -0.4908361388 -DEAL:: delta=0.003476292244 0.004413379108 -DEAL:: step_length=1.000000000 -DEAL:: ||f || =0.003483086008 -DEAL:: ||f*|| =6.491662448e-06 -DEAL:: ||f*||_A =6.293717918e-05 -DEAL::Newton iteration 2 for unit point guess 0.6799984006 -0.4952495179 -DEAL:: delta=-1.631085748e-06 6.285798877e-05 -DEAL:: step_length=1.000000000 -DEAL:: ||f || =6.491662448e-06 -DEAL:: ||f*|| =1.082952623e-11 -DEAL:: ||f*||_A =1.796084017e-11 -DEAL::Newton iteration 3 for unit point guess 0.6800000317 -0.4953123759 -DEAL:: delta=1.079499123e-11 1.435455296e-11 -DEAL:: step_length=1.000000000 -DEAL:: ||f || =1.082952623e-11 -DEAL:: ||f*|| =1.161181964e-14 -DEAL:: ||f*||_A =1.127395786e-13 -DEAL::Iteration converged for p_unit = [ 0.6800000317 -0.4953123759 ] and iteration error 1.127395786e-13 +DEAL:: delta=0.02584807626 -1.279204813 +DEAL:: step_length=1.000000000 +DEAL:: ||f || =0.1312006456 +DEAL:: ||f*|| =0.003483090498 +DEAL:: ||f*||_A =0.004640276356 +DEAL::Newton iteration 1 for unit point guess 0.6834747597 -0.4908305655 +DEAL:: delta=0.003476307473 0.004413805682 +DEAL:: step_length=1.000000000 +DEAL:: ||f || =0.003483090498 +DEAL:: ||f*|| =6.492193753e-06 +DEAL:: ||f*||_A =6.294218096e-05 +DEAL::Newton iteration 2 for unit point guess 0.6799984522 -0.4952443712 +DEAL:: delta=-1.631189853e-06 6.286298150e-05 +DEAL:: step_length=1.000000000 +DEAL:: ||f || =6.492193753e-06 +DEAL:: ||f*|| =1.082172879e-11 +DEAL:: ||f*||_A =1.730170494e-11 +DEAL::Newton iteration 3 for unit point guess 0.6800000834 -0.4953072342 +DEAL:: delta=1.079805089e-11 1.351830751e-11 +DEAL:: step_length=1.000000000 +DEAL:: ||f || =1.082172879e-11 +DEAL:: ||f*|| =5.553036170e-14 +DEAL:: ||f*||_A =5.537256463e-13 +DEAL::Iteration converged for p_unit = [ 0.6800000834 -0.4953072342 ] and iteration error 5.537256463e-13 DEAL:: DEAL::Testing on cell 1_1:0 with center -0.8227241336 0.4750000000 DEAL::Start MappingQ::do_transform_real_to_unit_cell for real point [ -0.1779244106 0.9327124237 ] DEAL::Newton iteration 0 for unit point guess -0.2566215243 2.835738205 -DEAL:: delta=0.08391430126 2.309996091 -DEAL:: step_length=1.000000000 -DEAL:: ||f || =0.2394359386 -DEAL:: ||f*|| =0.02052737282 -DEAL:: ||f*||_A =0.04536287909 -DEAL::Newton iteration 1 for unit point guess -0.3405358255 0.5257421149 -DEAL:: delta=-0.02059923699 0.01867125106 -DEAL:: step_length=1.000000000 -DEAL:: ||f || =0.02052737282 -DEAL:: ||f*|| =0.0002237278046 -DEAL:: ||f*||_A =0.002204559523 -DEAL::Newton iteration 2 for unit point guess -0.3199365885 0.5070708638 -DEAL:: delta=4.321568918e-05 0.002195484167 -DEAL:: step_length=1.000000000 -DEAL:: ||f || =0.0002237278046 -DEAL:: ||f*|| =9.986961377e-09 -DEAL:: ||f*||_A =1.393358301e-08 -DEAL::Newton iteration 3 for unit point guess -0.3199798042 0.5048753796 -DEAL:: delta=-9.994402177e-09 9.701761994e-09 -DEAL:: step_length=1.000000000 -DEAL:: ||f || =9.986961377e-09 -DEAL:: ||f*|| =5.613217784e-15 -DEAL:: ||f*||_A =5.299531741e-14 -DEAL::Iteration converged for p_unit = [ -0.3199797942 0.5048753699 ] and iteration error 5.299531741e-14 +DEAL:: delta=0.08412187102 2.308420268 +DEAL:: step_length=1.000000000 +DEAL:: ||f || =0.2393864378 +DEAL:: ||f*|| =0.02049941905 +DEAL:: ||f*||_A =0.04520655781 +DEAL::Newton iteration 1 for unit point guess -0.3407433953 0.5273179379 +DEAL:: delta=-0.02062157418 0.01861308253 +DEAL:: step_length=1.000000000 +DEAL:: ||f || =0.02049941905 +DEAL:: ||f*|| =0.0002221792543 +DEAL:: ||f*||_A =0.002182355912 +DEAL::Newton iteration 2 for unit point guess -0.3201218211 0.5087048554 +DEAL:: delta=4.627026001e-05 0.002172664255 +DEAL:: step_length=1.000000000 +DEAL:: ||f || =0.0002221792543 +DEAL:: ||f*|| =1.055434765e-08 +DEAL:: ||f*||_A =1.525990234e-08 +DEAL::Newton iteration 3 for unit point guess -0.3201680914 0.5065321911 +DEAL:: delta=-1.057702170e-08 1.099230188e-08 +DEAL:: step_length=1.000000000 +DEAL:: ||f || =1.055434765e-08 +DEAL:: ||f*|| =7.642869567e-15 +DEAL:: ||f*||_A =2.520895018e-14 +DEAL::Iteration converged for p_unit = [ -0.3201680808 0.5065321801 ] and iteration error 2.520895018e-14 DEAL:: DEAL::Testing on cell 1_1:1 with center -0.8227241336 -0.4750000000 DEAL:: DEAL::Testing on cell 1_1:2 with center -0.7361215932 0.4250000000 DEAL::Start MappingQ::do_transform_real_to_unit_cell for real point [ -0.1779244106 0.9327124237 ] DEAL::Newton iteration 0 for unit point guess -0.3456358213 1.835738205 -DEAL:: delta=-0.03399801320 2.327443055 -DEAL:: step_length=1.000000000 -DEAL:: ||f || =0.2341373451 -DEAL:: ||f*|| =0.008302069707 -DEAL:: ||f*||_A =0.01256092625 -DEAL::Newton iteration 1 for unit point guess -0.3116378081 -0.4917048500 -DEAL:: delta=0.008344955591 0.003058087986 -DEAL:: step_length=1.000000000 -DEAL:: ||f || =0.008302069707 -DEAL:: ||f*|| =3.628962386e-05 -DEAL:: ||f*||_A =0.0003619456236 -DEAL::Newton iteration 2 for unit point guess -0.3199827637 -0.4947629380 -DEAL:: delta=-2.969542047e-06 0.0003616921090 -DEAL:: step_length=1.000000000 -DEAL:: ||f || =3.628962386e-05 -DEAL:: ||f*|| =1.129550220e-10 -DEAL:: ||f*||_A =1.145932932e-10 -DEAL::Newton iteration 3 for unit point guess -0.3199797941 -0.4951246301 -DEAL:: delta=1.135631070e-10 1.529558763e-11 -DEAL:: step_length=1.000000000 -DEAL:: ||f || =1.129550220e-10 -DEAL:: ||f*|| =5.774045463e-12 -DEAL:: ||f*||_A =5.059472616e-11 -DEAL::Iteration converged for p_unit = [ -0.3199797942 -0.4951246301 ] and iteration error 5.059472616e-11 +DEAL:: delta=-0.03374928690 2.325878018 +DEAL:: step_length=1.000000000 +DEAL:: ||f || =0.2339649831 +DEAL:: ||f*|| =0.008226460055 +DEAL:: ||f*||_A =0.01241782297 +DEAL::Newton iteration 1 for unit point guess -0.3118865344 -0.4901398129 +DEAL:: delta=0.008283966047 0.002975593670 +DEAL:: step_length=1.000000000 +DEAL:: ||f || =0.008226460055 +DEAL:: ||f*|| =3.532603083e-05 +DEAL:: ||f*||_A =0.0003526124521 +DEAL::Newton iteration 2 for unit point guess -0.3201705004 -0.4931154066 +DEAL:: delta=-2.419686321e-06 0.0003524132495 +DEAL:: step_length=1.000000000 +DEAL:: ||f || =3.532603083e-05 +DEAL:: ||f*|| =8.855843482e-11 +DEAL:: ||f*||_A =9.557271248e-11 +DEAL::Newton iteration 3 for unit point guess -0.3201680807 -0.4934678198 +DEAL:: delta=8.914594156e-11 3.444419961e-11 +DEAL:: step_length=1.000000000 +DEAL:: ||f || =8.855843482e-11 +DEAL:: ||f*|| =4.938890368e-13 +DEAL:: ||f*||_A =4.184448513e-12 +DEAL::Iteration converged for p_unit = [ -0.3201680808 -0.4934678199 ] and iteration error 4.184448513e-12 DEAL:: DEAL::Testing on cell 1_1:3 with center -0.7361215932 -0.4250000000 DEAL:: @@ -405,24 +405,24 @@ DEAL:: DEAL::Testing on cell 0_1:1 with center 5.817072296e-17 0.9500000000 DEAL::Start MappingQ::do_transform_real_to_unit_cell for real point [ -0.1872888532 0.9818025513 ] DEAL::Newton iteration 0 for unit point guess 0.6971461613 -1.336879345 -DEAL:: delta=0.01511593009 -1.343424826 +DEAL:: delta=0.01511587437 -1.343430368 DEAL:: step_length=1.000000000 -DEAL:: ||f || =0.1355357751 -DEAL:: ||f*|| =0.002130899755 -DEAL:: ||f*||_A =0.002185874357 -DEAL::Newton iteration 1 for unit point guess 0.6820302312 0.006545480669 -DEAL:: delta=0.002030525295 0.001588550858 +DEAL:: ||f || =0.1355366079 +DEAL:: ||f*|| =0.002130896460 +DEAL:: ||f*||_A =0.002185933713 +DEAL::Newton iteration 1 for unit point guess 0.6820302869 0.006551022401 +DEAL:: delta=0.002030529284 0.001588678636 DEAL:: step_length=1.000000000 -DEAL:: ||f || =0.002130899755 -DEAL:: ||f*|| =2.284452308e-06 -DEAL:: ||f*||_A =2.259810751e-05 -DEAL::Newton iteration 2 for unit point guess 0.6799997059 0.004956929811 -DEAL:: delta=-3.257664471e-07 2.258862507e-05 +DEAL:: ||f || =0.002130896460 +DEAL:: ||f*|| =2.284621676e-06 +DEAL:: ||f*||_A =2.259975608e-05 +DEAL::Newton iteration 2 for unit point guess 0.6799997576 0.004962343766 +DEAL:: delta=-3.257733652e-07 2.259027305e-05 DEAL:: step_length=1.000000000 -DEAL:: ||f || =2.284452308e-06 -DEAL:: ||f*|| =7.727988801e-13 -DEAL:: ||f*||_A =9.367047854e-13 -DEAL::Iteration converged for p_unit = [ 0.6800000317 0.004934341186 ] and iteration error 9.367047854e-13 +DEAL:: ||f || =2.284621676e-06 +DEAL:: ||f*|| =7.728256778e-13 +DEAL:: ||f*||_A =9.367551114e-13 +DEAL::Iteration converged for p_unit = [ 0.6800000834 0.004939753493 ] and iteration error 9.367551114e-13 DEAL:: DEAL::Testing on cell 0_1:2 with center 0.7361215932 0.4250000000 DEAL:: @@ -431,66 +431,66 @@ DEAL:: DEAL::Testing on cell 1_1:0 with center -0.8227241336 0.4750000000 DEAL::Start MappingQ::do_transform_real_to_unit_cell for real point [ -0.1872888532 0.9818025513 ] DEAL::Newton iteration 0 for unit point guess -0.2964437098 2.458671795 -DEAL:: delta=0.03119099915 2.450508799 -DEAL:: step_length=1.000000000 -DEAL:: ||f || =0.2462942128 -DEAL:: ||f*|| =0.008018379627 -DEAL:: ||f*||_A =0.01144192602 -DEAL::Newton iteration 1 for unit point guess -0.3276347089 0.008162996471 -DEAL:: delta=-0.007657091976 0.002710484824 -DEAL:: step_length=1.000000000 -DEAL:: ||f || =0.008018379627 -DEAL:: ||f*|| =3.213641709e-05 -DEAL:: ||f*||_A =0.0003207212085 -DEAL::Newton iteration 2 for unit point guess -0.3199776170 0.005452511648 -DEAL:: delta=2.177360645e-06 0.0003205432756 -DEAL:: step_length=1.000000000 -DEAL:: ||f || =3.213641709e-05 -DEAL:: ||f*|| =7.313349431e-11 -DEAL:: ||f*||_A =7.435299478e-11 -DEAL::Newton iteration 3 for unit point guess -0.3199797943 0.005131968372 -DEAL:: delta=-6.981530501e-11 2.556939660e-11 -DEAL:: step_length=1.000000000 -DEAL:: ||f || =7.313349431e-11 -DEAL:: ||f*|| =1.453374808e-14 -DEAL:: ||f*||_A =8.687247268e-14 -DEAL::Iteration converged for p_unit = [ -0.3199797942 0.005131968346 ] and iteration error 8.687247268e-14 +DEAL:: delta=0.03143044110 2.448749745 +DEAL:: step_length=1.000000000 +DEAL:: ||f || =0.2461989783 +DEAL:: ||f*|| =0.008055182155 +DEAL:: ||f*||_A =0.01150728574 +DEAL::Newton iteration 1 for unit point guess -0.3278741509 0.009922050051 +DEAL:: delta=-0.007708692379 0.002725081556 +DEAL:: step_length=1.000000000 +DEAL:: ||f || =0.008055182155 +DEAL:: ||f*|| =3.222628150e-05 +DEAL:: ||f*||_A =0.0003212064122 +DEAL::Newton iteration 2 for unit point guess -0.3201654585 0.007196968495 +DEAL:: delta=2.622398342e-06 0.0003209893894 +DEAL:: step_length=1.000000000 +DEAL:: ||f || =3.222628150e-05 +DEAL:: ||f*|| =8.803294779e-11 +DEAL:: ||f*||_A =9.197224229e-11 +DEAL::Newton iteration 3 for unit point guess -0.3201680809 0.006875979106 +DEAL:: delta=-8.418632350e-11 3.702602092e-11 +DEAL:: step_length=1.000000000 +DEAL:: ||f || =8.803294779e-11 +DEAL:: ||f*|| =2.715306840e-14 +DEAL:: ||f*||_A =2.083904112e-13 +DEAL::Iteration converged for p_unit = [ -0.3201680808 0.006875979069 ] and iteration error 2.083904112e-13 DEAL:: DEAL::Testing on cell 1_1:1 with center -0.8227241336 -0.4750000000 DEAL:: DEAL::Testing on cell 1_1:2 with center -0.7361215932 0.4250000000 DEAL::Start MappingQ::do_transform_real_to_unit_cell for real point [ -0.1872888532 0.9818025513 ] DEAL::Newton iteration 0 for unit point guess -0.3901429698 1.458671795 -DEAL:: delta=-0.09289797061 2.426643373 -DEAL:: step_length=1.000000000 -DEAL:: ||f || =0.2534993347 -DEAL:: ||f*|| =0.02392012965 -DEAL:: ||f*||_A =0.05560061173 -DEAL::Newton iteration 1 for unit point guess -0.2972449991 -0.9679715781 -DEAL:: delta=0.02279447829 0.02406831958 -DEAL:: step_length=1.000000000 -DEAL:: ||f || =0.02392012965 -DEAL:: ||f*|| =0.0002896231489 -DEAL:: ||f*||_A =0.002842698528 -DEAL::Newton iteration 2 for unit point guess -0.3200394774 -0.9920398977 -DEAL:: delta=-5.970030787e-05 0.002828115584 -DEAL:: step_length=1.000000000 -DEAL:: ||f || =0.0002896231489 -DEAL:: ||f*|| =1.776880373e-08 -DEAL:: ||f*||_A =2.554384058e-08 -DEAL::Newton iteration 3 for unit point guess -0.3199797771 -0.9948680133 -DEAL:: delta=1.687344142e-08 1.916233232e-08 -DEAL:: step_length=1.000000000 -DEAL:: ||f || =1.776880373e-08 -DEAL:: ||f*|| =7.882554997e-11 -DEAL:: ||f*||_A =7.532676922e-11 -DEAL::Newton iteration 4 for unit point guess -0.3199797940 -0.9948680324 -DEAL:: delta=7.529429264e-11 -2.211689996e-12 -DEAL:: step_length=1.000000000 -DEAL:: ||f || =7.882554997e-11 -DEAL:: ||f*|| =7.505789202e-11 -DEAL:: ||f*||_A =7.301551866e-11 -DEAL::Iteration converged for p_unit = [ -0.3199797941 -0.9948680324 ] and iteration error 7.301551866e-11 +DEAL:: delta=-0.09269387138 2.425411282 +DEAL:: step_length=1.000000000 +DEAL:: ||f || =0.2531997727 +DEAL:: ||f*|| =0.02385946855 +DEAL:: ||f*||_A =0.05491848413 +DEAL::Newton iteration 1 for unit point guess -0.2974490984 -0.9667394864 +DEAL:: delta=0.02277430253 0.02359126430 +DEAL:: step_length=1.000000000 +DEAL:: ||f || =0.02385946855 +DEAL:: ||f*|| =0.0002852047478 +DEAL:: ||f*||_A =0.002806529458 +DEAL::Newton iteration 2 for unit point guess -0.3202234009 -0.9903307507 +DEAL:: delta=-5.533558868e-05 0.002793253651 +DEAL:: step_length=1.000000000 +DEAL:: ||f || =0.0002852047478 +DEAL:: ||f*|| =1.626367011e-08 +DEAL:: ||f*||_A =2.262931483e-08 +DEAL::Newton iteration 3 for unit point guess -0.3201680653 -0.9931240043 +DEAL:: delta=1.548294947e-08 1.649020820e-08 +DEAL:: step_length=1.000000000 +DEAL:: ||f || =1.626367011e-08 +DEAL:: ||f*|| =4.605888820e-12 +DEAL:: ||f*||_A =4.413244539e-11 +DEAL::Newton iteration 4 for unit point guess -0.3201680808 -0.9931240208 +DEAL:: delta=-1.271525526e-12 4.411412405e-11 +DEAL:: step_length=1.000000000 +DEAL:: ||f || =4.605888820e-12 +DEAL:: ||f*|| =1.127381624e-11 +DEAL:: ||f*||_A =2.128805621e-11 +DEAL::Iteration converged for p_unit = [ -0.3201680808 -0.9931240208 ] and iteration error 2.128805621e-11 DEAL:: DEAL::Testing on cell 1_1:3 with center -0.7361215932 -0.4250000000 DEAL:: @@ -513,23 +513,23 @@ DEAL:: DEAL::Testing on cell 3_0: with center -0.9000000000 -5.358086410e-17 0.000000000 DEAL::Start MappingQ::do_transform_real_to_unit_cell for real point [ -0.1498310826 0.7854420410 0.02512860726 ] DEAL::Newton iteration 0 for unit point guess 3.702424762 1.255791956 0.5241800136 -DEAL:: delta=2.856388591 -0.7329178826 -0.07384132321 +DEAL:: delta=2.856388591 -0.7329178825 -0.07384132319 DEAL:: step_length=1.000000000 DEAL:: ||f || =0.5585835069 -DEAL:: ||f*|| =0.9496238328 -DEAL:: ||f*||_A =4.671562097 +DEAL:: ||f*|| =0.9496238324 +DEAL:: ||f*||_A =4.671562096 DEAL:: step_length=0.5000000000 -DEAL:: ||f*|| =0.3989025574 +DEAL:: ||f*|| =0.3989025573 DEAL:: ||f*||_A =2.107213631 DEAL::Newton iteration 1 for unit point guess 2.274230467 1.622250898 0.5611006752 DEAL::Newton iteration 1 for unit point guess 1.000000000 1.000000000 0.5611006752 -DEAL:: delta=-0.6775152184 -0.3855878006 -0.001349240327 +DEAL:: delta=-0.6775152184 -0.3855878006 -0.001349240331 DEAL:: step_length=1.000000000 DEAL:: ||f || =0.4709858772 DEAL:: ||f*|| =0.2020861084 DEAL:: ||f*||_A =0.5469157809 DEAL::Newton iteration 2 for unit point guess 1.677515218 1.385587801 0.5624499155 -DEAL:: delta=1.266079264 -0.2156126809 -0.008282391348 +DEAL:: delta=1.266079264 -0.2156126809 -0.008282391353 DEAL:: step_length=1.000000000 DEAL:: ||f || =0.2020861084 DEAL:: ||f*|| =0.1049223850 @@ -541,30 +541,30 @@ DEAL:: DEAL::Testing on cell 5_0: with center -5.358086410e-17 0.9000000000 0.000000000 DEAL::Start MappingQ::do_transform_real_to_unit_cell for real point [ -0.1498310826 0.7854420410 0.02512860726 ] DEAL::Newton iteration 0 for unit point guess -1.802127607 0.3558249736 0.5241800136 -DEAL:: delta=-2.805512532 -0.01580652674 0.002582563452 +DEAL:: delta=-2.805512532 -0.01580652674 0.002582563451 DEAL:: step_length=1.000000000 DEAL:: ||f || =0.5620799794 DEAL:: ||f*|| =0.01436684397 -DEAL:: ||f*||_A =0.006730022603 +DEAL:: ||f*||_A =0.006730022601 DEAL::Newton iteration 1 for unit point guess 1.003384925 0.3716315003 0.5215974502 -DEAL:: delta=0.003147124864 -0.01106989251 0.001788042630 +DEAL:: delta=0.003147124852 -0.01106989251 0.001788042630 DEAL:: step_length=1.000000000 DEAL:: ||f || =0.01436684397 DEAL:: ||f*|| =0.0001299736755 DEAL:: ||f*||_A =0.0006449800586 DEAL::Newton iteration 2 for unit point guess 1.000237800 0.3827013928 0.5198094075 -DEAL:: delta=0.0006433441903 1.326333807e-05 -5.908202151e-06 +DEAL:: delta=0.0006433441903 1.326333804e-05 -5.908202146e-06 DEAL:: step_length=1.000000000 DEAL:: ||f || =0.0001299736755 -DEAL:: ||f*|| =2.979104214e-09 -DEAL:: ||f*||_A =2.561312331e-09 +DEAL:: ||f*|| =2.979104135e-09 +DEAL:: ||f*||_A =2.561312308e-09 DEAL::Newton iteration 3 for unit point guess 0.9995944559 0.3826881295 0.5198153157 -DEAL:: delta=1.078281554e-09 -2.127435542e-09 9.323111313e-10 +DEAL:: delta=1.078281634e-09 -2.127435478e-09 9.323111204e-10 DEAL:: step_length=1.000000000 -DEAL:: ||f || =2.979104214e-09 +DEAL:: ||f || =2.979104135e-09 DEAL:: ||f*|| =1.394700414e-16 -DEAL:: ||f*||_A =6.230726486e-16 -DEAL::Iteration converged for p_unit = [ 0.9995944549 0.3826881316 0.5198153148 ] and iteration error 6.230726486e-16 +DEAL:: ||f*||_A =6.273418574e-16 +DEAL::Iteration converged for p_unit = [ 0.9995944549 0.3826881316 0.5198153148 ] and iteration error 6.273418574e-16 DEAL:: DEAL:: DEAL::Testing 3D with point -0.1591955252 0.8345321686 0.02669914522 @@ -577,23 +577,23 @@ DEAL:: DEAL::Testing on cell 3_0: with center -0.9000000000 -5.358086410e-17 0.000000000 DEAL::Start MappingQ::do_transform_real_to_unit_cell for real point [ -0.1591955252 0.8345321686 0.02669914522 ] DEAL::Newton iteration 0 for unit point guess 3.621326310 1.303028954 0.5256912645 -DEAL:: delta=3.194052890 -0.6600674790 -0.07966380170 +DEAL:: delta=3.194052890 -0.6600674791 -0.07966380169 DEAL:: step_length=1.000000000 DEAL:: ||f || =0.5920447676 -DEAL:: ||f*|| =0.9165285292 -DEAL:: ||f*||_A =4.978904026 +DEAL:: ||f*|| =0.9165285296 +DEAL:: ||f*||_A =4.978904028 DEAL:: step_length=0.5000000000 DEAL:: ||f*|| =0.4201155126 -DEAL:: ||f*||_A =2.306653962 +DEAL:: ||f*||_A =2.306653963 DEAL::Newton iteration 1 for unit point guess 2.024299865 1.633062693 0.5655231653 DEAL::Newton iteration 1 for unit point guess 1.000000000 1.000000000 0.5655231653 -DEAL:: delta=-0.4706798901 -0.4099576263 0.0004091119732 +DEAL:: delta=-0.4706798901 -0.4099576263 0.0004091119710 DEAL:: step_length=1.000000000 DEAL:: ||f || =0.4882994847 DEAL:: ||f*|| =0.2160200439 DEAL:: ||f*||_A =0.6434558405 DEAL::Newton iteration 2 for unit point guess 1.470679890 1.409957626 0.5651140533 -DEAL:: delta=1.453515393 -0.2064922549 -0.007935435240 +DEAL:: delta=1.453515393 -0.2064922549 -0.007935435243 DEAL:: step_length=1.000000000 DEAL:: ||f || =0.2160200439 DEAL:: ||f*|| =0.1139084658 @@ -609,26 +609,26 @@ DEAL:: delta=-2.984004804 -0.02111069061 0.003484766185 DEAL:: step_length=1.000000000 DEAL:: ||f || =0.5987206642 DEAL:: ||f*|| =0.02039700604 -DEAL:: ||f*||_A =0.009167287651 +DEAL:: ||f*||_A =0.009167287649 DEAL::Newton iteration 1 for unit point guess 0.7567442217 0.3679247250 0.5222064983 -DEAL:: delta=0.005956738230 -0.01479312618 0.002402897797 +DEAL:: delta=0.005956738224 -0.01479312618 0.002402897797 DEAL:: step_length=1.000000000 DEAL:: ||f || =0.02039700604 DEAL:: ||f*|| =0.0002474545613 DEAL:: ||f*||_A =0.001223428251 DEAL::Newton iteration 2 for unit point guess 0.7507874835 0.3827178512 0.5198036005 -DEAL:: delta=0.001218369679 2.972808970e-05 -1.171759931e-05 +DEAL:: delta=0.001218369679 2.972808967e-05 -1.171759931e-05 DEAL:: step_length=1.000000000 DEAL:: ||f || =0.0002474545613 -DEAL:: ||f*|| =1.243143899e-08 -DEAL:: ||f*||_A =1.066824255e-08 +DEAL:: ||f*|| =1.243143908e-08 +DEAL:: ||f*||_A =1.066824344e-08 DEAL::Newton iteration 3 for unit point guess 0.7495691138 0.3826881231 0.5198153181 -DEAL:: delta=5.551613750e-09 -8.494136978e-09 3.280125929e-09 +DEAL:: delta=5.551615388e-09 -8.494137023e-09 3.280125926e-09 DEAL:: step_length=1.000000000 -DEAL:: ||f || =1.243143899e-08 -DEAL:: ||f*|| =2.529605155e-16 -DEAL:: ||f*||_A =1.203458471e-15 -DEAL::Iteration converged for p_unit = [ 0.7495691083 0.3826881316 0.5198153148 ] and iteration error 1.203458471e-15 +DEAL:: ||f || =1.243143908e-08 +DEAL:: ||f*|| =1.287440662e-16 +DEAL:: ||f*||_A =5.128642543e-16 +DEAL::Iteration converged for p_unit = [ 0.7495691083 0.3826881316 0.5198153148 ] and iteration error 5.128642543e-16 DEAL:: DEAL:: DEAL::Testing 3D with point -0.1685599679 0.8836222961 0.02826968317 @@ -641,23 +641,23 @@ DEAL:: DEAL::Testing on cell 3_0: with center -0.9000000000 -5.358086410e-17 0.000000000 DEAL::Start MappingQ::do_transform_real_to_unit_cell for real point [ -0.1685599679 0.8836222961 0.02826968317 ] DEAL::Newton iteration 0 for unit point guess 3.540227857 1.350265951 0.5272025153 -DEAL:: delta=3.563108903 -0.5947761734 -0.08726992219 +DEAL:: delta=3.563108902 -0.5947761734 -0.08726992222 DEAL:: step_length=1.000000000 DEAL:: ||f || =0.6279729539 -DEAL:: ||f*|| =0.8983345289 +DEAL:: ||f*|| =0.8983345290 DEAL:: ||f*||_A =5.504053174 DEAL:: step_length=0.5000000000 DEAL:: ||f*|| =0.4439967188 DEAL:: ||f*||_A =2.555152222 DEAL::Newton iteration 1 for unit point guess 1.758673406 1.647654038 0.5708374764 DEAL::Newton iteration 1 for unit point guess 1.000000000 1.000000000 0.5708374764 -DEAL:: delta=-0.2642670141 -0.4344439561 0.002772053464 +DEAL:: delta=-0.2642670141 -0.4344439561 0.002772053470 DEAL:: step_length=1.000000000 DEAL:: ||f || =0.5100712180 DEAL:: ||f*|| =0.2331871882 DEAL:: ||f*||_A =0.7513804837 -DEAL::Newton iteration 2 for unit point guess 1.264267014 1.434443956 0.5680654229 -DEAL:: delta=1.670051431 -0.2002124112 -0.007724121203 +DEAL::Newton iteration 2 for unit point guess 1.264267014 1.434443956 0.5680654230 +DEAL:: delta=1.670051431 -0.2002124112 -0.007724121196 DEAL:: step_length=1.000000000 DEAL:: ||f || =0.2331871882 DEAL:: ||f*|| =0.1274152335 @@ -673,26 +673,26 @@ DEAL:: delta=-3.163815489 -0.02641498558 0.004391680085 DEAL:: step_length=1.000000000 DEAL:: ||f || =0.6359961941 DEAL:: ||f*|| =0.02704151679 -DEAL:: ||f*||_A =0.01179290428 +DEAL:: ||f*||_A =0.01179290427 DEAL::Newton iteration 1 for unit point guess 0.5114219311 0.3642180808 0.5228108352 -DEAL:: delta=0.009859953043 -0.01852606978 0.003015648199 +DEAL:: delta=0.009859953034 -0.01852606978 0.003015648199 DEAL:: step_length=1.000000000 DEAL:: ||f || =0.02704151679 DEAL:: ||f*|| =0.0004125306161 DEAL:: ||f*||_A =0.002030597423 DEAL::Newton iteration 2 for unit point guess 0.5015619781 0.3827441506 0.5197951870 -DEAL:: delta=0.002018195959 5.604404836e-05 -2.013654739e-05 +DEAL:: delta=0.002018195959 5.604404832e-05 -2.013654738e-05 DEAL:: step_length=1.000000000 DEAL:: ||f || =0.0004125306161 -DEAL:: ||f*|| =3.843012284e-08 -DEAL:: ||f*||_A =3.350019527e-08 +DEAL:: ||f*|| =3.843012286e-08 +DEAL:: ||f*||_A =3.350019492e-08 DEAL::Newton iteration 3 for unit point guess 0.4995437821 0.3826881066 0.5198153236 -DEAL:: delta=2.042052715e-08 -2.503750211e-08 8.776975346e-09 +DEAL:: delta=2.042052656e-08 -2.503750213e-08 8.776975345e-09 DEAL:: step_length=1.000000000 -DEAL:: ||f || =3.843012284e-08 -DEAL:: ||f*|| =1.010532634e-15 -DEAL:: ||f*||_A =4.812016529e-15 -DEAL::Iteration converged for p_unit = [ 0.4995437617 0.3826881316 0.5198153148 ] and iteration error 4.812016529e-15 +DEAL:: ||f || =3.843012286e-08 +DEAL:: ||f*|| =1.412814861e-15 +DEAL:: ||f*||_A =6.967799930e-15 +DEAL::Iteration converged for p_unit = [ 0.4995437617 0.3826881316 0.5198153148 ] and iteration error 6.967799930e-15 DEAL:: DEAL:: DEAL::Testing 3D with point -0.1779244106 0.9327124237 0.02984022112 @@ -705,23 +705,23 @@ DEAL:: DEAL::Testing on cell 3_0: with center -0.9000000000 -5.358086410e-17 0.000000000 DEAL::Start MappingQ::do_transform_real_to_unit_cell for real point [ -0.1779244106 0.9327124237 0.02984022112 ] DEAL::Newton iteration 0 for unit point guess 3.459129405 1.397502948 0.5287137662 -DEAL:: delta=3.979828397 -0.5423958605 -0.09739294425 +DEAL:: delta=3.979828397 -0.5423958610 -0.09739294428 DEAL:: step_length=1.000000000 DEAL:: ||f || =0.6668294077 -DEAL:: ||f*|| =0.9171795316 -DEAL:: ||f*||_A =6.576519580 +DEAL:: ||f*|| =0.9171795335 +DEAL:: ||f*||_A =6.576519595 DEAL:: step_length=0.5000000000 -DEAL:: ||f*|| =0.4737130779 -DEAL:: ||f*||_A =2.906475606 -DEAL::Newton iteration 1 for unit point guess 1.469215207 1.668700878 0.5774102383 +DEAL:: ||f*|| =0.4737130781 +DEAL:: ||f*||_A =2.906475608 +DEAL::Newton iteration 1 for unit point guess 1.469215207 1.668700879 0.5774102383 DEAL::Newton iteration 1 for unit point guess 1.000000000 1.000000000 0.5774102383 -DEAL:: delta=-0.05852563526 -0.4591073408 0.005969607502 +DEAL:: delta=-0.05852563526 -0.4591073408 0.005969607510 DEAL:: step_length=1.000000000 DEAL:: ||f || =0.5358286371 DEAL:: ||f*|| =0.2540023766 DEAL:: ||f*||_A =0.8710470496 DEAL::Newton iteration 2 for unit point guess 1.058525635 1.459107341 0.5714406308 -DEAL:: delta=1.928810109 -0.1985615361 -0.007803797494 +DEAL:: delta=1.928810109 -0.1985615361 -0.007803797485 DEAL:: step_length=1.000000000 DEAL:: ||f || =0.2540023766 DEAL:: ||f*|| =0.1498020872 @@ -737,26 +737,26 @@ DEAL:: delta=-3.345097096 -0.03171894519 0.005303684595 DEAL:: step_length=1.000000000 DEAL:: ||f || =0.6739766956 DEAL:: ||f*|| =0.03430597763 -DEAL:: ||f*||_A =0.01468153345 -DEAL::Newton iteration 1 for unit point guess 0.2675705624 0.3605111013 0.5234100816 -DEAL:: delta=0.01498260400 -0.02227148874 0.003626316435 +DEAL:: ||f*||_A =0.01468153343 +DEAL::Newton iteration 1 for unit point guess 0.2675705623 0.3605111013 0.5234100816 +DEAL:: delta=0.01498260396 -0.02227148874 0.003626316435 DEAL:: step_length=1.000000000 DEAL:: ||f || =0.03430597763 -DEAL:: ||f*|| =0.0006321096333 -DEAL:: ||f*||_A =0.003095644195 +DEAL:: ||f*|| =0.0006321096332 +DEAL:: ||f*||_A =0.003095644194 DEAL::Newton iteration 2 for unit point guess 0.2525879584 0.3827825900 0.5197837651 -DEAL:: delta=0.003069482877 9.451923784e-05 -3.156939907e-05 +DEAL:: delta=0.003069482877 9.451923766e-05 -3.156939904e-05 DEAL:: step_length=1.000000000 -DEAL:: ||f || =0.0006321096333 -DEAL:: ||f*|| =9.796087459e-08 -DEAL:: ||f*||_A =8.800136754e-08 +DEAL:: ||f || =0.0006321096332 +DEAL:: ||f*|| =9.796087445e-08 +DEAL:: ||f*||_A =8.800136912e-08 DEAL::Newton iteration 3 for unit point guess 0.2495184755 0.3826880708 0.5198153345 -DEAL:: delta=6.035639763e-08 -6.080731178e-08 1.973325104e-08 +DEAL:: delta=6.035640007e-08 -6.080731168e-08 1.973325093e-08 DEAL:: step_length=1.000000000 -DEAL:: ||f || =9.796087459e-08 -DEAL:: ||f*|| =5.678071909e-15 -DEAL:: ||f*||_A =2.739952915e-14 -DEAL::Iteration converged for p_unit = [ 0.2495184151 0.3826881316 0.5198153148 ] and iteration error 2.739952915e-14 +DEAL:: ||f || =9.796087445e-08 +DEAL:: ||f*|| =5.324953477e-15 +DEAL:: ||f*||_A =2.563625060e-14 +DEAL::Iteration converged for p_unit = [ 0.2495184151 0.3826881316 0.5198153148 ] and iteration error 2.563625060e-14 DEAL:: DEAL:: DEAL::Testing 3D with point -0.1872888532 0.9818025513 0.03141075908 @@ -769,23 +769,23 @@ DEAL:: DEAL::Testing on cell 3_0: with center -0.9000000000 -5.358086410e-17 0.000000000 DEAL::Start MappingQ::do_transform_real_to_unit_cell for real point [ -0.1872888532 0.9818025513 0.03141075908 ] DEAL::Newton iteration 0 for unit point guess 3.378030953 1.444739945 0.5302250170 -DEAL:: delta=4.481775075 -0.5164923720 -0.1114133431 +DEAL:: delta=4.481775075 -0.5164923719 -0.1114133431 DEAL:: step_length=1.000000000 DEAL:: ||f || =0.7090545024 DEAL:: ||f*|| =1.040376963 -DEAL:: ||f*||_A =9.431636220 +DEAL:: ||f*||_A =9.431636214 DEAL:: step_length=0.5000000000 -DEAL:: ||f*|| =0.5189006404 -DEAL:: ||f*||_A =3.548765003 +DEAL:: ||f*|| =0.5189006403 +DEAL:: ||f*||_A =3.548765002 DEAL::Newton iteration 1 for unit point guess 1.137143415 1.702986131 0.5859316886 DEAL::Newton iteration 1 for unit point guess 1.000000000 1.000000000 0.5859316886 -DEAL:: delta=0.1460488594 -0.4840658966 0.01041830048 +DEAL:: delta=0.1460488594 -0.4840658966 0.01041830049 DEAL:: step_length=1.000000000 DEAL:: ||f || =0.5651606508 DEAL:: ||f*|| =0.2788717609 DEAL:: ||f*||_A =1.003004700 DEAL::Newton iteration 2 for unit point guess 0.8539511406 1.484065897 0.5755133881 -DEAL:: delta=2.256510264 -0.2053129307 -0.008548455194 +DEAL:: delta=2.256510264 -0.2053129307 -0.008548455193 DEAL:: step_length=1.000000000 DEAL:: ||f || =0.2788717609 DEAL:: ||f*|| =0.1920633747 @@ -811,24 +811,24 @@ DEAL:: ||f || =0.5791702826 DEAL:: ||f*|| =0.007834938277 DEAL:: ||f*||_A =0.003571810880 DEAL::Newton iteration 1 for unit point guess 0.5402026982 1.000964698 0.5553192031 -DEAL:: delta=0.003587465407 0.0009021921043 0.004953715025 +DEAL:: delta=0.003587465407 0.0009021920969 0.004953715025 DEAL:: step_length=1.000000000 DEAL:: ||f || =0.007834938277 DEAL:: ||f*|| =3.884066112e-05 DEAL:: ||f*||_A =0.0001929674524 DEAL::Newton iteration 2 for unit point guess 0.5366152327 1.000062506 0.5503654881 -DEAL:: delta=-2.660056701e-06 0.0001927096002 -2.683324685e-06 +DEAL:: delta=-2.660056694e-06 0.0001927096002 -2.683324676e-06 DEAL:: step_length=1.000000000 DEAL:: ||f || =3.884066112e-05 -DEAL:: ||f*|| =2.326926395e-10 -DEAL:: ||f*||_A =1.956071920e-10 +DEAL:: ||f*|| =2.326927137e-10 +DEAL:: ||f*||_A =1.956076480e-10 DEAL::Newton iteration 3 for unit point guess 0.5366178928 0.9998697960 0.5503681714 -DEAL:: delta=1.274583858e-10 7.366131196e-11 1.287881751e-10 +DEAL:: delta=1.274584824e-10 7.366240638e-11 1.287881459e-10 DEAL:: step_length=1.000000000 -DEAL:: ||f || =2.326926395e-10 -DEAL:: ||f*|| =1.249000903e-16 -DEAL:: ||f*||_A =5.801276172e-16 -DEAL::Iteration converged for p_unit = [ 0.5366178927 0.9998697959 0.5503681713 ] and iteration error 5.801276172e-16 +DEAL:: ||f || =2.326927137e-10 +DEAL:: ||f*|| =2.423651446e-16 +DEAL:: ||f*||_A =1.145811616e-15 +DEAL::Iteration converged for p_unit = [ 0.5366178927 0.9998697959 0.5503681713 ] and iteration error 1.145811616e-15 DEAL:: DEAL::Testing on cell 3_0: with center -0.9000000000 -5.358086410e-17 0.000000000 DEAL:: @@ -851,24 +851,24 @@ DEAL:: ||f || =0.6035598825 DEAL:: ||f*|| =0.009951748567 DEAL:: ||f*||_A =0.004371343603 DEAL::Newton iteration 1 for unit point guess 0.5409897591 0.8348933245 0.5564043770 -DEAL:: delta=0.004376158946 0.001397237999 0.006040640167 +DEAL:: delta=0.004376158946 0.001397238001 0.006040640167 DEAL:: step_length=1.000000000 DEAL:: ||f || =0.009951748567 DEAL:: ||f*|| =6.023554464e-05 DEAL:: ||f*||_A =0.0002989039364 DEAL::Newton iteration 2 for unit point guess 0.5366136002 0.8334960865 0.5503637368 -DEAL:: delta=-4.292825732e-06 0.0002983822338 -4.434798037e-06 +DEAL:: delta=-4.292825735e-06 0.0002983822338 -4.434798041e-06 DEAL:: step_length=1.000000000 DEAL:: ||f || =6.023554464e-05 -DEAL:: ||f*|| =5.885477309e-10 -DEAL:: ||f*||_A =4.851418110e-10 +DEAL:: ||f*|| =5.885477540e-10 +DEAL:: ||f*||_A =4.851422850e-10 DEAL::Newton iteration 3 for unit point guess 0.5366178930 0.8331977043 0.5503681716 -DEAL:: delta=3.055682263e-10 2.047482349e-10 3.162747034e-10 +DEAL:: delta=3.055682205e-10 2.047493457e-10 3.162747168e-10 DEAL:: step_length=1.000000000 -DEAL:: ||f || =5.885477309e-10 -DEAL:: ||f*|| =1.177569344e-16 -DEAL:: ||f*||_A =5.501515204e-16 -DEAL::Iteration converged for p_unit = [ 0.5366178927 0.8331977041 0.5503681713 ] and iteration error 5.501515204e-16 +DEAL:: ||f || =5.885477540e-10 +DEAL:: ||f*|| =2.298230378e-16 +DEAL:: ||f*||_A =1.121689035e-15 +DEAL::Iteration converged for p_unit = [ 0.5366178927 0.8331977041 0.5503681713 ] and iteration error 1.121689035e-15 DEAL:: DEAL::Testing on cell 3_0: with center -0.9000000000 -5.358086410e-17 0.000000000 DEAL:: @@ -889,26 +889,26 @@ DEAL:: delta=0.007160560813 -3.137037000 0.009866511490 DEAL:: step_length=1.000000000 DEAL:: ||f || =0.6280236718 DEAL:: ||f*|| =0.01221120457 -DEAL:: ||f*||_A =0.005181873659 -DEAL::Newton iteration 1 for unit point guess 0.5417761567 0.6689800054 0.5574891018 -DEAL:: delta=0.005164708568 0.002022568303 0.007127722446 +DEAL:: ||f*||_A =0.005181873653 +DEAL::Newton iteration 1 for unit point guess 0.5417761567 0.6689800053 0.5574891018 +DEAL:: delta=0.005164708568 0.002022568271 0.007127722446 DEAL:: step_length=1.000000000 DEAL:: ||f || =0.01221120457 -DEAL:: ||f*|| =8.732694440e-05 -DEAL:: ||f*||_A =0.0004327777067 +DEAL:: ||f*|| =8.732694438e-05 +DEAL:: ||f*||_A =0.0004327777066 DEAL::Newton iteration 2 for unit point guess 0.5366114481 0.6669574371 0.5503613793 -DEAL:: delta=-6.445176365e-06 0.0004318243265 -6.792660029e-06 +DEAL:: delta=-6.445176327e-06 0.0004318243265 -6.792659976e-06 DEAL:: step_length=1.000000000 -DEAL:: ||f || =8.732694440e-05 -DEAL:: ||f*|| =1.292239442e-09 -DEAL:: ||f*||_A =1.049589250e-09 +DEAL:: ||f || =8.732694438e-05 +DEAL:: ||f*|| =1.292239485e-09 +DEAL:: ||f*||_A =1.049590811e-09 DEAL::Newton iteration 3 for unit point guess 0.5366178933 0.6665256127 0.5503681720 -DEAL:: delta=6.380390606e-10 4.900757270e-10 6.738742233e-10 +DEAL:: delta=6.380390639e-10 4.900790794e-10 6.738742123e-10 DEAL:: step_length=1.000000000 -DEAL:: ||f || =1.292239442e-09 -DEAL:: ||f*|| =3.356589068e-16 -DEAL:: ||f*||_A =1.640844821e-15 -DEAL::Iteration converged for p_unit = [ 0.5366178927 0.6665256123 0.5503681713 ] and iteration error 1.640844821e-15 +DEAL:: ||f || =1.292239485e-09 +DEAL:: ||f*|| =4.462523459e-16 +DEAL:: ||f*||_A =2.230322707e-15 +DEAL::Iteration converged for p_unit = [ 0.5366178927 0.6665256123 0.5503681713 ] and iteration error 2.230322707e-15 DEAL:: DEAL::Testing on cell 3_0: with center -0.9000000000 -5.358086410e-17 0.000000000 DEAL:: @@ -929,26 +929,26 @@ DEAL:: delta=0.008257034834 -3.258527571 0.01137284273 DEAL:: step_length=1.000000000 DEAL:: ||f || =0.6525676654 DEAL:: ||f*|| =0.01461334118 -DEAL:: ||f*||_A =0.006006826696 +DEAL:: ||f*||_A =0.006006826687 DEAL::Newton iteration 1 for unit point guess 0.5425618641 0.5032376147 0.5585733710 -DEAL:: delta=0.005953152018 0.002788806055 0.008215041053 +DEAL:: delta=0.005953152018 0.002788806007 0.008215041053 DEAL:: step_length=1.000000000 DEAL:: ||f || =0.01461334118 DEAL:: ||f*|| =0.0001206127230 DEAL:: ||f*||_A =0.0005969040838 DEAL::Newton iteration 2 for unit point guess 0.5366087121 0.5004488087 0.5503583300 -DEAL:: delta=-9.181772851e-06 0.0005952871909 -9.842617055e-06 +DEAL:: delta=-9.181772786e-06 0.0005952871909 -9.842616965e-06 DEAL:: step_length=1.000000000 DEAL:: ||f || =0.0001206127230 -DEAL:: ||f*|| =2.560943948e-09 -DEAL:: ||f*||_A =2.059237894e-09 +DEAL:: ||f*|| =2.560943728e-09 +DEAL:: ||f*||_A =2.059236695e-09 DEAL::Newton iteration 3 for unit point guess 0.5366178939 0.4998535215 0.5503681726 -DEAL:: delta=1.205909623e-09 1.051591552e-09 1.295765321e-09 +DEAL:: delta=1.205909596e-09 1.051589420e-09 1.295765171e-09 DEAL:: step_length=1.000000000 -DEAL:: ||f || =2.560943948e-09 -DEAL:: ||f*|| =2.380556418e-16 -DEAL:: ||f*||_A =1.145522000e-15 -DEAL::Iteration converged for p_unit = [ 0.5366178927 0.4998535204 0.5503681713 ] and iteration error 1.145522000e-15 +DEAL:: ||f || =2.560943728e-09 +DEAL:: ||f*|| =1.144391700e-16 +DEAL:: ||f*||_A =5.637667917e-16 +DEAL::Iteration converged for p_unit = [ 0.5366178927 0.4998535204 0.5503681713 ] and iteration error 5.637667917e-16 DEAL:: DEAL::Testing on cell 3_0: with center -0.9000000000 -5.358086410e-17 0.000000000 DEAL:: @@ -969,26 +969,26 @@ DEAL:: delta=0.009354226180 -3.380201895 0.01287963629 DEAL:: step_length=1.000000000 DEAL:: ||f || =0.6771978331 DEAL:: ||f*|| =0.01715820711 -DEAL:: ||f*||_A =0.006850101635 +DEAL:: ||f*||_A =0.006850101628 DEAL::Newton iteration 1 for unit point guess 0.5433468542 0.3376789780 0.5596571780 -DEAL:: delta=0.006741526548 0.003706534669 0.009302674610 +DEAL:: delta=0.006741526547 0.003706534640 0.009302674610 DEAL:: step_length=1.000000000 DEAL:: ||f || =0.01715820711 -DEAL:: ||f*|| =0.0001605975924 -DEAL:: ||f*||_A =0.0007936021326 +DEAL:: ||f*|| =0.0001605975923 +DEAL:: ||f*||_A =0.0007936021325 DEAL::Newton iteration 2 for unit point guess 0.5366053277 0.3339724433 0.5503545034 -DEAL:: delta=-1.256711306e-05 0.0007910126895 -1.367023802e-05 +DEAL:: delta=-1.256711302e-05 0.0007910126895 -1.367023797e-05 DEAL:: step_length=1.000000000 -DEAL:: ||f || =0.0001605975924 -DEAL:: ||f*|| =4.695015866e-09 -DEAL:: ||f*||_A =3.754227613e-09 +DEAL:: ||f || =0.0001605975923 +DEAL:: ||f*|| =4.695015943e-09 +DEAL:: ||f*||_A =3.754229775e-09 DEAL::Newton iteration 3 for unit point guess 0.5366178948 0.3331814307 0.5503681736 -DEAL:: delta=2.113650475e-09 2.075279271e-09 2.305167363e-09 +DEAL:: delta=2.113650487e-09 2.075283174e-09 2.305167359e-09 DEAL:: step_length=1.000000000 -DEAL:: ||f || =4.695015866e-09 -DEAL:: ||f*|| =3.408544028e-16 -DEAL:: ||f*||_A =1.691542209e-15 -DEAL::Iteration converged for p_unit = [ 0.5366178927 0.3331814286 0.5503681713 ] and iteration error 1.691542209e-15 +DEAL:: ||f || =4.695015943e-09 +DEAL:: ||f*|| =6.664228726e-16 +DEAL:: ||f*||_A =3.323816735e-15 +DEAL::Iteration converged for p_unit = [ 0.5366178927 0.3331814286 0.5503681713 ] and iteration error 3.323816735e-15 DEAL:: DEAL::Testing on cell 3_0: with center -0.9000000000 -5.358086410e-17 0.000000000 DEAL:: -- 2.39.5