From 2458f2d0b2f875c73fc11aff2bc6301ff8fc52a2 Mon Sep 17 00:00:00 2001 From: bangerth Date: Tue, 16 Nov 2010 13:57:17 +0000 Subject: [PATCH] Add header. Minor adjustments. git-svn-id: https://svn.dealii.org/trunk@22750 0785d39b-7218-0410-832d-ea1e28bc413d --- tests/codim_one/extract_boundary_mesh_00.cc | 92 ++- tests/codim_one/extract_boundary_mesh_01.cc | 70 +- .../interpolate_boundary_values_01.cc | 72 ++ .../cmp/generic | 771 ++++++++++++++++++ 4 files changed, 936 insertions(+), 69 deletions(-) create mode 100644 tests/codim_one/interpolate_boundary_values_01.cc create mode 100644 tests/codim_one/interpolate_boundary_values_01/cmp/generic diff --git a/tests/codim_one/extract_boundary_mesh_00.cc b/tests/codim_one/extract_boundary_mesh_00.cc index 4780676c90..37ff05a0b3 100644 --- a/tests/codim_one/extract_boundary_mesh_00.cc +++ b/tests/codim_one/extract_boundary_mesh_00.cc @@ -1,11 +1,23 @@ - -/* - Code for testing the function +//---------------------------- extract_boundary_mesh_00.cc --------------------------- +// $Id: bem.cc 22693 2010-11-11 20:11:47Z kanschat $ +// Version: $Name$ +// +// Copyright (C) 2010 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. +// +//---------------------------- extract_boundary_mesh_00.cc --------------------------- + +/* + Code for testing the function GridTools::extract_boundary_mesh (...). - We test that the order of cells and the orientation + We test that the order of cells and the orientation of the vertices is consistent between the two meshes. */ - + #include "../tests.h" @@ -31,15 +43,15 @@ bool test_vertices_orientation(const Triangulation &boundary_mes typename Triangulation::face_iterator face; bool success = true; - + if (verbosity>1) - deallog << "Vol faces" << "\t" << "Surf cell" << + deallog << "Vol faces" << "\t" << "Surf cell" << "\t" << "Distance" <::vertices_per_cell; ++k) { Point diff(face->vertex(k)); @@ -60,19 +72,19 @@ bool test_vertices_orientation(const Triangulation &boundary_mes template void save_mesh(const Triangulation& tria) -{ +{ GridOut grid_out; grid_out.write_ucd (tria, deallog.get_file_stream()); } -int main () +int main () { ofstream logfile("extract_boundary_mesh_00/output"); deallog.attach(logfile); deallog.depth_console(0); - + { // Extract the whole boundary of a hyper-cube const int dim = 2; @@ -80,99 +92,99 @@ int main () map< Triangulation::cell_iterator, Triangulation::face_iterator> surface_to_volume_mapping; - + Triangulation volume_mesh; GridGenerator::hyper_cube(volume_mesh); volume_mesh.begin_active()->face(0)->set_boundary_indicator(1); volume_mesh.refine_global (1); save_mesh(volume_mesh); - + Triangulation boundary_mesh; - - - GridTools::extract_boundary_mesh (volume_mesh, boundary_mesh, + + + GridTools::extract_boundary_mesh (volume_mesh, boundary_mesh, surface_to_volume_mapping); - + if (test_vertices_orientation(boundary_mesh, surface_to_volume_mapping)) deallog << "Passed."; else deallog << "Failed."; deallog << endl; - + save_mesh(boundary_mesh); - + } { // Extract the whole boundary of a hyper-cube const int dim = 3; - + deallog << "Testing hyper_cube in dim: " << dim << "..."<< endl; map< Triangulation::cell_iterator, Triangulation::face_iterator> surface_to_volume_mapping; - + Triangulation volume_mesh; GridGenerator::hyper_cube(volume_mesh); volume_mesh.begin_active()->face(0)->set_boundary_indicator(1); volume_mesh.refine_global (1); save_mesh(volume_mesh); - + Triangulation boundary_mesh; - - - GridTools::extract_boundary_mesh (volume_mesh, boundary_mesh, + + + GridTools::extract_boundary_mesh (volume_mesh, boundary_mesh, surface_to_volume_mapping); - + if (test_vertices_orientation(boundary_mesh, surface_to_volume_mapping)) deallog << "Passed."; else deallog << "Failed."; deallog << endl; - + save_mesh(boundary_mesh); - + } { // Extract a piece of the boundary of a hyper-cube - + const int dim = 3; deallog << "Testing hyper_cube in dim: " << dim << "..."<< endl; map< Triangulation::cell_iterator, Triangulation::face_iterator> surface_to_volume_mapping; - + Triangulation volume_mesh; GridGenerator::hyper_cube(volume_mesh); volume_mesh.begin_active()->face(0)->set_boundary_indicator(1); volume_mesh.refine_global (1); save_mesh(volume_mesh); - + Triangulation boundary_mesh; set boundary_ids; boundary_ids.insert(0); - - GridTools::extract_boundary_mesh (volume_mesh, boundary_mesh, + + GridTools::extract_boundary_mesh (volume_mesh, boundary_mesh, surface_to_volume_mapping, boundary_ids); - + if (test_vertices_orientation(boundary_mesh, surface_to_volume_mapping)) deallog << "Passed."; else deallog << "Failed."; deallog << endl; - + save_mesh(boundary_mesh); - + } - - + + return 0; } diff --git a/tests/codim_one/extract_boundary_mesh_01.cc b/tests/codim_one/extract_boundary_mesh_01.cc index 6ac0867b1b..87a1b69ec0 100644 --- a/tests/codim_one/extract_boundary_mesh_01.cc +++ b/tests/codim_one/extract_boundary_mesh_01.cc @@ -1,8 +1,20 @@ +//---------------------------- extract_boundary_mesh_01.cc --------------------------- +// $Id: bem.cc 22693 2010-11-11 20:11:47Z kanschat $ +// Version: $Name$ +// +// Copyright (C) 2010 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. +// +//---------------------------- extract_boundary_mesh_01.cc --------------------------- -/* - Code for testing the function +/* + Code for testing the function GridTools::extract_boundary_mesh (...). - We test that the order of cells and the orientation + We test that the order of cells and the orientation of the vertices is consistent between the two meshes. It's faling when boundary object is attached and refinement @@ -21,29 +33,29 @@ using namespace std; template -bool test_vertices_orientation(const Triangulation &bdry_mesh, +bool test_vertices_orientation(const Triangulation &boundary_mesh, map< typename Triangulation::cell_iterator, typename Triangulation::face_iterator > &surface_to_volume_mapping, const int verbosity = 1) { typename Triangulation::active_cell_iterator - cell = bdry_mesh.begin_active(), - endc = bdry_mesh.end(); + cell = boundary_mesh.begin_active(), + endc = boundary_mesh.end(); typename Triangulation::face_iterator face; bool success = true; - + if (verbosity>1){ deallog << "The last column should be 0" <::vertices_per_cell; ++k) { Point diff(face->vertex(k)); @@ -64,25 +76,25 @@ bool test_vertices_orientation(const Triangulation &bdry_mesh, template void save_mesh(const Triangulation& tria) -{ +{ GridOut grid_out; grid_out.write_ucd (tria, deallog.get_file_stream()); } -int main () +int main () { ofstream logfile("extract_boundary_mesh_01/output"); deallog.attach(logfile); deallog.depth_console(0); - - + + { // Extract the boundary of a hyper-sphere - + const int dim = 3; deallog << "Testing hyper_cube in dim: " << dim << "..."<< endl; - + map< Triangulation::cell_iterator, Triangulation::face_iterator> surface_to_volume_mapping; @@ -90,25 +102,25 @@ int main () Triangulation volume_mesh; GridGenerator::hyper_ball(volume_mesh); volume_mesh.set_boundary (0, boundary_description); - + volume_mesh.refine_global (1); - + // save_mesh(volume_mesh); - - Triangulation bdry_mesh; - - GridTools::extract_boundary_mesh (volume_mesh, bdry_mesh, surface_to_volume_mapping); - - if (test_vertices_orientation(bdry_mesh, surface_to_volume_mapping,2)) + + Triangulation boundary_mesh; + + GridTools::extract_boundary_mesh (volume_mesh, boundary_mesh, + surface_to_volume_mapping); + + if (test_vertices_orientation(boundary_mesh, surface_to_volume_mapping,2)) deallog << "Passed."; else deallog << "Failed."; deallog << endl; - - // save_mesh(bdry_mesh); - + + save_mesh(boundary_mesh); } - + return 0; } diff --git a/tests/codim_one/interpolate_boundary_values_01.cc b/tests/codim_one/interpolate_boundary_values_01.cc new file mode 100644 index 0000000000..d65ce7d0de --- /dev/null +++ b/tests/codim_one/interpolate_boundary_values_01.cc @@ -0,0 +1,72 @@ + +//---------------------------- template.cc --------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 2005, 2008, 2010 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. +// +//---------------------------- template.cc --------------------------- + + +// test VectorTools::interpolate_boundary_values for codim=1 + +#include "../tests.h" +#include +#include +#include +#include +#include +#include +#include +#include + +#include + +std::ofstream logfile("interpolate_boundary_values_01/output"); + +template +void test(std::string filename) { + Triangulation tria; + GridIn gi; + gi.attach_triangulation (tria); + std::ifstream in (filename.c_str()); + gi.read_ucd (in); + + deallog << tria.n_active_cells() << " active cells" << std::endl; + + FE_Q fe(2); + DoFHandler dof_handler (tria); + dof_handler.distribute_dofs (fe); + + deallog << dof_handler.n_dofs() << " degrees of freedom" << std::endl; + + std::map bv; + VectorTools::interpolate_boundary_values (dof_handler, + 0, + Functions::SquareFunction(), + bv); + deallog << bv.size() << " boundary degrees of freedom" << std::endl; + + for (std::map::const_iterator i = bv.begin(); + i != bv.end(); ++i) + deallog << i->first << ' ' << i->second << std::endl; +} + + + +int main () +{ + deallog.attach(logfile); + deallog.depth_console(0); + + test<2,3>("grids/square.inp"); + test<2,3>("grids/sphere_1.inp"); + + return 0; +} + diff --git a/tests/codim_one/interpolate_boundary_values_01/cmp/generic b/tests/codim_one/interpolate_boundary_values_01/cmp/generic new file mode 100644 index 0000000000..421ee75969 --- /dev/null +++ b/tests/codim_one/interpolate_boundary_values_01/cmp/generic @@ -0,0 +1,771 @@ + +1.00000 1.00000 0.00000 0 0 +0.00000 1.00000 0.00000 0 0 +0.00000 0.00000 0.00000 0 0 +1.00000 0.00000 0.00000 0 0 +1.00000 1.00000 0.00000 0 0 + + +2.00000 1.00000 0.00000 0 0 +1.00000 1.00000 0.00000 0 0 +1.00000 0.00000 0.00000 0 0 +2.00000 0.00000 0.00000 0 0 +2.00000 1.00000 0.00000 0 0 + + +2.00000 2.00000 0.00000 0 0 +1.00000 2.00000 0.00000 0 0 +1.00000 1.00000 0.00000 0 0 +2.00000 1.00000 0.00000 0 0 +2.00000 2.00000 0.00000 0 0 + + +1.00000 2.00000 0.00000 0 0 +0.00000 2.00000 0.00000 0 0 +0.00000 1.00000 0.00000 0 0 +1.00000 1.00000 0.00000 0 0 +1.00000 2.00000 0.00000 0 0 + + +0.00178022 0.00931797 0.999955 0 1 +0.342339 0.0465385 0.938423 0 1 +0.263823 0.408120 0.873977 0 1 +-0.0499119 0.322444 0.945272 0 1 +0.00178022 0.00931797 0.999955 0 1 + + +0.00178022 0.00931797 0.999955 0 1 +-0.0499119 0.322444 0.945272 0 1 +-0.349880 0.276923 0.894929 0 1 +-0.311977 0.00745462 0.950060 0 1 +0.00178022 0.00931797 0.999955 0 1 + + +0.00679510 -0.328843 0.944360 0 1 +0.00178022 0.00931797 0.999955 0 1 +-0.311977 0.00745462 0.950060 0 1 +-0.316292 -0.298937 0.900331 0 1 +0.00679510 -0.328843 0.944360 0 1 + + +0.00679510 -0.328843 0.944360 0 1 +0.354845 -0.314540 0.880426 0 1 +0.342339 0.0465385 0.938423 0 1 +0.00178022 0.00931797 0.999955 0 1 +0.00679510 -0.328843 0.944360 0 1 + + +0.298350 -0.356878 -0.885226 0 1 +0.00385941 -0.311698 -0.950173 0 1 +0.00349231 0.00461231 -0.999983 0 1 +0.344411 -0.0231948 -0.938532 0 1 +0.298350 -0.356878 -0.885226 0 1 + + +-0.289183 -0.332580 -0.897643 0 1 +-0.342360 -0.0100870 -0.939515 0 1 +0.00349231 0.00461231 -0.999983 0 1 +0.00385941 -0.311698 -0.950173 0 1 +-0.289183 -0.332580 -0.897643 0 1 + + +-0.366349 0.350743 -0.861840 0 1 +0.00809038 0.366486 -0.930389 0 1 +0.00349231 0.00461231 -0.999983 0 1 +-0.342360 -0.0100870 -0.939515 0 1 +-0.366349 0.350743 -0.861840 0 1 + + +0.363753 0.326848 -0.872270 0 1 +0.344411 -0.0231948 -0.938532 0 1 +0.00349231 0.00461231 -0.999983 0 1 +0.00809038 0.366486 -0.930389 0 1 +0.363753 0.326848 -0.872270 0 1 + + +-0.581804 -0.238653 0.777527 0 1 +-0.316292 -0.298937 0.900331 0 1 +-0.311977 0.00745462 0.950060 0 1 +-0.518718 -0.0208746 0.854690 0 1 +-0.581804 -0.238653 0.777527 0 1 + + +-0.518718 -0.0208746 0.854690 0 1 +-0.311977 0.00745462 0.950060 0 1 +-0.349880 0.276923 0.894929 0 1 +-0.618273 0.185258 0.763818 0 1 +-0.518718 -0.0208746 0.854690 0 1 + + +-0.655703 0.470729 0.590312 0 1 +-0.618273 0.185258 0.763818 0 1 +-0.349880 0.276923 0.894929 0 1 +-0.355505 0.548576 0.756757 0 1 +-0.655703 0.470729 0.590312 0 1 + + +-0.109474 0.540719 0.834050 0 1 +-0.355505 0.548576 0.756757 0 1 +-0.349880 0.276923 0.894929 0 1 +-0.0499119 0.322444 0.945272 0 1 +-0.109474 0.540719 0.834050 0 1 + + +-0.109474 0.540719 0.834050 0 1 +-0.0499119 0.322444 0.945272 0 1 +0.263823 0.408120 0.873977 0 1 +0.0849177 0.689837 0.718967 0 1 +-0.109474 0.540719 0.834050 0 1 + + +0.342339 0.0465385 0.938423 0 1 +0.653761 0.0750076 0.752975 0 1 +0.590651 0.458181 0.664230 0 1 +0.263823 0.408120 0.873977 0 1 +0.342339 0.0465385 0.938423 0 1 + + +0.354845 -0.314540 0.880426 0 1 +0.647206 -0.264372 0.715005 0 1 +0.653761 0.0750076 0.752975 0 1 +0.342339 0.0465385 0.938423 0 1 +0.354845 -0.314540 0.880426 0 1 + + +0.334293 -0.631291 0.699800 0 1 +0.644255 -0.545349 0.536218 0 1 +0.647206 -0.264372 0.715005 0 1 +0.354845 -0.314540 0.880426 0 1 +0.334293 -0.631291 0.699800 0 1 + + +-0.0136400 -0.623344 0.781828 0 1 +0.334293 -0.631291 0.699800 0 1 +0.354845 -0.314540 0.880426 0 1 +0.00679510 -0.328843 0.944360 0 1 +-0.0136400 -0.623344 0.781828 0 1 + + +-0.0136400 -0.623344 0.781828 0 1 +0.00679510 -0.328843 0.944360 0 1 +-0.316292 -0.298937 0.900331 0 1 +-0.315086 -0.567457 0.760732 0 1 +-0.0136400 -0.623344 0.781828 0 1 + + +-0.576157 -0.514159 0.635361 0 1 +-0.315086 -0.567457 0.760732 0 1 +-0.316292 -0.298937 0.900331 0 1 +-0.581804 -0.238653 0.777527 0 1 +-0.576157 -0.514159 0.635361 0 1 + + +-0.576157 -0.514159 0.635361 0 1 +-0.581804 -0.238653 0.777527 0 1 +-0.789430 -0.0638458 0.610511 0 1 +-0.815841 -0.391026 0.426030 0 1 +-0.576157 -0.514159 0.635361 0 1 + + +-0.683844 0.271870 -0.677085 0 1 +-0.366349 0.350743 -0.861840 0 1 +-0.342360 -0.0100870 -0.939515 0 1 +-0.630568 -0.0635365 -0.773529 0 1 +-0.683844 0.271870 -0.677085 0 1 + + +-0.545967 -0.351787 -0.760373 0 1 +-0.630568 -0.0635365 -0.773529 0 1 +-0.342360 -0.0100870 -0.939515 0 1 +-0.289183 -0.332580 -0.897643 0 1 +-0.545967 -0.351787 -0.760373 0 1 + + +-0.476920 -0.600556 -0.641779 0 1 +-0.545967 -0.351787 -0.760373 0 1 +-0.289183 -0.332580 -0.897643 0 1 +-0.216924 -0.585305 -0.781257 0 1 +-0.476920 -0.600556 -0.641779 0 1 + + +-0.216924 -0.585305 -0.781257 0 1 +-0.289183 -0.332580 -0.897643 0 1 +0.00385941 -0.311698 -0.950173 0 1 +0.00748938 -0.520154 -0.854040 0 1 +-0.216924 -0.585305 -0.781257 0 1 + + +0.182410 -0.619455 -0.763546 0 1 +0.00748938 -0.520154 -0.854040 0 1 +0.00385941 -0.311698 -0.950173 0 1 +0.298350 -0.356878 -0.885226 0 1 +0.182410 -0.619455 -0.763546 0 1 + + +0.182410 -0.619455 -0.763546 0 1 +0.298350 -0.356878 -0.885226 0 1 +0.587904 -0.398117 -0.704181 0 1 +0.434724 -0.699062 -0.567739 0 1 +0.182410 -0.619455 -0.763546 0 1 + + +0.298350 -0.356878 -0.885226 0 1 +0.344411 -0.0231948 -0.938532 0 1 +0.641342 -0.0572571 -0.765115 0 1 +0.587904 -0.398117 -0.704181 0 1 +0.298350 -0.356878 -0.885226 0 1 + + +0.363753 0.326848 -0.872270 0 1 +0.646115 0.257731 -0.718408 0 1 +0.641342 -0.0572571 -0.765115 0 1 +0.344411 -0.0231948 -0.938532 0 1 +0.363753 0.326848 -0.872270 0 1 + + +0.363753 0.326848 -0.872270 0 1 +0.382789 0.637705 -0.668435 0 1 +0.671849 0.513247 -0.534039 0 1 +0.646115 0.257731 -0.718408 0 1 +0.363753 0.326848 -0.872270 0 1 + + +0.363753 0.326848 -0.872270 0 1 +0.00809038 0.366486 -0.930389 0 1 +0.0230305 0.697195 -0.716511 0 1 +0.382789 0.637705 -0.668435 0 1 +0.363753 0.326848 -0.872270 0 1 + + +-0.366349 0.350743 -0.861840 0 1 +-0.351416 0.677986 -0.645633 0 1 +0.0230305 0.697195 -0.716511 0 1 +0.00809038 0.366486 -0.930389 0 1 +-0.366349 0.350743 -0.861840 0 1 + + +-0.683844 0.271870 -0.677085 0 1 +-0.669229 0.582943 -0.460771 0 1 +-0.351416 0.677986 -0.645633 0 1 +-0.366349 0.350743 -0.861840 0 1 +-0.683844 0.271870 -0.677085 0 1 + + +-0.893850 0.128655 -0.429512 0 1 +-0.883097 0.413202 -0.222268 0 1 +-0.669229 0.582943 -0.460771 0 1 +-0.683844 0.271870 -0.677085 0 1 +-0.893850 0.128655 -0.429512 0 1 + + +-0.893850 0.128655 -0.429512 0 1 +-0.683844 0.271870 -0.677085 0 1 +-0.630568 -0.0635365 -0.773529 0 1 +-0.816819 -0.157920 -0.554859 0 1 +-0.893850 0.128655 -0.429512 0 1 + + +-0.922392 0.225124 0.313866 0 1 +-0.789430 -0.0638458 0.610511 0 1 +-0.618273 0.185258 0.763818 0 1 +-0.655703 0.470729 0.590312 0 1 +-0.922392 0.225124 0.313866 0 1 + + +-0.922392 0.225124 0.313866 0 1 +-0.655703 0.470729 0.590312 0 1 +-0.550074 0.753033 0.361053 0 1 +-0.796328 0.599676 0.0790578 0 1 +-0.922392 0.225124 0.313866 0 1 + + +-0.655703 0.470729 0.590312 0 1 +-0.355505 0.548576 0.756757 0 1 +-0.227479 0.793528 0.564418 0 1 +-0.550074 0.753033 0.361053 0 1 +-0.655703 0.470729 0.590312 0 1 + + +-0.109474 0.540719 0.834050 0 1 +0.0849177 0.689837 0.718967 0 1 +-0.227479 0.793528 0.564418 0 1 +-0.355505 0.548576 0.756757 0 1 +-0.109474 0.540719 0.834050 0 1 + + +0.653761 0.0750076 0.752975 0 1 +0.867044 0.0465761 0.496050 0 1 +0.844766 0.377775 0.379020 0 1 +0.590651 0.458181 0.664230 0 1 +0.653761 0.0750076 0.752975 0 1 + + +0.647206 -0.264372 0.715005 0 1 +0.818455 -0.202855 0.537571 0 1 +0.867044 0.0465761 0.496050 0 1 +0.653761 0.0750076 0.752975 0 1 +0.647206 -0.264372 0.715005 0 1 + + +0.334293 -0.631291 0.699800 0 1 +0.245075 -0.866643 0.434590 0 1 +0.577369 -0.777704 0.248639 0 1 +0.644255 -0.545349 0.536218 0 1 +0.334293 -0.631291 0.699800 0 1 + + +-0.0136400 -0.623344 0.781828 0 1 +-0.0762364 -0.830976 0.551060 0 1 +0.245075 -0.866643 0.434590 0 1 +0.334293 -0.631291 0.699800 0 1 +-0.0136400 -0.623344 0.781828 0 1 + + +-0.576157 -0.514159 0.635361 0 1 +-0.815841 -0.391026 0.426030 0 1 +-0.698790 -0.680384 0.220839 0 1 +-0.482227 -0.749358 0.453784 0 1 +-0.576157 -0.514159 0.635361 0 1 + + +-0.968869 -0.201841 0.143363 0 1 +-0.850655 -0.523067 -0.0527958 0 1 +-0.698790 -0.680384 0.220839 0 1 +-0.815841 -0.391026 0.426030 0 1 +-0.968869 -0.201841 0.143363 0 1 + + +-0.968869 -0.201841 0.143363 0 1 +-0.815841 -0.391026 0.426030 0 1 +-0.789430 -0.0638458 0.610511 0 1 +-0.922392 0.225124 0.313866 0 1 +-0.968869 -0.201841 0.143363 0 1 + + +-0.708921 -0.356642 -0.608471 0 1 +-0.816819 -0.157920 -0.554859 0 1 +-0.630568 -0.0635365 -0.773529 0 1 +-0.545967 -0.351787 -0.760373 0 1 +-0.708921 -0.356642 -0.608471 0 1 + + +-0.706419 -0.531732 -0.467153 0 1 +-0.708921 -0.356642 -0.608471 0 1 +-0.545967 -0.351787 -0.760373 0 1 +-0.476920 -0.600556 -0.641779 0 1 +-0.706419 -0.531732 -0.467153 0 1 + + +-0.627703 -0.738044 -0.247548 0 1 +-0.706419 -0.531732 -0.467153 0 1 +-0.476920 -0.600556 -0.641779 0 1 +-0.344524 -0.828036 -0.442335 0 1 +-0.627703 -0.738044 -0.247548 0 1 + + +-0.344524 -0.828036 -0.442335 0 1 +-0.476920 -0.600556 -0.641779 0 1 +-0.216924 -0.585305 -0.781257 0 1 +-0.0527458 -0.777682 -0.626442 0 1 +-0.344524 -0.828036 -0.442335 0 1 + + +-0.0527458 -0.777682 -0.626442 0 1 +-0.216924 -0.585305 -0.781257 0 1 +0.00748938 -0.520154 -0.854040 0 1 +0.182410 -0.619455 -0.763546 0 1 +-0.0527458 -0.777682 -0.626442 0 1 + + +-0.0527458 -0.777682 -0.626442 0 1 +0.182410 -0.619455 -0.763546 0 1 +0.434724 -0.699062 -0.567739 0 1 +0.180294 -0.904820 -0.385740 0 1 +-0.0527458 -0.777682 -0.626442 0 1 + + +0.410092 -0.908811 -0.0767257 0 1 +0.180294 -0.904820 -0.385740 0 1 +0.434724 -0.699062 -0.567739 0 1 +0.671511 -0.689556 -0.271267 0 1 +0.410092 -0.908811 -0.0767257 0 1 + + +0.671511 -0.689556 -0.271267 0 1 +0.434724 -0.699062 -0.567739 0 1 +0.587904 -0.398117 -0.704181 0 1 +0.820909 -0.378965 -0.427193 0 1 +0.671511 -0.689556 -0.271267 0 1 + + +0.820909 -0.378965 -0.427193 0 1 +0.587904 -0.398117 -0.704181 0 1 +0.641342 -0.0572571 -0.765115 0 1 +0.850590 -0.0521153 -0.523241 0 1 +0.820909 -0.378965 -0.427193 0 1 + + +0.810912 0.188820 -0.553867 0 1 +0.850590 -0.0521153 -0.523241 0 1 +0.641342 -0.0572571 -0.765115 0 1 +0.646115 0.257731 -0.718408 0 1 +0.810912 0.188820 -0.553867 0 1 + + +0.810912 0.188820 -0.553867 0 1 +0.646115 0.257731 -0.718408 0 1 +0.671849 0.513247 -0.534039 0 1 +0.863023 0.343845 -0.370084 0 1 +0.810912 0.188820 -0.553867 0 1 + + +0.850430 0.515922 -0.102922 0 1 +0.863023 0.343845 -0.370084 0 1 +0.671849 0.513247 -0.534039 0 1 +0.655782 0.705401 -0.268995 0 1 +0.850430 0.515922 -0.102922 0 1 + + +0.385544 0.848621 -0.362213 0 1 +0.655782 0.705401 -0.268995 0 1 +0.671849 0.513247 -0.534039 0 1 +0.382789 0.637705 -0.668435 0 1 +0.385544 0.848621 -0.362213 0 1 + + +0.385544 0.848621 -0.362213 0 1 +0.382789 0.637705 -0.668435 0 1 +0.0230305 0.697195 -0.716511 0 1 +0.0439654 0.916174 -0.398361 0 1 +0.385544 0.848621 -0.362213 0 1 + + +-0.796328 0.599676 0.0790578 0 1 +-0.570342 0.803635 -0.169944 0 1 +-0.669229 0.582943 -0.460771 0 1 +-0.883097 0.413202 -0.222268 0 1 +-0.796328 0.599676 0.0790578 0 1 + + +-0.984277 -0.0519672 -0.168814 0 1 +-0.977511 0.209292 -0.0258734 0 1 +-0.883097 0.413202 -0.222268 0 1 +-0.893850 0.128655 -0.429512 0 1 +-0.984277 -0.0519672 -0.168814 0 1 + + +-0.627703 -0.738044 -0.247548 0 1 +-0.850655 -0.523067 -0.0527958 0 1 +-0.886983 -0.329962 -0.323088 0 1 +-0.706419 -0.531732 -0.467153 0 1 +-0.627703 -0.738044 -0.247548 0 1 + + +-0.627703 -0.738044 -0.247548 0 1 +-0.461518 -0.886803 0.0241058 0 1 +-0.698790 -0.680384 0.220839 0 1 +-0.850655 -0.523067 -0.0527958 0 1 +-0.627703 -0.738044 -0.247548 0 1 + + +-0.796328 0.599676 0.0790578 0 1 +-0.550074 0.753033 0.361053 0 1 +-0.371668 0.922819 0.101334 0 1 +-0.570342 0.803635 -0.169944 0 1 +-0.796328 0.599676 0.0790578 0 1 + + +0.384841 0.827678 0.408468 0 1 +0.590651 0.458181 0.664230 0 1 +0.844766 0.377775 0.379020 0 1 +0.725490 0.663670 0.182225 0 1 +0.384841 0.827678 0.408468 0 1 + + +0.850430 0.515922 -0.102922 0 1 +0.725490 0.663670 0.182225 0 1 +0.844766 0.377775 0.379020 0 1 +0.969530 0.235677 0.0668435 0 1 +0.850430 0.515922 -0.102922 0 1 + + +0.972392 -0.0935506 0.213780 0 1 +0.969530 0.235677 0.0668435 0 1 +0.844766 0.377775 0.379020 0 1 +0.867044 0.0465761 0.496050 0 1 +0.972392 -0.0935506 0.213780 0 1 + + +0.859439 -0.375019 0.347455 0 1 +0.972392 -0.0935506 0.213780 0 1 +0.867044 0.0465761 0.496050 0 1 +0.818455 -0.202855 0.537571 0 1 +0.859439 -0.375019 0.347455 0 1 + + +0.644255 -0.545349 0.536218 0 1 +0.577369 -0.777704 0.248639 0 1 +0.823247 -0.564669 0.0584194 0 1 +0.859439 -0.375019 0.347455 0 1 +0.644255 -0.545349 0.536218 0 1 + + +-0.249654 -0.920049 0.301963 0 1 +0.0699297 -0.989322 0.127877 0 1 +0.245075 -0.866643 0.434590 0 1 +-0.0762364 -0.830976 0.551060 0 1 +-0.249654 -0.920049 0.301963 0 1 + + +-0.249654 -0.920049 0.301963 0 1 +-0.482227 -0.749358 0.453784 0 1 +-0.698790 -0.680384 0.220839 0 1 +-0.461518 -0.886803 0.0241058 0 1 +-0.249654 -0.920049 0.301963 0 1 + + +-0.968869 -0.201841 0.143363 0 1 +-0.984277 -0.0519672 -0.168814 0 1 +-0.886983 -0.329962 -0.323088 0 1 +-0.850655 -0.523067 -0.0527958 0 1 +-0.968869 -0.201841 0.143363 0 1 + + +-0.249654 -0.920049 0.301963 0 1 +-0.461518 -0.886803 0.0241058 0 1 +-0.143988 -0.972315 -0.184038 0 1 +0.0699297 -0.989322 0.127877 0 1 +-0.249654 -0.920049 0.301963 0 1 + + +0.671511 -0.689556 -0.271267 0 1 +0.820909 -0.378965 -0.427193 0 1 +0.959996 -0.259541 -0.105098 0 1 +0.823247 -0.564669 0.0584194 0 1 +0.671511 -0.689556 -0.271267 0 1 + + +0.820909 -0.378965 -0.427193 0 1 +0.850590 -0.0521153 -0.523241 0 1 +0.966797 0.0718926 -0.245223 0 1 +0.959996 -0.259541 -0.105098 0 1 +0.820909 -0.378965 -0.427193 0 1 + + +0.850430 0.515922 -0.102922 0 1 +0.969530 0.235677 0.0668435 0 1 +0.966797 0.0718926 -0.245223 0 1 +0.863023 0.343845 -0.370084 0 1 +0.850430 0.515922 -0.102922 0 1 + + +0.410092 -0.908811 -0.0767257 0 1 +0.671511 -0.689556 -0.271267 0 1 +0.823247 -0.564669 0.0584194 0 1 +0.577369 -0.777704 0.248639 0 1 +0.410092 -0.908811 -0.0767257 0 1 + + +-0.968869 -0.201841 0.143363 0 1 +-0.922392 0.225124 0.313866 0 1 +-0.977511 0.209292 -0.0258734 0 1 +-0.984277 -0.0519672 -0.168814 0 1 +-0.968869 -0.201841 0.143363 0 1 + + +0.859439 -0.375019 0.347455 0 1 +0.823247 -0.564669 0.0584194 0 1 +0.959996 -0.259541 -0.105098 0 1 +0.972392 -0.0935506 0.213780 0 1 +0.859439 -0.375019 0.347455 0 1 + + +0.972392 -0.0935506 0.213780 0 1 +0.959996 -0.259541 -0.105098 0 1 +0.966797 0.0718926 -0.245223 0 1 +0.969530 0.235677 0.0668435 0 1 +0.972392 -0.0935506 0.213780 0 1 + + +0.850430 0.515922 -0.102922 0 1 +0.655782 0.705401 -0.268995 0 1 +0.605130 0.795338 -0.0354306 0 1 +0.725490 0.663670 0.182225 0 1 +0.850430 0.515922 -0.102922 0 1 + + +0.385544 0.848621 -0.362213 0 1 +0.368054 0.929539 -0.0222340 0 1 +0.605130 0.795338 -0.0354306 0 1 +0.655782 0.705401 -0.268995 0 1 +0.385544 0.848621 -0.362213 0 1 + + +0.385544 0.848621 -0.362213 0 1 +0.0439654 0.916174 -0.398361 0 1 +0.0453701 0.996779 -0.0661311 0 1 +0.368054 0.929539 -0.0222340 0 1 +0.385544 0.848621 -0.362213 0 1 + + +0.384841 0.827678 0.408468 0 1 +0.368054 0.929539 -0.0222340 0 1 +0.0453701 0.996779 -0.0661311 0 1 +-0.0526868 0.960179 0.274372 0 1 +0.384841 0.827678 0.408468 0 1 + + +0.384841 0.827678 0.408468 0 1 +0.725490 0.663670 0.182225 0 1 +0.605130 0.795338 -0.0354306 0 1 +0.368054 0.929539 -0.0222340 0 1 +0.384841 0.827678 0.408468 0 1 + + +0.644255 -0.545349 0.536218 0 1 +0.859439 -0.375019 0.347455 0 1 +0.818455 -0.202855 0.537571 0 1 +0.647206 -0.264372 0.715005 0 1 +0.644255 -0.545349 0.536218 0 1 + + +0.0699297 -0.989322 0.127877 0 1 +0.410092 -0.908811 -0.0767257 0 1 +0.577369 -0.777704 0.248639 0 1 +0.245075 -0.866643 0.434590 0 1 +0.0699297 -0.989322 0.127877 0 1 + + +0.0699297 -0.989322 0.127877 0 1 +-0.143988 -0.972315 -0.184038 0 1 +0.180294 -0.904820 -0.385740 0 1 +0.410092 -0.908811 -0.0767257 0 1 +0.0699297 -0.989322 0.127877 0 1 + + +-0.0136400 -0.623344 0.781828 0 1 +-0.315086 -0.567457 0.760732 0 1 +-0.299076 -0.738598 0.604174 0 1 +-0.0762364 -0.830976 0.551060 0 1 +-0.0136400 -0.623344 0.781828 0 1 + + +-0.576157 -0.514159 0.635361 0 1 +-0.482227 -0.749358 0.453784 0 1 +-0.299076 -0.738598 0.604174 0 1 +-0.315086 -0.567457 0.760732 0 1 +-0.576157 -0.514159 0.635361 0 1 + + +-0.344524 -0.828036 -0.442335 0 1 +-0.0527458 -0.777682 -0.626442 0 1 +0.180294 -0.904820 -0.385740 0 1 +-0.143988 -0.972315 -0.184038 0 1 +-0.344524 -0.828036 -0.442335 0 1 + + +-0.290124 0.889598 -0.352767 0 1 +0.0439654 0.916174 -0.398361 0 1 +0.0230305 0.697195 -0.716511 0 1 +-0.351416 0.677986 -0.645633 0 1 +-0.290124 0.889598 -0.352767 0 1 + + +-0.570342 0.803635 -0.169944 0 1 +-0.290124 0.889598 -0.352767 0 1 +-0.351416 0.677986 -0.645633 0 1 +-0.669229 0.582943 -0.460771 0 1 +-0.570342 0.803635 -0.169944 0 1 + + +-0.290124 0.889598 -0.352767 0 1 +-0.213036 0.970861 -0.109750 0 1 +0.0453701 0.996779 -0.0661311 0 1 +0.0439654 0.916174 -0.398361 0 1 +-0.290124 0.889598 -0.352767 0 1 + + +-0.371668 0.922819 0.101334 0 1 +-0.0526868 0.960179 0.274372 0 1 +0.0453701 0.996779 -0.0661311 0 1 +-0.213036 0.970861 -0.109750 0 1 +-0.371668 0.922819 0.101334 0 1 + + +-0.627703 -0.738044 -0.247548 0 1 +-0.344524 -0.828036 -0.442335 0 1 +-0.143988 -0.972315 -0.184038 0 1 +-0.461518 -0.886803 0.0241058 0 1 +-0.627703 -0.738044 -0.247548 0 1 + + +-0.249654 -0.920049 0.301963 0 1 +-0.0762364 -0.830976 0.551060 0 1 +-0.299076 -0.738598 0.604174 0 1 +-0.482227 -0.749358 0.453784 0 1 +-0.249654 -0.920049 0.301963 0 1 + + +0.810912 0.188820 -0.553867 0 1 +0.863023 0.343845 -0.370084 0 1 +0.966797 0.0718926 -0.245223 0 1 +0.850590 -0.0521153 -0.523241 0 1 +0.810912 0.188820 -0.553867 0 1 + + +-0.550074 0.753033 0.361053 0 1 +-0.227479 0.793528 0.564418 0 1 +-0.0526868 0.960179 0.274372 0 1 +-0.371668 0.922819 0.101334 0 1 +-0.550074 0.753033 0.361053 0 1 + + +-0.984277 -0.0519672 -0.168814 0 1 +-0.893850 0.128655 -0.429512 0 1 +-0.816819 -0.157920 -0.554859 0 1 +-0.886983 -0.329962 -0.323088 0 1 +-0.984277 -0.0519672 -0.168814 0 1 + + +-0.706419 -0.531732 -0.467153 0 1 +-0.886983 -0.329962 -0.323088 0 1 +-0.816819 -0.157920 -0.554859 0 1 +-0.708921 -0.356642 -0.608471 0 1 +-0.706419 -0.531732 -0.467153 0 1 + + +-0.581804 -0.238653 0.777527 0 1 +-0.518718 -0.0208746 0.854690 0 1 +-0.618273 0.185258 0.763818 0 1 +-0.789430 -0.0638458 0.610511 0 1 +-0.581804 -0.238653 0.777527 0 1 + + +-0.570342 0.803635 -0.169944 0 1 +-0.371668 0.922819 0.101334 0 1 +-0.213036 0.970861 -0.109750 0 1 +-0.290124 0.889598 -0.352767 0 1 +-0.570342 0.803635 -0.169944 0 1 + + +-0.922392 0.225124 0.313866 0 1 +-0.796328 0.599676 0.0790578 0 1 +-0.883097 0.413202 -0.222268 0 1 +-0.977511 0.209292 -0.0258734 0 1 +-0.922392 0.225124 0.313866 0 1 + + +0.0849177 0.689837 0.718967 0 1 +0.384841 0.827678 0.408468 0 1 +-0.0526868 0.960179 0.274372 0 1 +-0.227479 0.793528 0.564418 0 1 +0.0849177 0.689837 0.718967 0 1 + + +0.0849177 0.689837 0.718967 0 1 +0.263823 0.408120 0.873977 0 1 +0.590651 0.458181 0.664230 0 1 +0.384841 0.827678 0.408468 0 1 +0.0849177 0.689837 0.718967 0 1 + + -- 2.39.5