From 5e3802e675baa924c37cd01c3220f934f99f781a Mon Sep 17 00:00:00 2001 From: bangerth Date: Sat, 30 Dec 2006 00:52:57 +0000 Subject: [PATCH] Add a new version of GridGenerator::subdivided_hyper_cube git-svn-id: https://svn.dealii.org/trunk@14287 0785d39b-7218-0410-832d-ea1e28bc413d --- deal.II/deal.II/include/grid/grid_generator.h | 26 +- deal.II/deal.II/source/grid/grid_generator.cc | 282 ++++ deal.II/doc/news/changes.html | 6 +- tests/bits/grid_generator_03.cc | 141 ++ tests/bits/grid_generator_03/cmp/generic | 1139 +++++++++++++++++ 5 files changed, 1590 insertions(+), 4 deletions(-) create mode 100644 tests/bits/grid_generator_03.cc create mode 100644 tests/bits/grid_generator_03/cmp/generic diff --git a/deal.II/deal.II/include/grid/grid_generator.h b/deal.II/deal.II/include/grid/grid_generator.h index 2d79c6720f..12c4f364e2 100644 --- a/deal.II/deal.II/include/grid/grid_generator.h +++ b/deal.II/deal.II/include/grid/grid_generator.h @@ -17,6 +17,7 @@ #include #include #include +#include #include DEAL_II_NAMESPACE_OPEN @@ -128,7 +129,7 @@ template class SparseMatrix; * shell onto a grid of an airfoil, for example. * * @ingroup grid - * @author Wolfgang Bangerth, Ralf Hartmann, Guido Kanschat, Stefan Nauber, Joerg Weimar, 1998, 1999, 2000, 2001, 2002, 2003. + * @author Wolfgang Bangerth, Ralf Hartmann, Guido Kanschat, Stefan Nauber, Joerg Weimar, Yaqi Wang, 1998, 1999, 2000, 2001, 2002, 2003, 2006. */ class GridGenerator { @@ -305,6 +306,29 @@ class GridGenerator const Point &p_1, const Point &p_2, const bool colorize); + + /** + * Like the previous function, but with + * the following twist: the @p + * material_id argument is a + * dim-dimensional array that, for each + * cell, indicates which material_id + * should be set. In addition, and this + * is the major new functionality, if the + * material_id of a cell is (unsigned + * char)(-1), then that cell is + * deleted from the triangulation, + * i.e. the domain will have a void + * there. + */ + template + static + void + subdivided_hyper_rectangle (Triangulation &tria, + const std::vector< std::vector > &spacing, + const Point &p, + const Table &material_id, + const bool colorize=false); /** * A parallelogram. The first diff --git a/deal.II/deal.II/source/grid/grid_generator.cc b/deal.II/deal.II/source/grid/grid_generator.cc index cfb251096d..8074e46deb 100644 --- a/deal.II/deal.II/source/grid/grid_generator.cc +++ b/deal.II/deal.II/source/grid/grid_generator.cc @@ -22,6 +22,7 @@ #include #include #include +#include #include #include #include @@ -638,6 +639,287 @@ subdivided_hyper_rectangle(Triangulation &tria, +#if deal_II_dimension == 1 + +template <> +void +GridGenerator:: +subdivided_hyper_rectangle (Triangulation<1>& tria, + const std::vector< std::vector >& spacing, + const Point<1>& p, + const Table<1,unsigned char>& material_id, + const bool colorize) +{ + // contributed by Yaqi Wang 2006 + Assert(spacing.size() == 1, + ExcInvalidRepetitionsDimension(1)); + + const unsigned int n_cells = material_id.size(0); + + Assert(spacing[0].size() == n_cells, + ExcInvalidRepetitionsDimension(1)); + + double delta = std::numeric_limits::max(); + for (unsigned int i=0; i= 0, ExcInvalidRepetitions(-1)); + delta = std::min (delta, spacing[0][i]); + } + + // generate the necessary points + std::vector > points; + double ax = p[0]; + for (unsigned int x=0; x<=n_cells; ++x) { + points.push_back (Point<1> (ax)); + if (x > cells(n_val_cells); + unsigned int id = 0; + for (unsigned int x=0; x +void +GridGenerator:: +subdivided_hyper_rectangle (Triangulation<2>& tria, + const std::vector< std::vector >& spacing, + const Point<2>& p, + const Table<2,unsigned char>& material_id, + const bool colorize) +{ + // contributed by Yaqi Wang 2006 + Assert(spacing.size() == 2, + ExcInvalidRepetitionsDimension(2)); + + std::vector repetitions(2); + unsigned int n_cells = 1; + double delta = std::numeric_limits::max(); + for (unsigned int i=0; i<2; i++) + { + repetitions[i] = spacing[i].size(); + n_cells *= repetitions[i]; + for (unsigned int j=0; j= 0, ExcInvalidRepetitions(-1)); + delta = std::min (delta, spacing[i][j]); + } + Assert(material_id.size(i) == repetitions[i], + ExcInvalidRepetitionsDimension(i)); + } + + // generate the necessary points + std::vector > points; + double ay = p[1]; + for (unsigned int y=0; y<=repetitions[1]; ++y) + { + double ax = p[0]; + for (unsigned int x=0; x<=repetitions[0]; ++x) + { + points.push_back (Point<2> (ax,ay)); + if (x > cells(n_val_cells); + unsigned int id = 0; + for (unsigned int y=0; y::cell_iterator cell = tria.begin_raw(), + endc = tria.end(); + for (; cell !=endc; ++cell) + { + Point<2> cell_center = cell->center(); + for(unsigned int f=0; f::faces_per_cell; ++f) + if (cell->face(f)->boundary_indicator() == 0) + { + Point<2> face_center = cell->face(f)->center(); + for (unsigned int i=0; i<2; ++i) + { + if (face_center[i]face(f)->set_boundary_indicator(i*2); + if (face_center[i]>cell_center[i]+eps) + cell->face(f)->set_boundary_indicator(i*2+1); + } + } + } + } +} + +#endif + +#if deal_II_dimension == 3 + +template <> +void +GridGenerator:: +subdivided_hyper_rectangle (Triangulation<3>& tria, + const std::vector< std::vector >& spacing, + const Point<3>& p, + const Table<3,unsigned char>& material_id, + const bool colorize) +{ + // contributed by Yaqi Wang 2006 + const unsigned int dim = 3; + + Assert(spacing.size() == dim, + ExcInvalidRepetitionsDimension(dim)); + + std::vector repetitions(dim); + unsigned int n_cells = 1; + double delta = std::numeric_limits::max(); + for (unsigned int i=0; i= 0, ExcInvalidRepetitions(-1)); + delta = std::min (delta, spacing[i][j]); + } + Assert(material_id.size(i) == repetitions[i], + ExcInvalidRepetitionsDimension(i)); + } + + // generate the necessary points + std::vector > points; + double az = p[2]; + for (unsigned int z=0; z<=repetitions[2]; ++z) + { + double ay = p[1]; + for (unsigned int y=0; y<=repetitions[1]; ++y) + { + double ax = p[0]; + for (unsigned int x=0; x<=repetitions[0]; ++x) + { + points.push_back (Point (ax,ay,az)); + if (x > cells(n_val_cells); + unsigned int id = 0; + const unsigned int n_x = (repetitions[0]+1); + const unsigned int n_xy = (repetitions[0]+1)*(repetitions[1]+1); + for (unsigned int z=0; z::cell_iterator cell = tria.begin_raw(), + endc = tria.end(); + for (; cell !=endc; ++cell) + { + Point cell_center = cell->center(); + for(unsigned int f=0; f::faces_per_cell; ++f) + if (cell->face(f)->boundary_indicator() == 0) + { + Point face_center = cell->face(f)->center(); + for (unsigned int i=0; iface(f)->set_boundary_indicator(i*2); + if (face_center[i]>cell_center[i]+eps) + cell->face(f)->set_boundary_indicator(i*2+1); + } + } + } + } +} + +#endif + + #if deal_II_dimension == 1 // Implementation for 1D only diff --git a/deal.II/doc/news/changes.html b/deal.II/doc/news/changes.html index 72da0b2d35..eee625f1a2 100644 --- a/deal.II/doc/news/changes.html +++ b/deal.II/doc/news/changes.html @@ -1027,13 +1027,13 @@ inconvenience this causes.

  • - New: There is now a function GridGenerator::subdivided_hyper_rectangle that produces a non-uniformly subdivided rectangle, ideally suited for graded - meshes. + meshes. One of these functions is able to create meshes with holes.
    - (Yaqi Wang 2006/11/15) + (Yaqi Wang 2006/11/15, 2006/12/29)

  • Fixed: Corrected clone method diff --git a/tests/bits/grid_generator_03.cc b/tests/bits/grid_generator_03.cc new file mode 100644 index 0000000000..b1cfc69717 --- /dev/null +++ b/tests/bits/grid_generator_03.cc @@ -0,0 +1,141 @@ +//--------------------------------------------------------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 2005, 2006 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//--------------------------------------------------------------------------- + + +// Test GridGenerator::subdivided_hyper_rectangle with vector of step +// sizes and the table argument for material id + +#include "../tests.h" +#include +#include +#include +#include +#include +#include + +#include +#include + + +template Table material_ids(); + +template <> Table<1,unsigned char> material_ids<1>() +{ + Table<1,unsigned char> t(2); + for (unsigned int i=0; i<2; ++i) + t[i] = 1; + return t; +} + + +template <> Table<2,unsigned char> material_ids<2>() +{ + Table<2,unsigned char> t(2,3); + for (unsigned int i=0; i<2; ++i) + for (unsigned int j=0; j<3; ++j) + t[i][j] = 1; + // produce a hole in the middle + t[1][1] = (unsigned char)(-1); + return t; +} + + +template <> Table<3,unsigned char> material_ids<3>() +{ + Table<3,unsigned char> t(2,3,4); + for (unsigned int i=0; i<2; ++i) + for (unsigned int j=0; j<3; ++j) + for (unsigned int k=0; k<4; ++k) + t[i][j][k] = 1; + // produce a hole in the middle + t[1][1][1] = (unsigned char)(-1); + t[1][1][2] = (unsigned char)(-1); + return t; +} + + + +template +void test(std::ostream& out) +{ + Point p1; + p1[0] = 2.; + if (dim>1) p1[1] = -1.; + if (dim>2) p1[2] = 0.; + + Point p2; + p2[0] = 3.; + if (dim>1) p2[1] = 2.; + if (dim>2) p2[2] = 4.; + + Point p3; + p3[0] = 2.; + if (dim>1) p3[1] = 1.; + if (dim>2) p3[2] = 4.; + + GridOut go; + + // uniformly subdivided mesh + if (true) + { + deallog << "subdivided_hyper_rectangle" << std::endl; + Triangulation tr; + std::vector > sub(dim); + for (unsigned int i=0; i (i+2, (p2[i]-p1[i])/(i+2)); + + GridGenerator::subdivided_hyper_rectangle(tr, sub, p1, material_ids(), + dim!=1); + if (tr.n_cells() > 0) + go.write_gnuplot(tr, out); + } + + + // non-uniformly subdivided mesh + if (true) + { + deallog << "subdivided_hyper_rectangle" << std::endl; + Triangulation tr; + std::vector > sub(dim); + for (unsigned int i=0; i (i+2, (p2[i]-p1[i])/(i+2)); + sub[i][0] /= 2; + sub[i].back() *= 1.5; + } + + GridGenerator::subdivided_hyper_rectangle(tr, sub, p1, material_ids(), + dim!=1); + if (tr.n_cells() > 0) + go.write_gnuplot(tr, out); + } +} + + +int main() +{ + std::ofstream logfile("grid_generator_03/output"); + deallog.attach(logfile); + deallog.depth_console(0); + deallog.threshold_double(1.e-10); + + deallog.push("1d"); + test<1>(logfile); + deallog.pop(); + deallog.push("2d"); + test<2>(logfile); + deallog.pop(); + deallog.push("3d"); + test<3>(logfile); + deallog.pop(); +} diff --git a/tests/bits/grid_generator_03/cmp/generic b/tests/bits/grid_generator_03/cmp/generic new file mode 100644 index 0000000000..1c0c7c0d46 --- /dev/null +++ b/tests/bits/grid_generator_03/cmp/generic @@ -0,0 +1,1139 @@ + +DEAL:1d::subdivided_hyper_rectangle +2.00000 0 1 +2.50000 0 1 + +DEAL:1d::subdivided_hyper_rectangle +2.00000 0 1 +2.25000 0 1 + +DEAL:2d::subdivided_hyper_rectangle +2.00000 -1.00000 0 1 +2.50000 -1.00000 0 1 +2.50000 0.00000 0 1 +2.00000 0.00000 0 1 +2.00000 -1.00000 0 1 + + +2.50000 -1.00000 0 1 +3.00000 -1.00000 0 1 +3.00000 0.00000 0 1 +2.50000 0.00000 0 1 +2.50000 -1.00000 0 1 + + +2.00000 0.00000 0 1 +2.50000 0.00000 0 1 +2.50000 1.00000 0 1 +2.00000 1.00000 0 1 +2.00000 0.00000 0 1 + + +2.00000 1.00000 0 1 +2.50000 1.00000 0 1 +2.50000 2.00000 0 1 +2.00000 2.00000 0 1 +2.00000 1.00000 0 1 + + +2.50000 1.00000 0 1 +3.00000 1.00000 0 1 +3.00000 2.00000 0 1 +2.50000 2.00000 0 1 +2.50000 1.00000 0 1 + + +DEAL:2d::subdivided_hyper_rectangle +2.00000 -1.00000 0 1 +2.25000 -1.00000 0 1 +2.25000 -0.500000 0 1 +2.00000 -0.500000 0 1 +2.00000 -1.00000 0 1 + + +2.25000 -1.00000 0 1 +3.00000 -1.00000 0 1 +3.00000 -0.500000 0 1 +2.25000 -0.500000 0 1 +2.25000 -1.00000 0 1 + + +2.00000 -0.500000 0 1 +2.25000 -0.500000 0 1 +2.25000 0.500000 0 1 +2.00000 0.500000 0 1 +2.00000 -0.500000 0 1 + + +2.00000 0.500000 0 1 +2.25000 0.500000 0 1 +2.25000 2.00000 0 1 +2.00000 2.00000 0 1 +2.00000 0.500000 0 1 + + +2.25000 0.500000 0 1 +3.00000 0.500000 0 1 +3.00000 2.00000 0 1 +2.25000 2.00000 0 1 +2.25000 0.500000 0 1 + + +DEAL:3d::subdivided_hyper_rectangle +2.00000 -1.00000 0.00000 0 1 +2.50000 -1.00000 0.00000 0 1 +2.50000 -1.00000 1.00000 0 1 +2.00000 -1.00000 1.00000 0 1 +2.00000 -1.00000 0.00000 0 1 + +2.00000 0.00000 0.00000 0 1 +2.50000 0.00000 0.00000 0 1 +2.50000 0.00000 1.00000 0 1 +2.00000 0.00000 1.00000 0 1 +2.00000 0.00000 0.00000 0 1 + +2.00000 -1.00000 0.00000 0 1 +2.00000 0.00000 0.00000 0 1 + +2.50000 -1.00000 0.00000 0 1 +2.50000 0.00000 0.00000 0 1 + +2.50000 -1.00000 1.00000 0 1 +2.50000 0.00000 1.00000 0 1 + +2.00000 -1.00000 1.00000 0 1 +2.00000 0.00000 1.00000 0 1 + +2.50000 -1.00000 0.00000 0 1 +3.00000 -1.00000 0.00000 0 1 +3.00000 -1.00000 1.00000 0 1 +2.50000 -1.00000 1.00000 0 1 +2.50000 -1.00000 0.00000 0 1 + +2.50000 0.00000 0.00000 0 1 +3.00000 0.00000 0.00000 0 1 +3.00000 0.00000 1.00000 0 1 +2.50000 0.00000 1.00000 0 1 +2.50000 0.00000 0.00000 0 1 + +2.50000 -1.00000 0.00000 0 1 +2.50000 0.00000 0.00000 0 1 + +3.00000 -1.00000 0.00000 0 1 +3.00000 0.00000 0.00000 0 1 + +3.00000 -1.00000 1.00000 0 1 +3.00000 0.00000 1.00000 0 1 + +2.50000 -1.00000 1.00000 0 1 +2.50000 0.00000 1.00000 0 1 + +2.00000 0.00000 0.00000 0 1 +2.50000 0.00000 0.00000 0 1 +2.50000 0.00000 1.00000 0 1 +2.00000 0.00000 1.00000 0 1 +2.00000 0.00000 0.00000 0 1 + +2.00000 1.00000 0.00000 0 1 +2.50000 1.00000 0.00000 0 1 +2.50000 1.00000 1.00000 0 1 +2.00000 1.00000 1.00000 0 1 +2.00000 1.00000 0.00000 0 1 + +2.00000 0.00000 0.00000 0 1 +2.00000 1.00000 0.00000 0 1 + +2.50000 0.00000 0.00000 0 1 +2.50000 1.00000 0.00000 0 1 + +2.50000 0.00000 1.00000 0 1 +2.50000 1.00000 1.00000 0 1 + +2.00000 0.00000 1.00000 0 1 +2.00000 1.00000 1.00000 0 1 + +2.50000 0.00000 0.00000 0 1 +3.00000 0.00000 0.00000 0 1 +3.00000 0.00000 1.00000 0 1 +2.50000 0.00000 1.00000 0 1 +2.50000 0.00000 0.00000 0 1 + +2.50000 1.00000 0.00000 0 1 +3.00000 1.00000 0.00000 0 1 +3.00000 1.00000 1.00000 0 1 +2.50000 1.00000 1.00000 0 1 +2.50000 1.00000 0.00000 0 1 + +2.50000 0.00000 0.00000 0 1 +2.50000 1.00000 0.00000 0 1 + +3.00000 0.00000 0.00000 0 1 +3.00000 1.00000 0.00000 0 1 + +3.00000 0.00000 1.00000 0 1 +3.00000 1.00000 1.00000 0 1 + +2.50000 0.00000 1.00000 0 1 +2.50000 1.00000 1.00000 0 1 + +2.00000 1.00000 0.00000 0 1 +2.50000 1.00000 0.00000 0 1 +2.50000 1.00000 1.00000 0 1 +2.00000 1.00000 1.00000 0 1 +2.00000 1.00000 0.00000 0 1 + +2.00000 2.00000 0.00000 0 1 +2.50000 2.00000 0.00000 0 1 +2.50000 2.00000 1.00000 0 1 +2.00000 2.00000 1.00000 0 1 +2.00000 2.00000 0.00000 0 1 + +2.00000 1.00000 0.00000 0 1 +2.00000 2.00000 0.00000 0 1 + +2.50000 1.00000 0.00000 0 1 +2.50000 2.00000 0.00000 0 1 + +2.50000 1.00000 1.00000 0 1 +2.50000 2.00000 1.00000 0 1 + +2.00000 1.00000 1.00000 0 1 +2.00000 2.00000 1.00000 0 1 + +2.50000 1.00000 0.00000 0 1 +3.00000 1.00000 0.00000 0 1 +3.00000 1.00000 1.00000 0 1 +2.50000 1.00000 1.00000 0 1 +2.50000 1.00000 0.00000 0 1 + +2.50000 2.00000 0.00000 0 1 +3.00000 2.00000 0.00000 0 1 +3.00000 2.00000 1.00000 0 1 +2.50000 2.00000 1.00000 0 1 +2.50000 2.00000 0.00000 0 1 + +2.50000 1.00000 0.00000 0 1 +2.50000 2.00000 0.00000 0 1 + +3.00000 1.00000 0.00000 0 1 +3.00000 2.00000 0.00000 0 1 + +3.00000 1.00000 1.00000 0 1 +3.00000 2.00000 1.00000 0 1 + +2.50000 1.00000 1.00000 0 1 +2.50000 2.00000 1.00000 0 1 + +2.00000 -1.00000 1.00000 0 1 +2.50000 -1.00000 1.00000 0 1 +2.50000 -1.00000 2.00000 0 1 +2.00000 -1.00000 2.00000 0 1 +2.00000 -1.00000 1.00000 0 1 + +2.00000 0.00000 1.00000 0 1 +2.50000 0.00000 1.00000 0 1 +2.50000 0.00000 2.00000 0 1 +2.00000 0.00000 2.00000 0 1 +2.00000 0.00000 1.00000 0 1 + +2.00000 -1.00000 1.00000 0 1 +2.00000 0.00000 1.00000 0 1 + +2.50000 -1.00000 1.00000 0 1 +2.50000 0.00000 1.00000 0 1 + +2.50000 -1.00000 2.00000 0 1 +2.50000 0.00000 2.00000 0 1 + +2.00000 -1.00000 2.00000 0 1 +2.00000 0.00000 2.00000 0 1 + +2.50000 -1.00000 1.00000 0 1 +3.00000 -1.00000 1.00000 0 1 +3.00000 -1.00000 2.00000 0 1 +2.50000 -1.00000 2.00000 0 1 +2.50000 -1.00000 1.00000 0 1 + +2.50000 0.00000 1.00000 0 1 +3.00000 0.00000 1.00000 0 1 +3.00000 0.00000 2.00000 0 1 +2.50000 0.00000 2.00000 0 1 +2.50000 0.00000 1.00000 0 1 + +2.50000 -1.00000 1.00000 0 1 +2.50000 0.00000 1.00000 0 1 + +3.00000 -1.00000 1.00000 0 1 +3.00000 0.00000 1.00000 0 1 + +3.00000 -1.00000 2.00000 0 1 +3.00000 0.00000 2.00000 0 1 + +2.50000 -1.00000 2.00000 0 1 +2.50000 0.00000 2.00000 0 1 + +2.00000 0.00000 1.00000 0 1 +2.50000 0.00000 1.00000 0 1 +2.50000 0.00000 2.00000 0 1 +2.00000 0.00000 2.00000 0 1 +2.00000 0.00000 1.00000 0 1 + +2.00000 1.00000 1.00000 0 1 +2.50000 1.00000 1.00000 0 1 +2.50000 1.00000 2.00000 0 1 +2.00000 1.00000 2.00000 0 1 +2.00000 1.00000 1.00000 0 1 + +2.00000 0.00000 1.00000 0 1 +2.00000 1.00000 1.00000 0 1 + +2.50000 0.00000 1.00000 0 1 +2.50000 1.00000 1.00000 0 1 + +2.50000 0.00000 2.00000 0 1 +2.50000 1.00000 2.00000 0 1 + +2.00000 0.00000 2.00000 0 1 +2.00000 1.00000 2.00000 0 1 + +2.00000 1.00000 1.00000 0 1 +2.50000 1.00000 1.00000 0 1 +2.50000 1.00000 2.00000 0 1 +2.00000 1.00000 2.00000 0 1 +2.00000 1.00000 1.00000 0 1 + +2.00000 2.00000 1.00000 0 1 +2.50000 2.00000 1.00000 0 1 +2.50000 2.00000 2.00000 0 1 +2.00000 2.00000 2.00000 0 1 +2.00000 2.00000 1.00000 0 1 + +2.00000 1.00000 1.00000 0 1 +2.00000 2.00000 1.00000 0 1 + +2.50000 1.00000 1.00000 0 1 +2.50000 2.00000 1.00000 0 1 + +2.50000 1.00000 2.00000 0 1 +2.50000 2.00000 2.00000 0 1 + +2.00000 1.00000 2.00000 0 1 +2.00000 2.00000 2.00000 0 1 + +2.50000 1.00000 1.00000 0 1 +3.00000 1.00000 1.00000 0 1 +3.00000 1.00000 2.00000 0 1 +2.50000 1.00000 2.00000 0 1 +2.50000 1.00000 1.00000 0 1 + +2.50000 2.00000 1.00000 0 1 +3.00000 2.00000 1.00000 0 1 +3.00000 2.00000 2.00000 0 1 +2.50000 2.00000 2.00000 0 1 +2.50000 2.00000 1.00000 0 1 + +2.50000 1.00000 1.00000 0 1 +2.50000 2.00000 1.00000 0 1 + +3.00000 1.00000 1.00000 0 1 +3.00000 2.00000 1.00000 0 1 + +3.00000 1.00000 2.00000 0 1 +3.00000 2.00000 2.00000 0 1 + +2.50000 1.00000 2.00000 0 1 +2.50000 2.00000 2.00000 0 1 + +2.00000 -1.00000 2.00000 0 1 +2.50000 -1.00000 2.00000 0 1 +2.50000 -1.00000 3.00000 0 1 +2.00000 -1.00000 3.00000 0 1 +2.00000 -1.00000 2.00000 0 1 + +2.00000 0.00000 2.00000 0 1 +2.50000 0.00000 2.00000 0 1 +2.50000 0.00000 3.00000 0 1 +2.00000 0.00000 3.00000 0 1 +2.00000 0.00000 2.00000 0 1 + +2.00000 -1.00000 2.00000 0 1 +2.00000 0.00000 2.00000 0 1 + +2.50000 -1.00000 2.00000 0 1 +2.50000 0.00000 2.00000 0 1 + +2.50000 -1.00000 3.00000 0 1 +2.50000 0.00000 3.00000 0 1 + +2.00000 -1.00000 3.00000 0 1 +2.00000 0.00000 3.00000 0 1 + +2.50000 -1.00000 2.00000 0 1 +3.00000 -1.00000 2.00000 0 1 +3.00000 -1.00000 3.00000 0 1 +2.50000 -1.00000 3.00000 0 1 +2.50000 -1.00000 2.00000 0 1 + +2.50000 0.00000 2.00000 0 1 +3.00000 0.00000 2.00000 0 1 +3.00000 0.00000 3.00000 0 1 +2.50000 0.00000 3.00000 0 1 +2.50000 0.00000 2.00000 0 1 + +2.50000 -1.00000 2.00000 0 1 +2.50000 0.00000 2.00000 0 1 + +3.00000 -1.00000 2.00000 0 1 +3.00000 0.00000 2.00000 0 1 + +3.00000 -1.00000 3.00000 0 1 +3.00000 0.00000 3.00000 0 1 + +2.50000 -1.00000 3.00000 0 1 +2.50000 0.00000 3.00000 0 1 + +2.00000 0.00000 2.00000 0 1 +2.50000 0.00000 2.00000 0 1 +2.50000 0.00000 3.00000 0 1 +2.00000 0.00000 3.00000 0 1 +2.00000 0.00000 2.00000 0 1 + +2.00000 1.00000 2.00000 0 1 +2.50000 1.00000 2.00000 0 1 +2.50000 1.00000 3.00000 0 1 +2.00000 1.00000 3.00000 0 1 +2.00000 1.00000 2.00000 0 1 + +2.00000 0.00000 2.00000 0 1 +2.00000 1.00000 2.00000 0 1 + +2.50000 0.00000 2.00000 0 1 +2.50000 1.00000 2.00000 0 1 + +2.50000 0.00000 3.00000 0 1 +2.50000 1.00000 3.00000 0 1 + +2.00000 0.00000 3.00000 0 1 +2.00000 1.00000 3.00000 0 1 + +2.00000 1.00000 2.00000 0 1 +2.50000 1.00000 2.00000 0 1 +2.50000 1.00000 3.00000 0 1 +2.00000 1.00000 3.00000 0 1 +2.00000 1.00000 2.00000 0 1 + +2.00000 2.00000 2.00000 0 1 +2.50000 2.00000 2.00000 0 1 +2.50000 2.00000 3.00000 0 1 +2.00000 2.00000 3.00000 0 1 +2.00000 2.00000 2.00000 0 1 + +2.00000 1.00000 2.00000 0 1 +2.00000 2.00000 2.00000 0 1 + +2.50000 1.00000 2.00000 0 1 +2.50000 2.00000 2.00000 0 1 + +2.50000 1.00000 3.00000 0 1 +2.50000 2.00000 3.00000 0 1 + +2.00000 1.00000 3.00000 0 1 +2.00000 2.00000 3.00000 0 1 + +2.50000 1.00000 2.00000 0 1 +3.00000 1.00000 2.00000 0 1 +3.00000 1.00000 3.00000 0 1 +2.50000 1.00000 3.00000 0 1 +2.50000 1.00000 2.00000 0 1 + +2.50000 2.00000 2.00000 0 1 +3.00000 2.00000 2.00000 0 1 +3.00000 2.00000 3.00000 0 1 +2.50000 2.00000 3.00000 0 1 +2.50000 2.00000 2.00000 0 1 + +2.50000 1.00000 2.00000 0 1 +2.50000 2.00000 2.00000 0 1 + +3.00000 1.00000 2.00000 0 1 +3.00000 2.00000 2.00000 0 1 + +3.00000 1.00000 3.00000 0 1 +3.00000 2.00000 3.00000 0 1 + +2.50000 1.00000 3.00000 0 1 +2.50000 2.00000 3.00000 0 1 + +2.00000 -1.00000 3.00000 0 1 +2.50000 -1.00000 3.00000 0 1 +2.50000 -1.00000 4.00000 0 1 +2.00000 -1.00000 4.00000 0 1 +2.00000 -1.00000 3.00000 0 1 + +2.00000 0.00000 3.00000 0 1 +2.50000 0.00000 3.00000 0 1 +2.50000 0.00000 4.00000 0 1 +2.00000 0.00000 4.00000 0 1 +2.00000 0.00000 3.00000 0 1 + +2.00000 -1.00000 3.00000 0 1 +2.00000 0.00000 3.00000 0 1 + +2.50000 -1.00000 3.00000 0 1 +2.50000 0.00000 3.00000 0 1 + +2.50000 -1.00000 4.00000 0 1 +2.50000 0.00000 4.00000 0 1 + +2.00000 -1.00000 4.00000 0 1 +2.00000 0.00000 4.00000 0 1 + +2.50000 -1.00000 3.00000 0 1 +3.00000 -1.00000 3.00000 0 1 +3.00000 -1.00000 4.00000 0 1 +2.50000 -1.00000 4.00000 0 1 +2.50000 -1.00000 3.00000 0 1 + +2.50000 0.00000 3.00000 0 1 +3.00000 0.00000 3.00000 0 1 +3.00000 0.00000 4.00000 0 1 +2.50000 0.00000 4.00000 0 1 +2.50000 0.00000 3.00000 0 1 + +2.50000 -1.00000 3.00000 0 1 +2.50000 0.00000 3.00000 0 1 + +3.00000 -1.00000 3.00000 0 1 +3.00000 0.00000 3.00000 0 1 + +3.00000 -1.00000 4.00000 0 1 +3.00000 0.00000 4.00000 0 1 + +2.50000 -1.00000 4.00000 0 1 +2.50000 0.00000 4.00000 0 1 + +2.00000 0.00000 3.00000 0 1 +2.50000 0.00000 3.00000 0 1 +2.50000 0.00000 4.00000 0 1 +2.00000 0.00000 4.00000 0 1 +2.00000 0.00000 3.00000 0 1 + +2.00000 1.00000 3.00000 0 1 +2.50000 1.00000 3.00000 0 1 +2.50000 1.00000 4.00000 0 1 +2.00000 1.00000 4.00000 0 1 +2.00000 1.00000 3.00000 0 1 + +2.00000 0.00000 3.00000 0 1 +2.00000 1.00000 3.00000 0 1 + +2.50000 0.00000 3.00000 0 1 +2.50000 1.00000 3.00000 0 1 + +2.50000 0.00000 4.00000 0 1 +2.50000 1.00000 4.00000 0 1 + +2.00000 0.00000 4.00000 0 1 +2.00000 1.00000 4.00000 0 1 + +2.50000 0.00000 3.00000 0 1 +3.00000 0.00000 3.00000 0 1 +3.00000 0.00000 4.00000 0 1 +2.50000 0.00000 4.00000 0 1 +2.50000 0.00000 3.00000 0 1 + +2.50000 1.00000 3.00000 0 1 +3.00000 1.00000 3.00000 0 1 +3.00000 1.00000 4.00000 0 1 +2.50000 1.00000 4.00000 0 1 +2.50000 1.00000 3.00000 0 1 + +2.50000 0.00000 3.00000 0 1 +2.50000 1.00000 3.00000 0 1 + +3.00000 0.00000 3.00000 0 1 +3.00000 1.00000 3.00000 0 1 + +3.00000 0.00000 4.00000 0 1 +3.00000 1.00000 4.00000 0 1 + +2.50000 0.00000 4.00000 0 1 +2.50000 1.00000 4.00000 0 1 + +2.00000 1.00000 3.00000 0 1 +2.50000 1.00000 3.00000 0 1 +2.50000 1.00000 4.00000 0 1 +2.00000 1.00000 4.00000 0 1 +2.00000 1.00000 3.00000 0 1 + +2.00000 2.00000 3.00000 0 1 +2.50000 2.00000 3.00000 0 1 +2.50000 2.00000 4.00000 0 1 +2.00000 2.00000 4.00000 0 1 +2.00000 2.00000 3.00000 0 1 + +2.00000 1.00000 3.00000 0 1 +2.00000 2.00000 3.00000 0 1 + +2.50000 1.00000 3.00000 0 1 +2.50000 2.00000 3.00000 0 1 + +2.50000 1.00000 4.00000 0 1 +2.50000 2.00000 4.00000 0 1 + +2.00000 1.00000 4.00000 0 1 +2.00000 2.00000 4.00000 0 1 + +2.50000 1.00000 3.00000 0 1 +3.00000 1.00000 3.00000 0 1 +3.00000 1.00000 4.00000 0 1 +2.50000 1.00000 4.00000 0 1 +2.50000 1.00000 3.00000 0 1 + +2.50000 2.00000 3.00000 0 1 +3.00000 2.00000 3.00000 0 1 +3.00000 2.00000 4.00000 0 1 +2.50000 2.00000 4.00000 0 1 +2.50000 2.00000 3.00000 0 1 + +2.50000 1.00000 3.00000 0 1 +2.50000 2.00000 3.00000 0 1 + +3.00000 1.00000 3.00000 0 1 +3.00000 2.00000 3.00000 0 1 + +3.00000 1.00000 4.00000 0 1 +3.00000 2.00000 4.00000 0 1 + +2.50000 1.00000 4.00000 0 1 +2.50000 2.00000 4.00000 0 1 + +DEAL:3d::subdivided_hyper_rectangle +2.00000 -1.00000 0.00000 0 1 +2.25000 -1.00000 0.00000 0 1 +2.25000 -1.00000 0.500000 0 1 +2.00000 -1.00000 0.500000 0 1 +2.00000 -1.00000 0.00000 0 1 + +2.00000 -0.500000 0.00000 0 1 +2.25000 -0.500000 0.00000 0 1 +2.25000 -0.500000 0.500000 0 1 +2.00000 -0.500000 0.500000 0 1 +2.00000 -0.500000 0.00000 0 1 + +2.00000 -1.00000 0.00000 0 1 +2.00000 -0.500000 0.00000 0 1 + +2.25000 -1.00000 0.00000 0 1 +2.25000 -0.500000 0.00000 0 1 + +2.25000 -1.00000 0.500000 0 1 +2.25000 -0.500000 0.500000 0 1 + +2.00000 -1.00000 0.500000 0 1 +2.00000 -0.500000 0.500000 0 1 + +2.25000 -1.00000 0.00000 0 1 +3.00000 -1.00000 0.00000 0 1 +3.00000 -1.00000 0.500000 0 1 +2.25000 -1.00000 0.500000 0 1 +2.25000 -1.00000 0.00000 0 1 + +2.25000 -0.500000 0.00000 0 1 +3.00000 -0.500000 0.00000 0 1 +3.00000 -0.500000 0.500000 0 1 +2.25000 -0.500000 0.500000 0 1 +2.25000 -0.500000 0.00000 0 1 + +2.25000 -1.00000 0.00000 0 1 +2.25000 -0.500000 0.00000 0 1 + +3.00000 -1.00000 0.00000 0 1 +3.00000 -0.500000 0.00000 0 1 + +3.00000 -1.00000 0.500000 0 1 +3.00000 -0.500000 0.500000 0 1 + +2.25000 -1.00000 0.500000 0 1 +2.25000 -0.500000 0.500000 0 1 + +2.00000 -0.500000 0.00000 0 1 +2.25000 -0.500000 0.00000 0 1 +2.25000 -0.500000 0.500000 0 1 +2.00000 -0.500000 0.500000 0 1 +2.00000 -0.500000 0.00000 0 1 + +2.00000 0.500000 0.00000 0 1 +2.25000 0.500000 0.00000 0 1 +2.25000 0.500000 0.500000 0 1 +2.00000 0.500000 0.500000 0 1 +2.00000 0.500000 0.00000 0 1 + +2.00000 -0.500000 0.00000 0 1 +2.00000 0.500000 0.00000 0 1 + +2.25000 -0.500000 0.00000 0 1 +2.25000 0.500000 0.00000 0 1 + +2.25000 -0.500000 0.500000 0 1 +2.25000 0.500000 0.500000 0 1 + +2.00000 -0.500000 0.500000 0 1 +2.00000 0.500000 0.500000 0 1 + +2.25000 -0.500000 0.00000 0 1 +3.00000 -0.500000 0.00000 0 1 +3.00000 -0.500000 0.500000 0 1 +2.25000 -0.500000 0.500000 0 1 +2.25000 -0.500000 0.00000 0 1 + +2.25000 0.500000 0.00000 0 1 +3.00000 0.500000 0.00000 0 1 +3.00000 0.500000 0.500000 0 1 +2.25000 0.500000 0.500000 0 1 +2.25000 0.500000 0.00000 0 1 + +2.25000 -0.500000 0.00000 0 1 +2.25000 0.500000 0.00000 0 1 + +3.00000 -0.500000 0.00000 0 1 +3.00000 0.500000 0.00000 0 1 + +3.00000 -0.500000 0.500000 0 1 +3.00000 0.500000 0.500000 0 1 + +2.25000 -0.500000 0.500000 0 1 +2.25000 0.500000 0.500000 0 1 + +2.00000 0.500000 0.00000 0 1 +2.25000 0.500000 0.00000 0 1 +2.25000 0.500000 0.500000 0 1 +2.00000 0.500000 0.500000 0 1 +2.00000 0.500000 0.00000 0 1 + +2.00000 2.00000 0.00000 0 1 +2.25000 2.00000 0.00000 0 1 +2.25000 2.00000 0.500000 0 1 +2.00000 2.00000 0.500000 0 1 +2.00000 2.00000 0.00000 0 1 + +2.00000 0.500000 0.00000 0 1 +2.00000 2.00000 0.00000 0 1 + +2.25000 0.500000 0.00000 0 1 +2.25000 2.00000 0.00000 0 1 + +2.25000 0.500000 0.500000 0 1 +2.25000 2.00000 0.500000 0 1 + +2.00000 0.500000 0.500000 0 1 +2.00000 2.00000 0.500000 0 1 + +2.25000 0.500000 0.00000 0 1 +3.00000 0.500000 0.00000 0 1 +3.00000 0.500000 0.500000 0 1 +2.25000 0.500000 0.500000 0 1 +2.25000 0.500000 0.00000 0 1 + +2.25000 2.00000 0.00000 0 1 +3.00000 2.00000 0.00000 0 1 +3.00000 2.00000 0.500000 0 1 +2.25000 2.00000 0.500000 0 1 +2.25000 2.00000 0.00000 0 1 + +2.25000 0.500000 0.00000 0 1 +2.25000 2.00000 0.00000 0 1 + +3.00000 0.500000 0.00000 0 1 +3.00000 2.00000 0.00000 0 1 + +3.00000 0.500000 0.500000 0 1 +3.00000 2.00000 0.500000 0 1 + +2.25000 0.500000 0.500000 0 1 +2.25000 2.00000 0.500000 0 1 + +2.00000 -1.00000 0.500000 0 1 +2.25000 -1.00000 0.500000 0 1 +2.25000 -1.00000 1.50000 0 1 +2.00000 -1.00000 1.50000 0 1 +2.00000 -1.00000 0.500000 0 1 + +2.00000 -0.500000 0.500000 0 1 +2.25000 -0.500000 0.500000 0 1 +2.25000 -0.500000 1.50000 0 1 +2.00000 -0.500000 1.50000 0 1 +2.00000 -0.500000 0.500000 0 1 + +2.00000 -1.00000 0.500000 0 1 +2.00000 -0.500000 0.500000 0 1 + +2.25000 -1.00000 0.500000 0 1 +2.25000 -0.500000 0.500000 0 1 + +2.25000 -1.00000 1.50000 0 1 +2.25000 -0.500000 1.50000 0 1 + +2.00000 -1.00000 1.50000 0 1 +2.00000 -0.500000 1.50000 0 1 + +2.25000 -1.00000 0.500000 0 1 +3.00000 -1.00000 0.500000 0 1 +3.00000 -1.00000 1.50000 0 1 +2.25000 -1.00000 1.50000 0 1 +2.25000 -1.00000 0.500000 0 1 + +2.25000 -0.500000 0.500000 0 1 +3.00000 -0.500000 0.500000 0 1 +3.00000 -0.500000 1.50000 0 1 +2.25000 -0.500000 1.50000 0 1 +2.25000 -0.500000 0.500000 0 1 + +2.25000 -1.00000 0.500000 0 1 +2.25000 -0.500000 0.500000 0 1 + +3.00000 -1.00000 0.500000 0 1 +3.00000 -0.500000 0.500000 0 1 + +3.00000 -1.00000 1.50000 0 1 +3.00000 -0.500000 1.50000 0 1 + +2.25000 -1.00000 1.50000 0 1 +2.25000 -0.500000 1.50000 0 1 + +2.00000 -0.500000 0.500000 0 1 +2.25000 -0.500000 0.500000 0 1 +2.25000 -0.500000 1.50000 0 1 +2.00000 -0.500000 1.50000 0 1 +2.00000 -0.500000 0.500000 0 1 + +2.00000 0.500000 0.500000 0 1 +2.25000 0.500000 0.500000 0 1 +2.25000 0.500000 1.50000 0 1 +2.00000 0.500000 1.50000 0 1 +2.00000 0.500000 0.500000 0 1 + +2.00000 -0.500000 0.500000 0 1 +2.00000 0.500000 0.500000 0 1 + +2.25000 -0.500000 0.500000 0 1 +2.25000 0.500000 0.500000 0 1 + +2.25000 -0.500000 1.50000 0 1 +2.25000 0.500000 1.50000 0 1 + +2.00000 -0.500000 1.50000 0 1 +2.00000 0.500000 1.50000 0 1 + +2.00000 0.500000 0.500000 0 1 +2.25000 0.500000 0.500000 0 1 +2.25000 0.500000 1.50000 0 1 +2.00000 0.500000 1.50000 0 1 +2.00000 0.500000 0.500000 0 1 + +2.00000 2.00000 0.500000 0 1 +2.25000 2.00000 0.500000 0 1 +2.25000 2.00000 1.50000 0 1 +2.00000 2.00000 1.50000 0 1 +2.00000 2.00000 0.500000 0 1 + +2.00000 0.500000 0.500000 0 1 +2.00000 2.00000 0.500000 0 1 + +2.25000 0.500000 0.500000 0 1 +2.25000 2.00000 0.500000 0 1 + +2.25000 0.500000 1.50000 0 1 +2.25000 2.00000 1.50000 0 1 + +2.00000 0.500000 1.50000 0 1 +2.00000 2.00000 1.50000 0 1 + +2.25000 0.500000 0.500000 0 1 +3.00000 0.500000 0.500000 0 1 +3.00000 0.500000 1.50000 0 1 +2.25000 0.500000 1.50000 0 1 +2.25000 0.500000 0.500000 0 1 + +2.25000 2.00000 0.500000 0 1 +3.00000 2.00000 0.500000 0 1 +3.00000 2.00000 1.50000 0 1 +2.25000 2.00000 1.50000 0 1 +2.25000 2.00000 0.500000 0 1 + +2.25000 0.500000 0.500000 0 1 +2.25000 2.00000 0.500000 0 1 + +3.00000 0.500000 0.500000 0 1 +3.00000 2.00000 0.500000 0 1 + +3.00000 0.500000 1.50000 0 1 +3.00000 2.00000 1.50000 0 1 + +2.25000 0.500000 1.50000 0 1 +2.25000 2.00000 1.50000 0 1 + +2.00000 -1.00000 1.50000 0 1 +2.25000 -1.00000 1.50000 0 1 +2.25000 -1.00000 2.50000 0 1 +2.00000 -1.00000 2.50000 0 1 +2.00000 -1.00000 1.50000 0 1 + +2.00000 -0.500000 1.50000 0 1 +2.25000 -0.500000 1.50000 0 1 +2.25000 -0.500000 2.50000 0 1 +2.00000 -0.500000 2.50000 0 1 +2.00000 -0.500000 1.50000 0 1 + +2.00000 -1.00000 1.50000 0 1 +2.00000 -0.500000 1.50000 0 1 + +2.25000 -1.00000 1.50000 0 1 +2.25000 -0.500000 1.50000 0 1 + +2.25000 -1.00000 2.50000 0 1 +2.25000 -0.500000 2.50000 0 1 + +2.00000 -1.00000 2.50000 0 1 +2.00000 -0.500000 2.50000 0 1 + +2.25000 -1.00000 1.50000 0 1 +3.00000 -1.00000 1.50000 0 1 +3.00000 -1.00000 2.50000 0 1 +2.25000 -1.00000 2.50000 0 1 +2.25000 -1.00000 1.50000 0 1 + +2.25000 -0.500000 1.50000 0 1 +3.00000 -0.500000 1.50000 0 1 +3.00000 -0.500000 2.50000 0 1 +2.25000 -0.500000 2.50000 0 1 +2.25000 -0.500000 1.50000 0 1 + +2.25000 -1.00000 1.50000 0 1 +2.25000 -0.500000 1.50000 0 1 + +3.00000 -1.00000 1.50000 0 1 +3.00000 -0.500000 1.50000 0 1 + +3.00000 -1.00000 2.50000 0 1 +3.00000 -0.500000 2.50000 0 1 + +2.25000 -1.00000 2.50000 0 1 +2.25000 -0.500000 2.50000 0 1 + +2.00000 -0.500000 1.50000 0 1 +2.25000 -0.500000 1.50000 0 1 +2.25000 -0.500000 2.50000 0 1 +2.00000 -0.500000 2.50000 0 1 +2.00000 -0.500000 1.50000 0 1 + +2.00000 0.500000 1.50000 0 1 +2.25000 0.500000 1.50000 0 1 +2.25000 0.500000 2.50000 0 1 +2.00000 0.500000 2.50000 0 1 +2.00000 0.500000 1.50000 0 1 + +2.00000 -0.500000 1.50000 0 1 +2.00000 0.500000 1.50000 0 1 + +2.25000 -0.500000 1.50000 0 1 +2.25000 0.500000 1.50000 0 1 + +2.25000 -0.500000 2.50000 0 1 +2.25000 0.500000 2.50000 0 1 + +2.00000 -0.500000 2.50000 0 1 +2.00000 0.500000 2.50000 0 1 + +2.00000 0.500000 1.50000 0 1 +2.25000 0.500000 1.50000 0 1 +2.25000 0.500000 2.50000 0 1 +2.00000 0.500000 2.50000 0 1 +2.00000 0.500000 1.50000 0 1 + +2.00000 2.00000 1.50000 0 1 +2.25000 2.00000 1.50000 0 1 +2.25000 2.00000 2.50000 0 1 +2.00000 2.00000 2.50000 0 1 +2.00000 2.00000 1.50000 0 1 + +2.00000 0.500000 1.50000 0 1 +2.00000 2.00000 1.50000 0 1 + +2.25000 0.500000 1.50000 0 1 +2.25000 2.00000 1.50000 0 1 + +2.25000 0.500000 2.50000 0 1 +2.25000 2.00000 2.50000 0 1 + +2.00000 0.500000 2.50000 0 1 +2.00000 2.00000 2.50000 0 1 + +2.25000 0.500000 1.50000 0 1 +3.00000 0.500000 1.50000 0 1 +3.00000 0.500000 2.50000 0 1 +2.25000 0.500000 2.50000 0 1 +2.25000 0.500000 1.50000 0 1 + +2.25000 2.00000 1.50000 0 1 +3.00000 2.00000 1.50000 0 1 +3.00000 2.00000 2.50000 0 1 +2.25000 2.00000 2.50000 0 1 +2.25000 2.00000 1.50000 0 1 + +2.25000 0.500000 1.50000 0 1 +2.25000 2.00000 1.50000 0 1 + +3.00000 0.500000 1.50000 0 1 +3.00000 2.00000 1.50000 0 1 + +3.00000 0.500000 2.50000 0 1 +3.00000 2.00000 2.50000 0 1 + +2.25000 0.500000 2.50000 0 1 +2.25000 2.00000 2.50000 0 1 + +2.00000 -1.00000 2.50000 0 1 +2.25000 -1.00000 2.50000 0 1 +2.25000 -1.00000 4.00000 0 1 +2.00000 -1.00000 4.00000 0 1 +2.00000 -1.00000 2.50000 0 1 + +2.00000 -0.500000 2.50000 0 1 +2.25000 -0.500000 2.50000 0 1 +2.25000 -0.500000 4.00000 0 1 +2.00000 -0.500000 4.00000 0 1 +2.00000 -0.500000 2.50000 0 1 + +2.00000 -1.00000 2.50000 0 1 +2.00000 -0.500000 2.50000 0 1 + +2.25000 -1.00000 2.50000 0 1 +2.25000 -0.500000 2.50000 0 1 + +2.25000 -1.00000 4.00000 0 1 +2.25000 -0.500000 4.00000 0 1 + +2.00000 -1.00000 4.00000 0 1 +2.00000 -0.500000 4.00000 0 1 + +2.25000 -1.00000 2.50000 0 1 +3.00000 -1.00000 2.50000 0 1 +3.00000 -1.00000 4.00000 0 1 +2.25000 -1.00000 4.00000 0 1 +2.25000 -1.00000 2.50000 0 1 + +2.25000 -0.500000 2.50000 0 1 +3.00000 -0.500000 2.50000 0 1 +3.00000 -0.500000 4.00000 0 1 +2.25000 -0.500000 4.00000 0 1 +2.25000 -0.500000 2.50000 0 1 + +2.25000 -1.00000 2.50000 0 1 +2.25000 -0.500000 2.50000 0 1 + +3.00000 -1.00000 2.50000 0 1 +3.00000 -0.500000 2.50000 0 1 + +3.00000 -1.00000 4.00000 0 1 +3.00000 -0.500000 4.00000 0 1 + +2.25000 -1.00000 4.00000 0 1 +2.25000 -0.500000 4.00000 0 1 + +2.00000 -0.500000 2.50000 0 1 +2.25000 -0.500000 2.50000 0 1 +2.25000 -0.500000 4.00000 0 1 +2.00000 -0.500000 4.00000 0 1 +2.00000 -0.500000 2.50000 0 1 + +2.00000 0.500000 2.50000 0 1 +2.25000 0.500000 2.50000 0 1 +2.25000 0.500000 4.00000 0 1 +2.00000 0.500000 4.00000 0 1 +2.00000 0.500000 2.50000 0 1 + +2.00000 -0.500000 2.50000 0 1 +2.00000 0.500000 2.50000 0 1 + +2.25000 -0.500000 2.50000 0 1 +2.25000 0.500000 2.50000 0 1 + +2.25000 -0.500000 4.00000 0 1 +2.25000 0.500000 4.00000 0 1 + +2.00000 -0.500000 4.00000 0 1 +2.00000 0.500000 4.00000 0 1 + +2.25000 -0.500000 2.50000 0 1 +3.00000 -0.500000 2.50000 0 1 +3.00000 -0.500000 4.00000 0 1 +2.25000 -0.500000 4.00000 0 1 +2.25000 -0.500000 2.50000 0 1 + +2.25000 0.500000 2.50000 0 1 +3.00000 0.500000 2.50000 0 1 +3.00000 0.500000 4.00000 0 1 +2.25000 0.500000 4.00000 0 1 +2.25000 0.500000 2.50000 0 1 + +2.25000 -0.500000 2.50000 0 1 +2.25000 0.500000 2.50000 0 1 + +3.00000 -0.500000 2.50000 0 1 +3.00000 0.500000 2.50000 0 1 + +3.00000 -0.500000 4.00000 0 1 +3.00000 0.500000 4.00000 0 1 + +2.25000 -0.500000 4.00000 0 1 +2.25000 0.500000 4.00000 0 1 + +2.00000 0.500000 2.50000 0 1 +2.25000 0.500000 2.50000 0 1 +2.25000 0.500000 4.00000 0 1 +2.00000 0.500000 4.00000 0 1 +2.00000 0.500000 2.50000 0 1 + +2.00000 2.00000 2.50000 0 1 +2.25000 2.00000 2.50000 0 1 +2.25000 2.00000 4.00000 0 1 +2.00000 2.00000 4.00000 0 1 +2.00000 2.00000 2.50000 0 1 + +2.00000 0.500000 2.50000 0 1 +2.00000 2.00000 2.50000 0 1 + +2.25000 0.500000 2.50000 0 1 +2.25000 2.00000 2.50000 0 1 + +2.25000 0.500000 4.00000 0 1 +2.25000 2.00000 4.00000 0 1 + +2.00000 0.500000 4.00000 0 1 +2.00000 2.00000 4.00000 0 1 + +2.25000 0.500000 2.50000 0 1 +3.00000 0.500000 2.50000 0 1 +3.00000 0.500000 4.00000 0 1 +2.25000 0.500000 4.00000 0 1 +2.25000 0.500000 2.50000 0 1 + +2.25000 2.00000 2.50000 0 1 +3.00000 2.00000 2.50000 0 1 +3.00000 2.00000 4.00000 0 1 +2.25000 2.00000 4.00000 0 1 +2.25000 2.00000 2.50000 0 1 + +2.25000 0.500000 2.50000 0 1 +2.25000 2.00000 2.50000 0 1 + +3.00000 0.500000 2.50000 0 1 +3.00000 2.00000 2.50000 0 1 + +3.00000 0.500000 4.00000 0 1 +3.00000 2.00000 4.00000 0 1 + +2.25000 0.500000 4.00000 0 1 +2.25000 2.00000 4.00000 0 1 + -- 2.39.5