From: Peter Munch Date: Mon, 8 Mar 2021 12:24:56 +0000 (+0100) Subject: Add further MappingQCache::initialize() functions X-Git-Tag: v9.3.0-rc1~301^2 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=9b0cc29ee61b631b0f107b44f2aa60df7ec32363;p=dealii.git Add further MappingQCache::initialize() functions --- diff --git a/doc/news/changes/minor/20210310Fehn b/doc/news/changes/minor/20210310Fehn index b01b92c6bb..ddd3aac7e0 100644 --- a/doc/news/changes/minor/20210310Fehn +++ b/doc/news/changes/minor/20210310Fehn @@ -1,6 +1,8 @@ -New: MappingQCache has a new initialize function that takes +New: MappingQCache has new initialize functions. One set of functions takes either a std::function or a dealii::Function for transforming -individual points. +individual points. Another set of functions take global vectors (and +MGLevelObjects of global vectors) and use these to initialize the position of +the support points much like MappingFEField does.
(Niklas Fehn, Martin Kronbichler, Peter Munch, 2021/03/10) diff --git a/include/deal.II/fe/mapping_q_cache.h b/include/deal.II/fe/mapping_q_cache.h index 3f576d9f8f..f9c8a17aaf 100644 --- a/include/deal.II/fe/mapping_q_cache.h +++ b/include/deal.II/fe/mapping_q_cache.h @@ -20,6 +20,7 @@ #include #include +#include #include @@ -28,6 +29,11 @@ DEAL_II_NAMESPACE_OPEN +// Forward declarations +#ifndef DOXYGEN +template +class DoFHandler; +#endif /*!@addtogroup mapping */ @@ -161,6 +167,42 @@ public: const Function & transformation_function, const bool function_describes_relative_displacement); + /** + * Initialize the data cache of the active cells by a discrete field + * (specified + * by @p dof_handler and @p vector) that describes the absolute or + * relative position of each support point. + * + * @note By using this function for reinitialization, this class behaves like + * MappingFEField (vector_describes_relative_displacement == false) or + * MappingQEulerian (vector_describes_relative_displacement == true), but + * with much more efficient operations internally. + */ + template + void + initialize(const Mapping & mapping, + const DoFHandler &dof_handler, + const VectorType & vector, + const bool vector_describes_relative_displacement); + + /** + * Initialize the data cache of all non-artificial cells by a solution + * (specified by @p dof_handler and a set of @p vectors on all levels of the + * triangulation) that describes the absolute or relative position of each + * support point. + * + * @note By using this function for reinitialization, this class behaves like + * MappingFEField (vector_describes_relative_displacement == false) or + * MappingQEulerian (vector_describes_relative_displacement == true), but + * with much more efficient operations internally. + */ + template + void + initialize(const Mapping & mapping, + const DoFHandler &dof_handler, + const MGLevelObject &vectors, + const bool vector_describes_relative_displacement); + /** * Return the memory consumption (in bytes) of the cache. */ diff --git a/source/fe/mapping_q_cache.cc b/source/fe/mapping_q_cache.cc index 8d62b9eef3..0b1633e0a1 100644 --- a/source/fe/mapping_q_cache.cc +++ b/source/fe/mapping_q_cache.cc @@ -14,14 +14,24 @@ // --------------------------------------------------------------------- #include +#include #include +#include + +#include #include +#include #include #include #include #include +#include +#include +#include +#include + #include DEAL_II_NAMESPACE_OPEN @@ -249,17 +259,441 @@ MappingQCache::initialize( { AssertDimension(transformation_function.n_components, spacedim); + this->initialize(mapping, + tria, + [&](const auto &, const auto &point) { + Point new_point; + for (int c = 0; c < spacedim; ++c) + new_point[c] = transformation_function.value(point, c); + return new_point; + }, + function_describes_relative_displacement); +} + + + +namespace +{ + template + void + copy_locally_owned_data_from( + const VectorType &vector, + LinearAlgebra::distributed::Vector + &vector_ghosted) + { + LinearAlgebra::ReadWriteVector temp; + temp.reinit(vector.locally_owned_elements()); + temp.import(vector, VectorOperation::insert); + vector_ghosted.import(temp, VectorOperation::insert); + } +} // namespace + + + +template +template +void +MappingQCache::initialize( + const Mapping & mapping, + const DoFHandler &dof_handler, + const VectorType & vector, + const bool vector_describes_relative_displacement) +{ + AssertDimension(dof_handler.get_fe_collection().size(), 1); + const FiniteElement &fe = dof_handler.get_fe(); + AssertDimension(fe.n_base_elements(), 1); + AssertDimension(fe.element_multiplicity(0), spacedim); + + const unsigned int is_fe_q = + dynamic_cast *>(&fe.base_element(0)) != nullptr; + const unsigned int is_fe_dgq = + dynamic_cast *>(&fe.base_element(0)) != nullptr; + + const auto lexicographic_to_hierarchic_numbering = + Utilities::invert_permutation( + FETools::hierarchic_to_lexicographic_numbering( + this->get_degree())); + + // Step 1: copy global vector so that the ghost values are such that the + // cache can be set up for all ghost cells + LinearAlgebra::distributed::Vector + vector_ghosted; + IndexSet locally_relevant_dofs; + DoFTools::extract_locally_relevant_dofs(dof_handler, locally_relevant_dofs); + vector_ghosted.reinit(dof_handler.locally_owned_dofs(), + locally_relevant_dofs, + dof_handler.get_communicator()); + copy_locally_owned_data_from(vector, vector_ghosted); + vector_ghosted.update_ghost_values(); + + // FE and FEValues in the case they are needed + FE_Nothing fe_nothing; + Threads::ThreadLocalStorage>> + fe_values_all; + + // Interpolation of values is needed if we cannot just read off locations + // from the solution vectors (as in the case of FE_Q and FE_DGQ with the + // same polynomial degree as this class has). + const bool interpolation_of_values_is_needed = + ((is_fe_q || is_fe_dgq) && fe.degree == this->get_degree()) == false; + + // Step 2: loop over all cells this->initialize( - mapping, - tria, - [&](const typename Triangulation::cell_iterator &, - const Point &point) -> Point { - Point new_point; - for (int c = 0; c < spacedim; ++c) - new_point[c] = transformation_function.value(point, c); - return new_point; - }, - function_describes_relative_displacement); + dof_handler.get_triangulation(), + [&](const typename Triangulation::cell_iterator &cell_tria) + -> std::vector> { + const bool is_active_non_artificial_cell = + (cell_tria->is_active() == true) && + (cell_tria->is_artificial() == false); + + const typename DoFHandler::cell_iterator cell_dofs( + &cell_tria->get_triangulation(), + cell_tria->level(), + cell_tria->index(), + &dof_handler); + + const auto mapping_q_generic = + dynamic_cast *>(&mapping); + + // Step 2a) set up and reinit FEValues (if needed) + if ( + ((vector_describes_relative_displacement || + (is_active_non_artificial_cell == false)) && + ((mapping_q_generic != nullptr && + this->get_degree() == mapping_q_generic->get_degree()) == + false)) /*condition 1: points need to be computed via FEValues*/ + || + (is_active_non_artificial_cell && interpolation_of_values_is_needed) /*condition 2: interpolation of values is needed*/) + { + // get FEValues (thread-safe); in the case that this thread has + // not created a an FEValues object yet, this helper-function also + // creates one with the right quadrature rule + auto &fe_values = fe_values_all.get(); + if (fe_values.get() == nullptr) + { + QGaussLobatto quadrature_gl(this->polynomial_degree + 1); + + std::vector> quadrature_points; + for (const auto i : + FETools::hierarchic_to_lexicographic_numbering( + this->polynomial_degree)) + quadrature_points.push_back(quadrature_gl.point(i)); + Quadrature quadrature(quadrature_points); + + fe_values = std::make_unique>( + mapping, + interpolation_of_values_is_needed ? + fe : + static_cast &>(fe_nothing), + quadrature, + update_quadrature_points | update_values); + } + + if (interpolation_of_values_is_needed) + fe_values->reinit(cell_dofs); + else + fe_values->reinit(cell_tria); + } + + std::vector> result; + + // Step 2b) read of quadrature points in the relative displacement case + // note: we also take this path for non-active or artifical cells so that + // these cells are filled with some useful data + if (vector_describes_relative_displacement || + is_active_non_artificial_cell == false) + { + if (mapping_q_generic != nullptr && + this->get_degree() == mapping_q_generic->get_degree()) + result = + mapping_q_generic->compute_mapping_support_points(cell_tria); + else + result = fe_values_all.get()->get_quadrature_points(); + + // for non-active or artificial cells we are done here and return + // the absolute positions, since the provided vector cannot contain + // any useful information for these cells + if (is_active_non_artificial_cell == false) + return result; + } + else + { + result.resize( + Utilities::pow(this->get_degree() + 1, dim)); + } + + // Step 2c) read global vector and adjust points accordingly + if (interpolation_of_values_is_needed == false) + { + // case 1: FE_Q or FE_DGQ with same degree as this class has; this + // is the simple case since no interpolation is needed + std::vector dof_indices( + fe.n_dofs_per_cell()); + cell_dofs->get_dof_indices(dof_indices); + + for (unsigned int i = 0; i < dof_indices.size(); ++i) + { + const auto id = fe.system_to_component_index(i); + + if (is_fe_q) + { + // case 1a: FE_Q + if (vector_describes_relative_displacement) + result[id.second][id.first] += + vector_ghosted(dof_indices[i]); + else + result[id.second][id.first] = + vector_ghosted(dof_indices[i]); + } + else + { + // case 1b: FE_DGQ + if (vector_describes_relative_displacement) + result[lexicographic_to_hierarchic_numbering[id.second]] + [id.first] += vector_ghosted(dof_indices[i]); + else + result[lexicographic_to_hierarchic_numbering[id.second]] + [id.first] = vector_ghosted(dof_indices[i]); + } + } + } + else + { + // case 2: general case; interpolation is needed + // note: the following code could be optimized for tensor-product + // elements via application of sum factorization as is done on + // MatrixFree/FEEvaluation + auto &fe_values = fe_values_all.get(); + + std::vector> values( + fe_values->n_quadrature_points, + Vector(spacedim)); + + fe_values->get_function_values(vector_ghosted, values); + + for (unsigned int q = 0; q < fe_values->n_quadrature_points; ++q) + for (unsigned int c = 0; c < spacedim; ++c) + if (vector_describes_relative_displacement) + result[q][c] += values[q][c]; + else + result[q][c] = values[q][c]; + } + + return result; + }); +} + + + +template +template +void +MappingQCache::initialize( + const Mapping & mapping, + const DoFHandler &dof_handler, + const MGLevelObject &vectors, + const bool vector_describes_relative_displacement) +{ + AssertDimension(dof_handler.get_fe_collection().size(), 1); + const FiniteElement &fe = dof_handler.get_fe(); + AssertDimension(fe.n_base_elements(), 1); + AssertDimension(fe.element_multiplicity(0), spacedim); + AssertDimension(0, vectors.min_level()); + AssertDimension(dof_handler.get_triangulation().n_global_levels() - 1, + vectors.max_level()); + + const unsigned int is_fe_q = + dynamic_cast *>(&fe.base_element(0)) != nullptr; + const unsigned int is_fe_dgq = + dynamic_cast *>(&fe.base_element(0)) != nullptr; + + const auto lexicographic_to_hierarchic_numbering = + Utilities::invert_permutation( + FETools::hierarchic_to_lexicographic_numbering( + this->get_degree())); + + // Step 1: copy global vector so that the ghost values are such that the + // cache can be set up for all ghost cells + MGLevelObject< + LinearAlgebra::distributed::Vector> + vectors_ghosted(vectors.min_level(), vectors.max_level()); + + for (unsigned int l = vectors.min_level(); l <= vectors.max_level(); ++l) + { + IndexSet locally_relevant_dofs; + DoFTools::extract_locally_relevant_level_dofs(dof_handler, + l, + locally_relevant_dofs); + vectors_ghosted[l].reinit(dof_handler.locally_owned_mg_dofs(l), + locally_relevant_dofs, + dof_handler.get_communicator()); + copy_locally_owned_data_from(vectors[l], vectors_ghosted[l]); + vectors_ghosted[l].update_ghost_values(); + } + + // FE and FEValues in the case they are needed + FE_Nothing fe_nothing; + Threads::ThreadLocalStorage>> + fe_values_all; + + // Interpolation of values is needed if we cannot just read off locations + // from the solution vectors (as in the case of FE_Q and FE_DGQ with the + // same polynomial degree as this class has). + const bool interpolation_of_values_is_needed = + ((is_fe_q || is_fe_dgq) && fe.degree == this->get_degree()) == false; + + // Step 2: loop over all cells + this->initialize( + dof_handler.get_triangulation(), + [&](const typename Triangulation::cell_iterator &cell_tria) + -> std::vector> { + const bool is_non_artificial_cell = + cell_tria->level_subdomain_id() != numbers::artificial_subdomain_id; + + const typename DoFHandler::level_cell_iterator cell_dofs( + &cell_tria->get_triangulation(), + cell_tria->level(), + cell_tria->index(), + &dof_handler); + + const auto mapping_q_generic = + dynamic_cast *>(&mapping); + + // Step 2a) set up and reinit FEValues (if needed) + if ( + ((vector_describes_relative_displacement || + (is_non_artificial_cell == false)) && + ((mapping_q_generic != nullptr && + this->get_degree() == mapping_q_generic->get_degree()) == + false)) /*condition 1: points need to be computed via FEValues*/ + || + (is_non_artificial_cell == true && interpolation_of_values_is_needed) /*condition 2: interpolation of values is needed*/) + { + // get FEValues (thread-safe); in the case that this thread has + // not created a an FEValues object yet, this helper-function also + // creates one with the right quadrature rule + auto &fe_values = fe_values_all.get(); + if (fe_values.get() == nullptr) + { + QGaussLobatto quadrature_gl(this->polynomial_degree + 1); + + std::vector> quadrature_points; + for (const auto i : + FETools::hierarchic_to_lexicographic_numbering( + this->polynomial_degree)) + quadrature_points.push_back(quadrature_gl.point(i)); + Quadrature quadrature(quadrature_points); + + fe_values = std::make_unique>( + mapping, + interpolation_of_values_is_needed ? + fe : + static_cast &>(fe_nothing), + quadrature, + update_quadrature_points | update_values); + } + + if (interpolation_of_values_is_needed) + fe_values->reinit(cell_dofs); + else + fe_values->reinit(cell_tria); + } + + std::vector> result; + + // Step 2b) read of quadrature points in the relative displacement case + // note: we also take this path for non-active or artifical cells so that + // these cells are filled with some useful data + if (vector_describes_relative_displacement || + (is_non_artificial_cell == false)) + { + if (mapping_q_generic != nullptr && + this->get_degree() == mapping_q_generic->get_degree()) + result = + mapping_q_generic->compute_mapping_support_points(cell_tria); + else + result = fe_values_all.get()->get_quadrature_points(); + + // for non-active or artificial cells we are done here and return + // the absolute positions, since the provided vector cannot contain + // any useful information for these cells + if (is_non_artificial_cell == false) + return result; + } + else + { + result.resize( + Utilities::pow(this->get_degree() + 1, dim)); + } + + // Step 2c) read global vector and adjust points accordingly + if (interpolation_of_values_is_needed == false) + { + // case 1: FE_Q or FE_DGQ with same degree as this class has; this + // is the simple case since no interpolation is needed + std::vector dof_indices( + fe.n_dofs_per_cell()); + cell_dofs->get_mg_dof_indices(dof_indices); + + for (unsigned int i = 0; i < dof_indices.size(); ++i) + { + const auto id = fe.system_to_component_index(i); + + if (is_fe_q) + { + // case 1a: FE_Q + if (vector_describes_relative_displacement) + result[id.second][id.first] += + vectors_ghosted[cell_tria->level()](dof_indices[i]); + else + result[id.second][id.first] = + vectors_ghosted[cell_tria->level()](dof_indices[i]); + } + else + { + // case 1b: FE_DGQ + if (vector_describes_relative_displacement) + result[lexicographic_to_hierarchic_numbering[id.second]] + [id.first] += + vectors_ghosted[cell_tria->level()](dof_indices[i]); + else + result[lexicographic_to_hierarchic_numbering[id.second]] + [id.first] = + vectors_ghosted[cell_tria->level()](dof_indices[i]); + } + } + } + else + { + // case 2: general case; interpolation is needed + // note: the following code could be optimized for tensor-product + // elements via application of sum factorization as is done on + // MatrixFree/FEEvaluation + auto &fe_values = fe_values_all.get(); + + std::vector dof_indices( + fe.n_dofs_per_cell()); + cell_dofs->get_mg_dof_indices(dof_indices); + + std::vector dof_values( + fe.n_dofs_per_cell()); + + for (unsigned int i = 0; i < fe.n_dofs_per_cell(); ++i) + dof_values[i] = vectors_ghosted[cell_tria->level()](dof_indices[i]); + + for (unsigned int c = 0; c < spacedim; ++c) + for (unsigned int i = 0; i < fe.n_dofs_per_cell(); ++i) + for (unsigned int q = 0; q < fe_values->n_quadrature_points; ++q) + if (vector_describes_relative_displacement == false && i == 0) + result[q][c] = + dof_values[i] * fe_values->shape_value_component(i, q, c); + else + result[q][c] += + dof_values[i] * fe_values->shape_value_component(i, q, c); + } + + return result; + }); } diff --git a/source/fe/mapping_q_cache.inst.in b/source/fe/mapping_q_cache.inst.in index d57d9e87b5..bc0e485105 100644 --- a/source/fe/mapping_q_cache.inst.in +++ b/source/fe/mapping_q_cache.inst.in @@ -20,3 +20,23 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) template class MappingQCache; #endif } + +for (deal_II_vec : REAL_NONBLOCK_VECTORS; deal_II_dimension : DIMENSIONS; + deal_II_space_dimension : SPACE_DIMENSIONS) + { +#if deal_II_dimension <= deal_II_space_dimension + template void + MappingQCache::initialize( + const Mapping & mapping, + const DoFHandler &dof_handler, + const deal_II_vec & vector, + const bool vector_describes_relative_displacement); + + template void + MappingQCache::initialize( + const Mapping & mapping, + const DoFHandler &dof_handler, + const MGLevelObject & vector, + const bool vector_describes_relative_displacement); +#endif + } diff --git a/tests/mappings/mapping_q_cache_06.cc b/tests/mappings/mapping_q_cache_06.cc new file mode 100644 index 0000000000..1c609340bd --- /dev/null +++ b/tests/mappings/mapping_q_cache_06.cc @@ -0,0 +1,173 @@ +// --------------------------------------------------------------------- +// +// Copyright (C) 2019 by the deal.II authors +// +// This file is part of the deal.II library. +// +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE.md at +// the top level directory of deal.II. +// +// --------------------------------------------------------------------- + +// Test MappingQCache initialization with point lambda/Function + +#include + +#include +#include +#include +#include +#include +#include + +#include +#include + +#include + +#include +#include + +#include "../tests.h" + +template +class Solution : public Function +{ +public: + Solution(const bool is_displacement_function) + : Function(dim) + , is_displacement_function(is_displacement_function) + {} + + double + value(const Point &point, const unsigned int compontent) const + { + return std::sin(point[compontent] * 0.5 * numbers::PI) - + (is_displacement_function ? point[compontent] : 0.0); + } + +private: + const bool is_displacement_function; +}; + +static int counter = 0; + +template +void +do_test(const unsigned int degree, + const unsigned int mapping_degree, + const Fu & fu, + const bool is_displacement_function) +{ + parallel::distributed::Triangulation tria( + MPI_COMM_WORLD, + Triangulation::MeshSmoothing::none, + parallel::distributed::Triangulation< + dim>::Settings::construct_multigrid_hierarchy); + GridGenerator::subdivided_hyper_cube(tria, 4); + tria.refine_global(1); + + FESystem fe(FE_Q(degree), dim); + DoFHandler dof_handler(tria); + dof_handler.distribute_dofs(fe); + dof_handler.distribute_mg_dofs(); + + IndexSet locally_relevant_dofs; + DoFTools::extract_locally_relevant_dofs(dof_handler, locally_relevant_dofs); + LinearAlgebra::distributed::Vector vector( + dof_handler.locally_owned_dofs(), + locally_relevant_dofs, + dof_handler.get_communicator()); + + VectorTools::interpolate(dof_handler, fu, vector); + + { + MappingQGeneric mapping(mapping_degree); + MappingQCache mapping_cache(mapping_degree); + mapping_cache.initialize(mapping, + dof_handler, + vector, + is_displacement_function); + + DataOut data_out; + + DataOutBase::VtkFlags flags; + flags.write_higher_order_cells = true; + data_out.set_flags(flags); + + data_out.attach_triangulation(tria); + + data_out.build_patches(mapping_cache, + 2, + DataOut::CurvedCellRegion::curved_inner_cells); + +#if false + std::ofstream output("test." + std::to_string(counter++) + "." + std::to_string(Utilities::MPI::this_mpi_process (MPI_COMM_WORLD)) + ".vtk"); + data_out.write_vtk(output); +#else + data_out.write_vtk(deallog.get_file_stream()); +#endif + } + + { + MGLevelObject> vectors( + 0, tria.n_global_levels() - 1); + MGTransferMatrixFree transfer; + transfer.build(dof_handler); + transfer.interpolate_to_mg(dof_handler, vectors, vector); + + MappingQGeneric mapping(mapping_degree); + MappingQCache mapping_cache(mapping_degree); + mapping_cache.initialize(mapping, + dof_handler, + vectors, + is_displacement_function); + + const unsigned int rank = Utilities::MPI::this_mpi_process(MPI_COMM_WORLD); + + for (unsigned int lvl = 0; lvl < tria.n_global_levels(); ++lvl) + { + DataOut data_out; + + DataOutBase::VtkFlags flags; + flags.write_higher_order_cells = true; + data_out.set_flags(flags); + + data_out.attach_triangulation(tria); + + data_out.set_cell_selection( + [&](const typename Triangulation::cell_iterator &cell) { + return (cell->level_subdomain_id() == rank) && + (static_cast(cell->level()) == lvl); + }); + data_out.build_patches(mapping_cache, + 2, + DataOut::curved_inner_cells); + +#if true + data_out.write_vtu_with_pvtu_record( + "./", "mg_solution", lvl, MPI_COMM_WORLD, 1, 1); +#else + data_out.write_vtk(deallog.get_file_stream()); +#endif + } + } +} + + +int +main(int argc, char *argv[]) +{ + Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1); + MPILogInitAll log; + + do_test<2>(3, 3, Solution<2>(true), true); + do_test<2>(3, 3, Solution<2>(false), false); + + do_test<2>(3, 4, Solution<2>(true), true); + do_test<2>(3, 4, Solution<2>(false), false); +} diff --git a/tests/mappings/mapping_q_cache_06.with_p4est=true.with_mpi=true.mpirun=1.output b/tests/mappings/mapping_q_cache_06.with_p4est=true.with_mpi=true.mpirun=1.output new file mode 100644 index 0000000000..8df6b20790 --- /dev/null +++ b/tests/mappings/mapping_q_cache_06.with_p4est=true.with_mpi=true.mpirun=1.output @@ -0,0 +1,2609 @@ + +# vtk DataFile Version 3.0 +#This file was generated +ASCII +DATASET UNSTRUCTURED_GRID + +POINTS 576 double +0.00000 0.00000 0 +0.0980171 0.00000 0 +0.195090 0.00000 0 +0.00000 0.0980171 0 +0.0980171 0.0980171 0 +0.195090 0.0980171 0 +0.00000 0.195090 0 +0.0980171 0.195090 0 +0.195090 0.195090 0 +0.195090 0.00000 0 +0.290284 0.00000 0 +0.382683 0.00000 0 +0.195090 0.0980171 0 +0.290284 0.0980171 0 +0.382683 0.0980171 0 +0.195090 0.195090 0 +0.290284 0.195090 0 +0.382683 0.195090 0 +0.00000 0.195090 0 +0.0980171 0.195090 0 +0.195090 0.195090 0 +0.00000 0.290284 0 +0.0980171 0.290284 0 +0.195090 0.290284 0 +0.00000 0.382683 0 +0.0980171 0.382683 0 +0.195090 0.382683 0 +0.195090 0.195090 0 +0.290284 0.195090 0 +0.382683 0.195090 0 +0.195090 0.290284 0 +0.290284 0.290284 0 +0.382683 0.290284 0 +0.195090 0.382683 0 +0.290284 0.382683 0 +0.382683 0.382683 0 +0.382683 0.00000 0 +0.471396 0.00000 0 +0.555570 0.00000 0 +0.382683 0.0980171 0 +0.471396 0.0980171 0 +0.555570 0.0980171 0 +0.382683 0.195090 0 +0.471396 0.195090 0 +0.555570 0.195090 0 +0.555570 0.00000 0 +0.634393 0.00000 0 +0.707107 0.00000 0 +0.555570 0.0980171 0 +0.634393 0.0980171 0 +0.707107 0.0980171 0 +0.555570 0.195090 0 +0.634393 0.195090 0 +0.707107 0.195090 0 +0.382683 0.195090 0 +0.471396 0.195090 0 +0.555570 0.195090 0 +0.382683 0.290284 0 +0.471396 0.290284 0 +0.555570 0.290284 0 +0.382683 0.382683 0 +0.471396 0.382683 0 +0.555570 0.382683 0 +0.555570 0.195090 0 +0.634393 0.195090 0 +0.707107 0.195090 0 +0.555570 0.290284 0 +0.634393 0.290284 0 +0.707107 0.290284 0 +0.555570 0.382683 0 +0.634393 0.382683 0 +0.707107 0.382683 0 +0.707107 0.00000 0 +0.773010 0.00000 0 +0.831470 0.00000 0 +0.707107 0.0980171 0 +0.773010 0.0980171 0 +0.831470 0.0980171 0 +0.707107 0.195090 0 +0.773010 0.195090 0 +0.831470 0.195090 0 +0.831470 0.00000 0 +0.881921 0.00000 0 +0.923880 0.00000 0 +0.831470 0.0980171 0 +0.881921 0.0980171 0 +0.923880 0.0980171 0 +0.831470 0.195090 0 +0.881921 0.195090 0 +0.923880 0.195090 0 +0.707107 0.195090 0 +0.773010 0.195090 0 +0.831470 0.195090 0 +0.707107 0.290284 0 +0.773010 0.290284 0 +0.831470 0.290284 0 +0.707107 0.382683 0 +0.773010 0.382683 0 +0.831470 0.382683 0 +0.831470 0.195090 0 +0.881921 0.195090 0 +0.923880 0.195090 0 +0.831470 0.290284 0 +0.881921 0.290284 0 +0.923880 0.290284 0 +0.831470 0.382683 0 +0.881921 0.382683 0 +0.923880 0.382683 0 +0.923880 0.00000 0 +0.956940 0.00000 0 +0.980785 0.00000 0 +0.923880 0.0980171 0 +0.956940 0.0980171 0 +0.980785 0.0980171 0 +0.923880 0.195090 0 +0.956940 0.195090 0 +0.980785 0.195090 0 +0.980785 0.00000 0 +0.995184 0.00000 0 +1.00000 0.00000 0 +0.980785 0.0980171 0 +0.995184 0.0980171 0 +1.00000 0.0980171 0 +0.980785 0.195090 0 +0.995184 0.195090 0 +1.00000 0.195090 0 +0.923880 0.195090 0 +0.956940 0.195090 0 +0.980785 0.195090 0 +0.923880 0.290284 0 +0.956940 0.290284 0 +0.980785 0.290284 0 +0.923880 0.382683 0 +0.956940 0.382683 0 +0.980785 0.382683 0 +0.980785 0.195090 0 +0.995184 0.195090 0 +1.00000 0.195090 0 +0.980785 0.290284 0 +0.995184 0.290284 0 +1.00000 0.290284 0 +0.980785 0.382683 0 +0.995184 0.382683 0 +1.00000 0.382683 0 +0.00000 0.382683 0 +0.0980171 0.382683 0 +0.195090 0.382683 0 +0.00000 0.471396 0 +0.0980171 0.471396 0 +0.195090 0.471396 0 +0.00000 0.555570 0 +0.0980171 0.555570 0 +0.195090 0.555570 0 +0.195090 0.382683 0 +0.290284 0.382683 0 +0.382683 0.382683 0 +0.195090 0.471396 0 +0.290284 0.471396 0 +0.382683 0.471396 0 +0.195090 0.555570 0 +0.290284 0.555570 0 +0.382683 0.555570 0 +0.00000 0.555570 0 +0.0980171 0.555570 0 +0.195090 0.555570 0 +0.00000 0.634393 0 +0.0980171 0.634393 0 +0.195090 0.634393 0 +0.00000 0.707107 0 +0.0980171 0.707107 0 +0.195090 0.707107 0 +0.195090 0.555570 0 +0.290284 0.555570 0 +0.382683 0.555570 0 +0.195090 0.634393 0 +0.290284 0.634393 0 +0.382683 0.634393 0 +0.195090 0.707107 0 +0.290284 0.707107 0 +0.382683 0.707107 0 +0.382683 0.382683 0 +0.471396 0.382683 0 +0.555570 0.382683 0 +0.382683 0.471396 0 +0.471396 0.471396 0 +0.555570 0.471396 0 +0.382683 0.555570 0 +0.471396 0.555570 0 +0.555570 0.555570 0 +0.555570 0.382683 0 +0.634393 0.382683 0 +0.707107 0.382683 0 +0.555570 0.471396 0 +0.634393 0.471396 0 +0.707107 0.471396 0 +0.555570 0.555570 0 +0.634393 0.555570 0 +0.707107 0.555570 0 +0.382683 0.555570 0 +0.471396 0.555570 0 +0.555570 0.555570 0 +0.382683 0.634393 0 +0.471396 0.634393 0 +0.555570 0.634393 0 +0.382683 0.707107 0 +0.471396 0.707107 0 +0.555570 0.707107 0 +0.555570 0.555570 0 +0.634393 0.555570 0 +0.707107 0.555570 0 +0.555570 0.634393 0 +0.634393 0.634393 0 +0.707107 0.634393 0 +0.555570 0.707107 0 +0.634393 0.707107 0 +0.707107 0.707107 0 +0.707107 0.382683 0 +0.773010 0.382683 0 +0.831470 0.382683 0 +0.707107 0.471396 0 +0.773010 0.471396 0 +0.831470 0.471396 0 +0.707107 0.555570 0 +0.773010 0.555570 0 +0.831470 0.555570 0 +0.831470 0.382683 0 +0.881921 0.382683 0 +0.923880 0.382683 0 +0.831470 0.471396 0 +0.881921 0.471396 0 +0.923880 0.471396 0 +0.831470 0.555570 0 +0.881921 0.555570 0 +0.923880 0.555570 0 +0.707107 0.555570 0 +0.773010 0.555570 0 +0.831470 0.555570 0 +0.707107 0.634393 0 +0.773010 0.634393 0 +0.831470 0.634393 0 +0.707107 0.707107 0 +0.773010 0.707107 0 +0.831470 0.707107 0 +0.831470 0.555570 0 +0.881921 0.555570 0 +0.923880 0.555570 0 +0.831470 0.634393 0 +0.881921 0.634393 0 +0.923880 0.634393 0 +0.831470 0.707107 0 +0.881921 0.707107 0 +0.923880 0.707107 0 +0.923880 0.382683 0 +0.956940 0.382683 0 +0.980785 0.382683 0 +0.923880 0.471396 0 +0.956940 0.471396 0 +0.980785 0.471396 0 +0.923880 0.555570 0 +0.956940 0.555570 0 +0.980785 0.555570 0 +0.980785 0.382683 0 +0.995184 0.382683 0 +1.00000 0.382683 0 +0.980785 0.471396 0 +0.995184 0.471396 0 +1.00000 0.471396 0 +0.980785 0.555570 0 +0.995184 0.555570 0 +1.00000 0.555570 0 +0.923880 0.555570 0 +0.956940 0.555570 0 +0.980785 0.555570 0 +0.923880 0.634393 0 +0.956940 0.634393 0 +0.980785 0.634393 0 +0.923880 0.707107 0 +0.956940 0.707107 0 +0.980785 0.707107 0 +0.980785 0.555570 0 +0.995184 0.555570 0 +1.00000 0.555570 0 +0.980785 0.634393 0 +0.995184 0.634393 0 +1.00000 0.634393 0 +0.980785 0.707107 0 +0.995184 0.707107 0 +1.00000 0.707107 0 +0.00000 0.707107 0 +0.0980171 0.707107 0 +0.195090 0.707107 0 +0.00000 0.773010 0 +0.0980171 0.773010 0 +0.195090 0.773010 0 +0.00000 0.831470 0 +0.0980171 0.831470 0 +0.195090 0.831470 0 +0.195090 0.707107 0 +0.290284 0.707107 0 +0.382683 0.707107 0 +0.195090 0.773010 0 +0.290284 0.773010 0 +0.382683 0.773010 0 +0.195090 0.831470 0 +0.290284 0.831470 0 +0.382683 0.831470 0 +0.00000 0.831470 0 +0.0980171 0.831470 0 +0.195090 0.831470 0 +0.00000 0.881921 0 +0.0980171 0.881921 0 +0.195090 0.881921 0 +0.00000 0.923880 0 +0.0980171 0.923880 0 +0.195090 0.923880 0 +0.195090 0.831470 0 +0.290284 0.831470 0 +0.382683 0.831470 0 +0.195090 0.881921 0 +0.290284 0.881921 0 +0.382683 0.881921 0 +0.195090 0.923880 0 +0.290284 0.923880 0 +0.382683 0.923880 0 +0.382683 0.707107 0 +0.471396 0.707107 0 +0.555570 0.707107 0 +0.382683 0.773010 0 +0.471396 0.773010 0 +0.555570 0.773010 0 +0.382683 0.831470 0 +0.471396 0.831470 0 +0.555570 0.831470 0 +0.555570 0.707107 0 +0.634393 0.707107 0 +0.707107 0.707107 0 +0.555570 0.773010 0 +0.634393 0.773010 0 +0.707107 0.773010 0 +0.555570 0.831470 0 +0.634393 0.831470 0 +0.707107 0.831470 0 +0.382683 0.831470 0 +0.471396 0.831470 0 +0.555570 0.831470 0 +0.382683 0.881921 0 +0.471396 0.881921 0 +0.555570 0.881921 0 +0.382683 0.923880 0 +0.471396 0.923880 0 +0.555570 0.923880 0 +0.555570 0.831470 0 +0.634393 0.831470 0 +0.707107 0.831470 0 +0.555570 0.881921 0 +0.634393 0.881921 0 +0.707107 0.881921 0 +0.555570 0.923880 0 +0.634393 0.923880 0 +0.707107 0.923880 0 +0.707107 0.707107 0 +0.773010 0.707107 0 +0.831470 0.707107 0 +0.707107 0.773010 0 +0.773010 0.773010 0 +0.831470 0.773010 0 +0.707107 0.831470 0 +0.773010 0.831470 0 +0.831470 0.831470 0 +0.831470 0.707107 0 +0.881921 0.707107 0 +0.923880 0.707107 0 +0.831470 0.773010 0 +0.881921 0.773010 0 +0.923880 0.773010 0 +0.831470 0.831470 0 +0.881921 0.831470 0 +0.923880 0.831470 0 +0.707107 0.831470 0 +0.773010 0.831470 0 +0.831470 0.831470 0 +0.707107 0.881921 0 +0.773010 0.881921 0 +0.831470 0.881921 0 +0.707107 0.923880 0 +0.773010 0.923880 0 +0.831470 0.923880 0 +0.831470 0.831470 0 +0.881921 0.831470 0 +0.923880 0.831470 0 +0.831470 0.881921 0 +0.881921 0.881921 0 +0.923880 0.881921 0 +0.831470 0.923880 0 +0.881921 0.923880 0 +0.923880 0.923880 0 +0.923880 0.707107 0 +0.956940 0.707107 0 +0.980785 0.707107 0 +0.923880 0.773010 0 +0.956940 0.773010 0 +0.980785 0.773010 0 +0.923880 0.831470 0 +0.956940 0.831470 0 +0.980785 0.831470 0 +0.980785 0.707107 0 +0.995184 0.707107 0 +1.00000 0.707107 0 +0.980785 0.773010 0 +0.995184 0.773010 0 +1.00000 0.773010 0 +0.980785 0.831470 0 +0.995184 0.831470 0 +1.00000 0.831470 0 +0.923880 0.831470 0 +0.956940 0.831470 0 +0.980785 0.831470 0 +0.923880 0.881921 0 +0.956940 0.881921 0 +0.980785 0.881921 0 +0.923880 0.923880 0 +0.956940 0.923880 0 +0.980785 0.923880 0 +0.980785 0.831470 0 +0.995184 0.831470 0 +1.00000 0.831470 0 +0.980785 0.881921 0 +0.995184 0.881921 0 +1.00000 0.881921 0 +0.980785 0.923880 0 +0.995184 0.923880 0 +1.00000 0.923880 0 +0.00000 0.923880 0 +0.0980171 0.923880 0 +0.195090 0.923880 0 +0.00000 0.956940 0 +0.0980171 0.956940 0 +0.195090 0.956940 0 +0.00000 0.980785 0 +0.0980171 0.980785 0 +0.195090 0.980785 0 +0.195090 0.923880 0 +0.290284 0.923880 0 +0.382683 0.923880 0 +0.195090 0.956940 0 +0.290284 0.956940 0 +0.382683 0.956940 0 +0.195090 0.980785 0 +0.290284 0.980785 0 +0.382683 0.980785 0 +0.00000 0.980785 0 +0.0980171 0.980785 0 +0.195090 0.980785 0 +0.00000 0.995184 0 +0.0980171 0.995184 0 +0.195090 0.995184 0 +0.00000 1.00000 0 +0.0980171 1.00000 0 +0.195090 1.00000 0 +0.195090 0.980785 0 +0.290284 0.980785 0 +0.382683 0.980785 0 +0.195090 0.995184 0 +0.290284 0.995184 0 +0.382683 0.995184 0 +0.195090 1.00000 0 +0.290284 1.00000 0 +0.382683 1.00000 0 +0.382683 0.923880 0 +0.471396 0.923880 0 +0.555570 0.923880 0 +0.382683 0.956940 0 +0.471396 0.956940 0 +0.555570 0.956940 0 +0.382683 0.980785 0 +0.471396 0.980785 0 +0.555570 0.980785 0 +0.555570 0.923880 0 +0.634393 0.923880 0 +0.707107 0.923880 0 +0.555570 0.956940 0 +0.634393 0.956940 0 +0.707107 0.956940 0 +0.555570 0.980785 0 +0.634393 0.980785 0 +0.707107 0.980785 0 +0.382683 0.980785 0 +0.471396 0.980785 0 +0.555570 0.980785 0 +0.382683 0.995184 0 +0.471396 0.995184 0 +0.555570 0.995184 0 +0.382683 1.00000 0 +0.471396 1.00000 0 +0.555570 1.00000 0 +0.555570 0.980785 0 +0.634393 0.980785 0 +0.707107 0.980785 0 +0.555570 0.995184 0 +0.634393 0.995184 0 +0.707107 0.995184 0 +0.555570 1.00000 0 +0.634393 1.00000 0 +0.707107 1.00000 0 +0.707107 0.923880 0 +0.773010 0.923880 0 +0.831470 0.923880 0 +0.707107 0.956940 0 +0.773010 0.956940 0 +0.831470 0.956940 0 +0.707107 0.980785 0 +0.773010 0.980785 0 +0.831470 0.980785 0 +0.831470 0.923880 0 +0.881921 0.923880 0 +0.923880 0.923880 0 +0.831470 0.956940 0 +0.881921 0.956940 0 +0.923880 0.956940 0 +0.831470 0.980785 0 +0.881921 0.980785 0 +0.923880 0.980785 0 +0.707107 0.980785 0 +0.773010 0.980785 0 +0.831470 0.980785 0 +0.707107 0.995184 0 +0.773010 0.995184 0 +0.831470 0.995184 0 +0.707107 1.00000 0 +0.773010 1.00000 0 +0.831470 1.00000 0 +0.831470 0.980785 0 +0.881921 0.980785 0 +0.923880 0.980785 0 +0.831470 0.995184 0 +0.881921 0.995184 0 +0.923880 0.995184 0 +0.831470 1.00000 0 +0.881921 1.00000 0 +0.923880 1.00000 0 +0.923880 0.923880 0 +0.956940 0.923880 0 +0.980785 0.923880 0 +0.923880 0.956940 0 +0.956940 0.956940 0 +0.980785 0.956940 0 +0.923880 0.980785 0 +0.956940 0.980785 0 +0.980785 0.980785 0 +0.980785 0.923880 0 +0.995184 0.923880 0 +1.00000 0.923880 0 +0.980785 0.956940 0 +0.995184 0.956940 0 +1.00000 0.956940 0 +0.980785 0.980785 0 +0.995184 0.980785 0 +1.00000 0.980785 0 +0.923880 0.980785 0 +0.956940 0.980785 0 +0.980785 0.980785 0 +0.923880 0.995184 0 +0.956940 0.995184 0 +0.980785 0.995184 0 +0.923880 1.00000 0 +0.956940 1.00000 0 +0.980785 1.00000 0 +0.980785 0.980785 0 +0.995184 0.980785 0 +1.00000 0.980785 0 +0.980785 0.995184 0 +0.995184 0.995184 0 +1.00000 0.995184 0 +0.980785 1.00000 0 +0.995184 1.00000 0 +1.00000 1.00000 0 + +CELLS 64 640 +9 0 2 8 6 1 5 7 3 4 +9 9 11 17 15 10 14 16 12 13 +9 18 20 26 24 19 23 25 21 22 +9 27 29 35 33 28 32 34 30 31 +9 36 38 44 42 37 41 43 39 40 +9 45 47 53 51 46 50 52 48 49 +9 54 56 62 60 55 59 61 57 58 +9 63 65 71 69 64 68 70 66 67 +9 72 74 80 78 73 77 79 75 76 +9 81 83 89 87 82 86 88 84 85 +9 90 92 98 96 91 95 97 93 94 +9 99 101 107 105 100 104 106 102 103 +9 108 110 116 114 109 113 115 111 112 +9 117 119 125 123 118 122 124 120 121 +9 126 128 134 132 127 131 133 129 130 +9 135 137 143 141 136 140 142 138 139 +9 144 146 152 150 145 149 151 147 148 +9 153 155 161 159 154 158 160 156 157 +9 162 164 170 168 163 167 169 165 166 +9 171 173 179 177 172 176 178 174 175 +9 180 182 188 186 181 185 187 183 184 +9 189 191 197 195 190 194 196 192 193 +9 198 200 206 204 199 203 205 201 202 +9 207 209 215 213 208 212 214 210 211 +9 216 218 224 222 217 221 223 219 220 +9 225 227 233 231 226 230 232 228 229 +9 234 236 242 240 235 239 241 237 238 +9 243 245 251 249 244 248 250 246 247 +9 252 254 260 258 253 257 259 255 256 +9 261 263 269 267 262 266 268 264 265 +9 270 272 278 276 271 275 277 273 274 +9 279 281 287 285 280 284 286 282 283 +9 288 290 296 294 289 293 295 291 292 +9 297 299 305 303 298 302 304 300 301 +9 306 308 314 312 307 311 313 309 310 +9 315 317 323 321 316 320 322 318 319 +9 324 326 332 330 325 329 331 327 328 +9 333 335 341 339 334 338 340 336 337 +9 342 344 350 348 343 347 349 345 346 +9 351 353 359 357 352 356 358 354 355 +9 360 362 368 366 361 365 367 363 364 +9 369 371 377 375 370 374 376 372 373 +9 378 380 386 384 379 383 385 381 382 +9 387 389 395 393 388 392 394 390 391 +9 396 398 404 402 397 401 403 399 400 +9 405 407 413 411 406 410 412 408 409 +9 414 416 422 420 415 419 421 417 418 +9 423 425 431 429 424 428 430 426 427 +9 432 434 440 438 433 437 439 435 436 +9 441 443 449 447 442 446 448 444 445 +9 450 452 458 456 451 455 457 453 454 +9 459 461 467 465 460 464 466 462 463 +9 468 470 476 474 469 473 475 471 472 +9 477 479 485 483 478 482 484 480 481 +9 486 488 494 492 487 491 493 489 490 +9 495 497 503 501 496 500 502 498 499 +9 504 506 512 510 505 509 511 507 508 +9 513 515 521 519 514 518 520 516 517 +9 522 524 530 528 523 527 529 525 526 +9 531 533 539 537 532 536 538 534 535 +9 540 542 548 546 541 545 547 543 544 +9 549 551 557 555 550 554 556 552 553 +9 558 560 566 564 559 563 565 561 562 +9 567 569 575 573 568 572 574 570 571 + +CELL_TYPES 64 + 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 +POINT_DATA 576 +# vtk DataFile Version 3.0 +#This file was generated +ASCII +DATASET UNSTRUCTURED_GRID + +POINTS 576 double +0.00000 0.00000 0 +0.0980171 0.00000 0 +0.195090 0.00000 0 +0.00000 0.0980171 0 +0.0980171 0.0980171 0 +0.195090 0.0980171 0 +0.00000 0.195090 0 +0.0980171 0.195090 0 +0.195090 0.195090 0 +0.195090 0.00000 0 +0.290284 0.00000 0 +0.382683 0.00000 0 +0.195090 0.0980171 0 +0.290284 0.0980171 0 +0.382683 0.0980171 0 +0.195090 0.195090 0 +0.290284 0.195090 0 +0.382683 0.195090 0 +0.00000 0.195090 0 +0.0980171 0.195090 0 +0.195090 0.195090 0 +0.00000 0.290284 0 +0.0980171 0.290284 0 +0.195090 0.290284 0 +0.00000 0.382683 0 +0.0980171 0.382683 0 +0.195090 0.382683 0 +0.195090 0.195090 0 +0.290284 0.195090 0 +0.382683 0.195090 0 +0.195090 0.290284 0 +0.290284 0.290284 0 +0.382683 0.290284 0 +0.195090 0.382683 0 +0.290284 0.382683 0 +0.382683 0.382683 0 +0.382683 0.00000 0 +0.471396 0.00000 0 +0.555570 0.00000 0 +0.382683 0.0980171 0 +0.471396 0.0980171 0 +0.555570 0.0980171 0 +0.382683 0.195090 0 +0.471396 0.195090 0 +0.555570 0.195090 0 +0.555570 0.00000 0 +0.634393 0.00000 0 +0.707107 0.00000 0 +0.555570 0.0980171 0 +0.634393 0.0980171 0 +0.707107 0.0980171 0 +0.555570 0.195090 0 +0.634393 0.195090 0 +0.707107 0.195090 0 +0.382683 0.195090 0 +0.471396 0.195090 0 +0.555570 0.195090 0 +0.382683 0.290284 0 +0.471396 0.290284 0 +0.555570 0.290284 0 +0.382683 0.382683 0 +0.471396 0.382683 0 +0.555570 0.382683 0 +0.555570 0.195090 0 +0.634393 0.195090 0 +0.707107 0.195090 0 +0.555570 0.290284 0 +0.634393 0.290284 0 +0.707107 0.290284 0 +0.555570 0.382683 0 +0.634393 0.382683 0 +0.707107 0.382683 0 +0.707107 0.00000 0 +0.773010 0.00000 0 +0.831470 0.00000 0 +0.707107 0.0980171 0 +0.773010 0.0980171 0 +0.831470 0.0980171 0 +0.707107 0.195090 0 +0.773010 0.195090 0 +0.831470 0.195090 0 +0.831470 0.00000 0 +0.881921 0.00000 0 +0.923880 0.00000 0 +0.831470 0.0980171 0 +0.881921 0.0980171 0 +0.923880 0.0980171 0 +0.831470 0.195090 0 +0.881921 0.195090 0 +0.923880 0.195090 0 +0.707107 0.195090 0 +0.773010 0.195090 0 +0.831470 0.195090 0 +0.707107 0.290284 0 +0.773010 0.290284 0 +0.831470 0.290284 0 +0.707107 0.382683 0 +0.773010 0.382683 0 +0.831470 0.382683 0 +0.831470 0.195090 0 +0.881921 0.195090 0 +0.923880 0.195090 0 +0.831470 0.290284 0 +0.881921 0.290284 0 +0.923880 0.290284 0 +0.831470 0.382683 0 +0.881921 0.382683 0 +0.923880 0.382683 0 +0.923880 0.00000 0 +0.956940 0.00000 0 +0.980785 0.00000 0 +0.923880 0.0980171 0 +0.956940 0.0980171 0 +0.980785 0.0980171 0 +0.923880 0.195090 0 +0.956940 0.195090 0 +0.980785 0.195090 0 +0.980785 0.00000 0 +0.995184 0.00000 0 +1.00000 0.00000 0 +0.980785 0.0980171 0 +0.995184 0.0980171 0 +1.00000 0.0980171 0 +0.980785 0.195090 0 +0.995184 0.195090 0 +1.00000 0.195090 0 +0.923880 0.195090 0 +0.956940 0.195090 0 +0.980785 0.195090 0 +0.923880 0.290284 0 +0.956940 0.290284 0 +0.980785 0.290284 0 +0.923880 0.382683 0 +0.956940 0.382683 0 +0.980785 0.382683 0 +0.980785 0.195090 0 +0.995184 0.195090 0 +1.00000 0.195090 0 +0.980785 0.290284 0 +0.995184 0.290284 0 +1.00000 0.290284 0 +0.980785 0.382683 0 +0.995184 0.382683 0 +1.00000 0.382683 0 +0.00000 0.382683 0 +0.0980171 0.382683 0 +0.195090 0.382683 0 +0.00000 0.471396 0 +0.0980171 0.471396 0 +0.195090 0.471396 0 +0.00000 0.555570 0 +0.0980171 0.555570 0 +0.195090 0.555570 0 +0.195090 0.382683 0 +0.290284 0.382683 0 +0.382683 0.382683 0 +0.195090 0.471396 0 +0.290284 0.471396 0 +0.382683 0.471396 0 +0.195090 0.555570 0 +0.290284 0.555570 0 +0.382683 0.555570 0 +0.00000 0.555570 0 +0.0980171 0.555570 0 +0.195090 0.555570 0 +0.00000 0.634393 0 +0.0980171 0.634393 0 +0.195090 0.634393 0 +0.00000 0.707107 0 +0.0980171 0.707107 0 +0.195090 0.707107 0 +0.195090 0.555570 0 +0.290284 0.555570 0 +0.382683 0.555570 0 +0.195090 0.634393 0 +0.290284 0.634393 0 +0.382683 0.634393 0 +0.195090 0.707107 0 +0.290284 0.707107 0 +0.382683 0.707107 0 +0.382683 0.382683 0 +0.471396 0.382683 0 +0.555570 0.382683 0 +0.382683 0.471396 0 +0.471396 0.471396 0 +0.555570 0.471396 0 +0.382683 0.555570 0 +0.471396 0.555570 0 +0.555570 0.555570 0 +0.555570 0.382683 0 +0.634393 0.382683 0 +0.707107 0.382683 0 +0.555570 0.471396 0 +0.634393 0.471396 0 +0.707107 0.471396 0 +0.555570 0.555570 0 +0.634393 0.555570 0 +0.707107 0.555570 0 +0.382683 0.555570 0 +0.471396 0.555570 0 +0.555570 0.555570 0 +0.382683 0.634393 0 +0.471396 0.634393 0 +0.555570 0.634393 0 +0.382683 0.707107 0 +0.471396 0.707107 0 +0.555570 0.707107 0 +0.555570 0.555570 0 +0.634393 0.555570 0 +0.707107 0.555570 0 +0.555570 0.634393 0 +0.634393 0.634393 0 +0.707107 0.634393 0 +0.555570 0.707107 0 +0.634393 0.707107 0 +0.707107 0.707107 0 +0.707107 0.382683 0 +0.773010 0.382683 0 +0.831470 0.382683 0 +0.707107 0.471396 0 +0.773010 0.471396 0 +0.831470 0.471396 0 +0.707107 0.555570 0 +0.773010 0.555570 0 +0.831470 0.555570 0 +0.831470 0.382683 0 +0.881921 0.382683 0 +0.923880 0.382683 0 +0.831470 0.471396 0 +0.881921 0.471396 0 +0.923880 0.471396 0 +0.831470 0.555570 0 +0.881921 0.555570 0 +0.923880 0.555570 0 +0.707107 0.555570 0 +0.773010 0.555570 0 +0.831470 0.555570 0 +0.707107 0.634393 0 +0.773010 0.634393 0 +0.831470 0.634393 0 +0.707107 0.707107 0 +0.773010 0.707107 0 +0.831470 0.707107 0 +0.831470 0.555570 0 +0.881921 0.555570 0 +0.923880 0.555570 0 +0.831470 0.634393 0 +0.881921 0.634393 0 +0.923880 0.634393 0 +0.831470 0.707107 0 +0.881921 0.707107 0 +0.923880 0.707107 0 +0.923880 0.382683 0 +0.956940 0.382683 0 +0.980785 0.382683 0 +0.923880 0.471396 0 +0.956940 0.471396 0 +0.980785 0.471396 0 +0.923880 0.555570 0 +0.956940 0.555570 0 +0.980785 0.555570 0 +0.980785 0.382683 0 +0.995184 0.382683 0 +1.00000 0.382683 0 +0.980785 0.471396 0 +0.995184 0.471396 0 +1.00000 0.471396 0 +0.980785 0.555570 0 +0.995184 0.555570 0 +1.00000 0.555570 0 +0.923880 0.555570 0 +0.956940 0.555570 0 +0.980785 0.555570 0 +0.923880 0.634393 0 +0.956940 0.634393 0 +0.980785 0.634393 0 +0.923880 0.707107 0 +0.956940 0.707107 0 +0.980785 0.707107 0 +0.980785 0.555570 0 +0.995184 0.555570 0 +1.00000 0.555570 0 +0.980785 0.634393 0 +0.995184 0.634393 0 +1.00000 0.634393 0 +0.980785 0.707107 0 +0.995184 0.707107 0 +1.00000 0.707107 0 +0.00000 0.707107 0 +0.0980171 0.707107 0 +0.195090 0.707107 0 +0.00000 0.773010 0 +0.0980171 0.773010 0 +0.195090 0.773010 0 +0.00000 0.831470 0 +0.0980171 0.831470 0 +0.195090 0.831470 0 +0.195090 0.707107 0 +0.290284 0.707107 0 +0.382683 0.707107 0 +0.195090 0.773010 0 +0.290284 0.773010 0 +0.382683 0.773010 0 +0.195090 0.831470 0 +0.290284 0.831470 0 +0.382683 0.831470 0 +0.00000 0.831470 0 +0.0980171 0.831470 0 +0.195090 0.831470 0 +0.00000 0.881921 0 +0.0980171 0.881921 0 +0.195090 0.881921 0 +0.00000 0.923880 0 +0.0980171 0.923880 0 +0.195090 0.923880 0 +0.195090 0.831470 0 +0.290284 0.831470 0 +0.382683 0.831470 0 +0.195090 0.881921 0 +0.290284 0.881921 0 +0.382683 0.881921 0 +0.195090 0.923880 0 +0.290284 0.923880 0 +0.382683 0.923880 0 +0.382683 0.707107 0 +0.471396 0.707107 0 +0.555570 0.707107 0 +0.382683 0.773010 0 +0.471396 0.773010 0 +0.555570 0.773010 0 +0.382683 0.831470 0 +0.471396 0.831470 0 +0.555570 0.831470 0 +0.555570 0.707107 0 +0.634393 0.707107 0 +0.707107 0.707107 0 +0.555570 0.773010 0 +0.634393 0.773010 0 +0.707107 0.773010 0 +0.555570 0.831470 0 +0.634393 0.831470 0 +0.707107 0.831470 0 +0.382683 0.831470 0 +0.471396 0.831470 0 +0.555570 0.831470 0 +0.382683 0.881921 0 +0.471396 0.881921 0 +0.555570 0.881921 0 +0.382683 0.923880 0 +0.471396 0.923880 0 +0.555570 0.923880 0 +0.555570 0.831470 0 +0.634393 0.831470 0 +0.707107 0.831470 0 +0.555570 0.881921 0 +0.634393 0.881921 0 +0.707107 0.881921 0 +0.555570 0.923880 0 +0.634393 0.923880 0 +0.707107 0.923880 0 +0.707107 0.707107 0 +0.773010 0.707107 0 +0.831470 0.707107 0 +0.707107 0.773010 0 +0.773010 0.773010 0 +0.831470 0.773010 0 +0.707107 0.831470 0 +0.773010 0.831470 0 +0.831470 0.831470 0 +0.831470 0.707107 0 +0.881921 0.707107 0 +0.923880 0.707107 0 +0.831470 0.773010 0 +0.881921 0.773010 0 +0.923880 0.773010 0 +0.831470 0.831470 0 +0.881921 0.831470 0 +0.923880 0.831470 0 +0.707107 0.831470 0 +0.773010 0.831470 0 +0.831470 0.831470 0 +0.707107 0.881921 0 +0.773010 0.881921 0 +0.831470 0.881921 0 +0.707107 0.923880 0 +0.773010 0.923880 0 +0.831470 0.923880 0 +0.831470 0.831470 0 +0.881921 0.831470 0 +0.923880 0.831470 0 +0.831470 0.881921 0 +0.881921 0.881921 0 +0.923880 0.881921 0 +0.831470 0.923880 0 +0.881921 0.923880 0 +0.923880 0.923880 0 +0.923880 0.707107 0 +0.956940 0.707107 0 +0.980785 0.707107 0 +0.923880 0.773010 0 +0.956940 0.773010 0 +0.980785 0.773010 0 +0.923880 0.831470 0 +0.956940 0.831470 0 +0.980785 0.831470 0 +0.980785 0.707107 0 +0.995184 0.707107 0 +1.00000 0.707107 0 +0.980785 0.773010 0 +0.995184 0.773010 0 +1.00000 0.773010 0 +0.980785 0.831470 0 +0.995184 0.831470 0 +1.00000 0.831470 0 +0.923880 0.831470 0 +0.956940 0.831470 0 +0.980785 0.831470 0 +0.923880 0.881921 0 +0.956940 0.881921 0 +0.980785 0.881921 0 +0.923880 0.923880 0 +0.956940 0.923880 0 +0.980785 0.923880 0 +0.980785 0.831470 0 +0.995184 0.831470 0 +1.00000 0.831470 0 +0.980785 0.881921 0 +0.995184 0.881921 0 +1.00000 0.881921 0 +0.980785 0.923880 0 +0.995184 0.923880 0 +1.00000 0.923880 0 +0.00000 0.923880 0 +0.0980171 0.923880 0 +0.195090 0.923880 0 +0.00000 0.956940 0 +0.0980171 0.956940 0 +0.195090 0.956940 0 +0.00000 0.980785 0 +0.0980171 0.980785 0 +0.195090 0.980785 0 +0.195090 0.923880 0 +0.290284 0.923880 0 +0.382683 0.923880 0 +0.195090 0.956940 0 +0.290284 0.956940 0 +0.382683 0.956940 0 +0.195090 0.980785 0 +0.290284 0.980785 0 +0.382683 0.980785 0 +0.00000 0.980785 0 +0.0980171 0.980785 0 +0.195090 0.980785 0 +0.00000 0.995184 0 +0.0980171 0.995184 0 +0.195090 0.995184 0 +0.00000 1.00000 0 +0.0980171 1.00000 0 +0.195090 1.00000 0 +0.195090 0.980785 0 +0.290284 0.980785 0 +0.382683 0.980785 0 +0.195090 0.995184 0 +0.290284 0.995184 0 +0.382683 0.995184 0 +0.195090 1.00000 0 +0.290284 1.00000 0 +0.382683 1.00000 0 +0.382683 0.923880 0 +0.471396 0.923880 0 +0.555570 0.923880 0 +0.382683 0.956940 0 +0.471396 0.956940 0 +0.555570 0.956940 0 +0.382683 0.980785 0 +0.471396 0.980785 0 +0.555570 0.980785 0 +0.555570 0.923880 0 +0.634393 0.923880 0 +0.707107 0.923880 0 +0.555570 0.956940 0 +0.634393 0.956940 0 +0.707107 0.956940 0 +0.555570 0.980785 0 +0.634393 0.980785 0 +0.707107 0.980785 0 +0.382683 0.980785 0 +0.471396 0.980785 0 +0.555570 0.980785 0 +0.382683 0.995184 0 +0.471396 0.995184 0 +0.555570 0.995184 0 +0.382683 1.00000 0 +0.471396 1.00000 0 +0.555570 1.00000 0 +0.555570 0.980785 0 +0.634393 0.980785 0 +0.707107 0.980785 0 +0.555570 0.995184 0 +0.634393 0.995184 0 +0.707107 0.995184 0 +0.555570 1.00000 0 +0.634393 1.00000 0 +0.707107 1.00000 0 +0.707107 0.923880 0 +0.773010 0.923880 0 +0.831470 0.923880 0 +0.707107 0.956940 0 +0.773010 0.956940 0 +0.831470 0.956940 0 +0.707107 0.980785 0 +0.773010 0.980785 0 +0.831470 0.980785 0 +0.831470 0.923880 0 +0.881921 0.923880 0 +0.923880 0.923880 0 +0.831470 0.956940 0 +0.881921 0.956940 0 +0.923880 0.956940 0 +0.831470 0.980785 0 +0.881921 0.980785 0 +0.923880 0.980785 0 +0.707107 0.980785 0 +0.773010 0.980785 0 +0.831470 0.980785 0 +0.707107 0.995184 0 +0.773010 0.995184 0 +0.831470 0.995184 0 +0.707107 1.00000 0 +0.773010 1.00000 0 +0.831470 1.00000 0 +0.831470 0.980785 0 +0.881921 0.980785 0 +0.923880 0.980785 0 +0.831470 0.995184 0 +0.881921 0.995184 0 +0.923880 0.995184 0 +0.831470 1.00000 0 +0.881921 1.00000 0 +0.923880 1.00000 0 +0.923880 0.923880 0 +0.956940 0.923880 0 +0.980785 0.923880 0 +0.923880 0.956940 0 +0.956940 0.956940 0 +0.980785 0.956940 0 +0.923880 0.980785 0 +0.956940 0.980785 0 +0.980785 0.980785 0 +0.980785 0.923880 0 +0.995184 0.923880 0 +1.00000 0.923880 0 +0.980785 0.956940 0 +0.995184 0.956940 0 +1.00000 0.956940 0 +0.980785 0.980785 0 +0.995184 0.980785 0 +1.00000 0.980785 0 +0.923880 0.980785 0 +0.956940 0.980785 0 +0.980785 0.980785 0 +0.923880 0.995184 0 +0.956940 0.995184 0 +0.980785 0.995184 0 +0.923880 1.00000 0 +0.956940 1.00000 0 +0.980785 1.00000 0 +0.980785 0.980785 0 +0.995184 0.980785 0 +1.00000 0.980785 0 +0.980785 0.995184 0 +0.995184 0.995184 0 +1.00000 0.995184 0 +0.980785 1.00000 0 +0.995184 1.00000 0 +1.00000 1.00000 0 + +CELLS 64 640 +9 0 2 8 6 1 5 7 3 4 +9 9 11 17 15 10 14 16 12 13 +9 18 20 26 24 19 23 25 21 22 +9 27 29 35 33 28 32 34 30 31 +9 36 38 44 42 37 41 43 39 40 +9 45 47 53 51 46 50 52 48 49 +9 54 56 62 60 55 59 61 57 58 +9 63 65 71 69 64 68 70 66 67 +9 72 74 80 78 73 77 79 75 76 +9 81 83 89 87 82 86 88 84 85 +9 90 92 98 96 91 95 97 93 94 +9 99 101 107 105 100 104 106 102 103 +9 108 110 116 114 109 113 115 111 112 +9 117 119 125 123 118 122 124 120 121 +9 126 128 134 132 127 131 133 129 130 +9 135 137 143 141 136 140 142 138 139 +9 144 146 152 150 145 149 151 147 148 +9 153 155 161 159 154 158 160 156 157 +9 162 164 170 168 163 167 169 165 166 +9 171 173 179 177 172 176 178 174 175 +9 180 182 188 186 181 185 187 183 184 +9 189 191 197 195 190 194 196 192 193 +9 198 200 206 204 199 203 205 201 202 +9 207 209 215 213 208 212 214 210 211 +9 216 218 224 222 217 221 223 219 220 +9 225 227 233 231 226 230 232 228 229 +9 234 236 242 240 235 239 241 237 238 +9 243 245 251 249 244 248 250 246 247 +9 252 254 260 258 253 257 259 255 256 +9 261 263 269 267 262 266 268 264 265 +9 270 272 278 276 271 275 277 273 274 +9 279 281 287 285 280 284 286 282 283 +9 288 290 296 294 289 293 295 291 292 +9 297 299 305 303 298 302 304 300 301 +9 306 308 314 312 307 311 313 309 310 +9 315 317 323 321 316 320 322 318 319 +9 324 326 332 330 325 329 331 327 328 +9 333 335 341 339 334 338 340 336 337 +9 342 344 350 348 343 347 349 345 346 +9 351 353 359 357 352 356 358 354 355 +9 360 362 368 366 361 365 367 363 364 +9 369 371 377 375 370 374 376 372 373 +9 378 380 386 384 379 383 385 381 382 +9 387 389 395 393 388 392 394 390 391 +9 396 398 404 402 397 401 403 399 400 +9 405 407 413 411 406 410 412 408 409 +9 414 416 422 420 415 419 421 417 418 +9 423 425 431 429 424 428 430 426 427 +9 432 434 440 438 433 437 439 435 436 +9 441 443 449 447 442 446 448 444 445 +9 450 452 458 456 451 455 457 453 454 +9 459 461 467 465 460 464 466 462 463 +9 468 470 476 474 469 473 475 471 472 +9 477 479 485 483 478 482 484 480 481 +9 486 488 494 492 487 491 493 489 490 +9 495 497 503 501 496 500 502 498 499 +9 504 506 512 510 505 509 511 507 508 +9 513 515 521 519 514 518 520 516 517 +9 522 524 530 528 523 527 529 525 526 +9 531 533 539 537 532 536 538 534 535 +9 540 542 548 546 541 545 547 543 544 +9 549 551 557 555 550 554 556 552 553 +9 558 560 566 564 559 563 565 561 562 +9 567 569 575 573 568 572 574 570 571 + +CELL_TYPES 64 + 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 +POINT_DATA 576 +# vtk DataFile Version 3.0 +#This file was generated +ASCII +DATASET UNSTRUCTURED_GRID + +POINTS 576 double +0.00000 0.00000 0 +0.0980171 0.00000 0 +0.195090 0.00000 0 +0.00000 0.0980171 0 +0.0980171 0.0980171 0 +0.195090 0.0980171 0 +0.00000 0.195090 0 +0.0980171 0.195090 0 +0.195090 0.195090 0 +0.195090 0.00000 0 +0.290284 0.00000 0 +0.382683 0.00000 0 +0.195090 0.0980171 0 +0.290284 0.0980171 0 +0.382683 0.0980171 0 +0.195090 0.195090 0 +0.290284 0.195090 0 +0.382683 0.195090 0 +0.00000 0.195090 0 +0.0980171 0.195090 0 +0.195090 0.195090 0 +0.00000 0.290284 0 +0.0980171 0.290284 0 +0.195090 0.290284 0 +0.00000 0.382683 0 +0.0980171 0.382683 0 +0.195090 0.382683 0 +0.195090 0.195090 0 +0.290284 0.195090 0 +0.382683 0.195090 0 +0.195090 0.290284 0 +0.290284 0.290284 0 +0.382683 0.290284 0 +0.195090 0.382683 0 +0.290284 0.382683 0 +0.382683 0.382683 0 +0.382683 0.00000 0 +0.471396 0.00000 0 +0.555570 0.00000 0 +0.382683 0.0980171 0 +0.471396 0.0980171 0 +0.555570 0.0980171 0 +0.382683 0.195090 0 +0.471396 0.195090 0 +0.555570 0.195090 0 +0.555570 0.00000 0 +0.634393 0.00000 0 +0.707107 0.00000 0 +0.555570 0.0980171 0 +0.634393 0.0980171 0 +0.707107 0.0980171 0 +0.555570 0.195090 0 +0.634393 0.195090 0 +0.707107 0.195090 0 +0.382683 0.195090 0 +0.471396 0.195090 0 +0.555570 0.195090 0 +0.382683 0.290284 0 +0.471396 0.290284 0 +0.555570 0.290284 0 +0.382683 0.382683 0 +0.471396 0.382683 0 +0.555570 0.382683 0 +0.555570 0.195090 0 +0.634393 0.195090 0 +0.707107 0.195090 0 +0.555570 0.290284 0 +0.634393 0.290284 0 +0.707107 0.290284 0 +0.555570 0.382683 0 +0.634393 0.382683 0 +0.707107 0.382683 0 +0.707107 0.00000 0 +0.773010 0.00000 0 +0.831470 0.00000 0 +0.707107 0.0980171 0 +0.773010 0.0980171 0 +0.831470 0.0980171 0 +0.707107 0.195090 0 +0.773010 0.195090 0 +0.831470 0.195090 0 +0.831470 0.00000 0 +0.881921 0.00000 0 +0.923880 0.00000 0 +0.831470 0.0980171 0 +0.881921 0.0980171 0 +0.923880 0.0980171 0 +0.831470 0.195090 0 +0.881921 0.195090 0 +0.923880 0.195090 0 +0.707107 0.195090 0 +0.773010 0.195090 0 +0.831470 0.195090 0 +0.707107 0.290284 0 +0.773010 0.290284 0 +0.831470 0.290284 0 +0.707107 0.382683 0 +0.773010 0.382683 0 +0.831470 0.382683 0 +0.831470 0.195090 0 +0.881921 0.195090 0 +0.923880 0.195090 0 +0.831470 0.290284 0 +0.881921 0.290284 0 +0.923880 0.290284 0 +0.831470 0.382683 0 +0.881921 0.382683 0 +0.923880 0.382683 0 +0.923880 0.00000 0 +0.956940 0.00000 0 +0.980785 0.00000 0 +0.923880 0.0980171 0 +0.956940 0.0980171 0 +0.980785 0.0980171 0 +0.923880 0.195090 0 +0.956940 0.195090 0 +0.980785 0.195090 0 +0.980785 0.00000 0 +0.995184 0.00000 0 +1.00000 0.00000 0 +0.980785 0.0980171 0 +0.995184 0.0980171 0 +1.00000 0.0980171 0 +0.980785 0.195090 0 +0.995184 0.195090 0 +1.00000 0.195090 0 +0.923880 0.195090 0 +0.956940 0.195090 0 +0.980785 0.195090 0 +0.923880 0.290284 0 +0.956940 0.290284 0 +0.980785 0.290284 0 +0.923880 0.382683 0 +0.956940 0.382683 0 +0.980785 0.382683 0 +0.980785 0.195090 0 +0.995184 0.195090 0 +1.00000 0.195090 0 +0.980785 0.290284 0 +0.995184 0.290284 0 +1.00000 0.290284 0 +0.980785 0.382683 0 +0.995184 0.382683 0 +1.00000 0.382683 0 +0.00000 0.382683 0 +0.0980171 0.382683 0 +0.195090 0.382683 0 +0.00000 0.471396 0 +0.0980171 0.471396 0 +0.195090 0.471396 0 +0.00000 0.555570 0 +0.0980171 0.555570 0 +0.195090 0.555570 0 +0.195090 0.382683 0 +0.290284 0.382683 0 +0.382683 0.382683 0 +0.195090 0.471396 0 +0.290284 0.471396 0 +0.382683 0.471396 0 +0.195090 0.555570 0 +0.290284 0.555570 0 +0.382683 0.555570 0 +0.00000 0.555570 0 +0.0980171 0.555570 0 +0.195090 0.555570 0 +0.00000 0.634393 0 +0.0980171 0.634393 0 +0.195090 0.634393 0 +0.00000 0.707107 0 +0.0980171 0.707107 0 +0.195090 0.707107 0 +0.195090 0.555570 0 +0.290284 0.555570 0 +0.382683 0.555570 0 +0.195090 0.634393 0 +0.290284 0.634393 0 +0.382683 0.634393 0 +0.195090 0.707107 0 +0.290284 0.707107 0 +0.382683 0.707107 0 +0.382683 0.382683 0 +0.471396 0.382683 0 +0.555570 0.382683 0 +0.382683 0.471396 0 +0.471396 0.471396 0 +0.555570 0.471396 0 +0.382683 0.555570 0 +0.471396 0.555570 0 +0.555570 0.555570 0 +0.555570 0.382683 0 +0.634393 0.382683 0 +0.707107 0.382683 0 +0.555570 0.471396 0 +0.634393 0.471396 0 +0.707107 0.471396 0 +0.555570 0.555570 0 +0.634393 0.555570 0 +0.707107 0.555570 0 +0.382683 0.555570 0 +0.471396 0.555570 0 +0.555570 0.555570 0 +0.382683 0.634393 0 +0.471396 0.634393 0 +0.555570 0.634393 0 +0.382683 0.707107 0 +0.471396 0.707107 0 +0.555570 0.707107 0 +0.555570 0.555570 0 +0.634393 0.555570 0 +0.707107 0.555570 0 +0.555570 0.634393 0 +0.634393 0.634393 0 +0.707107 0.634393 0 +0.555570 0.707107 0 +0.634393 0.707107 0 +0.707107 0.707107 0 +0.707107 0.382683 0 +0.773010 0.382683 0 +0.831470 0.382683 0 +0.707107 0.471396 0 +0.773010 0.471396 0 +0.831470 0.471396 0 +0.707107 0.555570 0 +0.773010 0.555570 0 +0.831470 0.555570 0 +0.831470 0.382683 0 +0.881921 0.382683 0 +0.923880 0.382683 0 +0.831470 0.471396 0 +0.881921 0.471396 0 +0.923880 0.471396 0 +0.831470 0.555570 0 +0.881921 0.555570 0 +0.923880 0.555570 0 +0.707107 0.555570 0 +0.773010 0.555570 0 +0.831470 0.555570 0 +0.707107 0.634393 0 +0.773010 0.634393 0 +0.831470 0.634393 0 +0.707107 0.707107 0 +0.773010 0.707107 0 +0.831470 0.707107 0 +0.831470 0.555570 0 +0.881921 0.555570 0 +0.923880 0.555570 0 +0.831470 0.634393 0 +0.881921 0.634393 0 +0.923880 0.634393 0 +0.831470 0.707107 0 +0.881921 0.707107 0 +0.923880 0.707107 0 +0.923880 0.382683 0 +0.956940 0.382683 0 +0.980785 0.382683 0 +0.923880 0.471396 0 +0.956940 0.471396 0 +0.980785 0.471396 0 +0.923880 0.555570 0 +0.956940 0.555570 0 +0.980785 0.555570 0 +0.980785 0.382683 0 +0.995184 0.382683 0 +1.00000 0.382683 0 +0.980785 0.471396 0 +0.995184 0.471396 0 +1.00000 0.471396 0 +0.980785 0.555570 0 +0.995184 0.555570 0 +1.00000 0.555570 0 +0.923880 0.555570 0 +0.956940 0.555570 0 +0.980785 0.555570 0 +0.923880 0.634393 0 +0.956940 0.634393 0 +0.980785 0.634393 0 +0.923880 0.707107 0 +0.956940 0.707107 0 +0.980785 0.707107 0 +0.980785 0.555570 0 +0.995184 0.555570 0 +1.00000 0.555570 0 +0.980785 0.634393 0 +0.995184 0.634393 0 +1.00000 0.634393 0 +0.980785 0.707107 0 +0.995184 0.707107 0 +1.00000 0.707107 0 +0.00000 0.707107 0 +0.0980171 0.707107 0 +0.195090 0.707107 0 +0.00000 0.773010 0 +0.0980171 0.773010 0 +0.195090 0.773010 0 +0.00000 0.831470 0 +0.0980171 0.831470 0 +0.195090 0.831470 0 +0.195090 0.707107 0 +0.290284 0.707107 0 +0.382683 0.707107 0 +0.195090 0.773010 0 +0.290284 0.773010 0 +0.382683 0.773010 0 +0.195090 0.831470 0 +0.290284 0.831470 0 +0.382683 0.831470 0 +0.00000 0.831470 0 +0.0980171 0.831470 0 +0.195090 0.831470 0 +0.00000 0.881921 0 +0.0980171 0.881921 0 +0.195090 0.881921 0 +0.00000 0.923880 0 +0.0980171 0.923880 0 +0.195090 0.923880 0 +0.195090 0.831470 0 +0.290284 0.831470 0 +0.382683 0.831470 0 +0.195090 0.881921 0 +0.290284 0.881921 0 +0.382683 0.881921 0 +0.195090 0.923880 0 +0.290284 0.923880 0 +0.382683 0.923880 0 +0.382683 0.707107 0 +0.471396 0.707107 0 +0.555570 0.707107 0 +0.382683 0.773010 0 +0.471396 0.773010 0 +0.555570 0.773010 0 +0.382683 0.831470 0 +0.471396 0.831470 0 +0.555570 0.831470 0 +0.555570 0.707107 0 +0.634393 0.707107 0 +0.707107 0.707107 0 +0.555570 0.773010 0 +0.634393 0.773010 0 +0.707107 0.773010 0 +0.555570 0.831470 0 +0.634393 0.831470 0 +0.707107 0.831470 0 +0.382683 0.831470 0 +0.471396 0.831470 0 +0.555570 0.831470 0 +0.382683 0.881921 0 +0.471396 0.881921 0 +0.555570 0.881921 0 +0.382683 0.923880 0 +0.471396 0.923880 0 +0.555570 0.923880 0 +0.555570 0.831470 0 +0.634393 0.831470 0 +0.707107 0.831470 0 +0.555570 0.881921 0 +0.634393 0.881921 0 +0.707107 0.881921 0 +0.555570 0.923880 0 +0.634393 0.923880 0 +0.707107 0.923880 0 +0.707107 0.707107 0 +0.773010 0.707107 0 +0.831470 0.707107 0 +0.707107 0.773010 0 +0.773010 0.773010 0 +0.831470 0.773010 0 +0.707107 0.831470 0 +0.773010 0.831470 0 +0.831470 0.831470 0 +0.831470 0.707107 0 +0.881921 0.707107 0 +0.923880 0.707107 0 +0.831470 0.773010 0 +0.881921 0.773010 0 +0.923880 0.773010 0 +0.831470 0.831470 0 +0.881921 0.831470 0 +0.923880 0.831470 0 +0.707107 0.831470 0 +0.773010 0.831470 0 +0.831470 0.831470 0 +0.707107 0.881921 0 +0.773010 0.881921 0 +0.831470 0.881921 0 +0.707107 0.923880 0 +0.773010 0.923880 0 +0.831470 0.923880 0 +0.831470 0.831470 0 +0.881921 0.831470 0 +0.923880 0.831470 0 +0.831470 0.881921 0 +0.881921 0.881921 0 +0.923880 0.881921 0 +0.831470 0.923880 0 +0.881921 0.923880 0 +0.923880 0.923880 0 +0.923880 0.707107 0 +0.956940 0.707107 0 +0.980785 0.707107 0 +0.923880 0.773010 0 +0.956940 0.773010 0 +0.980785 0.773010 0 +0.923880 0.831470 0 +0.956940 0.831470 0 +0.980785 0.831470 0 +0.980785 0.707107 0 +0.995184 0.707107 0 +1.00000 0.707107 0 +0.980785 0.773010 0 +0.995184 0.773010 0 +1.00000 0.773010 0 +0.980785 0.831470 0 +0.995184 0.831470 0 +1.00000 0.831470 0 +0.923880 0.831470 0 +0.956940 0.831470 0 +0.980785 0.831470 0 +0.923880 0.881921 0 +0.956940 0.881921 0 +0.980785 0.881921 0 +0.923880 0.923880 0 +0.956940 0.923880 0 +0.980785 0.923880 0 +0.980785 0.831470 0 +0.995184 0.831470 0 +1.00000 0.831470 0 +0.980785 0.881921 0 +0.995184 0.881921 0 +1.00000 0.881921 0 +0.980785 0.923880 0 +0.995184 0.923880 0 +1.00000 0.923880 0 +0.00000 0.923880 0 +0.0980171 0.923880 0 +0.195090 0.923880 0 +0.00000 0.956940 0 +0.0980171 0.956940 0 +0.195090 0.956940 0 +0.00000 0.980785 0 +0.0980171 0.980785 0 +0.195090 0.980785 0 +0.195090 0.923880 0 +0.290284 0.923880 0 +0.382683 0.923880 0 +0.195090 0.956940 0 +0.290284 0.956940 0 +0.382683 0.956940 0 +0.195090 0.980785 0 +0.290284 0.980785 0 +0.382683 0.980785 0 +0.00000 0.980785 0 +0.0980171 0.980785 0 +0.195090 0.980785 0 +0.00000 0.995184 0 +0.0980171 0.995184 0 +0.195090 0.995184 0 +0.00000 1.00000 0 +0.0980171 1.00000 0 +0.195090 1.00000 0 +0.195090 0.980785 0 +0.290284 0.980785 0 +0.382683 0.980785 0 +0.195090 0.995184 0 +0.290284 0.995184 0 +0.382683 0.995184 0 +0.195090 1.00000 0 +0.290284 1.00000 0 +0.382683 1.00000 0 +0.382683 0.923880 0 +0.471396 0.923880 0 +0.555570 0.923880 0 +0.382683 0.956940 0 +0.471396 0.956940 0 +0.555570 0.956940 0 +0.382683 0.980785 0 +0.471396 0.980785 0 +0.555570 0.980785 0 +0.555570 0.923880 0 +0.634393 0.923880 0 +0.707107 0.923880 0 +0.555570 0.956940 0 +0.634393 0.956940 0 +0.707107 0.956940 0 +0.555570 0.980785 0 +0.634393 0.980785 0 +0.707107 0.980785 0 +0.382683 0.980785 0 +0.471396 0.980785 0 +0.555570 0.980785 0 +0.382683 0.995184 0 +0.471396 0.995184 0 +0.555570 0.995184 0 +0.382683 1.00000 0 +0.471396 1.00000 0 +0.555570 1.00000 0 +0.555570 0.980785 0 +0.634393 0.980785 0 +0.707107 0.980785 0 +0.555570 0.995184 0 +0.634393 0.995184 0 +0.707107 0.995184 0 +0.555570 1.00000 0 +0.634393 1.00000 0 +0.707107 1.00000 0 +0.707107 0.923880 0 +0.773010 0.923880 0 +0.831470 0.923880 0 +0.707107 0.956940 0 +0.773010 0.956940 0 +0.831470 0.956940 0 +0.707107 0.980785 0 +0.773010 0.980785 0 +0.831470 0.980785 0 +0.831470 0.923880 0 +0.881921 0.923880 0 +0.923880 0.923880 0 +0.831470 0.956940 0 +0.881921 0.956940 0 +0.923880 0.956940 0 +0.831470 0.980785 0 +0.881921 0.980785 0 +0.923880 0.980785 0 +0.707107 0.980785 0 +0.773010 0.980785 0 +0.831470 0.980785 0 +0.707107 0.995184 0 +0.773010 0.995184 0 +0.831470 0.995184 0 +0.707107 1.00000 0 +0.773010 1.00000 0 +0.831470 1.00000 0 +0.831470 0.980785 0 +0.881921 0.980785 0 +0.923880 0.980785 0 +0.831470 0.995184 0 +0.881921 0.995184 0 +0.923880 0.995184 0 +0.831470 1.00000 0 +0.881921 1.00000 0 +0.923880 1.00000 0 +0.923880 0.923880 0 +0.956940 0.923880 0 +0.980785 0.923880 0 +0.923880 0.956940 0 +0.956940 0.956940 0 +0.980785 0.956940 0 +0.923880 0.980785 0 +0.956940 0.980785 0 +0.980785 0.980785 0 +0.980785 0.923880 0 +0.995184 0.923880 0 +1.00000 0.923880 0 +0.980785 0.956940 0 +0.995184 0.956940 0 +1.00000 0.956940 0 +0.980785 0.980785 0 +0.995184 0.980785 0 +1.00000 0.980785 0 +0.923880 0.980785 0 +0.956940 0.980785 0 +0.980785 0.980785 0 +0.923880 0.995184 0 +0.956940 0.995184 0 +0.980785 0.995184 0 +0.923880 1.00000 0 +0.956940 1.00000 0 +0.980785 1.00000 0 +0.980785 0.980785 0 +0.995184 0.980785 0 +1.00000 0.980785 0 +0.980785 0.995184 0 +0.995184 0.995184 0 +1.00000 0.995184 0 +0.980785 1.00000 0 +0.995184 1.00000 0 +1.00000 1.00000 0 + +CELLS 64 640 +9 0 2 8 6 1 5 7 3 4 +9 9 11 17 15 10 14 16 12 13 +9 18 20 26 24 19 23 25 21 22 +9 27 29 35 33 28 32 34 30 31 +9 36 38 44 42 37 41 43 39 40 +9 45 47 53 51 46 50 52 48 49 +9 54 56 62 60 55 59 61 57 58 +9 63 65 71 69 64 68 70 66 67 +9 72 74 80 78 73 77 79 75 76 +9 81 83 89 87 82 86 88 84 85 +9 90 92 98 96 91 95 97 93 94 +9 99 101 107 105 100 104 106 102 103 +9 108 110 116 114 109 113 115 111 112 +9 117 119 125 123 118 122 124 120 121 +9 126 128 134 132 127 131 133 129 130 +9 135 137 143 141 136 140 142 138 139 +9 144 146 152 150 145 149 151 147 148 +9 153 155 161 159 154 158 160 156 157 +9 162 164 170 168 163 167 169 165 166 +9 171 173 179 177 172 176 178 174 175 +9 180 182 188 186 181 185 187 183 184 +9 189 191 197 195 190 194 196 192 193 +9 198 200 206 204 199 203 205 201 202 +9 207 209 215 213 208 212 214 210 211 +9 216 218 224 222 217 221 223 219 220 +9 225 227 233 231 226 230 232 228 229 +9 234 236 242 240 235 239 241 237 238 +9 243 245 251 249 244 248 250 246 247 +9 252 254 260 258 253 257 259 255 256 +9 261 263 269 267 262 266 268 264 265 +9 270 272 278 276 271 275 277 273 274 +9 279 281 287 285 280 284 286 282 283 +9 288 290 296 294 289 293 295 291 292 +9 297 299 305 303 298 302 304 300 301 +9 306 308 314 312 307 311 313 309 310 +9 315 317 323 321 316 320 322 318 319 +9 324 326 332 330 325 329 331 327 328 +9 333 335 341 339 334 338 340 336 337 +9 342 344 350 348 343 347 349 345 346 +9 351 353 359 357 352 356 358 354 355 +9 360 362 368 366 361 365 367 363 364 +9 369 371 377 375 370 374 376 372 373 +9 378 380 386 384 379 383 385 381 382 +9 387 389 395 393 388 392 394 390 391 +9 396 398 404 402 397 401 403 399 400 +9 405 407 413 411 406 410 412 408 409 +9 414 416 422 420 415 419 421 417 418 +9 423 425 431 429 424 428 430 426 427 +9 432 434 440 438 433 437 439 435 436 +9 441 443 449 447 442 446 448 444 445 +9 450 452 458 456 451 455 457 453 454 +9 459 461 467 465 460 464 466 462 463 +9 468 470 476 474 469 473 475 471 472 +9 477 479 485 483 478 482 484 480 481 +9 486 488 494 492 487 491 493 489 490 +9 495 497 503 501 496 500 502 498 499 +9 504 506 512 510 505 509 511 507 508 +9 513 515 521 519 514 518 520 516 517 +9 522 524 530 528 523 527 529 525 526 +9 531 533 539 537 532 536 538 534 535 +9 540 542 548 546 541 545 547 543 544 +9 549 551 557 555 550 554 556 552 553 +9 558 560 566 564 559 563 565 561 562 +9 567 569 575 573 568 572 574 570 571 + +CELL_TYPES 64 + 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 +POINT_DATA 576 +# vtk DataFile Version 3.0 +#This file was generated +ASCII +DATASET UNSTRUCTURED_GRID + +POINTS 576 double +0.00000 0.00000 0 +0.0980171 0.00000 0 +0.195090 0.00000 0 +0.00000 0.0980171 0 +0.0980171 0.0980171 0 +0.195090 0.0980171 0 +0.00000 0.195090 0 +0.0980171 0.195090 0 +0.195090 0.195090 0 +0.195090 0.00000 0 +0.290284 0.00000 0 +0.382683 0.00000 0 +0.195090 0.0980171 0 +0.290284 0.0980171 0 +0.382683 0.0980171 0 +0.195090 0.195090 0 +0.290284 0.195090 0 +0.382683 0.195090 0 +0.00000 0.195090 0 +0.0980171 0.195090 0 +0.195090 0.195090 0 +0.00000 0.290284 0 +0.0980171 0.290284 0 +0.195090 0.290284 0 +0.00000 0.382683 0 +0.0980171 0.382683 0 +0.195090 0.382683 0 +0.195090 0.195090 0 +0.290284 0.195090 0 +0.382683 0.195090 0 +0.195090 0.290284 0 +0.290284 0.290284 0 +0.382683 0.290284 0 +0.195090 0.382683 0 +0.290284 0.382683 0 +0.382683 0.382683 0 +0.382683 0.00000 0 +0.471396 0.00000 0 +0.555570 0.00000 0 +0.382683 0.0980171 0 +0.471396 0.0980171 0 +0.555570 0.0980171 0 +0.382683 0.195090 0 +0.471396 0.195090 0 +0.555570 0.195090 0 +0.555570 0.00000 0 +0.634393 0.00000 0 +0.707107 0.00000 0 +0.555570 0.0980171 0 +0.634393 0.0980171 0 +0.707107 0.0980171 0 +0.555570 0.195090 0 +0.634393 0.195090 0 +0.707107 0.195090 0 +0.382683 0.195090 0 +0.471396 0.195090 0 +0.555570 0.195090 0 +0.382683 0.290284 0 +0.471396 0.290284 0 +0.555570 0.290284 0 +0.382683 0.382683 0 +0.471396 0.382683 0 +0.555570 0.382683 0 +0.555570 0.195090 0 +0.634393 0.195090 0 +0.707107 0.195090 0 +0.555570 0.290284 0 +0.634393 0.290284 0 +0.707107 0.290284 0 +0.555570 0.382683 0 +0.634393 0.382683 0 +0.707107 0.382683 0 +0.707107 0.00000 0 +0.773010 0.00000 0 +0.831470 0.00000 0 +0.707107 0.0980171 0 +0.773010 0.0980171 0 +0.831470 0.0980171 0 +0.707107 0.195090 0 +0.773010 0.195090 0 +0.831470 0.195090 0 +0.831470 0.00000 0 +0.881921 0.00000 0 +0.923880 0.00000 0 +0.831470 0.0980171 0 +0.881921 0.0980171 0 +0.923880 0.0980171 0 +0.831470 0.195090 0 +0.881921 0.195090 0 +0.923880 0.195090 0 +0.707107 0.195090 0 +0.773010 0.195090 0 +0.831470 0.195090 0 +0.707107 0.290284 0 +0.773010 0.290284 0 +0.831470 0.290284 0 +0.707107 0.382683 0 +0.773010 0.382683 0 +0.831470 0.382683 0 +0.831470 0.195090 0 +0.881921 0.195090 0 +0.923880 0.195090 0 +0.831470 0.290284 0 +0.881921 0.290284 0 +0.923880 0.290284 0 +0.831470 0.382683 0 +0.881921 0.382683 0 +0.923880 0.382683 0 +0.923880 0.00000 0 +0.956940 0.00000 0 +0.980785 0.00000 0 +0.923880 0.0980171 0 +0.956940 0.0980171 0 +0.980785 0.0980171 0 +0.923880 0.195090 0 +0.956940 0.195090 0 +0.980785 0.195090 0 +0.980785 0.00000 0 +0.995184 0.00000 0 +1.00000 0.00000 0 +0.980785 0.0980171 0 +0.995184 0.0980171 0 +1.00000 0.0980171 0 +0.980785 0.195090 0 +0.995184 0.195090 0 +1.00000 0.195090 0 +0.923880 0.195090 0 +0.956940 0.195090 0 +0.980785 0.195090 0 +0.923880 0.290284 0 +0.956940 0.290284 0 +0.980785 0.290284 0 +0.923880 0.382683 0 +0.956940 0.382683 0 +0.980785 0.382683 0 +0.980785 0.195090 0 +0.995184 0.195090 0 +1.00000 0.195090 0 +0.980785 0.290284 0 +0.995184 0.290284 0 +1.00000 0.290284 0 +0.980785 0.382683 0 +0.995184 0.382683 0 +1.00000 0.382683 0 +0.00000 0.382683 0 +0.0980171 0.382683 0 +0.195090 0.382683 0 +0.00000 0.471396 0 +0.0980171 0.471396 0 +0.195090 0.471396 0 +0.00000 0.555570 0 +0.0980171 0.555570 0 +0.195090 0.555570 0 +0.195090 0.382683 0 +0.290284 0.382683 0 +0.382683 0.382683 0 +0.195090 0.471396 0 +0.290284 0.471396 0 +0.382683 0.471396 0 +0.195090 0.555570 0 +0.290284 0.555570 0 +0.382683 0.555570 0 +0.00000 0.555570 0 +0.0980171 0.555570 0 +0.195090 0.555570 0 +0.00000 0.634393 0 +0.0980171 0.634393 0 +0.195090 0.634393 0 +0.00000 0.707107 0 +0.0980171 0.707107 0 +0.195090 0.707107 0 +0.195090 0.555570 0 +0.290284 0.555570 0 +0.382683 0.555570 0 +0.195090 0.634393 0 +0.290284 0.634393 0 +0.382683 0.634393 0 +0.195090 0.707107 0 +0.290284 0.707107 0 +0.382683 0.707107 0 +0.382683 0.382683 0 +0.471396 0.382683 0 +0.555570 0.382683 0 +0.382683 0.471396 0 +0.471396 0.471396 0 +0.555570 0.471396 0 +0.382683 0.555570 0 +0.471396 0.555570 0 +0.555570 0.555570 0 +0.555570 0.382683 0 +0.634393 0.382683 0 +0.707107 0.382683 0 +0.555570 0.471396 0 +0.634393 0.471396 0 +0.707107 0.471396 0 +0.555570 0.555570 0 +0.634393 0.555570 0 +0.707107 0.555570 0 +0.382683 0.555570 0 +0.471396 0.555570 0 +0.555570 0.555570 0 +0.382683 0.634393 0 +0.471396 0.634393 0 +0.555570 0.634393 0 +0.382683 0.707107 0 +0.471396 0.707107 0 +0.555570 0.707107 0 +0.555570 0.555570 0 +0.634393 0.555570 0 +0.707107 0.555570 0 +0.555570 0.634393 0 +0.634393 0.634393 0 +0.707107 0.634393 0 +0.555570 0.707107 0 +0.634393 0.707107 0 +0.707107 0.707107 0 +0.707107 0.382683 0 +0.773010 0.382683 0 +0.831470 0.382683 0 +0.707107 0.471396 0 +0.773010 0.471396 0 +0.831470 0.471396 0 +0.707107 0.555570 0 +0.773010 0.555570 0 +0.831470 0.555570 0 +0.831470 0.382683 0 +0.881921 0.382683 0 +0.923880 0.382683 0 +0.831470 0.471396 0 +0.881921 0.471396 0 +0.923880 0.471396 0 +0.831470 0.555570 0 +0.881921 0.555570 0 +0.923880 0.555570 0 +0.707107 0.555570 0 +0.773010 0.555570 0 +0.831470 0.555570 0 +0.707107 0.634393 0 +0.773010 0.634393 0 +0.831470 0.634393 0 +0.707107 0.707107 0 +0.773010 0.707107 0 +0.831470 0.707107 0 +0.831470 0.555570 0 +0.881921 0.555570 0 +0.923880 0.555570 0 +0.831470 0.634393 0 +0.881921 0.634393 0 +0.923880 0.634393 0 +0.831470 0.707107 0 +0.881921 0.707107 0 +0.923880 0.707107 0 +0.923880 0.382683 0 +0.956940 0.382683 0 +0.980785 0.382683 0 +0.923880 0.471396 0 +0.956940 0.471396 0 +0.980785 0.471396 0 +0.923880 0.555570 0 +0.956940 0.555570 0 +0.980785 0.555570 0 +0.980785 0.382683 0 +0.995184 0.382683 0 +1.00000 0.382683 0 +0.980785 0.471396 0 +0.995184 0.471396 0 +1.00000 0.471396 0 +0.980785 0.555570 0 +0.995184 0.555570 0 +1.00000 0.555570 0 +0.923880 0.555570 0 +0.956940 0.555570 0 +0.980785 0.555570 0 +0.923880 0.634393 0 +0.956940 0.634393 0 +0.980785 0.634393 0 +0.923880 0.707107 0 +0.956940 0.707107 0 +0.980785 0.707107 0 +0.980785 0.555570 0 +0.995184 0.555570 0 +1.00000 0.555570 0 +0.980785 0.634393 0 +0.995184 0.634393 0 +1.00000 0.634393 0 +0.980785 0.707107 0 +0.995184 0.707107 0 +1.00000 0.707107 0 +0.00000 0.707107 0 +0.0980171 0.707107 0 +0.195090 0.707107 0 +0.00000 0.773010 0 +0.0980171 0.773010 0 +0.195090 0.773010 0 +0.00000 0.831470 0 +0.0980171 0.831470 0 +0.195090 0.831470 0 +0.195090 0.707107 0 +0.290284 0.707107 0 +0.382683 0.707107 0 +0.195090 0.773010 0 +0.290284 0.773010 0 +0.382683 0.773010 0 +0.195090 0.831470 0 +0.290284 0.831470 0 +0.382683 0.831470 0 +0.00000 0.831470 0 +0.0980171 0.831470 0 +0.195090 0.831470 0 +0.00000 0.881921 0 +0.0980171 0.881921 0 +0.195090 0.881921 0 +0.00000 0.923880 0 +0.0980171 0.923880 0 +0.195090 0.923880 0 +0.195090 0.831470 0 +0.290284 0.831470 0 +0.382683 0.831470 0 +0.195090 0.881921 0 +0.290284 0.881921 0 +0.382683 0.881921 0 +0.195090 0.923880 0 +0.290284 0.923880 0 +0.382683 0.923880 0 +0.382683 0.707107 0 +0.471396 0.707107 0 +0.555570 0.707107 0 +0.382683 0.773010 0 +0.471396 0.773010 0 +0.555570 0.773010 0 +0.382683 0.831470 0 +0.471396 0.831470 0 +0.555570 0.831470 0 +0.555570 0.707107 0 +0.634393 0.707107 0 +0.707107 0.707107 0 +0.555570 0.773010 0 +0.634393 0.773010 0 +0.707107 0.773010 0 +0.555570 0.831470 0 +0.634393 0.831470 0 +0.707107 0.831470 0 +0.382683 0.831470 0 +0.471396 0.831470 0 +0.555570 0.831470 0 +0.382683 0.881921 0 +0.471396 0.881921 0 +0.555570 0.881921 0 +0.382683 0.923880 0 +0.471396 0.923880 0 +0.555570 0.923880 0 +0.555570 0.831470 0 +0.634393 0.831470 0 +0.707107 0.831470 0 +0.555570 0.881921 0 +0.634393 0.881921 0 +0.707107 0.881921 0 +0.555570 0.923880 0 +0.634393 0.923880 0 +0.707107 0.923880 0 +0.707107 0.707107 0 +0.773010 0.707107 0 +0.831470 0.707107 0 +0.707107 0.773010 0 +0.773010 0.773010 0 +0.831470 0.773010 0 +0.707107 0.831470 0 +0.773010 0.831470 0 +0.831470 0.831470 0 +0.831470 0.707107 0 +0.881921 0.707107 0 +0.923880 0.707107 0 +0.831470 0.773010 0 +0.881921 0.773010 0 +0.923880 0.773010 0 +0.831470 0.831470 0 +0.881921 0.831470 0 +0.923880 0.831470 0 +0.707107 0.831470 0 +0.773010 0.831470 0 +0.831470 0.831470 0 +0.707107 0.881921 0 +0.773010 0.881921 0 +0.831470 0.881921 0 +0.707107 0.923880 0 +0.773010 0.923880 0 +0.831470 0.923880 0 +0.831470 0.831470 0 +0.881921 0.831470 0 +0.923880 0.831470 0 +0.831470 0.881921 0 +0.881921 0.881921 0 +0.923880 0.881921 0 +0.831470 0.923880 0 +0.881921 0.923880 0 +0.923880 0.923880 0 +0.923880 0.707107 0 +0.956940 0.707107 0 +0.980785 0.707107 0 +0.923880 0.773010 0 +0.956940 0.773010 0 +0.980785 0.773010 0 +0.923880 0.831470 0 +0.956940 0.831470 0 +0.980785 0.831470 0 +0.980785 0.707107 0 +0.995184 0.707107 0 +1.00000 0.707107 0 +0.980785 0.773010 0 +0.995184 0.773010 0 +1.00000 0.773010 0 +0.980785 0.831470 0 +0.995184 0.831470 0 +1.00000 0.831470 0 +0.923880 0.831470 0 +0.956940 0.831470 0 +0.980785 0.831470 0 +0.923880 0.881921 0 +0.956940 0.881921 0 +0.980785 0.881921 0 +0.923880 0.923880 0 +0.956940 0.923880 0 +0.980785 0.923880 0 +0.980785 0.831470 0 +0.995184 0.831470 0 +1.00000 0.831470 0 +0.980785 0.881921 0 +0.995184 0.881921 0 +1.00000 0.881921 0 +0.980785 0.923880 0 +0.995184 0.923880 0 +1.00000 0.923880 0 +0.00000 0.923880 0 +0.0980171 0.923880 0 +0.195090 0.923880 0 +0.00000 0.956940 0 +0.0980171 0.956940 0 +0.195090 0.956940 0 +0.00000 0.980785 0 +0.0980171 0.980785 0 +0.195090 0.980785 0 +0.195090 0.923880 0 +0.290284 0.923880 0 +0.382683 0.923880 0 +0.195090 0.956940 0 +0.290284 0.956940 0 +0.382683 0.956940 0 +0.195090 0.980785 0 +0.290284 0.980785 0 +0.382683 0.980785 0 +0.00000 0.980785 0 +0.0980171 0.980785 0 +0.195090 0.980785 0 +0.00000 0.995184 0 +0.0980171 0.995184 0 +0.195090 0.995184 0 +0.00000 1.00000 0 +0.0980171 1.00000 0 +0.195090 1.00000 0 +0.195090 0.980785 0 +0.290284 0.980785 0 +0.382683 0.980785 0 +0.195090 0.995184 0 +0.290284 0.995184 0 +0.382683 0.995184 0 +0.195090 1.00000 0 +0.290284 1.00000 0 +0.382683 1.00000 0 +0.382683 0.923880 0 +0.471396 0.923880 0 +0.555570 0.923880 0 +0.382683 0.956940 0 +0.471396 0.956940 0 +0.555570 0.956940 0 +0.382683 0.980785 0 +0.471396 0.980785 0 +0.555570 0.980785 0 +0.555570 0.923880 0 +0.634393 0.923880 0 +0.707107 0.923880 0 +0.555570 0.956940 0 +0.634393 0.956940 0 +0.707107 0.956940 0 +0.555570 0.980785 0 +0.634393 0.980785 0 +0.707107 0.980785 0 +0.382683 0.980785 0 +0.471396 0.980785 0 +0.555570 0.980785 0 +0.382683 0.995184 0 +0.471396 0.995184 0 +0.555570 0.995184 0 +0.382683 1.00000 0 +0.471396 1.00000 0 +0.555570 1.00000 0 +0.555570 0.980785 0 +0.634393 0.980785 0 +0.707107 0.980785 0 +0.555570 0.995184 0 +0.634393 0.995184 0 +0.707107 0.995184 0 +0.555570 1.00000 0 +0.634393 1.00000 0 +0.707107 1.00000 0 +0.707107 0.923880 0 +0.773010 0.923880 0 +0.831470 0.923880 0 +0.707107 0.956940 0 +0.773010 0.956940 0 +0.831470 0.956940 0 +0.707107 0.980785 0 +0.773010 0.980785 0 +0.831470 0.980785 0 +0.831470 0.923880 0 +0.881921 0.923880 0 +0.923880 0.923880 0 +0.831470 0.956940 0 +0.881921 0.956940 0 +0.923880 0.956940 0 +0.831470 0.980785 0 +0.881921 0.980785 0 +0.923880 0.980785 0 +0.707107 0.980785 0 +0.773010 0.980785 0 +0.831470 0.980785 0 +0.707107 0.995184 0 +0.773010 0.995184 0 +0.831470 0.995184 0 +0.707107 1.00000 0 +0.773010 1.00000 0 +0.831470 1.00000 0 +0.831470 0.980785 0 +0.881921 0.980785 0 +0.923880 0.980785 0 +0.831470 0.995184 0 +0.881921 0.995184 0 +0.923880 0.995184 0 +0.831470 1.00000 0 +0.881921 1.00000 0 +0.923880 1.00000 0 +0.923880 0.923880 0 +0.956940 0.923880 0 +0.980785 0.923880 0 +0.923880 0.956940 0 +0.956940 0.956940 0 +0.980785 0.956940 0 +0.923880 0.980785 0 +0.956940 0.980785 0 +0.980785 0.980785 0 +0.980785 0.923880 0 +0.995184 0.923880 0 +1.00000 0.923880 0 +0.980785 0.956940 0 +0.995184 0.956940 0 +1.00000 0.956940 0 +0.980785 0.980785 0 +0.995184 0.980785 0 +1.00000 0.980785 0 +0.923880 0.980785 0 +0.956940 0.980785 0 +0.980785 0.980785 0 +0.923880 0.995184 0 +0.956940 0.995184 0 +0.980785 0.995184 0 +0.923880 1.00000 0 +0.956940 1.00000 0 +0.980785 1.00000 0 +0.980785 0.980785 0 +0.995184 0.980785 0 +1.00000 0.980785 0 +0.980785 0.995184 0 +0.995184 0.995184 0 +1.00000 0.995184 0 +0.980785 1.00000 0 +0.995184 1.00000 0 +1.00000 1.00000 0 + +CELLS 64 640 +9 0 2 8 6 1 5 7 3 4 +9 9 11 17 15 10 14 16 12 13 +9 18 20 26 24 19 23 25 21 22 +9 27 29 35 33 28 32 34 30 31 +9 36 38 44 42 37 41 43 39 40 +9 45 47 53 51 46 50 52 48 49 +9 54 56 62 60 55 59 61 57 58 +9 63 65 71 69 64 68 70 66 67 +9 72 74 80 78 73 77 79 75 76 +9 81 83 89 87 82 86 88 84 85 +9 90 92 98 96 91 95 97 93 94 +9 99 101 107 105 100 104 106 102 103 +9 108 110 116 114 109 113 115 111 112 +9 117 119 125 123 118 122 124 120 121 +9 126 128 134 132 127 131 133 129 130 +9 135 137 143 141 136 140 142 138 139 +9 144 146 152 150 145 149 151 147 148 +9 153 155 161 159 154 158 160 156 157 +9 162 164 170 168 163 167 169 165 166 +9 171 173 179 177 172 176 178 174 175 +9 180 182 188 186 181 185 187 183 184 +9 189 191 197 195 190 194 196 192 193 +9 198 200 206 204 199 203 205 201 202 +9 207 209 215 213 208 212 214 210 211 +9 216 218 224 222 217 221 223 219 220 +9 225 227 233 231 226 230 232 228 229 +9 234 236 242 240 235 239 241 237 238 +9 243 245 251 249 244 248 250 246 247 +9 252 254 260 258 253 257 259 255 256 +9 261 263 269 267 262 266 268 264 265 +9 270 272 278 276 271 275 277 273 274 +9 279 281 287 285 280 284 286 282 283 +9 288 290 296 294 289 293 295 291 292 +9 297 299 305 303 298 302 304 300 301 +9 306 308 314 312 307 311 313 309 310 +9 315 317 323 321 316 320 322 318 319 +9 324 326 332 330 325 329 331 327 328 +9 333 335 341 339 334 338 340 336 337 +9 342 344 350 348 343 347 349 345 346 +9 351 353 359 357 352 356 358 354 355 +9 360 362 368 366 361 365 367 363 364 +9 369 371 377 375 370 374 376 372 373 +9 378 380 386 384 379 383 385 381 382 +9 387 389 395 393 388 392 394 390 391 +9 396 398 404 402 397 401 403 399 400 +9 405 407 413 411 406 410 412 408 409 +9 414 416 422 420 415 419 421 417 418 +9 423 425 431 429 424 428 430 426 427 +9 432 434 440 438 433 437 439 435 436 +9 441 443 449 447 442 446 448 444 445 +9 450 452 458 456 451 455 457 453 454 +9 459 461 467 465 460 464 466 462 463 +9 468 470 476 474 469 473 475 471 472 +9 477 479 485 483 478 482 484 480 481 +9 486 488 494 492 487 491 493 489 490 +9 495 497 503 501 496 500 502 498 499 +9 504 506 512 510 505 509 511 507 508 +9 513 515 521 519 514 518 520 516 517 +9 522 524 530 528 523 527 529 525 526 +9 531 533 539 537 532 536 538 534 535 +9 540 542 548 546 541 545 547 543 544 +9 549 551 557 555 550 554 556 552 553 +9 558 560 566 564 559 563 565 561 562 +9 567 569 575 573 568 572 574 570 571 + +CELL_TYPES 64 + 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 +POINT_DATA 576 diff --git a/tests/mappings/mapping_q_cache_06.with_p4est=true.with_mpi=true.mpirun=4.output b/tests/mappings/mapping_q_cache_06.with_p4est=true.with_mpi=true.mpirun=4.output new file mode 100644 index 0000000000..1683579f90 --- /dev/null +++ b/tests/mappings/mapping_q_cache_06.with_p4est=true.with_mpi=true.mpirun=4.output @@ -0,0 +1,2759 @@ + +# vtk DataFile Version 3.0 +#This file was generated +ASCII +DATASET UNSTRUCTURED_GRID + +POINTS 144 double +0.00000 0.00000 0 +0.0980171 0.00000 0 +0.195090 0.00000 0 +0.00000 0.0980171 0 +0.0980171 0.0980171 0 +0.195090 0.0980171 0 +0.00000 0.195090 0 +0.0980171 0.195090 0 +0.195090 0.195090 0 +0.195090 0.00000 0 +0.290284 0.00000 0 +0.382683 0.00000 0 +0.195090 0.0980171 0 +0.290284 0.0980171 0 +0.382683 0.0980171 0 +0.195090 0.195090 0 +0.290284 0.195090 0 +0.382683 0.195090 0 +0.00000 0.195090 0 +0.0980171 0.195090 0 +0.195090 0.195090 0 +0.00000 0.290284 0 +0.0980171 0.290284 0 +0.195090 0.290284 0 +0.00000 0.382683 0 +0.0980171 0.382683 0 +0.195090 0.382683 0 +0.195090 0.195090 0 +0.290284 0.195090 0 +0.382683 0.195090 0 +0.195090 0.290284 0 +0.290284 0.290284 0 +0.382683 0.290284 0 +0.195090 0.382683 0 +0.290284 0.382683 0 +0.382683 0.382683 0 +0.382683 0.00000 0 +0.471396 0.00000 0 +0.555570 0.00000 0 +0.382683 0.0980171 0 +0.471396 0.0980171 0 +0.555570 0.0980171 0 +0.382683 0.195090 0 +0.471396 0.195090 0 +0.555570 0.195090 0 +0.555570 0.00000 0 +0.634393 0.00000 0 +0.707107 0.00000 0 +0.555570 0.0980171 0 +0.634393 0.0980171 0 +0.707107 0.0980171 0 +0.555570 0.195090 0 +0.634393 0.195090 0 +0.707107 0.195090 0 +0.382683 0.195090 0 +0.471396 0.195090 0 +0.555570 0.195090 0 +0.382683 0.290284 0 +0.471396 0.290284 0 +0.555570 0.290284 0 +0.382683 0.382683 0 +0.471396 0.382683 0 +0.555570 0.382683 0 +0.555570 0.195090 0 +0.634393 0.195090 0 +0.707107 0.195090 0 +0.555570 0.290284 0 +0.634393 0.290284 0 +0.707107 0.290284 0 +0.555570 0.382683 0 +0.634393 0.382683 0 +0.707107 0.382683 0 +0.00000 0.382683 0 +0.0980171 0.382683 0 +0.195090 0.382683 0 +0.00000 0.471396 0 +0.0980171 0.471396 0 +0.195090 0.471396 0 +0.00000 0.555570 0 +0.0980171 0.555570 0 +0.195090 0.555570 0 +0.195090 0.382683 0 +0.290284 0.382683 0 +0.382683 0.382683 0 +0.195090 0.471396 0 +0.290284 0.471396 0 +0.382683 0.471396 0 +0.195090 0.555570 0 +0.290284 0.555570 0 +0.382683 0.555570 0 +0.00000 0.555570 0 +0.0980171 0.555570 0 +0.195090 0.555570 0 +0.00000 0.634393 0 +0.0980171 0.634393 0 +0.195090 0.634393 0 +0.00000 0.707107 0 +0.0980171 0.707107 0 +0.195090 0.707107 0 +0.195090 0.555570 0 +0.290284 0.555570 0 +0.382683 0.555570 0 +0.195090 0.634393 0 +0.290284 0.634393 0 +0.382683 0.634393 0 +0.195090 0.707107 0 +0.290284 0.707107 0 +0.382683 0.707107 0 +0.382683 0.382683 0 +0.471396 0.382683 0 +0.555570 0.382683 0 +0.382683 0.471396 0 +0.471396 0.471396 0 +0.555570 0.471396 0 +0.382683 0.555570 0 +0.471396 0.555570 0 +0.555570 0.555570 0 +0.555570 0.382683 0 +0.634393 0.382683 0 +0.707107 0.382683 0 +0.555570 0.471396 0 +0.634393 0.471396 0 +0.707107 0.471396 0 +0.555570 0.555570 0 +0.634393 0.555570 0 +0.707107 0.555570 0 +0.382683 0.555570 0 +0.471396 0.555570 0 +0.555570 0.555570 0 +0.382683 0.634393 0 +0.471396 0.634393 0 +0.555570 0.634393 0 +0.382683 0.707107 0 +0.471396 0.707107 0 +0.555570 0.707107 0 +0.555570 0.555570 0 +0.634393 0.555570 0 +0.707107 0.555570 0 +0.555570 0.634393 0 +0.634393 0.634393 0 +0.707107 0.634393 0 +0.555570 0.707107 0 +0.634393 0.707107 0 +0.707107 0.707107 0 + +CELLS 16 160 +9 0 2 8 6 1 5 7 3 4 +9 9 11 17 15 10 14 16 12 13 +9 18 20 26 24 19 23 25 21 22 +9 27 29 35 33 28 32 34 30 31 +9 36 38 44 42 37 41 43 39 40 +9 45 47 53 51 46 50 52 48 49 +9 54 56 62 60 55 59 61 57 58 +9 63 65 71 69 64 68 70 66 67 +9 72 74 80 78 73 77 79 75 76 +9 81 83 89 87 82 86 88 84 85 +9 90 92 98 96 91 95 97 93 94 +9 99 101 107 105 100 104 106 102 103 +9 108 110 116 114 109 113 115 111 112 +9 117 119 125 123 118 122 124 120 121 +9 126 128 134 132 127 131 133 129 130 +9 135 137 143 141 136 140 142 138 139 + +CELL_TYPES 16 + 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 +POINT_DATA 144 +# vtk DataFile Version 3.0 +#This file was generated +ASCII +DATASET UNSTRUCTURED_GRID + +POINTS 144 double +0.00000 0.00000 0 +0.0980171 0.00000 0 +0.195090 0.00000 0 +0.00000 0.0980171 0 +0.0980171 0.0980171 0 +0.195090 0.0980171 0 +0.00000 0.195090 0 +0.0980171 0.195090 0 +0.195090 0.195090 0 +0.195090 0.00000 0 +0.290284 0.00000 0 +0.382683 0.00000 0 +0.195090 0.0980171 0 +0.290284 0.0980171 0 +0.382683 0.0980171 0 +0.195090 0.195090 0 +0.290284 0.195090 0 +0.382683 0.195090 0 +0.00000 0.195090 0 +0.0980171 0.195090 0 +0.195090 0.195090 0 +0.00000 0.290284 0 +0.0980171 0.290284 0 +0.195090 0.290284 0 +0.00000 0.382683 0 +0.0980171 0.382683 0 +0.195090 0.382683 0 +0.195090 0.195090 0 +0.290284 0.195090 0 +0.382683 0.195090 0 +0.195090 0.290284 0 +0.290284 0.290284 0 +0.382683 0.290284 0 +0.195090 0.382683 0 +0.290284 0.382683 0 +0.382683 0.382683 0 +0.382683 0.00000 0 +0.471396 0.00000 0 +0.555570 0.00000 0 +0.382683 0.0980171 0 +0.471396 0.0980171 0 +0.555570 0.0980171 0 +0.382683 0.195090 0 +0.471396 0.195090 0 +0.555570 0.195090 0 +0.555570 0.00000 0 +0.634393 0.00000 0 +0.707107 0.00000 0 +0.555570 0.0980171 0 +0.634393 0.0980171 0 +0.707107 0.0980171 0 +0.555570 0.195090 0 +0.634393 0.195090 0 +0.707107 0.195090 0 +0.382683 0.195090 0 +0.471396 0.195090 0 +0.555570 0.195090 0 +0.382683 0.290284 0 +0.471396 0.290284 0 +0.555570 0.290284 0 +0.382683 0.382683 0 +0.471396 0.382683 0 +0.555570 0.382683 0 +0.555570 0.195090 0 +0.634393 0.195090 0 +0.707107 0.195090 0 +0.555570 0.290284 0 +0.634393 0.290284 0 +0.707107 0.290284 0 +0.555570 0.382683 0 +0.634393 0.382683 0 +0.707107 0.382683 0 +0.00000 0.382683 0 +0.0980171 0.382683 0 +0.195090 0.382683 0 +0.00000 0.471396 0 +0.0980171 0.471396 0 +0.195090 0.471396 0 +0.00000 0.555570 0 +0.0980171 0.555570 0 +0.195090 0.555570 0 +0.195090 0.382683 0 +0.290284 0.382683 0 +0.382683 0.382683 0 +0.195090 0.471396 0 +0.290284 0.471396 0 +0.382683 0.471396 0 +0.195090 0.555570 0 +0.290284 0.555570 0 +0.382683 0.555570 0 +0.00000 0.555570 0 +0.0980171 0.555570 0 +0.195090 0.555570 0 +0.00000 0.634393 0 +0.0980171 0.634393 0 +0.195090 0.634393 0 +0.00000 0.707107 0 +0.0980171 0.707107 0 +0.195090 0.707107 0 +0.195090 0.555570 0 +0.290284 0.555570 0 +0.382683 0.555570 0 +0.195090 0.634393 0 +0.290284 0.634393 0 +0.382683 0.634393 0 +0.195090 0.707107 0 +0.290284 0.707107 0 +0.382683 0.707107 0 +0.382683 0.382683 0 +0.471396 0.382683 0 +0.555570 0.382683 0 +0.382683 0.471396 0 +0.471396 0.471396 0 +0.555570 0.471396 0 +0.382683 0.555570 0 +0.471396 0.555570 0 +0.555570 0.555570 0 +0.555570 0.382683 0 +0.634393 0.382683 0 +0.707107 0.382683 0 +0.555570 0.471396 0 +0.634393 0.471396 0 +0.707107 0.471396 0 +0.555570 0.555570 0 +0.634393 0.555570 0 +0.707107 0.555570 0 +0.382683 0.555570 0 +0.471396 0.555570 0 +0.555570 0.555570 0 +0.382683 0.634393 0 +0.471396 0.634393 0 +0.555570 0.634393 0 +0.382683 0.707107 0 +0.471396 0.707107 0 +0.555570 0.707107 0 +0.555570 0.555570 0 +0.634393 0.555570 0 +0.707107 0.555570 0 +0.555570 0.634393 0 +0.634393 0.634393 0 +0.707107 0.634393 0 +0.555570 0.707107 0 +0.634393 0.707107 0 +0.707107 0.707107 0 + +CELLS 16 160 +9 0 2 8 6 1 5 7 3 4 +9 9 11 17 15 10 14 16 12 13 +9 18 20 26 24 19 23 25 21 22 +9 27 29 35 33 28 32 34 30 31 +9 36 38 44 42 37 41 43 39 40 +9 45 47 53 51 46 50 52 48 49 +9 54 56 62 60 55 59 61 57 58 +9 63 65 71 69 64 68 70 66 67 +9 72 74 80 78 73 77 79 75 76 +9 81 83 89 87 82 86 88 84 85 +9 90 92 98 96 91 95 97 93 94 +9 99 101 107 105 100 104 106 102 103 +9 108 110 116 114 109 113 115 111 112 +9 117 119 125 123 118 122 124 120 121 +9 126 128 134 132 127 131 133 129 130 +9 135 137 143 141 136 140 142 138 139 + +CELL_TYPES 16 + 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 +POINT_DATA 144 +# vtk DataFile Version 3.0 +#This file was generated +ASCII +DATASET UNSTRUCTURED_GRID + +POINTS 144 double +0.00000 0.00000 0 +0.0980171 0.00000 0 +0.195090 0.00000 0 +0.00000 0.0980171 0 +0.0980171 0.0980171 0 +0.195090 0.0980171 0 +0.00000 0.195090 0 +0.0980171 0.195090 0 +0.195090 0.195090 0 +0.195090 0.00000 0 +0.290284 0.00000 0 +0.382683 0.00000 0 +0.195090 0.0980171 0 +0.290284 0.0980171 0 +0.382683 0.0980171 0 +0.195090 0.195090 0 +0.290284 0.195090 0 +0.382683 0.195090 0 +0.00000 0.195090 0 +0.0980171 0.195090 0 +0.195090 0.195090 0 +0.00000 0.290284 0 +0.0980171 0.290284 0 +0.195090 0.290284 0 +0.00000 0.382683 0 +0.0980171 0.382683 0 +0.195090 0.382683 0 +0.195090 0.195090 0 +0.290284 0.195090 0 +0.382683 0.195090 0 +0.195090 0.290284 0 +0.290284 0.290284 0 +0.382683 0.290284 0 +0.195090 0.382683 0 +0.290284 0.382683 0 +0.382683 0.382683 0 +0.382683 0.00000 0 +0.471396 0.00000 0 +0.555570 0.00000 0 +0.382683 0.0980171 0 +0.471396 0.0980171 0 +0.555570 0.0980171 0 +0.382683 0.195090 0 +0.471396 0.195090 0 +0.555570 0.195090 0 +0.555570 0.00000 0 +0.634393 0.00000 0 +0.707107 0.00000 0 +0.555570 0.0980171 0 +0.634393 0.0980171 0 +0.707107 0.0980171 0 +0.555570 0.195090 0 +0.634393 0.195090 0 +0.707107 0.195090 0 +0.382683 0.195090 0 +0.471396 0.195090 0 +0.555570 0.195090 0 +0.382683 0.290284 0 +0.471396 0.290284 0 +0.555570 0.290284 0 +0.382683 0.382683 0 +0.471396 0.382683 0 +0.555570 0.382683 0 +0.555570 0.195090 0 +0.634393 0.195090 0 +0.707107 0.195090 0 +0.555570 0.290284 0 +0.634393 0.290284 0 +0.707107 0.290284 0 +0.555570 0.382683 0 +0.634393 0.382683 0 +0.707107 0.382683 0 +0.00000 0.382683 0 +0.0980171 0.382683 0 +0.195090 0.382683 0 +0.00000 0.471396 0 +0.0980171 0.471396 0 +0.195090 0.471396 0 +0.00000 0.555570 0 +0.0980171 0.555570 0 +0.195090 0.555570 0 +0.195090 0.382683 0 +0.290284 0.382683 0 +0.382683 0.382683 0 +0.195090 0.471396 0 +0.290284 0.471396 0 +0.382683 0.471396 0 +0.195090 0.555570 0 +0.290284 0.555570 0 +0.382683 0.555570 0 +0.00000 0.555570 0 +0.0980171 0.555570 0 +0.195090 0.555570 0 +0.00000 0.634393 0 +0.0980171 0.634393 0 +0.195090 0.634393 0 +0.00000 0.707107 0 +0.0980171 0.707107 0 +0.195090 0.707107 0 +0.195090 0.555570 0 +0.290284 0.555570 0 +0.382683 0.555570 0 +0.195090 0.634393 0 +0.290284 0.634393 0 +0.382683 0.634393 0 +0.195090 0.707107 0 +0.290284 0.707107 0 +0.382683 0.707107 0 +0.382683 0.382683 0 +0.471396 0.382683 0 +0.555570 0.382683 0 +0.382683 0.471396 0 +0.471396 0.471396 0 +0.555570 0.471396 0 +0.382683 0.555570 0 +0.471396 0.555570 0 +0.555570 0.555570 0 +0.555570 0.382683 0 +0.634393 0.382683 0 +0.707107 0.382683 0 +0.555570 0.471396 0 +0.634393 0.471396 0 +0.707107 0.471396 0 +0.555570 0.555570 0 +0.634393 0.555570 0 +0.707107 0.555570 0 +0.382683 0.555570 0 +0.471396 0.555570 0 +0.555570 0.555570 0 +0.382683 0.634393 0 +0.471396 0.634393 0 +0.555570 0.634393 0 +0.382683 0.707107 0 +0.471396 0.707107 0 +0.555570 0.707107 0 +0.555570 0.555570 0 +0.634393 0.555570 0 +0.707107 0.555570 0 +0.555570 0.634393 0 +0.634393 0.634393 0 +0.707107 0.634393 0 +0.555570 0.707107 0 +0.634393 0.707107 0 +0.707107 0.707107 0 + +CELLS 16 160 +9 0 2 8 6 1 5 7 3 4 +9 9 11 17 15 10 14 16 12 13 +9 18 20 26 24 19 23 25 21 22 +9 27 29 35 33 28 32 34 30 31 +9 36 38 44 42 37 41 43 39 40 +9 45 47 53 51 46 50 52 48 49 +9 54 56 62 60 55 59 61 57 58 +9 63 65 71 69 64 68 70 66 67 +9 72 74 80 78 73 77 79 75 76 +9 81 83 89 87 82 86 88 84 85 +9 90 92 98 96 91 95 97 93 94 +9 99 101 107 105 100 104 106 102 103 +9 108 110 116 114 109 113 115 111 112 +9 117 119 125 123 118 122 124 120 121 +9 126 128 134 132 127 131 133 129 130 +9 135 137 143 141 136 140 142 138 139 + +CELL_TYPES 16 + 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 +POINT_DATA 144 +# vtk DataFile Version 3.0 +#This file was generated +ASCII +DATASET UNSTRUCTURED_GRID + +POINTS 144 double +0.00000 0.00000 0 +0.0980171 0.00000 0 +0.195090 0.00000 0 +0.00000 0.0980171 0 +0.0980171 0.0980171 0 +0.195090 0.0980171 0 +0.00000 0.195090 0 +0.0980171 0.195090 0 +0.195090 0.195090 0 +0.195090 0.00000 0 +0.290284 0.00000 0 +0.382683 0.00000 0 +0.195090 0.0980171 0 +0.290284 0.0980171 0 +0.382683 0.0980171 0 +0.195090 0.195090 0 +0.290284 0.195090 0 +0.382683 0.195090 0 +0.00000 0.195090 0 +0.0980171 0.195090 0 +0.195090 0.195090 0 +0.00000 0.290284 0 +0.0980171 0.290284 0 +0.195090 0.290284 0 +0.00000 0.382683 0 +0.0980171 0.382683 0 +0.195090 0.382683 0 +0.195090 0.195090 0 +0.290284 0.195090 0 +0.382683 0.195090 0 +0.195090 0.290284 0 +0.290284 0.290284 0 +0.382683 0.290284 0 +0.195090 0.382683 0 +0.290284 0.382683 0 +0.382683 0.382683 0 +0.382683 0.00000 0 +0.471396 0.00000 0 +0.555570 0.00000 0 +0.382683 0.0980171 0 +0.471396 0.0980171 0 +0.555570 0.0980171 0 +0.382683 0.195090 0 +0.471396 0.195090 0 +0.555570 0.195090 0 +0.555570 0.00000 0 +0.634393 0.00000 0 +0.707107 0.00000 0 +0.555570 0.0980171 0 +0.634393 0.0980171 0 +0.707107 0.0980171 0 +0.555570 0.195090 0 +0.634393 0.195090 0 +0.707107 0.195090 0 +0.382683 0.195090 0 +0.471396 0.195090 0 +0.555570 0.195090 0 +0.382683 0.290284 0 +0.471396 0.290284 0 +0.555570 0.290284 0 +0.382683 0.382683 0 +0.471396 0.382683 0 +0.555570 0.382683 0 +0.555570 0.195090 0 +0.634393 0.195090 0 +0.707107 0.195090 0 +0.555570 0.290284 0 +0.634393 0.290284 0 +0.707107 0.290284 0 +0.555570 0.382683 0 +0.634393 0.382683 0 +0.707107 0.382683 0 +0.00000 0.382683 0 +0.0980171 0.382683 0 +0.195090 0.382683 0 +0.00000 0.471396 0 +0.0980171 0.471396 0 +0.195090 0.471396 0 +0.00000 0.555570 0 +0.0980171 0.555570 0 +0.195090 0.555570 0 +0.195090 0.382683 0 +0.290284 0.382683 0 +0.382683 0.382683 0 +0.195090 0.471396 0 +0.290284 0.471396 0 +0.382683 0.471396 0 +0.195090 0.555570 0 +0.290284 0.555570 0 +0.382683 0.555570 0 +0.00000 0.555570 0 +0.0980171 0.555570 0 +0.195090 0.555570 0 +0.00000 0.634393 0 +0.0980171 0.634393 0 +0.195090 0.634393 0 +0.00000 0.707107 0 +0.0980171 0.707107 0 +0.195090 0.707107 0 +0.195090 0.555570 0 +0.290284 0.555570 0 +0.382683 0.555570 0 +0.195090 0.634393 0 +0.290284 0.634393 0 +0.382683 0.634393 0 +0.195090 0.707107 0 +0.290284 0.707107 0 +0.382683 0.707107 0 +0.382683 0.382683 0 +0.471396 0.382683 0 +0.555570 0.382683 0 +0.382683 0.471396 0 +0.471396 0.471396 0 +0.555570 0.471396 0 +0.382683 0.555570 0 +0.471396 0.555570 0 +0.555570 0.555570 0 +0.555570 0.382683 0 +0.634393 0.382683 0 +0.707107 0.382683 0 +0.555570 0.471396 0 +0.634393 0.471396 0 +0.707107 0.471396 0 +0.555570 0.555570 0 +0.634393 0.555570 0 +0.707107 0.555570 0 +0.382683 0.555570 0 +0.471396 0.555570 0 +0.555570 0.555570 0 +0.382683 0.634393 0 +0.471396 0.634393 0 +0.555570 0.634393 0 +0.382683 0.707107 0 +0.471396 0.707107 0 +0.555570 0.707107 0 +0.555570 0.555570 0 +0.634393 0.555570 0 +0.707107 0.555570 0 +0.555570 0.634393 0 +0.634393 0.634393 0 +0.707107 0.634393 0 +0.555570 0.707107 0 +0.634393 0.707107 0 +0.707107 0.707107 0 + +CELLS 16 160 +9 0 2 8 6 1 5 7 3 4 +9 9 11 17 15 10 14 16 12 13 +9 18 20 26 24 19 23 25 21 22 +9 27 29 35 33 28 32 34 30 31 +9 36 38 44 42 37 41 43 39 40 +9 45 47 53 51 46 50 52 48 49 +9 54 56 62 60 55 59 61 57 58 +9 63 65 71 69 64 68 70 66 67 +9 72 74 80 78 73 77 79 75 76 +9 81 83 89 87 82 86 88 84 85 +9 90 92 98 96 91 95 97 93 94 +9 99 101 107 105 100 104 106 102 103 +9 108 110 116 114 109 113 115 111 112 +9 117 119 125 123 118 122 124 120 121 +9 126 128 134 132 127 131 133 129 130 +9 135 137 143 141 136 140 142 138 139 + +CELL_TYPES 16 + 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 +POINT_DATA 144 + +# vtk DataFile Version 3.0 +#This file was generated +ASCII +DATASET UNSTRUCTURED_GRID + +POINTS 144 double +0.707107 0.00000 0 +0.773010 0.00000 0 +0.831470 0.00000 0 +0.707107 0.0980171 0 +0.773010 0.0980171 0 +0.831470 0.0980171 0 +0.707107 0.195090 0 +0.773010 0.195090 0 +0.831470 0.195090 0 +0.831470 0.00000 0 +0.881921 0.00000 0 +0.923880 0.00000 0 +0.831470 0.0980171 0 +0.881921 0.0980171 0 +0.923880 0.0980171 0 +0.831470 0.195090 0 +0.881921 0.195090 0 +0.923880 0.195090 0 +0.707107 0.195090 0 +0.773010 0.195090 0 +0.831470 0.195090 0 +0.707107 0.290284 0 +0.773010 0.290284 0 +0.831470 0.290284 0 +0.707107 0.382683 0 +0.773010 0.382683 0 +0.831470 0.382683 0 +0.831470 0.195090 0 +0.881921 0.195090 0 +0.923880 0.195090 0 +0.831470 0.290284 0 +0.881921 0.290284 0 +0.923880 0.290284 0 +0.831470 0.382683 0 +0.881921 0.382683 0 +0.923880 0.382683 0 +0.923880 0.00000 0 +0.956940 0.00000 0 +0.980785 0.00000 0 +0.923880 0.0980171 0 +0.956940 0.0980171 0 +0.980785 0.0980171 0 +0.923880 0.195090 0 +0.956940 0.195090 0 +0.980785 0.195090 0 +0.980785 0.00000 0 +0.995184 0.00000 0 +1.00000 0.00000 0 +0.980785 0.0980171 0 +0.995184 0.0980171 0 +1.00000 0.0980171 0 +0.980785 0.195090 0 +0.995184 0.195090 0 +1.00000 0.195090 0 +0.923880 0.195090 0 +0.956940 0.195090 0 +0.980785 0.195090 0 +0.923880 0.290284 0 +0.956940 0.290284 0 +0.980785 0.290284 0 +0.923880 0.382683 0 +0.956940 0.382683 0 +0.980785 0.382683 0 +0.980785 0.195090 0 +0.995184 0.195090 0 +1.00000 0.195090 0 +0.980785 0.290284 0 +0.995184 0.290284 0 +1.00000 0.290284 0 +0.980785 0.382683 0 +0.995184 0.382683 0 +1.00000 0.382683 0 +0.707107 0.382683 0 +0.773010 0.382683 0 +0.831470 0.382683 0 +0.707107 0.471396 0 +0.773010 0.471396 0 +0.831470 0.471396 0 +0.707107 0.555570 0 +0.773010 0.555570 0 +0.831470 0.555570 0 +0.831470 0.382683 0 +0.881921 0.382683 0 +0.923880 0.382683 0 +0.831470 0.471396 0 +0.881921 0.471396 0 +0.923880 0.471396 0 +0.831470 0.555570 0 +0.881921 0.555570 0 +0.923880 0.555570 0 +0.707107 0.555570 0 +0.773010 0.555570 0 +0.831470 0.555570 0 +0.707107 0.634393 0 +0.773010 0.634393 0 +0.831470 0.634393 0 +0.707107 0.707107 0 +0.773010 0.707107 0 +0.831470 0.707107 0 +0.831470 0.555570 0 +0.881921 0.555570 0 +0.923880 0.555570 0 +0.831470 0.634393 0 +0.881921 0.634393 0 +0.923880 0.634393 0 +0.831470 0.707107 0 +0.881921 0.707107 0 +0.923880 0.707107 0 +0.923880 0.382683 0 +0.956940 0.382683 0 +0.980785 0.382683 0 +0.923880 0.471396 0 +0.956940 0.471396 0 +0.980785 0.471396 0 +0.923880 0.555570 0 +0.956940 0.555570 0 +0.980785 0.555570 0 +0.980785 0.382683 0 +0.995184 0.382683 0 +1.00000 0.382683 0 +0.980785 0.471396 0 +0.995184 0.471396 0 +1.00000 0.471396 0 +0.980785 0.555570 0 +0.995184 0.555570 0 +1.00000 0.555570 0 +0.923880 0.555570 0 +0.956940 0.555570 0 +0.980785 0.555570 0 +0.923880 0.634393 0 +0.956940 0.634393 0 +0.980785 0.634393 0 +0.923880 0.707107 0 +0.956940 0.707107 0 +0.980785 0.707107 0 +0.980785 0.555570 0 +0.995184 0.555570 0 +1.00000 0.555570 0 +0.980785 0.634393 0 +0.995184 0.634393 0 +1.00000 0.634393 0 +0.980785 0.707107 0 +0.995184 0.707107 0 +1.00000 0.707107 0 + +CELLS 16 160 +9 0 2 8 6 1 5 7 3 4 +9 9 11 17 15 10 14 16 12 13 +9 18 20 26 24 19 23 25 21 22 +9 27 29 35 33 28 32 34 30 31 +9 36 38 44 42 37 41 43 39 40 +9 45 47 53 51 46 50 52 48 49 +9 54 56 62 60 55 59 61 57 58 +9 63 65 71 69 64 68 70 66 67 +9 72 74 80 78 73 77 79 75 76 +9 81 83 89 87 82 86 88 84 85 +9 90 92 98 96 91 95 97 93 94 +9 99 101 107 105 100 104 106 102 103 +9 108 110 116 114 109 113 115 111 112 +9 117 119 125 123 118 122 124 120 121 +9 126 128 134 132 127 131 133 129 130 +9 135 137 143 141 136 140 142 138 139 + +CELL_TYPES 16 + 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 +POINT_DATA 144 +# vtk DataFile Version 3.0 +#This file was generated +ASCII +DATASET UNSTRUCTURED_GRID + +POINTS 144 double +0.707107 0.00000 0 +0.773010 0.00000 0 +0.831470 0.00000 0 +0.707107 0.0980171 0 +0.773010 0.0980171 0 +0.831470 0.0980171 0 +0.707107 0.195090 0 +0.773010 0.195090 0 +0.831470 0.195090 0 +0.831470 0.00000 0 +0.881921 0.00000 0 +0.923880 0.00000 0 +0.831470 0.0980171 0 +0.881921 0.0980171 0 +0.923880 0.0980171 0 +0.831470 0.195090 0 +0.881921 0.195090 0 +0.923880 0.195090 0 +0.707107 0.195090 0 +0.773010 0.195090 0 +0.831470 0.195090 0 +0.707107 0.290284 0 +0.773010 0.290284 0 +0.831470 0.290284 0 +0.707107 0.382683 0 +0.773010 0.382683 0 +0.831470 0.382683 0 +0.831470 0.195090 0 +0.881921 0.195090 0 +0.923880 0.195090 0 +0.831470 0.290284 0 +0.881921 0.290284 0 +0.923880 0.290284 0 +0.831470 0.382683 0 +0.881921 0.382683 0 +0.923880 0.382683 0 +0.923880 0.00000 0 +0.956940 0.00000 0 +0.980785 0.00000 0 +0.923880 0.0980171 0 +0.956940 0.0980171 0 +0.980785 0.0980171 0 +0.923880 0.195090 0 +0.956940 0.195090 0 +0.980785 0.195090 0 +0.980785 0.00000 0 +0.995184 0.00000 0 +1.00000 0.00000 0 +0.980785 0.0980171 0 +0.995184 0.0980171 0 +1.00000 0.0980171 0 +0.980785 0.195090 0 +0.995184 0.195090 0 +1.00000 0.195090 0 +0.923880 0.195090 0 +0.956940 0.195090 0 +0.980785 0.195090 0 +0.923880 0.290284 0 +0.956940 0.290284 0 +0.980785 0.290284 0 +0.923880 0.382683 0 +0.956940 0.382683 0 +0.980785 0.382683 0 +0.980785 0.195090 0 +0.995184 0.195090 0 +1.00000 0.195090 0 +0.980785 0.290284 0 +0.995184 0.290284 0 +1.00000 0.290284 0 +0.980785 0.382683 0 +0.995184 0.382683 0 +1.00000 0.382683 0 +0.707107 0.382683 0 +0.773010 0.382683 0 +0.831470 0.382683 0 +0.707107 0.471396 0 +0.773010 0.471396 0 +0.831470 0.471396 0 +0.707107 0.555570 0 +0.773010 0.555570 0 +0.831470 0.555570 0 +0.831470 0.382683 0 +0.881921 0.382683 0 +0.923880 0.382683 0 +0.831470 0.471396 0 +0.881921 0.471396 0 +0.923880 0.471396 0 +0.831470 0.555570 0 +0.881921 0.555570 0 +0.923880 0.555570 0 +0.707107 0.555570 0 +0.773010 0.555570 0 +0.831470 0.555570 0 +0.707107 0.634393 0 +0.773010 0.634393 0 +0.831470 0.634393 0 +0.707107 0.707107 0 +0.773010 0.707107 0 +0.831470 0.707107 0 +0.831470 0.555570 0 +0.881921 0.555570 0 +0.923880 0.555570 0 +0.831470 0.634393 0 +0.881921 0.634393 0 +0.923880 0.634393 0 +0.831470 0.707107 0 +0.881921 0.707107 0 +0.923880 0.707107 0 +0.923880 0.382683 0 +0.956940 0.382683 0 +0.980785 0.382683 0 +0.923880 0.471396 0 +0.956940 0.471396 0 +0.980785 0.471396 0 +0.923880 0.555570 0 +0.956940 0.555570 0 +0.980785 0.555570 0 +0.980785 0.382683 0 +0.995184 0.382683 0 +1.00000 0.382683 0 +0.980785 0.471396 0 +0.995184 0.471396 0 +1.00000 0.471396 0 +0.980785 0.555570 0 +0.995184 0.555570 0 +1.00000 0.555570 0 +0.923880 0.555570 0 +0.956940 0.555570 0 +0.980785 0.555570 0 +0.923880 0.634393 0 +0.956940 0.634393 0 +0.980785 0.634393 0 +0.923880 0.707107 0 +0.956940 0.707107 0 +0.980785 0.707107 0 +0.980785 0.555570 0 +0.995184 0.555570 0 +1.00000 0.555570 0 +0.980785 0.634393 0 +0.995184 0.634393 0 +1.00000 0.634393 0 +0.980785 0.707107 0 +0.995184 0.707107 0 +1.00000 0.707107 0 + +CELLS 16 160 +9 0 2 8 6 1 5 7 3 4 +9 9 11 17 15 10 14 16 12 13 +9 18 20 26 24 19 23 25 21 22 +9 27 29 35 33 28 32 34 30 31 +9 36 38 44 42 37 41 43 39 40 +9 45 47 53 51 46 50 52 48 49 +9 54 56 62 60 55 59 61 57 58 +9 63 65 71 69 64 68 70 66 67 +9 72 74 80 78 73 77 79 75 76 +9 81 83 89 87 82 86 88 84 85 +9 90 92 98 96 91 95 97 93 94 +9 99 101 107 105 100 104 106 102 103 +9 108 110 116 114 109 113 115 111 112 +9 117 119 125 123 118 122 124 120 121 +9 126 128 134 132 127 131 133 129 130 +9 135 137 143 141 136 140 142 138 139 + +CELL_TYPES 16 + 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 +POINT_DATA 144 +# vtk DataFile Version 3.0 +#This file was generated +ASCII +DATASET UNSTRUCTURED_GRID + +POINTS 144 double +0.707107 0.00000 0 +0.773010 0.00000 0 +0.831470 0.00000 0 +0.707107 0.0980171 0 +0.773010 0.0980171 0 +0.831470 0.0980171 0 +0.707107 0.195090 0 +0.773010 0.195090 0 +0.831470 0.195090 0 +0.831470 0.00000 0 +0.881921 0.00000 0 +0.923880 0.00000 0 +0.831470 0.0980171 0 +0.881921 0.0980171 0 +0.923880 0.0980171 0 +0.831470 0.195090 0 +0.881921 0.195090 0 +0.923880 0.195090 0 +0.707107 0.195090 0 +0.773010 0.195090 0 +0.831470 0.195090 0 +0.707107 0.290284 0 +0.773010 0.290284 0 +0.831470 0.290284 0 +0.707107 0.382683 0 +0.773010 0.382683 0 +0.831470 0.382683 0 +0.831470 0.195090 0 +0.881921 0.195090 0 +0.923880 0.195090 0 +0.831470 0.290284 0 +0.881921 0.290284 0 +0.923880 0.290284 0 +0.831470 0.382683 0 +0.881921 0.382683 0 +0.923880 0.382683 0 +0.923880 0.00000 0 +0.956940 0.00000 0 +0.980785 0.00000 0 +0.923880 0.0980171 0 +0.956940 0.0980171 0 +0.980785 0.0980171 0 +0.923880 0.195090 0 +0.956940 0.195090 0 +0.980785 0.195090 0 +0.980785 0.00000 0 +0.995184 0.00000 0 +1.00000 0.00000 0 +0.980785 0.0980171 0 +0.995184 0.0980171 0 +1.00000 0.0980171 0 +0.980785 0.195090 0 +0.995184 0.195090 0 +1.00000 0.195090 0 +0.923880 0.195090 0 +0.956940 0.195090 0 +0.980785 0.195090 0 +0.923880 0.290284 0 +0.956940 0.290284 0 +0.980785 0.290284 0 +0.923880 0.382683 0 +0.956940 0.382683 0 +0.980785 0.382683 0 +0.980785 0.195090 0 +0.995184 0.195090 0 +1.00000 0.195090 0 +0.980785 0.290284 0 +0.995184 0.290284 0 +1.00000 0.290284 0 +0.980785 0.382683 0 +0.995184 0.382683 0 +1.00000 0.382683 0 +0.707107 0.382683 0 +0.773010 0.382683 0 +0.831470 0.382683 0 +0.707107 0.471396 0 +0.773010 0.471396 0 +0.831470 0.471396 0 +0.707107 0.555570 0 +0.773010 0.555570 0 +0.831470 0.555570 0 +0.831470 0.382683 0 +0.881921 0.382683 0 +0.923880 0.382683 0 +0.831470 0.471396 0 +0.881921 0.471396 0 +0.923880 0.471396 0 +0.831470 0.555570 0 +0.881921 0.555570 0 +0.923880 0.555570 0 +0.707107 0.555570 0 +0.773010 0.555570 0 +0.831470 0.555570 0 +0.707107 0.634393 0 +0.773010 0.634393 0 +0.831470 0.634393 0 +0.707107 0.707107 0 +0.773010 0.707107 0 +0.831470 0.707107 0 +0.831470 0.555570 0 +0.881921 0.555570 0 +0.923880 0.555570 0 +0.831470 0.634393 0 +0.881921 0.634393 0 +0.923880 0.634393 0 +0.831470 0.707107 0 +0.881921 0.707107 0 +0.923880 0.707107 0 +0.923880 0.382683 0 +0.956940 0.382683 0 +0.980785 0.382683 0 +0.923880 0.471396 0 +0.956940 0.471396 0 +0.980785 0.471396 0 +0.923880 0.555570 0 +0.956940 0.555570 0 +0.980785 0.555570 0 +0.980785 0.382683 0 +0.995184 0.382683 0 +1.00000 0.382683 0 +0.980785 0.471396 0 +0.995184 0.471396 0 +1.00000 0.471396 0 +0.980785 0.555570 0 +0.995184 0.555570 0 +1.00000 0.555570 0 +0.923880 0.555570 0 +0.956940 0.555570 0 +0.980785 0.555570 0 +0.923880 0.634393 0 +0.956940 0.634393 0 +0.980785 0.634393 0 +0.923880 0.707107 0 +0.956940 0.707107 0 +0.980785 0.707107 0 +0.980785 0.555570 0 +0.995184 0.555570 0 +1.00000 0.555570 0 +0.980785 0.634393 0 +0.995184 0.634393 0 +1.00000 0.634393 0 +0.980785 0.707107 0 +0.995184 0.707107 0 +1.00000 0.707107 0 + +CELLS 16 160 +9 0 2 8 6 1 5 7 3 4 +9 9 11 17 15 10 14 16 12 13 +9 18 20 26 24 19 23 25 21 22 +9 27 29 35 33 28 32 34 30 31 +9 36 38 44 42 37 41 43 39 40 +9 45 47 53 51 46 50 52 48 49 +9 54 56 62 60 55 59 61 57 58 +9 63 65 71 69 64 68 70 66 67 +9 72 74 80 78 73 77 79 75 76 +9 81 83 89 87 82 86 88 84 85 +9 90 92 98 96 91 95 97 93 94 +9 99 101 107 105 100 104 106 102 103 +9 108 110 116 114 109 113 115 111 112 +9 117 119 125 123 118 122 124 120 121 +9 126 128 134 132 127 131 133 129 130 +9 135 137 143 141 136 140 142 138 139 + +CELL_TYPES 16 + 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 +POINT_DATA 144 +# vtk DataFile Version 3.0 +#This file was generated +ASCII +DATASET UNSTRUCTURED_GRID + +POINTS 144 double +0.707107 0.00000 0 +0.773010 0.00000 0 +0.831470 0.00000 0 +0.707107 0.0980171 0 +0.773010 0.0980171 0 +0.831470 0.0980171 0 +0.707107 0.195090 0 +0.773010 0.195090 0 +0.831470 0.195090 0 +0.831470 0.00000 0 +0.881921 0.00000 0 +0.923880 0.00000 0 +0.831470 0.0980171 0 +0.881921 0.0980171 0 +0.923880 0.0980171 0 +0.831470 0.195090 0 +0.881921 0.195090 0 +0.923880 0.195090 0 +0.707107 0.195090 0 +0.773010 0.195090 0 +0.831470 0.195090 0 +0.707107 0.290284 0 +0.773010 0.290284 0 +0.831470 0.290284 0 +0.707107 0.382683 0 +0.773010 0.382683 0 +0.831470 0.382683 0 +0.831470 0.195090 0 +0.881921 0.195090 0 +0.923880 0.195090 0 +0.831470 0.290284 0 +0.881921 0.290284 0 +0.923880 0.290284 0 +0.831470 0.382683 0 +0.881921 0.382683 0 +0.923880 0.382683 0 +0.923880 0.00000 0 +0.956940 0.00000 0 +0.980785 0.00000 0 +0.923880 0.0980171 0 +0.956940 0.0980171 0 +0.980785 0.0980171 0 +0.923880 0.195090 0 +0.956940 0.195090 0 +0.980785 0.195090 0 +0.980785 0.00000 0 +0.995184 0.00000 0 +1.00000 0.00000 0 +0.980785 0.0980171 0 +0.995184 0.0980171 0 +1.00000 0.0980171 0 +0.980785 0.195090 0 +0.995184 0.195090 0 +1.00000 0.195090 0 +0.923880 0.195090 0 +0.956940 0.195090 0 +0.980785 0.195090 0 +0.923880 0.290284 0 +0.956940 0.290284 0 +0.980785 0.290284 0 +0.923880 0.382683 0 +0.956940 0.382683 0 +0.980785 0.382683 0 +0.980785 0.195090 0 +0.995184 0.195090 0 +1.00000 0.195090 0 +0.980785 0.290284 0 +0.995184 0.290284 0 +1.00000 0.290284 0 +0.980785 0.382683 0 +0.995184 0.382683 0 +1.00000 0.382683 0 +0.707107 0.382683 0 +0.773010 0.382683 0 +0.831470 0.382683 0 +0.707107 0.471396 0 +0.773010 0.471396 0 +0.831470 0.471396 0 +0.707107 0.555570 0 +0.773010 0.555570 0 +0.831470 0.555570 0 +0.831470 0.382683 0 +0.881921 0.382683 0 +0.923880 0.382683 0 +0.831470 0.471396 0 +0.881921 0.471396 0 +0.923880 0.471396 0 +0.831470 0.555570 0 +0.881921 0.555570 0 +0.923880 0.555570 0 +0.707107 0.555570 0 +0.773010 0.555570 0 +0.831470 0.555570 0 +0.707107 0.634393 0 +0.773010 0.634393 0 +0.831470 0.634393 0 +0.707107 0.707107 0 +0.773010 0.707107 0 +0.831470 0.707107 0 +0.831470 0.555570 0 +0.881921 0.555570 0 +0.923880 0.555570 0 +0.831470 0.634393 0 +0.881921 0.634393 0 +0.923880 0.634393 0 +0.831470 0.707107 0 +0.881921 0.707107 0 +0.923880 0.707107 0 +0.923880 0.382683 0 +0.956940 0.382683 0 +0.980785 0.382683 0 +0.923880 0.471396 0 +0.956940 0.471396 0 +0.980785 0.471396 0 +0.923880 0.555570 0 +0.956940 0.555570 0 +0.980785 0.555570 0 +0.980785 0.382683 0 +0.995184 0.382683 0 +1.00000 0.382683 0 +0.980785 0.471396 0 +0.995184 0.471396 0 +1.00000 0.471396 0 +0.980785 0.555570 0 +0.995184 0.555570 0 +1.00000 0.555570 0 +0.923880 0.555570 0 +0.956940 0.555570 0 +0.980785 0.555570 0 +0.923880 0.634393 0 +0.956940 0.634393 0 +0.980785 0.634393 0 +0.923880 0.707107 0 +0.956940 0.707107 0 +0.980785 0.707107 0 +0.980785 0.555570 0 +0.995184 0.555570 0 +1.00000 0.555570 0 +0.980785 0.634393 0 +0.995184 0.634393 0 +1.00000 0.634393 0 +0.980785 0.707107 0 +0.995184 0.707107 0 +1.00000 0.707107 0 + +CELLS 16 160 +9 0 2 8 6 1 5 7 3 4 +9 9 11 17 15 10 14 16 12 13 +9 18 20 26 24 19 23 25 21 22 +9 27 29 35 33 28 32 34 30 31 +9 36 38 44 42 37 41 43 39 40 +9 45 47 53 51 46 50 52 48 49 +9 54 56 62 60 55 59 61 57 58 +9 63 65 71 69 64 68 70 66 67 +9 72 74 80 78 73 77 79 75 76 +9 81 83 89 87 82 86 88 84 85 +9 90 92 98 96 91 95 97 93 94 +9 99 101 107 105 100 104 106 102 103 +9 108 110 116 114 109 113 115 111 112 +9 117 119 125 123 118 122 124 120 121 +9 126 128 134 132 127 131 133 129 130 +9 135 137 143 141 136 140 142 138 139 + +CELL_TYPES 16 + 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 +POINT_DATA 144 + + +# vtk DataFile Version 3.0 +#This file was generated +ASCII +DATASET UNSTRUCTURED_GRID + +POINTS 144 double +0.00000 0.707107 0 +0.0980171 0.707107 0 +0.195090 0.707107 0 +0.00000 0.773010 0 +0.0980171 0.773010 0 +0.195090 0.773010 0 +0.00000 0.831470 0 +0.0980171 0.831470 0 +0.195090 0.831470 0 +0.195090 0.707107 0 +0.290284 0.707107 0 +0.382683 0.707107 0 +0.195090 0.773010 0 +0.290284 0.773010 0 +0.382683 0.773010 0 +0.195090 0.831470 0 +0.290284 0.831470 0 +0.382683 0.831470 0 +0.00000 0.831470 0 +0.0980171 0.831470 0 +0.195090 0.831470 0 +0.00000 0.881921 0 +0.0980171 0.881921 0 +0.195090 0.881921 0 +0.00000 0.923880 0 +0.0980171 0.923880 0 +0.195090 0.923880 0 +0.195090 0.831470 0 +0.290284 0.831470 0 +0.382683 0.831470 0 +0.195090 0.881921 0 +0.290284 0.881921 0 +0.382683 0.881921 0 +0.195090 0.923880 0 +0.290284 0.923880 0 +0.382683 0.923880 0 +0.382683 0.707107 0 +0.471396 0.707107 0 +0.555570 0.707107 0 +0.382683 0.773010 0 +0.471396 0.773010 0 +0.555570 0.773010 0 +0.382683 0.831470 0 +0.471396 0.831470 0 +0.555570 0.831470 0 +0.555570 0.707107 0 +0.634393 0.707107 0 +0.707107 0.707107 0 +0.555570 0.773010 0 +0.634393 0.773010 0 +0.707107 0.773010 0 +0.555570 0.831470 0 +0.634393 0.831470 0 +0.707107 0.831470 0 +0.382683 0.831470 0 +0.471396 0.831470 0 +0.555570 0.831470 0 +0.382683 0.881921 0 +0.471396 0.881921 0 +0.555570 0.881921 0 +0.382683 0.923880 0 +0.471396 0.923880 0 +0.555570 0.923880 0 +0.555570 0.831470 0 +0.634393 0.831470 0 +0.707107 0.831470 0 +0.555570 0.881921 0 +0.634393 0.881921 0 +0.707107 0.881921 0 +0.555570 0.923880 0 +0.634393 0.923880 0 +0.707107 0.923880 0 +0.00000 0.923880 0 +0.0980171 0.923880 0 +0.195090 0.923880 0 +0.00000 0.956940 0 +0.0980171 0.956940 0 +0.195090 0.956940 0 +0.00000 0.980785 0 +0.0980171 0.980785 0 +0.195090 0.980785 0 +0.195090 0.923880 0 +0.290284 0.923880 0 +0.382683 0.923880 0 +0.195090 0.956940 0 +0.290284 0.956940 0 +0.382683 0.956940 0 +0.195090 0.980785 0 +0.290284 0.980785 0 +0.382683 0.980785 0 +0.00000 0.980785 0 +0.0980171 0.980785 0 +0.195090 0.980785 0 +0.00000 0.995184 0 +0.0980171 0.995184 0 +0.195090 0.995184 0 +0.00000 1.00000 0 +0.0980171 1.00000 0 +0.195090 1.00000 0 +0.195090 0.980785 0 +0.290284 0.980785 0 +0.382683 0.980785 0 +0.195090 0.995184 0 +0.290284 0.995184 0 +0.382683 0.995184 0 +0.195090 1.00000 0 +0.290284 1.00000 0 +0.382683 1.00000 0 +0.382683 0.923880 0 +0.471396 0.923880 0 +0.555570 0.923880 0 +0.382683 0.956940 0 +0.471396 0.956940 0 +0.555570 0.956940 0 +0.382683 0.980785 0 +0.471396 0.980785 0 +0.555570 0.980785 0 +0.555570 0.923880 0 +0.634393 0.923880 0 +0.707107 0.923880 0 +0.555570 0.956940 0 +0.634393 0.956940 0 +0.707107 0.956940 0 +0.555570 0.980785 0 +0.634393 0.980785 0 +0.707107 0.980785 0 +0.382683 0.980785 0 +0.471396 0.980785 0 +0.555570 0.980785 0 +0.382683 0.995184 0 +0.471396 0.995184 0 +0.555570 0.995184 0 +0.382683 1.00000 0 +0.471396 1.00000 0 +0.555570 1.00000 0 +0.555570 0.980785 0 +0.634393 0.980785 0 +0.707107 0.980785 0 +0.555570 0.995184 0 +0.634393 0.995184 0 +0.707107 0.995184 0 +0.555570 1.00000 0 +0.634393 1.00000 0 +0.707107 1.00000 0 + +CELLS 16 160 +9 0 2 8 6 1 5 7 3 4 +9 9 11 17 15 10 14 16 12 13 +9 18 20 26 24 19 23 25 21 22 +9 27 29 35 33 28 32 34 30 31 +9 36 38 44 42 37 41 43 39 40 +9 45 47 53 51 46 50 52 48 49 +9 54 56 62 60 55 59 61 57 58 +9 63 65 71 69 64 68 70 66 67 +9 72 74 80 78 73 77 79 75 76 +9 81 83 89 87 82 86 88 84 85 +9 90 92 98 96 91 95 97 93 94 +9 99 101 107 105 100 104 106 102 103 +9 108 110 116 114 109 113 115 111 112 +9 117 119 125 123 118 122 124 120 121 +9 126 128 134 132 127 131 133 129 130 +9 135 137 143 141 136 140 142 138 139 + +CELL_TYPES 16 + 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 +POINT_DATA 144 +# vtk DataFile Version 3.0 +#This file was generated +ASCII +DATASET UNSTRUCTURED_GRID + +POINTS 144 double +0.00000 0.707107 0 +0.0980171 0.707107 0 +0.195090 0.707107 0 +0.00000 0.773010 0 +0.0980171 0.773010 0 +0.195090 0.773010 0 +0.00000 0.831470 0 +0.0980171 0.831470 0 +0.195090 0.831470 0 +0.195090 0.707107 0 +0.290284 0.707107 0 +0.382683 0.707107 0 +0.195090 0.773010 0 +0.290284 0.773010 0 +0.382683 0.773010 0 +0.195090 0.831470 0 +0.290284 0.831470 0 +0.382683 0.831470 0 +0.00000 0.831470 0 +0.0980171 0.831470 0 +0.195090 0.831470 0 +0.00000 0.881921 0 +0.0980171 0.881921 0 +0.195090 0.881921 0 +0.00000 0.923880 0 +0.0980171 0.923880 0 +0.195090 0.923880 0 +0.195090 0.831470 0 +0.290284 0.831470 0 +0.382683 0.831470 0 +0.195090 0.881921 0 +0.290284 0.881921 0 +0.382683 0.881921 0 +0.195090 0.923880 0 +0.290284 0.923880 0 +0.382683 0.923880 0 +0.382683 0.707107 0 +0.471396 0.707107 0 +0.555570 0.707107 0 +0.382683 0.773010 0 +0.471396 0.773010 0 +0.555570 0.773010 0 +0.382683 0.831470 0 +0.471396 0.831470 0 +0.555570 0.831470 0 +0.555570 0.707107 0 +0.634393 0.707107 0 +0.707107 0.707107 0 +0.555570 0.773010 0 +0.634393 0.773010 0 +0.707107 0.773010 0 +0.555570 0.831470 0 +0.634393 0.831470 0 +0.707107 0.831470 0 +0.382683 0.831470 0 +0.471396 0.831470 0 +0.555570 0.831470 0 +0.382683 0.881921 0 +0.471396 0.881921 0 +0.555570 0.881921 0 +0.382683 0.923880 0 +0.471396 0.923880 0 +0.555570 0.923880 0 +0.555570 0.831470 0 +0.634393 0.831470 0 +0.707107 0.831470 0 +0.555570 0.881921 0 +0.634393 0.881921 0 +0.707107 0.881921 0 +0.555570 0.923880 0 +0.634393 0.923880 0 +0.707107 0.923880 0 +0.00000 0.923880 0 +0.0980171 0.923880 0 +0.195090 0.923880 0 +0.00000 0.956940 0 +0.0980171 0.956940 0 +0.195090 0.956940 0 +0.00000 0.980785 0 +0.0980171 0.980785 0 +0.195090 0.980785 0 +0.195090 0.923880 0 +0.290284 0.923880 0 +0.382683 0.923880 0 +0.195090 0.956940 0 +0.290284 0.956940 0 +0.382683 0.956940 0 +0.195090 0.980785 0 +0.290284 0.980785 0 +0.382683 0.980785 0 +0.00000 0.980785 0 +0.0980171 0.980785 0 +0.195090 0.980785 0 +0.00000 0.995184 0 +0.0980171 0.995184 0 +0.195090 0.995184 0 +0.00000 1.00000 0 +0.0980171 1.00000 0 +0.195090 1.00000 0 +0.195090 0.980785 0 +0.290284 0.980785 0 +0.382683 0.980785 0 +0.195090 0.995184 0 +0.290284 0.995184 0 +0.382683 0.995184 0 +0.195090 1.00000 0 +0.290284 1.00000 0 +0.382683 1.00000 0 +0.382683 0.923880 0 +0.471396 0.923880 0 +0.555570 0.923880 0 +0.382683 0.956940 0 +0.471396 0.956940 0 +0.555570 0.956940 0 +0.382683 0.980785 0 +0.471396 0.980785 0 +0.555570 0.980785 0 +0.555570 0.923880 0 +0.634393 0.923880 0 +0.707107 0.923880 0 +0.555570 0.956940 0 +0.634393 0.956940 0 +0.707107 0.956940 0 +0.555570 0.980785 0 +0.634393 0.980785 0 +0.707107 0.980785 0 +0.382683 0.980785 0 +0.471396 0.980785 0 +0.555570 0.980785 0 +0.382683 0.995184 0 +0.471396 0.995184 0 +0.555570 0.995184 0 +0.382683 1.00000 0 +0.471396 1.00000 0 +0.555570 1.00000 0 +0.555570 0.980785 0 +0.634393 0.980785 0 +0.707107 0.980785 0 +0.555570 0.995184 0 +0.634393 0.995184 0 +0.707107 0.995184 0 +0.555570 1.00000 0 +0.634393 1.00000 0 +0.707107 1.00000 0 + +CELLS 16 160 +9 0 2 8 6 1 5 7 3 4 +9 9 11 17 15 10 14 16 12 13 +9 18 20 26 24 19 23 25 21 22 +9 27 29 35 33 28 32 34 30 31 +9 36 38 44 42 37 41 43 39 40 +9 45 47 53 51 46 50 52 48 49 +9 54 56 62 60 55 59 61 57 58 +9 63 65 71 69 64 68 70 66 67 +9 72 74 80 78 73 77 79 75 76 +9 81 83 89 87 82 86 88 84 85 +9 90 92 98 96 91 95 97 93 94 +9 99 101 107 105 100 104 106 102 103 +9 108 110 116 114 109 113 115 111 112 +9 117 119 125 123 118 122 124 120 121 +9 126 128 134 132 127 131 133 129 130 +9 135 137 143 141 136 140 142 138 139 + +CELL_TYPES 16 + 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 +POINT_DATA 144 +# vtk DataFile Version 3.0 +#This file was generated +ASCII +DATASET UNSTRUCTURED_GRID + +POINTS 144 double +0.00000 0.707107 0 +0.0980171 0.707107 0 +0.195090 0.707107 0 +0.00000 0.773010 0 +0.0980171 0.773010 0 +0.195090 0.773010 0 +0.00000 0.831470 0 +0.0980171 0.831470 0 +0.195090 0.831470 0 +0.195090 0.707107 0 +0.290284 0.707107 0 +0.382683 0.707107 0 +0.195090 0.773010 0 +0.290284 0.773010 0 +0.382683 0.773010 0 +0.195090 0.831470 0 +0.290284 0.831470 0 +0.382683 0.831470 0 +0.00000 0.831470 0 +0.0980171 0.831470 0 +0.195090 0.831470 0 +0.00000 0.881921 0 +0.0980171 0.881921 0 +0.195090 0.881921 0 +0.00000 0.923880 0 +0.0980171 0.923880 0 +0.195090 0.923880 0 +0.195090 0.831470 0 +0.290284 0.831470 0 +0.382683 0.831470 0 +0.195090 0.881921 0 +0.290284 0.881921 0 +0.382683 0.881921 0 +0.195090 0.923880 0 +0.290284 0.923880 0 +0.382683 0.923880 0 +0.382683 0.707107 0 +0.471396 0.707107 0 +0.555570 0.707107 0 +0.382683 0.773010 0 +0.471396 0.773010 0 +0.555570 0.773010 0 +0.382683 0.831470 0 +0.471396 0.831470 0 +0.555570 0.831470 0 +0.555570 0.707107 0 +0.634393 0.707107 0 +0.707107 0.707107 0 +0.555570 0.773010 0 +0.634393 0.773010 0 +0.707107 0.773010 0 +0.555570 0.831470 0 +0.634393 0.831470 0 +0.707107 0.831470 0 +0.382683 0.831470 0 +0.471396 0.831470 0 +0.555570 0.831470 0 +0.382683 0.881921 0 +0.471396 0.881921 0 +0.555570 0.881921 0 +0.382683 0.923880 0 +0.471396 0.923880 0 +0.555570 0.923880 0 +0.555570 0.831470 0 +0.634393 0.831470 0 +0.707107 0.831470 0 +0.555570 0.881921 0 +0.634393 0.881921 0 +0.707107 0.881921 0 +0.555570 0.923880 0 +0.634393 0.923880 0 +0.707107 0.923880 0 +0.00000 0.923880 0 +0.0980171 0.923880 0 +0.195090 0.923880 0 +0.00000 0.956940 0 +0.0980171 0.956940 0 +0.195090 0.956940 0 +0.00000 0.980785 0 +0.0980171 0.980785 0 +0.195090 0.980785 0 +0.195090 0.923880 0 +0.290284 0.923880 0 +0.382683 0.923880 0 +0.195090 0.956940 0 +0.290284 0.956940 0 +0.382683 0.956940 0 +0.195090 0.980785 0 +0.290284 0.980785 0 +0.382683 0.980785 0 +0.00000 0.980785 0 +0.0980171 0.980785 0 +0.195090 0.980785 0 +0.00000 0.995184 0 +0.0980171 0.995184 0 +0.195090 0.995184 0 +0.00000 1.00000 0 +0.0980171 1.00000 0 +0.195090 1.00000 0 +0.195090 0.980785 0 +0.290284 0.980785 0 +0.382683 0.980785 0 +0.195090 0.995184 0 +0.290284 0.995184 0 +0.382683 0.995184 0 +0.195090 1.00000 0 +0.290284 1.00000 0 +0.382683 1.00000 0 +0.382683 0.923880 0 +0.471396 0.923880 0 +0.555570 0.923880 0 +0.382683 0.956940 0 +0.471396 0.956940 0 +0.555570 0.956940 0 +0.382683 0.980785 0 +0.471396 0.980785 0 +0.555570 0.980785 0 +0.555570 0.923880 0 +0.634393 0.923880 0 +0.707107 0.923880 0 +0.555570 0.956940 0 +0.634393 0.956940 0 +0.707107 0.956940 0 +0.555570 0.980785 0 +0.634393 0.980785 0 +0.707107 0.980785 0 +0.382683 0.980785 0 +0.471396 0.980785 0 +0.555570 0.980785 0 +0.382683 0.995184 0 +0.471396 0.995184 0 +0.555570 0.995184 0 +0.382683 1.00000 0 +0.471396 1.00000 0 +0.555570 1.00000 0 +0.555570 0.980785 0 +0.634393 0.980785 0 +0.707107 0.980785 0 +0.555570 0.995184 0 +0.634393 0.995184 0 +0.707107 0.995184 0 +0.555570 1.00000 0 +0.634393 1.00000 0 +0.707107 1.00000 0 + +CELLS 16 160 +9 0 2 8 6 1 5 7 3 4 +9 9 11 17 15 10 14 16 12 13 +9 18 20 26 24 19 23 25 21 22 +9 27 29 35 33 28 32 34 30 31 +9 36 38 44 42 37 41 43 39 40 +9 45 47 53 51 46 50 52 48 49 +9 54 56 62 60 55 59 61 57 58 +9 63 65 71 69 64 68 70 66 67 +9 72 74 80 78 73 77 79 75 76 +9 81 83 89 87 82 86 88 84 85 +9 90 92 98 96 91 95 97 93 94 +9 99 101 107 105 100 104 106 102 103 +9 108 110 116 114 109 113 115 111 112 +9 117 119 125 123 118 122 124 120 121 +9 126 128 134 132 127 131 133 129 130 +9 135 137 143 141 136 140 142 138 139 + +CELL_TYPES 16 + 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 +POINT_DATA 144 +# vtk DataFile Version 3.0 +#This file was generated +ASCII +DATASET UNSTRUCTURED_GRID + +POINTS 144 double +0.00000 0.707107 0 +0.0980171 0.707107 0 +0.195090 0.707107 0 +0.00000 0.773010 0 +0.0980171 0.773010 0 +0.195090 0.773010 0 +0.00000 0.831470 0 +0.0980171 0.831470 0 +0.195090 0.831470 0 +0.195090 0.707107 0 +0.290284 0.707107 0 +0.382683 0.707107 0 +0.195090 0.773010 0 +0.290284 0.773010 0 +0.382683 0.773010 0 +0.195090 0.831470 0 +0.290284 0.831470 0 +0.382683 0.831470 0 +0.00000 0.831470 0 +0.0980171 0.831470 0 +0.195090 0.831470 0 +0.00000 0.881921 0 +0.0980171 0.881921 0 +0.195090 0.881921 0 +0.00000 0.923880 0 +0.0980171 0.923880 0 +0.195090 0.923880 0 +0.195090 0.831470 0 +0.290284 0.831470 0 +0.382683 0.831470 0 +0.195090 0.881921 0 +0.290284 0.881921 0 +0.382683 0.881921 0 +0.195090 0.923880 0 +0.290284 0.923880 0 +0.382683 0.923880 0 +0.382683 0.707107 0 +0.471396 0.707107 0 +0.555570 0.707107 0 +0.382683 0.773010 0 +0.471396 0.773010 0 +0.555570 0.773010 0 +0.382683 0.831470 0 +0.471396 0.831470 0 +0.555570 0.831470 0 +0.555570 0.707107 0 +0.634393 0.707107 0 +0.707107 0.707107 0 +0.555570 0.773010 0 +0.634393 0.773010 0 +0.707107 0.773010 0 +0.555570 0.831470 0 +0.634393 0.831470 0 +0.707107 0.831470 0 +0.382683 0.831470 0 +0.471396 0.831470 0 +0.555570 0.831470 0 +0.382683 0.881921 0 +0.471396 0.881921 0 +0.555570 0.881921 0 +0.382683 0.923880 0 +0.471396 0.923880 0 +0.555570 0.923880 0 +0.555570 0.831470 0 +0.634393 0.831470 0 +0.707107 0.831470 0 +0.555570 0.881921 0 +0.634393 0.881921 0 +0.707107 0.881921 0 +0.555570 0.923880 0 +0.634393 0.923880 0 +0.707107 0.923880 0 +0.00000 0.923880 0 +0.0980171 0.923880 0 +0.195090 0.923880 0 +0.00000 0.956940 0 +0.0980171 0.956940 0 +0.195090 0.956940 0 +0.00000 0.980785 0 +0.0980171 0.980785 0 +0.195090 0.980785 0 +0.195090 0.923880 0 +0.290284 0.923880 0 +0.382683 0.923880 0 +0.195090 0.956940 0 +0.290284 0.956940 0 +0.382683 0.956940 0 +0.195090 0.980785 0 +0.290284 0.980785 0 +0.382683 0.980785 0 +0.00000 0.980785 0 +0.0980171 0.980785 0 +0.195090 0.980785 0 +0.00000 0.995184 0 +0.0980171 0.995184 0 +0.195090 0.995184 0 +0.00000 1.00000 0 +0.0980171 1.00000 0 +0.195090 1.00000 0 +0.195090 0.980785 0 +0.290284 0.980785 0 +0.382683 0.980785 0 +0.195090 0.995184 0 +0.290284 0.995184 0 +0.382683 0.995184 0 +0.195090 1.00000 0 +0.290284 1.00000 0 +0.382683 1.00000 0 +0.382683 0.923880 0 +0.471396 0.923880 0 +0.555570 0.923880 0 +0.382683 0.956940 0 +0.471396 0.956940 0 +0.555570 0.956940 0 +0.382683 0.980785 0 +0.471396 0.980785 0 +0.555570 0.980785 0 +0.555570 0.923880 0 +0.634393 0.923880 0 +0.707107 0.923880 0 +0.555570 0.956940 0 +0.634393 0.956940 0 +0.707107 0.956940 0 +0.555570 0.980785 0 +0.634393 0.980785 0 +0.707107 0.980785 0 +0.382683 0.980785 0 +0.471396 0.980785 0 +0.555570 0.980785 0 +0.382683 0.995184 0 +0.471396 0.995184 0 +0.555570 0.995184 0 +0.382683 1.00000 0 +0.471396 1.00000 0 +0.555570 1.00000 0 +0.555570 0.980785 0 +0.634393 0.980785 0 +0.707107 0.980785 0 +0.555570 0.995184 0 +0.634393 0.995184 0 +0.707107 0.995184 0 +0.555570 1.00000 0 +0.634393 1.00000 0 +0.707107 1.00000 0 + +CELLS 16 160 +9 0 2 8 6 1 5 7 3 4 +9 9 11 17 15 10 14 16 12 13 +9 18 20 26 24 19 23 25 21 22 +9 27 29 35 33 28 32 34 30 31 +9 36 38 44 42 37 41 43 39 40 +9 45 47 53 51 46 50 52 48 49 +9 54 56 62 60 55 59 61 57 58 +9 63 65 71 69 64 68 70 66 67 +9 72 74 80 78 73 77 79 75 76 +9 81 83 89 87 82 86 88 84 85 +9 90 92 98 96 91 95 97 93 94 +9 99 101 107 105 100 104 106 102 103 +9 108 110 116 114 109 113 115 111 112 +9 117 119 125 123 118 122 124 120 121 +9 126 128 134 132 127 131 133 129 130 +9 135 137 143 141 136 140 142 138 139 + +CELL_TYPES 16 + 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 +POINT_DATA 144 + + +# vtk DataFile Version 3.0 +#This file was generated +ASCII +DATASET UNSTRUCTURED_GRID + +POINTS 144 double +0.707107 0.707107 0 +0.773010 0.707107 0 +0.831470 0.707107 0 +0.707107 0.773010 0 +0.773010 0.773010 0 +0.831470 0.773010 0 +0.707107 0.831470 0 +0.773010 0.831470 0 +0.831470 0.831470 0 +0.831470 0.707107 0 +0.881921 0.707107 0 +0.923880 0.707107 0 +0.831470 0.773010 0 +0.881921 0.773010 0 +0.923880 0.773010 0 +0.831470 0.831470 0 +0.881921 0.831470 0 +0.923880 0.831470 0 +0.707107 0.831470 0 +0.773010 0.831470 0 +0.831470 0.831470 0 +0.707107 0.881921 0 +0.773010 0.881921 0 +0.831470 0.881921 0 +0.707107 0.923880 0 +0.773010 0.923880 0 +0.831470 0.923880 0 +0.831470 0.831470 0 +0.881921 0.831470 0 +0.923880 0.831470 0 +0.831470 0.881921 0 +0.881921 0.881921 0 +0.923880 0.881921 0 +0.831470 0.923880 0 +0.881921 0.923880 0 +0.923880 0.923880 0 +0.923880 0.707107 0 +0.956940 0.707107 0 +0.980785 0.707107 0 +0.923880 0.773010 0 +0.956940 0.773010 0 +0.980785 0.773010 0 +0.923880 0.831470 0 +0.956940 0.831470 0 +0.980785 0.831470 0 +0.980785 0.707107 0 +0.995184 0.707107 0 +1.00000 0.707107 0 +0.980785 0.773010 0 +0.995184 0.773010 0 +1.00000 0.773010 0 +0.980785 0.831470 0 +0.995184 0.831470 0 +1.00000 0.831470 0 +0.923880 0.831470 0 +0.956940 0.831470 0 +0.980785 0.831470 0 +0.923880 0.881921 0 +0.956940 0.881921 0 +0.980785 0.881921 0 +0.923880 0.923880 0 +0.956940 0.923880 0 +0.980785 0.923880 0 +0.980785 0.831470 0 +0.995184 0.831470 0 +1.00000 0.831470 0 +0.980785 0.881921 0 +0.995184 0.881921 0 +1.00000 0.881921 0 +0.980785 0.923880 0 +0.995184 0.923880 0 +1.00000 0.923880 0 +0.707107 0.923880 0 +0.773010 0.923880 0 +0.831470 0.923880 0 +0.707107 0.956940 0 +0.773010 0.956940 0 +0.831470 0.956940 0 +0.707107 0.980785 0 +0.773010 0.980785 0 +0.831470 0.980785 0 +0.831470 0.923880 0 +0.881921 0.923880 0 +0.923880 0.923880 0 +0.831470 0.956940 0 +0.881921 0.956940 0 +0.923880 0.956940 0 +0.831470 0.980785 0 +0.881921 0.980785 0 +0.923880 0.980785 0 +0.707107 0.980785 0 +0.773010 0.980785 0 +0.831470 0.980785 0 +0.707107 0.995184 0 +0.773010 0.995184 0 +0.831470 0.995184 0 +0.707107 1.00000 0 +0.773010 1.00000 0 +0.831470 1.00000 0 +0.831470 0.980785 0 +0.881921 0.980785 0 +0.923880 0.980785 0 +0.831470 0.995184 0 +0.881921 0.995184 0 +0.923880 0.995184 0 +0.831470 1.00000 0 +0.881921 1.00000 0 +0.923880 1.00000 0 +0.923880 0.923880 0 +0.956940 0.923880 0 +0.980785 0.923880 0 +0.923880 0.956940 0 +0.956940 0.956940 0 +0.980785 0.956940 0 +0.923880 0.980785 0 +0.956940 0.980785 0 +0.980785 0.980785 0 +0.980785 0.923880 0 +0.995184 0.923880 0 +1.00000 0.923880 0 +0.980785 0.956940 0 +0.995184 0.956940 0 +1.00000 0.956940 0 +0.980785 0.980785 0 +0.995184 0.980785 0 +1.00000 0.980785 0 +0.923880 0.980785 0 +0.956940 0.980785 0 +0.980785 0.980785 0 +0.923880 0.995184 0 +0.956940 0.995184 0 +0.980785 0.995184 0 +0.923880 1.00000 0 +0.956940 1.00000 0 +0.980785 1.00000 0 +0.980785 0.980785 0 +0.995184 0.980785 0 +1.00000 0.980785 0 +0.980785 0.995184 0 +0.995184 0.995184 0 +1.00000 0.995184 0 +0.980785 1.00000 0 +0.995184 1.00000 0 +1.00000 1.00000 0 + +CELLS 16 160 +9 0 2 8 6 1 5 7 3 4 +9 9 11 17 15 10 14 16 12 13 +9 18 20 26 24 19 23 25 21 22 +9 27 29 35 33 28 32 34 30 31 +9 36 38 44 42 37 41 43 39 40 +9 45 47 53 51 46 50 52 48 49 +9 54 56 62 60 55 59 61 57 58 +9 63 65 71 69 64 68 70 66 67 +9 72 74 80 78 73 77 79 75 76 +9 81 83 89 87 82 86 88 84 85 +9 90 92 98 96 91 95 97 93 94 +9 99 101 107 105 100 104 106 102 103 +9 108 110 116 114 109 113 115 111 112 +9 117 119 125 123 118 122 124 120 121 +9 126 128 134 132 127 131 133 129 130 +9 135 137 143 141 136 140 142 138 139 + +CELL_TYPES 16 + 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 +POINT_DATA 144 +# vtk DataFile Version 3.0 +#This file was generated +ASCII +DATASET UNSTRUCTURED_GRID + +POINTS 144 double +0.707107 0.707107 0 +0.773010 0.707107 0 +0.831470 0.707107 0 +0.707107 0.773010 0 +0.773010 0.773010 0 +0.831470 0.773010 0 +0.707107 0.831470 0 +0.773010 0.831470 0 +0.831470 0.831470 0 +0.831470 0.707107 0 +0.881921 0.707107 0 +0.923880 0.707107 0 +0.831470 0.773010 0 +0.881921 0.773010 0 +0.923880 0.773010 0 +0.831470 0.831470 0 +0.881921 0.831470 0 +0.923880 0.831470 0 +0.707107 0.831470 0 +0.773010 0.831470 0 +0.831470 0.831470 0 +0.707107 0.881921 0 +0.773010 0.881921 0 +0.831470 0.881921 0 +0.707107 0.923880 0 +0.773010 0.923880 0 +0.831470 0.923880 0 +0.831470 0.831470 0 +0.881921 0.831470 0 +0.923880 0.831470 0 +0.831470 0.881921 0 +0.881921 0.881921 0 +0.923880 0.881921 0 +0.831470 0.923880 0 +0.881921 0.923880 0 +0.923880 0.923880 0 +0.923880 0.707107 0 +0.956940 0.707107 0 +0.980785 0.707107 0 +0.923880 0.773010 0 +0.956940 0.773010 0 +0.980785 0.773010 0 +0.923880 0.831470 0 +0.956940 0.831470 0 +0.980785 0.831470 0 +0.980785 0.707107 0 +0.995184 0.707107 0 +1.00000 0.707107 0 +0.980785 0.773010 0 +0.995184 0.773010 0 +1.00000 0.773010 0 +0.980785 0.831470 0 +0.995184 0.831470 0 +1.00000 0.831470 0 +0.923880 0.831470 0 +0.956940 0.831470 0 +0.980785 0.831470 0 +0.923880 0.881921 0 +0.956940 0.881921 0 +0.980785 0.881921 0 +0.923880 0.923880 0 +0.956940 0.923880 0 +0.980785 0.923880 0 +0.980785 0.831470 0 +0.995184 0.831470 0 +1.00000 0.831470 0 +0.980785 0.881921 0 +0.995184 0.881921 0 +1.00000 0.881921 0 +0.980785 0.923880 0 +0.995184 0.923880 0 +1.00000 0.923880 0 +0.707107 0.923880 0 +0.773010 0.923880 0 +0.831470 0.923880 0 +0.707107 0.956940 0 +0.773010 0.956940 0 +0.831470 0.956940 0 +0.707107 0.980785 0 +0.773010 0.980785 0 +0.831470 0.980785 0 +0.831470 0.923880 0 +0.881921 0.923880 0 +0.923880 0.923880 0 +0.831470 0.956940 0 +0.881921 0.956940 0 +0.923880 0.956940 0 +0.831470 0.980785 0 +0.881921 0.980785 0 +0.923880 0.980785 0 +0.707107 0.980785 0 +0.773010 0.980785 0 +0.831470 0.980785 0 +0.707107 0.995184 0 +0.773010 0.995184 0 +0.831470 0.995184 0 +0.707107 1.00000 0 +0.773010 1.00000 0 +0.831470 1.00000 0 +0.831470 0.980785 0 +0.881921 0.980785 0 +0.923880 0.980785 0 +0.831470 0.995184 0 +0.881921 0.995184 0 +0.923880 0.995184 0 +0.831470 1.00000 0 +0.881921 1.00000 0 +0.923880 1.00000 0 +0.923880 0.923880 0 +0.956940 0.923880 0 +0.980785 0.923880 0 +0.923880 0.956940 0 +0.956940 0.956940 0 +0.980785 0.956940 0 +0.923880 0.980785 0 +0.956940 0.980785 0 +0.980785 0.980785 0 +0.980785 0.923880 0 +0.995184 0.923880 0 +1.00000 0.923880 0 +0.980785 0.956940 0 +0.995184 0.956940 0 +1.00000 0.956940 0 +0.980785 0.980785 0 +0.995184 0.980785 0 +1.00000 0.980785 0 +0.923880 0.980785 0 +0.956940 0.980785 0 +0.980785 0.980785 0 +0.923880 0.995184 0 +0.956940 0.995184 0 +0.980785 0.995184 0 +0.923880 1.00000 0 +0.956940 1.00000 0 +0.980785 1.00000 0 +0.980785 0.980785 0 +0.995184 0.980785 0 +1.00000 0.980785 0 +0.980785 0.995184 0 +0.995184 0.995184 0 +1.00000 0.995184 0 +0.980785 1.00000 0 +0.995184 1.00000 0 +1.00000 1.00000 0 + +CELLS 16 160 +9 0 2 8 6 1 5 7 3 4 +9 9 11 17 15 10 14 16 12 13 +9 18 20 26 24 19 23 25 21 22 +9 27 29 35 33 28 32 34 30 31 +9 36 38 44 42 37 41 43 39 40 +9 45 47 53 51 46 50 52 48 49 +9 54 56 62 60 55 59 61 57 58 +9 63 65 71 69 64 68 70 66 67 +9 72 74 80 78 73 77 79 75 76 +9 81 83 89 87 82 86 88 84 85 +9 90 92 98 96 91 95 97 93 94 +9 99 101 107 105 100 104 106 102 103 +9 108 110 116 114 109 113 115 111 112 +9 117 119 125 123 118 122 124 120 121 +9 126 128 134 132 127 131 133 129 130 +9 135 137 143 141 136 140 142 138 139 + +CELL_TYPES 16 + 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 +POINT_DATA 144 +# vtk DataFile Version 3.0 +#This file was generated +ASCII +DATASET UNSTRUCTURED_GRID + +POINTS 144 double +0.707107 0.707107 0 +0.773010 0.707107 0 +0.831470 0.707107 0 +0.707107 0.773010 0 +0.773010 0.773010 0 +0.831470 0.773010 0 +0.707107 0.831470 0 +0.773010 0.831470 0 +0.831470 0.831470 0 +0.831470 0.707107 0 +0.881921 0.707107 0 +0.923880 0.707107 0 +0.831470 0.773010 0 +0.881921 0.773010 0 +0.923880 0.773010 0 +0.831470 0.831470 0 +0.881921 0.831470 0 +0.923880 0.831470 0 +0.707107 0.831470 0 +0.773010 0.831470 0 +0.831470 0.831470 0 +0.707107 0.881921 0 +0.773010 0.881921 0 +0.831470 0.881921 0 +0.707107 0.923880 0 +0.773010 0.923880 0 +0.831470 0.923880 0 +0.831470 0.831470 0 +0.881921 0.831470 0 +0.923880 0.831470 0 +0.831470 0.881921 0 +0.881921 0.881921 0 +0.923880 0.881921 0 +0.831470 0.923880 0 +0.881921 0.923880 0 +0.923880 0.923880 0 +0.923880 0.707107 0 +0.956940 0.707107 0 +0.980785 0.707107 0 +0.923880 0.773010 0 +0.956940 0.773010 0 +0.980785 0.773010 0 +0.923880 0.831470 0 +0.956940 0.831470 0 +0.980785 0.831470 0 +0.980785 0.707107 0 +0.995184 0.707107 0 +1.00000 0.707107 0 +0.980785 0.773010 0 +0.995184 0.773010 0 +1.00000 0.773010 0 +0.980785 0.831470 0 +0.995184 0.831470 0 +1.00000 0.831470 0 +0.923880 0.831470 0 +0.956940 0.831470 0 +0.980785 0.831470 0 +0.923880 0.881921 0 +0.956940 0.881921 0 +0.980785 0.881921 0 +0.923880 0.923880 0 +0.956940 0.923880 0 +0.980785 0.923880 0 +0.980785 0.831470 0 +0.995184 0.831470 0 +1.00000 0.831470 0 +0.980785 0.881921 0 +0.995184 0.881921 0 +1.00000 0.881921 0 +0.980785 0.923880 0 +0.995184 0.923880 0 +1.00000 0.923880 0 +0.707107 0.923880 0 +0.773010 0.923880 0 +0.831470 0.923880 0 +0.707107 0.956940 0 +0.773010 0.956940 0 +0.831470 0.956940 0 +0.707107 0.980785 0 +0.773010 0.980785 0 +0.831470 0.980785 0 +0.831470 0.923880 0 +0.881921 0.923880 0 +0.923880 0.923880 0 +0.831470 0.956940 0 +0.881921 0.956940 0 +0.923880 0.956940 0 +0.831470 0.980785 0 +0.881921 0.980785 0 +0.923880 0.980785 0 +0.707107 0.980785 0 +0.773010 0.980785 0 +0.831470 0.980785 0 +0.707107 0.995184 0 +0.773010 0.995184 0 +0.831470 0.995184 0 +0.707107 1.00000 0 +0.773010 1.00000 0 +0.831470 1.00000 0 +0.831470 0.980785 0 +0.881921 0.980785 0 +0.923880 0.980785 0 +0.831470 0.995184 0 +0.881921 0.995184 0 +0.923880 0.995184 0 +0.831470 1.00000 0 +0.881921 1.00000 0 +0.923880 1.00000 0 +0.923880 0.923880 0 +0.956940 0.923880 0 +0.980785 0.923880 0 +0.923880 0.956940 0 +0.956940 0.956940 0 +0.980785 0.956940 0 +0.923880 0.980785 0 +0.956940 0.980785 0 +0.980785 0.980785 0 +0.980785 0.923880 0 +0.995184 0.923880 0 +1.00000 0.923880 0 +0.980785 0.956940 0 +0.995184 0.956940 0 +1.00000 0.956940 0 +0.980785 0.980785 0 +0.995184 0.980785 0 +1.00000 0.980785 0 +0.923880 0.980785 0 +0.956940 0.980785 0 +0.980785 0.980785 0 +0.923880 0.995184 0 +0.956940 0.995184 0 +0.980785 0.995184 0 +0.923880 1.00000 0 +0.956940 1.00000 0 +0.980785 1.00000 0 +0.980785 0.980785 0 +0.995184 0.980785 0 +1.00000 0.980785 0 +0.980785 0.995184 0 +0.995184 0.995184 0 +1.00000 0.995184 0 +0.980785 1.00000 0 +0.995184 1.00000 0 +1.00000 1.00000 0 + +CELLS 16 160 +9 0 2 8 6 1 5 7 3 4 +9 9 11 17 15 10 14 16 12 13 +9 18 20 26 24 19 23 25 21 22 +9 27 29 35 33 28 32 34 30 31 +9 36 38 44 42 37 41 43 39 40 +9 45 47 53 51 46 50 52 48 49 +9 54 56 62 60 55 59 61 57 58 +9 63 65 71 69 64 68 70 66 67 +9 72 74 80 78 73 77 79 75 76 +9 81 83 89 87 82 86 88 84 85 +9 90 92 98 96 91 95 97 93 94 +9 99 101 107 105 100 104 106 102 103 +9 108 110 116 114 109 113 115 111 112 +9 117 119 125 123 118 122 124 120 121 +9 126 128 134 132 127 131 133 129 130 +9 135 137 143 141 136 140 142 138 139 + +CELL_TYPES 16 + 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 +POINT_DATA 144 +# vtk DataFile Version 3.0 +#This file was generated +ASCII +DATASET UNSTRUCTURED_GRID + +POINTS 144 double +0.707107 0.707107 0 +0.773010 0.707107 0 +0.831470 0.707107 0 +0.707107 0.773010 0 +0.773010 0.773010 0 +0.831470 0.773010 0 +0.707107 0.831470 0 +0.773010 0.831470 0 +0.831470 0.831470 0 +0.831470 0.707107 0 +0.881921 0.707107 0 +0.923880 0.707107 0 +0.831470 0.773010 0 +0.881921 0.773010 0 +0.923880 0.773010 0 +0.831470 0.831470 0 +0.881921 0.831470 0 +0.923880 0.831470 0 +0.707107 0.831470 0 +0.773010 0.831470 0 +0.831470 0.831470 0 +0.707107 0.881921 0 +0.773010 0.881921 0 +0.831470 0.881921 0 +0.707107 0.923880 0 +0.773010 0.923880 0 +0.831470 0.923880 0 +0.831470 0.831470 0 +0.881921 0.831470 0 +0.923880 0.831470 0 +0.831470 0.881921 0 +0.881921 0.881921 0 +0.923880 0.881921 0 +0.831470 0.923880 0 +0.881921 0.923880 0 +0.923880 0.923880 0 +0.923880 0.707107 0 +0.956940 0.707107 0 +0.980785 0.707107 0 +0.923880 0.773010 0 +0.956940 0.773010 0 +0.980785 0.773010 0 +0.923880 0.831470 0 +0.956940 0.831470 0 +0.980785 0.831470 0 +0.980785 0.707107 0 +0.995184 0.707107 0 +1.00000 0.707107 0 +0.980785 0.773010 0 +0.995184 0.773010 0 +1.00000 0.773010 0 +0.980785 0.831470 0 +0.995184 0.831470 0 +1.00000 0.831470 0 +0.923880 0.831470 0 +0.956940 0.831470 0 +0.980785 0.831470 0 +0.923880 0.881921 0 +0.956940 0.881921 0 +0.980785 0.881921 0 +0.923880 0.923880 0 +0.956940 0.923880 0 +0.980785 0.923880 0 +0.980785 0.831470 0 +0.995184 0.831470 0 +1.00000 0.831470 0 +0.980785 0.881921 0 +0.995184 0.881921 0 +1.00000 0.881921 0 +0.980785 0.923880 0 +0.995184 0.923880 0 +1.00000 0.923880 0 +0.707107 0.923880 0 +0.773010 0.923880 0 +0.831470 0.923880 0 +0.707107 0.956940 0 +0.773010 0.956940 0 +0.831470 0.956940 0 +0.707107 0.980785 0 +0.773010 0.980785 0 +0.831470 0.980785 0 +0.831470 0.923880 0 +0.881921 0.923880 0 +0.923880 0.923880 0 +0.831470 0.956940 0 +0.881921 0.956940 0 +0.923880 0.956940 0 +0.831470 0.980785 0 +0.881921 0.980785 0 +0.923880 0.980785 0 +0.707107 0.980785 0 +0.773010 0.980785 0 +0.831470 0.980785 0 +0.707107 0.995184 0 +0.773010 0.995184 0 +0.831470 0.995184 0 +0.707107 1.00000 0 +0.773010 1.00000 0 +0.831470 1.00000 0 +0.831470 0.980785 0 +0.881921 0.980785 0 +0.923880 0.980785 0 +0.831470 0.995184 0 +0.881921 0.995184 0 +0.923880 0.995184 0 +0.831470 1.00000 0 +0.881921 1.00000 0 +0.923880 1.00000 0 +0.923880 0.923880 0 +0.956940 0.923880 0 +0.980785 0.923880 0 +0.923880 0.956940 0 +0.956940 0.956940 0 +0.980785 0.956940 0 +0.923880 0.980785 0 +0.956940 0.980785 0 +0.980785 0.980785 0 +0.980785 0.923880 0 +0.995184 0.923880 0 +1.00000 0.923880 0 +0.980785 0.956940 0 +0.995184 0.956940 0 +1.00000 0.956940 0 +0.980785 0.980785 0 +0.995184 0.980785 0 +1.00000 0.980785 0 +0.923880 0.980785 0 +0.956940 0.980785 0 +0.980785 0.980785 0 +0.923880 0.995184 0 +0.956940 0.995184 0 +0.980785 0.995184 0 +0.923880 1.00000 0 +0.956940 1.00000 0 +0.980785 1.00000 0 +0.980785 0.980785 0 +0.995184 0.980785 0 +1.00000 0.980785 0 +0.980785 0.995184 0 +0.995184 0.995184 0 +1.00000 0.995184 0 +0.980785 1.00000 0 +0.995184 1.00000 0 +1.00000 1.00000 0 + +CELLS 16 160 +9 0 2 8 6 1 5 7 3 4 +9 9 11 17 15 10 14 16 12 13 +9 18 20 26 24 19 23 25 21 22 +9 27 29 35 33 28 32 34 30 31 +9 36 38 44 42 37 41 43 39 40 +9 45 47 53 51 46 50 52 48 49 +9 54 56 62 60 55 59 61 57 58 +9 63 65 71 69 64 68 70 66 67 +9 72 74 80 78 73 77 79 75 76 +9 81 83 89 87 82 86 88 84 85 +9 90 92 98 96 91 95 97 93 94 +9 99 101 107 105 100 104 106 102 103 +9 108 110 116 114 109 113 115 111 112 +9 117 119 125 123 118 122 124 120 121 +9 126 128 134 132 127 131 133 129 130 +9 135 137 143 141 136 140 142 138 139 + +CELL_TYPES 16 + 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 70 +POINT_DATA 144 + diff --git a/tests/mappings/mapping_q_cache_07.cc b/tests/mappings/mapping_q_cache_07.cc new file mode 100644 index 0000000000..58504fdae4 --- /dev/null +++ b/tests/mappings/mapping_q_cache_07.cc @@ -0,0 +1,118 @@ +// --------------------------------------------------------------------- +// +// Copyright (C) 2019 by the deal.II authors +// +// This file is part of the deal.II library. +// +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE.md at +// the top level directory of deal.II. +// +// --------------------------------------------------------------------- + +// Test VectorTools::get_position_vector() with Mapping as argument. + +#include +#include +#include +#include +#include +#include +#include + +#include +#include + +#include +#include + +#include "../tests.h" + +template +void +test(const bool vector_describes_relative_displacement, + const unsigned int fe_degree, + const unsigned int fe_degree_mapping) +{ + // surface mesh + const unsigned int spacedim = dim + 1; + const unsigned int n_refinements = 1; + + Triangulation tria; + GridGenerator::hyper_sphere(tria, Point(), 0.5); + tria.refine_global(n_refinements); + + FE_Q fe(fe_degree); + DoFHandler dof_handler(tria); + dof_handler.distribute_dofs(fe); + + FESystem fe_dim(fe, spacedim); + DoFHandler dof_handler_dim(tria); + dof_handler_dim.distribute_dofs(fe_dim); + + // set up base high-order mapping + Vector euler_vector_base(dof_handler_dim.n_dofs()); + VectorTools::get_position_vector(dof_handler_dim, euler_vector_base); + MappingFEField mapping_base(dof_handler_dim, + euler_vector_base); + + // clear manifold + tria.reset_all_manifolds(); + + auto euler_vector = euler_vector_base; + + if (vector_describes_relative_displacement) + { + Vector absolut_vector(dof_handler_dim.n_dofs()); + VectorTools::get_position_vector(dof_handler_dim, absolut_vector); + + euler_vector -= absolut_vector; + } + + // output mesh with with MappingFEField based on a vector constructed + // with the triangulation without manifolds and the high-order base mapping + { + MappingQCache mapping(fe_degree_mapping); + mapping.initialize(MappingQ1(), + dof_handler_dim, + euler_vector, + vector_describes_relative_displacement); + DataOutBase::VtkFlags flags; + + DataOut> data_out; + data_out.set_flags(flags); + data_out.attach_dof_handler(dof_handler); + + data_out.build_patches( + mapping, + fe_degree + 1, + DataOut>::CurvedCellRegion::curved_inner_cells); + + static unsigned int counter = 0; + +#if false + std::ofstream output("test." + std::to_string(counter++) + ".vtk"); + data_out.write_vtk(output); +#else + data_out.write_vtk(deallog.get_file_stream()); +#endif + } +} + + + +int +main(int argc, char **argv) +{ + initlog(); + + test<1>(false, 4, 4); + test<1>(true, 4, 4); + + test<1>(false, 4, 5); + test<1>(true, 4, 5); +} diff --git a/tests/mappings/mapping_q_cache_07.with_p4est=true.with_mpi=true.mpirun=1.output b/tests/mappings/mapping_q_cache_07.with_p4est=true.with_mpi=true.mpirun=1.output new file mode 100644 index 0000000000..6f7a28156b --- /dev/null +++ b/tests/mappings/mapping_q_cache_07.with_p4est=true.with_mpi=true.mpirun=1.output @@ -0,0 +1,401 @@ + +# vtk DataFile Version 3.0 +#This file was generated +ASCII +DATASET UNSTRUCTURED_GRID + +POINTS 48 double +0.353553 -0.353553 0 +0.293892 -0.404509 0 +0.226993 -0.445504 0 +0.154511 -0.475527 0 +0.0782182 -0.493844 0 +5.55112e-17 -0.500000 0 +5.55112e-17 -0.500000 0 +-0.0782182 -0.493844 0 +-0.154511 -0.475527 0 +-0.226993 -0.445504 0 +-0.293892 -0.404509 0 +-0.353553 -0.353553 0 +-0.353553 -0.353553 0 +-0.404509 -0.293892 0 +-0.445504 -0.226993 0 +-0.475527 -0.154511 0 +-0.493844 -0.0782182 0 +-0.500000 -5.55112e-17 0 +-0.500000 -5.55112e-17 0 +-0.493844 0.0782182 0 +-0.475527 0.154511 0 +-0.445504 0.226993 0 +-0.404509 0.293892 0 +-0.353553 0.353553 0 +0.353553 0.353553 0 +0.404509 0.293892 0 +0.445504 0.226993 0 +0.475527 0.154511 0 +0.493844 0.0782182 0 +0.500000 5.55112e-17 0 +0.500000 5.55112e-17 0 +0.493844 -0.0782182 0 +0.475527 -0.154511 0 +0.445504 -0.226993 0 +0.404509 -0.293892 0 +0.353553 -0.353553 0 +-0.353553 0.353553 0 +-0.293892 0.404509 0 +-0.226993 0.445504 0 +-0.154511 0.475527 0 +-0.0782182 0.493844 0 +-5.55112e-17 0.500000 0 +-5.55112e-17 0.500000 0 +0.0782182 0.493844 0 +0.154511 0.475527 0 +0.226993 0.445504 0 +0.293892 0.404509 0 +0.353553 0.353553 0 + +CELLS 40 120 +2 0 1 +2 1 2 +2 2 3 +2 3 4 +2 4 5 +2 6 7 +2 7 8 +2 8 9 +2 9 10 +2 10 11 +2 12 13 +2 13 14 +2 14 15 +2 15 16 +2 16 17 +2 18 19 +2 19 20 +2 20 21 +2 21 22 +2 22 23 +2 24 25 +2 25 26 +2 26 27 +2 27 28 +2 28 29 +2 30 31 +2 31 32 +2 32 33 +2 33 34 +2 34 35 +2 36 37 +2 37 38 +2 38 39 +2 39 40 +2 40 41 +2 42 43 +2 43 44 +2 44 45 +2 45 46 +2 46 47 + +CELL_TYPES 40 + 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 +POINT_DATA 48 +# vtk DataFile Version 3.0 +#This file was generated +ASCII +DATASET UNSTRUCTURED_GRID + +POINTS 48 double +0.353553 -0.353553 0 +0.293892 -0.404509 0 +0.226993 -0.445504 0 +0.154511 -0.475527 0 +0.0782182 -0.493844 0 +5.55112e-17 -0.500000 0 +5.55112e-17 -0.500000 0 +-0.0782182 -0.493844 0 +-0.154511 -0.475527 0 +-0.226993 -0.445504 0 +-0.293892 -0.404509 0 +-0.353553 -0.353553 0 +-0.353553 -0.353553 0 +-0.404509 -0.293892 0 +-0.445504 -0.226993 0 +-0.475527 -0.154511 0 +-0.493844 -0.0782182 0 +-0.500000 -5.55112e-17 0 +-0.500000 -5.55112e-17 0 +-0.493844 0.0782182 0 +-0.475527 0.154511 0 +-0.445504 0.226993 0 +-0.404509 0.293892 0 +-0.353553 0.353553 0 +0.353553 0.353553 0 +0.404509 0.293892 0 +0.445504 0.226993 0 +0.475527 0.154511 0 +0.493844 0.0782182 0 +0.500000 5.55112e-17 0 +0.500000 5.55112e-17 0 +0.493844 -0.0782182 0 +0.475527 -0.154511 0 +0.445504 -0.226993 0 +0.404509 -0.293892 0 +0.353553 -0.353553 0 +-0.353553 0.353553 0 +-0.293892 0.404509 0 +-0.226993 0.445504 0 +-0.154511 0.475527 0 +-0.0782182 0.493844 0 +-5.55112e-17 0.500000 0 +-5.55112e-17 0.500000 0 +0.0782182 0.493844 0 +0.154511 0.475527 0 +0.226993 0.445504 0 +0.293892 0.404509 0 +0.353553 0.353553 0 + +CELLS 40 120 +2 0 1 +2 1 2 +2 2 3 +2 3 4 +2 4 5 +2 6 7 +2 7 8 +2 8 9 +2 9 10 +2 10 11 +2 12 13 +2 13 14 +2 14 15 +2 15 16 +2 16 17 +2 18 19 +2 19 20 +2 20 21 +2 21 22 +2 22 23 +2 24 25 +2 25 26 +2 26 27 +2 27 28 +2 28 29 +2 30 31 +2 31 32 +2 32 33 +2 33 34 +2 34 35 +2 36 37 +2 37 38 +2 38 39 +2 39 40 +2 40 41 +2 42 43 +2 43 44 +2 44 45 +2 45 46 +2 46 47 + +CELL_TYPES 40 + 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 +POINT_DATA 48 +# vtk DataFile Version 3.0 +#This file was generated +ASCII +DATASET UNSTRUCTURED_GRID + +POINTS 48 double +0.353553 -0.353553 0 +0.293892 -0.404509 0 +0.226993 -0.445504 0 +0.154511 -0.475527 0 +0.0782182 -0.493844 0 +5.55112e-17 -0.500000 0 +5.55112e-17 -0.500000 0 +-0.0782182 -0.493844 0 +-0.154511 -0.475527 0 +-0.226993 -0.445504 0 +-0.293892 -0.404509 0 +-0.353553 -0.353553 0 +-0.353553 -0.353553 0 +-0.404509 -0.293892 0 +-0.445504 -0.226993 0 +-0.475527 -0.154511 0 +-0.493844 -0.0782182 0 +-0.500000 -5.55112e-17 0 +-0.500000 -5.55112e-17 0 +-0.493844 0.0782182 0 +-0.475527 0.154511 0 +-0.445504 0.226993 0 +-0.404509 0.293892 0 +-0.353553 0.353553 0 +0.353553 0.353553 0 +0.404509 0.293892 0 +0.445504 0.226993 0 +0.475527 0.154511 0 +0.493844 0.0782182 0 +0.500000 5.55112e-17 0 +0.500000 5.55112e-17 0 +0.493844 -0.0782182 0 +0.475527 -0.154511 0 +0.445504 -0.226993 0 +0.404509 -0.293892 0 +0.353553 -0.353553 0 +-0.353553 0.353553 0 +-0.293892 0.404509 0 +-0.226993 0.445504 0 +-0.154511 0.475527 0 +-0.0782182 0.493844 0 +-5.55112e-17 0.500000 0 +-5.55112e-17 0.500000 0 +0.0782182 0.493844 0 +0.154511 0.475527 0 +0.226993 0.445504 0 +0.293892 0.404509 0 +0.353553 0.353553 0 + +CELLS 40 120 +2 0 1 +2 1 2 +2 2 3 +2 3 4 +2 4 5 +2 6 7 +2 7 8 +2 8 9 +2 9 10 +2 10 11 +2 12 13 +2 13 14 +2 14 15 +2 15 16 +2 16 17 +2 18 19 +2 19 20 +2 20 21 +2 21 22 +2 22 23 +2 24 25 +2 25 26 +2 26 27 +2 27 28 +2 28 29 +2 30 31 +2 31 32 +2 32 33 +2 33 34 +2 34 35 +2 36 37 +2 37 38 +2 38 39 +2 39 40 +2 40 41 +2 42 43 +2 43 44 +2 44 45 +2 45 46 +2 46 47 + +CELL_TYPES 40 + 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 +POINT_DATA 48 +# vtk DataFile Version 3.0 +#This file was generated +ASCII +DATASET UNSTRUCTURED_GRID + +POINTS 48 double +0.353553 -0.353553 0 +0.293892 -0.404509 0 +0.226993 -0.445504 0 +0.154511 -0.475527 0 +0.0782182 -0.493844 0 +5.55112e-17 -0.500000 0 +5.55112e-17 -0.500000 0 +-0.0782182 -0.493844 0 +-0.154511 -0.475527 0 +-0.226993 -0.445504 0 +-0.293892 -0.404509 0 +-0.353553 -0.353553 0 +-0.353553 -0.353553 0 +-0.404509 -0.293892 0 +-0.445504 -0.226993 0 +-0.475527 -0.154511 0 +-0.493844 -0.0782182 0 +-0.500000 -5.55112e-17 0 +-0.500000 -5.55112e-17 0 +-0.493844 0.0782182 0 +-0.475527 0.154511 0 +-0.445504 0.226993 0 +-0.404509 0.293892 0 +-0.353553 0.353553 0 +0.353553 0.353553 0 +0.404509 0.293892 0 +0.445504 0.226993 0 +0.475527 0.154511 0 +0.493844 0.0782182 0 +0.500000 5.55112e-17 0 +0.500000 5.55112e-17 0 +0.493844 -0.0782182 0 +0.475527 -0.154511 0 +0.445504 -0.226993 0 +0.404509 -0.293892 0 +0.353553 -0.353553 0 +-0.353553 0.353553 0 +-0.293892 0.404509 0 +-0.226993 0.445504 0 +-0.154511 0.475527 0 +-0.0782182 0.493844 0 +-5.55112e-17 0.500000 0 +-5.55112e-17 0.500000 0 +0.0782182 0.493844 0 +0.154511 0.475527 0 +0.226993 0.445504 0 +0.293892 0.404509 0 +0.353553 0.353553 0 + +CELLS 40 120 +2 0 1 +2 1 2 +2 2 3 +2 3 4 +2 4 5 +2 6 7 +2 7 8 +2 8 9 +2 9 10 +2 10 11 +2 12 13 +2 13 14 +2 14 15 +2 15 16 +2 16 17 +2 18 19 +2 19 20 +2 20 21 +2 21 22 +2 22 23 +2 24 25 +2 25 26 +2 26 27 +2 27 28 +2 28 29 +2 30 31 +2 31 32 +2 32 33 +2 33 34 +2 34 35 +2 36 37 +2 37 38 +2 38 39 +2 39 40 +2 40 41 +2 42 43 +2 43 44 +2 44 45 +2 45 46 +2 46 47 + +CELL_TYPES 40 + 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 3 +POINT_DATA 48