bool do_zero = false;
for (unsigned int j = 0; j < fe.n_dofs_per_cell(); ++j)
- if (matrix_other(i, j) != 0.)
+ if (std::fabs(matrix_other(i, j)) > 1e-12)
do_zero = true;
if (do_zero)
const std::function<bool()> &has_children_function,
const std::function<void(std::vector<types::global_dof_index> &)>
&get_dof_indices_function,
- const std::function<unsigned int()> &active_fe_index_function)
+ const std::function<unsigned int()> &active_fe_index_function,
+ const std::function<std::uint8_t()> &refinement_case_function)
: has_children_function(has_children_function)
, get_dof_indices_function(get_dof_indices_function)
, active_fe_index_function(active_fe_index_function)
+ , refinement_case_function(refinement_case_function)
{}
/**
{
return active_fe_index_function();
}
+ /**
+ * Get refinement choice.
+ */
+ std::uint8_t
+ refinement_case() const
+ {
+ return refinement_case_function();
+ }
private:
/**
* Lambda function returning active FE index.
*/
const std::function<unsigned int()> active_fe_index_function;
+
+ /**
+ * Lambda function returning the refinement choice.
+ */
+ const std::function<std::uint8_t()> refinement_case_function;
};
else
return cell->as_dof_handler_level_iterator(this->dof_handler_fine)
->active_fe_index();
+ },
+ []() {
+ DEAL_II_ASSERT_UNREACHABLE();
+ return 0;
});
}
return false;
},
[](auto &) { DEAL_II_ASSERT_UNREACHABLE(); },
+ []() {
+ DEAL_II_ASSERT_UNREACHABLE();
+ return 0;
+ },
[]() {
DEAL_II_ASSERT_UNREACHABLE();
return 0;
{
return cell->active_fe_index();
}
+ },
+ []() {
+ DEAL_II_ASSERT_UNREACHABLE(); // only children have the correct info
+ return 0;
});
}
{
return cell->child(c)->active_fe_index();
}
+ },
+ [this, cell]() {
+ if (this->mg_level_fine == numbers::invalid_unsigned_int)
+ {
+ const auto cell_id = cell->id();
+ const auto cell_raw =
+ dof_handler_fine.get_triangulation().create_cell_iterator(
+ cell_id);
+ return cell_raw->refinement_case();
+ }
+ else
+ {
+ return cell->refinement_case();
+ }
});
}
cell->get_mg_dof_indices(indices);
buffer.push_back(cell->active_fe_index());
+ if (cell->level() != 0)
+ buffer.push_back(cell->parent()->refinement_case());
+ else
+ buffer.push_back(numbers::invalid_dof_index);
buffer.insert(buffer.end(), indices.begin(), indices.end());
}
for (unsigned int i = 0, k = 0; i < ids.size(); ++i)
{
const unsigned int active_fe_index = buffer[k++];
-
+ const std::uint8_t refinement_case =
+ static_cast<std::uint8_t>(buffer[k++]);
indices.resize(
dof_handler_fine.get_fe(active_fe_index).n_dofs_per_cell());
for (unsigned int j = 0; j < indices.size(); ++j, ++k)
indices[j] = buffer[k];
- map[ids[i]] = {active_fe_index, indices};
+ remote_cell_info_map[ids[i]] = {active_fe_index,
+ indices,
+ refinement_case};
}
}
const bool is_cell_locally_owned =
this->is_dst_locally_owned.is_element(id);
- const bool is_cell_remotly_owned = this->is_dst_remote.is_element(id);
+ const bool is_cell_remotely_owned = this->is_dst_remote.is_element(id);
const bool has_cell_any_children = [&]() {
for (unsigned int i = 0; i < GeometryInfo<dim>::max_children_per_cell;
return true;
}
- AssertThrow(is_cell_locally_owned || is_cell_remotly_owned,
+ AssertThrow(is_cell_locally_owned || is_cell_remotely_owned,
ExcInternalError());
return false;
return FineDoFHandlerViewCell(
[has_cell_any_children]() { return has_cell_any_children; },
- [cell, is_cell_locally_owned, is_cell_remotly_owned, id, this](
+ [cell, is_cell_locally_owned, is_cell_remotely_owned, id, this](
auto &dof_indices) {
if (is_cell_locally_owned)
{
else
cell_fine->get_mg_dof_indices(dof_indices);
}
- else if (is_cell_remotly_owned)
+ else if (is_cell_remotely_owned)
{
- dof_indices = map.at(id).second;
+ dof_indices = std::get<1>(remote_cell_info_map.at(id));
}
else
{
AssertThrow(false, ExcNotImplemented()); // should not happen!
}
},
- [cell, is_cell_locally_owned, is_cell_remotly_owned, id, this]()
+ [cell, is_cell_locally_owned, is_cell_remotely_owned, id, this]()
-> unsigned int {
if (is_cell_locally_owned)
{
&dof_handler_fine))
->active_fe_index();
}
- else if (is_cell_remotly_owned)
+ else if (is_cell_remotely_owned)
{
- return map.at(id).first;
+ return std::get<0>(remote_cell_info_map.at(id));
}
else
{
AssertThrow(false, ExcNotImplemented()); // should not happen!
return 0;
}
+ },
+ []() -> std::uint8_t {
+ AssertThrow(false,
+ ExcNotImplemented()); // only children hold correct info
+ return 0;
});
}
}
else if (is_cell_remotely_owned)
{
- dof_indices = map.at(id).second;
+ dof_indices = std::get<1>(remote_cell_info_map.at(id));
}
else
{
// children
return 0;
+ },
+ [cell, is_cell_locally_owned, is_cell_remotely_owned, id, this]() {
+ if (is_cell_locally_owned &&
+ (mg_level_fine == numbers::invalid_unsigned_int))
+ {
+ const auto cell_fine = (typename DoFHandler<dim>::cell_iterator(
+ *dof_handler_fine.get_triangulation().create_cell_iterator(
+ cell->id()),
+ &dof_handler_fine));
+ return cell_fine->refinement_case();
+ }
+ else if (is_cell_locally_owned)
+ {
+ return cell->refinement_case();
+ }
+
+ else if (is_cell_remotely_owned)
+ {
+ return RefinementCase<dim>(
+ std::get<2>(remote_cell_info_map.at(id)));
+ }
+ else
+ {
+ AssertThrow(false, ExcNotImplemented());
+ }
+ // return no refinement
+ return RefinementCase<dim>(0);
});
}
IndexSet is_src_locally_owned;
std::map<types::global_cell_index,
- std::pair<unsigned int, std::vector<types::global_dof_index>>>
- map;
+ std::tuple<unsigned int,
+ std::vector<types::global_dof_index>,
+ std::uint8_t>>
+ remote_cell_info_map;
};
template <int dim>
AssertDimension(min_active_fe_indices[0], max_active_fe_indices[0]);
AssertDimension(min_active_fe_indices[1], max_active_fe_indices[1]);
- // set up two mg-schemes
+ const auto reference_cell = dof_handler_fine.get_fe(0).reference_cell();
+ // set up mg-schemes
// (0) no refinement -> identity
// (1) h-refinement
- transfer.schemes.resize(2);
+ // (2) h-refinement chocie II <- e.g. for Tets
+ // .
+ // .
+ // .
+ transfer.schemes.resize(1 +
+ reference_cell.n_isotropic_refinement_choices());
const unsigned int fe_index_fine = min_active_fe_indices[0];
const unsigned int fe_index_coarse = min_active_fe_indices[1];
transfer.n_components = fe_fine.n_components();
- const auto reference_cell = dof_handler_fine.get_fe(0).reference_cell();
-
// helper function: to process the fine level cells; function @p fu_non_refined is
// performed on cells that are not refined and @fu_refined is performed on
// children of cells that are refined
AssertDimension(fe_coarse.n_dofs_per_cell(), fe_fine.n_dofs_per_cell());
- const bool is_feq =
- fe_fine.n_base_elements() == 1 &&
- (dynamic_cast<const FE_Q<dim> *>(&fe_fine.base_element(0)) != nullptr);
-
- // number of dofs on coarse and fine cells
- transfer.schemes[0].n_dofs_per_cell_coarse =
- transfer.schemes[0].n_dofs_per_cell_fine =
- transfer.schemes[1].n_dofs_per_cell_coarse =
- fe_coarse.n_dofs_per_cell();
- transfer.schemes[1].n_dofs_per_cell_fine =
- is_feq ? (fe_fine.n_components() *
- Utilities::pow(2 * fe_fine.degree + 1, dim)) :
- (fe_coarse.n_dofs_per_cell() *
- GeometryInfo<dim>::max_children_per_cell);
-
- // degree of FE on coarse and fine cell
- transfer.schemes[0].degree_coarse = transfer.schemes[0].degree_fine =
- transfer.schemes[1].degree_coarse = fe_coarse.degree;
- transfer.schemes[1].degree_fine =
- is_feq ? (fe_coarse.degree * 2) : (fe_coarse.degree * 2 + 1);
+ const bool is_feq = fe_fine.n_base_elements() == 1 &&
+ ((dynamic_cast<const FE_Q<dim> *>(
+ &fe_fine.base_element(0)) != nullptr));
+
+ for (auto &scheme : transfer.schemes)
+ {
+ // number of dofs on coarse and fine cells
+ scheme.n_dofs_per_cell_coarse = fe_coarse.n_dofs_per_cell();
+ scheme.n_dofs_per_cell_fine =
+ is_feq ? (fe_fine.n_components() *
+ Utilities::pow(2 * fe_fine.degree + 1, dim)) :
+ (fe_coarse.n_dofs_per_cell() *
+ GeometryInfo<dim>::max_children_per_cell);
+
+ // degree of FE on coarse and fine cell
+ scheme.degree_coarse = fe_coarse.degree;
+ scheme.degree_fine =
+ is_feq ? (fe_coarse.degree * 2) : (fe_coarse.degree * 2 + 1);
+
+ // reset number of coarse cells
+ scheme.n_coarse_cells = 0;
+ }
+ // correct for first scheme
+ transfer.schemes[0].n_dofs_per_cell_fine = fe_coarse.n_dofs_per_cell();
+ transfer.schemes[0].degree_fine = fe_coarse.degree;
// continuous or discontinuous
- transfer.fine_element_is_continuous = fe_fine.n_dofs_per_vertex() > 0;
+ transfer.fine_element_is_continuous = fe_fine.n_dofs_per_vertex() > 0;
+ std::uint8_t current_refinement_case = static_cast<std::uint8_t>(-1);
- // count coarse cells for each scheme (0, 1)
+ // count coarse cells for each scheme (0, 1, ...)
{
- transfer.schemes[0].n_coarse_cells = 0; // reset
- transfer.schemes[1].n_coarse_cells = 0;
-
// count by looping over all coarse cells
process_cells(
[&](const auto &, const auto &) {
transfer.schemes[0].n_coarse_cells++;
},
- [&](const auto &, const auto &, const auto c) {
+ [&](const auto &, const auto &cell_fine, const auto c) {
+ std::uint8_t refinement_case = cell_fine.refinement_case();
+ // Assert triggers if cell has no children
+ if (reference_cell == ReferenceCells::Tetrahedron)
+ Assert(RefinementCase<dim>(refinement_case) ==
+ RefinementCase<dim>(static_cast<std::uint8_t>(
+ IsotropicRefinementChoice::cut_tet_68)) ||
+ RefinementCase<dim>(refinement_case) ==
+ RefinementCase<dim>(static_cast<std::uint8_t>(
+ IsotropicRefinementChoice::cut_tet_57)) ||
+ RefinementCase<dim>(refinement_case) ==
+ RefinementCase<dim>(static_cast<std::uint8_t>(
+ IsotropicRefinementChoice::cut_tet_49)),
+ ExcNotImplemented());
+ else
+ {
+ Assert(RefinementCase<dim>(refinement_case) ==
+ RefinementCase<dim>::isotropic_refinement,
+ ExcNotImplemented());
+ refinement_case = 1;
+ }
+
if (c == 0)
- transfer.schemes[1].n_coarse_cells++;
+ {
+ transfer.schemes[refinement_case].n_coarse_cells++;
+ current_refinement_case = refinement_case;
+ }
+ else
+ // Check that all children have the same refinement case
+ AssertThrow(current_refinement_case == refinement_case,
+ ExcNotImplemented());
});
}
}
// ------------------------------ indices ------------------------------
- std::vector<types::global_dof_index> level_dof_indices_fine_0(
+ std::vector<types::global_dof_index> level_dof_indices_coarse(
transfer.schemes[0].n_dofs_per_cell_fine);
- std::vector<types::global_dof_index> level_dof_indices_fine_1(
+ std::vector<types::global_dof_index> level_dof_indices_fine(
transfer.schemes[1].n_dofs_per_cell_fine);
- unsigned int cell_no_0 = 0;
- unsigned int cell_no_1 = transfer.schemes[0].n_coarse_cells;
+
+ unsigned int n_coarse_cells_total = 0;
+ for (const auto &scheme : transfer.schemes)
+ n_coarse_cells_total += scheme.n_coarse_cells;
transfer.constraint_info_coarse.reinit(
dof_handler_coarse,
- transfer.schemes[0].n_coarse_cells +
- transfer.schemes[1].n_coarse_cells,
+ n_coarse_cells_total,
constraints_coarse.n_constraints() > 0 &&
use_fast_hanging_node_algorithm(dof_handler_coarse,
mg_level_coarse));
dof_handler_coarse.locally_owned_dofs() :
dof_handler_coarse.locally_owned_mg_dofs(mg_level_coarse));
- transfer.constraint_info_fine.reinit(
- transfer.schemes[0].n_coarse_cells +
- transfer.schemes[1].n_coarse_cells);
+ transfer.constraint_info_fine.reinit(n_coarse_cells_total);
transfer.constraint_info_fine.set_locally_owned_indices(
(mg_level_fine == numbers::invalid_unsigned_int) ?
dof_handler_fine.locally_owned_dofs() :
dof_handler_fine.locally_owned_mg_dofs(mg_level_fine));
+
+ std::vector<unsigned int> cell_no(transfer.schemes.size(), 0);
+ for (unsigned int i = 1; i < transfer.schemes.size(); ++i)
+ cell_no[i] = cell_no[i - 1] + transfer.schemes[i - 1].n_coarse_cells;
+
process_cells(
[&](const auto &cell_coarse, const auto &cell_fine) {
+ // first process cells with scheme 0
// parent
{
transfer.constraint_info_coarse.read_dof_indices(
- cell_no_0,
+ cell_no[0],
mg_level_coarse,
cell_coarse,
constraints_coarse,
for (unsigned int i = 0;
i < transfer.schemes[0].n_dofs_per_cell_coarse;
i++)
- level_dof_indices_fine_0[i] =
+ level_dof_indices_coarse[i] =
local_dof_indices[lexicographic_numbering_fine[i]];
transfer.constraint_info_fine.read_dof_indices(
- cell_no_0, level_dof_indices_fine_0, {});
+ cell_no[0], level_dof_indices_coarse, {});
}
// move pointers
{
- cell_no_0++;
+ ++cell_no[0];
}
},
[&](const auto &cell_coarse, const auto &cell_fine, const auto c) {
+ // process rest of cells
+ const std::uint8_t refinement_case =
+ reference_cell == ReferenceCells::Tetrahedron ?
+ cell_fine.refinement_case() :
+ 1;
// parent (only once at the beginning)
if (c == 0)
{
transfer.constraint_info_coarse.read_dof_indices(
- cell_no_1,
+ cell_no[refinement_case],
mg_level_coarse,
cell_coarse,
constraints_coarse,
{});
- level_dof_indices_fine_1.assign(level_dof_indices_fine_1.size(),
- numbers::invalid_dof_index);
+ level_dof_indices_fine.assign(level_dof_indices_fine.size(),
+ numbers::invalid_dof_index);
}
// child
{
cell_fine.get_dof_indices(local_dof_indices);
for (unsigned int i = 0;
- i < transfer.schemes[1].n_dofs_per_cell_coarse;
+ i < transfer.schemes[refinement_case].n_dofs_per_cell_coarse;
++i)
{
const auto index =
local_dof_indices[lexicographic_numbering_fine[i]];
+ Assert(
+ level_dof_indices_fine[cell_local_children_indices[c][i]] ==
+ numbers::invalid_dof_index ||
+ level_dof_indices_fine[cell_local_children_indices[c]
+ [i]] ==
+ index,
+ ExcInternalError());
- Assert(level_dof_indices_fine_1
- [cell_local_children_indices[c][i]] ==
- numbers::invalid_dof_index ||
- level_dof_indices_fine_1
- [cell_local_children_indices[c][i]] == index,
- ExcInternalError());
-
- level_dof_indices_fine_1[cell_local_children_indices[c][i]] =
+ level_dof_indices_fine[cell_local_children_indices[c][i]] =
index;
}
}
if (c + 1 == GeometryInfo<dim>::max_children_per_cell)
{
transfer.constraint_info_fine.read_dof_indices(
- cell_no_1, level_dof_indices_fine_1, {});
+ cell_no[refinement_case], level_dof_indices_fine, {});
- cell_no_1++;
+ ++cell_no[refinement_case];
}
});
}
// nothing to do since for identity prolongation matrices a short-cut
// code path is used during prolongation/restriction
- // ----------------------- prolongation matrix (1) -----------------------
+ // -------------------prolongation matrix (i = 1 ... n)-------------------
{
AssertDimension(fe_fine.n_base_elements(), 1);
- if (reference_cell == ReferenceCells::get_hypercube<dim>())
+ for (unsigned int transfer_scheme_index = 1;
+ transfer_scheme_index < transfer.schemes.size();
+ ++transfer_scheme_index)
{
- const auto fe = create_1D_fe(fe_fine.base_element(0));
-
- std::vector<unsigned int> renumbering(fe->n_dofs_per_cell());
- {
- AssertIndexRange(fe->n_dofs_per_vertex(), 2);
- renumbering[0] = 0;
- for (unsigned int i = 0; i < fe->dofs_per_line; ++i)
- renumbering[i + fe->n_dofs_per_vertex()] =
- GeometryInfo<1>::vertices_per_cell * fe->n_dofs_per_vertex() +
- i;
- if (fe->n_dofs_per_vertex() > 0)
- renumbering[fe->n_dofs_per_cell() - fe->n_dofs_per_vertex()] =
- fe->n_dofs_per_vertex();
- }
+ if (reference_cell == ReferenceCells::get_hypercube<dim>())
+ {
+ const auto fe = create_1D_fe(fe_fine.base_element(0));
- // TODO: data structures are saved in form of DG data structures
- // here
- const unsigned int shift =
- is_feq ? (fe->n_dofs_per_cell() - fe->n_dofs_per_vertex()) :
- (fe->n_dofs_per_cell());
- const unsigned int n_child_dofs_1d =
- is_feq ? (fe->n_dofs_per_cell() * 2 - fe->n_dofs_per_vertex()) :
- (fe->n_dofs_per_cell() * 2);
+ std::vector<unsigned int> renumbering(fe->n_dofs_per_cell());
+ {
+ AssertIndexRange(fe->n_dofs_per_vertex(), 2);
+ renumbering[0] = 0;
+ for (unsigned int i = 0; i < fe->dofs_per_line; ++i)
+ renumbering[i + fe->n_dofs_per_vertex()] =
+ GeometryInfo<1>::vertices_per_cell *
+ fe->n_dofs_per_vertex() +
+ i;
+ if (fe->n_dofs_per_vertex() > 0)
+ renumbering[fe->n_dofs_per_cell() -
+ fe->n_dofs_per_vertex()] =
+ fe->n_dofs_per_vertex();
+ }
- {
- transfer.schemes[1].prolongation_matrix_1d.resize(
- fe->n_dofs_per_cell() * n_child_dofs_1d);
-
- for (unsigned int c = 0;
- c < GeometryInfo<1>::max_children_per_cell;
- ++c)
- for (unsigned int i = 0; i < fe->n_dofs_per_cell(); ++i)
- for (unsigned int j = 0; j < fe->n_dofs_per_cell(); ++j)
- transfer.schemes[1]
- .prolongation_matrix_1d[i * n_child_dofs_1d + j +
- c * shift] =
- fe->get_prolongation_matrix(c)(renumbering[j],
- renumbering[i]);
- }
- {
- transfer.schemes[1].restriction_matrix_1d.resize(
- fe->n_dofs_per_cell() * n_child_dofs_1d);
+ // TODO: data structures are saved in form of DG data structures
+ // here
+ const unsigned int shift =
+ is_feq ? (fe->n_dofs_per_cell() - fe->n_dofs_per_vertex()) :
+ (fe->n_dofs_per_cell());
+ const unsigned int n_child_dofs_1d =
+ is_feq ?
+ (fe->n_dofs_per_cell() * 2 - fe->n_dofs_per_vertex()) :
+ (fe->n_dofs_per_cell() * 2);
- for (unsigned int c = 0;
- c < GeometryInfo<1>::max_children_per_cell;
- ++c)
{
- const auto matrix = get_restriction_matrix(*fe, c);
- for (unsigned int i = 0; i < fe->n_dofs_per_cell(); ++i)
- for (unsigned int j = 0; j < fe->n_dofs_per_cell(); ++j)
- transfer.schemes[1]
- .restriction_matrix_1d[i * n_child_dofs_1d + j +
- c * shift] +=
- matrix(renumbering[i], renumbering[j]);
+ transfer.schemes[transfer_scheme_index]
+ .prolongation_matrix_1d.resize(fe->n_dofs_per_cell() *
+ n_child_dofs_1d);
+
+ for (unsigned int c = 0;
+ c < GeometryInfo<1>::max_children_per_cell;
+ ++c)
+ for (unsigned int i = 0; i < fe->n_dofs_per_cell(); ++i)
+ for (unsigned int j = 0; j < fe->n_dofs_per_cell(); ++j)
+ transfer.schemes[transfer_scheme_index]
+ .prolongation_matrix_1d[i * n_child_dofs_1d + j +
+ c * shift] =
+ fe->get_prolongation_matrix(c)(renumbering[j],
+ renumbering[i]);
}
- }
- }
- else
- {
- const auto &fe = fe_fine.base_element(0);
- const unsigned int n_dofs_per_cell = fe.n_dofs_per_cell();
+ {
+ transfer.schemes[transfer_scheme_index]
+ .restriction_matrix_1d.resize(fe->n_dofs_per_cell() *
+ n_child_dofs_1d);
- {
- transfer.schemes[1].prolongation_matrix.resize(
- n_dofs_per_cell * n_dofs_per_cell *
- GeometryInfo<dim>::max_children_per_cell);
+ for (unsigned int c = 0;
+ c < GeometryInfo<1>::max_children_per_cell;
+ ++c)
+ {
+ const auto matrix = get_restriction_matrix(*fe, c);
+ for (unsigned int i = 0; i < fe->n_dofs_per_cell(); ++i)
+ for (unsigned int j = 0; j < fe->n_dofs_per_cell(); ++j)
+ transfer.schemes[transfer_scheme_index]
+ .restriction_matrix_1d[i * n_child_dofs_1d + j +
+ c * shift] +=
+ matrix(renumbering[i], renumbering[j]);
+ }
+ }
+ }
+ else
+ {
+ const auto &fe = fe_fine.base_element(0);
+ const unsigned int n_dofs_per_cell = fe.n_dofs_per_cell();
- for (unsigned int c = 0;
- c < GeometryInfo<dim>::max_children_per_cell;
- ++c)
{
- const auto matrix =
- reference_cell == ReferenceCells::Tetrahedron ?
- fe.get_prolongation_matrix(c, RefinementCase<dim>(1)) :
- fe.get_prolongation_matrix(c);
-
-
- for (unsigned int i = 0; i < n_dofs_per_cell; ++i)
- for (unsigned int j = 0; j < n_dofs_per_cell; ++j)
- transfer.schemes[1].prolongation_matrix
- [i * n_dofs_per_cell *
- GeometryInfo<dim>::max_children_per_cell +
- j + c * n_dofs_per_cell] = matrix(j, i);
- }
- }
- {
- transfer.schemes[1].restriction_matrix.resize(
- n_dofs_per_cell * n_dofs_per_cell *
- GeometryInfo<dim>::max_children_per_cell);
+ transfer.schemes[transfer_scheme_index]
+ .prolongation_matrix.resize(
+ n_dofs_per_cell * n_dofs_per_cell *
+ GeometryInfo<dim>::max_children_per_cell);
- for (unsigned int c = 0;
- c < GeometryInfo<dim>::max_children_per_cell;
- ++c)
+ for (unsigned int c = 0;
+ c < GeometryInfo<dim>::max_children_per_cell;
+ ++c)
+ {
+ const auto matrix =
+ reference_cell == ReferenceCells::Tetrahedron ?
+ fe.get_prolongation_matrix(
+ c, RefinementCase<dim>(transfer_scheme_index)) :
+ fe.get_prolongation_matrix(c);
+
+
+ for (unsigned int i = 0; i < n_dofs_per_cell; ++i)
+ for (unsigned int j = 0; j < n_dofs_per_cell; ++j)
+ transfer.schemes[transfer_scheme_index]
+ .prolongation_matrix
+ [i * n_dofs_per_cell *
+ GeometryInfo<dim>::max_children_per_cell +
+ j + c * n_dofs_per_cell] = matrix(j, i);
+ }
+ }
{
- const auto matrix =
- reference_cell == ReferenceCells::Tetrahedron ?
- get_restriction_matrix(fe, c, RefinementCase<dim>(1)) :
- get_restriction_matrix(fe, c);
- for (unsigned int i = 0; i < n_dofs_per_cell; ++i)
- for (unsigned int j = 0; j < n_dofs_per_cell; ++j)
- transfer.schemes[1].restriction_matrix
- [i * n_dofs_per_cell *
- GeometryInfo<dim>::max_children_per_cell +
- j + c * n_dofs_per_cell] += matrix(i, j);
+ transfer.schemes[transfer_scheme_index]
+ .restriction_matrix.resize(
+ n_dofs_per_cell * n_dofs_per_cell *
+ GeometryInfo<dim>::max_children_per_cell);
+
+ for (unsigned int c = 0;
+ c < GeometryInfo<dim>::max_children_per_cell;
+ ++c)
+ {
+ const auto matrix =
+ reference_cell == ReferenceCells::Tetrahedron ?
+ get_restriction_matrix(
+ fe, c, RefinementCase<dim>(transfer_scheme_index)) :
+ get_restriction_matrix(fe, c);
+ for (unsigned int i = 0; i < n_dofs_per_cell; ++i)
+ for (unsigned int j = 0; j < n_dofs_per_cell; ++j)
+ transfer.schemes[transfer_scheme_index]
+ .restriction_matrix
+ [i * n_dofs_per_cell *
+ GeometryInfo<dim>::max_children_per_cell +
+ j + c * n_dofs_per_cell] += matrix(i, j);
+ }
}
- }
+ }
}
}
}
const bool needs_interpolation =
- (scheme.prolongation_matrix.empty() &&
- scheme.prolongation_matrix_1d.empty()) == false;
+ (scheme.restriction_matrix.empty() &&
+ scheme.restriction_matrix_1d.empty()) == false;
// general case -> local restriction is needed
evaluation_data_fine.resize(scheme.n_dofs_per_cell_fine);
-DEAL:0:CG<2>(1)<->CG<2>(1)::3.0618622
-DEAL:0:CG<2>(1)<->CG<2>(1)::0.0000000 0.50000000 0.0000000 0.50000000 1.0000000 1.0000000 0.0000000 0.50000000 1.0000000
-DEAL:0:CG<2>(1)<->CG<2>(1)::0.0000000 0.25000000 0.0000000 0.25000000 0.50000000 0.50000000 0.0000000 0.25000000 0.50000000 0.75000000 0.75000000 1.0000000 1.0000000 0.75000000 1.0000000 0.0000000 0.25000000 0.50000000 0.0000000 0.25000000 0.50000000 0.75000000 1.0000000 0.75000000 1.0000000
-DEAL:0:CG<2>(1)<->CG<2>(1)::4.9702238
-DEAL:0:CG<2>(1)<->CG<2>(1)::0.0000000 0.25000000 0.0000000 0.25000000 0.50000000 0.50000000 0.0000000 0.25000000 0.50000000 0.75000000 0.75000000 1.0000000 1.0000000 0.75000000 1.0000000 0.0000000 0.25000000 0.50000000 0.0000000 0.25000000 0.50000000 0.75000000 1.0000000 0.75000000 1.0000000
-DEAL:0:CG<2>(1)<->CG<2>(1)::0.18750000 1.5000000 0.25000000 2.0000000 2.0625000 2.7500000 0.18750000 1.5000000 2.0625000
-DEAL:0:CG<2>(2)<->CG<2>(2)::5.3560713
-DEAL:0:CG<2>(2)<->CG<2>(2)::0.0000000 0.50000000 0.0000000 0.50000000 0.0000000 0.50000000 0.25000000 0.25000000 0.25000000 1.0000000 1.0000000 1.0000000 0.75000000 0.75000000 0.75000000 0.0000000 0.50000000 0.0000000 0.50000000 0.25000000 0.25000000 1.0000000 1.0000000 0.75000000 0.75000000
-DEAL:0:CG<2>(2)<->CG<2>(2)::0.0000000 0.25000000 0.0000000 0.25000000 0.0000000 0.25000000 0.12500000 0.12500000 0.12500000 0.50000000 0.50000000 0.50000000 0.37500000 0.37500000 0.37500000 0.0000000 0.25000000 0.0000000 0.25000000 0.12500000 0.12500000 0.50000000 0.50000000 0.37500000 0.37500000 0.75000000 0.75000000 0.75000000 0.62500000 0.62500000 0.62500000 1.0000000 1.0000000 1.0000000 0.87500000 0.87500000 0.87500000 0.75000000 0.75000000 0.62500000 0.62500000 1.0000000 1.0000000 0.87500000 0.87500000 0.0000000 0.25000000 0.0000000 0.25000000 0.12500000 0.12500000 0.50000000 0.50000000 0.37500000 0.37500000 0.0000000 0.25000000 0.0000000 0.25000000 0.12500000 0.12500000 0.50000000 0.50000000 0.37500000 0.37500000 0.75000000 0.75000000 0.62500000 0.62500000 1.0000000 1.0000000 0.87500000 0.87500000 0.75000000 0.75000000 0.62500000 0.62500000 1.0000000 1.0000000 0.87500000 0.87500000
-DEAL:0:CG<2>(2)<->CG<2>(2)::10.383092
-DEAL:0:CG<2>(2)<->CG<2>(2)::0.0000000 0.25000000 0.0000000 0.25000000 0.0000000 0.25000000 0.12500000 0.12500000 0.12500000 0.50000000 0.50000000 0.50000000 0.37500000 0.37500000 0.37500000 0.0000000 0.25000000 0.0000000 0.25000000 0.12500000 0.12500000 0.50000000 0.50000000 0.37500000 0.37500000 0.75000000 0.75000000 0.75000000 0.62500000 0.62500000 0.62500000 1.0000000 1.0000000 1.0000000 0.87500000 0.87500000 0.87500000 0.75000000 0.75000000 0.62500000 0.62500000 1.0000000 1.0000000 0.87500000 0.87500000 0.0000000 0.25000000 0.0000000 0.25000000 0.12500000 0.12500000 0.50000000 0.50000000 0.37500000 0.37500000 0.0000000 0.25000000 0.0000000 0.25000000 0.12500000 0.12500000 0.50000000 0.50000000 0.37500000 0.37500000 0.75000000 0.75000000 0.62500000 0.62500000 1.0000000 1.0000000 0.87500000 0.87500000 0.75000000 0.75000000 0.62500000 0.62500000 1.0000000 1.0000000 0.87500000 0.87500000
-DEAL:0:CG<2>(2)<->CG<2>(2)::0.0000000 0.93750000 0.0000000 1.1250000 0.0000000 1.8750000 0.78125000 0.93750000 1.5625000 1.5625000 1.8750000 3.1250000 2.3437500 2.8125000 4.6875000 0.0000000 0.93750000 0.0000000 1.8750000 0.78125000 1.5625000 1.5625000 3.1250000 2.3437500 4.6875000
-DEAL:0:CG<2>(3)<->CG<2>(3)::7.6697458
-DEAL:0:CG<2>(3)<->CG<2>(3)::0.0000000 0.50000000 0.0000000 0.50000000 0.0000000 0.0000000 0.50000000 0.50000000 0.13819660 0.36180340 0.13819660 0.36180340 0.13819660 0.36180340 0.13819660 0.36180340 1.0000000 1.0000000 1.0000000 1.0000000 0.63819660 0.86180340 0.63819660 0.86180340 0.63819660 0.86180340 0.63819660 0.86180340 0.0000000 0.50000000 0.0000000 0.0000000 0.50000000 0.50000000 0.13819660 0.36180340 0.13819660 0.36180340 0.13819660 0.36180340 1.0000000 1.0000000 1.0000000 0.63819660 0.86180340 0.63819660 0.86180340 0.63819660 0.86180340
-DEAL:0:CG<2>(3)<->CG<2>(3)::0.0000000 0.25000000 0.0000000 0.25000000 0.0000000 0.0000000 0.25000000 0.25000000 0.069098301 0.18090170 0.069098301 0.18090170 0.069098301 0.18090170 0.069098301 0.18090170 0.50000000 0.50000000 0.50000000 0.50000000 0.31909830 0.43090170 0.31909830 0.43090170 0.31909830 0.43090170 0.31909830 0.43090170 0.0000000 0.25000000 0.0000000 0.0000000 0.25000000 0.25000000 0.069098301 0.18090170 0.069098301 0.18090170 0.069098301 0.18090170 0.50000000 0.50000000 0.50000000 0.31909830 0.43090170 0.31909830 0.43090170 0.31909830 0.43090170 0.75000000 0.75000000 0.75000000 0.75000000 0.56909830 0.68090170 0.56909830 0.68090170 0.56909830 0.68090170 0.56909830 0.68090170 1.0000000 1.0000000 1.0000000 1.0000000 0.81909830 0.93090170 0.81909830 0.93090170 0.81909830 0.93090170 0.81909830 0.93090170 0.75000000 0.75000000 0.75000000 0.56909830 0.68090170 0.56909830 0.68090170 0.56909830 0.68090170 1.0000000 1.0000000 1.0000000 0.81909830 0.93090170 0.81909830 0.93090170 0.81909830 0.93090170 0.0000000 0.25000000 0.0000000 0.0000000 0.25000000 0.25000000 0.069098301 0.18090170 0.069098301 0.18090170 0.069098301 0.18090170 0.50000000 0.50000000 0.50000000 0.31909830 0.43090170 0.31909830 0.43090170 0.31909830 0.43090170 0.0000000 0.25000000 0.0000000 0.0000000 0.25000000 0.25000000 0.069098301 0.18090170 0.069098301 0.18090170 0.069098301 0.18090170 0.50000000 0.50000000 0.50000000 0.31909830 0.43090170 0.31909830 0.43090170 0.31909830 0.43090170 0.75000000 0.75000000 0.75000000 0.56909830 0.68090170 0.56909830 0.68090170 0.56909830 0.68090170 1.0000000 1.0000000 1.0000000 0.81909830 0.93090170 0.81909830 0.93090170 0.81909830 0.93090170 0.75000000 0.75000000 0.75000000 0.56909830 0.68090170 0.56909830 0.68090170 0.56909830 0.68090170 1.0000000 1.0000000 1.0000000 0.81909830 0.93090170 0.81909830 0.93090170 0.81909830 0.93090170
-DEAL:0:CG<2>(3)<->CG<2>(3)::15.445755
-DEAL:0:CG<2>(3)<->CG<2>(3)::0.0000000 0.25000000 0.0000000 0.25000000 0.0000000 0.0000000 0.25000000 0.25000000 0.069098301 0.18090170 0.069098301 0.18090170 0.069098301 0.18090170 0.069098301 0.18090170 0.50000000 0.50000000 0.50000000 0.50000000 0.31909830 0.43090170 0.31909830 0.43090170 0.31909830 0.43090170 0.31909830 0.43090170 0.0000000 0.25000000 0.0000000 0.0000000 0.25000000 0.25000000 0.069098301 0.18090170 0.069098301 0.18090170 0.069098301 0.18090170 0.50000000 0.50000000 0.50000000 0.31909830 0.43090170 0.31909830 0.43090170 0.31909830 0.43090170 0.75000000 0.75000000 0.75000000 0.75000000 0.56909830 0.68090170 0.56909830 0.68090170 0.56909830 0.68090170 0.56909830 0.68090170 1.0000000 1.0000000 1.0000000 1.0000000 0.81909830 0.93090170 0.81909830 0.93090170 0.81909830 0.93090170 0.81909830 0.93090170 0.75000000 0.75000000 0.75000000 0.56909830 0.68090170 0.56909830 0.68090170 0.56909830 0.68090170 1.0000000 1.0000000 1.0000000 0.81909830 0.93090170 0.81909830 0.93090170 0.81909830 0.93090170 0.0000000 0.25000000 0.0000000 0.0000000 0.25000000 0.25000000 0.069098301 0.18090170 0.069098301 0.18090170 0.069098301 0.18090170 0.50000000 0.50000000 0.50000000 0.31909830 0.43090170 0.31909830 0.43090170 0.31909830 0.43090170 0.0000000 0.25000000 0.0000000 0.0000000 0.25000000 0.25000000 0.069098301 0.18090170 0.069098301 0.18090170 0.069098301 0.18090170 0.50000000 0.50000000 0.50000000 0.31909830 0.43090170 0.31909830 0.43090170 0.31909830 0.43090170 0.75000000 0.75000000 0.75000000 0.56909830 0.68090170 0.56909830 0.68090170 0.56909830 0.68090170 1.0000000 1.0000000 1.0000000 0.81909830 0.93090170 0.81909830 0.93090170 0.81909830 0.93090170 0.75000000 0.75000000 0.75000000 0.56909830 0.68090170 0.56909830 0.68090170 0.56909830 0.68090170 1.0000000 1.0000000 1.0000000 0.81909830 0.93090170 0.81909830 0.93090170 0.81909830 0.93090170
-DEAL:0:CG<2>(3)<->CG<2>(3)::-0.021093750 0.70312500 -0.023437500 0.78125000 -0.044531250 -0.044531250 1.4843750 1.4843750 0.41641110 0.91952640 0.46267900 1.0216960 0.87909011 1.9412224 0.87909011 1.9412224 1.2867187 1.4296875 2.7164063 2.7164063 1.7523486 2.2554639 1.9470540 2.5060710 3.6994026 4.7615349 3.6994026 4.7615349 -0.021093750 0.70312500 -0.044531250 -0.044531250 1.4843750 1.4843750 0.41641110 0.91952640 0.87909011 1.9412224 0.87909011 1.9412224 1.2867188 2.7164063 2.7164063 1.7523486 2.2554639 3.6994026 4.7615349 3.6994026 4.7615349
-DEAL:0:CG<2>(4)<->CG<2>(4)::9.9861511
-DEAL:0:CG<2>(4)<->CG<2>(4)::0.0000000 0.50000000 0.0000000 0.50000000 0.0000000 0.0000000 0.0000000 0.50000000 0.50000000 0.50000000 0.086336582 0.25000000 0.41366342 0.086336582 0.25000000 0.41366342 0.086336582 0.25000000 0.41366342 0.086336582 0.25000000 0.41366342 0.086336582 0.25000000 0.41366342 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 0.58633658 0.75000000 0.91366342 0.58633658 0.75000000 0.91366342 0.58633658 0.75000000 0.91366342 0.58633658 0.75000000 0.91366342 0.58633658 0.75000000 0.91366342 0.0000000 0.50000000 0.0000000 0.0000000 0.0000000 0.50000000 0.50000000 0.50000000 0.086336582 0.25000000 0.41366342 0.086336582 0.25000000 0.41366342 0.086336582 0.25000000 0.41366342 0.086336582 0.25000000 0.41366342 1.0000000 1.0000000 1.0000000 1.0000000 0.58633658 0.75000000 0.91366342 0.58633658 0.75000000 0.91366342 0.58633658 0.75000000 0.91366342 0.58633658 0.75000000 0.91366342
-DEAL:0:CG<2>(4)<->CG<2>(4)::0.0000000 0.25000000 0.0000000 0.25000000 0.0000000 0.0000000 0.0000000 0.25000000 0.25000000 0.25000000 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.50000000 0.50000000 0.50000000 0.50000000 0.50000000 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.0000000 0.25000000 0.0000000 0.0000000 0.0000000 0.25000000 0.25000000 0.25000000 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.50000000 0.50000000 0.50000000 0.50000000 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.75000000 0.75000000 0.75000000 0.75000000 0.75000000 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.75000000 0.75000000 0.75000000 0.75000000 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 1.0000000 1.0000000 1.0000000 1.0000000 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.0000000 0.25000000 0.0000000 0.0000000 0.0000000 0.25000000 0.25000000 0.25000000 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.50000000 0.50000000 0.50000000 0.50000000 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.0000000 0.25000000 0.0000000 0.0000000 0.0000000 0.25000000 0.25000000 0.25000000 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.50000000 0.50000000 0.50000000 0.50000000 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.75000000 0.75000000 0.75000000 0.75000000 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 1.0000000 1.0000000 1.0000000 1.0000000 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.75000000 0.75000000 0.75000000 0.75000000 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 1.0000000 1.0000000 1.0000000 1.0000000 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171
-DEAL:0:CG<2>(4)<->CG<2>(4)::20.810567
-DEAL:0:CG<2>(4)<->CG<2>(4)::0.0000000 0.25000000 0.0000000 0.25000000 0.0000000 0.0000000 0.0000000 0.25000000 0.25000000 0.25000000 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.50000000 0.50000000 0.50000000 0.50000000 0.50000000 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.0000000 0.25000000 0.0000000 0.0000000 0.0000000 0.25000000 0.25000000 0.25000000 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.50000000 0.50000000 0.50000000 0.50000000 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.75000000 0.75000000 0.75000000 0.75000000 0.75000000 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.75000000 0.75000000 0.75000000 0.75000000 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 1.0000000 1.0000000 1.0000000 1.0000000 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.0000000 0.25000000 0.0000000 0.0000000 0.0000000 0.25000000 0.25000000 0.25000000 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.50000000 0.50000000 0.50000000 0.50000000 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.0000000 0.25000000 0.0000000 0.0000000 0.0000000 0.25000000 0.25000000 0.25000000 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.50000000 0.50000000 0.50000000 0.50000000 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.75000000 0.75000000 0.75000000 0.75000000 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 1.0000000 1.0000000 1.0000000 1.0000000 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.75000000 0.75000000 0.75000000 0.75000000 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 1.0000000 1.0000000 1.0000000 1.0000000 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171
-DEAL:0:CG<2>(4)<->CG<2>(4)::-3.4694470e-18 0.85447724 -1.9081958e-17 1.0013652 -1.3877788e-17 -4.8572257e-17 -1.7347235e-17 1.2493373 2.1606744 1.2493373 0.18408253 0.92186504 0.88199239 0.21572703 1.0803372 1.0336103 0.26914839 1.3478655 1.2895674 0.46548041 2.3310746 2.2302506 0.26914839 1.3478655 1.2895674 1.4582719 1.7089545 2.1321498 3.6874601 2.1321498 1.2501574 2.7655951 1.9480673 1.4650644 3.2410116 2.2829476 1.8278642 4.0435965 2.8482832 3.1612114 6.9932239 4.9259816 1.8278642 4.0435965 2.8482832 -1.0408341e-17 0.85447724 -1.3877788e-17 -4.8572257e-17 -1.7347235e-17 1.2493373 2.1606744 1.2493373 0.18408253 0.92186504 0.88199239 0.26914839 1.3478655 1.2895674 0.46548041 2.3310746 2.2302506 0.26914839 1.3478655 1.2895674 1.4582719 2.1321498 3.6874601 2.1321498 1.2501574 2.7655951 1.9480673 1.8278642 4.0435965 2.8482832 3.1612114 6.9932239 4.9259816 1.8278642 4.0435965 2.8482832
-DEAL:0:CG<2>(1)<->CG<2>(1)::3.0618622
-DEAL:0:CG<2>(1)<->CG<2>(1)::0.0000000 0.50000000 0.0000000 1.0000000 0.50000000 0.0000000 1.0000000 0.50000000 1.0000000
-DEAL:0:CG<2>(1)<->CG<2>(1)::0.0000000 0.25000000 0.0000000 0.50000000 0.25000000 0.0000000 0.75000000 0.50000000 1.0000000 0.75000000 0.50000000 0.25000000 0.0000000 0.25000000 0.0000000 1.0000000 0.75000000 1.0000000 0.50000000 0.75000000 1.0000000 0.25000000 0.50000000 0.75000000 1.0000000
-DEAL:0:CG<2>(1)<->CG<2>(1)::4.9812147
-DEAL:0:CG<2>(1)<->CG<2>(1)::0.0000000 0.25000000 0.0000000 0.50000000 0.25000000 0.0000000 0.75000000 0.50000000 1.0000000 0.75000000 0.50000000 0.25000000 0.0000000 0.25000000 0.0000000 1.0000000 0.75000000 1.0000000 0.50000000 0.75000000 1.0000000 0.25000000 0.50000000 0.75000000 1.0000000
-DEAL:0:CG<2>(1)<->CG<2>(1)::0.12500000 1.3750000 0.25000000 2.2500000 2.0000000 0.25000000 1.8750000 1.6250000 2.7500000
-DEAL:0:CG<2>(2)<->CG<2>(2)::5.3560713
-DEAL:0:CG<2>(2)<->CG<2>(2)::0.0000000 0.50000000 0.0000000 0.25000000 0.25000000 0.0000000 1.0000000 0.50000000 0.75000000 0.75000000 0.50000000 0.0000000 0.25000000 0.25000000 0.0000000 1.0000000 0.50000000 1.0000000 0.75000000 0.75000000 1.0000000 0.25000000 0.50000000 0.75000000 1.0000000
-DEAL:0:CG<2>(2)<->CG<2>(2)::0.0000000 0.25000000 0.0000000 0.12500000 0.12500000 0.0000000 0.50000000 0.25000000 0.37500000 0.37500000 0.25000000 0.0000000 0.12500000 0.12500000 0.0000000 0.75000000 0.50000000 0.62500000 0.62500000 0.50000000 1.0000000 0.75000000 0.87500000 0.87500000 0.75000000 0.50000000 0.62500000 0.62500000 0.50000000 0.25000000 0.0000000 0.12500000 0.12500000 0.0000000 0.25000000 0.37500000 0.37500000 0.25000000 0.0000000 0.12500000 0.12500000 0.0000000 0.37500000 0.37500000 0.25000000 1.0000000 0.75000000 1.0000000 0.87500000 0.87500000 1.0000000 0.50000000 0.75000000 0.62500000 0.62500000 0.75000000 1.0000000 0.87500000 0.87500000 1.0000000 0.25000000 0.50000000 0.37500000 0.37500000 0.50000000 0.12500000 0.25000000 0.37500000 0.50000000 0.75000000 1.0000000 0.87500000 0.87500000 1.0000000 0.62500000 0.75000000 0.87500000 1.0000000 0.62500000 0.62500000 0.75000000
-DEAL:0:CG<2>(2)<->CG<2>(2)::10.451291
-DEAL:0:CG<2>(2)<->CG<2>(2)::0.0000000 0.25000000 0.0000000 0.12500000 0.12500000 0.0000000 0.50000000 0.25000000 0.37500000 0.37500000 0.25000000 0.0000000 0.12500000 0.12500000 0.0000000 0.75000000 0.50000000 0.62500000 0.62500000 0.50000000 1.0000000 0.75000000 0.87500000 0.87500000 0.75000000 0.50000000 0.62500000 0.62500000 0.50000000 0.25000000 0.0000000 0.12500000 0.12500000 0.0000000 0.25000000 0.37500000 0.37500000 0.25000000 0.0000000 0.12500000 0.12500000 0.0000000 0.37500000 0.37500000 0.25000000 1.0000000 0.75000000 1.0000000 0.87500000 0.87500000 1.0000000 0.50000000 0.75000000 0.62500000 0.62500000 0.75000000 1.0000000 0.87500000 0.87500000 1.0000000 0.25000000 0.50000000 0.37500000 0.37500000 0.50000000 0.12500000 0.25000000 0.37500000 0.50000000 0.75000000 1.0000000 0.87500000 0.87500000 1.0000000 0.62500000 0.75000000 0.87500000 1.0000000 0.62500000 0.62500000 0.75000000
-DEAL:0:CG<2>(2)<->CG<2>(2)::-0.046875000 0.71875000 -0.18750000 0.84375000 1.2500000 0.18750000 1.3906250 0.50000000 2.7187500 3.7500000 2.5000000 -0.14062500 1.2500000 1.2500000 0.18750000 1.2968750 0.53125000 1.4375000 2.9062500 3.7500000 3.5625000 1.0312500 2.5000000 3.7500000 3.5625000
-DEAL:0:CG<2>(1)<->CG<2>(1)::6.6283022
-DEAL:0:CG<2>(1)<->CG<2>(1)::0.0000000 0.50000000 0.0000000 0.0000000 1.0000000 0.50000000 0.50000000 0.0000000 0.0000000 0.0000000 0.50000000 0.50000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 0.50000000 0.50000000 1.0000000 1.0000000 0.0000000 0.0000000 0.50000000 0.0000000
-DEAL:0:CG<2>(1)<->CG<2>(1)::0.0000000 0.25000000 0.0000000 0.0000000 0.50000000 0.25000000 0.25000000 0.0000000 0.0000000 0.0000000 0.75000000 0.50000000 0.50000000 1.0000000 0.75000000 0.75000000 0.50000000 0.50000000 0.50000000 0.25000000 0.0000000 0.0000000 0.25000000 0.26041667 0.0000000 0.0000000 0.0000000 0.25000000 0.0000000 0.0000000 0.25000000 0.25000000 0.0000000 0.0000000 0.25000000 0.25000000 0.25000000 0.50000000 0.51041667 0.50000000 0.50000000 0.50000000 0.75000000 0.74038462 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 0.75000000 0.75000000 0.75000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 0.75000000 0.75000000 0.75000000 1.0000000 1.0000000 1.0000000 1.0000000 0.73863636 1.0000000 0.75000000 0.75000000 1.0000000 1.0000000 0.50000000 0.50961538 0.25000000 0.25000000 0.50000000 0.50000000 0.50000000 0.73214286 1.0000000 1.0000000 0.75000000 0.75000000 1.0000000 1.0000000 1.0000000 0.73958333 0.97916667 0.75000000 0.75000000 1.0000000 0.76136364 0.0000000 0.24038462 0.0000000 0.25000000 0.0000000 0.25000000 0.0000000 0.0000000 0.25000000 0.0000000 0.50000000 0.50000000 0.50000000 0.75000000 0.50000000 0.017857143 0.25000000 0.0000000 0.25000000 0.0000000 0.25000000 0.0000000 0.25000000 0.51041667
-DEAL:0:CG<2>(1)<->CG<2>(1)::13.907302
-DEAL:0:CG<2>(1)<->CG<2>(1)::0.0000000 0.25000000 0.0000000 0.0000000 0.50000000 0.25000000 0.25000000 0.0000000 0.0000000 0.0000000 0.75000000 0.50000000 0.50000000 1.0000000 0.75000000 0.75000000 0.50000000 0.50000000 0.50000000 0.25000000 0.0000000 0.0000000 0.25000000 0.25000000 0.0000000 0.0000000 0.0000000 0.25000000 0.0000000 0.0000000 0.25000000 0.25000000 0.0000000 0.0000000 0.25000000 0.25000000 0.25000000 0.50000000 0.50000000 0.50000000 0.50000000 0.50000000 0.75000000 0.75000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 0.75000000 0.75000000 0.75000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 0.75000000 0.75000000 0.75000000 1.0000000 1.0000000 1.0000000 1.0000000 0.75000000 1.0000000 0.75000000 0.75000000 1.0000000 1.0000000 0.50000000 0.50000000 0.25000000 0.25000000 0.50000000 0.50000000 0.50000000 0.75000000 1.0000000 1.0000000 0.75000000 0.75000000 1.0000000 1.0000000 1.0000000 0.75000000 1.0000000 0.75000000 0.75000000 1.0000000 0.75000000 0.0000000 0.25000000 0.0000000 0.25000000 0.0000000 0.25000000 0.0000000 0.0000000 0.25000000 0.0000000 0.50000000 0.50000000 0.50000000 0.75000000 0.50000000 0.0000000 0.25000000 0.0000000 0.25000000 0.0000000 0.25000000 0.0000000 0.25000000 0.50000000
-DEAL:0:CG<2>(1)<->CG<2>(1)::0.12500000 1.7458333 0.37916667 0.24583333 3.6250000 3.0201933 3.4017639 0.37500000 0.50087413 0.37500000 2.6202131 3.3708843 3.7376374 5.8625229 2.3750000 3.7357955 3.6250000 4.1310304 2.2328297 3.4106362 2.3750000 3.7253788 0.25007284 0.38406906 1.7452652 0.12500000
-DEAL:0:CG<2>(2)<->CG<2>(2)::15.262163
-DEAL:0:CG<2>(2)<->CG<2>(2)::0.0000000 0.50000000 0.0000000 0.0000000 0.25000000 0.25000000 0.0000000 0.0000000 0.25000000 0.0000000 1.0000000 0.50000000 0.50000000 0.75000000 0.75000000 0.50000000 0.50000000 0.75000000 0.50000000 0.0000000 0.0000000 0.25000000 0.25000000 0.0000000 0.0000000 0.25000000 0.0000000 0.0000000 0.25000000 0.25000000 0.0000000 0.0000000 0.25000000 0.0000000 0.25000000 0.50000000 0.50000000 0.50000000 0.25000000 0.25000000 0.50000000 0.50000000 1.0000000 1.0000000 1.0000000 0.75000000 0.75000000 1.0000000 1.0000000 1.0000000 1.0000000 0.75000000 1.0000000 0.75000000 0.75000000 1.0000000 1.0000000 1.0000000 0.75000000 1.0000000 0.75000000 0.75000000 1.0000000 1.0000000 0.75000000 1.0000000 0.75000000 1.0000000 0.75000000 1.0000000 0.50000000 0.50000000 0.25000000 0.50000000 0.50000000 0.25000000 0.50000000 1.0000000 1.0000000 0.75000000 0.75000000 1.0000000 1.0000000 0.75000000 1.0000000 0.75000000 0.75000000 1.0000000 0.75000000 1.0000000 0.75000000 0.0000000 0.25000000 0.0000000 0.0000000 0.25000000 0.0000000 0.25000000 0.0000000 0.0000000 0.25000000 0.50000000 0.50000000 0.50000000 0.50000000 0.75000000 0.0000000 0.0000000 0.25000000 0.25000000 0.0000000 0.0000000 0.25000000 0.25000000 0.50000000
-DEAL:0:CG<2>(2)<->CG<2>(2)::0.0000000 0.25000000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.0000000 0.50000000 0.25000000 0.25000000 0.37500000 0.37500000 0.25000000 0.25000000 0.37500000 0.22916667 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.0000000 0.0000000 0.12500000 0.14583333 0.0000000 0.0000000 0.12500000 0.0000000 0.12500000 0.75000000 0.50000000 0.50000000 0.62500000 0.62500000 0.50000000 0.50000000 0.62500000 0.50000000 1.0000000 0.75000000 0.75000000 0.87500000 0.87500000 0.75000000 0.75000000 0.87500000 0.75000000 0.50000000 0.50000000 0.62500000 0.62500000 0.50000000 0.50000000 0.62500000 0.50000000 0.50000000 0.62500000 0.62500000 0.50000000 0.50000000 0.62500000 0.50000000 0.62500000 0.25000000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.0000000 0.25000000 0.26041667 0.37500000 0.37500000 0.25000000 0.25000000 0.37500000 0.25000000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.0000000 0.12500000 0.25000000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.0000000 0.25000000 0.25000000 0.37500000 0.37500000 0.25000000 0.25000000 0.37500000 0.25000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.0000000 0.12500000 0.37500000 0.37500000 0.37500000 0.37500000 0.25000000 0.25000000 0.27083333 0.25000000 0.12500000 0.37500000 0.35000000 0.37500000 0.37500000 0.33333333 0.29166667 0.12500000 0.37500000 0.22500000 0.14583333 0.25000000 0.0000000 0.12500000 0.0000000 0.12500000 0.0000000 0.25000000 0.12500000 0.37500000 0.37500000 0.27083333 0.25000000 0.25000000 0.25000000 0.25000000 0.12500000 0.12500000 0.25000000 0.25000000 0.50000000 0.51041667 0.50000000 0.37500000 0.37500000 0.50000000 0.50000000 0.50000000 0.50000000 0.37500000 0.50000000 0.37500000 0.37500000 0.50000000 0.50000000 0.50000000 0.37500000 0.52083333 0.37500000 0.37500000 0.50000000 0.50000000 0.37500000 0.75000000 0.74038462 0.75000000 0.62500000 0.62500000 0.75000000 0.77083333 1.0000000 1.0000000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 1.0000000 0.87500000 1.0000000 0.85000000 0.87500000 1.0000000 1.0000000 0.87500000 0.75000000 0.75000000 0.75000000 0.62500000 0.75000000 0.62500000 0.62500000 0.75000000 0.75000000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 0.87500000 0.75000000 0.75000000 0.75000000 0.62500000 0.77083333 0.62500000 0.62500000 0.75000000 0.75000000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 1.0000000 0.85416667 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 0.87500000 0.62500000 0.65000000 0.70833333 0.85000000 0.73863636 0.66666667 0.62500000 0.77083333 0.62500000 0.87500000 0.70833333 0.87500000 0.75000000 0.62500000 0.65000000 0.62500000 0.72500000 0.70833333 0.64583333 0.62500000 0.62500000 0.77083333 0.70833333 0.87500000 0.66666667 0.85416667 0.75000000 1.0000000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 1.0000000 0.87500000 1.0000000 0.75000000 0.75000000 0.62500000 0.75000000 0.75000000 0.62500000 0.77083333 1.0000000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.85416667 1.0000000 0.87500000 1.0000000 0.87500000 0.50000000 0.50961538 0.37500000 0.50000000 0.50000000 0.37500000 0.50000000 0.25000000 0.25000000 0.12500000 0.25000000 0.25000000 0.12500000 0.25000000 0.50000000 0.50000000 0.37500000 0.37500000 0.50000000 0.50000000 0.37500000 0.50000000 0.50000000 0.37500000 0.37500000 0.52500000 0.50000000 0.37500000 0.50000000 0.37500000 0.73214286 1.0000000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 0.87500000 1.0000000 0.75000000 0.75000000 0.62500000 0.62500000 0.75000000 0.75000000 0.62500000 0.75000000 1.0000000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 0.87500000 1.0000000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.73958333 0.97916667 0.87500000 0.85416667 1.0000000 0.87500000 1.0000000 0.75000000 0.75000000 0.62500000 0.62500000 0.75000000 0.75000000 0.62500000 0.75000000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.87500000 1.0000000 0.87500000 1.0000000 0.87500000 0.62500000 0.62500000 0.62500000 0.62500000 0.76136364 0.70833333 0.72500000 0.72916667 0.87500000 0.62500000 0.66666667 0.62500000 0.62500000 0.65000000 0.70833333 0.87500000 0.62500000 0.79166667 0.85416667 0.75000000 1.0000000 0.87500000 1.0000000 0.87500000 0.95833333 0.77083333 0.87500000 0.62500000 0.62500000 0.75000000 0.75000000 0.0000000 0.12500000 0.0000000 0.0000000 0.12500000 0.24038462 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.25000000 0.25000000 0.37500000 0.25000000 0.22500000 0.37500000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.12500000 0.25000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.0000000 0.12500000 0.0000000 0.0000000 0.12500000 0.25000000 0.25000000 0.37500000 0.25000000 0.25000000 0.37500000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.12500000 0.50000000 0.50000000 0.50000000 0.62500000 0.50000000 0.50000000 0.62500000 0.50000000 0.50000000 0.62500000 0.50000000 0.50000000 0.62500000 0.75000000 0.75000000 0.75000000 0.75000000 0.87500000 0.50000000 0.50000000 0.62500000 0.62500000 0.50000000 0.50000000 0.62500000 0.62500000 0.017857143 0.25000000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.25000000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.25000000 0.25000000 0.37500000 0.37500000 0.25000000 0.25000000 0.37500000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.12500000 0.25000000 0.12500000 0.37500000 0.37500000 0.25000000 0.37500000 0.22916667 0.37500000 0.37500000 0.25000000 0.12500000 0.12500000 0.25000000 0.0000000 0.0000000 0.12500000 0.041666667 0.14583333 0.25000000 0.12500000 0.37500000 0.37500000 0.37500000 0.37500000 0.25000000 0.25000000 0.25000000 0.37500000 0.25000000 0.37500000 0.37500000 0.62500000 0.62500000 0.72916667 0.75000000 0.37500000 0.27083333 0.37500000 0.25000000 0.37500000 0.25000000 0.37500000 0.25000000 0.72916667 0.62500000 0.62500000 0.75000000 0.50000000 0.25000000 0.51041667 0.47916667 0.35416667 0.50000000 0.37500000 0.52083333 0.50000000 0.37500000 0.75000000 0.66666667 0.62500000 0.62500000 0.50000000 0.50000000 0.52083333 0.62500000 0.37500000
-DEAL:0:CG<2>(2)<->CG<2>(2)::42.871349
-DEAL:0:CG<2>(2)<->CG<2>(2)::0.0000000 0.25000000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.0000000 0.50000000 0.25000000 0.25000000 0.37500000 0.37500000 0.25000000 0.25000000 0.37500000 0.25000000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.0000000 0.12500000 0.75000000 0.50000000 0.50000000 0.62500000 0.62500000 0.50000000 0.50000000 0.62500000 0.50000000 1.0000000 0.75000000 0.75000000 0.87500000 0.87500000 0.75000000 0.75000000 0.87500000 0.75000000 0.50000000 0.50000000 0.62500000 0.62500000 0.50000000 0.50000000 0.62500000 0.50000000 0.50000000 0.62500000 0.62500000 0.50000000 0.50000000 0.62500000 0.50000000 0.62500000 0.25000000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.0000000 0.25000000 0.25000000 0.37500000 0.37500000 0.25000000 0.25000000 0.37500000 0.25000000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.0000000 0.12500000 0.25000000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.0000000 0.25000000 0.25000000 0.37500000 0.37500000 0.25000000 0.25000000 0.37500000 0.25000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.0000000 0.12500000 0.37500000 0.37500000 0.37500000 0.37500000 0.25000000 0.25000000 0.25000000 0.25000000 0.12500000 0.37500000 0.37500000 0.37500000 0.37500000 0.37500000 0.25000000 0.12500000 0.37500000 0.25000000 0.12500000 0.25000000 0.0000000 0.12500000 0.0000000 0.12500000 0.0000000 0.25000000 0.12500000 0.37500000 0.37500000 0.25000000 0.25000000 0.25000000 0.25000000 0.25000000 0.12500000 0.12500000 0.25000000 0.25000000 0.50000000 0.50000000 0.50000000 0.37500000 0.37500000 0.50000000 0.50000000 0.50000000 0.50000000 0.37500000 0.50000000 0.37500000 0.37500000 0.50000000 0.50000000 0.50000000 0.37500000 0.50000000 0.37500000 0.37500000 0.50000000 0.50000000 0.37500000 0.75000000 0.75000000 0.75000000 0.62500000 0.62500000 0.75000000 0.75000000 1.0000000 1.0000000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 0.87500000 0.75000000 0.75000000 0.75000000 0.62500000 0.75000000 0.62500000 0.62500000 0.75000000 0.75000000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 0.87500000 0.75000000 0.75000000 0.75000000 0.62500000 0.75000000 0.62500000 0.62500000 0.75000000 0.75000000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 0.87500000 0.62500000 0.62500000 0.75000000 0.87500000 0.75000000 0.62500000 0.62500000 0.75000000 0.62500000 0.87500000 0.75000000 0.87500000 0.75000000 0.62500000 0.62500000 0.62500000 0.75000000 0.75000000 0.62500000 0.62500000 0.62500000 0.75000000 0.75000000 0.87500000 0.62500000 0.87500000 0.75000000 1.0000000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 1.0000000 0.87500000 1.0000000 0.75000000 0.75000000 0.62500000 0.75000000 0.75000000 0.62500000 0.75000000 1.0000000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.87500000 1.0000000 0.87500000 1.0000000 0.87500000 0.50000000 0.50000000 0.37500000 0.50000000 0.50000000 0.37500000 0.50000000 0.25000000 0.25000000 0.12500000 0.25000000 0.25000000 0.12500000 0.25000000 0.50000000 0.50000000 0.37500000 0.37500000 0.50000000 0.50000000 0.37500000 0.50000000 0.50000000 0.37500000 0.37500000 0.50000000 0.50000000 0.37500000 0.50000000 0.37500000 0.75000000 1.0000000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 0.87500000 1.0000000 0.75000000 0.75000000 0.62500000 0.62500000 0.75000000 0.75000000 0.62500000 0.75000000 1.0000000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 0.87500000 1.0000000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.75000000 1.0000000 0.87500000 0.87500000 1.0000000 0.87500000 1.0000000 0.75000000 0.75000000 0.62500000 0.62500000 0.75000000 0.75000000 0.62500000 0.75000000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.87500000 1.0000000 0.87500000 1.0000000 0.87500000 0.62500000 0.62500000 0.62500000 0.62500000 0.75000000 0.75000000 0.75000000 0.75000000 0.87500000 0.62500000 0.62500000 0.62500000 0.62500000 0.62500000 0.75000000 0.87500000 0.62500000 0.75000000 0.87500000 0.75000000 1.0000000 0.87500000 1.0000000 0.87500000 1.0000000 0.75000000 0.87500000 0.62500000 0.62500000 0.75000000 0.75000000 0.0000000 0.12500000 0.0000000 0.0000000 0.12500000 0.25000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.25000000 0.25000000 0.37500000 0.25000000 0.25000000 0.37500000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.12500000 0.25000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.0000000 0.12500000 0.0000000 0.0000000 0.12500000 0.25000000 0.25000000 0.37500000 0.25000000 0.25000000 0.37500000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.12500000 0.50000000 0.50000000 0.50000000 0.62500000 0.50000000 0.50000000 0.62500000 0.50000000 0.50000000 0.62500000 0.50000000 0.50000000 0.62500000 0.75000000 0.75000000 0.75000000 0.75000000 0.87500000 0.50000000 0.50000000 0.62500000 0.62500000 0.50000000 0.50000000 0.62500000 0.62500000 0.0000000 0.25000000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.25000000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.25000000 0.25000000 0.37500000 0.37500000 0.25000000 0.25000000 0.37500000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.12500000 0.25000000 0.12500000 0.37500000 0.37500000 0.25000000 0.37500000 0.25000000 0.37500000 0.37500000 0.25000000 0.12500000 0.12500000 0.25000000 0.0000000 0.0000000 0.12500000 0.0000000 0.12500000 0.25000000 0.12500000 0.37500000 0.37500000 0.37500000 0.37500000 0.25000000 0.25000000 0.25000000 0.37500000 0.25000000 0.37500000 0.37500000 0.62500000 0.62500000 0.75000000 0.75000000 0.37500000 0.25000000 0.37500000 0.25000000 0.37500000 0.25000000 0.37500000 0.25000000 0.75000000 0.62500000 0.62500000 0.75000000 0.50000000 0.25000000 0.50000000 0.50000000 0.37500000 0.50000000 0.37500000 0.50000000 0.50000000 0.37500000 0.75000000 0.62500000 0.62500000 0.62500000 0.50000000 0.50000000 0.50000000 0.62500000 0.37500000
-DEAL:0:CG<2>(2)<->CG<2>(2)::-0.10937500 0.27864583 -0.72135417 -0.40677083 1.0937500 2.0677083 0.21875000 0.21875000 1.4770833 0.59583333 0.32812500 -1.5609375 -1.9760417 3.7187500 6.1875000 3.3750000 3.9000000 6.1875000 5.7760417 -0.57812500 -1.2348958 2.0625000 2.0625000 0.21875000 0.50000000 2.0885417 0.50000000 -0.57812500 1.8052083 2.8593750 0.25000000 0.21875000 2.0625000 0.50000000 2.0895833 -1.1807292 -1.9911458 4.5292926 1.5312500 2.0625000 4.7694712 4.6775568 0.15000000 -2.3947917 5.0312500 5.1687500 7.2509980 7.7500000 7.8907509 0.98437500 0.15625000 6.2157738 5.0312500 4.1562500 6.4062500 6.5000000 5.0312500 0.32812500 8.2916667 7.9142992 4.9427083 6.1875000 7.7500000 5.0312500 6.1313447 -0.23697917 6.2748855 5.0312500 7.4350962 8.0421402 -0.53906250 -2.2859375 1.5312500 3.3593750 5.8258377 2.0625000 4.5373855 0.98437500 0.15104167 5.9595238 4.1562500 5.0312500 7.7135417 5.1875000 5.0312500 7.4635417 6.6799242 6.1614583 6.1875000 5.0312500 6.1688447 -0.40208333 2.9442162 0.21875000 0.24687500 1.8761874 -0.70989583 2.0833333 0.52211538 0.21875000 2.1051136 0.27760417 5.8541667 3.8666667 3.3750000 3.7187500 -0.10937500 0.50729167 2.1280303 1.4760417 0.21875000 0.21875000 1.0937500 2.0420455 4.0052083
+DEAL:0:HCG<2>(1)<->HCG<2>(1)::3.0618622
+DEAL:0:HCG<2>(1)<->HCG<2>(1)::0.0000000 0.50000000 0.0000000 0.50000000 1.0000000 1.0000000 0.0000000 0.50000000 1.0000000
+DEAL:0:HCG<2>(1)<->HCG<2>(1)::0.0000000 0.25000000 0.0000000 0.25000000 0.50000000 0.50000000 0.0000000 0.25000000 0.50000000 0.75000000 0.75000000 1.0000000 1.0000000 0.75000000 1.0000000 0.0000000 0.25000000 0.50000000 0.0000000 0.25000000 0.50000000 0.75000000 1.0000000 0.75000000 1.0000000
+DEAL:0:HCG<2>(1)<->HCG<2>(1)::4.9702238
+DEAL:0:HCG<2>(1)<->HCG<2>(1)::0.0000000 0.25000000 0.0000000 0.25000000 0.50000000 0.50000000 0.0000000 0.25000000 0.50000000 0.75000000 0.75000000 1.0000000 1.0000000 0.75000000 1.0000000 0.0000000 0.25000000 0.50000000 0.0000000 0.25000000 0.50000000 0.75000000 1.0000000 0.75000000 1.0000000
+DEAL:0:HCG<2>(1)<->HCG<2>(1)::0.18750000 1.5000000 0.25000000 2.0000000 2.0625000 2.7500000 0.18750000 1.5000000 2.0625000
+DEAL:0:HCG<2>(2)<->HCG<2>(2)::5.3560713
+DEAL:0:HCG<2>(2)<->HCG<2>(2)::0.0000000 0.50000000 0.0000000 0.50000000 0.0000000 0.50000000 0.25000000 0.25000000 0.25000000 1.0000000 1.0000000 1.0000000 0.75000000 0.75000000 0.75000000 0.0000000 0.50000000 0.0000000 0.50000000 0.25000000 0.25000000 1.0000000 1.0000000 0.75000000 0.75000000
+DEAL:0:HCG<2>(2)<->HCG<2>(2)::0.0000000 0.25000000 0.0000000 0.25000000 0.0000000 0.25000000 0.12500000 0.12500000 0.12500000 0.50000000 0.50000000 0.50000000 0.37500000 0.37500000 0.37500000 0.0000000 0.25000000 0.0000000 0.25000000 0.12500000 0.12500000 0.50000000 0.50000000 0.37500000 0.37500000 0.75000000 0.75000000 0.75000000 0.62500000 0.62500000 0.62500000 1.0000000 1.0000000 1.0000000 0.87500000 0.87500000 0.87500000 0.75000000 0.75000000 0.62500000 0.62500000 1.0000000 1.0000000 0.87500000 0.87500000 0.0000000 0.25000000 0.0000000 0.25000000 0.12500000 0.12500000 0.50000000 0.50000000 0.37500000 0.37500000 0.0000000 0.25000000 0.0000000 0.25000000 0.12500000 0.12500000 0.50000000 0.50000000 0.37500000 0.37500000 0.75000000 0.75000000 0.62500000 0.62500000 1.0000000 1.0000000 0.87500000 0.87500000 0.75000000 0.75000000 0.62500000 0.62500000 1.0000000 1.0000000 0.87500000 0.87500000
+DEAL:0:HCG<2>(2)<->HCG<2>(2)::10.383092
+DEAL:0:HCG<2>(2)<->HCG<2>(2)::0.0000000 0.25000000 0.0000000 0.25000000 0.0000000 0.25000000 0.12500000 0.12500000 0.12500000 0.50000000 0.50000000 0.50000000 0.37500000 0.37500000 0.37500000 0.0000000 0.25000000 0.0000000 0.25000000 0.12500000 0.12500000 0.50000000 0.50000000 0.37500000 0.37500000 0.75000000 0.75000000 0.75000000 0.62500000 0.62500000 0.62500000 1.0000000 1.0000000 1.0000000 0.87500000 0.87500000 0.87500000 0.75000000 0.75000000 0.62500000 0.62500000 1.0000000 1.0000000 0.87500000 0.87500000 0.0000000 0.25000000 0.0000000 0.25000000 0.12500000 0.12500000 0.50000000 0.50000000 0.37500000 0.37500000 0.0000000 0.25000000 0.0000000 0.25000000 0.12500000 0.12500000 0.50000000 0.50000000 0.37500000 0.37500000 0.75000000 0.75000000 0.62500000 0.62500000 1.0000000 1.0000000 0.87500000 0.87500000 0.75000000 0.75000000 0.62500000 0.62500000 1.0000000 1.0000000 0.87500000 0.87500000
+DEAL:0:HCG<2>(2)<->HCG<2>(2)::0.0000000 0.93750000 0.0000000 1.1250000 0.0000000 1.8750000 0.78125000 0.93750000 1.5625000 1.5625000 1.8750000 3.1250000 2.3437500 2.8125000 4.6875000 0.0000000 0.93750000 0.0000000 1.8750000 0.78125000 1.5625000 1.5625000 3.1250000 2.3437500 4.6875000
+DEAL:0:HCG<2>(3)<->HCG<2>(3)::7.6697458
+DEAL:0:HCG<2>(3)<->HCG<2>(3)::0.0000000 0.50000000 0.0000000 0.50000000 0.0000000 0.0000000 0.50000000 0.50000000 0.13819660 0.36180340 0.13819660 0.36180340 0.13819660 0.36180340 0.13819660 0.36180340 1.0000000 1.0000000 1.0000000 1.0000000 0.63819660 0.86180340 0.63819660 0.86180340 0.63819660 0.86180340 0.63819660 0.86180340 0.0000000 0.50000000 0.0000000 0.0000000 0.50000000 0.50000000 0.13819660 0.36180340 0.13819660 0.36180340 0.13819660 0.36180340 1.0000000 1.0000000 1.0000000 0.63819660 0.86180340 0.63819660 0.86180340 0.63819660 0.86180340
+DEAL:0:HCG<2>(3)<->HCG<2>(3)::0.0000000 0.25000000 0.0000000 0.25000000 0.0000000 0.0000000 0.25000000 0.25000000 0.069098301 0.18090170 0.069098301 0.18090170 0.069098301 0.18090170 0.069098301 0.18090170 0.50000000 0.50000000 0.50000000 0.50000000 0.31909830 0.43090170 0.31909830 0.43090170 0.31909830 0.43090170 0.31909830 0.43090170 0.0000000 0.25000000 0.0000000 0.0000000 0.25000000 0.25000000 0.069098301 0.18090170 0.069098301 0.18090170 0.069098301 0.18090170 0.50000000 0.50000000 0.50000000 0.31909830 0.43090170 0.31909830 0.43090170 0.31909830 0.43090170 0.75000000 0.75000000 0.75000000 0.75000000 0.56909830 0.68090170 0.56909830 0.68090170 0.56909830 0.68090170 0.56909830 0.68090170 1.0000000 1.0000000 1.0000000 1.0000000 0.81909830 0.93090170 0.81909830 0.93090170 0.81909830 0.93090170 0.81909830 0.93090170 0.75000000 0.75000000 0.75000000 0.56909830 0.68090170 0.56909830 0.68090170 0.56909830 0.68090170 1.0000000 1.0000000 1.0000000 0.81909830 0.93090170 0.81909830 0.93090170 0.81909830 0.93090170 0.0000000 0.25000000 0.0000000 0.0000000 0.25000000 0.25000000 0.069098301 0.18090170 0.069098301 0.18090170 0.069098301 0.18090170 0.50000000 0.50000000 0.50000000 0.31909830 0.43090170 0.31909830 0.43090170 0.31909830 0.43090170 0.0000000 0.25000000 0.0000000 0.0000000 0.25000000 0.25000000 0.069098301 0.18090170 0.069098301 0.18090170 0.069098301 0.18090170 0.50000000 0.50000000 0.50000000 0.31909830 0.43090170 0.31909830 0.43090170 0.31909830 0.43090170 0.75000000 0.75000000 0.75000000 0.56909830 0.68090170 0.56909830 0.68090170 0.56909830 0.68090170 1.0000000 1.0000000 1.0000000 0.81909830 0.93090170 0.81909830 0.93090170 0.81909830 0.93090170 0.75000000 0.75000000 0.75000000 0.56909830 0.68090170 0.56909830 0.68090170 0.56909830 0.68090170 1.0000000 1.0000000 1.0000000 0.81909830 0.93090170 0.81909830 0.93090170 0.81909830 0.93090170
+DEAL:0:HCG<2>(3)<->HCG<2>(3)::15.445755
+DEAL:0:HCG<2>(3)<->HCG<2>(3)::0.0000000 0.25000000 0.0000000 0.25000000 0.0000000 0.0000000 0.25000000 0.25000000 0.069098301 0.18090170 0.069098301 0.18090170 0.069098301 0.18090170 0.069098301 0.18090170 0.50000000 0.50000000 0.50000000 0.50000000 0.31909830 0.43090170 0.31909830 0.43090170 0.31909830 0.43090170 0.31909830 0.43090170 0.0000000 0.25000000 0.0000000 0.0000000 0.25000000 0.25000000 0.069098301 0.18090170 0.069098301 0.18090170 0.069098301 0.18090170 0.50000000 0.50000000 0.50000000 0.31909830 0.43090170 0.31909830 0.43090170 0.31909830 0.43090170 0.75000000 0.75000000 0.75000000 0.75000000 0.56909830 0.68090170 0.56909830 0.68090170 0.56909830 0.68090170 0.56909830 0.68090170 1.0000000 1.0000000 1.0000000 1.0000000 0.81909830 0.93090170 0.81909830 0.93090170 0.81909830 0.93090170 0.81909830 0.93090170 0.75000000 0.75000000 0.75000000 0.56909830 0.68090170 0.56909830 0.68090170 0.56909830 0.68090170 1.0000000 1.0000000 1.0000000 0.81909830 0.93090170 0.81909830 0.93090170 0.81909830 0.93090170 0.0000000 0.25000000 0.0000000 0.0000000 0.25000000 0.25000000 0.069098301 0.18090170 0.069098301 0.18090170 0.069098301 0.18090170 0.50000000 0.50000000 0.50000000 0.31909830 0.43090170 0.31909830 0.43090170 0.31909830 0.43090170 0.0000000 0.25000000 0.0000000 0.0000000 0.25000000 0.25000000 0.069098301 0.18090170 0.069098301 0.18090170 0.069098301 0.18090170 0.50000000 0.50000000 0.50000000 0.31909830 0.43090170 0.31909830 0.43090170 0.31909830 0.43090170 0.75000000 0.75000000 0.75000000 0.56909830 0.68090170 0.56909830 0.68090170 0.56909830 0.68090170 1.0000000 1.0000000 1.0000000 0.81909830 0.93090170 0.81909830 0.93090170 0.81909830 0.93090170 0.75000000 0.75000000 0.75000000 0.56909830 0.68090170 0.56909830 0.68090170 0.56909830 0.68090170 1.0000000 1.0000000 1.0000000 0.81909830 0.93090170 0.81909830 0.93090170 0.81909830 0.93090170
+DEAL:0:HCG<2>(3)<->HCG<2>(3)::-0.021093750 0.70312500 -0.023437500 0.78125000 -0.044531250 -0.044531250 1.4843750 1.4843750 0.41641110 0.91952640 0.46267900 1.0216960 0.87909011 1.9412224 0.87909011 1.9412224 1.2867187 1.4296875 2.7164063 2.7164063 1.7523486 2.2554639 1.9470540 2.5060710 3.6994026 4.7615349 3.6994026 4.7615349 -0.021093750 0.70312500 -0.044531250 -0.044531250 1.4843750 1.4843750 0.41641110 0.91952640 0.87909011 1.9412224 0.87909011 1.9412224 1.2867188 2.7164063 2.7164063 1.7523486 2.2554639 3.6994026 4.7615349 3.6994026 4.7615349
+DEAL:0:HCG<2>(4)<->HCG<2>(4)::9.9861511
+DEAL:0:HCG<2>(4)<->HCG<2>(4)::0.0000000 0.50000000 0.0000000 0.50000000 0.0000000 0.0000000 0.0000000 0.50000000 0.50000000 0.50000000 0.086336582 0.25000000 0.41366342 0.086336582 0.25000000 0.41366342 0.086336582 0.25000000 0.41366342 0.086336582 0.25000000 0.41366342 0.086336582 0.25000000 0.41366342 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 0.58633658 0.75000000 0.91366342 0.58633658 0.75000000 0.91366342 0.58633658 0.75000000 0.91366342 0.58633658 0.75000000 0.91366342 0.58633658 0.75000000 0.91366342 0.0000000 0.50000000 0.0000000 0.0000000 0.0000000 0.50000000 0.50000000 0.50000000 0.086336582 0.25000000 0.41366342 0.086336582 0.25000000 0.41366342 0.086336582 0.25000000 0.41366342 0.086336582 0.25000000 0.41366342 1.0000000 1.0000000 1.0000000 1.0000000 0.58633658 0.75000000 0.91366342 0.58633658 0.75000000 0.91366342 0.58633658 0.75000000 0.91366342 0.58633658 0.75000000 0.91366342
+DEAL:0:HCG<2>(4)<->HCG<2>(4)::0.0000000 0.25000000 0.0000000 0.25000000 0.0000000 0.0000000 0.0000000 0.25000000 0.25000000 0.25000000 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.50000000 0.50000000 0.50000000 0.50000000 0.50000000 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.0000000 0.25000000 0.0000000 0.0000000 0.0000000 0.25000000 0.25000000 0.25000000 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.50000000 0.50000000 0.50000000 0.50000000 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.75000000 0.75000000 0.75000000 0.75000000 0.75000000 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.75000000 0.75000000 0.75000000 0.75000000 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 1.0000000 1.0000000 1.0000000 1.0000000 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.0000000 0.25000000 0.0000000 0.0000000 0.0000000 0.25000000 0.25000000 0.25000000 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.50000000 0.50000000 0.50000000 0.50000000 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.0000000 0.25000000 0.0000000 0.0000000 0.0000000 0.25000000 0.25000000 0.25000000 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.50000000 0.50000000 0.50000000 0.50000000 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.75000000 0.75000000 0.75000000 0.75000000 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 1.0000000 1.0000000 1.0000000 1.0000000 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.75000000 0.75000000 0.75000000 0.75000000 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 1.0000000 1.0000000 1.0000000 1.0000000 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171
+DEAL:0:HCG<2>(4)<->HCG<2>(4)::20.810567
+DEAL:0:HCG<2>(4)<->HCG<2>(4)::0.0000000 0.25000000 0.0000000 0.25000000 0.0000000 0.0000000 0.0000000 0.25000000 0.25000000 0.25000000 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.50000000 0.50000000 0.50000000 0.50000000 0.50000000 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.0000000 0.25000000 0.0000000 0.0000000 0.0000000 0.25000000 0.25000000 0.25000000 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.50000000 0.50000000 0.50000000 0.50000000 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.75000000 0.75000000 0.75000000 0.75000000 0.75000000 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.75000000 0.75000000 0.75000000 0.75000000 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 1.0000000 1.0000000 1.0000000 1.0000000 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.0000000 0.25000000 0.0000000 0.0000000 0.0000000 0.25000000 0.25000000 0.25000000 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.50000000 0.50000000 0.50000000 0.50000000 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.0000000 0.25000000 0.0000000 0.0000000 0.0000000 0.25000000 0.25000000 0.25000000 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.043168291 0.12500000 0.20683171 0.50000000 0.50000000 0.50000000 0.50000000 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.29316829 0.37500000 0.45683171 0.75000000 0.75000000 0.75000000 0.75000000 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 1.0000000 1.0000000 1.0000000 1.0000000 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.75000000 0.75000000 0.75000000 0.75000000 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 0.54316829 0.62500000 0.70683171 1.0000000 1.0000000 1.0000000 1.0000000 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171 0.79316829 0.87500000 0.95683171
+DEAL:0:HCG<2>(4)<->HCG<2>(4)::-3.4694470e-18 0.85447724 -1.9081958e-17 1.0013652 -1.3877788e-17 -4.8572257e-17 -1.7347235e-17 1.2493373 2.1606744 1.2493373 0.18408253 0.92186504 0.88199239 0.21572703 1.0803372 1.0336103 0.26914839 1.3478655 1.2895674 0.46548041 2.3310746 2.2302506 0.26914839 1.3478655 1.2895674 1.4582719 1.7089545 2.1321498 3.6874601 2.1321498 1.2501574 2.7655951 1.9480673 1.4650644 3.2410116 2.2829476 1.8278642 4.0435965 2.8482832 3.1612114 6.9932239 4.9259816 1.8278642 4.0435965 2.8482832 -1.0408341e-17 0.85447724 -1.3877788e-17 -4.8572257e-17 -1.7347235e-17 1.2493373 2.1606744 1.2493373 0.18408253 0.92186504 0.88199239 0.26914839 1.3478655 1.2895674 0.46548041 2.3310746 2.2302506 0.26914839 1.3478655 1.2895674 1.4582719 2.1321498 3.6874601 2.1321498 1.2501574 2.7655951 1.9480673 1.8278642 4.0435965 2.8482832 3.1612114 6.9932239 4.9259816 1.8278642 4.0435965 2.8482832
+DEAL:0:SCG<2>(1)<->SCG<2>(1)::3.0618622
+DEAL:0:SCG<2>(1)<->SCG<2>(1)::0.0000000 0.50000000 0.0000000 1.0000000 0.50000000 0.0000000 1.0000000 0.50000000 1.0000000
+DEAL:0:SCG<2>(1)<->SCG<2>(1)::0.0000000 0.25000000 0.0000000 0.50000000 0.25000000 0.0000000 0.75000000 0.50000000 1.0000000 0.75000000 0.50000000 0.25000000 0.0000000 0.25000000 0.0000000 1.0000000 0.75000000 1.0000000 0.50000000 0.75000000 1.0000000 0.25000000 0.50000000 0.75000000 1.0000000
+DEAL:0:SCG<2>(1)<->SCG<2>(1)::4.9812147
+DEAL:0:SCG<2>(1)<->SCG<2>(1)::0.0000000 0.25000000 0.0000000 0.50000000 0.25000000 0.0000000 0.75000000 0.50000000 1.0000000 0.75000000 0.50000000 0.25000000 0.0000000 0.25000000 0.0000000 1.0000000 0.75000000 1.0000000 0.50000000 0.75000000 1.0000000 0.25000000 0.50000000 0.75000000 1.0000000
+DEAL:0:SCG<2>(1)<->SCG<2>(1)::0.12500000 1.3750000 0.25000000 2.2500000 2.0000000 0.25000000 1.8750000 1.6250000 2.7500000
+DEAL:0:SCG<2>(2)<->SCG<2>(2)::5.3560713
+DEAL:0:SCG<2>(2)<->SCG<2>(2)::0.0000000 0.50000000 0.0000000 0.25000000 0.25000000 0.0000000 1.0000000 0.50000000 0.75000000 0.75000000 0.50000000 0.0000000 0.25000000 0.25000000 0.0000000 1.0000000 0.50000000 1.0000000 0.75000000 0.75000000 1.0000000 0.25000000 0.50000000 0.75000000 1.0000000
+DEAL:0:SCG<2>(2)<->SCG<2>(2)::0.0000000 0.25000000 0.0000000 0.12500000 0.12500000 0.0000000 0.50000000 0.25000000 0.37500000 0.37500000 0.25000000 0.0000000 0.12500000 0.12500000 0.0000000 0.75000000 0.50000000 0.62500000 0.62500000 0.50000000 1.0000000 0.75000000 0.87500000 0.87500000 0.75000000 0.50000000 0.62500000 0.62500000 0.50000000 0.25000000 0.0000000 0.12500000 0.12500000 0.0000000 0.25000000 0.37500000 0.37500000 0.25000000 0.0000000 0.12500000 0.12500000 0.0000000 0.37500000 0.37500000 0.25000000 1.0000000 0.75000000 1.0000000 0.87500000 0.87500000 1.0000000 0.50000000 0.75000000 0.62500000 0.62500000 0.75000000 1.0000000 0.87500000 0.87500000 1.0000000 0.25000000 0.50000000 0.37500000 0.37500000 0.50000000 0.12500000 0.25000000 0.37500000 0.50000000 0.75000000 1.0000000 0.87500000 0.87500000 1.0000000 0.62500000 0.75000000 0.87500000 1.0000000 0.62500000 0.62500000 0.75000000
+DEAL:0:SCG<2>(2)<->SCG<2>(2)::10.451291
+DEAL:0:SCG<2>(2)<->SCG<2>(2)::0.0000000 0.25000000 0.0000000 0.12500000 0.12500000 0.0000000 0.50000000 0.25000000 0.37500000 0.37500000 0.25000000 0.0000000 0.12500000 0.12500000 0.0000000 0.75000000 0.50000000 0.62500000 0.62500000 0.50000000 1.0000000 0.75000000 0.87500000 0.87500000 0.75000000 0.50000000 0.62500000 0.62500000 0.50000000 0.25000000 0.0000000 0.12500000 0.12500000 0.0000000 0.25000000 0.37500000 0.37500000 0.25000000 0.0000000 0.12500000 0.12500000 0.0000000 0.37500000 0.37500000 0.25000000 1.0000000 0.75000000 1.0000000 0.87500000 0.87500000 1.0000000 0.50000000 0.75000000 0.62500000 0.62500000 0.75000000 1.0000000 0.87500000 0.87500000 1.0000000 0.25000000 0.50000000 0.37500000 0.37500000 0.50000000 0.12500000 0.25000000 0.37500000 0.50000000 0.75000000 1.0000000 0.87500000 0.87500000 1.0000000 0.62500000 0.75000000 0.87500000 1.0000000 0.62500000 0.62500000 0.75000000
+DEAL:0:SCG<2>(2)<->SCG<2>(2)::-0.046875000 0.71875000 -0.18750000 0.84375000 1.2500000 0.18750000 1.3906250 0.50000000 2.7187500 3.7500000 2.5000000 -0.14062500 1.2500000 1.2500000 0.18750000 1.2968750 0.53125000 1.4375000 2.9062500 3.7500000 3.5625000 1.0312500 2.5000000 3.7500000 3.5625000
+DEAL:0:SCG<2>(3)<->SCG<2>(3)::7.6603235
+DEAL:0:SCG<2>(3)<->SCG<2>(3)::0.0000000 0.50000000 0.0000000 0.16666667 0.33333333 0.33333333 0.16666667 0.0000000 0.0000000 0.16666667 1.0000000 0.50000000 0.66666667 0.83333333 0.83333333 0.66666667 0.50000000 0.50000000 0.66666667 0.0000000 0.16666667 0.33333333 0.33333333 0.16666667 0.0000000 0.0000000 0.16666667 0.33333333 1.0000000 0.50000000 1.0000000 0.83333333 0.66666667 0.66666667 0.83333333 1.0000000 1.0000000 0.83333333 0.33333333 0.16666667 0.50000000 0.50000000 0.33333333 0.83333333 0.66666667 1.0000000 1.0000000 0.83333333 0.66666667
+DEAL:0:SCG<2>(3)<->SCG<2>(3)::0.0000000 0.25000000 0.0000000 0.083333333 0.16666667 0.16666667 0.083333333 0.0000000 0.0000000 0.083333333 0.50000000 0.25000000 0.33333333 0.41666667 0.41666667 0.33333333 0.25000000 0.25000000 0.33333333 0.0000000 0.083333333 0.16666667 0.16666667 0.083333333 0.0000000 0.0000000 0.083333333 0.16666667 0.75000000 0.50000000 0.58333333 0.66666667 0.66666667 0.58333333 0.50000000 0.50000000 0.58333333 1.0000000 0.75000000 0.83333333 0.91666667 0.91666667 0.83333333 0.75000000 0.75000000 0.83333333 0.50000000 0.58333333 0.66666667 0.66666667 0.58333333 0.50000000 0.50000000 0.58333333 0.66666667 0.25000000 0.0000000 0.083333333 0.16666667 0.16666667 0.083333333 0.0000000 0.0000000 0.083333333 0.25000000 0.33333333 0.41666667 0.41666667 0.33333333 0.25000000 0.25000000 0.33333333 0.0000000 0.083333333 0.16666667 0.16666667 0.083333333 0.0000000 0.0000000 0.083333333 0.16666667 0.41666667 0.33333333 0.41666667 0.33333333 0.41666667 0.41666667 0.25000000 0.25000000 0.16666667 0.33333333 1.0000000 0.75000000 1.0000000 0.91666667 0.83333333 0.83333333 0.91666667 1.0000000 1.0000000 0.91666667 0.50000000 0.75000000 0.66666667 0.58333333 0.58333333 0.66666667 0.75000000 0.75000000 0.66666667 1.0000000 0.91666667 0.83333333 0.83333333 0.91666667 1.0000000 1.0000000 0.91666667 0.83333333 0.25000000 0.50000000 0.41666667 0.33333333 0.33333333 0.41666667 0.50000000 0.50000000 0.41666667 0.16666667 0.083333333 0.25000000 0.25000000 0.16666667 0.41666667 0.33333333 0.50000000 0.50000000 0.41666667 0.33333333 0.75000000 1.0000000 0.91666667 0.83333333 0.83333333 0.91666667 1.0000000 1.0000000 0.91666667 0.66666667 0.58333333 0.75000000 0.75000000 0.66666667 0.91666667 0.83333333 1.0000000 1.0000000 0.91666667 0.83333333 0.58333333 0.66666667 0.58333333 0.66666667 0.58333333 0.58333333 0.75000000 0.75000000 0.83333333 0.66666667
+DEAL:0:SCG<2>(3)<->SCG<2>(3)::15.480309
+DEAL:0:SCG<2>(3)<->SCG<2>(3)::0.0000000 0.25000000 0.0000000 0.083333333 0.16666667 0.16666667 0.083333333 0.0000000 0.0000000 0.083333333 0.50000000 0.25000000 0.33333333 0.41666667 0.41666667 0.33333333 0.25000000 0.25000000 0.33333333 0.0000000 0.083333333 0.16666667 0.16666667 0.083333333 0.0000000 0.0000000 0.083333333 0.16666667 0.75000000 0.50000000 0.58333333 0.66666667 0.66666667 0.58333333 0.50000000 0.50000000 0.58333333 1.0000000 0.75000000 0.83333333 0.91666667 0.91666667 0.83333333 0.75000000 0.75000000 0.83333333 0.50000000 0.58333333 0.66666667 0.66666667 0.58333333 0.50000000 0.50000000 0.58333333 0.66666667 0.25000000 0.0000000 0.083333333 0.16666667 0.16666667 0.083333333 0.0000000 0.0000000 0.083333333 0.25000000 0.33333333 0.41666667 0.41666667 0.33333333 0.25000000 0.25000000 0.33333333 0.0000000 0.083333333 0.16666667 0.16666667 0.083333333 0.0000000 0.0000000 0.083333333 0.16666667 0.41666667 0.33333333 0.41666667 0.33333333 0.41666667 0.41666667 0.25000000 0.25000000 0.16666667 0.33333333 1.0000000 0.75000000 1.0000000 0.91666667 0.83333333 0.83333333 0.91666667 1.0000000 1.0000000 0.91666667 0.50000000 0.75000000 0.66666667 0.58333333 0.58333333 0.66666667 0.75000000 0.75000000 0.66666667 1.0000000 0.91666667 0.83333333 0.83333333 0.91666667 1.0000000 1.0000000 0.91666667 0.83333333 0.25000000 0.50000000 0.41666667 0.33333333 0.33333333 0.41666667 0.50000000 0.50000000 0.41666667 0.16666667 0.083333333 0.25000000 0.25000000 0.16666667 0.41666667 0.33333333 0.50000000 0.50000000 0.41666667 0.33333333 0.75000000 1.0000000 0.91666667 0.83333333 0.83333333 0.91666667 1.0000000 1.0000000 0.91666667 0.66666667 0.58333333 0.75000000 0.75000000 0.66666667 0.91666667 0.83333333 1.0000000 1.0000000 0.91666667 0.83333333 0.58333333 0.66666667 0.58333333 0.66666667 0.58333333 0.58333333 0.75000000 0.75000000 0.83333333 0.66666667
+DEAL:0:SCG<2>(3)<->SCG<2>(3)::0.072916667 1.2031250 0.21875000 0.21875000 1.0937500 1.3489583 0.18229167 1.7347235e-17 5.8980598e-17 1.1666667 2.0052083 1.8125000 1.5312500 2.4062500 2.8802083 1.7135417 1.5312500 1.5312500 4.6666667 0.18229167 0.18229167 1.3489583 1.3489583 0.18229167 1.7347235e-17 5.8980598e-17 1.1666667 2.3333333 1.6770833 1.4218750 2.4062500 2.4062500 1.5312500 1.7135417 2.8802083 2.6250000 2.6250000 5.8333333 1.0937500 0.21875000 1.5312500 1.5312500 2.3333333 2.8802083 1.7135417 2.6250000 2.6250000 5.8333333 4.6666667
+DEAL:0:SCG<3>(1)<->SCG<3>(1)::6.6332496
+DEAL:0:SCG<3>(1)<->SCG<3>(1)::0.0000000 0.50000000 0.0000000 0.0000000 1.0000000 0.50000000 0.50000000 0.0000000 0.0000000 0.0000000 0.50000000 0.50000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 0.50000000 0.50000000 1.0000000 1.0000000 0.0000000 0.0000000 0.50000000 0.0000000
+DEAL:0:SCG<3>(1)<->SCG<3>(1)::0.0000000 0.25000000 0.0000000 0.0000000 0.50000000 0.25000000 0.25000000 0.0000000 0.0000000 0.0000000 0.75000000 0.50000000 0.50000000 1.0000000 0.75000000 0.75000000 0.50000000 0.50000000 0.50000000 0.25000000 0.0000000 0.0000000 0.25000000 0.25000000 0.0000000 0.0000000 0.0000000 0.25000000 0.0000000 0.0000000 0.25000000 0.25000000 0.0000000 0.0000000 0.25000000 0.25000000 0.25000000 0.50000000 0.50000000 0.50000000 0.50000000 0.50000000 0.75000000 0.75000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 0.75000000 0.75000000 0.75000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 0.75000000 0.75000000 0.75000000 1.0000000 1.0000000 1.0000000 1.0000000 0.75000000 1.0000000 0.75000000 0.75000000 1.0000000 1.0000000 0.50000000 0.50000000 0.25000000 0.25000000 0.50000000 0.50000000 0.50000000 0.75000000 1.0000000 1.0000000 0.75000000 0.75000000 1.0000000 1.0000000 1.0000000 0.75000000 1.0000000 0.75000000 0.75000000 1.0000000 0.75000000 0.0000000 0.25000000 0.0000000 0.25000000 0.0000000 0.25000000 0.0000000 0.0000000 0.25000000 0.0000000 0.50000000 0.50000000 0.50000000 0.75000000 0.50000000 0.0000000 0.25000000 0.0000000 0.25000000 0.0000000 0.25000000 0.0000000 0.25000000 0.50000000
+DEAL:0:SCG<3>(1)<->SCG<3>(1)::13.910428
+DEAL:0:SCG<3>(1)<->SCG<3>(1)::0.0000000 0.25000000 0.0000000 0.0000000 0.50000000 0.25000000 0.25000000 0.0000000 0.0000000 0.0000000 0.75000000 0.50000000 0.50000000 1.0000000 0.75000000 0.75000000 0.50000000 0.50000000 0.50000000 0.25000000 0.0000000 0.0000000 0.25000000 0.25000000 0.0000000 0.0000000 0.0000000 0.25000000 0.0000000 0.0000000 0.25000000 0.25000000 0.0000000 0.0000000 0.25000000 0.25000000 0.25000000 0.50000000 0.50000000 0.50000000 0.50000000 0.50000000 0.75000000 0.75000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 0.75000000 0.75000000 0.75000000 1.0000000 1.0000000 1.0000000 1.0000000 1.0000000 0.75000000 0.75000000 0.75000000 1.0000000 1.0000000 1.0000000 1.0000000 0.75000000 1.0000000 0.75000000 0.75000000 1.0000000 1.0000000 0.50000000 0.50000000 0.25000000 0.25000000 0.50000000 0.50000000 0.50000000 0.75000000 1.0000000 1.0000000 0.75000000 0.75000000 1.0000000 1.0000000 1.0000000 0.75000000 1.0000000 0.75000000 0.75000000 1.0000000 0.75000000 0.0000000 0.25000000 0.0000000 0.25000000 0.0000000 0.25000000 0.0000000 0.0000000 0.25000000 0.0000000 0.50000000 0.50000000 0.50000000 0.75000000 0.50000000 0.0000000 0.25000000 0.0000000 0.25000000 0.0000000 0.25000000 0.0000000 0.25000000 0.50000000
+DEAL:0:SCG<3>(1)<->SCG<3>(1)::0.12500000 1.7500000 0.37500000 0.25000000 3.6250000 3.0000000 3.3750000 0.37500000 0.50000000 0.37500000 2.6250000 3.3750000 3.7500000 5.8750000 2.3750000 3.7500000 3.6250000 4.1250000 2.2500000 3.3750000 2.3750000 3.7500000 0.25000000 0.37500000 1.7500000 0.12500000
+DEAL:0:SCG<3>(2)<->SCG<3>(2)::15.272524
+DEAL:0:SCG<3>(2)<->SCG<3>(2)::0.0000000 0.50000000 0.0000000 0.0000000 0.25000000 0.25000000 0.0000000 0.0000000 0.25000000 0.0000000 1.0000000 0.50000000 0.50000000 0.75000000 0.75000000 0.50000000 0.50000000 0.75000000 0.50000000 0.0000000 0.0000000 0.25000000 0.25000000 0.0000000 0.0000000 0.25000000 0.0000000 0.0000000 0.25000000 0.25000000 0.0000000 0.0000000 0.25000000 0.0000000 0.25000000 0.50000000 0.50000000 0.50000000 0.25000000 0.25000000 0.50000000 0.50000000 1.0000000 1.0000000 1.0000000 0.75000000 0.75000000 1.0000000 1.0000000 1.0000000 1.0000000 0.75000000 1.0000000 0.75000000 0.75000000 1.0000000 1.0000000 1.0000000 0.75000000 1.0000000 0.75000000 0.75000000 1.0000000 1.0000000 0.75000000 1.0000000 0.75000000 1.0000000 0.75000000 1.0000000 0.50000000 0.50000000 0.25000000 0.50000000 0.50000000 0.25000000 0.50000000 1.0000000 1.0000000 0.75000000 0.75000000 1.0000000 1.0000000 0.75000000 1.0000000 0.75000000 0.75000000 1.0000000 0.75000000 1.0000000 0.75000000 0.0000000 0.25000000 0.0000000 0.0000000 0.25000000 0.0000000 0.25000000 0.0000000 0.0000000 0.25000000 0.50000000 0.50000000 0.50000000 0.50000000 0.75000000 0.0000000 0.0000000 0.25000000 0.25000000 0.0000000 0.0000000 0.25000000 0.25000000 0.50000000
+DEAL:0:SCG<3>(2)<->SCG<3>(2)::0.0000000 0.25000000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.0000000 0.50000000 0.25000000 0.25000000 0.37500000 0.37500000 0.25000000 0.25000000 0.37500000 0.25000000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.0000000 0.12500000 0.75000000 0.50000000 0.50000000 0.62500000 0.62500000 0.50000000 0.50000000 0.62500000 0.50000000 1.0000000 0.75000000 0.75000000 0.87500000 0.87500000 0.75000000 0.75000000 0.87500000 0.75000000 0.50000000 0.50000000 0.62500000 0.62500000 0.50000000 0.50000000 0.62500000 0.50000000 0.50000000 0.62500000 0.62500000 0.50000000 0.50000000 0.62500000 0.50000000 0.62500000 0.25000000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.0000000 0.25000000 0.25000000 0.37500000 0.37500000 0.25000000 0.25000000 0.37500000 0.25000000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.0000000 0.12500000 0.25000000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.0000000 0.25000000 0.25000000 0.37500000 0.37500000 0.25000000 0.25000000 0.37500000 0.25000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.0000000 0.12500000 0.37500000 0.37500000 0.37500000 0.37500000 0.25000000 0.25000000 0.25000000 0.25000000 0.12500000 0.37500000 0.37500000 0.37500000 0.37500000 0.37500000 0.25000000 0.12500000 0.37500000 0.25000000 0.12500000 0.25000000 0.0000000 0.12500000 0.0000000 0.12500000 0.0000000 0.25000000 0.12500000 0.37500000 0.37500000 0.25000000 0.25000000 0.25000000 0.25000000 0.25000000 0.12500000 0.12500000 0.25000000 0.25000000 0.50000000 0.50000000 0.50000000 0.37500000 0.37500000 0.50000000 0.50000000 0.50000000 0.50000000 0.37500000 0.50000000 0.37500000 0.37500000 0.50000000 0.50000000 0.50000000 0.37500000 0.50000000 0.37500000 0.37500000 0.50000000 0.50000000 0.37500000 0.75000000 0.75000000 0.75000000 0.62500000 0.62500000 0.75000000 0.75000000 1.0000000 1.0000000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 0.87500000 0.75000000 0.75000000 0.75000000 0.62500000 0.75000000 0.62500000 0.62500000 0.75000000 0.75000000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 0.87500000 0.75000000 0.75000000 0.75000000 0.62500000 0.75000000 0.62500000 0.62500000 0.75000000 0.75000000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 0.87500000 0.62500000 0.62500000 0.75000000 0.87500000 0.75000000 0.62500000 0.62500000 0.75000000 0.62500000 0.87500000 0.75000000 0.87500000 0.75000000 0.62500000 0.62500000 0.62500000 0.75000000 0.75000000 0.62500000 0.62500000 0.62500000 0.75000000 0.75000000 0.87500000 0.62500000 0.87500000 0.75000000 1.0000000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 1.0000000 0.87500000 1.0000000 0.75000000 0.75000000 0.62500000 0.75000000 0.75000000 0.62500000 0.75000000 1.0000000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.87500000 1.0000000 0.87500000 1.0000000 0.87500000 0.50000000 0.50000000 0.37500000 0.50000000 0.50000000 0.37500000 0.50000000 0.25000000 0.25000000 0.12500000 0.25000000 0.25000000 0.12500000 0.25000000 0.50000000 0.50000000 0.37500000 0.37500000 0.50000000 0.50000000 0.37500000 0.50000000 0.50000000 0.37500000 0.37500000 0.50000000 0.50000000 0.37500000 0.50000000 0.37500000 0.75000000 1.0000000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 0.87500000 1.0000000 0.75000000 0.75000000 0.62500000 0.62500000 0.75000000 0.75000000 0.62500000 0.75000000 1.0000000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 0.87500000 1.0000000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.75000000 1.0000000 0.87500000 0.87500000 1.0000000 0.87500000 1.0000000 0.75000000 0.75000000 0.62500000 0.62500000 0.75000000 0.75000000 0.62500000 0.75000000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.87500000 1.0000000 0.87500000 1.0000000 0.87500000 0.62500000 0.62500000 0.62500000 0.62500000 0.75000000 0.75000000 0.75000000 0.75000000 0.87500000 0.62500000 0.62500000 0.62500000 0.62500000 0.62500000 0.75000000 0.87500000 0.62500000 0.75000000 0.87500000 0.75000000 1.0000000 0.87500000 1.0000000 0.87500000 1.0000000 0.75000000 0.87500000 0.62500000 0.62500000 0.75000000 0.75000000 0.0000000 0.12500000 0.0000000 0.0000000 0.12500000 0.25000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.25000000 0.25000000 0.37500000 0.25000000 0.25000000 0.37500000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.12500000 0.25000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.0000000 0.12500000 0.0000000 0.0000000 0.12500000 0.25000000 0.25000000 0.37500000 0.25000000 0.25000000 0.37500000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.12500000 0.50000000 0.50000000 0.50000000 0.62500000 0.50000000 0.50000000 0.62500000 0.50000000 0.50000000 0.62500000 0.50000000 0.50000000 0.62500000 0.75000000 0.75000000 0.75000000 0.75000000 0.87500000 0.50000000 0.50000000 0.62500000 0.62500000 0.50000000 0.50000000 0.62500000 0.62500000 0.0000000 0.25000000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.25000000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.25000000 0.25000000 0.37500000 0.37500000 0.25000000 0.25000000 0.37500000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.12500000 0.25000000 0.12500000 0.37500000 0.37500000 0.25000000 0.37500000 0.25000000 0.37500000 0.37500000 0.25000000 0.12500000 0.12500000 0.25000000 0.0000000 0.0000000 0.12500000 0.0000000 0.12500000 0.25000000 0.12500000 0.37500000 0.37500000 0.37500000 0.37500000 0.25000000 0.25000000 0.25000000 0.37500000 0.25000000 0.37500000 0.37500000 0.62500000 0.62500000 0.75000000 0.75000000 0.37500000 0.25000000 0.37500000 0.25000000 0.37500000 0.25000000 0.37500000 0.25000000 0.75000000 0.62500000 0.62500000 0.75000000 0.50000000 0.25000000 0.50000000 0.50000000 0.37500000 0.50000000 0.37500000 0.50000000 0.50000000 0.37500000 0.75000000 0.62500000 0.62500000 0.62500000 0.50000000 0.50000000 0.50000000 0.62500000 0.37500000
+DEAL:0:SCG<3>(2)<->SCG<3>(2)::42.937068
+DEAL:0:SCG<3>(2)<->SCG<3>(2)::0.0000000 0.25000000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.0000000 0.50000000 0.25000000 0.25000000 0.37500000 0.37500000 0.25000000 0.25000000 0.37500000 0.25000000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.0000000 0.12500000 0.75000000 0.50000000 0.50000000 0.62500000 0.62500000 0.50000000 0.50000000 0.62500000 0.50000000 1.0000000 0.75000000 0.75000000 0.87500000 0.87500000 0.75000000 0.75000000 0.87500000 0.75000000 0.50000000 0.50000000 0.62500000 0.62500000 0.50000000 0.50000000 0.62500000 0.50000000 0.50000000 0.62500000 0.62500000 0.50000000 0.50000000 0.62500000 0.50000000 0.62500000 0.25000000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.0000000 0.25000000 0.25000000 0.37500000 0.37500000 0.25000000 0.25000000 0.37500000 0.25000000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.0000000 0.12500000 0.25000000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.0000000 0.25000000 0.25000000 0.37500000 0.37500000 0.25000000 0.25000000 0.37500000 0.25000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.0000000 0.12500000 0.37500000 0.37500000 0.37500000 0.37500000 0.25000000 0.25000000 0.25000000 0.25000000 0.12500000 0.37500000 0.37500000 0.37500000 0.37500000 0.37500000 0.25000000 0.12500000 0.37500000 0.25000000 0.12500000 0.25000000 0.0000000 0.12500000 0.0000000 0.12500000 0.0000000 0.25000000 0.12500000 0.37500000 0.37500000 0.25000000 0.25000000 0.25000000 0.25000000 0.25000000 0.12500000 0.12500000 0.25000000 0.25000000 0.50000000 0.50000000 0.50000000 0.37500000 0.37500000 0.50000000 0.50000000 0.50000000 0.50000000 0.37500000 0.50000000 0.37500000 0.37500000 0.50000000 0.50000000 0.50000000 0.37500000 0.50000000 0.37500000 0.37500000 0.50000000 0.50000000 0.37500000 0.75000000 0.75000000 0.75000000 0.62500000 0.62500000 0.75000000 0.75000000 1.0000000 1.0000000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 0.87500000 0.75000000 0.75000000 0.75000000 0.62500000 0.75000000 0.62500000 0.62500000 0.75000000 0.75000000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 0.87500000 0.75000000 0.75000000 0.75000000 0.62500000 0.75000000 0.62500000 0.62500000 0.75000000 0.75000000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 0.87500000 0.62500000 0.62500000 0.75000000 0.87500000 0.75000000 0.62500000 0.62500000 0.75000000 0.62500000 0.87500000 0.75000000 0.87500000 0.75000000 0.62500000 0.62500000 0.62500000 0.75000000 0.75000000 0.62500000 0.62500000 0.62500000 0.75000000 0.75000000 0.87500000 0.62500000 0.87500000 0.75000000 1.0000000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 1.0000000 0.87500000 1.0000000 0.75000000 0.75000000 0.62500000 0.75000000 0.75000000 0.62500000 0.75000000 1.0000000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.87500000 1.0000000 0.87500000 1.0000000 0.87500000 0.50000000 0.50000000 0.37500000 0.50000000 0.50000000 0.37500000 0.50000000 0.25000000 0.25000000 0.12500000 0.25000000 0.25000000 0.12500000 0.25000000 0.50000000 0.50000000 0.37500000 0.37500000 0.50000000 0.50000000 0.37500000 0.50000000 0.50000000 0.37500000 0.37500000 0.50000000 0.50000000 0.37500000 0.50000000 0.37500000 0.75000000 1.0000000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 0.87500000 1.0000000 0.75000000 0.75000000 0.62500000 0.62500000 0.75000000 0.75000000 0.62500000 0.75000000 1.0000000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 0.87500000 1.0000000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.75000000 1.0000000 0.87500000 0.87500000 1.0000000 0.87500000 1.0000000 0.75000000 0.75000000 0.62500000 0.62500000 0.75000000 0.75000000 0.62500000 0.75000000 1.0000000 0.87500000 0.87500000 1.0000000 1.0000000 0.87500000 1.0000000 0.87500000 0.87500000 1.0000000 0.87500000 1.0000000 0.87500000 0.62500000 0.62500000 0.62500000 0.62500000 0.75000000 0.75000000 0.75000000 0.75000000 0.87500000 0.62500000 0.62500000 0.62500000 0.62500000 0.62500000 0.75000000 0.87500000 0.62500000 0.75000000 0.87500000 0.75000000 1.0000000 0.87500000 1.0000000 0.87500000 1.0000000 0.75000000 0.87500000 0.62500000 0.62500000 0.75000000 0.75000000 0.0000000 0.12500000 0.0000000 0.0000000 0.12500000 0.25000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.25000000 0.25000000 0.37500000 0.25000000 0.25000000 0.37500000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.12500000 0.25000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.0000000 0.12500000 0.0000000 0.0000000 0.12500000 0.25000000 0.25000000 0.37500000 0.25000000 0.25000000 0.37500000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.12500000 0.50000000 0.50000000 0.50000000 0.62500000 0.50000000 0.50000000 0.62500000 0.50000000 0.50000000 0.62500000 0.50000000 0.50000000 0.62500000 0.75000000 0.75000000 0.75000000 0.75000000 0.87500000 0.50000000 0.50000000 0.62500000 0.62500000 0.50000000 0.50000000 0.62500000 0.62500000 0.0000000 0.25000000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.25000000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.25000000 0.25000000 0.37500000 0.37500000 0.25000000 0.25000000 0.37500000 0.0000000 0.0000000 0.12500000 0.12500000 0.0000000 0.0000000 0.12500000 0.12500000 0.25000000 0.12500000 0.37500000 0.37500000 0.25000000 0.37500000 0.25000000 0.37500000 0.37500000 0.25000000 0.12500000 0.12500000 0.25000000 0.0000000 0.0000000 0.12500000 0.0000000 0.12500000 0.25000000 0.12500000 0.37500000 0.37500000 0.37500000 0.37500000 0.25000000 0.25000000 0.25000000 0.37500000 0.25000000 0.37500000 0.37500000 0.62500000 0.62500000 0.75000000 0.75000000 0.37500000 0.25000000 0.37500000 0.25000000 0.37500000 0.25000000 0.37500000 0.25000000 0.75000000 0.62500000 0.62500000 0.75000000 0.50000000 0.25000000 0.50000000 0.50000000 0.37500000 0.50000000 0.37500000 0.50000000 0.50000000 0.37500000 0.75000000 0.62500000 0.62500000 0.62500000 0.50000000 0.50000000 0.50000000 0.62500000 0.37500000
+DEAL:0:SCG<3>(2)<->SCG<3>(2)::-0.10937500 0.28125000 -0.71875000 -0.40625000 1.0937500 2.0625000 0.21875000 0.21875000 1.5625000 0.50000000 0.32812500 -1.6250000 -2.0625000 3.7187500 6.1875000 3.3750000 3.8750000 6.1875000 5.7500000 -0.57812500 -1.2500000 2.0625000 2.0625000 0.21875000 0.50000000 2.1250000 0.50000000 -0.57812500 1.8125000 2.8750000 0.25000000 0.21875000 2.0625000 0.50000000 2.1250000 -1.2187500 -2.0625000 4.3750000 1.5312500 2.0625000 4.7500000 4.3750000 0.15625000 -2.4375000 5.0312500 5.1875000 7.3750000 7.7500000 7.7500000 0.98437500 0.15625000 6.4375000 5.0312500 4.1562500 6.4375000 6.5000000 5.0312500 0.32812500 8.3750000 7.7500000 5.1875000 6.1875000 7.7500000 5.0312500 6.3750000 -0.28125000 6.1875000 5.0312500 7.3750000 7.7500000 -0.53125000 -2.3125000 1.5312500 3.3750000 5.7500000 2.0625000 4.3750000 0.98437500 0.15625000 6.1875000 4.1562500 5.0312500 7.7500000 5.1875000 5.0312500 7.6250000 6.4375000 6.5000000 6.1875000 5.0312500 6.3750000 -0.40625000 2.8750000 0.21875000 0.25000000 1.8125000 -0.71875000 2.1250000 0.50000000 0.21875000 2.0625000 0.28125000 5.7500000 3.8750000 3.3750000 3.7187500 -0.10937500 0.50000000 2.0625000 1.5625000 0.21875000 0.21875000 1.0937500 2.1250000 4.2500000
+DEAL:0:SCG<3>(3)<->SCG<3>(3)::26.027763
+DEAL:0:SCG<3>(3)<->SCG<3>(3)::0.0000000 0.50000000 0.0000000 0.0000000 0.16666667 0.33333333 0.33333333 0.16666667 0.0000000 0.0000000 0.0000000 0.0000000 0.33333333 0.16666667 1.8503717e-17 9.2518585e-18 0.16666667 0.16666667 0.0000000 0.16666667 1.0000000 0.50000000 0.50000000 0.66666667 0.83333333 0.83333333 0.66666667 0.50000000 0.50000000 0.50000000 0.50000000 0.83333333 0.66666667 0.50000000 0.50000000 0.66666667 0.66666667 0.50000000 0.66666667 0.0000000 0.0000000 0.16666667 0.33333333 0.33333333 0.16666667 0.0000000 0.0000000 1.8503717e-17 9.2518585e-18 0.33333333 0.16666667 9.2518585e-18 1.8503717e-17 0.16666667 0.16666667 0.0000000 0.16666667 0.0000000 0.16666667 0.33333333 0.33333333 0.16666667 0.0000000 0.0000000 0.0000000 0.0000000 0.33333333 0.16666667 9.2518585e-18 1.8503717e-17 0.16666667 0.16666667 0.0000000 0.16666667 0.16666667 0.33333333 0.33333333 0.33333333 0.33333333 0.33333333 0.16666667 0.0000000 0.16666667 0.33333333 0.50000000 0.50000000 0.50000000 0.50000000 0.33333333 0.16666667 0.16666667 0.33333333 0.50000000 0.50000000 0.50000000 0.50000000 0.33333333 0.33333333 0.33333333 0.50000000 1.0000000 1.0000000 1.0000000 1.0000000 0.83333333 0.66666667 0.66666667 0.83333333 1.0000000 1.0000000 1.0000000 1.0000000 0.83333333 0.83333333 0.83333333 1.0000000 1.0000000 1.0000000 0.66666667 0.83333333 1.0000000 1.0000000 0.83333333 0.66666667 0.66666667 0.83333333 1.0000000 1.0000000 1.0000000 1.0000000 0.83333333 0.83333333 0.83333333 1.0000000 1.0000000 0.66666667 0.83333333 1.0000000 1.0000000 0.83333333 0.66666667 0.66666667 0.83333333 1.0000000 1.0000000 1.0000000 1.0000000 0.83333333 0.83333333 0.83333333 1.0000000 0.66666667 0.83333333 0.66666667 0.66666667 0.83333333 0.66666667 0.66666667 0.66666667 0.83333333 1.0000000 1.0000000 0.66666667 0.83333333 1.0000000 1.0000000 0.66666667 0.83333333 1.0000000 1.0000000 0.83333333 0.83333333 1.0000000 0.83333333 0.50000000 0.50000000 0.16666667 0.33333333 0.50000000 0.50000000 0.50000000 0.50000000 0.16666667 0.33333333 0.50000000 0.50000000 0.33333333 0.33333333 0.50000000 0.33333333 1.0000000 1.0000000 0.83333333 0.66666667 0.66666667 0.83333333 1.0000000 1.0000000 1.0000000 1.0000000 0.66666667 0.83333333 1.0000000 1.0000000 0.83333333 0.83333333 1.0000000 0.83333333 0.83333333 0.66666667 0.66666667 0.83333333 1.0000000 1.0000000 0.66666667 0.83333333 1.0000000 1.0000000 0.83333333 0.83333333 1.0000000 0.83333333 0.83333333 0.66666667 0.66666667 0.66666667 0.66666667 0.66666667 0.83333333 1.0000000 0.83333333 0.66666667 0.0000000 0.16666667 0.33333333 0.0000000 0.0000000 0.0000000 0.0000000 0.33333333 0.16666667 0.16666667 0.0000000 0.16666667 0.16666667 0.0000000 0.33333333 0.16666667 0.0000000 0.0000000 0.0000000 0.0000000 0.33333333 0.16666667 0.16666667 0.0000000 0.16666667 0.16666667 0.50000000 0.50000000 0.50000000 0.50000000 0.50000000 0.50000000 0.50000000 0.83333333 0.66666667 0.66666667 0.50000000 0.66666667 0.66666667 0.0000000 9.2518585e-18 1.8503717e-17 0.16666667 0.33333333 0.33333333 0.16666667 0.0000000 0.0000000 0.0000000 0.0000000 0.33333333 0.16666667 0.16666667 0.0000000 0.16666667 0.16666667 0.33333333 0.16666667 0.33333333 0.16666667 0.33333333 0.0000000 0.16666667 0.33333333 0.33333333 0.33333333 0.66666667 0.33333333 0.33333333 0.66666667 0.50000000 0.50000000 0.50000000 0.33333333 0.66666667 0.50000000
+DEAL:0:SCG<3>(3)<->SCG<3>(3)::0.0000000 0.25000000 0.0000000 0.0000000 0.083333333 0.16666667 0.16666667 0.083333333 0.0000000 0.0000000 0.0000000 0.0000000 0.16666667 0.083333333 -1.1564823e-18 -2.3129646e-18 0.083333333 0.083333333 -1.7347235e-18 0.083333333 0.50000000 0.25000000 0.25000000 0.33333333 0.41666667 0.41666667 0.33333333 0.25000000 0.25000000 0.25000000 0.25000000 0.41666667 0.33333333 0.25000000 0.25000000 0.33333333 0.33333333 0.25000000 0.33333333 0.0000000 1.5612511e-17 0.083333333 0.16666667 0.16666667 0.083333333 0.0000000 0.0000000 1.7347235e-18 6.9388939e-18 0.16666667 0.083333333 1.4456029e-17 1.8503717e-17 0.083333333 0.083333333 6.9388939e-18 0.083333333 0.0000000 0.083333333 0.16666667 0.16666667 0.083333333 3.4694470e-18 -1.7347235e-18 0.0000000 0.0000000 0.16666667 0.083333333 9.2518585e-18 2.8912058e-18 0.083333333 0.083333333 5.3926038e-33 0.083333333 0.083333333 0.16666667 0.16666667 0.16666667 0.16666667 0.16666667 0.083333333 0.0000000 0.083333333 0.16666667 0.75000000 0.50000000 0.50000000 0.58333333 0.66666667 0.66666667 0.58333333 0.50000000 0.50000000 0.50000000 0.50000000 0.66666667 0.58333333 0.50000000 0.50000000 0.58333333 0.58333333 0.50000000 0.58333333 1.0000000 0.75000000 0.75000000 0.83333333 0.91666667 0.91666667 0.83333333 0.75000000 0.75000000 0.75000000 0.75000000 0.91666667 0.83333333 0.75000000 0.75000000 0.83333333 0.83333333 0.75000000 0.83333333 0.50000000 0.50000000 0.58333333 0.66666667 0.66666667 0.58333333 0.50000000 0.50000000 0.50000000 0.50000000 0.66666667 0.58333333 0.50000000 0.50000000 0.58333333 0.58333333 0.50000000 0.58333333 0.50000000 0.58333333 0.66666667 0.66666667 0.58333333 0.50000000 0.50000000 0.50000000 0.50000000 0.66666667 0.58333333 0.50000000 0.50000000 0.58333333 0.58333333 0.50000000 0.58333333 0.58333333 0.66666667 0.66666667 0.66666667 0.66666667 0.66666667 0.58333333 0.50000000 0.58333333 0.66666667 0.25000000 0.0000000 1.5612511e-17 0.083333333 0.16666667 0.16666667 0.083333333 0.0000000 0.0000000 1.4456029e-17 1.8503717e-17 0.16666667 0.083333333 -5.7824116e-19 5.7824116e-18 0.083333333 0.083333333 5.2041704e-18 0.083333333 0.25000000 0.25000000 0.33333333 0.41666667 0.41666667 0.33333333 0.25000000 0.25000000 0.25000000 0.25000000 0.41666667 0.33333333 0.25000000 0.25000000 0.33333333 0.33333333 0.25000000 0.33333333 0.0000000 1.5612511e-17 0.083333333 0.16666667 0.16666667 0.083333333 0.0000000 0.0000000 -2.8912058e-18 1.1564823e-18 0.16666667 0.083333333 2.8912058e-18 9.2518585e-18 0.083333333 0.083333333 -1.7347235e-18 0.083333333 0.0000000 0.083333333 0.16666667 0.16666667 0.083333333 5.2041704e-18 5.2041704e-18 9.2518585e-18 2.8912058e-18 0.16666667 0.083333333 1.8503717e-17 1.4456029e-17 0.083333333 0.083333333 6.9388939e-18 0.083333333 0.083333333 0.16666667 0.16666667 0.16666667 0.16666667 0.16666667 0.083333333 0.0000000 0.083333333 0.16666667 0.25000000 0.0000000 0.0000000 0.083333333 0.16666667 0.16666667 0.083333333 0.0000000 0.0000000 0.0000000 0.0000000 0.16666667 0.083333333 -2.3129646e-18 -1.1564823e-18 0.083333333 0.083333333 -1.7347235e-18 0.083333333 0.25000000 0.25000000 0.33333333 0.41666667 0.41666667 0.33333333 0.25000000 0.25000000 0.25000000 0.25000000 0.41666667 0.33333333 0.25000000 0.25000000 0.33333333 0.33333333 0.25000000 0.33333333 1.5612511e-17 0.083333333 0.16666667 0.16666667 0.083333333 0.0000000 0.0000000 -1.7347235e-18 3.4694470e-18 0.16666667 0.083333333 2.8912058e-18 9.2518585e-18 0.083333333 0.083333333 1.5407440e-33 0.083333333 0.0000000 0.083333333 0.16666667 0.16666667 0.083333333 6.9388939e-18 1.7347235e-18 0.0000000 0.0000000 0.16666667 0.083333333 1.8503717e-17 1.4456029e-17 0.083333333 0.083333333 6.9388939e-18 0.083333333 0.083333333 0.16666667 0.16666667 0.16666667 0.16666667 0.16666667 0.083333333 0.0000000 0.083333333 0.16666667 0.41666667 0.33333333 0.33333333 0.41666667 0.41666667 0.41666667 0.41666667 0.33333333 0.41666667 0.33333333 0.41666667 0.41666667 0.41666667 0.41666667 0.25000000 0.25000000 0.25000000 0.25000000 0.25000000 0.25000000 0.25000000 0.083333333 0.16666667 0.16666667 0.25000000 0.16666667 0.16666667 0.41666667 0.33333333 0.33333333 0.41666667 0.33333333 0.41666667 0.41666667 0.41666667 0.41666667 0.33333333 0.41666667 0.33333333 0.41666667 0.33333333 0.41666667 0.33333333 0.33333333 0.33333333 0.33333333 0.41666667 0.41666667 0.33333333 0.25000000 0.25000000 0.16666667 0.083333333 0.16666667 0.16666667 0.083333333 0.41666667 0.33333333 0.25000000 0.25000000 0.41666667 0.33333333 0.33333333 0.083333333 0.16666667 0.16666667 0.083333333 0.25000000 0.25000000 0.33333333 0.25000000 0.33333333 0.25000000 0.16666667 0.16666667 8.6736174e-18 8.6736174e-18 0.083333333 0.16666667 1.3877788e-17 0.083333333 0.083333333 -4.0476881e-18 2.3129646e-18 0.083333333 0.16666667 -1.7347235e-18 0.083333333 0.083333333 2.3129646e-18 -4.0476881e-18 -1.7347235e-18 0.083333333 0.25000000 0.25000000 0.25000000 0.33333333 0.083333333 0.16666667 0.0000000 0.083333333 0.083333333 0.16666667 0.16666667 0.16666667 0.41666667 0.33333333 0.41666667 0.33333333 0.33333333 0.41666667 0.41666667 0.33333333 0.25000000 0.25000000 0.16666667 0.16666667 0.16666667 0.25000000 0.25000000 0.33333333 0.33333333 0.25000000 0.25000000 0.16666667 0.25000000 0.25000000 0.25000000 0.25000000 0.16666667 0.083333333 0.083333333 0.16666667 0.25000000 0.25000000 0.25000000 0.25000000 0.16666667 0.16666667 0.16666667 0.25000000 0.50000000 0.50000000 0.50000000 0.50000000 0.41666667 0.33333333 0.33333333 0.41666667 0.50000000 0.50000000 0.50000000 0.50000000 0.41666667 0.41666667 0.41666667 0.50000000 0.50000000 0.50000000 0.33333333 0.41666667 0.50000000 0.50000000 0.41666667 0.33333333 0.33333333 0.41666667 0.50000000 0.50000000 0.50000000 0.50000000 0.41666667 0.41666667 0.41666667 0.50000000 0.50000000 0.33333333 0.41666667 0.50000000 0.50000000 0.41666667 0.33333333 0.33333333 0.41666667 0.50000000 0.50000000 0.50000000 0.50000000 0.41666667 0.41666667 0.41666667 0.50000000 0.33333333 0.41666667 0.33333333 0.33333333 0.41666667 0.33333333 0.33333333 0.33333333 0.41666667 0.50000000 0.75000000 0.75000000 0.75000000 0.75000000 0.66666667 0.58333333 0.58333333 0.66666667 0.75000000 0.75000000 0.75000000 0.75000000 0.66666667 0.66666667 0.66666667 0.75000000 1.0000000 1.0000000 1.0000000 1.0000000 0.91666667 0.83333333 0.83333333 0.91666667 1.0000000 1.0000000 1.0000000 1.0000000 0.91666667 0.91666667 0.91666667 1.0000000 1.0000000 1.0000000 0.83333333 0.91666667 1.0000000 1.0000000 0.91666667 0.83333333 0.83333333 0.91666667 1.0000000 1.0000000 1.0000000 1.0000000 0.91666667 0.91666667 0.91666667 1.0000000 1.0000000 0.83333333 0.91666667 1.0000000 1.0000000 0.91666667 0.83333333 0.83333333 0.91666667 1.0000000 1.0000000 1.0000000 1.0000000 0.91666667 0.91666667 0.91666667 1.0000000 0.83333333 0.91666667 0.83333333 0.83333333 0.91666667 0.83333333 0.83333333 0.83333333 0.91666667 1.0000000 0.75000000 0.75000000 0.75000000 0.58333333 0.66666667 0.75000000 0.75000000 0.66666667 0.58333333 0.58333333 0.66666667 0.75000000 0.75000000 0.75000000 0.75000000 0.66666667 0.66666667 0.66666667 0.75000000 1.0000000 1.0000000 0.83333333 0.91666667 1.0000000 1.0000000 0.91666667 0.83333333 0.83333333 0.91666667 1.0000000 1.0000000 1.0000000 1.0000000 0.91666667 0.91666667 0.91666667 1.0000000 1.0000000 1.0000000 0.83333333 0.91666667 1.0000000 1.0000000 0.91666667 0.83333333 0.83333333 0.91666667 1.0000000 1.0000000 1.0000000 1.0000000 0.91666667 0.91666667 0.91666667 1.0000000 1.0000000 0.83333333 0.91666667 1.0000000 1.0000000 0.91666667 0.83333333 0.83333333 0.91666667 1.0000000 1.0000000 1.0000000 1.0000000 0.91666667 0.91666667 0.91666667 1.0000000 0.83333333 0.91666667 0.83333333 0.83333333 0.91666667 0.83333333 0.83333333 0.83333333 0.91666667 1.0000000 0.75000000 0.75000000 0.75000000 0.58333333 0.66666667 0.75000000 0.75000000 0.66666667 0.58333333 0.58333333 0.66666667 0.75000000 0.75000000 0.75000000 0.75000000 0.66666667 0.66666667 0.66666667 0.75000000 1.0000000 1.0000000 0.83333333 0.91666667 1.0000000 1.0000000 0.91666667 0.83333333 0.83333333 0.91666667 1.0000000 1.0000000 1.0000000 1.0000000 0.91666667 0.91666667 0.91666667 1.0000000 1.0000000 0.83333333 0.91666667 1.0000000 1.0000000 0.91666667 0.83333333 0.83333333 0.91666667 1.0000000 1.0000000 1.0000000 1.0000000 0.91666667 0.91666667 0.91666667 1.0000000 1.0000000 0.83333333 0.91666667 1.0000000 1.0000000 0.91666667 0.83333333 0.83333333 0.91666667 1.0000000 1.0000000 1.0000000 1.0000000 0.91666667 0.91666667 0.91666667 1.0000000 0.83333333 0.91666667 0.83333333 0.83333333 0.91666667 0.83333333 0.83333333 0.83333333 0.91666667 1.0000000 0.66666667 0.58333333 0.58333333 0.66666667 0.58333333 0.58333333 0.66666667 0.75000000 0.75000000 0.83333333 0.91666667 0.83333333 0.83333333 0.91666667 0.75000000 0.58333333 0.66666667 0.58333333 0.66666667 0.75000000 0.75000000 0.58333333 0.66666667 0.58333333 0.66666667 0.58333333 0.66666667 0.91666667 0.83333333 0.75000000 0.75000000 0.83333333 0.91666667 0.83333333 0.83333333 0.91666667 0.75000000 0.75000000 0.66666667 0.75000000 0.66666667 0.83333333 0.66666667 0.75000000 0.83333333 0.58333333 0.66666667 0.58333333 0.58333333 0.66666667 0.58333333 0.66666667 0.58333333 0.58333333 0.58333333 0.58333333 0.75000000 0.75000000 0.75000000 0.75000000 0.83333333 0.75000000 0.83333333 0.58333333 0.66666667 0.58333333 0.58333333 0.58333333 0.66666667 0.66666667 0.66666667 0.66666667 0.58333333 0.58333333 0.66666667 0.66666667 0.58333333 0.75000000 0.75000000 0.58333333 0.66666667 0.66666667 0.75000000 0.75000000 0.83333333 0.91666667 0.83333333 0.91666667 0.83333333 0.58333333 0.66666667 0.58333333 0.66666667 0.83333333 0.91666667 0.83333333 0.91666667 0.75000000 0.75000000 0.66666667 0.75000000 0.66666667 0.83333333 0.83333333 0.75000000 1.0000000 1.0000000 1.0000000 0.91666667 1.0000000 1.0000000 1.0000000 0.91666667 1.0000000 1.0000000 1.0000000 0.91666667 0.75000000 0.91666667 0.83333333 1.0000000 0.91666667 0.91666667 0.83333333 0.83333333 1.0000000 0.83333333 0.91666667 1.0000000 1.0000000 0.83333333 0.91666667 1.0000000 1.0000000 0.91666667 0.91666667 1.0000000 0.91666667 0.75000000 0.75000000 0.58333333 0.66666667 0.75000000 0.75000000 0.75000000 0.75000000 0.58333333 0.66666667 0.75000000 0.75000000 0.66666667 0.66666667 0.75000000 0.66666667 1.0000000 1.0000000 0.91666667 0.83333333 0.83333333 0.91666667 1.0000000 1.0000000 1.0000000 1.0000000 0.83333333 0.91666667 1.0000000 1.0000000 0.91666667 0.91666667 1.0000000 0.91666667 0.91666667 0.83333333 0.83333333 0.91666667 1.0000000 1.0000000 0.83333333 0.91666667 1.0000000 1.0000000 0.91666667 0.91666667 1.0000000 0.91666667 0.91666667 0.83333333 0.83333333 0.83333333 0.83333333 0.83333333 0.91666667 1.0000000 0.91666667 0.83333333 0.50000000 0.50000000 0.33333333 0.41666667 0.50000000 0.50000000 0.50000000 0.50000000 0.33333333 0.41666667 0.50000000 0.50000000 0.41666667 0.41666667 0.50000000 0.41666667 0.25000000 0.25000000 0.083333333 0.16666667 0.25000000 0.25000000 0.25000000 0.25000000 0.083333333 0.16666667 0.25000000 0.25000000 0.16666667 0.16666667 0.25000000 0.16666667 0.50000000 0.50000000 0.41666667 0.33333333 0.33333333 0.41666667 0.50000000 0.50000000 0.50000000 0.50000000 0.33333333 0.41666667 0.50000000 0.50000000 0.41666667 0.41666667 0.50000000 0.41666667 0.50000000 0.41666667 0.33333333 0.33333333 0.41666667 0.50000000 0.50000000 0.50000000 0.50000000 0.33333333 0.41666667 0.50000000 0.50000000 0.41666667 0.41666667 0.50000000 0.41666667 0.41666667 0.33333333 0.33333333 0.33333333 0.33333333 0.33333333 0.41666667 0.50000000 0.41666667 0.33333333 0.75000000 1.0000000 1.0000000 0.91666667 0.83333333 0.83333333 0.91666667 1.0000000 1.0000000 1.0000000 1.0000000 0.83333333 0.91666667 1.0000000 1.0000000 0.91666667 0.91666667 1.0000000 0.91666667 0.75000000 0.75000000 0.66666667 0.58333333 0.58333333 0.66666667 0.75000000 0.75000000 0.75000000 0.75000000 0.58333333 0.66666667 0.75000000 0.75000000 0.66666667 0.66666667 0.75000000 0.66666667 1.0000000 1.0000000 0.91666667 0.83333333 0.83333333 0.91666667 1.0000000 1.0000000 1.0000000 1.0000000 0.83333333 0.91666667 1.0000000 1.0000000 0.91666667 0.91666667 1.0000000 0.91666667 1.0000000 0.91666667 0.83333333 0.83333333 0.91666667 1.0000000 1.0000000 1.0000000 1.0000000 0.83333333 0.91666667 1.0000000 1.0000000 0.91666667 0.91666667 1.0000000 0.91666667 0.91666667 0.83333333 0.83333333 0.83333333 0.83333333 0.83333333 0.91666667 1.0000000 0.91666667 0.83333333 0.75000000 1.0000000 0.91666667 0.83333333 0.83333333 0.91666667 1.0000000 1.0000000 0.83333333 0.91666667 1.0000000 1.0000000 0.91666667 0.91666667 1.0000000 0.91666667 0.75000000 0.75000000 0.66666667 0.58333333 0.58333333 0.66666667 0.75000000 0.75000000 0.75000000 0.75000000 0.58333333 0.66666667 0.75000000 0.75000000 0.66666667 0.66666667 0.75000000 0.66666667 1.0000000 0.91666667 0.83333333 0.83333333 0.91666667 1.0000000 1.0000000 1.0000000 1.0000000 0.83333333 0.91666667 1.0000000 1.0000000 0.91666667 0.91666667 1.0000000 0.91666667 0.91666667 0.83333333 0.83333333 0.91666667 1.0000000 1.0000000 0.83333333 0.91666667 1.0000000 1.0000000 0.91666667 0.91666667 1.0000000 0.91666667 0.91666667 0.83333333 0.83333333 0.83333333 0.83333333 0.83333333 0.91666667 1.0000000 0.91666667 0.83333333 0.58333333 0.66666667 0.66666667 0.58333333 0.58333333 0.58333333 0.58333333 0.66666667 0.58333333 0.66666667 0.58333333 0.58333333 0.58333333 0.58333333 0.75000000 0.75000000 0.75000000 0.75000000 0.75000000 0.75000000 0.75000000 0.91666667 0.83333333 0.83333333 0.75000000 0.83333333 0.83333333 0.58333333 0.66666667 0.66666667 0.58333333 0.66666667 0.58333333 0.58333333 0.58333333 0.58333333 0.66666667 0.58333333 0.66666667 0.58333333 0.66666667 0.58333333 0.66666667 0.66666667 0.66666667 0.66666667 0.58333333 0.58333333 0.66666667 0.75000000 0.75000000 0.83333333 0.91666667 0.83333333 0.83333333 0.91666667 0.58333333 0.66666667 0.75000000 0.75000000 0.58333333 0.66666667 0.66666667 0.91666667 0.83333333 0.83333333 0.91666667 0.75000000 0.75000000 0.66666667 0.75000000 0.66666667 0.75000000 0.83333333 0.83333333 1.0000000 1.0000000 0.91666667 0.83333333 1.0000000 0.91666667 0.91666667 1.0000000 1.0000000 0.91666667 0.83333333 1.0000000 0.91666667 0.91666667 1.0000000 1.0000000 1.0000000 0.91666667 0.75000000 0.75000000 0.75000000 0.66666667 0.91666667 0.83333333 1.0000000 0.91666667 0.91666667 0.83333333 0.83333333 0.83333333 0.58333333 0.66666667 0.58333333 0.66666667 0.66666667 0.58333333 0.58333333 0.66666667 0.75000000 0.75000000 0.83333333 0.83333333 0.83333333 0.75000000 0.75000000 0.66666667 0.66666667 0.75000000 0.75000000 0.83333333 0.0000000 0.083333333 0.16666667 0.0000000 0.0000000 3.4694470e-18 -1.7347235e-18 0.16666667 0.083333333 0.083333333 3.8518599e-33 0.083333333 0.083333333 0.25000000 0.0000000 0.083333333 0.16666667 0.16666667 0.083333333 6.9388939e-18 1.7347235e-18 0.0000000 0.0000000 0.16666667 0.083333333 0.083333333 6.9388939e-18 0.083333333 0.083333333 0.25000000 0.25000000 0.25000000 0.33333333 0.41666667 0.25000000 0.25000000 0.25000000 0.25000000 0.41666667 0.33333333 0.33333333 0.25000000 0.33333333 0.33333333 0.0000000 -2.3129646e-18 -1.1564823e-18 0.083333333 0.16666667 0.16666667 0.083333333 0.0000000 0.0000000 0.0000000 0.0000000 0.16666667 0.083333333 0.083333333 -1.7347235e-18 0.083333333 0.083333333 0.16666667 0.083333333 0.16666667 0.083333333 0.16666667 0.0000000 0.083333333 0.16666667 0.16666667 0.16666667 0.25000000 0.0000000 0.083333333 0.16666667 0.16666667 0.083333333 0.0000000 0.0000000 3.4694470e-18 -1.7347235e-18 0.16666667 0.083333333 0.083333333 3.8518599e-33 0.083333333 0.083333333 0.0000000 0.16666667 0.083333333 6.9388939e-18 1.7347235e-18 0.0000000 0.0000000 0.16666667 0.083333333 0.083333333 6.9388939e-18 0.083333333 0.083333333 0.25000000 0.25000000 0.25000000 0.41666667 0.33333333 0.25000000 0.25000000 0.25000000 0.25000000 0.41666667 0.33333333 0.33333333 0.25000000 0.33333333 0.33333333 0.0000000 -2.3129646e-18 -1.1564823e-18 0.083333333 0.16666667 0.16666667 0.083333333 0.0000000 0.0000000 0.0000000 0.0000000 0.16666667 0.083333333 0.083333333 -1.7347235e-18 0.083333333 0.083333333 0.16666667 0.083333333 0.16666667 0.083333333 0.16666667 0.0000000 0.083333333 0.16666667 0.16666667 0.16666667 0.50000000 0.50000000 0.50000000 0.50000000 0.58333333 0.66666667 0.50000000 0.50000000 0.50000000 0.50000000 0.66666667 0.58333333 0.58333333 0.50000000 0.58333333 0.58333333 0.50000000 0.50000000 0.50000000 0.66666667 0.58333333 0.50000000 0.50000000 0.50000000 0.50000000 0.66666667 0.58333333 0.58333333 0.50000000 0.58333333 0.58333333 0.75000000 0.75000000 0.75000000 0.75000000 0.75000000 0.75000000 0.75000000 0.91666667 0.83333333 0.83333333 0.75000000 0.83333333 0.83333333 0.50000000 0.50000000 0.50000000 0.58333333 0.66666667 0.66666667 0.58333333 0.50000000 0.50000000 0.50000000 0.50000000 0.66666667 0.58333333 0.58333333 0.50000000 0.58333333 0.58333333 0.66666667 0.58333333 0.66666667 0.58333333 0.66666667 0.50000000 0.58333333 0.66666667 0.66666667 0.66666667 1.5612511e-17 0.25000000 0.0000000 2.8912058e-18 9.2518585e-18 0.083333333 0.16666667 0.16666667 0.083333333 0.0000000 0.0000000 3.4694470e-18 -1.7347235e-18 0.16666667 0.083333333 0.083333333 3.8518599e-33 0.083333333 0.083333333 0.25000000 0.0000000 1.8503717e-17 1.4456029e-17 0.083333333 0.16666667 0.16666667 0.083333333 6.9388939e-18 1.7347235e-18 0.0000000 0.0000000 0.16666667 0.083333333 0.083333333 6.9388939e-18 0.083333333 0.083333333 0.25000000 0.25000000 0.25000000 0.33333333 0.41666667 0.41666667 0.33333333 0.25000000 0.25000000 0.25000000 0.25000000 0.41666667 0.33333333 0.33333333 0.25000000 0.33333333 0.33333333 0.0000000 -2.3129646e-18 -1.1564823e-18 0.083333333 0.16666667 0.16666667 0.083333333 0.0000000 0.0000000 0.0000000 0.0000000 0.16666667 0.083333333 0.083333333 -1.7347235e-18 0.083333333 0.083333333 0.16666667 0.083333333 0.16666667 0.083333333 0.16666667 0.0000000 0.083333333 0.16666667 0.16666667 0.16666667 0.25000000 0.25000000 0.16666667 0.083333333 0.16666667 0.083333333 0.16666667 0.41666667 0.33333333 0.41666667 0.33333333 0.41666667 0.33333333 0.41666667 0.25000000 0.33333333 0.41666667 0.25000000 0.25000000 0.41666667 0.33333333 0.41666667 0.33333333 0.41666667 0.33333333 0.33333333 0.41666667 0.25000000 0.25000000 0.16666667 0.083333333 0.16666667 0.083333333 0.16666667 0.083333333 0.16666667 0.25000000 0.25000000 0.33333333 0.33333333 0.25000000 0.16666667 0.25000000 0.16666667 0.33333333 -2.3129646e-18 -1.1564823e-18 -1.7347235e-18 0.083333333 3.4694470e-18 -1.7347235e-18 0.083333333 0.16666667 2.3111159e-33 0.083333333 0.083333333 1.7347235e-18 6.9388939e-18 0.083333333 0.16666667 6.9388939e-18 0.083333333 0.083333333 0.25000000 0.25000000 0.25000000 0.33333333 0.083333333 0.16666667 0.0000000 0.083333333 0.083333333 0.16666667 0.16666667 0.16666667 0.41666667 0.33333333 0.41666667 0.33333333 0.41666667 0.41666667 0.33333333 0.33333333 0.41666667 0.41666667 0.33333333 0.41666667 0.41666667 0.33333333 0.25000000 0.25000000 0.16666667 0.16666667 0.25000000 0.25000000 0.16666667 0.16666667 0.25000000 0.25000000 0.33333333 0.33333333 0.25000000 0.33333333 0.25000000 0.16666667 0.33333333 0.41666667 0.41666667 0.41666667 0.25000000 0.25000000 0.16666667 0.25000000 0.41666667 0.33333333 0.41666667 0.41666667 0.41666667 0.41666667 0.33333333 0.33333333 0.33333333 0.33333333 0.41666667 0.41666667 0.83333333 0.58333333 0.66666667 0.66666667 0.58333333 0.58333333 0.66666667 0.66666667 0.58333333 0.75000000 0.75000000 0.83333333 0.83333333 0.75000000 0.75000000 0.75000000 0.66666667 0.83333333 0.75000000 0.66666667 0.33333333 0.41666667 0.41666667 0.33333333 0.16666667 0.25000000 0.25000000 0.16666667 0.16666667 0.33333333 0.41666667 0.33333333 0.41666667 0.25000000 0.25000000 0.25000000 0.16666667 0.33333333 0.33333333 0.25000000 0.33333333 0.41666667 0.41666667 0.33333333 0.25000000 0.25000000 0.16666667 0.16666667 0.16666667 0.41666667 0.33333333 0.33333333 0.41666667 0.25000000 0.25000000 0.25000000 0.16666667 0.33333333 0.33333333 0.25000000 0.75000000 0.75000000 0.83333333 0.83333333 0.58333333 0.66666667 0.58333333 0.66666667 0.66666667 0.58333333 0.58333333 0.66666667 0.83333333 0.75000000 0.75000000 0.66666667 0.75000000 0.66666667 0.83333333 0.75000000 0.50000000 0.50000000 0.50000000 0.41666667 0.25000000 0.25000000 0.25000000 0.16666667 0.50000000 0.50000000 0.50000000 0.33333333 0.41666667 0.50000000 0.50000000 0.41666667 0.50000000 0.41666667 0.33333333 0.41666667 0.50000000 0.50000000 0.50000000 0.50000000 0.41666667 0.50000000 0.41666667 0.33333333 0.41666667 0.33333333 0.41666667 0.41666667 0.33333333 0.50000000 0.33333333 0.58333333 0.75000000 0.75000000 0.75000000 0.83333333 0.66666667 0.58333333 0.58333333 0.58333333 0.66666667 0.58333333 0.58333333 0.58333333 0.66666667 0.58333333 0.66666667 0.58333333 0.58333333 0.66666667 0.66666667 0.50000000 0.50000000 0.50000000 0.58333333 0.50000000 0.50000000 0.50000000 0.58333333 0.75000000 0.50000000 0.50000000 0.58333333 0.50000000 0.66666667 0.58333333 0.58333333 0.66666667 0.50000000 0.58333333 0.66666667 0.25000000 0.41666667 0.41666667 0.41666667 0.33333333 0.41666667 0.33333333 0.41666667 0.33333333 0.41666667
+DEAL:0:SCG<3>(3)<->SCG<3>(3)::79.960985
+DEAL:0:SCG<3>(3)<->SCG<3>(3)::0.0000000 0.25000000 0.0000000 0.0000000 0.083333333 0.16666667 0.16666667 0.083333333 0.0000000 0.0000000 0.0000000 0.0000000 0.16666667 0.083333333 9.2518585e-18 4.6259293e-18 0.083333333 0.083333333 0.0000000 0.083333333 0.50000000 0.25000000 0.25000000 0.33333333 0.41666667 0.41666667 0.33333333 0.25000000 0.25000000 0.25000000 0.25000000 0.41666667 0.33333333 0.25000000 0.25000000 0.33333333 0.33333333 0.25000000 0.33333333 0.0000000 0.0000000 0.083333333 0.16666667 0.16666667 0.083333333 0.0000000 0.0000000 9.2518585e-18 4.6259293e-18 0.16666667 0.083333333 9.2518585e-18 4.6259293e-18 0.083333333 0.083333333 0.0000000 0.083333333 0.0000000 0.083333333 0.16666667 0.16666667 0.083333333 0.0000000 0.0000000 0.0000000 0.0000000 0.16666667 0.083333333 9.2518585e-18 4.6259293e-18 0.083333333 0.083333333 0.0000000 0.083333333 0.083333333 0.16666667 0.16666667 0.16666667 0.16666667 0.16666667 0.083333333 0.0000000 0.083333333 0.16666667 0.75000000 0.50000000 0.50000000 0.58333333 0.66666667 0.66666667 0.58333333 0.50000000 0.50000000 0.50000000 0.50000000 0.66666667 0.58333333 0.50000000 0.50000000 0.58333333 0.58333333 0.50000000 0.58333333 1.0000000 0.75000000 0.75000000 0.83333333 0.91666667 0.91666667 0.83333333 0.75000000 0.75000000 0.75000000 0.75000000 0.91666667 0.83333333 0.75000000 0.75000000 0.83333333 0.83333333 0.75000000 0.83333333 0.50000000 0.50000000 0.58333333 0.66666667 0.66666667 0.58333333 0.50000000 0.50000000 0.50000000 0.50000000 0.66666667 0.58333333 0.50000000 0.50000000 0.58333333 0.58333333 0.50000000 0.58333333 0.50000000 0.58333333 0.66666667 0.66666667 0.58333333 0.50000000 0.50000000 0.50000000 0.50000000 0.66666667 0.58333333 0.50000000 0.50000000 0.58333333 0.58333333 0.50000000 0.58333333 0.58333333 0.66666667 0.66666667 0.66666667 0.66666667 0.66666667 0.58333333 0.50000000 0.58333333 0.66666667 0.25000000 0.0000000 0.0000000 0.083333333 0.16666667 0.16666667 0.083333333 0.0000000 0.0000000 9.2518585e-18 4.6259293e-18 0.16666667 0.083333333 9.2518585e-18 4.6259293e-18 0.083333333 0.083333333 0.0000000 0.083333333 0.25000000 0.25000000 0.33333333 0.41666667 0.41666667 0.33333333 0.25000000 0.25000000 0.25000000 0.25000000 0.41666667 0.33333333 0.25000000 0.25000000 0.33333333 0.33333333 0.25000000 0.33333333 0.0000000 0.0000000 0.083333333 0.16666667 0.16666667 0.083333333 0.0000000 0.0000000 9.2518585e-18 4.6259293e-18 0.16666667 0.083333333 4.6259293e-18 9.2518585e-18 0.083333333 0.083333333 0.0000000 0.083333333 0.0000000 0.083333333 0.16666667 0.16666667 0.083333333 0.0000000 0.0000000 9.2518585e-18 4.6259293e-18 0.16666667 0.083333333 4.6259293e-18 9.2518585e-18 0.083333333 0.083333333 0.0000000 0.083333333 0.083333333 0.16666667 0.16666667 0.16666667 0.16666667 0.16666667 0.083333333 0.0000000 0.083333333 0.16666667 0.25000000 0.0000000 0.0000000 0.083333333 0.16666667 0.16666667 0.083333333 0.0000000 0.0000000 0.0000000 0.0000000 0.16666667 0.083333333 9.2518585e-18 4.6259293e-18 0.083333333 0.083333333 0.0000000 0.083333333 0.25000000 0.25000000 0.33333333 0.41666667 0.41666667 0.33333333 0.25000000 0.25000000 0.25000000 0.25000000 0.41666667 0.33333333 0.25000000 0.25000000 0.33333333 0.33333333 0.25000000 0.33333333 0.0000000 0.083333333 0.16666667 0.16666667 0.083333333 0.0000000 0.0000000 9.2518585e-18 4.6259293e-18 0.16666667 0.083333333 4.6259293e-18 9.2518585e-18 0.083333333 0.083333333 0.0000000 0.083333333 0.0000000 0.083333333 0.16666667 0.16666667 0.083333333 0.0000000 0.0000000 0.0000000 0.0000000 0.16666667 0.083333333 4.6259293e-18 9.2518585e-18 0.083333333 0.083333333 0.0000000 0.083333333 0.083333333 0.16666667 0.16666667 0.16666667 0.16666667 0.16666667 0.083333333 0.0000000 0.083333333 0.16666667 0.41666667 0.33333333 0.33333333 0.41666667 0.41666667 0.41666667 0.41666667 0.33333333 0.41666667 0.33333333 0.41666667 0.41666667 0.41666667 0.41666667 0.25000000 0.25000000 0.25000000 0.25000000 0.25000000 0.25000000 0.25000000 0.083333333 0.16666667 0.16666667 0.25000000 0.16666667 0.16666667 0.41666667 0.33333333 0.33333333 0.41666667 0.33333333 0.41666667 0.41666667 0.41666667 0.41666667 0.33333333 0.41666667 0.33333333 0.41666667 0.33333333 0.41666667 0.33333333 0.33333333 0.33333333 0.33333333 0.41666667 0.41666667 0.33333333 0.25000000 0.25000000 0.16666667 0.083333333 0.16666667 0.16666667 0.083333333 0.41666667 0.33333333 0.25000000 0.25000000 0.41666667 0.33333333 0.33333333 0.083333333 0.16666667 0.16666667 0.083333333 0.25000000 0.25000000 0.33333333 0.25000000 0.33333333 0.25000000 0.16666667 0.16666667 0.0000000 0.0000000 0.083333333 0.16666667 0.0000000 0.083333333 0.083333333 0.0000000 0.0000000 0.083333333 0.16666667 0.0000000 0.083333333 0.083333333 0.0000000 0.0000000 0.0000000 0.083333333 0.25000000 0.25000000 0.25000000 0.33333333 0.083333333 0.16666667 0.0000000 0.083333333 0.083333333 0.16666667 0.16666667 0.16666667 0.41666667 0.33333333 0.41666667 0.33333333 0.33333333 0.41666667 0.41666667 0.33333333 0.25000000 0.25000000 0.16666667 0.16666667 0.16666667 0.25000000 0.25000000 0.33333333 0.33333333 0.25000000 0.25000000 0.16666667 0.25000000 0.25000000 0.25000000 0.25000000 0.16666667 0.083333333 0.083333333 0.16666667 0.25000000 0.25000000 0.25000000 0.25000000 0.16666667 0.16666667 0.16666667 0.25000000 0.50000000 0.50000000 0.50000000 0.50000000 0.41666667 0.33333333 0.33333333 0.41666667 0.50000000 0.50000000 0.50000000 0.50000000 0.41666667 0.41666667 0.41666667 0.50000000 0.50000000 0.50000000 0.33333333 0.41666667 0.50000000 0.50000000 0.41666667 0.33333333 0.33333333 0.41666667 0.50000000 0.50000000 0.50000000 0.50000000 0.41666667 0.41666667 0.41666667 0.50000000 0.50000000 0.33333333 0.41666667 0.50000000 0.50000000 0.41666667 0.33333333 0.33333333 0.41666667 0.50000000 0.50000000 0.50000000 0.50000000 0.41666667 0.41666667 0.41666667 0.50000000 0.33333333 0.41666667 0.33333333 0.33333333 0.41666667 0.33333333 0.33333333 0.33333333 0.41666667 0.50000000 0.75000000 0.75000000 0.75000000 0.75000000 0.66666667 0.58333333 0.58333333 0.66666667 0.75000000 0.75000000 0.75000000 0.75000000 0.66666667 0.66666667 0.66666667 0.75000000 1.0000000 1.0000000 1.0000000 1.0000000 0.91666667 0.83333333 0.83333333 0.91666667 1.0000000 1.0000000 1.0000000 1.0000000 0.91666667 0.91666667 0.91666667 1.0000000 1.0000000 1.0000000 0.83333333 0.91666667 1.0000000 1.0000000 0.91666667 0.83333333 0.83333333 0.91666667 1.0000000 1.0000000 1.0000000 1.0000000 0.91666667 0.91666667 0.91666667 1.0000000 1.0000000 0.83333333 0.91666667 1.0000000 1.0000000 0.91666667 0.83333333 0.83333333 0.91666667 1.0000000 1.0000000 1.0000000 1.0000000 0.91666667 0.91666667 0.91666667 1.0000000 0.83333333 0.91666667 0.83333333 0.83333333 0.91666667 0.83333333 0.83333333 0.83333333 0.91666667 1.0000000 0.75000000 0.75000000 0.75000000 0.58333333 0.66666667 0.75000000 0.75000000 0.66666667 0.58333333 0.58333333 0.66666667 0.75000000 0.75000000 0.75000000 0.75000000 0.66666667 0.66666667 0.66666667 0.75000000 1.0000000 1.0000000 0.83333333 0.91666667 1.0000000 1.0000000 0.91666667 0.83333333 0.83333333 0.91666667 1.0000000 1.0000000 1.0000000 1.0000000 0.91666667 0.91666667 0.91666667 1.0000000 1.0000000 1.0000000 0.83333333 0.91666667 1.0000000 1.0000000 0.91666667 0.83333333 0.83333333 0.91666667 1.0000000 1.0000000 1.0000000 1.0000000 0.91666667 0.91666667 0.91666667 1.0000000 1.0000000 0.83333333 0.91666667 1.0000000 1.0000000 0.91666667 0.83333333 0.83333333 0.91666667 1.0000000 1.0000000 1.0000000 1.0000000 0.91666667 0.91666667 0.91666667 1.0000000 0.83333333 0.91666667 0.83333333 0.83333333 0.91666667 0.83333333 0.83333333 0.83333333 0.91666667 1.0000000 0.75000000 0.75000000 0.75000000 0.58333333 0.66666667 0.75000000 0.75000000 0.66666667 0.58333333 0.58333333 0.66666667 0.75000000 0.75000000 0.75000000 0.75000000 0.66666667 0.66666667 0.66666667 0.75000000 1.0000000 1.0000000 0.83333333 0.91666667 1.0000000 1.0000000 0.91666667 0.83333333 0.83333333 0.91666667 1.0000000 1.0000000 1.0000000 1.0000000 0.91666667 0.91666667 0.91666667 1.0000000 1.0000000 0.83333333 0.91666667 1.0000000 1.0000000 0.91666667 0.83333333 0.83333333 0.91666667 1.0000000 1.0000000 1.0000000 1.0000000 0.91666667 0.91666667 0.91666667 1.0000000 1.0000000 0.83333333 0.91666667 1.0000000 1.0000000 0.91666667 0.83333333 0.83333333 0.91666667 1.0000000 1.0000000 1.0000000 1.0000000 0.91666667 0.91666667 0.91666667 1.0000000 0.83333333 0.91666667 0.83333333 0.83333333 0.91666667 0.83333333 0.83333333 0.83333333 0.91666667 1.0000000 0.66666667 0.58333333 0.58333333 0.66666667 0.58333333 0.58333333 0.66666667 0.75000000 0.75000000 0.83333333 0.91666667 0.83333333 0.83333333 0.91666667 0.75000000 0.58333333 0.66666667 0.58333333 0.66666667 0.75000000 0.75000000 0.58333333 0.66666667 0.58333333 0.66666667 0.58333333 0.66666667 0.91666667 0.83333333 0.75000000 0.75000000 0.83333333 0.91666667 0.83333333 0.83333333 0.91666667 0.75000000 0.75000000 0.66666667 0.75000000 0.66666667 0.83333333 0.66666667 0.75000000 0.83333333 0.58333333 0.66666667 0.58333333 0.58333333 0.66666667 0.58333333 0.66666667 0.58333333 0.58333333 0.58333333 0.58333333 0.75000000 0.75000000 0.75000000 0.75000000 0.83333333 0.75000000 0.83333333 0.58333333 0.66666667 0.58333333 0.58333333 0.58333333 0.66666667 0.66666667 0.66666667 0.66666667 0.58333333 0.58333333 0.66666667 0.66666667 0.58333333 0.75000000 0.75000000 0.58333333 0.66666667 0.66666667 0.75000000 0.75000000 0.83333333 0.91666667 0.83333333 0.91666667 0.83333333 0.58333333 0.66666667 0.58333333 0.66666667 0.83333333 0.91666667 0.83333333 0.91666667 0.75000000 0.75000000 0.66666667 0.75000000 0.66666667 0.83333333 0.83333333 0.75000000 1.0000000 1.0000000 1.0000000 0.91666667 1.0000000 1.0000000 1.0000000 0.91666667 1.0000000 1.0000000 1.0000000 0.91666667 0.75000000 0.91666667 0.83333333 1.0000000 0.91666667 0.91666667 0.83333333 0.83333333 1.0000000 0.83333333 0.91666667 1.0000000 1.0000000 0.83333333 0.91666667 1.0000000 1.0000000 0.91666667 0.91666667 1.0000000 0.91666667 0.75000000 0.75000000 0.58333333 0.66666667 0.75000000 0.75000000 0.75000000 0.75000000 0.58333333 0.66666667 0.75000000 0.75000000 0.66666667 0.66666667 0.75000000 0.66666667 1.0000000 1.0000000 0.91666667 0.83333333 0.83333333 0.91666667 1.0000000 1.0000000 1.0000000 1.0000000 0.83333333 0.91666667 1.0000000 1.0000000 0.91666667 0.91666667 1.0000000 0.91666667 0.91666667 0.83333333 0.83333333 0.91666667 1.0000000 1.0000000 0.83333333 0.91666667 1.0000000 1.0000000 0.91666667 0.91666667 1.0000000 0.91666667 0.91666667 0.83333333 0.83333333 0.83333333 0.83333333 0.83333333 0.91666667 1.0000000 0.91666667 0.83333333 0.50000000 0.50000000 0.33333333 0.41666667 0.50000000 0.50000000 0.50000000 0.50000000 0.33333333 0.41666667 0.50000000 0.50000000 0.41666667 0.41666667 0.50000000 0.41666667 0.25000000 0.25000000 0.083333333 0.16666667 0.25000000 0.25000000 0.25000000 0.25000000 0.083333333 0.16666667 0.25000000 0.25000000 0.16666667 0.16666667 0.25000000 0.16666667 0.50000000 0.50000000 0.41666667 0.33333333 0.33333333 0.41666667 0.50000000 0.50000000 0.50000000 0.50000000 0.33333333 0.41666667 0.50000000 0.50000000 0.41666667 0.41666667 0.50000000 0.41666667 0.50000000 0.41666667 0.33333333 0.33333333 0.41666667 0.50000000 0.50000000 0.50000000 0.50000000 0.33333333 0.41666667 0.50000000 0.50000000 0.41666667 0.41666667 0.50000000 0.41666667 0.41666667 0.33333333 0.33333333 0.33333333 0.33333333 0.33333333 0.41666667 0.50000000 0.41666667 0.33333333 0.75000000 1.0000000 1.0000000 0.91666667 0.83333333 0.83333333 0.91666667 1.0000000 1.0000000 1.0000000 1.0000000 0.83333333 0.91666667 1.0000000 1.0000000 0.91666667 0.91666667 1.0000000 0.91666667 0.75000000 0.75000000 0.66666667 0.58333333 0.58333333 0.66666667 0.75000000 0.75000000 0.75000000 0.75000000 0.58333333 0.66666667 0.75000000 0.75000000 0.66666667 0.66666667 0.75000000 0.66666667 1.0000000 1.0000000 0.91666667 0.83333333 0.83333333 0.91666667 1.0000000 1.0000000 1.0000000 1.0000000 0.83333333 0.91666667 1.0000000 1.0000000 0.91666667 0.91666667 1.0000000 0.91666667 1.0000000 0.91666667 0.83333333 0.83333333 0.91666667 1.0000000 1.0000000 1.0000000 1.0000000 0.83333333 0.91666667 1.0000000 1.0000000 0.91666667 0.91666667 1.0000000 0.91666667 0.91666667 0.83333333 0.83333333 0.83333333 0.83333333 0.83333333 0.91666667 1.0000000 0.91666667 0.83333333 0.75000000 1.0000000 0.91666667 0.83333333 0.83333333 0.91666667 1.0000000 1.0000000 0.83333333 0.91666667 1.0000000 1.0000000 0.91666667 0.91666667 1.0000000 0.91666667 0.75000000 0.75000000 0.66666667 0.58333333 0.58333333 0.66666667 0.75000000 0.75000000 0.75000000 0.75000000 0.58333333 0.66666667 0.75000000 0.75000000 0.66666667 0.66666667 0.75000000 0.66666667 1.0000000 0.91666667 0.83333333 0.83333333 0.91666667 1.0000000 1.0000000 1.0000000 1.0000000 0.83333333 0.91666667 1.0000000 1.0000000 0.91666667 0.91666667 1.0000000 0.91666667 0.91666667 0.83333333 0.83333333 0.91666667 1.0000000 1.0000000 0.83333333 0.91666667 1.0000000 1.0000000 0.91666667 0.91666667 1.0000000 0.91666667 0.91666667 0.83333333 0.83333333 0.83333333 0.83333333 0.83333333 0.91666667 1.0000000 0.91666667 0.83333333 0.58333333 0.66666667 0.66666667 0.58333333 0.58333333 0.58333333 0.58333333 0.66666667 0.58333333 0.66666667 0.58333333 0.58333333 0.58333333 0.58333333 0.75000000 0.75000000 0.75000000 0.75000000 0.75000000 0.75000000 0.75000000 0.91666667 0.83333333 0.83333333 0.75000000 0.83333333 0.83333333 0.58333333 0.66666667 0.66666667 0.58333333 0.66666667 0.58333333 0.58333333 0.58333333 0.58333333 0.66666667 0.58333333 0.66666667 0.58333333 0.66666667 0.58333333 0.66666667 0.66666667 0.66666667 0.66666667 0.58333333 0.58333333 0.66666667 0.75000000 0.75000000 0.83333333 0.91666667 0.83333333 0.83333333 0.91666667 0.58333333 0.66666667 0.75000000 0.75000000 0.58333333 0.66666667 0.66666667 0.91666667 0.83333333 0.83333333 0.91666667 0.75000000 0.75000000 0.66666667 0.75000000 0.66666667 0.75000000 0.83333333 0.83333333 1.0000000 1.0000000 0.91666667 0.83333333 1.0000000 0.91666667 0.91666667 1.0000000 1.0000000 0.91666667 0.83333333 1.0000000 0.91666667 0.91666667 1.0000000 1.0000000 1.0000000 0.91666667 0.75000000 0.75000000 0.75000000 0.66666667 0.91666667 0.83333333 1.0000000 0.91666667 0.91666667 0.83333333 0.83333333 0.83333333 0.58333333 0.66666667 0.58333333 0.66666667 0.66666667 0.58333333 0.58333333 0.66666667 0.75000000 0.75000000 0.83333333 0.83333333 0.83333333 0.75000000 0.75000000 0.66666667 0.66666667 0.75000000 0.75000000 0.83333333 0.0000000 0.083333333 0.16666667 0.0000000 0.0000000 0.0000000 0.0000000 0.16666667 0.083333333 0.083333333 0.0000000 0.083333333 0.083333333 0.25000000 0.0000000 0.083333333 0.16666667 0.16666667 0.083333333 0.0000000 0.0000000 0.0000000 0.0000000 0.16666667 0.083333333 0.083333333 0.0000000 0.083333333 0.083333333 0.25000000 0.25000000 0.25000000 0.33333333 0.41666667 0.25000000 0.25000000 0.25000000 0.25000000 0.41666667 0.33333333 0.33333333 0.25000000 0.33333333 0.33333333 0.0000000 4.6259293e-18 9.2518585e-18 0.083333333 0.16666667 0.16666667 0.083333333 0.0000000 0.0000000 0.0000000 0.0000000 0.16666667 0.083333333 0.083333333 0.0000000 0.083333333 0.083333333 0.16666667 0.083333333 0.16666667 0.083333333 0.16666667 0.0000000 0.083333333 0.16666667 0.16666667 0.16666667 0.25000000 0.0000000 0.083333333 0.16666667 0.16666667 0.083333333 0.0000000 0.0000000 0.0000000 0.0000000 0.16666667 0.083333333 0.083333333 0.0000000 0.083333333 0.083333333 0.0000000 0.16666667 0.083333333 0.0000000 0.0000000 0.0000000 0.0000000 0.16666667 0.083333333 0.083333333 0.0000000 0.083333333 0.083333333 0.25000000 0.25000000 0.25000000 0.41666667 0.33333333 0.25000000 0.25000000 0.25000000 0.25000000 0.41666667 0.33333333 0.33333333 0.25000000 0.33333333 0.33333333 0.0000000 4.6259293e-18 9.2518585e-18 0.083333333 0.16666667 0.16666667 0.083333333 0.0000000 0.0000000 0.0000000 0.0000000 0.16666667 0.083333333 0.083333333 0.0000000 0.083333333 0.083333333 0.16666667 0.083333333 0.16666667 0.083333333 0.16666667 0.0000000 0.083333333 0.16666667 0.16666667 0.16666667 0.50000000 0.50000000 0.50000000 0.50000000 0.58333333 0.66666667 0.50000000 0.50000000 0.50000000 0.50000000 0.66666667 0.58333333 0.58333333 0.50000000 0.58333333 0.58333333 0.50000000 0.50000000 0.50000000 0.66666667 0.58333333 0.50000000 0.50000000 0.50000000 0.50000000 0.66666667 0.58333333 0.58333333 0.50000000 0.58333333 0.58333333 0.75000000 0.75000000 0.75000000 0.75000000 0.75000000 0.75000000 0.75000000 0.91666667 0.83333333 0.83333333 0.75000000 0.83333333 0.83333333 0.50000000 0.50000000 0.50000000 0.58333333 0.66666667 0.66666667 0.58333333 0.50000000 0.50000000 0.50000000 0.50000000 0.66666667 0.58333333 0.58333333 0.50000000 0.58333333 0.58333333 0.66666667 0.58333333 0.66666667 0.58333333 0.66666667 0.50000000 0.58333333 0.66666667 0.66666667 0.66666667 0.0000000 0.25000000 0.0000000 4.6259293e-18 9.2518585e-18 0.083333333 0.16666667 0.16666667 0.083333333 0.0000000 0.0000000 0.0000000 0.0000000 0.16666667 0.083333333 0.083333333 0.0000000 0.083333333 0.083333333 0.25000000 0.0000000 4.6259293e-18 9.2518585e-18 0.083333333 0.16666667 0.16666667 0.083333333 0.0000000 0.0000000 0.0000000 0.0000000 0.16666667 0.083333333 0.083333333 0.0000000 0.083333333 0.083333333 0.25000000 0.25000000 0.25000000 0.33333333 0.41666667 0.41666667 0.33333333 0.25000000 0.25000000 0.25000000 0.25000000 0.41666667 0.33333333 0.33333333 0.25000000 0.33333333 0.33333333 0.0000000 4.6259293e-18 9.2518585e-18 0.083333333 0.16666667 0.16666667 0.083333333 0.0000000 0.0000000 0.0000000 0.0000000 0.16666667 0.083333333 0.083333333 0.0000000 0.083333333 0.083333333 0.16666667 0.083333333 0.16666667 0.083333333 0.16666667 0.0000000 0.083333333 0.16666667 0.16666667 0.16666667 0.25000000 0.25000000 0.16666667 0.083333333 0.16666667 0.083333333 0.16666667 0.41666667 0.33333333 0.41666667 0.33333333 0.41666667 0.33333333 0.41666667 0.25000000 0.33333333 0.41666667 0.25000000 0.25000000 0.41666667 0.33333333 0.41666667 0.33333333 0.41666667 0.33333333 0.33333333 0.41666667 0.25000000 0.25000000 0.16666667 0.083333333 0.16666667 0.083333333 0.16666667 0.083333333 0.16666667 0.25000000 0.25000000 0.33333333 0.33333333 0.25000000 0.16666667 0.25000000 0.16666667 0.33333333 0.0000000 0.0000000 0.0000000 0.083333333 0.0000000 0.0000000 0.083333333 0.16666667 0.0000000 0.083333333 0.083333333 0.0000000 0.0000000 0.083333333 0.16666667 0.0000000 0.083333333 0.083333333 0.25000000 0.25000000 0.25000000 0.33333333 0.083333333 0.16666667 0.0000000 0.083333333 0.083333333 0.16666667 0.16666667 0.16666667 0.41666667 0.33333333 0.41666667 0.33333333 0.41666667 0.41666667 0.33333333 0.33333333 0.41666667 0.41666667 0.33333333 0.41666667 0.41666667 0.33333333 0.25000000 0.25000000 0.16666667 0.16666667 0.25000000 0.25000000 0.16666667 0.16666667 0.25000000 0.25000000 0.33333333 0.33333333 0.25000000 0.33333333 0.25000000 0.16666667 0.33333333 0.41666667 0.41666667 0.41666667 0.25000000 0.25000000 0.16666667 0.25000000 0.41666667 0.33333333 0.41666667 0.41666667 0.41666667 0.41666667 0.33333333 0.33333333 0.33333333 0.33333333 0.41666667 0.41666667 0.83333333 0.58333333 0.66666667 0.66666667 0.58333333 0.58333333 0.66666667 0.66666667 0.58333333 0.75000000 0.75000000 0.83333333 0.83333333 0.75000000 0.75000000 0.75000000 0.66666667 0.83333333 0.75000000 0.66666667 0.33333333 0.41666667 0.41666667 0.33333333 0.16666667 0.25000000 0.25000000 0.16666667 0.16666667 0.33333333 0.41666667 0.33333333 0.41666667 0.25000000 0.25000000 0.25000000 0.16666667 0.33333333 0.33333333 0.25000000 0.33333333 0.41666667 0.41666667 0.33333333 0.25000000 0.25000000 0.16666667 0.16666667 0.16666667 0.41666667 0.33333333 0.33333333 0.41666667 0.25000000 0.25000000 0.25000000 0.16666667 0.33333333 0.33333333 0.25000000 0.75000000 0.75000000 0.83333333 0.83333333 0.58333333 0.66666667 0.58333333 0.66666667 0.66666667 0.58333333 0.58333333 0.66666667 0.83333333 0.75000000 0.75000000 0.66666667 0.75000000 0.66666667 0.83333333 0.75000000 0.50000000 0.50000000 0.50000000 0.41666667 0.25000000 0.25000000 0.25000000 0.16666667 0.50000000 0.50000000 0.50000000 0.33333333 0.41666667 0.50000000 0.50000000 0.41666667 0.50000000 0.41666667 0.33333333 0.41666667 0.50000000 0.50000000 0.50000000 0.50000000 0.41666667 0.50000000 0.41666667 0.33333333 0.41666667 0.33333333 0.41666667 0.41666667 0.33333333 0.50000000 0.33333333 0.58333333 0.75000000 0.75000000 0.75000000 0.83333333 0.66666667 0.58333333 0.58333333 0.58333333 0.66666667 0.58333333 0.58333333 0.58333333 0.66666667 0.58333333 0.66666667 0.58333333 0.58333333 0.66666667 0.66666667 0.50000000 0.50000000 0.50000000 0.58333333 0.50000000 0.50000000 0.50000000 0.58333333 0.75000000 0.50000000 0.50000000 0.58333333 0.50000000 0.66666667 0.58333333 0.58333333 0.66666667 0.50000000 0.58333333 0.66666667 0.25000000 0.41666667 0.41666667 0.41666667 0.33333333 0.41666667 0.33333333 0.41666667 0.33333333 0.41666667
+DEAL:0:SCG<3>(3)<->SCG<3>(3)::0.15625000 2.0625000 1.0156250 0.56250000 0.093750000 1.3437500 1.6562500 -0.34375000 -0.062500000 -0.062500000 -0.062500000 -0.062500000 1.5312500 -0.093750000 -0.25000000 -0.25000000 1.6250000 1.6250000 0.37500000 2.4583333 4.4479167 5.2500000 6.1093750 1.4062500 2.6562500 2.9687500 0.96875000 1.3125000 1.3125000 1.4375000 1.4375000 2.9687500 0.96875000 1.0937500 1.0937500 6.8750000 6.8750000 7.0000000 9.4583333 0.80208333 1.8125000 -0.34375000 1.6562500 1.6562500 -0.34375000 -0.062500000 -0.062500000 -0.25000000 -0.25000000 1.5885417 -0.49479167 -0.25000000 -0.25000000 1.6250000 2.4583333 0.37500000 2.4583333 0.80208333 -0.21875000 1.7812500 1.9635417 -0.86979167 -0.12500000 -0.12500000 -0.062500000 -0.062500000 1.6562500 -0.34375000 -0.25000000 -0.25000000 2.0833333 1.6250000 0.37500000 2.4583333 -0.49479167 1.5885417 3.6250000 4.5416667 4.5416667 3.2500000 2.4583333 0.37500000 2.4583333 4.5416667 4.2968750 6.1093750 1.1875000 1.1875000 1.2187500 -0.031250000 -0.34375000 1.6562500 1.2187500 1.2187500 1.1875000 1.1875000 3.6250000 4.5416667 3.6250000 7.0000000 4.6875000 9.5468750 2.6875000 2.6875000 2.7187500 1.0937500 0.47395833 2.9322917 2.8750000 2.8750000 2.8750000 2.8750000 8.8750000 11.541667 11.541667 10.125000 2.4687500 4.6875000 0.84375000 2.8437500 2.6875000 2.6875000 2.5312500 1.2812500 0.84375000 2.8437500 2.7500000 2.7500000 2.6875000 2.6875000 8.8750000 11.916667 8.8750000 10.125000 4.4479167 0.34895833 3.1822917 2.8750000 2.8750000 2.7187500 1.0937500 0.96875000 2.9687500 2.8750000 2.8750000 2.6875000 2.6875000 11.541667 11.541667 8.8750000 10.125000 0.59895833 2.6822917 7.2500000 9.4583333 11.541667 9.0833333 9.4583333 7.2500000 11.541667 10.125000 5.5468750 0.96875000 2.9687500 2.6875000 2.6875000 0.47395833 2.9322917 2.8750000 2.8750000 8.8750000 11.541667 10.125000 11.541667 3.1875000 6.3593750 -0.031250000 1.2187500 1.3125000 1.3125000 1.0937500 1.0937500 -0.34375000 1.6562500 1.1875000 1.1875000 3.6250000 4.5416667 7.0000000 3.6250000 2.4687500 4.6875000 2.9687500 0.96875000 1.2812500 2.5312500 2.6875000 2.6875000 2.8750000 2.8750000 1.0937500 2.7187500 2.6875000 2.6875000 8.8750000 11.541667 10.125000 8.8750000 2.8072917 0.34895833 0.84375000 2.8437500 2.7500000 2.7500000 0.96875000 2.9687500 2.6875000 2.6875000 11.916667 11.541667 10.125000 8.8750000 2.6822917 0.59895833 6.8750000 9.4583333 9.4583333 9.4583333 11.541667 10.125000 11.541667 7.2500000 0.56250000 -0.86979167 1.9635417 -0.062500000 -0.062500000 -0.12500000 -0.12500000 1.7812500 -0.21875000 2.4583333 0.37500000 1.6250000 2.0833333 1.0156250 1.5885417 -0.49479167 -0.25000000 -0.25000000 -0.062500000 -0.062500000 1.6562500 -0.34375000 2.4583333 0.37500000 2.4583333 1.6250000 2.0625000 1.0937500 1.0937500 1.4375000 1.4375000 1.3125000 1.3125000 2.6562500 1.4062500 9.4583333 7.0000000 6.8750000 6.8750000 0.15625000 -0.25000000 -0.25000000 -0.34375000 1.6562500 1.5312500 -0.093750000 -0.062500000 -0.062500000 -0.062500000 -0.062500000 1.3437500 0.093750000 2.4583333 0.37500000 1.6250000 1.6250000 1.5885417 -0.49479167 4.5416667 2.4583333 4.5416667 0.37500000 2.4583333 3.2500000 4.5416667 3.6250000 9.4583333 4.5416667 4.5416667 9.4583333 1.0937500 1.0937500 7.0000000 4.9166667 9.0833333 7.0000000
--- /dev/null
+// ------------------------------------------------------------------------
+//
+// SPDX-License-Identifier: LGPL-2.1-or-later
+// Copyright (C) 2020 - 2023 by the deal.II authors
+//
+// This file is part of the deal.II library.
+//
+// Part of the source code is dual licensed under Apache-2.0 WITH
+// LLVM-exception OR LGPL-2.1-or-later. Detailed license information
+// governing the source code and code contributions can be found in
+// LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II.
+//
+// ------------------------------------------------------------------------
+
+
+/**
+ * Test interpolation operator with uniformly refined meshes.
+ *
+ * To compare with mg_transfer_a_01 but tests the interpolation
+ * operator instead of the transfer operators.
+ */
+
+#include <deal.II/base/conditional_ostream.h>
+#include <deal.II/base/function.h>
+#include <deal.II/base/logstream.h>
+#include <deal.II/base/mpi.h>
+#include <deal.II/base/quadrature_lib.h>
+
+#include <deal.II/distributed/tria.h>
+
+#include <deal.II/dofs/dof_handler.h>
+#include <deal.II/dofs/dof_tools.h>
+
+#include <deal.II/fe/fe_dgq.h>
+#include <deal.II/fe/fe_q.h>
+#include <deal.II/fe/fe_simplex_p.h>
+#include <deal.II/fe/fe_tools.h>
+#include <deal.II/fe/mapping_q.h>
+
+#include <deal.II/grid/grid_generator.h>
+#include <deal.II/grid/grid_out.h>
+
+#include <deal.II/matrix_free/fe_evaluation.h>
+#include <deal.II/matrix_free/matrix_free.h>
+
+#include <deal.II/multigrid/mg_constrained_dofs.h>
+#include <deal.II/multigrid/mg_transfer_global_coarsening.h>
+
+#include "mg_transfer_util.h"
+
+using namespace dealii;
+
+template <int dim>
+class RightHandSideFunction : public Function<dim>
+{
+public:
+ RightHandSideFunction()
+ : Function<dim>(1)
+ {}
+
+ virtual double
+ value(const Point<dim> &p, const unsigned int component = 0) const
+ {
+ (void)component;
+ return p[0];
+ }
+};
+
+template <int dim, typename Number, typename MeshType>
+void
+test_interpolation(
+ const MGTwoLevelTransferBase<LinearAlgebra::distributed::Vector<Number>>
+ &transfer,
+ const MeshType &dof_handler_fine,
+ const MeshType &dof_handler_coarse,
+ const Function<dim, Number> &function,
+ const unsigned int mg_level_fine = numbers::invalid_unsigned_int,
+ const unsigned int mg_level_coarse = numbers::invalid_unsigned_int)
+{
+ AffineConstraints<Number> constraint_fine(
+ dof_handler_fine.locally_owned_dofs(),
+ DoFTools::extract_locally_relevant_dofs(dof_handler_fine));
+ DoFTools::make_hanging_node_constraints(dof_handler_fine, constraint_fine);
+ constraint_fine.close();
+
+ // perform interpolation
+ LinearAlgebra::distributed::Vector<Number> src, dst;
+
+ initialize_dof_vector(dst, dof_handler_fine, mg_level_fine);
+ initialize_dof_vector(src, dof_handler_coarse, mg_level_coarse);
+
+ // test interpolate
+ {
+ VectorTools::interpolate(dof_handler_fine, function, dst); // dst = 1.0
+ src = 0.0;
+ transfer.interpolate(src, dst);
+
+ // print norms
+ if (true)
+ {
+ deallog << src.l2_norm() << std::endl;
+ }
+
+ // print vectors
+ if (true)
+ {
+ print(dst);
+ print(src);
+ }
+ }
+}
+
+template <int dim, typename Number>
+void
+do_test(const FiniteElement<dim> &fe_fine,
+ const FiniteElement<dim> &fe_coarse,
+ const Function<dim, Number> &function)
+{
+ // create coarse grid
+ Triangulation<dim> tria_coarse; // TODO
+ if (fe_coarse.reference_cell().is_simplex())
+ GridGenerator::subdivided_hyper_cube_with_simplices(tria_coarse, 1);
+ else
+ GridGenerator::hyper_cube(tria_coarse);
+ tria_coarse.refine_global();
+
+ // create fine grid
+ Triangulation<dim> tria_fine; // TODO
+
+ if (fe_fine.reference_cell().is_simplex())
+ GridGenerator::subdivided_hyper_cube_with_simplices(tria_fine, 1);
+ else
+ GridGenerator::hyper_cube(tria_fine);
+ tria_fine.refine_global();
+ tria_fine.refine_global();
+
+ // setup dof-handlers
+ DoFHandler<dim> dof_handler_fine(tria_fine);
+ dof_handler_fine.distribute_dofs(fe_fine);
+
+ DoFHandler<dim> dof_handler_coarse(tria_coarse);
+ dof_handler_coarse.distribute_dofs(fe_coarse);
+
+ // setup constraint matrix
+ AffineConstraints<Number> constraint_coarse;
+ constraint_coarse.close();
+
+ AffineConstraints<Number> constraint_fine;
+ constraint_fine.close();
+
+ // setup transfer operator
+ MGTwoLevelTransfer<dim, LinearAlgebra::distributed::Vector<Number>> transfer;
+
+ transfer.reinit(dof_handler_fine,
+ dof_handler_coarse,
+ constraint_fine,
+ constraint_coarse);
+
+ test_interpolation(transfer, dof_handler_fine, dof_handler_coarse, function);
+}
+
+template <int dim, typename Number>
+void
+test(int fe_degree,
+ const Function<dim, Number> &function,
+ const bool do_simplex_mesh)
+{
+ const auto str_fine = std::to_string(fe_degree);
+ const auto str_coarse = std::to_string(fe_degree);
+ const auto str_dim = std::to_string(dim);
+
+ if ((fe_degree > 0) && (do_simplex_mesh == false))
+ {
+ deallog.push("HCG<" + str_dim + ">(" + str_fine + ")<->HCG<" + str_dim +
+ ">(" + str_coarse + ")");
+ do_test<dim, double>(FE_Q<dim>(fe_degree),
+ FE_Q<dim>(fe_degree),
+ function);
+ deallog.pop();
+ }
+
+ if ((fe_degree > 0) && do_simplex_mesh)
+ {
+ deallog.push("SCG<" + str_dim + ">(" + str_fine + ")<->SCG<" + str_dim +
+ ">(" + str_coarse + ")");
+ do_test<dim, double>(FE_SimplexP<dim>(fe_degree),
+ FE_SimplexP<dim>(fe_degree),
+ function);
+ deallog.pop();
+ }
+}
+
+int
+main(int argc, char **argv)
+{
+ Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
+ MPILogInitAll all;
+
+ deallog.precision(8);
+
+ // Functions::ConstantFunction<2, double> fu(1.);
+ RightHandSideFunction<2> fu;
+ RightHandSideFunction<3> fu3;
+
+ for (unsigned int i = 0; i <= 4; ++i)
+ test<2, double>(i, fu, false);
+
+ for (unsigned int i = 0; i <= 3; ++i)
+ test<2, double>(i, fu, true);
+
+ for (unsigned int i = 1; i <= 3; ++i)
+ test<3, double>(i, fu3, true);
+}