From: bangerth Date: Wed, 27 Jun 2012 12:54:01 +0000 (+0000) Subject: Fix yet another bug in VectorTools::no_normal_flux when dealing with fluxes that... X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=a97d2f0899d8adb06894a3ec1c9514c904721e84;p=dealii-svn.git Fix yet another bug in VectorTools::no_normal_flux when dealing with fluxes that are tangential to *two* adjacent faces. This can only possibly have worked before if these faces where parallel to at least one coordinate axes :-( git-svn-id: https://svn.dealii.org/trunk@25649 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/doc/news/changes.h b/deal.II/doc/news/changes.h index 48cab3d81b..b998e7f4a8 100644 --- a/deal.II/doc/news/changes.h +++ b/deal.II/doc/news/changes.h @@ -47,6 +47,13 @@ used for boundary indicators.
    +
  1. Fixed: The function VectorTools::compute_no_normal_flux_constraints had +a bug that led to an exception whenever we were computing constraints for +vector fields located on edges shared between two faces of a 3d cell if those +faces were not parallel to the axes of the coordinate system. This is now fixed. +
    +(Wolfgang Bangerth, Jennifer Worthen, 2012/06/27) +
  2. Fixed: Due to an apparent bug in autoconf, it was not possible to override the F77 environment variable to select anything diff --git a/deal.II/include/deal.II/numerics/vectors.templates.h b/deal.II/include/deal.II/numerics/vectors.templates.h index 941af268f5..908df25d49 100644 --- a/deal.II/include/deal.II/numerics/vectors.templates.h +++ b/deal.II/include/deal.II/numerics/vectors.templates.h @@ -2585,7 +2585,65 @@ namespace VectorTools default: Assert (false, ExcNotImplemented()); } + } + + /** + * Add the constraint $\vec u \| + * \vec t$ to the list of + * constraints. In 2d, this is a + * single constraint, in 3d these + * are two constraints + * + * Here, $\vec u$ is represented + * by the set of given DoF + * indices, and $\vec t$ by the + * vector specified as the second + * argument. + * + * The function does not add constraints + * if a degree of freedom is already + * constrained in the constraints object. + */ + template + void + add_tangentiality_constraints (const VectorDoFTuple &dof_indices, + const Tensor<1,dim> &tangent_vector, + ConstraintMatrix &constraints) + { + + // choose the DoF that has the + // largest component in the + // tangent_vector as the + // independent component, and + // then constrain the others to + // it. specifically, if, say, + // component 0 of the tangent + // vector t is largest by + // magnitude, then + // x1=t[1]/t[0]*x_0, etc. + unsigned int largest_component = 0; + for (unsigned int d=1; d std::fabs(tangent_vector[largest_component]) + 1e-10) + largest_component = d; + + // then constrain all of the + // other degrees of freedom in + // terms of the one just found + for (unsigned int d=0; d std::numeric_limits::epsilon()) + constraints.add_entry (dof_indices.dof_indices[d], + dof_indices.dof_indices[largest_component], + tangent_vector[d]/tangent_vector[largest_component]); + } } @@ -4182,9 +4240,9 @@ namespace VectorTools } + template class DH, int spacedim> void - compute_no_normal_flux_constraints (const DH &dof_handler, const unsigned int first_vector_component, const std::set &boundary_ids, @@ -4812,35 +4870,16 @@ namespace VectorTools average_tangent += *t; average_tangent /= average_tangent.norm(); - // from the tangent - // vector we now need to - // again reconstruct dim-1 - // normal directions in - // which the vector field - // is to be constrained - Tensor<1,dim> constraining_normals[dim-1]; - internal:: - compute_orthonormal_vectors (average_tangent, - constraining_normals); - // normalize again - for (unsigned int e=0; e & dof_indices = same_dof_range[0]->first; - for (unsigned int c=0; c #include #include +#include #include #include -#include +#include #include #include #include #include -template -static void -colorize_sixty_deg_hyper_shell(Triangulation & tria, - const Point& center, - const double inner_radius, - const double outer_radius); - -template -static void sixty_deg_hyper_shell (Triangulation &tria, - const Point ¢er, - const double inner_radius, - const double outer_radius, - const unsigned int n_cells = 0, - const bool colorize = false); - -template -class SixtyDegHyperShellBoundary : public HyperShellBoundary -{ - public: - - SixtyDegHyperShellBoundary (const Point ¢er, - const double inner_radius, - const double outer_radius); - - private: - const double inner_radius; - const double outer_radius; -}; - -// Implementation for 3D only -template <> void colorize_sixty_deg_hyper_shell(Triangulation<3> & tria, const Point<3>& center, @@ -145,73 +115,44 @@ colorize_sixty_deg_hyper_shell(Triangulation<3> & tria, } } -// Implementation for 3D only -template <> void sixty_deg_hyper_shell (Triangulation<3> & tria, const Point<3>& center, const double inner_radius, - const double outer_radius, - const unsigned int n, - const bool colorize) + const double outer_radius) { - // Assert ((inner_radius > 0) && (inner_radius < outer_radius), - // ExcInvalidRadii ()); - if (n == 0 || n == 2) - { - const double r0 = inner_radius; - const double r1 = outer_radius; - - std::vector > vertices; - - vertices.push_back (center+Point<3>( 1.0/sqrt(5.)*r0, 1.0/sqrt(5.)*r0, sqrt(3./5.)*r0)); //8 -> 0 - vertices.push_back (center+Point<3>( 1.0/sqrt(5.)*r1, 1.0/sqrt(5.)*r1, sqrt(3./5.)*r1)); //9 -> 1 - vertices.push_back (center+Point<3>( 1.0/sqrt(5.)*r0, -1.0/sqrt(5.)*r0, sqrt(3./5.)*r0)); //10 -> 2 - vertices.push_back (center+Point<3>( 1.0/sqrt(5.)*r1, -1.0/sqrt(5.)*r1, sqrt(3./5.)*r1)); //11 -> 3 - vertices.push_back (center+Point<3>( -1.0/sqrt(5.)*r0, 1.0/sqrt(5.)*r0, sqrt(3./5.)*r0)); //14 -> 4 - vertices.push_back (center+Point<3>( -1.0/sqrt(5.)*r1, 1.0/sqrt(5.)*r1, sqrt(3./5.)*r1)); //15 -> 5 - vertices.push_back (center+Point<3>( -1.0/sqrt(5.)*r0, -1.0/sqrt(5.)*r0, sqrt(3./5.)*r0)); //16 -> 6 - vertices.push_back (center+Point<3>( -1.0/sqrt(5.)*r1, -1.0/sqrt(5.)*r1, sqrt(3./5.)*r1)); //17 -> 7 - - const int cell_vertices[1][8] = { - {6, 2, 4, 0, 7, 3, 5, 1}, - }; - - std::vector > cells(1); - - for (unsigned int i=0; i<1; ++i) - { - for (unsigned int j=0; j<8; ++j) - cells[i].vertices[j] = cell_vertices[i][j]; - cells[i].material_id = 0; - } - - tria.create_triangulation ( vertices, cells, SubCellData()); // no boundary information - } - else + const double r0 = inner_radius; + const double r1 = outer_radius; + + std::vector > vertices; + + vertices.push_back (center+Point<3>( 1.0/sqrt(5.)*r0, 1.0/sqrt(5.)*r0, sqrt(3./5.)*r0)); //8 -> 0 + vertices.push_back (center+Point<3>( 1.0/sqrt(5.)*r1, 1.0/sqrt(5.)*r1, sqrt(3./5.)*r1)); //9 -> 1 + vertices.push_back (center+Point<3>( 1.0/sqrt(5.)*r0, -1.0/sqrt(5.)*r0, sqrt(3./5.)*r0)); //10 -> 2 + vertices.push_back (center+Point<3>( 1.0/sqrt(5.)*r1, -1.0/sqrt(5.)*r1, sqrt(3./5.)*r1)); //11 -> 3 + vertices.push_back (center+Point<3>( -1.0/sqrt(5.)*r0, 1.0/sqrt(5.)*r0, sqrt(3./5.)*r0)); //14 -> 4 + vertices.push_back (center+Point<3>( -1.0/sqrt(5.)*r1, 1.0/sqrt(5.)*r1, sqrt(3./5.)*r1)); //15 -> 5 + vertices.push_back (center+Point<3>( -1.0/sqrt(5.)*r0, -1.0/sqrt(5.)*r0, sqrt(3./5.)*r0)); //16 -> 6 + vertices.push_back (center+Point<3>( -1.0/sqrt(5.)*r1, -1.0/sqrt(5.)*r1, sqrt(3./5.)*r1)); //17 -> 7 + + const int cell_vertices[1][8] = { + {6, 2, 4, 0, 7, 3, 5, 1}, + }; + + std::vector > cells(1); + + for (unsigned int i=0; i<1; ++i) { - AssertThrow(false, ExcNotImplemented()); + for (unsigned int j=0; j<8; ++j) + cells[i].vertices[j] = cell_vertices[i][j]; + cells[i].material_id = 0; } - if (colorize) - colorize_sixty_deg_hyper_shell(tria, center, inner_radius, outer_radius); -} + tria.create_triangulation ( vertices, cells, SubCellData()); // no boundary information -template -SixtyDegHyperShellBoundary::SixtyDegHyperShellBoundary (const Point ¢er, - const double inner_radius, - const double outer_radius) - : - HyperShellBoundary (center), - inner_radius (inner_radius), - outer_radius (outer_radius) -{ - if (dim > 2) - Assert ((inner_radius >= 0) && - (outer_radius > 0) && - (outer_radius > inner_radius), - ExcMessage ("Inner and outer radii must be specified explicitly in 3d.")); + colorize_sixty_deg_hyper_shell(tria, center, inner_radius, outer_radius); } + template void run() { @@ -223,18 +164,29 @@ void run() sixty_deg_hyper_shell (triangulation, Point(), 0.5, - 1.0, - 2, - true); + 1.0); - static SixtyDegHyperShellBoundary boundary(Point(), - 0.5, - 1.0); + static HyperShellBoundary boundary((Point())); triangulation.set_boundary (0, boundary); - triangulation.set_boundary (1, boundary); + + // write out the mesh. may not be + // strictly necessary here, but is + // a good test for functionality + // that may not actually be tested + // anywhere else + MappingQ<3> m(4); + GridOut go; + GridOutFlags::Gnuplot gof; + gof.n_boundary_face_points = 6; + go.set_flags (gof); + go.write_gnuplot (triangulation, deallog.get_file_stream(), &m); dof_handler.distribute_dofs (fe); + for (unsigned int f=0; f<6; ++f) + deallog << "Face=" << f << ", boundary_id=" + << (int)triangulation.begin_active()->face(f)->boundary_indicator() << std::endl; + std::set no_normal_flux_boundaries; no_normal_flux_boundaries.insert (0); no_normal_flux_boundaries.insert (2); @@ -243,9 +195,10 @@ void run() no_normal_flux_boundaries, constraints); - constraints.close(); constraints.print(deallog.get_file_stream()); + deallog.get_file_stream() << std::flush; + constraints.close(); deallog << "OK" << std::endl; } diff --git a/tests/deal.II/no_flux_10/cmp/generic b/tests/deal.II/no_flux_10/cmp/generic index 1ac20abe9d..33b19bd8cf 100644 --- a/tests/deal.II/no_flux_10/cmp/generic +++ b/tests/deal.II/no_flux_10/cmp/generic @@ -1,22 +1,2076 @@ - 2 = 0 - 5 = 0 - 8 = 0 - 7 6: -0.4142 - 11 9: 1.0000 - 11 10: 1.0000 - 19 18: -0.4889 - 19 20: -0.9881 - 22 21: -1.0000 - 22 23: -0.8648 - 25 = 0 - 26 = 0 - 27 = 0 - 28 = 0 - 29 = 0 - 31 = 0 - 34 = 0 - 35 33: -1.0000 - 37 = 0 - 40 = 0 - 41 39: -0.4142 +-0.2236 -0.2236 0.3873 0 0 +-0.2556 -0.2556 0.4426 0 0 +-0.2583 -0.1831 0.4473 0 0 +-0.2364 -0.1626 0.4095 0 0 +-0.2236 -0.2236 0.3873 0 0 + + +-0.2364 -0.1626 0.4095 0 0 +-0.2583 -0.1831 0.4473 0 0 +-0.2601 -0.1101 0.4505 0 0 +-0.2451 -0.0987 0.4245 0 0 +-0.2364 -0.1626 0.4095 0 0 + + +-0.2451 -0.0987 0.4245 0 0 +-0.2601 -0.1101 0.4505 0 0 +-0.2610 -0.0368 0.4521 0 0 +-0.2495 -0.0331 0.4321 0 0 +-0.2451 -0.0987 0.4245 0 0 + + +-0.2495 -0.0331 0.4321 0 0 +-0.2610 -0.0368 0.4521 0 0 +-0.2610 0.0368 0.4521 0 0 +-0.2495 0.0331 0.4321 0 0 +-0.2495 -0.0331 0.4321 0 0 + + +-0.2495 0.0331 0.4321 0 0 +-0.2610 0.0368 0.4521 0 0 +-0.2601 0.1101 0.4505 0 0 +-0.2451 0.0987 0.4245 0 0 +-0.2495 0.0331 0.4321 0 0 + + +-0.2451 0.0987 0.4245 0 0 +-0.2601 0.1101 0.4505 0 0 +-0.2583 0.1831 0.4473 0 0 +-0.2364 0.1626 0.4095 0 0 +-0.2451 0.0987 0.4245 0 0 + + +-0.2364 0.1626 0.4095 0 0 +-0.2583 0.1831 0.4473 0 0 +-0.2556 0.2556 0.4426 0 0 +-0.2236 0.2236 0.3873 0 0 +-0.2364 0.1626 0.4095 0 0 + + +-0.2556 -0.2556 0.4426 0 0 +-0.2875 -0.2875 0.4980 0 0 +-0.2871 -0.2053 0.4974 0 0 +-0.2583 -0.1831 0.4473 0 0 +-0.2556 -0.2556 0.4426 0 0 + + +-0.2583 -0.1831 0.4473 0 0 +-0.2871 -0.2053 0.4974 0 0 +-0.2869 -0.1231 0.4969 0 0 +-0.2601 -0.1101 0.4505 0 0 +-0.2583 -0.1831 0.4473 0 0 + + +-0.2601 -0.1101 0.4505 0 0 +-0.2869 -0.1231 0.4969 0 0 +-0.2868 -0.0410 0.4967 0 0 +-0.2610 -0.0368 0.4521 0 0 +-0.2601 -0.1101 0.4505 0 0 + + +-0.2610 -0.0368 0.4521 0 0 +-0.2868 -0.0410 0.4967 0 0 +-0.2868 0.0410 0.4967 0 0 +-0.2610 0.0368 0.4521 0 0 +-0.2610 -0.0368 0.4521 0 0 + + +-0.2610 0.0368 0.4521 0 0 +-0.2868 0.0410 0.4967 0 0 +-0.2869 0.1231 0.4969 0 0 +-0.2601 0.1101 0.4505 0 0 +-0.2610 0.0368 0.4521 0 0 + + +-0.2601 0.1101 0.4505 0 0 +-0.2869 0.1231 0.4969 0 0 +-0.2871 0.2053 0.4974 0 0 +-0.2583 0.1831 0.4473 0 0 +-0.2601 0.1101 0.4505 0 0 + + +-0.2583 0.1831 0.4473 0 0 +-0.2871 0.2053 0.4974 0 0 +-0.2875 0.2875 0.4980 0 0 +-0.2556 0.2556 0.4426 0 0 +-0.2583 0.1831 0.4473 0 0 + + +-0.2875 -0.2875 0.4980 0 0 +-0.3194 -0.3194 0.5533 0 0 +-0.3191 -0.2281 0.5527 0 0 +-0.2871 -0.2053 0.4974 0 0 +-0.2875 -0.2875 0.4980 0 0 + + +-0.2871 -0.2053 0.4974 0 0 +-0.3191 -0.2281 0.5527 0 0 +-0.3189 -0.1368 0.5524 0 0 +-0.2869 -0.1231 0.4969 0 0 +-0.2871 -0.2053 0.4974 0 0 + + +-0.2869 -0.1231 0.4969 0 0 +-0.3189 -0.1368 0.5524 0 0 +-0.3188 -0.0456 0.5522 0 0 +-0.2868 -0.0410 0.4967 0 0 +-0.2869 -0.1231 0.4969 0 0 + + +-0.2868 -0.0410 0.4967 0 0 +-0.3188 -0.0456 0.5522 0 0 +-0.3188 0.0456 0.5522 0 0 +-0.2868 0.0410 0.4967 0 0 +-0.2868 -0.0410 0.4967 0 0 + + +-0.2868 0.0410 0.4967 0 0 +-0.3188 0.0456 0.5522 0 0 +-0.3189 0.1368 0.5524 0 0 +-0.2869 0.1231 0.4969 0 0 +-0.2868 0.0410 0.4967 0 0 + + +-0.2869 0.1231 0.4969 0 0 +-0.3189 0.1368 0.5524 0 0 +-0.3191 0.2281 0.5527 0 0 +-0.2871 0.2053 0.4974 0 0 +-0.2869 0.1231 0.4969 0 0 + + +-0.2871 0.2053 0.4974 0 0 +-0.3191 0.2281 0.5527 0 0 +-0.3194 0.3194 0.5533 0 0 +-0.2875 0.2875 0.4980 0 0 +-0.2871 0.2053 0.4974 0 0 + + +-0.3194 -0.3194 0.5533 0 0 +-0.3514 -0.3514 0.6086 0 0 +-0.3516 -0.2510 0.6090 0 0 +-0.3191 -0.2281 0.5527 0 0 +-0.3194 -0.3194 0.5533 0 0 + + +-0.3191 -0.2281 0.5527 0 0 +-0.3516 -0.2510 0.6090 0 0 +-0.3518 -0.1506 0.6093 0 0 +-0.3189 -0.1368 0.5524 0 0 +-0.3191 -0.2281 0.5527 0 0 + + +-0.3189 -0.1368 0.5524 0 0 +-0.3518 -0.1506 0.6093 0 0 +-0.3519 -0.0502 0.6095 0 0 +-0.3188 -0.0456 0.5522 0 0 +-0.3189 -0.1368 0.5524 0 0 + + +-0.3188 -0.0456 0.5522 0 0 +-0.3519 -0.0502 0.6095 0 0 +-0.3519 0.0502 0.6095 0 0 +-0.3188 0.0456 0.5522 0 0 +-0.3188 -0.0456 0.5522 0 0 + + +-0.3188 0.0456 0.5522 0 0 +-0.3519 0.0502 0.6095 0 0 +-0.3518 0.1506 0.6093 0 0 +-0.3189 0.1368 0.5524 0 0 +-0.3188 0.0456 0.5522 0 0 + + +-0.3189 0.1368 0.5524 0 0 +-0.3518 0.1506 0.6093 0 0 +-0.3516 0.2510 0.6090 0 0 +-0.3191 0.2281 0.5527 0 0 +-0.3189 0.1368 0.5524 0 0 + + +-0.3191 0.2281 0.5527 0 0 +-0.3516 0.2510 0.6090 0 0 +-0.3514 0.3514 0.6086 0 0 +-0.3194 0.3194 0.5533 0 0 +-0.3191 0.2281 0.5527 0 0 + + +-0.3514 -0.3514 0.6086 0 0 +-0.3833 -0.3833 0.6639 0 0 +-0.3835 -0.2738 0.6642 0 0 +-0.3516 -0.2510 0.6090 0 0 +-0.3514 -0.3514 0.6086 0 0 + + +-0.3516 -0.2510 0.6090 0 0 +-0.3835 -0.2738 0.6642 0 0 +-0.3836 -0.1643 0.6643 0 0 +-0.3518 -0.1506 0.6093 0 0 +-0.3516 -0.2510 0.6090 0 0 + + +-0.3518 -0.1506 0.6093 0 0 +-0.3836 -0.1643 0.6643 0 0 +-0.3836 -0.0548 0.6644 0 0 +-0.3519 -0.0502 0.6095 0 0 +-0.3518 -0.1506 0.6093 0 0 + + +-0.3519 -0.0502 0.6095 0 0 +-0.3836 -0.0548 0.6644 0 0 +-0.3836 0.0548 0.6644 0 0 +-0.3519 0.0502 0.6095 0 0 +-0.3519 -0.0502 0.6095 0 0 + + +-0.3519 0.0502 0.6095 0 0 +-0.3836 0.0548 0.6644 0 0 +-0.3836 0.1643 0.6643 0 0 +-0.3518 0.1506 0.6093 0 0 +-0.3519 0.0502 0.6095 0 0 + + +-0.3518 0.1506 0.6093 0 0 +-0.3836 0.1643 0.6643 0 0 +-0.3835 0.2738 0.6642 0 0 +-0.3516 0.2510 0.6090 0 0 +-0.3518 0.1506 0.6093 0 0 + + +-0.3516 0.2510 0.6090 0 0 +-0.3835 0.2738 0.6642 0 0 +-0.3833 0.3833 0.6639 0 0 +-0.3514 0.3514 0.6086 0 0 +-0.3516 0.2510 0.6090 0 0 + + +-0.3833 -0.3833 0.6639 0 0 +-0.4153 -0.4153 0.7193 0 0 +-0.4148 -0.2965 0.7185 0 0 +-0.3835 -0.2738 0.6642 0 0 +-0.3833 -0.3833 0.6639 0 0 + + +-0.3835 -0.2738 0.6642 0 0 +-0.4148 -0.2965 0.7185 0 0 +-0.4145 -0.1779 0.7180 0 0 +-0.3836 -0.1643 0.6643 0 0 +-0.3835 -0.2738 0.6642 0 0 + + +-0.3836 -0.1643 0.6643 0 0 +-0.4145 -0.1779 0.7180 0 0 +-0.4144 -0.0593 0.7177 0 0 +-0.3836 -0.0548 0.6644 0 0 +-0.3836 -0.1643 0.6643 0 0 + + +-0.3836 -0.0548 0.6644 0 0 +-0.4144 -0.0593 0.7177 0 0 +-0.4144 0.0593 0.7177 0 0 +-0.3836 0.0548 0.6644 0 0 +-0.3836 -0.0548 0.6644 0 0 + + +-0.3836 0.0548 0.6644 0 0 +-0.4144 0.0593 0.7177 0 0 +-0.4145 0.1779 0.7180 0 0 +-0.3836 0.1643 0.6643 0 0 +-0.3836 0.0548 0.6644 0 0 + + +-0.3836 0.1643 0.6643 0 0 +-0.4145 0.1779 0.7180 0 0 +-0.4148 0.2965 0.7185 0 0 +-0.3835 0.2738 0.6642 0 0 +-0.3836 0.1643 0.6643 0 0 + + +-0.3835 0.2738 0.6642 0 0 +-0.4148 0.2965 0.7185 0 0 +-0.4153 0.4153 0.7193 0 0 +-0.3833 0.3833 0.6639 0 0 +-0.3835 0.2738 0.6642 0 0 + + +-0.4153 -0.4153 0.7193 0 0 +-0.4472 -0.4472 0.7746 0 0 +-0.4472 -0.3194 0.7746 0 0 +-0.4148 -0.2965 0.7185 0 0 +-0.4153 -0.4153 0.7193 0 0 + + +-0.4148 -0.2965 0.7185 0 0 +-0.4472 -0.3194 0.7746 0 0 +-0.4472 -0.1917 0.7746 0 0 +-0.4145 -0.1779 0.7180 0 0 +-0.4148 -0.2965 0.7185 0 0 + + +-0.4145 -0.1779 0.7180 0 0 +-0.4472 -0.1917 0.7746 0 0 +-0.4472 -0.0639 0.7746 0 0 +-0.4144 -0.0593 0.7177 0 0 +-0.4145 -0.1779 0.7180 0 0 + + +-0.4144 -0.0593 0.7177 0 0 +-0.4472 -0.0639 0.7746 0 0 +-0.4472 0.0639 0.7746 0 0 +-0.4144 0.0593 0.7177 0 0 +-0.4144 -0.0593 0.7177 0 0 + + +-0.4144 0.0593 0.7177 0 0 +-0.4472 0.0639 0.7746 0 0 +-0.4472 0.1917 0.7746 0 0 +-0.4145 0.1779 0.7180 0 0 +-0.4144 0.0593 0.7177 0 0 + + +-0.4145 0.1779 0.7180 0 0 +-0.4472 0.1917 0.7746 0 0 +-0.4472 0.3194 0.7746 0 0 +-0.4148 0.2965 0.7185 0 0 +-0.4145 0.1779 0.7180 0 0 + + +-0.4148 0.2965 0.7185 0 0 +-0.4472 0.3194 0.7746 0 0 +-0.4472 0.4472 0.7746 0 0 +-0.4153 0.4153 0.7193 0 0 +-0.4148 0.2965 0.7185 0 0 + + +0.2236 -0.2236 0.3873 0 0 +0.2556 -0.2556 0.4426 0 0 +0.2583 -0.1831 0.4473 0 0 +0.2364 -0.1626 0.4095 0 0 +0.2236 -0.2236 0.3873 0 0 + + +0.2364 -0.1626 0.4095 0 0 +0.2583 -0.1831 0.4473 0 0 +0.2601 -0.1101 0.4505 0 0 +0.2451 -0.0987 0.4245 0 0 +0.2364 -0.1626 0.4095 0 0 + + +0.2451 -0.0987 0.4245 0 0 +0.2601 -0.1101 0.4505 0 0 +0.2610 -0.0368 0.4521 0 0 +0.2495 -0.0331 0.4321 0 0 +0.2451 -0.0987 0.4245 0 0 + + +0.2495 -0.0331 0.4321 0 0 +0.2610 -0.0368 0.4521 0 0 +0.2610 0.0368 0.4521 0 0 +0.2495 0.0331 0.4321 0 0 +0.2495 -0.0331 0.4321 0 0 + + +0.2495 0.0331 0.4321 0 0 +0.2610 0.0368 0.4521 0 0 +0.2601 0.1101 0.4505 0 0 +0.2451 0.0987 0.4245 0 0 +0.2495 0.0331 0.4321 0 0 + + +0.2451 0.0987 0.4245 0 0 +0.2601 0.1101 0.4505 0 0 +0.2583 0.1831 0.4473 0 0 +0.2364 0.1626 0.4095 0 0 +0.2451 0.0987 0.4245 0 0 + + +0.2364 0.1626 0.4095 0 0 +0.2583 0.1831 0.4473 0 0 +0.2556 0.2556 0.4426 0 0 +0.2236 0.2236 0.3873 0 0 +0.2364 0.1626 0.4095 0 0 + + +0.2556 -0.2556 0.4426 0 0 +0.2875 -0.2875 0.4980 0 0 +0.2871 -0.2053 0.4974 0 0 +0.2583 -0.1831 0.4473 0 0 +0.2556 -0.2556 0.4426 0 0 + + +0.2583 -0.1831 0.4473 0 0 +0.2871 -0.2053 0.4974 0 0 +0.2869 -0.1231 0.4969 0 0 +0.2601 -0.1101 0.4505 0 0 +0.2583 -0.1831 0.4473 0 0 + + +0.2601 -0.1101 0.4505 0 0 +0.2869 -0.1231 0.4969 0 0 +0.2868 -0.0410 0.4967 0 0 +0.2610 -0.0368 0.4521 0 0 +0.2601 -0.1101 0.4505 0 0 + + +0.2610 -0.0368 0.4521 0 0 +0.2868 -0.0410 0.4967 0 0 +0.2868 0.0410 0.4967 0 0 +0.2610 0.0368 0.4521 0 0 +0.2610 -0.0368 0.4521 0 0 + + +0.2610 0.0368 0.4521 0 0 +0.2868 0.0410 0.4967 0 0 +0.2869 0.1231 0.4969 0 0 +0.2601 0.1101 0.4505 0 0 +0.2610 0.0368 0.4521 0 0 + + +0.2601 0.1101 0.4505 0 0 +0.2869 0.1231 0.4969 0 0 +0.2871 0.2053 0.4974 0 0 +0.2583 0.1831 0.4473 0 0 +0.2601 0.1101 0.4505 0 0 + + +0.2583 0.1831 0.4473 0 0 +0.2871 0.2053 0.4974 0 0 +0.2875 0.2875 0.4980 0 0 +0.2556 0.2556 0.4426 0 0 +0.2583 0.1831 0.4473 0 0 + + +0.2875 -0.2875 0.4980 0 0 +0.3194 -0.3194 0.5533 0 0 +0.3191 -0.2281 0.5527 0 0 +0.2871 -0.2053 0.4974 0 0 +0.2875 -0.2875 0.4980 0 0 + + +0.2871 -0.2053 0.4974 0 0 +0.3191 -0.2281 0.5527 0 0 +0.3189 -0.1368 0.5524 0 0 +0.2869 -0.1231 0.4969 0 0 +0.2871 -0.2053 0.4974 0 0 + + +0.2869 -0.1231 0.4969 0 0 +0.3189 -0.1368 0.5524 0 0 +0.3188 -0.0456 0.5522 0 0 +0.2868 -0.0410 0.4967 0 0 +0.2869 -0.1231 0.4969 0 0 + + +0.2868 -0.0410 0.4967 0 0 +0.3188 -0.0456 0.5522 0 0 +0.3188 0.0456 0.5522 0 0 +0.2868 0.0410 0.4967 0 0 +0.2868 -0.0410 0.4967 0 0 + + +0.2868 0.0410 0.4967 0 0 +0.3188 0.0456 0.5522 0 0 +0.3189 0.1368 0.5524 0 0 +0.2869 0.1231 0.4969 0 0 +0.2868 0.0410 0.4967 0 0 + + +0.2869 0.1231 0.4969 0 0 +0.3189 0.1368 0.5524 0 0 +0.3191 0.2281 0.5527 0 0 +0.2871 0.2053 0.4974 0 0 +0.2869 0.1231 0.4969 0 0 + + +0.2871 0.2053 0.4974 0 0 +0.3191 0.2281 0.5527 0 0 +0.3194 0.3194 0.5533 0 0 +0.2875 0.2875 0.4980 0 0 +0.2871 0.2053 0.4974 0 0 + + +0.3194 -0.3194 0.5533 0 0 +0.3514 -0.3514 0.6086 0 0 +0.3516 -0.2510 0.6090 0 0 +0.3191 -0.2281 0.5527 0 0 +0.3194 -0.3194 0.5533 0 0 + + +0.3191 -0.2281 0.5527 0 0 +0.3516 -0.2510 0.6090 0 0 +0.3518 -0.1506 0.6093 0 0 +0.3189 -0.1368 0.5524 0 0 +0.3191 -0.2281 0.5527 0 0 + + +0.3189 -0.1368 0.5524 0 0 +0.3518 -0.1506 0.6093 0 0 +0.3519 -0.0502 0.6095 0 0 +0.3188 -0.0456 0.5522 0 0 +0.3189 -0.1368 0.5524 0 0 + + +0.3188 -0.0456 0.5522 0 0 +0.3519 -0.0502 0.6095 0 0 +0.3519 0.0502 0.6095 0 0 +0.3188 0.0456 0.5522 0 0 +0.3188 -0.0456 0.5522 0 0 + + +0.3188 0.0456 0.5522 0 0 +0.3519 0.0502 0.6095 0 0 +0.3518 0.1506 0.6093 0 0 +0.3189 0.1368 0.5524 0 0 +0.3188 0.0456 0.5522 0 0 + + +0.3189 0.1368 0.5524 0 0 +0.3518 0.1506 0.6093 0 0 +0.3516 0.2510 0.6090 0 0 +0.3191 0.2281 0.5527 0 0 +0.3189 0.1368 0.5524 0 0 + + +0.3191 0.2281 0.5527 0 0 +0.3516 0.2510 0.6090 0 0 +0.3514 0.3514 0.6086 0 0 +0.3194 0.3194 0.5533 0 0 +0.3191 0.2281 0.5527 0 0 + + +0.3514 -0.3514 0.6086 0 0 +0.3833 -0.3833 0.6639 0 0 +0.3835 -0.2738 0.6642 0 0 +0.3516 -0.2510 0.6090 0 0 +0.3514 -0.3514 0.6086 0 0 + + +0.3516 -0.2510 0.6090 0 0 +0.3835 -0.2738 0.6642 0 0 +0.3836 -0.1643 0.6643 0 0 +0.3518 -0.1506 0.6093 0 0 +0.3516 -0.2510 0.6090 0 0 + + +0.3518 -0.1506 0.6093 0 0 +0.3836 -0.1643 0.6643 0 0 +0.3836 -0.0548 0.6644 0 0 +0.3519 -0.0502 0.6095 0 0 +0.3518 -0.1506 0.6093 0 0 + + +0.3519 -0.0502 0.6095 0 0 +0.3836 -0.0548 0.6644 0 0 +0.3836 0.0548 0.6644 0 0 +0.3519 0.0502 0.6095 0 0 +0.3519 -0.0502 0.6095 0 0 + + +0.3519 0.0502 0.6095 0 0 +0.3836 0.0548 0.6644 0 0 +0.3836 0.1643 0.6643 0 0 +0.3518 0.1506 0.6093 0 0 +0.3519 0.0502 0.6095 0 0 + + +0.3518 0.1506 0.6093 0 0 +0.3836 0.1643 0.6643 0 0 +0.3835 0.2738 0.6642 0 0 +0.3516 0.2510 0.6090 0 0 +0.3518 0.1506 0.6093 0 0 + + +0.3516 0.2510 0.6090 0 0 +0.3835 0.2738 0.6642 0 0 +0.3833 0.3833 0.6639 0 0 +0.3514 0.3514 0.6086 0 0 +0.3516 0.2510 0.6090 0 0 + + +0.3833 -0.3833 0.6639 0 0 +0.4153 -0.4153 0.7193 0 0 +0.4148 -0.2965 0.7185 0 0 +0.3835 -0.2738 0.6642 0 0 +0.3833 -0.3833 0.6639 0 0 + + +0.3835 -0.2738 0.6642 0 0 +0.4148 -0.2965 0.7185 0 0 +0.4145 -0.1779 0.7180 0 0 +0.3836 -0.1643 0.6643 0 0 +0.3835 -0.2738 0.6642 0 0 + + +0.3836 -0.1643 0.6643 0 0 +0.4145 -0.1779 0.7180 0 0 +0.4144 -0.0593 0.7177 0 0 +0.3836 -0.0548 0.6644 0 0 +0.3836 -0.1643 0.6643 0 0 + + +0.3836 -0.0548 0.6644 0 0 +0.4144 -0.0593 0.7177 0 0 +0.4144 0.0593 0.7177 0 0 +0.3836 0.0548 0.6644 0 0 +0.3836 -0.0548 0.6644 0 0 + + +0.3836 0.0548 0.6644 0 0 +0.4144 0.0593 0.7177 0 0 +0.4145 0.1779 0.7180 0 0 +0.3836 0.1643 0.6643 0 0 +0.3836 0.0548 0.6644 0 0 + + +0.3836 0.1643 0.6643 0 0 +0.4145 0.1779 0.7180 0 0 +0.4148 0.2965 0.7185 0 0 +0.3835 0.2738 0.6642 0 0 +0.3836 0.1643 0.6643 0 0 + + +0.3835 0.2738 0.6642 0 0 +0.4148 0.2965 0.7185 0 0 +0.4153 0.4153 0.7193 0 0 +0.3833 0.3833 0.6639 0 0 +0.3835 0.2738 0.6642 0 0 + + +0.4153 -0.4153 0.7193 0 0 +0.4472 -0.4472 0.7746 0 0 +0.4472 -0.3194 0.7746 0 0 +0.4148 -0.2965 0.7185 0 0 +0.4153 -0.4153 0.7193 0 0 + + +0.4148 -0.2965 0.7185 0 0 +0.4472 -0.3194 0.7746 0 0 +0.4472 -0.1917 0.7746 0 0 +0.4145 -0.1779 0.7180 0 0 +0.4148 -0.2965 0.7185 0 0 + + +0.4145 -0.1779 0.7180 0 0 +0.4472 -0.1917 0.7746 0 0 +0.4472 -0.0639 0.7746 0 0 +0.4144 -0.0593 0.7177 0 0 +0.4145 -0.1779 0.7180 0 0 + + +0.4144 -0.0593 0.7177 0 0 +0.4472 -0.0639 0.7746 0 0 +0.4472 0.0639 0.7746 0 0 +0.4144 0.0593 0.7177 0 0 +0.4144 -0.0593 0.7177 0 0 + + +0.4144 0.0593 0.7177 0 0 +0.4472 0.0639 0.7746 0 0 +0.4472 0.1917 0.7746 0 0 +0.4145 0.1779 0.7180 0 0 +0.4144 0.0593 0.7177 0 0 + + +0.4145 0.1779 0.7180 0 0 +0.4472 0.1917 0.7746 0 0 +0.4472 0.3194 0.7746 0 0 +0.4148 0.2965 0.7185 0 0 +0.4145 0.1779 0.7180 0 0 + + +0.4148 0.2965 0.7185 0 0 +0.4472 0.3194 0.7746 0 0 +0.4472 0.4472 0.7746 0 0 +0.4153 0.4153 0.7193 0 0 +0.4148 0.2965 0.7185 0 0 + + +-0.2236 -0.2236 0.3873 0 0 +-0.1626 -0.2364 0.4095 0 0 +-0.1831 -0.2583 0.4473 0 0 +-0.2556 -0.2556 0.4426 0 0 +-0.2236 -0.2236 0.3873 0 0 + + +-0.2556 -0.2556 0.4426 0 0 +-0.1831 -0.2583 0.4473 0 0 +-0.2053 -0.2871 0.4974 0 0 +-0.2875 -0.2875 0.4980 0 0 +-0.2556 -0.2556 0.4426 0 0 + + +-0.2875 -0.2875 0.4980 0 0 +-0.2053 -0.2871 0.4974 0 0 +-0.2281 -0.3191 0.5527 0 0 +-0.3194 -0.3194 0.5533 0 0 +-0.2875 -0.2875 0.4980 0 0 + + +-0.3194 -0.3194 0.5533 0 0 +-0.2281 -0.3191 0.5527 0 0 +-0.2510 -0.3516 0.6090 0 0 +-0.3514 -0.3514 0.6086 0 0 +-0.3194 -0.3194 0.5533 0 0 + + +-0.3514 -0.3514 0.6086 0 0 +-0.2510 -0.3516 0.6090 0 0 +-0.2738 -0.3835 0.6642 0 0 +-0.3833 -0.3833 0.6639 0 0 +-0.3514 -0.3514 0.6086 0 0 + + +-0.3833 -0.3833 0.6639 0 0 +-0.2738 -0.3835 0.6642 0 0 +-0.2965 -0.4148 0.7185 0 0 +-0.4153 -0.4153 0.7193 0 0 +-0.3833 -0.3833 0.6639 0 0 + + +-0.4153 -0.4153 0.7193 0 0 +-0.2965 -0.4148 0.7185 0 0 +-0.3194 -0.4472 0.7746 0 0 +-0.4472 -0.4472 0.7746 0 0 +-0.4153 -0.4153 0.7193 0 0 + + +-0.1626 -0.2364 0.4095 0 0 +-0.0987 -0.2451 0.4245 0 0 +-0.1101 -0.2601 0.4505 0 0 +-0.1831 -0.2583 0.4473 0 0 +-0.1626 -0.2364 0.4095 0 0 + + +-0.1831 -0.2583 0.4473 0 0 +-0.1101 -0.2601 0.4505 0 0 +-0.1231 -0.2869 0.4969 0 0 +-0.2053 -0.2871 0.4974 0 0 +-0.1831 -0.2583 0.4473 0 0 + + +-0.2053 -0.2871 0.4974 0 0 +-0.1231 -0.2869 0.4969 0 0 +-0.1368 -0.3189 0.5524 0 0 +-0.2281 -0.3191 0.5527 0 0 +-0.2053 -0.2871 0.4974 0 0 + + +-0.2281 -0.3191 0.5527 0 0 +-0.1368 -0.3189 0.5524 0 0 +-0.1506 -0.3518 0.6093 0 0 +-0.2510 -0.3516 0.6090 0 0 +-0.2281 -0.3191 0.5527 0 0 + + +-0.2510 -0.3516 0.6090 0 0 +-0.1506 -0.3518 0.6093 0 0 +-0.1643 -0.3836 0.6643 0 0 +-0.2738 -0.3835 0.6642 0 0 +-0.2510 -0.3516 0.6090 0 0 + + +-0.2738 -0.3835 0.6642 0 0 +-0.1643 -0.3836 0.6643 0 0 +-0.1779 -0.4145 0.7180 0 0 +-0.2965 -0.4148 0.7185 0 0 +-0.2738 -0.3835 0.6642 0 0 + + +-0.2965 -0.4148 0.7185 0 0 +-0.1779 -0.4145 0.7180 0 0 +-0.1917 -0.4472 0.7746 0 0 +-0.3194 -0.4472 0.7746 0 0 +-0.2965 -0.4148 0.7185 0 0 + + +-0.0987 -0.2451 0.4245 0 0 +-0.0331 -0.2495 0.4321 0 0 +-0.0368 -0.2610 0.4521 0 0 +-0.1101 -0.2601 0.4505 0 0 +-0.0987 -0.2451 0.4245 0 0 + + +-0.1101 -0.2601 0.4505 0 0 +-0.0368 -0.2610 0.4521 0 0 +-0.0410 -0.2868 0.4967 0 0 +-0.1231 -0.2869 0.4969 0 0 +-0.1101 -0.2601 0.4505 0 0 + + +-0.1231 -0.2869 0.4969 0 0 +-0.0410 -0.2868 0.4967 0 0 +-0.0456 -0.3188 0.5522 0 0 +-0.1368 -0.3189 0.5524 0 0 +-0.1231 -0.2869 0.4969 0 0 + + +-0.1368 -0.3189 0.5524 0 0 +-0.0456 -0.3188 0.5522 0 0 +-0.0502 -0.3519 0.6095 0 0 +-0.1506 -0.3518 0.6093 0 0 +-0.1368 -0.3189 0.5524 0 0 + + +-0.1506 -0.3518 0.6093 0 0 +-0.0502 -0.3519 0.6095 0 0 +-0.0548 -0.3836 0.6644 0 0 +-0.1643 -0.3836 0.6643 0 0 +-0.1506 -0.3518 0.6093 0 0 + + +-0.1643 -0.3836 0.6643 0 0 +-0.0548 -0.3836 0.6644 0 0 +-0.0593 -0.4144 0.7177 0 0 +-0.1779 -0.4145 0.7180 0 0 +-0.1643 -0.3836 0.6643 0 0 + + +-0.1779 -0.4145 0.7180 0 0 +-0.0593 -0.4144 0.7177 0 0 +-0.0639 -0.4472 0.7746 0 0 +-0.1917 -0.4472 0.7746 0 0 +-0.1779 -0.4145 0.7180 0 0 + + +-0.0331 -0.2495 0.4321 0 0 +0.0331 -0.2495 0.4321 0 0 +0.0368 -0.2610 0.4521 0 0 +-0.0368 -0.2610 0.4521 0 0 +-0.0331 -0.2495 0.4321 0 0 + + +-0.0368 -0.2610 0.4521 0 0 +0.0368 -0.2610 0.4521 0 0 +0.0410 -0.2868 0.4967 0 0 +-0.0410 -0.2868 0.4967 0 0 +-0.0368 -0.2610 0.4521 0 0 + + +-0.0410 -0.2868 0.4967 0 0 +0.0410 -0.2868 0.4967 0 0 +0.0456 -0.3188 0.5522 0 0 +-0.0456 -0.3188 0.5522 0 0 +-0.0410 -0.2868 0.4967 0 0 + + +-0.0456 -0.3188 0.5522 0 0 +0.0456 -0.3188 0.5522 0 0 +0.0502 -0.3519 0.6095 0 0 +-0.0502 -0.3519 0.6095 0 0 +-0.0456 -0.3188 0.5522 0 0 + + +-0.0502 -0.3519 0.6095 0 0 +0.0502 -0.3519 0.6095 0 0 +0.0548 -0.3836 0.6644 0 0 +-0.0548 -0.3836 0.6644 0 0 +-0.0502 -0.3519 0.6095 0 0 + + +-0.0548 -0.3836 0.6644 0 0 +0.0548 -0.3836 0.6644 0 0 +0.0593 -0.4144 0.7177 0 0 +-0.0593 -0.4144 0.7177 0 0 +-0.0548 -0.3836 0.6644 0 0 + + +-0.0593 -0.4144 0.7177 0 0 +0.0593 -0.4144 0.7177 0 0 +0.0639 -0.4472 0.7746 0 0 +-0.0639 -0.4472 0.7746 0 0 +-0.0593 -0.4144 0.7177 0 0 + + +0.0331 -0.2495 0.4321 0 0 +0.0987 -0.2451 0.4245 0 0 +0.1101 -0.2601 0.4505 0 0 +0.0368 -0.2610 0.4521 0 0 +0.0331 -0.2495 0.4321 0 0 + + +0.0368 -0.2610 0.4521 0 0 +0.1101 -0.2601 0.4505 0 0 +0.1231 -0.2869 0.4969 0 0 +0.0410 -0.2868 0.4967 0 0 +0.0368 -0.2610 0.4521 0 0 + + +0.0410 -0.2868 0.4967 0 0 +0.1231 -0.2869 0.4969 0 0 +0.1368 -0.3189 0.5524 0 0 +0.0456 -0.3188 0.5522 0 0 +0.0410 -0.2868 0.4967 0 0 + + +0.0456 -0.3188 0.5522 0 0 +0.1368 -0.3189 0.5524 0 0 +0.1506 -0.3518 0.6093 0 0 +0.0502 -0.3519 0.6095 0 0 +0.0456 -0.3188 0.5522 0 0 + + +0.0502 -0.3519 0.6095 0 0 +0.1506 -0.3518 0.6093 0 0 +0.1643 -0.3836 0.6643 0 0 +0.0548 -0.3836 0.6644 0 0 +0.0502 -0.3519 0.6095 0 0 + + +0.0548 -0.3836 0.6644 0 0 +0.1643 -0.3836 0.6643 0 0 +0.1779 -0.4145 0.7180 0 0 +0.0593 -0.4144 0.7177 0 0 +0.0548 -0.3836 0.6644 0 0 + + +0.0593 -0.4144 0.7177 0 0 +0.1779 -0.4145 0.7180 0 0 +0.1917 -0.4472 0.7746 0 0 +0.0639 -0.4472 0.7746 0 0 +0.0593 -0.4144 0.7177 0 0 + + +0.0987 -0.2451 0.4245 0 0 +0.1626 -0.2364 0.4095 0 0 +0.1831 -0.2583 0.4473 0 0 +0.1101 -0.2601 0.4505 0 0 +0.0987 -0.2451 0.4245 0 0 + + +0.1101 -0.2601 0.4505 0 0 +0.1831 -0.2583 0.4473 0 0 +0.2053 -0.2871 0.4974 0 0 +0.1231 -0.2869 0.4969 0 0 +0.1101 -0.2601 0.4505 0 0 + + +0.1231 -0.2869 0.4969 0 0 +0.2053 -0.2871 0.4974 0 0 +0.2281 -0.3191 0.5527 0 0 +0.1368 -0.3189 0.5524 0 0 +0.1231 -0.2869 0.4969 0 0 + + +0.1368 -0.3189 0.5524 0 0 +0.2281 -0.3191 0.5527 0 0 +0.2510 -0.3516 0.6090 0 0 +0.1506 -0.3518 0.6093 0 0 +0.1368 -0.3189 0.5524 0 0 + + +0.1506 -0.3518 0.6093 0 0 +0.2510 -0.3516 0.6090 0 0 +0.2738 -0.3835 0.6642 0 0 +0.1643 -0.3836 0.6643 0 0 +0.1506 -0.3518 0.6093 0 0 + + +0.1643 -0.3836 0.6643 0 0 +0.2738 -0.3835 0.6642 0 0 +0.2965 -0.4148 0.7185 0 0 +0.1779 -0.4145 0.7180 0 0 +0.1643 -0.3836 0.6643 0 0 + + +0.1779 -0.4145 0.7180 0 0 +0.2965 -0.4148 0.7185 0 0 +0.3194 -0.4472 0.7746 0 0 +0.1917 -0.4472 0.7746 0 0 +0.1779 -0.4145 0.7180 0 0 + + +0.1626 -0.2364 0.4095 0 0 +0.2236 -0.2236 0.3873 0 0 +0.2556 -0.2556 0.4426 0 0 +0.1831 -0.2583 0.4473 0 0 +0.1626 -0.2364 0.4095 0 0 + + +0.1831 -0.2583 0.4473 0 0 +0.2556 -0.2556 0.4426 0 0 +0.2875 -0.2875 0.4980 0 0 +0.2053 -0.2871 0.4974 0 0 +0.1831 -0.2583 0.4473 0 0 + + +0.2053 -0.2871 0.4974 0 0 +0.2875 -0.2875 0.4980 0 0 +0.3194 -0.3194 0.5533 0 0 +0.2281 -0.3191 0.5527 0 0 +0.2053 -0.2871 0.4974 0 0 + + +0.2281 -0.3191 0.5527 0 0 +0.3194 -0.3194 0.5533 0 0 +0.3514 -0.3514 0.6086 0 0 +0.2510 -0.3516 0.6090 0 0 +0.2281 -0.3191 0.5527 0 0 + + +0.2510 -0.3516 0.6090 0 0 +0.3514 -0.3514 0.6086 0 0 +0.3833 -0.3833 0.6639 0 0 +0.2738 -0.3835 0.6642 0 0 +0.2510 -0.3516 0.6090 0 0 + + +0.2738 -0.3835 0.6642 0 0 +0.3833 -0.3833 0.6639 0 0 +0.4153 -0.4153 0.7193 0 0 +0.2965 -0.4148 0.7185 0 0 +0.2738 -0.3835 0.6642 0 0 + + +0.2965 -0.4148 0.7185 0 0 +0.4153 -0.4153 0.7193 0 0 +0.4472 -0.4472 0.7746 0 0 +0.3194 -0.4472 0.7746 0 0 +0.2965 -0.4148 0.7185 0 0 + + +-0.2236 0.2236 0.3873 0 0 +-0.1626 0.2364 0.4095 0 0 +-0.1831 0.2583 0.4473 0 0 +-0.2556 0.2556 0.4426 0 0 +-0.2236 0.2236 0.3873 0 0 + + +-0.2556 0.2556 0.4426 0 0 +-0.1831 0.2583 0.4473 0 0 +-0.2053 0.2871 0.4974 0 0 +-0.2875 0.2875 0.4980 0 0 +-0.2556 0.2556 0.4426 0 0 + + +-0.2875 0.2875 0.4980 0 0 +-0.2053 0.2871 0.4974 0 0 +-0.2281 0.3191 0.5527 0 0 +-0.3194 0.3194 0.5533 0 0 +-0.2875 0.2875 0.4980 0 0 + + +-0.3194 0.3194 0.5533 0 0 +-0.2281 0.3191 0.5527 0 0 +-0.2510 0.3516 0.6090 0 0 +-0.3514 0.3514 0.6086 0 0 +-0.3194 0.3194 0.5533 0 0 + + +-0.3514 0.3514 0.6086 0 0 +-0.2510 0.3516 0.6090 0 0 +-0.2738 0.3835 0.6642 0 0 +-0.3833 0.3833 0.6639 0 0 +-0.3514 0.3514 0.6086 0 0 + + +-0.3833 0.3833 0.6639 0 0 +-0.2738 0.3835 0.6642 0 0 +-0.2965 0.4148 0.7185 0 0 +-0.4153 0.4153 0.7193 0 0 +-0.3833 0.3833 0.6639 0 0 + + +-0.4153 0.4153 0.7193 0 0 +-0.2965 0.4148 0.7185 0 0 +-0.3194 0.4472 0.7746 0 0 +-0.4472 0.4472 0.7746 0 0 +-0.4153 0.4153 0.7193 0 0 + + +-0.1626 0.2364 0.4095 0 0 +-0.0987 0.2451 0.4245 0 0 +-0.1101 0.2601 0.4505 0 0 +-0.1831 0.2583 0.4473 0 0 +-0.1626 0.2364 0.4095 0 0 + + +-0.1831 0.2583 0.4473 0 0 +-0.1101 0.2601 0.4505 0 0 +-0.1231 0.2869 0.4969 0 0 +-0.2053 0.2871 0.4974 0 0 +-0.1831 0.2583 0.4473 0 0 + + +-0.2053 0.2871 0.4974 0 0 +-0.1231 0.2869 0.4969 0 0 +-0.1368 0.3189 0.5524 0 0 +-0.2281 0.3191 0.5527 0 0 +-0.2053 0.2871 0.4974 0 0 + + +-0.2281 0.3191 0.5527 0 0 +-0.1368 0.3189 0.5524 0 0 +-0.1506 0.3518 0.6093 0 0 +-0.2510 0.3516 0.6090 0 0 +-0.2281 0.3191 0.5527 0 0 + + +-0.2510 0.3516 0.6090 0 0 +-0.1506 0.3518 0.6093 0 0 +-0.1643 0.3836 0.6643 0 0 +-0.2738 0.3835 0.6642 0 0 +-0.2510 0.3516 0.6090 0 0 + + +-0.2738 0.3835 0.6642 0 0 +-0.1643 0.3836 0.6643 0 0 +-0.1779 0.4145 0.7180 0 0 +-0.2965 0.4148 0.7185 0 0 +-0.2738 0.3835 0.6642 0 0 + + +-0.2965 0.4148 0.7185 0 0 +-0.1779 0.4145 0.7180 0 0 +-0.1917 0.4472 0.7746 0 0 +-0.3194 0.4472 0.7746 0 0 +-0.2965 0.4148 0.7185 0 0 + + +-0.0987 0.2451 0.4245 0 0 +-0.0331 0.2495 0.4321 0 0 +-0.0368 0.2610 0.4521 0 0 +-0.1101 0.2601 0.4505 0 0 +-0.0987 0.2451 0.4245 0 0 + + +-0.1101 0.2601 0.4505 0 0 +-0.0368 0.2610 0.4521 0 0 +-0.0410 0.2868 0.4967 0 0 +-0.1231 0.2869 0.4969 0 0 +-0.1101 0.2601 0.4505 0 0 + + +-0.1231 0.2869 0.4969 0 0 +-0.0410 0.2868 0.4967 0 0 +-0.0456 0.3188 0.5522 0 0 +-0.1368 0.3189 0.5524 0 0 +-0.1231 0.2869 0.4969 0 0 + + +-0.1368 0.3189 0.5524 0 0 +-0.0456 0.3188 0.5522 0 0 +-0.0502 0.3519 0.6095 0 0 +-0.1506 0.3518 0.6093 0 0 +-0.1368 0.3189 0.5524 0 0 + + +-0.1506 0.3518 0.6093 0 0 +-0.0502 0.3519 0.6095 0 0 +-0.0548 0.3836 0.6644 0 0 +-0.1643 0.3836 0.6643 0 0 +-0.1506 0.3518 0.6093 0 0 + + +-0.1643 0.3836 0.6643 0 0 +-0.0548 0.3836 0.6644 0 0 +-0.0593 0.4144 0.7177 0 0 +-0.1779 0.4145 0.7180 0 0 +-0.1643 0.3836 0.6643 0 0 + + +-0.1779 0.4145 0.7180 0 0 +-0.0593 0.4144 0.7177 0 0 +-0.0639 0.4472 0.7746 0 0 +-0.1917 0.4472 0.7746 0 0 +-0.1779 0.4145 0.7180 0 0 + + +-0.0331 0.2495 0.4321 0 0 +0.0331 0.2495 0.4321 0 0 +0.0368 0.2610 0.4521 0 0 +-0.0368 0.2610 0.4521 0 0 +-0.0331 0.2495 0.4321 0 0 + + +-0.0368 0.2610 0.4521 0 0 +0.0368 0.2610 0.4521 0 0 +0.0410 0.2868 0.4967 0 0 +-0.0410 0.2868 0.4967 0 0 +-0.0368 0.2610 0.4521 0 0 + + +-0.0410 0.2868 0.4967 0 0 +0.0410 0.2868 0.4967 0 0 +0.0456 0.3188 0.5522 0 0 +-0.0456 0.3188 0.5522 0 0 +-0.0410 0.2868 0.4967 0 0 + + +-0.0456 0.3188 0.5522 0 0 +0.0456 0.3188 0.5522 0 0 +0.0502 0.3519 0.6095 0 0 +-0.0502 0.3519 0.6095 0 0 +-0.0456 0.3188 0.5522 0 0 + + +-0.0502 0.3519 0.6095 0 0 +0.0502 0.3519 0.6095 0 0 +0.0548 0.3836 0.6644 0 0 +-0.0548 0.3836 0.6644 0 0 +-0.0502 0.3519 0.6095 0 0 + + +-0.0548 0.3836 0.6644 0 0 +0.0548 0.3836 0.6644 0 0 +0.0593 0.4144 0.7177 0 0 +-0.0593 0.4144 0.7177 0 0 +-0.0548 0.3836 0.6644 0 0 + + +-0.0593 0.4144 0.7177 0 0 +0.0593 0.4144 0.7177 0 0 +0.0639 0.4472 0.7746 0 0 +-0.0639 0.4472 0.7746 0 0 +-0.0593 0.4144 0.7177 0 0 + + +0.0331 0.2495 0.4321 0 0 +0.0987 0.2451 0.4245 0 0 +0.1101 0.2601 0.4505 0 0 +0.0368 0.2610 0.4521 0 0 +0.0331 0.2495 0.4321 0 0 + + +0.0368 0.2610 0.4521 0 0 +0.1101 0.2601 0.4505 0 0 +0.1231 0.2869 0.4969 0 0 +0.0410 0.2868 0.4967 0 0 +0.0368 0.2610 0.4521 0 0 + + +0.0410 0.2868 0.4967 0 0 +0.1231 0.2869 0.4969 0 0 +0.1368 0.3189 0.5524 0 0 +0.0456 0.3188 0.5522 0 0 +0.0410 0.2868 0.4967 0 0 + + +0.0456 0.3188 0.5522 0 0 +0.1368 0.3189 0.5524 0 0 +0.1506 0.3518 0.6093 0 0 +0.0502 0.3519 0.6095 0 0 +0.0456 0.3188 0.5522 0 0 + + +0.0502 0.3519 0.6095 0 0 +0.1506 0.3518 0.6093 0 0 +0.1643 0.3836 0.6643 0 0 +0.0548 0.3836 0.6644 0 0 +0.0502 0.3519 0.6095 0 0 + + +0.0548 0.3836 0.6644 0 0 +0.1643 0.3836 0.6643 0 0 +0.1779 0.4145 0.7180 0 0 +0.0593 0.4144 0.7177 0 0 +0.0548 0.3836 0.6644 0 0 + + +0.0593 0.4144 0.7177 0 0 +0.1779 0.4145 0.7180 0 0 +0.1917 0.4472 0.7746 0 0 +0.0639 0.4472 0.7746 0 0 +0.0593 0.4144 0.7177 0 0 + + +0.0987 0.2451 0.4245 0 0 +0.1626 0.2364 0.4095 0 0 +0.1831 0.2583 0.4473 0 0 +0.1101 0.2601 0.4505 0 0 +0.0987 0.2451 0.4245 0 0 + + +0.1101 0.2601 0.4505 0 0 +0.1831 0.2583 0.4473 0 0 +0.2053 0.2871 0.4974 0 0 +0.1231 0.2869 0.4969 0 0 +0.1101 0.2601 0.4505 0 0 + + +0.1231 0.2869 0.4969 0 0 +0.2053 0.2871 0.4974 0 0 +0.2281 0.3191 0.5527 0 0 +0.1368 0.3189 0.5524 0 0 +0.1231 0.2869 0.4969 0 0 + + +0.1368 0.3189 0.5524 0 0 +0.2281 0.3191 0.5527 0 0 +0.2510 0.3516 0.6090 0 0 +0.1506 0.3518 0.6093 0 0 +0.1368 0.3189 0.5524 0 0 + + +0.1506 0.3518 0.6093 0 0 +0.2510 0.3516 0.6090 0 0 +0.2738 0.3835 0.6642 0 0 +0.1643 0.3836 0.6643 0 0 +0.1506 0.3518 0.6093 0 0 + + +0.1643 0.3836 0.6643 0 0 +0.2738 0.3835 0.6642 0 0 +0.2965 0.4148 0.7185 0 0 +0.1779 0.4145 0.7180 0 0 +0.1643 0.3836 0.6643 0 0 + + +0.1779 0.4145 0.7180 0 0 +0.2965 0.4148 0.7185 0 0 +0.3194 0.4472 0.7746 0 0 +0.1917 0.4472 0.7746 0 0 +0.1779 0.4145 0.7180 0 0 + + +0.1626 0.2364 0.4095 0 0 +0.2236 0.2236 0.3873 0 0 +0.2556 0.2556 0.4426 0 0 +0.1831 0.2583 0.4473 0 0 +0.1626 0.2364 0.4095 0 0 + + +0.1831 0.2583 0.4473 0 0 +0.2556 0.2556 0.4426 0 0 +0.2875 0.2875 0.4980 0 0 +0.2053 0.2871 0.4974 0 0 +0.1831 0.2583 0.4473 0 0 + + +0.2053 0.2871 0.4974 0 0 +0.2875 0.2875 0.4980 0 0 +0.3194 0.3194 0.5533 0 0 +0.2281 0.3191 0.5527 0 0 +0.2053 0.2871 0.4974 0 0 + + +0.2281 0.3191 0.5527 0 0 +0.3194 0.3194 0.5533 0 0 +0.3514 0.3514 0.6086 0 0 +0.2510 0.3516 0.6090 0 0 +0.2281 0.3191 0.5527 0 0 + + +0.2510 0.3516 0.6090 0 0 +0.3514 0.3514 0.6086 0 0 +0.3833 0.3833 0.6639 0 0 +0.2738 0.3835 0.6642 0 0 +0.2510 0.3516 0.6090 0 0 + + +0.2738 0.3835 0.6642 0 0 +0.3833 0.3833 0.6639 0 0 +0.4153 0.4153 0.7193 0 0 +0.2965 0.4148 0.7185 0 0 +0.2738 0.3835 0.6642 0 0 + + +0.2965 0.4148 0.7185 0 0 +0.4153 0.4153 0.7193 0 0 +0.4472 0.4472 0.7746 0 0 +0.3194 0.4472 0.7746 0 0 +0.2965 0.4148 0.7185 0 0 + + +-0.2236 -0.2236 0.3873 0 0 +-0.2364 -0.1626 0.4095 0 0 +-0.1723 -0.1733 0.4362 0 0 +-0.1626 -0.2364 0.4095 0 0 +-0.2236 -0.2236 0.3873 0 0 + + +-0.1626 -0.2364 0.4095 0 0 +-0.1723 -0.1733 0.4362 0 0 +-0.1047 -0.1805 0.4544 0 0 +-0.0987 -0.2451 0.4245 0 0 +-0.1626 -0.2364 0.4095 0 0 + + +-0.0987 -0.2451 0.4245 0 0 +-0.1047 -0.1805 0.4544 0 0 +-0.0351 -0.1842 0.4635 0 0 +-0.0331 -0.2495 0.4321 0 0 +-0.0987 -0.2451 0.4245 0 0 + + +-0.0331 -0.2495 0.4321 0 0 +-0.0351 -0.1842 0.4635 0 0 +0.0351 -0.1842 0.4635 0 0 +0.0331 -0.2495 0.4321 0 0 +-0.0331 -0.2495 0.4321 0 0 + + +0.0331 -0.2495 0.4321 0 0 +0.0351 -0.1842 0.4635 0 0 +0.1047 -0.1805 0.4544 0 0 +0.0987 -0.2451 0.4245 0 0 +0.0331 -0.2495 0.4321 0 0 + + +0.0987 -0.2451 0.4245 0 0 +0.1047 -0.1805 0.4544 0 0 +0.1723 -0.1733 0.4362 0 0 +0.1626 -0.2364 0.4095 0 0 +0.0987 -0.2451 0.4245 0 0 + + +0.1626 -0.2364 0.4095 0 0 +0.1723 -0.1733 0.4362 0 0 +0.2364 -0.1626 0.4095 0 0 +0.2236 -0.2236 0.3873 0 0 +0.1626 -0.2364 0.4095 0 0 + + +-0.2364 -0.1626 0.4095 0 0 +-0.2451 -0.0987 0.4245 0 0 +-0.1789 -0.1057 0.4548 0 0 +-0.1723 -0.1733 0.4362 0 0 +-0.2364 -0.1626 0.4095 0 0 + + +-0.1723 -0.1733 0.4362 0 0 +-0.1789 -0.1057 0.4548 0 0 +-0.1089 -0.1105 0.4753 0 0 +-0.1047 -0.1805 0.4544 0 0 +-0.1723 -0.1733 0.4362 0 0 + + +-0.1047 -0.1805 0.4544 0 0 +-0.1089 -0.1105 0.4753 0 0 +-0.0366 -0.1129 0.4857 0 0 +-0.0351 -0.1842 0.4635 0 0 +-0.1047 -0.1805 0.4544 0 0 + + +-0.0351 -0.1842 0.4635 0 0 +-0.0366 -0.1129 0.4857 0 0 +0.0366 -0.1129 0.4857 0 0 +0.0351 -0.1842 0.4635 0 0 +-0.0351 -0.1842 0.4635 0 0 + + +0.0351 -0.1842 0.4635 0 0 +0.0366 -0.1129 0.4857 0 0 +0.1089 -0.1105 0.4753 0 0 +0.1047 -0.1805 0.4544 0 0 +0.0351 -0.1842 0.4635 0 0 + + +0.1047 -0.1805 0.4544 0 0 +0.1089 -0.1105 0.4753 0 0 +0.1789 -0.1057 0.4548 0 0 +0.1723 -0.1733 0.4362 0 0 +0.1047 -0.1805 0.4544 0 0 + + +0.1723 -0.1733 0.4362 0 0 +0.1789 -0.1057 0.4548 0 0 +0.2451 -0.0987 0.4245 0 0 +0.2364 -0.1626 0.4095 0 0 +0.1723 -0.1733 0.4362 0 0 + + +-0.2451 -0.0987 0.4245 0 0 +-0.2495 -0.0331 0.4321 0 0 +-0.1823 -0.0355 0.4642 0 0 +-0.1789 -0.1057 0.4548 0 0 +-0.2451 -0.0987 0.4245 0 0 + + +-0.1789 -0.1057 0.4548 0 0 +-0.1823 -0.0355 0.4642 0 0 +-0.1110 -0.0372 0.4861 0 0 +-0.1089 -0.1105 0.4753 0 0 +-0.1789 -0.1057 0.4548 0 0 + + +-0.1089 -0.1105 0.4753 0 0 +-0.1110 -0.0372 0.4861 0 0 +-0.0373 -0.0380 0.4972 0 0 +-0.0366 -0.1129 0.4857 0 0 +-0.1089 -0.1105 0.4753 0 0 + + +-0.0366 -0.1129 0.4857 0 0 +-0.0373 -0.0380 0.4972 0 0 +0.0373 -0.0380 0.4972 0 0 +0.0366 -0.1129 0.4857 0 0 +-0.0366 -0.1129 0.4857 0 0 + + +0.0366 -0.1129 0.4857 0 0 +0.0373 -0.0380 0.4972 0 0 +0.1110 -0.0372 0.4861 0 0 +0.1089 -0.1105 0.4753 0 0 +0.0366 -0.1129 0.4857 0 0 + + +0.1089 -0.1105 0.4753 0 0 +0.1110 -0.0372 0.4861 0 0 +0.1823 -0.0355 0.4642 0 0 +0.1789 -0.1057 0.4548 0 0 +0.1089 -0.1105 0.4753 0 0 + + +0.1789 -0.1057 0.4548 0 0 +0.1823 -0.0355 0.4642 0 0 +0.2495 -0.0331 0.4321 0 0 +0.2451 -0.0987 0.4245 0 0 +0.1789 -0.1057 0.4548 0 0 + + +-0.2495 -0.0331 0.4321 0 0 +-0.2495 0.0331 0.4321 0 0 +-0.1823 0.0355 0.4642 0 0 +-0.1823 -0.0355 0.4642 0 0 +-0.2495 -0.0331 0.4321 0 0 + + +-0.1823 -0.0355 0.4642 0 0 +-0.1823 0.0355 0.4642 0 0 +-0.1110 0.0372 0.4861 0 0 +-0.1110 -0.0372 0.4861 0 0 +-0.1823 -0.0355 0.4642 0 0 + + +-0.1110 -0.0372 0.4861 0 0 +-0.1110 0.0372 0.4861 0 0 +-0.0373 0.0380 0.4972 0 0 +-0.0373 -0.0380 0.4972 0 0 +-0.1110 -0.0372 0.4861 0 0 + + +-0.0373 -0.0380 0.4972 0 0 +-0.0373 0.0380 0.4972 0 0 +0.0373 0.0380 0.4972 0 0 +0.0373 -0.0380 0.4972 0 0 +-0.0373 -0.0380 0.4972 0 0 + + +0.0373 -0.0380 0.4972 0 0 +0.0373 0.0380 0.4972 0 0 +0.1110 0.0372 0.4861 0 0 +0.1110 -0.0372 0.4861 0 0 +0.0373 -0.0380 0.4972 0 0 + + +0.1110 -0.0372 0.4861 0 0 +0.1110 0.0372 0.4861 0 0 +0.1823 0.0355 0.4642 0 0 +0.1823 -0.0355 0.4642 0 0 +0.1110 -0.0372 0.4861 0 0 + + +0.1823 -0.0355 0.4642 0 0 +0.1823 0.0355 0.4642 0 0 +0.2495 0.0331 0.4321 0 0 +0.2495 -0.0331 0.4321 0 0 +0.1823 -0.0355 0.4642 0 0 + + +-0.2495 0.0331 0.4321 0 0 +-0.2451 0.0987 0.4245 0 0 +-0.1789 0.1057 0.4548 0 0 +-0.1823 0.0355 0.4642 0 0 +-0.2495 0.0331 0.4321 0 0 + + +-0.1823 0.0355 0.4642 0 0 +-0.1789 0.1057 0.4548 0 0 +-0.1089 0.1105 0.4753 0 0 +-0.1110 0.0372 0.4861 0 0 +-0.1823 0.0355 0.4642 0 0 + + +-0.1110 0.0372 0.4861 0 0 +-0.1089 0.1105 0.4753 0 0 +-0.0366 0.1129 0.4857 0 0 +-0.0373 0.0380 0.4972 0 0 +-0.1110 0.0372 0.4861 0 0 + + +-0.0373 0.0380 0.4972 0 0 +-0.0366 0.1129 0.4857 0 0 +0.0366 0.1129 0.4857 0 0 +0.0373 0.0380 0.4972 0 0 +-0.0373 0.0380 0.4972 0 0 + + +0.0373 0.0380 0.4972 0 0 +0.0366 0.1129 0.4857 0 0 +0.1089 0.1105 0.4753 0 0 +0.1110 0.0372 0.4861 0 0 +0.0373 0.0380 0.4972 0 0 + + +0.1110 0.0372 0.4861 0 0 +0.1089 0.1105 0.4753 0 0 +0.1789 0.1057 0.4548 0 0 +0.1823 0.0355 0.4642 0 0 +0.1110 0.0372 0.4861 0 0 + + +0.1823 0.0355 0.4642 0 0 +0.1789 0.1057 0.4548 0 0 +0.2451 0.0987 0.4245 0 0 +0.2495 0.0331 0.4321 0 0 +0.1823 0.0355 0.4642 0 0 + + +-0.2451 0.0987 0.4245 0 0 +-0.2364 0.1626 0.4095 0 0 +-0.1723 0.1733 0.4362 0 0 +-0.1789 0.1057 0.4548 0 0 +-0.2451 0.0987 0.4245 0 0 + + +-0.1789 0.1057 0.4548 0 0 +-0.1723 0.1733 0.4362 0 0 +-0.1047 0.1805 0.4544 0 0 +-0.1089 0.1105 0.4753 0 0 +-0.1789 0.1057 0.4548 0 0 + + +-0.1089 0.1105 0.4753 0 0 +-0.1047 0.1805 0.4544 0 0 +-0.0351 0.1842 0.4635 0 0 +-0.0366 0.1129 0.4857 0 0 +-0.1089 0.1105 0.4753 0 0 + + +-0.0366 0.1129 0.4857 0 0 +-0.0351 0.1842 0.4635 0 0 +0.0351 0.1842 0.4635 0 0 +0.0366 0.1129 0.4857 0 0 +-0.0366 0.1129 0.4857 0 0 + + +0.0366 0.1129 0.4857 0 0 +0.0351 0.1842 0.4635 0 0 +0.1047 0.1805 0.4544 0 0 +0.1089 0.1105 0.4753 0 0 +0.0366 0.1129 0.4857 0 0 + + +0.1089 0.1105 0.4753 0 0 +0.1047 0.1805 0.4544 0 0 +0.1723 0.1733 0.4362 0 0 +0.1789 0.1057 0.4548 0 0 +0.1089 0.1105 0.4753 0 0 + + +0.1789 0.1057 0.4548 0 0 +0.1723 0.1733 0.4362 0 0 +0.2364 0.1626 0.4095 0 0 +0.2451 0.0987 0.4245 0 0 +0.1789 0.1057 0.4548 0 0 + + +-0.2364 0.1626 0.4095 0 0 +-0.2236 0.2236 0.3873 0 0 +-0.1626 0.2364 0.4095 0 0 +-0.1723 0.1733 0.4362 0 0 +-0.2364 0.1626 0.4095 0 0 + + +-0.1723 0.1733 0.4362 0 0 +-0.1626 0.2364 0.4095 0 0 +-0.0987 0.2451 0.4245 0 0 +-0.1047 0.1805 0.4544 0 0 +-0.1723 0.1733 0.4362 0 0 + + +-0.1047 0.1805 0.4544 0 0 +-0.0987 0.2451 0.4245 0 0 +-0.0331 0.2495 0.4321 0 0 +-0.0351 0.1842 0.4635 0 0 +-0.1047 0.1805 0.4544 0 0 + + +-0.0351 0.1842 0.4635 0 0 +-0.0331 0.2495 0.4321 0 0 +0.0331 0.2495 0.4321 0 0 +0.0351 0.1842 0.4635 0 0 +-0.0351 0.1842 0.4635 0 0 + + +0.0351 0.1842 0.4635 0 0 +0.0331 0.2495 0.4321 0 0 +0.0987 0.2451 0.4245 0 0 +0.1047 0.1805 0.4544 0 0 +0.0351 0.1842 0.4635 0 0 + + +0.1047 0.1805 0.4544 0 0 +0.0987 0.2451 0.4245 0 0 +0.1626 0.2364 0.4095 0 0 +0.1723 0.1733 0.4362 0 0 +0.1047 0.1805 0.4544 0 0 + + +0.1723 0.1733 0.4362 0 0 +0.1626 0.2364 0.4095 0 0 +0.2236 0.2236 0.3873 0 0 +0.2364 0.1626 0.4095 0 0 +0.1723 0.1733 0.4362 0 0 + + +-0.4472 -0.4472 0.7746 0 0 +-0.4472 -0.3194 0.7746 0 0 +-0.3194 -0.3194 0.7746 0 0 +-0.3194 -0.4472 0.7746 0 0 +-0.4472 -0.4472 0.7746 0 0 + + +-0.3194 -0.4472 0.7746 0 0 +-0.3194 -0.3194 0.7746 0 0 +-0.1917 -0.3194 0.7746 0 0 +-0.1917 -0.4472 0.7746 0 0 +-0.3194 -0.4472 0.7746 0 0 + + +-0.1917 -0.4472 0.7746 0 0 +-0.1917 -0.3194 0.7746 0 0 +-0.0639 -0.3194 0.7746 0 0 +-0.0639 -0.4472 0.7746 0 0 +-0.1917 -0.4472 0.7746 0 0 + + +-0.0639 -0.4472 0.7746 0 0 +-0.0639 -0.3194 0.7746 0 0 +0.0639 -0.3194 0.7746 0 0 +0.0639 -0.4472 0.7746 0 0 +-0.0639 -0.4472 0.7746 0 0 + + +0.0639 -0.4472 0.7746 0 0 +0.0639 -0.3194 0.7746 0 0 +0.1917 -0.3194 0.7746 0 0 +0.1917 -0.4472 0.7746 0 0 +0.0639 -0.4472 0.7746 0 0 + + +0.1917 -0.4472 0.7746 0 0 +0.1917 -0.3194 0.7746 0 0 +0.3194 -0.3194 0.7746 0 0 +0.3194 -0.4472 0.7746 0 0 +0.1917 -0.4472 0.7746 0 0 + + +0.3194 -0.4472 0.7746 0 0 +0.3194 -0.3194 0.7746 0 0 +0.4472 -0.3194 0.7746 0 0 +0.4472 -0.4472 0.7746 0 0 +0.3194 -0.4472 0.7746 0 0 + + +-0.4472 -0.3194 0.7746 0 0 +-0.4472 -0.1917 0.7746 0 0 +-0.3194 -0.1917 0.7746 0 0 +-0.3194 -0.3194 0.7746 0 0 +-0.4472 -0.3194 0.7746 0 0 + + +-0.3194 -0.3194 0.7746 0 0 +-0.3194 -0.1917 0.7746 0 0 +-0.1917 -0.1917 0.7746 0 0 +-0.1917 -0.3194 0.7746 0 0 +-0.3194 -0.3194 0.7746 0 0 + + +-0.1917 -0.3194 0.7746 0 0 +-0.1917 -0.1917 0.7746 0 0 +-0.0639 -0.1917 0.7746 0 0 +-0.0639 -0.3194 0.7746 0 0 +-0.1917 -0.3194 0.7746 0 0 + + +-0.0639 -0.3194 0.7746 0 0 +-0.0639 -0.1917 0.7746 0 0 +0.0639 -0.1917 0.7746 0 0 +0.0639 -0.3194 0.7746 0 0 +-0.0639 -0.3194 0.7746 0 0 + + +0.0639 -0.3194 0.7746 0 0 +0.0639 -0.1917 0.7746 0 0 +0.1917 -0.1917 0.7746 0 0 +0.1917 -0.3194 0.7746 0 0 +0.0639 -0.3194 0.7746 0 0 + + +0.1917 -0.3194 0.7746 0 0 +0.1917 -0.1917 0.7746 0 0 +0.3194 -0.1917 0.7746 0 0 +0.3194 -0.3194 0.7746 0 0 +0.1917 -0.3194 0.7746 0 0 + + +0.3194 -0.3194 0.7746 0 0 +0.3194 -0.1917 0.7746 0 0 +0.4472 -0.1917 0.7746 0 0 +0.4472 -0.3194 0.7746 0 0 +0.3194 -0.3194 0.7746 0 0 + + +-0.4472 -0.1917 0.7746 0 0 +-0.4472 -0.0639 0.7746 0 0 +-0.3194 -0.0639 0.7746 0 0 +-0.3194 -0.1917 0.7746 0 0 +-0.4472 -0.1917 0.7746 0 0 + + +-0.3194 -0.1917 0.7746 0 0 +-0.3194 -0.0639 0.7746 0 0 +-0.1917 -0.0639 0.7746 0 0 +-0.1917 -0.1917 0.7746 0 0 +-0.3194 -0.1917 0.7746 0 0 + + +-0.1917 -0.1917 0.7746 0 0 +-0.1917 -0.0639 0.7746 0 0 +-0.0639 -0.0639 0.7746 0 0 +-0.0639 -0.1917 0.7746 0 0 +-0.1917 -0.1917 0.7746 0 0 + + +-0.0639 -0.1917 0.7746 0 0 +-0.0639 -0.0639 0.7746 0 0 +0.0639 -0.0639 0.7746 0 0 +0.0639 -0.1917 0.7746 0 0 +-0.0639 -0.1917 0.7746 0 0 + + +0.0639 -0.1917 0.7746 0 0 +0.0639 -0.0639 0.7746 0 0 +0.1917 -0.0639 0.7746 0 0 +0.1917 -0.1917 0.7746 0 0 +0.0639 -0.1917 0.7746 0 0 + + +0.1917 -0.1917 0.7746 0 0 +0.1917 -0.0639 0.7746 0 0 +0.3194 -0.0639 0.7746 0 0 +0.3194 -0.1917 0.7746 0 0 +0.1917 -0.1917 0.7746 0 0 + + +0.3194 -0.1917 0.7746 0 0 +0.3194 -0.0639 0.7746 0 0 +0.4472 -0.0639 0.7746 0 0 +0.4472 -0.1917 0.7746 0 0 +0.3194 -0.1917 0.7746 0 0 + + +-0.4472 -0.0639 0.7746 0 0 +-0.4472 0.0639 0.7746 0 0 +-0.3194 0.0639 0.7746 0 0 +-0.3194 -0.0639 0.7746 0 0 +-0.4472 -0.0639 0.7746 0 0 + + +-0.3194 -0.0639 0.7746 0 0 +-0.3194 0.0639 0.7746 0 0 +-0.1917 0.0639 0.7746 0 0 +-0.1917 -0.0639 0.7746 0 0 +-0.3194 -0.0639 0.7746 0 0 + + +-0.1917 -0.0639 0.7746 0 0 +-0.1917 0.0639 0.7746 0 0 +-0.0639 0.0639 0.7746 0 0 +-0.0639 -0.0639 0.7746 0 0 +-0.1917 -0.0639 0.7746 0 0 + + +-0.0639 -0.0639 0.7746 0 0 +-0.0639 0.0639 0.7746 0 0 +0.0639 0.0639 0.7746 0 0 +0.0639 -0.0639 0.7746 0 0 +-0.0639 -0.0639 0.7746 0 0 + + +0.0639 -0.0639 0.7746 0 0 +0.0639 0.0639 0.7746 0 0 +0.1917 0.0639 0.7746 0 0 +0.1917 -0.0639 0.7746 0 0 +0.0639 -0.0639 0.7746 0 0 + + +0.1917 -0.0639 0.7746 0 0 +0.1917 0.0639 0.7746 0 0 +0.3194 0.0639 0.7746 0 0 +0.3194 -0.0639 0.7746 0 0 +0.1917 -0.0639 0.7746 0 0 + + +0.3194 -0.0639 0.7746 0 0 +0.3194 0.0639 0.7746 0 0 +0.4472 0.0639 0.7746 0 0 +0.4472 -0.0639 0.7746 0 0 +0.3194 -0.0639 0.7746 0 0 + + +-0.4472 0.0639 0.7746 0 0 +-0.4472 0.1917 0.7746 0 0 +-0.3194 0.1917 0.7746 0 0 +-0.3194 0.0639 0.7746 0 0 +-0.4472 0.0639 0.7746 0 0 + + +-0.3194 0.0639 0.7746 0 0 +-0.3194 0.1917 0.7746 0 0 +-0.1917 0.1917 0.7746 0 0 +-0.1917 0.0639 0.7746 0 0 +-0.3194 0.0639 0.7746 0 0 + + +-0.1917 0.0639 0.7746 0 0 +-0.1917 0.1917 0.7746 0 0 +-0.0639 0.1917 0.7746 0 0 +-0.0639 0.0639 0.7746 0 0 +-0.1917 0.0639 0.7746 0 0 + + +-0.0639 0.0639 0.7746 0 0 +-0.0639 0.1917 0.7746 0 0 +0.0639 0.1917 0.7746 0 0 +0.0639 0.0639 0.7746 0 0 +-0.0639 0.0639 0.7746 0 0 + + +0.0639 0.0639 0.7746 0 0 +0.0639 0.1917 0.7746 0 0 +0.1917 0.1917 0.7746 0 0 +0.1917 0.0639 0.7746 0 0 +0.0639 0.0639 0.7746 0 0 + + +0.1917 0.0639 0.7746 0 0 +0.1917 0.1917 0.7746 0 0 +0.3194 0.1917 0.7746 0 0 +0.3194 0.0639 0.7746 0 0 +0.1917 0.0639 0.7746 0 0 + + +0.3194 0.0639 0.7746 0 0 +0.3194 0.1917 0.7746 0 0 +0.4472 0.1917 0.7746 0 0 +0.4472 0.0639 0.7746 0 0 +0.3194 0.0639 0.7746 0 0 + + +-0.4472 0.1917 0.7746 0 0 +-0.4472 0.3194 0.7746 0 0 +-0.3194 0.3194 0.7746 0 0 +-0.3194 0.1917 0.7746 0 0 +-0.4472 0.1917 0.7746 0 0 + + +-0.3194 0.1917 0.7746 0 0 +-0.3194 0.3194 0.7746 0 0 +-0.1917 0.3194 0.7746 0 0 +-0.1917 0.1917 0.7746 0 0 +-0.3194 0.1917 0.7746 0 0 + + +-0.1917 0.1917 0.7746 0 0 +-0.1917 0.3194 0.7746 0 0 +-0.0639 0.3194 0.7746 0 0 +-0.0639 0.1917 0.7746 0 0 +-0.1917 0.1917 0.7746 0 0 + + +-0.0639 0.1917 0.7746 0 0 +-0.0639 0.3194 0.7746 0 0 +0.0639 0.3194 0.7746 0 0 +0.0639 0.1917 0.7746 0 0 +-0.0639 0.1917 0.7746 0 0 + + +0.0639 0.1917 0.7746 0 0 +0.0639 0.3194 0.7746 0 0 +0.1917 0.3194 0.7746 0 0 +0.1917 0.1917 0.7746 0 0 +0.0639 0.1917 0.7746 0 0 + + +0.1917 0.1917 0.7746 0 0 +0.1917 0.3194 0.7746 0 0 +0.3194 0.3194 0.7746 0 0 +0.3194 0.1917 0.7746 0 0 +0.1917 0.1917 0.7746 0 0 + + +0.3194 0.1917 0.7746 0 0 +0.3194 0.3194 0.7746 0 0 +0.4472 0.3194 0.7746 0 0 +0.4472 0.1917 0.7746 0 0 +0.3194 0.1917 0.7746 0 0 + + +-0.4472 0.3194 0.7746 0 0 +-0.4472 0.4472 0.7746 0 0 +-0.3194 0.4472 0.7746 0 0 +-0.3194 0.3194 0.7746 0 0 +-0.4472 0.3194 0.7746 0 0 + + +-0.3194 0.3194 0.7746 0 0 +-0.3194 0.4472 0.7746 0 0 +-0.1917 0.4472 0.7746 0 0 +-0.1917 0.3194 0.7746 0 0 +-0.3194 0.3194 0.7746 0 0 + + +-0.1917 0.3194 0.7746 0 0 +-0.1917 0.4472 0.7746 0 0 +-0.0639 0.4472 0.7746 0 0 +-0.0639 0.3194 0.7746 0 0 +-0.1917 0.3194 0.7746 0 0 + + +-0.0639 0.3194 0.7746 0 0 +-0.0639 0.4472 0.7746 0 0 +0.0639 0.4472 0.7746 0 0 +0.0639 0.3194 0.7746 0 0 +-0.0639 0.3194 0.7746 0 0 + + +0.0639 0.3194 0.7746 0 0 +0.0639 0.4472 0.7746 0 0 +0.1917 0.4472 0.7746 0 0 +0.1917 0.3194 0.7746 0 0 +0.0639 0.3194 0.7746 0 0 + + +0.1917 0.3194 0.7746 0 0 +0.1917 0.4472 0.7746 0 0 +0.3194 0.4472 0.7746 0 0 +0.3194 0.3194 0.7746 0 0 +0.1917 0.3194 0.7746 0 0 + + +0.3194 0.3194 0.7746 0 0 +0.3194 0.4472 0.7746 0 0 +0.4472 0.4472 0.7746 0 0 +0.4472 0.3194 0.7746 0 0 +0.3194 0.3194 0.7746 0 0 + + +DEAL::Face=0, boundary_id=3 +DEAL::Face=1, boundary_id=2 +DEAL::Face=2, boundary_id=5 +DEAL::Face=3, boundary_id=4 +DEAL::Face=4, boundary_id=0 +DEAL::Face=5, boundary_id=1 + 2 0: 0.5774 + 2 1: 0.5774 + 3 4: 0.2500 + 5 4: 0.4330 + 8 6: 0.5774 + 8 7: -0.5774 + 9 10: -0.2500 + 11 10: -0.4330 + 15 17: 0.5774 + 21 23: 0.5774 +DEAL::OK