From c51967c3122ee9814687c2bb9522b2587066febf Mon Sep 17 00:00:00 2001 From: Peter Munch Date: Thu, 24 Aug 2023 22:17:10 +0200 Subject: [PATCH] MGTwoLevelTransferNonNested: simplices with multiple components --- .../mg_transfer_global_coarsening.templates.h | 54 +++--- .../events_non_nested.cc | 4 +- .../multigrid_a_01.cc | 2 +- .../multigrid_a_02.cc | 2 +- .../multigrid_a_03.cc | 2 +- .../multigrid_p_01.cc | 2 +- .../multigrid_p_02.cc | 2 +- .../multigrid_p_03.cc | 2 +- .../multigrid_util.h | 23 ++- .../non_nested_multigrid_01.cc | 4 +- .../non_nested_multigrid_02.cc | 4 +- .../non_nested_multigrid_03.cc | 4 +- .../non_nested_multigrid_04.cc | 4 +- .../non_nested_multigrid_05.cc | 160 ++++++++++++++++++ ...st=true.with_trilinos=true.mpirun=1.output | 9 + ...ransfer_04.with_p4est=true.mpirun=1.output | 24 +-- ...ransfer_04.with_p4est=true.mpirun=2.output | 42 ++--- 17 files changed, 271 insertions(+), 73 deletions(-) create mode 100644 tests/multigrid-global-coarsening/non_nested_multigrid_05.cc create mode 100644 tests/multigrid-global-coarsening/non_nested_multigrid_05.with_p4est=true.with_trilinos=true.mpirun=1.output diff --git a/include/deal.II/multigrid/mg_transfer_global_coarsening.templates.h b/include/deal.II/multigrid/mg_transfer_global_coarsening.templates.h index 903f620d4b..f227b765ff 100644 --- a/include/deal.II/multigrid/mg_transfer_global_coarsening.templates.h +++ b/include/deal.II/multigrid/mg_transfer_global_coarsening.templates.h @@ -4472,18 +4472,20 @@ namespace internal ExcMessage("Function expects FE_DGQ, FE_Q, FE_SimplexP, or " "FE_SimplexDGP in dof_handler.")); - Assert((dynamic_cast *>( - &dof_handler_support_points.get_fe()) != nullptr || - dynamic_cast *>( - &dof_handler_support_points.get_fe()) != nullptr) || - ((dynamic_cast *>( - &dof_handler_support_points.get_fe()) != nullptr || - dynamic_cast *>( - &dof_handler_support_points.get_fe()) != nullptr) && - dof_handler_support_points.get_fe().degree == 0), - ExcMessage( - "Function expects (FE_DGQ||FE_SimplexDGP)&°ree==0 or " - "(FE_Q||FE_SimplexP) in dof_handler_support_points.")); + Assert( + (dynamic_cast *>( + &dof_handler_support_points.get_fe().base_element(0)) != nullptr || + dynamic_cast *>( + &dof_handler_support_points.get_fe().base_element(0)) != nullptr) || + ((dynamic_cast *>( + &dof_handler_support_points.get_fe().base_element(0)) != + nullptr || + dynamic_cast *>( + &dof_handler_support_points.get_fe().base_element(0)) != + nullptr) && + dof_handler_support_points.get_fe().degree == 0), + ExcMessage("Function expects (FE_DGQ||FE_SimplexDGP)&°ree==0 or " + "(FE_Q||FE_SimplexP) in dof_handler_support_points.")); Assert( dof_handler_support_points.get_fe().n_components() == 1, @@ -4520,7 +4522,8 @@ namespace internal const bool needs_conversion = dof_handler.get_fe().conforming_space == FiniteElementData::Conformity::L2 && - (dof_handler.get_fe().degree > 0); + (dof_handler.get_fe().degree > 0) && + dof_handler.get_fe().reference_cell().is_hyper_cube(); std::vector lexicographic_to_hierarchic; if (needs_conversion) lexicographic_to_hierarchic = @@ -4658,8 +4661,10 @@ namespace internal const auto n_components = fe.n_components(); if (n_components == 1 && - (fe.conforming_space == FiniteElementData::Conformity::H1 || - degree == 0)) + ((fe.reference_cell().is_hyper_cube() || + fe.reference_cell().is_simplex()) && + (fe.conforming_space == FiniteElementData::Conformity::H1 || + degree == 0))) { // in case a DG space of order 0 is provided, DoFs indices are always // uniquely assigned to support points (they are always defined in the @@ -4678,7 +4683,13 @@ namespace internal auto dof_handler_support_points = std::make_shared>(tria); - if (degree == 0) + if (fe.reference_cell().is_simplex() && (degree == 0)) + dof_handler_support_points->distribute_dofs( + FE_SimplexDGP(degree)); + else if (fe.reference_cell().is_simplex()) + dof_handler_support_points->distribute_dofs( + FE_SimplexP(degree)); + else if (degree == 0) dof_handler_support_points->distribute_dofs( FE_DGQ(degree)); else @@ -4893,12 +4904,13 @@ MGTwoLevelTransferNonNested>:: if (const auto fe = dynamic_cast *>(&fe_base)) fe_coarse = std::make_unique>(FE_DGQ(fe->get_degree()), n_components); - else if (const auto fe = dynamic_cast *>(&fe_base)) - fe_coarse = fe->clone(); else if (const auto fe = dynamic_cast *>(&fe_base)) - fe_coarse = fe->clone(); - else if (const auto fe = dynamic_cast *>(&fe_base)) - fe_coarse = fe->clone(); + fe_coarse = + std::make_unique>(FE_SimplexDGP(fe->get_degree()), + n_components); + else if (dynamic_cast *>(&fe_base) || + dynamic_cast *>(&fe_base)) + fe_coarse = dof_handler_coarse.get_fe().clone(); else AssertThrow(false, ExcMessage(dof_handler_coarse.get_fe().get_name())); } diff --git a/tests/multigrid-global-coarsening/events_non_nested.cc b/tests/multigrid-global-coarsening/events_non_nested.cc index 0eace650f6..02e16f0d1c 100644 --- a/tests/multigrid-global-coarsening/events_non_nested.cc +++ b/tests/multigrid-global-coarsening/events_non_nested.cc @@ -45,8 +45,8 @@ test(const unsigned int n_refinements, MGLevelObject> constraints(min_level, max_level); MGLevelObject>> mappings(min_level, max_level); MGLevelObject>> - transfers(min_level, max_level); - MGLevelObject> operators(min_level, max_level); + transfers(min_level, max_level); + MGLevelObject> operators(min_level, max_level); // set up levels diff --git a/tests/multigrid-global-coarsening/multigrid_a_01.cc b/tests/multigrid-global-coarsening/multigrid_a_01.cc index 810f7d52a1..f1df401b39 100644 --- a/tests/multigrid-global-coarsening/multigrid_a_01.cc +++ b/tests/multigrid-global-coarsening/multigrid_a_01.cc @@ -37,7 +37,7 @@ test(const unsigned int n_refinements, MGLevelObject> constraints(min_level, max_level); MGLevelObject> transfers(min_level, max_level); - MGLevelObject> operators(min_level, max_level); + MGLevelObject> operators(min_level, max_level); std::unique_ptr> mapping_; diff --git a/tests/multigrid-global-coarsening/multigrid_a_02.cc b/tests/multigrid-global-coarsening/multigrid_a_02.cc index 278ef18265..d00f383438 100644 --- a/tests/multigrid-global-coarsening/multigrid_a_02.cc +++ b/tests/multigrid-global-coarsening/multigrid_a_02.cc @@ -39,7 +39,7 @@ test(const unsigned int n_refinements, const unsigned int fe_degree_fine) MGLevelObject> constraints(min_level, max_level); MGLevelObject> transfers(min_level, max_level); - MGLevelObject> operators(min_level, max_level); + MGLevelObject> operators(min_level, max_level); std::unique_ptr> fe; std::unique_ptr> quad; diff --git a/tests/multigrid-global-coarsening/multigrid_a_03.cc b/tests/multigrid-global-coarsening/multigrid_a_03.cc index 35245389b4..6e4379e937 100644 --- a/tests/multigrid-global-coarsening/multigrid_a_03.cc +++ b/tests/multigrid-global-coarsening/multigrid_a_03.cc @@ -37,7 +37,7 @@ test(const unsigned int n_refinements, const unsigned int fe_degree_fine) const unsigned int max_level = n_refinements; MGLevelObject> constraints(min_level, max_level); - MGLevelObject> operators(min_level, max_level); + MGLevelObject> operators(min_level, max_level); std::unique_ptr> fe; std::unique_ptr> quad; diff --git a/tests/multigrid-global-coarsening/multigrid_p_01.cc b/tests/multigrid-global-coarsening/multigrid_p_01.cc index 8f68647bd5..bf55c9ba8e 100644 --- a/tests/multigrid-global-coarsening/multigrid_p_01.cc +++ b/tests/multigrid-global-coarsening/multigrid_p_01.cc @@ -73,7 +73,7 @@ test(const unsigned int n_refinements, MGLevelObject> constraints(min_level, max_level); MGLevelObject> transfers(min_level, max_level); - MGLevelObject> operators(min_level, max_level); + MGLevelObject> operators(min_level, max_level); std::unique_ptr> mapping_; diff --git a/tests/multigrid-global-coarsening/multigrid_p_02.cc b/tests/multigrid-global-coarsening/multigrid_p_02.cc index 097df28d9c..e95a3a73ed 100644 --- a/tests/multigrid-global-coarsening/multigrid_p_02.cc +++ b/tests/multigrid-global-coarsening/multigrid_p_02.cc @@ -46,7 +46,7 @@ test(const unsigned int n_refinements, const unsigned int fe_degree_fine) MGLevelObject> constraints(min_level, max_level); MGLevelObject> transfers(min_level, max_level); - MGLevelObject> operators(min_level, max_level); + MGLevelObject> operators(min_level, max_level); std::unique_ptr> mapping_; diff --git a/tests/multigrid-global-coarsening/multigrid_p_03.cc b/tests/multigrid-global-coarsening/multigrid_p_03.cc index b63bb76dd8..69d57c66c0 100644 --- a/tests/multigrid-global-coarsening/multigrid_p_03.cc +++ b/tests/multigrid-global-coarsening/multigrid_p_03.cc @@ -49,7 +49,7 @@ test(const unsigned int n_refinements, MGLevelObject> constraints(min_level, max_level); MGLevelObject> transfers(min_level, max_level); - MGLevelObject> operators(min_level, max_level); + MGLevelObject> operators(min_level, max_level); std::unique_ptr> mapping_; diff --git a/tests/multigrid-global-coarsening/multigrid_util.h b/tests/multigrid-global-coarsening/multigrid_util.h index 05d01a6190..af2b57b6d8 100644 --- a/tests/multigrid-global-coarsening/multigrid_util.h +++ b/tests/multigrid-global-coarsening/multigrid_util.h @@ -58,7 +58,7 @@ #include "../tests.h" -template +template class Operator : public Subscriptor { public: @@ -68,7 +68,7 @@ public: static const int dim = dim_; - using FECellIntegrator = FEEvaluation; + using FECellIntegrator = FEEvaluation; void reinit(const Mapping &mapping, @@ -195,7 +195,24 @@ public: { phi.reinit(cell); for (unsigned int q = 0; q < phi.n_q_points; ++q) - phi.submit_value(1.0, q); + { + if constexpr (n_components == 1) + { + phi.submit_value(1.0, q); + } + else + { + Tensor<1, n_components, VectorizedArray> temp; + for (unsigned int v = 0; + v < VectorizedArray::size(); + ++v) + { + for (unsigned int i = 0; i < n_components; i++) + temp[i][v] = 1.; + } + phi.submit_value(temp, q); + } + } phi.integrate_scatter(EvaluationFlags::values, dst); } diff --git a/tests/multigrid-global-coarsening/non_nested_multigrid_01.cc b/tests/multigrid-global-coarsening/non_nested_multigrid_01.cc index 5cfc2d8d18..6fddb5c93e 100644 --- a/tests/multigrid-global-coarsening/non_nested_multigrid_01.cc +++ b/tests/multigrid-global-coarsening/non_nested_multigrid_01.cc @@ -39,8 +39,8 @@ test(const unsigned int n_refinements, MGLevelObject> constraints(min_level, max_level); MGLevelObject>> mappings(min_level, max_level); MGLevelObject>> - transfers(min_level, max_level); - MGLevelObject> operators(min_level, max_level); + transfers(min_level, max_level); + MGLevelObject> operators(min_level, max_level); // set up levels diff --git a/tests/multigrid-global-coarsening/non_nested_multigrid_02.cc b/tests/multigrid-global-coarsening/non_nested_multigrid_02.cc index f0a199a4ac..5d99efcbaa 100644 --- a/tests/multigrid-global-coarsening/non_nested_multigrid_02.cc +++ b/tests/multigrid-global-coarsening/non_nested_multigrid_02.cc @@ -39,8 +39,8 @@ test(const unsigned int n_refinements, MGLevelObject> constraints(min_level, max_level); MGLevelObject> mappings(min_level, max_level); MGLevelObject>> - transfers(min_level, max_level); - MGLevelObject> operators(min_level, max_level); + transfers(min_level, max_level); + MGLevelObject> operators(min_level, max_level); // set up levels diff --git a/tests/multigrid-global-coarsening/non_nested_multigrid_03.cc b/tests/multigrid-global-coarsening/non_nested_multigrid_03.cc index 1772d22b39..d4d8a61e0e 100644 --- a/tests/multigrid-global-coarsening/non_nested_multigrid_03.cc +++ b/tests/multigrid-global-coarsening/non_nested_multigrid_03.cc @@ -37,8 +37,8 @@ test(const unsigned int n_refinements, const unsigned int fe_degree_fine) MGLevelObject> constraints(min_level, max_level); MGLevelObject> mappings(min_level, max_level); MGLevelObject>> - transfers(min_level, max_level); - MGLevelObject> operators(min_level, max_level); + transfers(min_level, max_level); + MGLevelObject> operators(min_level, max_level); // set up levels diff --git a/tests/multigrid-global-coarsening/non_nested_multigrid_04.cc b/tests/multigrid-global-coarsening/non_nested_multigrid_04.cc index 0f42c5301a..4fc0491443 100644 --- a/tests/multigrid-global-coarsening/non_nested_multigrid_04.cc +++ b/tests/multigrid-global-coarsening/non_nested_multigrid_04.cc @@ -97,8 +97,8 @@ test(const unsigned int n_refinements, MGLevelObject> constraints(min_level, max_level); MGLevelObject>> mappings(min_level, max_level); MGLevelObject>> - transfers(min_level, max_level); - MGLevelObject> operators(min_level, max_level); + transfers(min_level, max_level); + MGLevelObject> operators(min_level, max_level); // set up levels diff --git a/tests/multigrid-global-coarsening/non_nested_multigrid_05.cc b/tests/multigrid-global-coarsening/non_nested_multigrid_05.cc new file mode 100644 index 0000000000..1156d105bb --- /dev/null +++ b/tests/multigrid-global-coarsening/non_nested_multigrid_05.cc @@ -0,0 +1,160 @@ +// // --------------------------------------------------------------------- +// // +// // Copyright (C) 2020 - 2023 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.md at +// // the top level directory of deal.II. +// // +// // --------------------------------------------------------------------- + + +/** + * Test global-coarsening multigrid for a uniformly refined mesh both for + * simplicial elements and multiple components. + */ + +#include + +#include + +#include "multigrid_util.h" + +template +void +test(const unsigned int n_refinements, + const unsigned int fe_degree_fine, + const double factor) +{ + using VectorType = LinearAlgebra::distributed::Vector; + + const unsigned int min_level = 0; + const unsigned int max_level = n_refinements; + + MGLevelObject> triangulations(min_level, max_level); + MGLevelObject> dof_handlers(min_level, max_level); + MGLevelObject> constraints(min_level, max_level); + MGLevelObject>> mappings(min_level, max_level); + MGLevelObject>> + transfers(min_level, max_level); + MGLevelObject> operators(min_level, + max_level); + + + // set up levels + for (auto l = min_level; l <= max_level; ++l) + { + auto &tria = triangulations[l]; + auto &dof_handler = dof_handlers[l]; + auto &constraint = constraints[l]; + auto &op = operators[l]; + + std::unique_ptr> fe = + std::make_unique>(FE_SimplexP(fe_degree_fine), + n_components); + std::unique_ptr> quad = + std::make_unique>(fe_degree_fine + 1); + std::unique_ptr> _mapping = + std::make_unique>(FE_SimplexP(fe_degree_fine)); + + mappings[l] = _mapping->clone(); + + // set up triangulation + Triangulation tria_tmp; + GridGenerator::hyper_cube(tria_tmp, -1.0, 1.0); + tria_tmp.refine_global(l); + + GridGenerator::convert_hypercube_to_simplex_mesh(tria_tmp, tria); + GridTools::distort_random(factor, + tria, + true, + boost::random::mt19937::default_seed); + + // set up dofhandler + dof_handler.reinit(tria); + dof_handler.distribute_dofs(*fe); + + // set up constraints + IndexSet locally_relevant_dofs; + DoFTools::extract_locally_relevant_dofs(dof_handler, + locally_relevant_dofs); + constraint.reinit(locally_relevant_dofs); + VectorTools::interpolate_boundary_values(*_mapping, + dof_handler, + 0, + Functions::ZeroFunction( + n_components), + constraint); + constraint.close(); + + // set up operator + op.reinit(*_mapping, dof_handler, *quad, constraint); + } + + // set up transfer operator + for (unsigned int l = min_level; l < max_level; ++l) + { + transfers[l + 1] = + std::make_shared>(); + transfers[l + 1]->reinit(dof_handlers[l + 1], + dof_handlers[l], + *mappings[l + 1], + *mappings[l], + constraints[l + 1], + constraints[l]); + } + + MGTransferGlobalCoarsening transfer( + transfers, + [&](const auto l, auto &vec) { operators[l].initialize_dof_vector(vec); }); + + + GMGParameters mg_data; // TODO + + VectorType dst, src; + operators[max_level].initialize_dof_vector(dst); + operators[max_level].initialize_dof_vector(src); + + operators[max_level].rhs(src); + + ReductionControl solver_control( + mg_data.maxiter, mg_data.abstol, mg_data.reltol, false, false); + + mg_solve(solver_control, + dst, + src, + mg_data, + dof_handlers[max_level], + operators[max_level], + operators, + transfer); + + deallog << dim << ' ' << fe_degree_fine << ' ' << n_refinements << ' ' + << n_components << ' ' << "simplex" << ' ' + << solver_control.last_step() << std::endl; +} + +int +main(int argc, char **argv) +{ + Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1); + MPILogInitAll all; + + deallog.precision(8); + static constexpr unsigned int dim = 2; + static constexpr unsigned int max_simplex_degree = 2; + + const double factor = .36; + for (unsigned int n_refinements = 2; n_refinements <= 3; ++n_refinements) + for (unsigned int degree = 1; degree <= max_simplex_degree; ++degree) + test(n_refinements, degree, factor); + + for (unsigned int n_refinements = 2; n_refinements <= 3; ++n_refinements) + for (unsigned int degree = 1; degree <= max_simplex_degree; ++degree) + test(n_refinements, degree, factor); +} diff --git a/tests/multigrid-global-coarsening/non_nested_multigrid_05.with_p4est=true.with_trilinos=true.mpirun=1.output b/tests/multigrid-global-coarsening/non_nested_multigrid_05.with_p4est=true.with_trilinos=true.mpirun=1.output new file mode 100644 index 0000000000..78db8ff970 --- /dev/null +++ b/tests/multigrid-global-coarsening/non_nested_multigrid_05.with_p4est=true.with_trilinos=true.mpirun=1.output @@ -0,0 +1,9 @@ + +DEAL:0::2 1 2 1 simplex 4 +DEAL:0::2 2 2 1 simplex 5 +DEAL:0::2 1 3 1 simplex 5 +DEAL:0::2 2 3 1 simplex 6 +DEAL:0::2 1 2 2 simplex 4 +DEAL:0::2 2 2 2 simplex 5 +DEAL:0::2 1 3 2 simplex 5 +DEAL:0::2 2 3 2 simplex 6 diff --git a/tests/multigrid-global-coarsening/non_nested_transfer_04.with_p4est=true.mpirun=1.output b/tests/multigrid-global-coarsening/non_nested_transfer_04.with_p4est=true.mpirun=1.output index b87a686a64..e8a9186e52 100644 --- a/tests/multigrid-global-coarsening/non_nested_transfer_04.with_p4est=true.mpirun=1.output +++ b/tests/multigrid-global-coarsening/non_nested_transfer_04.with_p4est=true.mpirun=1.output @@ -1,10 +1,10 @@ -DEAL:0:DG<2>(0)<->DG<2>(0)::4.0000000 +DEAL:0:DG<2>(0)<->DG<2>(0)::5.6568542 DEAL:0:DG<2>(0)<->DG<2>(0)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 -DEAL:0:DG<2>(0)<->DG<2>(0)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 -DEAL:0:DG<2>(0)<->DG<2>(0)::8.0000000 DEAL:0:DG<2>(0)<->DG<2>(0)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 -DEAL:0:DG<2>(0)<->DG<2>(0)::4.0000000 0.0000000 4.0000000 0.0000000 4.0000000 0.0000000 4.0000000 0.0000000 +DEAL:0:DG<2>(0)<->DG<2>(0)::11.313708 +DEAL:0:DG<2>(0)<->DG<2>(0)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 +DEAL:0:DG<2>(0)<->DG<2>(0)::4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 DEAL:0:CG<2>(1)<->CG<2>(1)::7.0710678 DEAL:0:CG<2>(1)<->CG<2>(1)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 DEAL:0:CG<2>(1)<->CG<2>(1)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 @@ -17,12 +17,12 @@ DEAL:0:DG<2>(1)<->CG<2>(1)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1. DEAL:0:DG<2>(1)<->CG<2>(1)::33.941125 DEAL:0:DG<2>(1)<->CG<2>(1)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 DEAL:0:DG<2>(1)<->CG<2>(1)::4.0000000 4.0000000 8.0000000 8.0000000 8.0000000 8.0000000 16.000000 16.000000 4.0000000 4.0000000 8.0000000 8.0000000 4.0000000 4.0000000 8.0000000 8.0000000 4.0000000 4.0000000 -DEAL:0:DG<2>(1)<->DG<2>(1)::8.0000000 +DEAL:0:DG<2>(1)<->DG<2>(1)::11.313708 DEAL:0:DG<2>(1)<->DG<2>(1)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 -DEAL:0:DG<2>(1)<->DG<2>(1)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 0.0000000 1.0000000 1.0000000 1.0000000 0.0000000 1.0000000 1.0000000 1.0000000 0.0000000 1.0000000 1.0000000 1.0000000 0.0000000 1.0000000 0.0000000 0.0000000 0.0000000 1.0000000 0.0000000 0.0000000 0.0000000 1.0000000 1.0000000 0.0000000 0.0000000 1.0000000 1.0000000 0.0000000 0.0000000 1.0000000 1.0000000 0.0000000 0.0000000 1.0000000 1.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 1.0000000 0.0000000 0.0000000 0.0000000 1.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 -DEAL:0:DG<2>(1)<->DG<2>(1)::16.000000 DEAL:0:DG<2>(1)<->DG<2>(1)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 -DEAL:0:DG<2>(1)<->DG<2>(1)::4.0000000 4.0000000 4.0000000 4.0000000 0.0000000 0.0000000 0.0000000 0.0000000 4.0000000 4.0000000 4.0000000 4.0000000 0.0000000 0.0000000 0.0000000 0.0000000 4.0000000 4.0000000 4.0000000 4.0000000 0.0000000 0.0000000 0.0000000 0.0000000 4.0000000 4.0000000 4.0000000 4.0000000 0.0000000 0.0000000 0.0000000 0.0000000 +DEAL:0:DG<2>(1)<->DG<2>(1)::22.627417 +DEAL:0:DG<2>(1)<->DG<2>(1)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 +DEAL:0:DG<2>(1)<->DG<2>(1)::4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 DEAL:0:CG<2>(2)<->CG<2>(2)::12.727922 DEAL:0:CG<2>(2)<->CG<2>(2)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 DEAL:0:CG<2>(2)<->CG<2>(2)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 @@ -35,9 +35,9 @@ DEAL:0:DG<2>(2)<->CG<2>(2)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1. DEAL:0:DG<2>(2)<->CG<2>(2)::47.906484 DEAL:0:DG<2>(2)<->CG<2>(2)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 DEAL:0:DG<2>(2)<->CG<2>(2)::1.5625000 1.5625000 3.1250000 3.1250000 3.1250000 3.1250000 6.2500000 6.2500000 4.3750000 4.3750000 8.7500000 8.7500000 4.3750000 4.3750000 8.7500000 8.7500000 12.250000 12.250000 1.5625000 1.5625000 3.1250000 3.1250000 4.3750000 4.3750000 4.3750000 4.3750000 8.7500000 8.7500000 12.250000 12.250000 1.5625000 1.5625000 3.1250000 3.1250000 4.3750000 4.3750000 8.7500000 8.7500000 4.3750000 4.3750000 12.250000 12.250000 1.5625000 1.5625000 4.3750000 4.3750000 4.3750000 4.3750000 12.250000 12.250000 -DEAL:0:DG<2>(2)<->DG<2>(2)::12.000000 +DEAL:0:DG<2>(2)<->DG<2>(2)::16.970563 DEAL:0:DG<2>(2)<->DG<2>(2)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 -DEAL:0:DG<2>(2)<->DG<2>(2)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 0.0000000 1.0000000 0.0000000 1.0000000 0.0000000 1.0000000 1.0000000 1.0000000 1.0000000 0.0000000 1.0000000 0.0000000 1.0000000 0.0000000 1.0000000 1.0000000 1.0000000 1.0000000 0.0000000 0.0000000 0.0000000 1.0000000 0.0000000 0.0000000 1.0000000 1.0000000 1.0000000 0.0000000 0.0000000 0.0000000 1.0000000 0.0000000 0.0000000 1.0000000 0.0000000 1.0000000 0.0000000 0.0000000 0.0000000 1.0000000 0.0000000 0.0000000 1.0000000 0.0000000 1.0000000 0.0000000 0.0000000 0.0000000 1.0000000 0.0000000 0.0000000 1.0000000 0.0000000 1.0000000 0.0000000 0.0000000 0.0000000 1.0000000 0.0000000 0.0000000 1.0000000 0.0000000 1.0000000 0.0000000 0.0000000 0.0000000 1.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 1.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 1.0000000 0.0000000 0.0000000 1.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 1.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 -DEAL:0:DG<2>(2)<->DG<2>(2)::30.750000 DEAL:0:DG<2>(2)<->DG<2>(2)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 -DEAL:0:DG<2>(2)<->DG<2>(2)::1.5625000 4.3750000 1.5625000 4.3750000 12.250000 4.3750000 1.5625000 4.3750000 1.5625000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 1.5625000 4.3750000 1.5625000 4.3750000 12.250000 4.3750000 1.5625000 4.3750000 1.5625000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 1.5625000 4.3750000 1.5625000 4.3750000 12.250000 4.3750000 1.5625000 4.3750000 1.5625000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 1.5625000 4.3750000 1.5625000 4.3750000 12.250000 4.3750000 1.5625000 4.3750000 1.5625000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 +DEAL:0:DG<2>(2)<->DG<2>(2)::43.487067 +DEAL:0:DG<2>(2)<->DG<2>(2)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 +DEAL:0:DG<2>(2)<->DG<2>(2)::1.5625000 4.3750000 1.5625000 4.3750000 12.250000 4.3750000 1.5625000 4.3750000 1.5625000 1.5625000 4.3750000 1.5625000 4.3750000 12.250000 4.3750000 1.5625000 4.3750000 1.5625000 1.5625000 4.3750000 1.5625000 4.3750000 12.250000 4.3750000 1.5625000 4.3750000 1.5625000 1.5625000 4.3750000 1.5625000 4.3750000 12.250000 4.3750000 1.5625000 4.3750000 1.5625000 1.5625000 4.3750000 1.5625000 4.3750000 12.250000 4.3750000 1.5625000 4.3750000 1.5625000 1.5625000 4.3750000 1.5625000 4.3750000 12.250000 4.3750000 1.5625000 4.3750000 1.5625000 1.5625000 4.3750000 1.5625000 4.3750000 12.250000 4.3750000 1.5625000 4.3750000 1.5625000 1.5625000 4.3750000 1.5625000 4.3750000 12.250000 4.3750000 1.5625000 4.3750000 1.5625000 diff --git a/tests/multigrid-global-coarsening/non_nested_transfer_04.with_p4est=true.mpirun=2.output b/tests/multigrid-global-coarsening/non_nested_transfer_04.with_p4est=true.mpirun=2.output index 0176b9eb03..e1a6c49abe 100644 --- a/tests/multigrid-global-coarsening/non_nested_transfer_04.with_p4est=true.mpirun=2.output +++ b/tests/multigrid-global-coarsening/non_nested_transfer_04.with_p4est=true.mpirun=2.output @@ -1,10 +1,10 @@ -DEAL:0:DG<2>(0)<->DG<2>(0)::4.0000000 +DEAL:0:DG<2>(0)<->DG<2>(0)::5.6568542 DEAL:0:DG<2>(0)<->DG<2>(0)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 -DEAL:0:DG<2>(0)<->DG<2>(0)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 -DEAL:0:DG<2>(0)<->DG<2>(0)::8.0000000 DEAL:0:DG<2>(0)<->DG<2>(0)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 -DEAL:0:DG<2>(0)<->DG<2>(0)::4.0000000 0.0000000 4.0000000 0.0000000 4.0000000 0.0000000 4.0000000 0.0000000 +DEAL:0:DG<2>(0)<->DG<2>(0)::11.313708 +DEAL:0:DG<2>(0)<->DG<2>(0)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 +DEAL:0:DG<2>(0)<->DG<2>(0)::4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 DEAL:0:CG<2>(1)<->CG<2>(1)::7.0710678 DEAL:0:CG<2>(1)<->CG<2>(1)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 DEAL:0:CG<2>(1)<->CG<2>(1)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 @@ -17,12 +17,12 @@ DEAL:0:DG<2>(1)<->CG<2>(1)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1. DEAL:0:DG<2>(1)<->CG<2>(1)::33.941125 DEAL:0:DG<2>(1)<->CG<2>(1)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 DEAL:0:DG<2>(1)<->CG<2>(1)::4.0000000 4.0000000 8.0000000 8.0000000 8.0000000 8.0000000 16.000000 16.000000 4.0000000 4.0000000 8.0000000 8.0000000 4.0000000 4.0000000 8.0000000 8.0000000 4.0000000 4.0000000 -DEAL:0:DG<2>(1)<->DG<2>(1)::8.0000000 +DEAL:0:DG<2>(1)<->DG<2>(1)::11.313708 DEAL:0:DG<2>(1)<->DG<2>(1)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 -DEAL:0:DG<2>(1)<->DG<2>(1)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 0.0000000 1.0000000 1.0000000 1.0000000 0.0000000 1.0000000 0.0000000 1.0000000 0.0000000 1.0000000 0.0000000 1.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 1.0000000 0.0000000 0.0000000 0.0000000 1.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 -DEAL:0:DG<2>(1)<->DG<2>(1)::16.000000 DEAL:0:DG<2>(1)<->DG<2>(1)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 -DEAL:0:DG<2>(1)<->DG<2>(1)::4.0000000 4.0000000 4.0000000 4.0000000 0.0000000 0.0000000 0.0000000 0.0000000 4.0000000 4.0000000 4.0000000 4.0000000 0.0000000 0.0000000 0.0000000 0.0000000 4.0000000 4.0000000 4.0000000 4.0000000 0.0000000 0.0000000 0.0000000 0.0000000 4.0000000 4.0000000 4.0000000 4.0000000 0.0000000 0.0000000 0.0000000 0.0000000 +DEAL:0:DG<2>(1)<->DG<2>(1)::22.627417 +DEAL:0:DG<2>(1)<->DG<2>(1)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 +DEAL:0:DG<2>(1)<->DG<2>(1)::4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 4.0000000 DEAL:0:CG<2>(2)<->CG<2>(2)::12.727922 DEAL:0:CG<2>(2)<->CG<2>(2)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 DEAL:0:CG<2>(2)<->CG<2>(2)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 @@ -35,17 +35,17 @@ DEAL:0:DG<2>(2)<->CG<2>(2)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1. DEAL:0:DG<2>(2)<->CG<2>(2)::47.906484 DEAL:0:DG<2>(2)<->CG<2>(2)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 DEAL:0:DG<2>(2)<->CG<2>(2)::1.5625000 1.5625000 3.1250000 3.1250000 3.1250000 3.1250000 6.2500000 6.2500000 4.3750000 4.3750000 8.7500000 8.7500000 4.3750000 4.3750000 8.7500000 8.7500000 12.250000 12.250000 1.5625000 1.5625000 3.1250000 3.1250000 4.3750000 4.3750000 4.3750000 4.3750000 8.7500000 8.7500000 12.250000 12.250000 1.5625000 1.5625000 3.1250000 3.1250000 4.3750000 4.3750000 8.7500000 8.7500000 4.3750000 4.3750000 12.250000 12.250000 1.5625000 1.5625000 4.3750000 4.3750000 4.3750000 4.3750000 12.250000 12.250000 -DEAL:0:DG<2>(2)<->DG<2>(2)::12.000000 +DEAL:0:DG<2>(2)<->DG<2>(2)::16.970563 DEAL:0:DG<2>(2)<->DG<2>(2)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 -DEAL:0:DG<2>(2)<->DG<2>(2)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 0.0000000 1.0000000 0.0000000 1.0000000 0.0000000 1.0000000 1.0000000 1.0000000 1.0000000 0.0000000 1.0000000 0.0000000 1.0000000 0.0000000 1.0000000 1.0000000 1.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 1.0000000 1.0000000 1.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 1.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 1.0000000 1.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 1.0000000 1.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 -DEAL:0:DG<2>(2)<->DG<2>(2)::30.750000 DEAL:0:DG<2>(2)<->DG<2>(2)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 -DEAL:0:DG<2>(2)<->DG<2>(2)::1.5625000 4.3750000 1.5625000 4.3750000 12.250000 4.3750000 1.5625000 4.3750000 1.5625000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 1.5625000 4.3750000 1.5625000 4.3750000 12.250000 4.3750000 1.5625000 4.3750000 1.5625000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 1.5625000 4.3750000 1.5625000 4.3750000 12.250000 4.3750000 1.5625000 4.3750000 1.5625000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 1.5625000 4.3750000 1.5625000 4.3750000 12.250000 4.3750000 1.5625000 4.3750000 1.5625000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 +DEAL:0:DG<2>(2)<->DG<2>(2)::43.487067 +DEAL:0:DG<2>(2)<->DG<2>(2)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 +DEAL:0:DG<2>(2)<->DG<2>(2)::1.5625000 4.3750000 1.5625000 4.3750000 12.250000 4.3750000 1.5625000 4.3750000 1.5625000 1.5625000 4.3750000 1.5625000 4.3750000 12.250000 4.3750000 1.5625000 4.3750000 1.5625000 1.5625000 4.3750000 1.5625000 4.3750000 12.250000 4.3750000 1.5625000 4.3750000 1.5625000 1.5625000 4.3750000 1.5625000 4.3750000 12.250000 4.3750000 1.5625000 4.3750000 1.5625000 1.5625000 4.3750000 1.5625000 4.3750000 12.250000 4.3750000 1.5625000 4.3750000 1.5625000 1.5625000 4.3750000 1.5625000 4.3750000 12.250000 4.3750000 1.5625000 4.3750000 1.5625000 1.5625000 4.3750000 1.5625000 4.3750000 12.250000 4.3750000 1.5625000 4.3750000 1.5625000 1.5625000 4.3750000 1.5625000 4.3750000 12.250000 4.3750000 1.5625000 4.3750000 1.5625000 -DEAL:1:DG<2>(0)<->DG<2>(0)::4.0000000 +DEAL:1:DG<2>(0)<->DG<2>(0)::5.6568542 DEAL:1:DG<2>(0)<->DG<2>(0):: -DEAL:1:DG<2>(0)<->DG<2>(0)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 -DEAL:1:DG<2>(0)<->DG<2>(0)::8.0000000 +DEAL:1:DG<2>(0)<->DG<2>(0)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 +DEAL:1:DG<2>(0)<->DG<2>(0)::11.313708 DEAL:1:DG<2>(0)<->DG<2>(0)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 DEAL:1:DG<2>(0)<->DG<2>(0):: DEAL:1:CG<2>(1)<->CG<2>(1)::7.0710678 @@ -60,10 +60,10 @@ DEAL:1:DG<2>(1)<->CG<2>(1)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1. DEAL:1:DG<2>(1)<->CG<2>(1)::33.941125 DEAL:1:DG<2>(1)<->CG<2>(1)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 DEAL:1:DG<2>(1)<->CG<2>(1):: -DEAL:1:DG<2>(1)<->DG<2>(1)::8.0000000 +DEAL:1:DG<2>(1)<->DG<2>(1)::11.313708 DEAL:1:DG<2>(1)<->DG<2>(1):: -DEAL:1:DG<2>(1)<->DG<2>(1)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 0.0000000 0.0000000 1.0000000 1.0000000 0.0000000 0.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 0.0000000 0.0000000 1.0000000 1.0000000 0.0000000 0.0000000 0.0000000 0.0000000 1.0000000 0.0000000 0.0000000 0.0000000 1.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 1.0000000 0.0000000 0.0000000 0.0000000 1.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 -DEAL:1:DG<2>(1)<->DG<2>(1)::16.000000 +DEAL:1:DG<2>(1)<->DG<2>(1)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 +DEAL:1:DG<2>(1)<->DG<2>(1)::22.627417 DEAL:1:DG<2>(1)<->DG<2>(1)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 DEAL:1:DG<2>(1)<->DG<2>(1):: DEAL:1:CG<2>(2)<->CG<2>(2)::12.727922 @@ -78,10 +78,10 @@ DEAL:1:DG<2>(2)<->CG<2>(2)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1. DEAL:1:DG<2>(2)<->CG<2>(2)::47.906484 DEAL:1:DG<2>(2)<->CG<2>(2)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 DEAL:1:DG<2>(2)<->CG<2>(2):: -DEAL:1:DG<2>(2)<->DG<2>(2)::12.000000 +DEAL:1:DG<2>(2)<->DG<2>(2)::16.970563 DEAL:1:DG<2>(2)<->DG<2>(2):: -DEAL:1:DG<2>(2)<->DG<2>(2)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 0.0000000 1.0000000 1.0000000 1.0000000 0.0000000 1.0000000 1.0000000 1.0000000 1.0000000 0.0000000 1.0000000 1.0000000 1.0000000 0.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 0.0000000 1.0000000 0.0000000 1.0000000 0.0000000 1.0000000 1.0000000 1.0000000 1.0000000 0.0000000 1.0000000 0.0000000 1.0000000 0.0000000 1.0000000 0.0000000 1.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 1.0000000 0.0000000 1.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 1.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 1.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 1.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 0.0000000 -DEAL:1:DG<2>(2)<->DG<2>(2)::30.750000 +DEAL:1:DG<2>(2)<->DG<2>(2)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 +DEAL:1:DG<2>(2)<->DG<2>(2)::43.487067 DEAL:1:DG<2>(2)<->DG<2>(2)::1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 DEAL:1:DG<2>(2)<->DG<2>(2):: -- 2.39.5