From 0f05e7003a4a7f2707ac52347c313a2b3df190b3 Mon Sep 17 00:00:00 2001 From: Wolfgang Bangerth Date: Wed, 21 Dec 2016 08:29:24 -0700 Subject: [PATCH] Provide the cell via DataOut. Add tests. --- source/numerics/data_out.cc | 11 + .../data_out_postprocessor_scalar_02.cc | 126 +++ .../data_out_postprocessor_scalar_02.output | 802 ++++++++++++++++++ .../data_out_postprocessor_vector_02.cc | 129 +++ .../data_out_postprocessor_vector_02.output | 802 ++++++++++++++++++ 5 files changed, 1870 insertions(+) create mode 100644 tests/numerics/data_out_postprocessor_scalar_02.cc create mode 100644 tests/numerics/data_out_postprocessor_scalar_02.output create mode 100644 tests/numerics/data_out_postprocessor_vector_02.cc create mode 100644 tests/numerics/data_out_postprocessor_vector_02.output diff --git a/source/numerics/data_out.cc b/source/numerics/data_out.cc index eaa4d63f53..6977459c17 100644 --- a/source/numerics/data_out.cc +++ b/source/numerics/data_out.cc @@ -167,6 +167,11 @@ build_one_patch if (update_flags & update_quadrature_points) scratch_data.patch_values_scalar.evaluation_points = this_fe_patch_values.get_quadrature_points(); + const typename DoFHandlerType::active_cell_iterator dh_cell(&cell_and_index->first->get_triangulation(), + cell_and_index->first->level(), + cell_and_index->first->index(), + this->dof_data[dataset]->dof_handler); + scratch_data.patch_values_scalar.template set_cell (dh_cell); postprocessor-> evaluate_scalar_field(scratch_data.patch_values_scalar, @@ -191,6 +196,12 @@ build_one_patch if (update_flags & update_quadrature_points) scratch_data.patch_values_system.evaluation_points = this_fe_patch_values.get_quadrature_points(); + const typename DoFHandlerType::active_cell_iterator dh_cell(&cell_and_index->first->get_triangulation(), + cell_and_index->first->level(), + cell_and_index->first->index(), + this->dof_data[dataset]->dof_handler); + scratch_data.patch_values_system.template set_cell (dh_cell); + postprocessor-> evaluate_vector_field(scratch_data.patch_values_system, scratch_data.postprocessed_values[dataset]); diff --git a/tests/numerics/data_out_postprocessor_scalar_02.cc b/tests/numerics/data_out_postprocessor_scalar_02.cc new file mode 100644 index 0000000000..560edbdedc --- /dev/null +++ b/tests/numerics/data_out_postprocessor_scalar_02.cc @@ -0,0 +1,126 @@ +// --------------------------------------------------------------------- +// +// Copyright (C) 2016 by the deal.II authors +// +// This file is part of the deal.II library. +// +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + + +// tests DataPostprocessor: access the cell we are currently working +// on for a scalar finite element + + +#include "../tests.h" +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include + +#include +#include +#include + +#include + + +std::ofstream logfile("output"); + + +template +class MyPostprocessor : public DataPostprocessorScalar +{ +public: + MyPostprocessor () + : + DataPostprocessorScalar ("data", update_values) + {} + + virtual + void + evaluate_scalar_field (const DataPostprocessorInputs::Scalar &input_data, + std::vector > &computed_quantities) const + { + for (unsigned int q=0; q::cell_iterator + cell = input_data.template get_cell >(); + + Assert (input_data.solution_values[q] + == + double(cell->active_cell_index()), + ExcInternalError()); + + computed_quantities[q][0] = input_data.solution_values[q]; + } + } +}; + + + +template +void test () +{ + Triangulation triangulation; + FE_DGQ fe(1); + DoFHandler dof_handler(triangulation); + + GridGenerator::hyper_cube (triangulation, 0, 1); + triangulation.refine_global (1); + triangulation.begin_active()->set_refine_flag (); + triangulation.execute_coarsening_and_refinement (); + + dof_handler.distribute_dofs (fe); + + // create a vector with piecewise constants, and set the elements of + // the vector so that on each cell the field has values equal to the + // cell's active_cell_index + Vector solution (dof_handler.n_dofs()); + for (typename DoFHandler::active_cell_iterator cell = dof_handler.begin_active(); + cell != dof_handler.end(); ++cell) + { + std::vector local_dof_indices (cell->get_fe().dofs_per_cell); + cell->get_dof_indices (local_dof_indices); + for (unsigned int i=0; iactive_cell_index(); + } + + MyPostprocessor p; + DataOut data_out; + data_out.attach_dof_handler (dof_handler); + data_out.add_data_vector (solution, p); + data_out.build_patches (); + data_out.write_gnuplot (logfile); +} + + +int main () +{ + logfile << std::setprecision(2); + deallog << std::setprecision(2); + + test<1>(); + test<2>(); + test<3>(); + + return 0; +} diff --git a/tests/numerics/data_out_postprocessor_scalar_02.output b/tests/numerics/data_out_postprocessor_scalar_02.output new file mode 100644 index 0000000000..3f8983b3e1 --- /dev/null +++ b/tests/numerics/data_out_postprocessor_scalar_02.output @@ -0,0 +1,802 @@ +# This file was generated by the deal.II library. + + +# +# For a description of the GNUPLOT format see the GNUPLOT manual. +# +# +0.5 0 +1 0 + + +0 1 +0.25 1 + + +0.25 2 +0.5 2 + + +# This file was generated by the deal.II library. + + +# +# For a description of the GNUPLOT format see the GNUPLOT manual. +# +# +0.5 0 0 +1 0 0 + +0.5 0.5 0 +1 0.5 0 + + +0 0.5 1 +0.5 0.5 1 + +0 1 1 +0.5 1 1 + + +0.5 0.5 2 +1 0.5 2 + +0.5 1 2 +1 1 2 + + +0 0 3 +0.25 0 3 + +0 0.25 3 +0.25 0.25 3 + + +0.25 0 4 +0.5 0 4 + +0.25 0.25 4 +0.5 0.25 4 + + +0 0.25 5 +0.25 0.25 5 + +0 0.5 5 +0.25 0.5 5 + + +0.25 0.25 6 +0.5 0.25 6 + +0.25 0.5 6 +0.5 0.5 6 + + +# This file was generated by the deal.II library. + + +# +# For a description of the GNUPLOT format see the GNUPLOT manual. +# +# +0.5 0 0 0 +1 0 0 0 + + +0.5 0 0 0 +0.5 0.5 0 0 + + +0.5 0 0 0 +0.5 0 0.5 0 + + +1 0 0 0 +1 0.5 0 0 + + +1 0 0 0 +1 0 0.5 0 + + +0.5 0.5 0 0 +1 0.5 0 0 + + +0.5 0.5 0 0 +0.5 0.5 0.5 0 + + +1 0.5 0 0 +1 0.5 0.5 0 + + +0.5 0 0.5 0 +1 0 0.5 0 + + +0.5 0 0.5 0 +0.5 0.5 0.5 0 + + +1 0 0.5 0 +1 0.5 0.5 0 + + +0.5 0.5 0.5 0 +1 0.5 0.5 0 + + +0 0.5 0 1 +0.5 0.5 0 1 + + +0 0.5 0 1 +0 1 0 1 + + +0 0.5 0 1 +0 0.5 0.5 1 + + +0.5 0.5 0 1 +0.5 1 0 1 + + +0.5 0.5 0 1 +0.5 0.5 0.5 1 + + +0 1 0 1 +0.5 1 0 1 + + +0 1 0 1 +0 1 0.5 1 + + +0.5 1 0 1 +0.5 1 0.5 1 + + +0 0.5 0.5 1 +0.5 0.5 0.5 1 + + +0 0.5 0.5 1 +0 1 0.5 1 + + +0.5 0.5 0.5 1 +0.5 1 0.5 1 + + +0 1 0.5 1 +0.5 1 0.5 1 + + +0.5 0.5 0 2 +1 0.5 0 2 + + +0.5 0.5 0 2 +0.5 1 0 2 + + +0.5 0.5 0 2 +0.5 0.5 0.5 2 + + +1 0.5 0 2 +1 1 0 2 + + +1 0.5 0 2 +1 0.5 0.5 2 + + +0.5 1 0 2 +1 1 0 2 + + +0.5 1 0 2 +0.5 1 0.5 2 + + +1 1 0 2 +1 1 0.5 2 + + +0.5 0.5 0.5 2 +1 0.5 0.5 2 + + +0.5 0.5 0.5 2 +0.5 1 0.5 2 + + +1 0.5 0.5 2 +1 1 0.5 2 + + +0.5 1 0.5 2 +1 1 0.5 2 + + +0 0 0.5 3 +0.5 0 0.5 3 + + +0 0 0.5 3 +0 0.5 0.5 3 + + +0 0 0.5 3 +0 0 1 3 + + +0.5 0 0.5 3 +0.5 0.5 0.5 3 + + +0.5 0 0.5 3 +0.5 0 1 3 + + +0 0.5 0.5 3 +0.5 0.5 0.5 3 + + +0 0.5 0.5 3 +0 0.5 1 3 + + +0.5 0.5 0.5 3 +0.5 0.5 1 3 + + +0 0 1 3 +0.5 0 1 3 + + +0 0 1 3 +0 0.5 1 3 + + +0.5 0 1 3 +0.5 0.5 1 3 + + +0 0.5 1 3 +0.5 0.5 1 3 + + +0.5 0 0.5 4 +1 0 0.5 4 + + +0.5 0 0.5 4 +0.5 0.5 0.5 4 + + +0.5 0 0.5 4 +0.5 0 1 4 + + +1 0 0.5 4 +1 0.5 0.5 4 + + +1 0 0.5 4 +1 0 1 4 + + +0.5 0.5 0.5 4 +1 0.5 0.5 4 + + +0.5 0.5 0.5 4 +0.5 0.5 1 4 + + +1 0.5 0.5 4 +1 0.5 1 4 + + +0.5 0 1 4 +1 0 1 4 + + +0.5 0 1 4 +0.5 0.5 1 4 + + +1 0 1 4 +1 0.5 1 4 + + +0.5 0.5 1 4 +1 0.5 1 4 + + +0 0.5 0.5 5 +0.5 0.5 0.5 5 + + +0 0.5 0.5 5 +0 1 0.5 5 + + +0 0.5 0.5 5 +0 0.5 1 5 + + +0.5 0.5 0.5 5 +0.5 1 0.5 5 + + +0.5 0.5 0.5 5 +0.5 0.5 1 5 + + +0 1 0.5 5 +0.5 1 0.5 5 + + +0 1 0.5 5 +0 1 1 5 + + +0.5 1 0.5 5 +0.5 1 1 5 + + +0 0.5 1 5 +0.5 0.5 1 5 + + +0 0.5 1 5 +0 1 1 5 + + +0.5 0.5 1 5 +0.5 1 1 5 + + +0 1 1 5 +0.5 1 1 5 + + +0.5 0.5 0.5 6 +1 0.5 0.5 6 + + +0.5 0.5 0.5 6 +0.5 1 0.5 6 + + +0.5 0.5 0.5 6 +0.5 0.5 1 6 + + +1 0.5 0.5 6 +1 1 0.5 6 + + +1 0.5 0.5 6 +1 0.5 1 6 + + +0.5 1 0.5 6 +1 1 0.5 6 + + +0.5 1 0.5 6 +0.5 1 1 6 + + +1 1 0.5 6 +1 1 1 6 + + +0.5 0.5 1 6 +1 0.5 1 6 + + +0.5 0.5 1 6 +0.5 1 1 6 + + +1 0.5 1 6 +1 1 1 6 + + +0.5 1 1 6 +1 1 1 6 + + +0 0 0 7 +0.25 0 0 7 + + +0 0 0 7 +0 0.25 0 7 + + +0 0 0 7 +0 0 0.25 7 + + +0.25 0 0 7 +0.25 0.25 0 7 + + +0.25 0 0 7 +0.25 0 0.25 7 + + +0 0.25 0 7 +0.25 0.25 0 7 + + +0 0.25 0 7 +0 0.25 0.25 7 + + +0.25 0.25 0 7 +0.25 0.25 0.25 7 + + +0 0 0.25 7 +0.25 0 0.25 7 + + +0 0 0.25 7 +0 0.25 0.25 7 + + +0.25 0 0.25 7 +0.25 0.25 0.25 7 + + +0 0.25 0.25 7 +0.25 0.25 0.25 7 + + +0.25 0 0 8 +0.5 0 0 8 + + +0.25 0 0 8 +0.25 0.25 0 8 + + +0.25 0 0 8 +0.25 0 0.25 8 + + +0.5 0 0 8 +0.5 0.25 0 8 + + +0.5 0 0 8 +0.5 0 0.25 8 + + +0.25 0.25 0 8 +0.5 0.25 0 8 + + +0.25 0.25 0 8 +0.25 0.25 0.25 8 + + +0.5 0.25 0 8 +0.5 0.25 0.25 8 + + +0.25 0 0.25 8 +0.5 0 0.25 8 + + +0.25 0 0.25 8 +0.25 0.25 0.25 8 + + +0.5 0 0.25 8 +0.5 0.25 0.25 8 + + +0.25 0.25 0.25 8 +0.5 0.25 0.25 8 + + +0 0.25 0 9 +0.25 0.25 0 9 + + +0 0.25 0 9 +0 0.5 0 9 + + +0 0.25 0 9 +0 0.25 0.25 9 + + +0.25 0.25 0 9 +0.25 0.5 0 9 + + +0.25 0.25 0 9 +0.25 0.25 0.25 9 + + +0 0.5 0 9 +0.25 0.5 0 9 + + +0 0.5 0 9 +0 0.5 0.25 9 + + +0.25 0.5 0 9 +0.25 0.5 0.25 9 + + +0 0.25 0.25 9 +0.25 0.25 0.25 9 + + +0 0.25 0.25 9 +0 0.5 0.25 9 + + +0.25 0.25 0.25 9 +0.25 0.5 0.25 9 + + +0 0.5 0.25 9 +0.25 0.5 0.25 9 + + +0.25 0.25 0 10 +0.5 0.25 0 10 + + +0.25 0.25 0 10 +0.25 0.5 0 10 + + +0.25 0.25 0 10 +0.25 0.25 0.25 10 + + +0.5 0.25 0 10 +0.5 0.5 0 10 + + +0.5 0.25 0 10 +0.5 0.25 0.25 10 + + +0.25 0.5 0 10 +0.5 0.5 0 10 + + +0.25 0.5 0 10 +0.25 0.5 0.25 10 + + +0.5 0.5 0 10 +0.5 0.5 0.25 10 + + +0.25 0.25 0.25 10 +0.5 0.25 0.25 10 + + +0.25 0.25 0.25 10 +0.25 0.5 0.25 10 + + +0.5 0.25 0.25 10 +0.5 0.5 0.25 10 + + +0.25 0.5 0.25 10 +0.5 0.5 0.25 10 + + +0 0 0.25 11 +0.25 0 0.25 11 + + +0 0 0.25 11 +0 0.25 0.25 11 + + +0 0 0.25 11 +0 0 0.5 11 + + +0.25 0 0.25 11 +0.25 0.25 0.25 11 + + +0.25 0 0.25 11 +0.25 0 0.5 11 + + +0 0.25 0.25 11 +0.25 0.25 0.25 11 + + +0 0.25 0.25 11 +0 0.25 0.5 11 + + +0.25 0.25 0.25 11 +0.25 0.25 0.5 11 + + +0 0 0.5 11 +0.25 0 0.5 11 + + +0 0 0.5 11 +0 0.25 0.5 11 + + +0.25 0 0.5 11 +0.25 0.25 0.5 11 + + +0 0.25 0.5 11 +0.25 0.25 0.5 11 + + +0.25 0 0.25 12 +0.5 0 0.25 12 + + +0.25 0 0.25 12 +0.25 0.25 0.25 12 + + +0.25 0 0.25 12 +0.25 0 0.5 12 + + +0.5 0 0.25 12 +0.5 0.25 0.25 12 + + +0.5 0 0.25 12 +0.5 0 0.5 12 + + +0.25 0.25 0.25 12 +0.5 0.25 0.25 12 + + +0.25 0.25 0.25 12 +0.25 0.25 0.5 12 + + +0.5 0.25 0.25 12 +0.5 0.25 0.5 12 + + +0.25 0 0.5 12 +0.5 0 0.5 12 + + +0.25 0 0.5 12 +0.25 0.25 0.5 12 + + +0.5 0 0.5 12 +0.5 0.25 0.5 12 + + +0.25 0.25 0.5 12 +0.5 0.25 0.5 12 + + +0 0.25 0.25 13 +0.25 0.25 0.25 13 + + +0 0.25 0.25 13 +0 0.5 0.25 13 + + +0 0.25 0.25 13 +0 0.25 0.5 13 + + +0.25 0.25 0.25 13 +0.25 0.5 0.25 13 + + +0.25 0.25 0.25 13 +0.25 0.25 0.5 13 + + +0 0.5 0.25 13 +0.25 0.5 0.25 13 + + +0 0.5 0.25 13 +0 0.5 0.5 13 + + +0.25 0.5 0.25 13 +0.25 0.5 0.5 13 + + +0 0.25 0.5 13 +0.25 0.25 0.5 13 + + +0 0.25 0.5 13 +0 0.5 0.5 13 + + +0.25 0.25 0.5 13 +0.25 0.5 0.5 13 + + +0 0.5 0.5 13 +0.25 0.5 0.5 13 + + +0.25 0.25 0.25 14 +0.5 0.25 0.25 14 + + +0.25 0.25 0.25 14 +0.25 0.5 0.25 14 + + +0.25 0.25 0.25 14 +0.25 0.25 0.5 14 + + +0.5 0.25 0.25 14 +0.5 0.5 0.25 14 + + +0.5 0.25 0.25 14 +0.5 0.25 0.5 14 + + +0.25 0.5 0.25 14 +0.5 0.5 0.25 14 + + +0.25 0.5 0.25 14 +0.25 0.5 0.5 14 + + +0.5 0.5 0.25 14 +0.5 0.5 0.5 14 + + +0.25 0.25 0.5 14 +0.5 0.25 0.5 14 + + +0.25 0.25 0.5 14 +0.25 0.5 0.5 14 + + +0.5 0.25 0.5 14 +0.5 0.5 0.5 14 + + +0.25 0.5 0.5 14 +0.5 0.5 0.5 14 + + diff --git a/tests/numerics/data_out_postprocessor_vector_02.cc b/tests/numerics/data_out_postprocessor_vector_02.cc new file mode 100644 index 0000000000..a0eb1c47fb --- /dev/null +++ b/tests/numerics/data_out_postprocessor_vector_02.cc @@ -0,0 +1,129 @@ +// --------------------------------------------------------------------- +// +// Copyright (C) 2016 by the deal.II authors +// +// This file is part of the deal.II library. +// +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + + +// tests DataPostprocessor: access the cell we are currently working +// on for a vector finite element + + +#include "../tests.h" +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include + +#include +#include +#include + +#include + + +std::ofstream logfile("output"); + + +template +class MyPostprocessor : public DataPostprocessorVector +{ +public: + MyPostprocessor () + : + DataPostprocessorVector ("data", update_values) + {} + + virtual + void + evaluate_vector_field (const DataPostprocessorInputs::Vector &input_data, + std::vector > &computed_quantities) const + { + for (unsigned int q=0; q::cell_iterator + cell = input_data.template get_cell >(); + + Assert (input_data.solution_values[q](0) + == + double(cell->active_cell_index()), + ExcInternalError()); + + computed_quantities[q][0] = input_data.solution_values[q](0); + } + } +}; + + + +template +void test () +{ + Triangulation triangulation; + FESystem fe(FE_DGQ(0),2); + DoFHandler dof_handler(triangulation); + + GridGenerator::hyper_cube (triangulation, 0, 1); + triangulation.refine_global (1); + triangulation.begin_active()->set_refine_flag (); + triangulation.execute_coarsening_and_refinement (); + + dof_handler.distribute_dofs (fe); + + // create a vector with piecewise constants, and set the elements of + // the vector so that on each cell the field has values equal to the + // cell's active_cell_index + Vector solution (dof_handler.n_dofs()); + for (typename DoFHandler::active_cell_iterator cell = dof_handler.begin_active(); + cell != dof_handler.end(); ++cell) + { + std::vector local_dof_indices (cell->get_fe().dofs_per_cell); + cell->get_dof_indices (local_dof_indices); + for (unsigned int i=0; iactive_cell_index(); + } + + MyPostprocessor p; + DataOut data_out; + data_out.attach_dof_handler (dof_handler); + data_out.add_data_vector (solution, p); + data_out.build_patches (); + data_out.write_gnuplot (logfile); +} + + +int main () +{ + logfile << std::setprecision(2); + deallog << std::setprecision(2); + + test<1>(); + test<2>(); + test<3>(); + + return 0; +} diff --git a/tests/numerics/data_out_postprocessor_vector_02.output b/tests/numerics/data_out_postprocessor_vector_02.output new file mode 100644 index 0000000000..1659cdcc7e --- /dev/null +++ b/tests/numerics/data_out_postprocessor_vector_02.output @@ -0,0 +1,802 @@ +# This file was generated by the deal.II library. + + +# +# For a description of the GNUPLOT format see the GNUPLOT manual. +# +# +0.5 0 +1 0 + + +0 1 +0.25 1 + + +0.25 2 +0.5 2 + + +# This file was generated by the deal.II library. + + +# +# For a description of the GNUPLOT format see the GNUPLOT manual. +# +# +0.5 0 0 0 +1 0 0 0 + +0.5 0.5 0 0 +1 0.5 0 0 + + +0 0.5 1 0 +0.5 0.5 1 0 + +0 1 1 0 +0.5 1 1 0 + + +0.5 0.5 2 0 +1 0.5 2 0 + +0.5 1 2 0 +1 1 2 0 + + +0 0 3 0 +0.25 0 3 0 + +0 0.25 3 0 +0.25 0.25 3 0 + + +0.25 0 4 0 +0.5 0 4 0 + +0.25 0.25 4 0 +0.5 0.25 4 0 + + +0 0.25 5 0 +0.25 0.25 5 0 + +0 0.5 5 0 +0.25 0.5 5 0 + + +0.25 0.25 6 0 +0.5 0.25 6 0 + +0.25 0.5 6 0 +0.5 0.5 6 0 + + +# This file was generated by the deal.II library. + + +# +# For a description of the GNUPLOT format see the GNUPLOT manual. +# +# +0.5 0 0 0 0 0 +1 0 0 0 0 0 + + +0.5 0 0 0 0 0 +0.5 0.5 0 0 0 0 + + +0.5 0 0 0 0 0 +0.5 0 0.5 0 0 0 + + +1 0 0 0 0 0 +1 0.5 0 0 0 0 + + +1 0 0 0 0 0 +1 0 0.5 0 0 0 + + +0.5 0.5 0 0 0 0 +1 0.5 0 0 0 0 + + +0.5 0.5 0 0 0 0 +0.5 0.5 0.5 0 0 0 + + +1 0.5 0 0 0 0 +1 0.5 0.5 0 0 0 + + +0.5 0 0.5 0 0 0 +1 0 0.5 0 0 0 + + +0.5 0 0.5 0 0 0 +0.5 0.5 0.5 0 0 0 + + +1 0 0.5 0 0 0 +1 0.5 0.5 0 0 0 + + +0.5 0.5 0.5 0 0 0 +1 0.5 0.5 0 0 0 + + +0 0.5 0 1 0 0 +0.5 0.5 0 1 0 0 + + +0 0.5 0 1 0 0 +0 1 0 1 0 0 + + +0 0.5 0 1 0 0 +0 0.5 0.5 1 0 0 + + +0.5 0.5 0 1 0 0 +0.5 1 0 1 0 0 + + +0.5 0.5 0 1 0 0 +0.5 0.5 0.5 1 0 0 + + +0 1 0 1 0 0 +0.5 1 0 1 0 0 + + +0 1 0 1 0 0 +0 1 0.5 1 0 0 + + +0.5 1 0 1 0 0 +0.5 1 0.5 1 0 0 + + +0 0.5 0.5 1 0 0 +0.5 0.5 0.5 1 0 0 + + +0 0.5 0.5 1 0 0 +0 1 0.5 1 0 0 + + +0.5 0.5 0.5 1 0 0 +0.5 1 0.5 1 0 0 + + +0 1 0.5 1 0 0 +0.5 1 0.5 1 0 0 + + +0.5 0.5 0 2 0 0 +1 0.5 0 2 0 0 + + +0.5 0.5 0 2 0 0 +0.5 1 0 2 0 0 + + +0.5 0.5 0 2 0 0 +0.5 0.5 0.5 2 0 0 + + +1 0.5 0 2 0 0 +1 1 0 2 0 0 + + +1 0.5 0 2 0 0 +1 0.5 0.5 2 0 0 + + +0.5 1 0 2 0 0 +1 1 0 2 0 0 + + +0.5 1 0 2 0 0 +0.5 1 0.5 2 0 0 + + +1 1 0 2 0 0 +1 1 0.5 2 0 0 + + +0.5 0.5 0.5 2 0 0 +1 0.5 0.5 2 0 0 + + +0.5 0.5 0.5 2 0 0 +0.5 1 0.5 2 0 0 + + +1 0.5 0.5 2 0 0 +1 1 0.5 2 0 0 + + +0.5 1 0.5 2 0 0 +1 1 0.5 2 0 0 + + +0 0 0.5 3 0 0 +0.5 0 0.5 3 0 0 + + +0 0 0.5 3 0 0 +0 0.5 0.5 3 0 0 + + +0 0 0.5 3 0 0 +0 0 1 3 0 0 + + +0.5 0 0.5 3 0 0 +0.5 0.5 0.5 3 0 0 + + +0.5 0 0.5 3 0 0 +0.5 0 1 3 0 0 + + +0 0.5 0.5 3 0 0 +0.5 0.5 0.5 3 0 0 + + +0 0.5 0.5 3 0 0 +0 0.5 1 3 0 0 + + +0.5 0.5 0.5 3 0 0 +0.5 0.5 1 3 0 0 + + +0 0 1 3 0 0 +0.5 0 1 3 0 0 + + +0 0 1 3 0 0 +0 0.5 1 3 0 0 + + +0.5 0 1 3 0 0 +0.5 0.5 1 3 0 0 + + +0 0.5 1 3 0 0 +0.5 0.5 1 3 0 0 + + +0.5 0 0.5 4 0 0 +1 0 0.5 4 0 0 + + +0.5 0 0.5 4 0 0 +0.5 0.5 0.5 4 0 0 + + +0.5 0 0.5 4 0 0 +0.5 0 1 4 0 0 + + +1 0 0.5 4 0 0 +1 0.5 0.5 4 0 0 + + +1 0 0.5 4 0 0 +1 0 1 4 0 0 + + +0.5 0.5 0.5 4 0 0 +1 0.5 0.5 4 0 0 + + +0.5 0.5 0.5 4 0 0 +0.5 0.5 1 4 0 0 + + +1 0.5 0.5 4 0 0 +1 0.5 1 4 0 0 + + +0.5 0 1 4 0 0 +1 0 1 4 0 0 + + +0.5 0 1 4 0 0 +0.5 0.5 1 4 0 0 + + +1 0 1 4 0 0 +1 0.5 1 4 0 0 + + +0.5 0.5 1 4 0 0 +1 0.5 1 4 0 0 + + +0 0.5 0.5 5 0 0 +0.5 0.5 0.5 5 0 0 + + +0 0.5 0.5 5 0 0 +0 1 0.5 5 0 0 + + +0 0.5 0.5 5 0 0 +0 0.5 1 5 0 0 + + +0.5 0.5 0.5 5 0 0 +0.5 1 0.5 5 0 0 + + +0.5 0.5 0.5 5 0 0 +0.5 0.5 1 5 0 0 + + +0 1 0.5 5 0 0 +0.5 1 0.5 5 0 0 + + +0 1 0.5 5 0 0 +0 1 1 5 0 0 + + +0.5 1 0.5 5 0 0 +0.5 1 1 5 0 0 + + +0 0.5 1 5 0 0 +0.5 0.5 1 5 0 0 + + +0 0.5 1 5 0 0 +0 1 1 5 0 0 + + +0.5 0.5 1 5 0 0 +0.5 1 1 5 0 0 + + +0 1 1 5 0 0 +0.5 1 1 5 0 0 + + +0.5 0.5 0.5 6 0 0 +1 0.5 0.5 6 0 0 + + +0.5 0.5 0.5 6 0 0 +0.5 1 0.5 6 0 0 + + +0.5 0.5 0.5 6 0 0 +0.5 0.5 1 6 0 0 + + +1 0.5 0.5 6 0 0 +1 1 0.5 6 0 0 + + +1 0.5 0.5 6 0 0 +1 0.5 1 6 0 0 + + +0.5 1 0.5 6 0 0 +1 1 0.5 6 0 0 + + +0.5 1 0.5 6 0 0 +0.5 1 1 6 0 0 + + +1 1 0.5 6 0 0 +1 1 1 6 0 0 + + +0.5 0.5 1 6 0 0 +1 0.5 1 6 0 0 + + +0.5 0.5 1 6 0 0 +0.5 1 1 6 0 0 + + +1 0.5 1 6 0 0 +1 1 1 6 0 0 + + +0.5 1 1 6 0 0 +1 1 1 6 0 0 + + +0 0 0 7 0 0 +0.25 0 0 7 0 0 + + +0 0 0 7 0 0 +0 0.25 0 7 0 0 + + +0 0 0 7 0 0 +0 0 0.25 7 0 0 + + +0.25 0 0 7 0 0 +0.25 0.25 0 7 0 0 + + +0.25 0 0 7 0 0 +0.25 0 0.25 7 0 0 + + +0 0.25 0 7 0 0 +0.25 0.25 0 7 0 0 + + +0 0.25 0 7 0 0 +0 0.25 0.25 7 0 0 + + +0.25 0.25 0 7 0 0 +0.25 0.25 0.25 7 0 0 + + +0 0 0.25 7 0 0 +0.25 0 0.25 7 0 0 + + +0 0 0.25 7 0 0 +0 0.25 0.25 7 0 0 + + +0.25 0 0.25 7 0 0 +0.25 0.25 0.25 7 0 0 + + +0 0.25 0.25 7 0 0 +0.25 0.25 0.25 7 0 0 + + +0.25 0 0 8 0 0 +0.5 0 0 8 0 0 + + +0.25 0 0 8 0 0 +0.25 0.25 0 8 0 0 + + +0.25 0 0 8 0 0 +0.25 0 0.25 8 0 0 + + +0.5 0 0 8 0 0 +0.5 0.25 0 8 0 0 + + +0.5 0 0 8 0 0 +0.5 0 0.25 8 0 0 + + +0.25 0.25 0 8 0 0 +0.5 0.25 0 8 0 0 + + +0.25 0.25 0 8 0 0 +0.25 0.25 0.25 8 0 0 + + +0.5 0.25 0 8 0 0 +0.5 0.25 0.25 8 0 0 + + +0.25 0 0.25 8 0 0 +0.5 0 0.25 8 0 0 + + +0.25 0 0.25 8 0 0 +0.25 0.25 0.25 8 0 0 + + +0.5 0 0.25 8 0 0 +0.5 0.25 0.25 8 0 0 + + +0.25 0.25 0.25 8 0 0 +0.5 0.25 0.25 8 0 0 + + +0 0.25 0 9 0 0 +0.25 0.25 0 9 0 0 + + +0 0.25 0 9 0 0 +0 0.5 0 9 0 0 + + +0 0.25 0 9 0 0 +0 0.25 0.25 9 0 0 + + +0.25 0.25 0 9 0 0 +0.25 0.5 0 9 0 0 + + +0.25 0.25 0 9 0 0 +0.25 0.25 0.25 9 0 0 + + +0 0.5 0 9 0 0 +0.25 0.5 0 9 0 0 + + +0 0.5 0 9 0 0 +0 0.5 0.25 9 0 0 + + +0.25 0.5 0 9 0 0 +0.25 0.5 0.25 9 0 0 + + +0 0.25 0.25 9 0 0 +0.25 0.25 0.25 9 0 0 + + +0 0.25 0.25 9 0 0 +0 0.5 0.25 9 0 0 + + +0.25 0.25 0.25 9 0 0 +0.25 0.5 0.25 9 0 0 + + +0 0.5 0.25 9 0 0 +0.25 0.5 0.25 9 0 0 + + +0.25 0.25 0 10 0 0 +0.5 0.25 0 10 0 0 + + +0.25 0.25 0 10 0 0 +0.25 0.5 0 10 0 0 + + +0.25 0.25 0 10 0 0 +0.25 0.25 0.25 10 0 0 + + +0.5 0.25 0 10 0 0 +0.5 0.5 0 10 0 0 + + +0.5 0.25 0 10 0 0 +0.5 0.25 0.25 10 0 0 + + +0.25 0.5 0 10 0 0 +0.5 0.5 0 10 0 0 + + +0.25 0.5 0 10 0 0 +0.25 0.5 0.25 10 0 0 + + +0.5 0.5 0 10 0 0 +0.5 0.5 0.25 10 0 0 + + +0.25 0.25 0.25 10 0 0 +0.5 0.25 0.25 10 0 0 + + +0.25 0.25 0.25 10 0 0 +0.25 0.5 0.25 10 0 0 + + +0.5 0.25 0.25 10 0 0 +0.5 0.5 0.25 10 0 0 + + +0.25 0.5 0.25 10 0 0 +0.5 0.5 0.25 10 0 0 + + +0 0 0.25 11 0 0 +0.25 0 0.25 11 0 0 + + +0 0 0.25 11 0 0 +0 0.25 0.25 11 0 0 + + +0 0 0.25 11 0 0 +0 0 0.5 11 0 0 + + +0.25 0 0.25 11 0 0 +0.25 0.25 0.25 11 0 0 + + +0.25 0 0.25 11 0 0 +0.25 0 0.5 11 0 0 + + +0 0.25 0.25 11 0 0 +0.25 0.25 0.25 11 0 0 + + +0 0.25 0.25 11 0 0 +0 0.25 0.5 11 0 0 + + +0.25 0.25 0.25 11 0 0 +0.25 0.25 0.5 11 0 0 + + +0 0 0.5 11 0 0 +0.25 0 0.5 11 0 0 + + +0 0 0.5 11 0 0 +0 0.25 0.5 11 0 0 + + +0.25 0 0.5 11 0 0 +0.25 0.25 0.5 11 0 0 + + +0 0.25 0.5 11 0 0 +0.25 0.25 0.5 11 0 0 + + +0.25 0 0.25 12 0 0 +0.5 0 0.25 12 0 0 + + +0.25 0 0.25 12 0 0 +0.25 0.25 0.25 12 0 0 + + +0.25 0 0.25 12 0 0 +0.25 0 0.5 12 0 0 + + +0.5 0 0.25 12 0 0 +0.5 0.25 0.25 12 0 0 + + +0.5 0 0.25 12 0 0 +0.5 0 0.5 12 0 0 + + +0.25 0.25 0.25 12 0 0 +0.5 0.25 0.25 12 0 0 + + +0.25 0.25 0.25 12 0 0 +0.25 0.25 0.5 12 0 0 + + +0.5 0.25 0.25 12 0 0 +0.5 0.25 0.5 12 0 0 + + +0.25 0 0.5 12 0 0 +0.5 0 0.5 12 0 0 + + +0.25 0 0.5 12 0 0 +0.25 0.25 0.5 12 0 0 + + +0.5 0 0.5 12 0 0 +0.5 0.25 0.5 12 0 0 + + +0.25 0.25 0.5 12 0 0 +0.5 0.25 0.5 12 0 0 + + +0 0.25 0.25 13 0 0 +0.25 0.25 0.25 13 0 0 + + +0 0.25 0.25 13 0 0 +0 0.5 0.25 13 0 0 + + +0 0.25 0.25 13 0 0 +0 0.25 0.5 13 0 0 + + +0.25 0.25 0.25 13 0 0 +0.25 0.5 0.25 13 0 0 + + +0.25 0.25 0.25 13 0 0 +0.25 0.25 0.5 13 0 0 + + +0 0.5 0.25 13 0 0 +0.25 0.5 0.25 13 0 0 + + +0 0.5 0.25 13 0 0 +0 0.5 0.5 13 0 0 + + +0.25 0.5 0.25 13 0 0 +0.25 0.5 0.5 13 0 0 + + +0 0.25 0.5 13 0 0 +0.25 0.25 0.5 13 0 0 + + +0 0.25 0.5 13 0 0 +0 0.5 0.5 13 0 0 + + +0.25 0.25 0.5 13 0 0 +0.25 0.5 0.5 13 0 0 + + +0 0.5 0.5 13 0 0 +0.25 0.5 0.5 13 0 0 + + +0.25 0.25 0.25 14 0 0 +0.5 0.25 0.25 14 0 0 + + +0.25 0.25 0.25 14 0 0 +0.25 0.5 0.25 14 0 0 + + +0.25 0.25 0.25 14 0 0 +0.25 0.25 0.5 14 0 0 + + +0.5 0.25 0.25 14 0 0 +0.5 0.5 0.25 14 0 0 + + +0.5 0.25 0.25 14 0 0 +0.5 0.25 0.5 14 0 0 + + +0.25 0.5 0.25 14 0 0 +0.5 0.5 0.25 14 0 0 + + +0.25 0.5 0.25 14 0 0 +0.25 0.5 0.5 14 0 0 + + +0.5 0.5 0.25 14 0 0 +0.5 0.5 0.5 14 0 0 + + +0.25 0.25 0.5 14 0 0 +0.5 0.25 0.5 14 0 0 + + +0.25 0.25 0.5 14 0 0 +0.25 0.5 0.5 14 0 0 + + +0.5 0.25 0.5 14 0 0 +0.5 0.5 0.5 14 0 0 + + +0.25 0.5 0.5 14 0 0 +0.5 0.5 0.5 14 0 0 + + -- 2.39.5