From: Peter Munch Date: Mon, 13 Jul 2020 15:48:46 +0000 (+0200) Subject: Generalize DataOut::write_vtk for simplex mesh X-Git-Tag: v9.3.0-rc1~1218^2 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=a3f52df42978439a5aea1aaa85bd9305ba62de89;p=dealii.git Generalize DataOut::write_vtk for simplex mesh --- diff --git a/include/deal.II/base/data_out_base.h b/include/deal.II/base/data_out_base.h index a2f704fdb1..03fcfeff17 100644 --- a/include/deal.II/base/data_out_base.h +++ b/include/deal.II/base/data_out_base.h @@ -24,6 +24,8 @@ #include #include +#include + #include // To be able to serialize XDMFEntry @@ -319,6 +321,11 @@ namespace DataOutBase */ bool points_are_available; + /** + * Reference-cell type of the underlying cell of this patch. + */ + ReferenceCell::Type reference_cell_type; + /** * Default constructor. Sets #n_subdivisions to one, #points_are_available * to false, and #patch_index to #no_neighbor. @@ -464,6 +471,11 @@ namespace DataOutBase */ bool points_are_available; + /** + * Reference-cell type of the underlying cell of this patch. + */ + ReferenceCell::Type reference_cell_type; + /** * Default constructor. Sets #points_are_available * to false, and #patch_index to #no_neighbor. @@ -1350,6 +1362,15 @@ namespace DataOutBase const unsigned int d2, const unsigned int d3); + /** + * Record a single deal.II cell without subdivisions (e.g. simplex) in the + * internal reordered format. + */ + void + write_cell_single(const unsigned int index, + const unsigned int start, + const unsigned int n_points); + /** * Filter and record a data set. If there are multiple values at a given * vertex and redundant values are being removed, one is arbitrarily diff --git a/include/deal.II/numerics/data_out_dof_data.templates.h b/include/deal.II/numerics/data_out_dof_data.templates.h index 602b339512..a477639ea0 100644 --- a/include/deal.II/numerics/data_out_dof_data.templates.h +++ b/include/deal.II/numerics/data_out_dof_data.templates.h @@ -46,6 +46,8 @@ #include #include +#include + #include #include #include @@ -60,10 +62,10 @@ namespace internal { template ParallelDataBase::ParallelDataBase( - const unsigned int n_datasets, - const unsigned int n_subdivisions, - const std::vector &n_postprocessor_outputs, - const Mapping & mapping, + const unsigned int n_datasets, + const unsigned int n_subdivisions, + const std::vector & n_postprocessor_outputs, + const dealii::Mapping &mapping, const std::vector< std::shared_ptr>> & finite_elements, @@ -101,9 +103,49 @@ namespace internal unsigned int n_q_points = 0; if (use_face_values == false) { - dealii::hp::QCollection quadrature( - QIterated(QTrapez<1>(), n_subdivisions)); - n_q_points = quadrature[0].size(); + const bool do_simplex = + std::any_of(finite_elements.begin(), + finite_elements.end(), + [](const auto &fe) { + for (unsigned int i = 0; i < fe->size(); ++i) + if ((*fe)[i].reference_cell_type() != + ReferenceCell::get_hypercube(dim)) + return true; + return false; + }); + + const bool do_hex = + std::any_of(finite_elements.begin(), + finite_elements.end(), + [](const auto &fe) { + for (unsigned int i = 0; i < fe->size(); ++i) + if ((*fe)[i].reference_cell_type() == + ReferenceCell::get_hypercube(dim)) + return true; + return false; + }); + + std::unique_ptr> quadrature1; + std::unique_ptr> quadrature2; + + if (do_simplex) + { + Assert(1 <= n_subdivisions && n_subdivisions <= 2, + ExcNotImplemented()); + quadrature1.reset(new Quadrature( + Simplex::FE_P(n_subdivisions == 1 ? 1 : 2) + .get_unit_support_points())); + } + + if (do_hex) + { + quadrature2.reset(new Quadrature( + QIterated(QTrapez<1>(), n_subdivisions))); + } + + n_q_points = std::max(do_simplex ? quadrature1->size() : 0, + do_hex ? quadrature2->size() : 1); + x_fe_values.resize(this->finite_elements.size()); for (unsigned int i = 0; i < this->finite_elements.size(); ++i) { @@ -117,12 +159,25 @@ namespace internal break; } if (x_fe_values[i].get() == nullptr) - x_fe_values[i] = - std::make_shared>( - this->mapping_collection, - *this->finite_elements[i], - quadrature, - this->update_flags); + { + dealii::hp::QCollection quadrature; + + for (unsigned int j = 0; j < this->finite_elements[i]->size(); + ++j) + if ((*this->finite_elements[i])[j].reference_cell_type() != + ReferenceCell::get_hypercube(dim)) + quadrature.push_back(*quadrature1); + else + quadrature.push_back(*quadrature2); + + x_fe_values[i] = + std::make_shared>( + this->mapping_collection, + *this->finite_elements[i], + quadrature, + do_simplex ? (update_flags | update_quadrature_points) : + update_flags); + } } } else @@ -186,9 +241,49 @@ namespace internal if (data.x_fe_values.empty() == false) { Assert(data.x_fe_face_values.empty() == true, ExcInternalError()); - dealii::hp::QCollection quadrature( - QIterated(QTrapez<1>(), n_subdivisions)); + + const bool do_simplex = + std::any_of(finite_elements.begin(), + finite_elements.end(), + [](const auto &fe) { + for (unsigned int i = 0; i < fe->size(); ++i) + if ((*fe)[i].reference_cell_type() != + ReferenceCell::get_hypercube(dim)) + return true; + return false; + }); + + const bool do_hex = + std::any_of(finite_elements.begin(), + finite_elements.end(), + [](const auto &fe) { + for (unsigned int i = 0; i < fe->size(); ++i) + if ((*fe)[i].reference_cell_type() == + ReferenceCell::get_hypercube(dim)) + return true; + return false; + }); + + std::unique_ptr> quadrature1; + std::unique_ptr> quadrature2; + + if (do_simplex) + { + Assert(1 <= n_subdivisions && n_subdivisions <= 2, + ExcNotImplemented()); + quadrature1.reset(new Quadrature( + Simplex::FE_P(n_subdivisions == 1 ? 1 : 2) + .get_unit_support_points())); + } + + if (do_hex) + { + quadrature2.reset(new Quadrature( + QIterated(QTrapez<1>(), n_subdivisions))); + } + x_fe_values.resize(this->finite_elements.size()); + for (unsigned int i = 0; i < this->finite_elements.size(); ++i) { // check if there is a finite element that is equal to the present @@ -201,12 +296,25 @@ namespace internal break; } if (x_fe_values[i].get() == nullptr) - x_fe_values[i] = - std::make_shared>( - this->mapping_collection, - *this->finite_elements[i], - quadrature, - this->update_flags); + { + dealii::hp::QCollection quadrature; + + for (unsigned int j = 0; j < this->finite_elements[i]->size(); + ++j) + if ((*this->finite_elements[i])[j].reference_cell_type() != + ReferenceCell::get_hypercube(dim)) + quadrature.push_back(*quadrature1); + else + quadrature.push_back(*quadrature2); + + x_fe_values[i] = + std::make_shared>( + this->mapping_collection, + *this->finite_elements[i], + quadrature, + do_simplex ? (update_flags | update_quadrature_points) : + update_flags); + } } } else diff --git a/source/base/data_out_base.cc b/source/base/data_out_base.cc index 8c52f6145e..3d64d59ba6 100644 --- a/source/base/data_out_base.cc +++ b/source/base/data_out_base.cc @@ -292,7 +292,9 @@ namespace DataOutBase (n_data_sets + spacedim) : n_data_sets, patch.data.n_rows())); - Assert((n_data_sets == 0) || + Assert(patch.reference_cell_type != + ReferenceCell::get_hypercube(dim) || + (n_data_sets == 0) || (patch.data.n_cols() == Utilities::fixed_power(n_subdivisions + 1)), ExcInvalidDatasetSize(patch.data.n_cols(), @@ -487,6 +489,20 @@ namespace DataOutBase + void + DataOutFilter::write_cell_single(const unsigned int index, + const unsigned int start, + const unsigned int n_points) + { + (void)index; + (void)start; + (void)n_points; + + Assert(false, ExcNotImplemented()); + } + + + void DataOutFilter::write_data_set(const std::string & name, const unsigned int dimension, @@ -851,6 +867,27 @@ namespace "it.")); } + /** + * Write dim-dimensional @p index cell with @p n_point vertices and first + * vertex at number @p start. + * + * @note All inheriting classes should implement this function. + */ + void + write_cell_single(const unsigned int index, + const unsigned int start, + const unsigned int n_points) + { + (void)index; + (void)start; + (void)n_points; + + Assert(false, + ExcMessage("The derived class you are using needs to " + "reimplement this function if you want to call " + "it.")); + } + /** * Do whatever is necessary to terminate the list of cells. This function is * usually only reimplemented if deal.II is compiled with zlib. The default @@ -1060,6 +1097,14 @@ namespace const unsigned int y_offset, const unsigned int z_offset); + /** + * Print vertices [start, start+n_points[ + */ + void + write_cell_single(const unsigned int index, + const unsigned int start, + const unsigned int n_points); + /** * Write a high-order cell type, i.e., a Lagrange cell * in the VTK terminology. @@ -1452,6 +1497,19 @@ namespace stream << '\n'; } + void + VtkStream::write_cell_single(const unsigned int index, + const unsigned int start, + const unsigned int n_points) + { + (void)index; + + stream << '\t' << n_points; + for (unsigned int i = 0; i < n_points; ++i) + stream << '\t' << start + i; + stream << '\n'; + } + template void VtkStream::write_high_order_cell(const unsigned int, @@ -1612,6 +1670,7 @@ namespace DataOutBase : patch_index(no_neighbor) , n_subdivisions(1) , points_are_available(false) + , reference_cell_type(ReferenceCell::get_hypercube(dim)) // all the other data has a constructor of its own, except for the "neighbors" // field, which we set to invalid values. { @@ -1689,6 +1748,7 @@ namespace DataOutBase std::swap(n_subdivisions, other_patch.n_subdivisions); data.swap(other_patch.data); std::swap(points_are_available, other_patch.points_are_available); + std::swap(reference_cell_type, other_patch.reference_cell_type); } @@ -1712,6 +1772,7 @@ namespace DataOutBase Patch<0, spacedim>::Patch() : patch_index(no_neighbor) , points_are_available(false) + , reference_cell_type(ReferenceCell::get_hypercube(0)) { Assert(spacedim <= 3, ExcNotImplemented()); } @@ -2371,19 +2432,39 @@ namespace DataOutBase for (const auto &patch : patches) { - const unsigned int n_subdivisions = patch.n_subdivisions; - const unsigned int n = n_subdivisions + 1; - // Length of loops in all dimensions. If a dimension is not used, a loop - // of length one will do the job. - const unsigned int n1 = (dim > 0) ? n : 1; - const unsigned int n2 = (dim > 1) ? n : 1; - const unsigned int n3 = (dim > 2) ? n : 1; + // special treatment of simplices since they are not subdivided, such + // that no new nodes have to be created, but the precomputed ones can be + // used + if (patch.reference_cell_type != ReferenceCell::get_hypercube(dim)) + { + Point node; + + for (unsigned int point_no = 0; point_no < patch.data.n_cols(); + ++point_no) + { + for (unsigned int d = 0; d < spacedim; ++d) + node[d] = + patch.data(patch.data.size(0) - spacedim + d, point_no); + + out.write_point(count++, node); + } + } + else + { + const unsigned int n_subdivisions = patch.n_subdivisions; + const unsigned int n = n_subdivisions + 1; + // Length of loops in all dimensions. If a dimension is not used, a + // loop of length one will do the job. + const unsigned int n1 = (dim > 0) ? n : 1; + const unsigned int n2 = (dim > 1) ? n : 1; + const unsigned int n3 = (dim > 2) ? n : 1; - for (unsigned int i3 = 0; i3 < n3; ++i3) - for (unsigned int i2 = 0; i2 < n2; ++i2) - for (unsigned int i1 = 0; i1 < n1; ++i1) - out.write_point(count++, - compute_node(patch, i1, i2, i3, n_subdivisions)); + for (unsigned int i3 = 0; i3 < n3; ++i3) + for (unsigned int i2 = 0; i2 < n2; ++i2) + for (unsigned int i1 = 0; i1 < n1; ++i1) + out.write_point( + count++, compute_node(patch, i1, i2, i3, n_subdivisions)); + } } out.flush_points(); } @@ -2397,28 +2478,39 @@ namespace DataOutBase unsigned int first_vertex_of_patch = 0; for (const auto &patch : patches) { - const unsigned int n_subdivisions = patch.n_subdivisions; - const unsigned int n = n_subdivisions + 1; - // Length of loops in all dimensons - const unsigned int n1 = (dim > 0) ? n_subdivisions : 1; - const unsigned int n2 = (dim > 1) ? n_subdivisions : 1; - const unsigned int n3 = (dim > 2) ? n_subdivisions : 1; - // Offsets of outer loops - const unsigned int d1 = 1; - const unsigned int d2 = n; - const unsigned int d3 = n * n; - for (unsigned int i3 = 0; i3 < n3; ++i3) - for (unsigned int i2 = 0; i2 < n2; ++i2) - for (unsigned int i1 = 0; i1 < n1; ++i1) - { - const unsigned int offset = - first_vertex_of_patch + i3 * d3 + i2 * d2 + i1 * d1; - // First write line in x direction - out.template write_cell(count++, offset, d1, d2, d3); - } - // finally update the number of the first vertex of this patch - first_vertex_of_patch += - Utilities::fixed_power(n_subdivisions + 1); + // special treatment of simplices since they are not subdivided + if (patch.reference_cell_type != ReferenceCell::get_hypercube(dim)) + { + out.write_cell_single(count++, + first_vertex_of_patch, + patch.data.n_cols()); + first_vertex_of_patch += patch.data.n_cols(); + } + else + { + const unsigned int n_subdivisions = patch.n_subdivisions; + const unsigned int n = n_subdivisions + 1; + // Length of loops in all dimensons + const unsigned int n1 = (dim > 0) ? n_subdivisions : 1; + const unsigned int n2 = (dim > 1) ? n_subdivisions : 1; + const unsigned int n3 = (dim > 2) ? n_subdivisions : 1; + // Offsets of outer loops + const unsigned int d1 = 1; + const unsigned int d2 = n; + const unsigned int d3 = n * n; + for (unsigned int i3 = 0; i3 < n3; ++i3) + for (unsigned int i2 = 0; i2 < n2; ++i2) + for (unsigned int i1 = 0; i1 < n1; ++i1) + { + const unsigned int offset = + first_vertex_of_patch + i3 * d3 + i2 * d2 + i1 * d1; + // First write line in x direction + out.template write_cell(count++, offset, d1, d2, d3); + } + // finally update the number of the first vertex of this patch + first_vertex_of_patch += + Utilities::fixed_power(n_subdivisions + 1); + } } out.flush_cells(); @@ -4836,18 +4928,39 @@ namespace DataOutBase } // first count the number of cells and cells for later use - unsigned int n_nodes; - unsigned int n_cells; - compute_sizes(patches, n_nodes, n_cells); + unsigned int n_nodes = 0; + unsigned int n_cells = 0; + unsigned int n_points_an_n_cell = 0; - // If a user set to output high order cells, we treat n_subdivisions - // as a cell order and adjust variables accordingly, otherwise - // each patch is written as a linear cell. - unsigned int n_points_per_cell = GeometryInfo::vertices_per_cell; - if (flags.write_higher_order_cells) + // compute_sizes(patches, n_nodes, n_cells); + + for (const auto &patch : patches) { - n_cells = patches.size(); - n_points_per_cell = n_nodes / n_cells; + // special treatment of simplices since they are not subdivided + if (patch.reference_cell_type != ReferenceCell::get_hypercube(dim)) + { + n_nodes += patch.data.n_cols(); + n_cells += 1; + n_points_an_n_cell += patch.data.n_cols() + 1; + } + else + { + n_nodes += Utilities::fixed_power(patch.n_subdivisions + 1); + + if (flags.write_higher_order_cells) + { + n_cells += 1; + n_points_an_n_cell += + 1 + Utilities::fixed_power(patch.n_subdivisions + 1); + } + else + { + n_cells += Utilities::fixed_power(patch.n_subdivisions); + n_points_an_n_cell += + Utilities::fixed_power(patch.n_subdivisions) * + (1 + GeometryInfo::vertices_per_cell); + } + } } // in gmv format the vertex coordinates and the data have an order that is a @@ -4879,8 +4992,7 @@ namespace DataOutBase out << '\n'; ///////////////////////////////// // now for the cells - out << "CELLS " << n_cells << ' ' << n_cells * (n_points_per_cell + 1) - << '\n'; + out << "CELLS " << n_cells << ' ' << n_points_an_n_cell << '\n'; if (flags.write_higher_order_cells) write_high_order_cells(patches, vtk_out); else @@ -4890,12 +5002,39 @@ namespace DataOutBase // simple out << "CELL_TYPES " << n_cells << '\n'; - // need to distinguish between linear and high order cells - const unsigned int vtk_cell_id = flags.write_higher_order_cells ? - vtk_lagrange_cell_type[dim] : - vtk_cell_type[dim]; - for (unsigned int i = 0; i < n_cells; ++i) - out << ' ' << vtk_cell_id; + // need to distinguish between linear cells, simplex cells (linear or + // quadratic), and high order cells + for (const auto &patch : patches) + { + std::pair vtk_cell_id = {-1, -1}; + + if (flags.write_higher_order_cells && + patch.reference_cell_type == ReferenceCell::get_hypercube(dim)) + vtk_cell_id = {vtk_lagrange_cell_type[dim], 1}; + else if (patch.reference_cell_type == ReferenceCell::Type::Tri && + patch.data.n_cols() == 3) + vtk_cell_id = {5, 1}; + else if (patch.reference_cell_type == ReferenceCell::Type::Tri && + patch.data.n_cols() == 6) + vtk_cell_id = {22, 1}; + else if (patch.reference_cell_type == ReferenceCell::Type::Tet && + patch.data.n_cols() == 4) + vtk_cell_id = {10, 1}; + else if (patch.reference_cell_type == ReferenceCell::Type::Tet && + patch.data.n_cols() == 10) + vtk_cell_id = {24, 1}; + else if (patch.reference_cell_type == ReferenceCell::get_hypercube(dim)) + vtk_cell_id = {vtk_cell_type[dim], + Utilities::pow(patch.n_subdivisions, dim)}; + else + { + Assert(false, ExcNotImplemented()); + } + + for (unsigned int i = 0; i < vtk_cell_id.second; ++i) + out << ' ' << vtk_cell_id.first; + } + out << '\n'; /////////////////////////////////////// // data output. diff --git a/source/numerics/data_out.cc b/source/numerics/data_out.cc index d78b22e2de..2a28a0f04a 100644 --- a/source/numerics/data_out.cc +++ b/source/numerics/data_out.cc @@ -97,7 +97,8 @@ DataOut::build_one_patch( ::dealii::DataOutBase::Patch patch; - patch.n_subdivisions = n_subdivisions; + patch.n_subdivisions = n_subdivisions; + patch.reference_cell_type = cell_and_index->first->reference_cell_type(); // initialize FEValues scratch_data.reinit_all_fe_values(this->dof_data, cell_and_index->first); @@ -108,8 +109,7 @@ DataOut::build_one_patch( // set the vertices of the patch. if the mapping does not preserve locations // (e.g. MappingQEulerian), we need to compute the offset of the vertex for // the graphical output. Otherwise, we can just use the vertex info. - for (const unsigned int vertex : - GeometryInfo::vertex_indices()) + for (const unsigned int vertex : cell_and_index->first->vertex_indices()) if (fe_patch_values.get_mapping().preserves_vertex_locations()) patch.vertices[vertex] = cell_and_index->first->vertex(vertex); else @@ -133,7 +133,9 @@ DataOut::build_one_patch( if (curved_cell_region == curved_inner_cells || (curved_cell_region == curved_boundary && (cell_and_index->first->at_boundary() || - (DoFHandlerType::dimension != DoFHandlerType::space_dimension)))) + (DoFHandlerType::dimension != DoFHandlerType::space_dimension))) || + (cell_and_index->first->reference_cell_type() != + ReferenceCell::get_hypercube(dim))) { Assert(patch.space_dim == DoFHandlerType::space_dimension, ExcInternalError()); @@ -1009,8 +1011,7 @@ DataOut::build_one_patch( } - for (const unsigned int f : - GeometryInfo::face_indices()) + for (const unsigned int f : cell_and_index->first->face_indices()) { // let's look up whether the neighbor behind that face is noted in the // table of cells which we treat. this can only happen if the neighbor diff --git a/source/simplex/fe_lib.cc b/source/simplex/fe_lib.cc index 75af427581..a4b0d0282f 100644 --- a/source/simplex/fe_lib.cc +++ b/source/simplex/fe_lib.cc @@ -115,9 +115,9 @@ namespace Simplex { if (degree == 1) { + this->unit_support_points.emplace_back(0.0, 0.0); this->unit_support_points.emplace_back(1.0, 0.0); this->unit_support_points.emplace_back(0.0, 1.0); - this->unit_support_points.emplace_back(0.0, 0.0); // TODO this->unit_face_support_points.emplace_back(0.0); @@ -125,12 +125,12 @@ namespace Simplex } else if (degree == 2) { + this->unit_support_points.emplace_back(0.0, 0.0); this->unit_support_points.emplace_back(1.0, 0.0); this->unit_support_points.emplace_back(0.0, 1.0); - this->unit_support_points.emplace_back(0.0, 0.0); + this->unit_support_points.emplace_back(0.5, 0.0); this->unit_support_points.emplace_back(0.5, 0.5); this->unit_support_points.emplace_back(0.0, 0.5); - this->unit_support_points.emplace_back(0.5, 0.0); // TODO this->unit_face_support_points.emplace_back(0.0); diff --git a/tests/simplex/data_out_write_vtk_01.cc b/tests/simplex/data_out_write_vtk_01.cc new file mode 100644 index 0000000000..027654e519 --- /dev/null +++ b/tests/simplex/data_out_write_vtk_01.cc @@ -0,0 +1,120 @@ +// --------------------------------------------------------------------- +// +// Copyright (C) 2020 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 DataOut::write_vtk() for simplex meshes. + +#include + +#include +#include + +#include +#include +#include + +#include +#include + +#include +#include + +#include "../tests.h" + +using namespace dealii; + +template +class RightHandSideFunction : public Function +{ +public: + RightHandSideFunction(const unsigned int n_components) + : Function(n_components) + {} + + virtual double + value(const Point &p, const unsigned int component = 0) const + { + return p[component % dim] * p[component % dim]; + } +}; + +template +void +test(const FiniteElement &fe, const unsigned int n_components) +{ + Triangulation tria; + Simplex::GridGenerator::subdivided_hyper_cube(tria, dim == 2 ? 4 : 2); + + DoFHandler dof_handler(tria); + + dof_handler.distribute_dofs(fe); + + Vector solution(dof_handler.n_dofs()); + + MappingFE mapping(Simplex::FE_P(1)); + + VectorTools::interpolate(mapping, + dof_handler, + RightHandSideFunction(n_components), + solution); + + static unsigned int counter = 0; + + for (unsigned int n_subdivisions = 1; n_subdivisions <= 2; ++n_subdivisions) + { + DataOut data_out; + + data_out.attach_dof_handler(dof_handler); + data_out.add_data_vector(solution, "solution"); + + + data_out.build_patches(mapping, n_subdivisions); + +#if false + std::ofstream output("test." + std::to_string(dim) + "." + std::to_string(counter++) + ".vtk"); + data_out.write_vtk(output); +#else + data_out.write_vtk(deallog.get_file_stream()); +#endif + } +} + +int +main() +{ + initlog(); + + { + const unsigned int dim = 2; + test(Simplex::FE_P(2) /*=degree*/, 1); + test(FESystem(Simplex::FE_P(2 /*=degree*/), dim), dim); + test(FESystem(Simplex::FE_P(2 /*=degree*/), + dim, + Simplex::FE_P(1 /*=degree*/), + 1), + dim + 1); + } + { + const unsigned int dim = 3; + test(Simplex::FE_P(2) /*=degree*/, 1); + test(FESystem(Simplex::FE_P(2 /*=degree*/), dim), dim); + test(FESystem(Simplex::FE_P(2 /*=degree*/), + dim, + Simplex::FE_P(1 /*=degree*/), + 1), + dim + 1); + } +} diff --git a/tests/simplex/data_out_write_vtk_01.with_simplex_support=on.output b/tests/simplex/data_out_write_vtk_01.with_simplex_support=on.output new file mode 100644 index 0000000000..9545765567 --- /dev/null +++ b/tests/simplex/data_out_write_vtk_01.with_simplex_support=on.output @@ -0,0 +1,3205 @@ + +# vtk DataFile Version 3.0 +#This file was generated +ASCII +DATASET UNSTRUCTURED_GRID + +POINTS 96 double +0.00000 0.00000 0 +0.250000 0.00000 0 +0.00000 0.250000 0 +0.250000 0.250000 0 +0.00000 0.250000 0 +0.250000 0.00000 0 +0.250000 0.00000 0 +0.500000 0.00000 0 +0.250000 0.250000 0 +0.500000 0.250000 0 +0.250000 0.250000 0 +0.500000 0.00000 0 +0.500000 0.00000 0 +0.750000 0.00000 0 +0.500000 0.250000 0 +0.750000 0.250000 0 +0.500000 0.250000 0 +0.750000 0.00000 0 +0.750000 0.00000 0 +1.00000 0.00000 0 +0.750000 0.250000 0 +1.00000 0.250000 0 +0.750000 0.250000 0 +1.00000 0.00000 0 +0.00000 0.250000 0 +0.250000 0.250000 0 +0.00000 0.500000 0 +0.250000 0.500000 0 +0.00000 0.500000 0 +0.250000 0.250000 0 +0.250000 0.250000 0 +0.500000 0.250000 0 +0.250000 0.500000 0 +0.500000 0.500000 0 +0.250000 0.500000 0 +0.500000 0.250000 0 +0.500000 0.250000 0 +0.750000 0.250000 0 +0.500000 0.500000 0 +0.750000 0.500000 0 +0.500000 0.500000 0 +0.750000 0.250000 0 +0.750000 0.250000 0 +1.00000 0.250000 0 +0.750000 0.500000 0 +1.00000 0.500000 0 +0.750000 0.500000 0 +1.00000 0.250000 0 +0.00000 0.500000 0 +0.250000 0.500000 0 +0.00000 0.750000 0 +0.250000 0.750000 0 +0.00000 0.750000 0 +0.250000 0.500000 0 +0.250000 0.500000 0 +0.500000 0.500000 0 +0.250000 0.750000 0 +0.500000 0.750000 0 +0.250000 0.750000 0 +0.500000 0.500000 0 +0.500000 0.500000 0 +0.750000 0.500000 0 +0.500000 0.750000 0 +0.750000 0.750000 0 +0.500000 0.750000 0 +0.750000 0.500000 0 +0.750000 0.500000 0 +1.00000 0.500000 0 +0.750000 0.750000 0 +1.00000 0.750000 0 +0.750000 0.750000 0 +1.00000 0.500000 0 +0.00000 0.750000 0 +0.250000 0.750000 0 +0.00000 1.00000 0 +0.250000 1.00000 0 +0.00000 1.00000 0 +0.250000 0.750000 0 +0.250000 0.750000 0 +0.500000 0.750000 0 +0.250000 1.00000 0 +0.500000 1.00000 0 +0.250000 1.00000 0 +0.500000 0.750000 0 +0.500000 0.750000 0 +0.750000 0.750000 0 +0.500000 1.00000 0 +0.750000 1.00000 0 +0.500000 1.00000 0 +0.750000 0.750000 0 +0.750000 0.750000 0 +1.00000 0.750000 0 +0.750000 1.00000 0 +1.00000 1.00000 0 +0.750000 1.00000 0 +1.00000 0.750000 0 + +CELLS 32 128 + 3 0 1 2 + 3 3 4 5 + 3 6 7 8 + 3 9 10 11 + 3 12 13 14 + 3 15 16 17 + 3 18 19 20 + 3 21 22 23 + 3 24 25 26 + 3 27 28 29 + 3 30 31 32 + 3 33 34 35 + 3 36 37 38 + 3 39 40 41 + 3 42 43 44 + 3 45 46 47 + 3 48 49 50 + 3 51 52 53 + 3 54 55 56 + 3 57 58 59 + 3 60 61 62 + 3 63 64 65 + 3 66 67 68 + 3 69 70 71 + 3 72 73 74 + 3 75 76 77 + 3 78 79 80 + 3 81 82 83 + 3 84 85 86 + 3 87 88 89 + 3 90 91 92 + 3 93 94 95 + +CELL_TYPES 32 + 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 +POINT_DATA 96 +SCALARS solution double 1 +LOOKUP_TABLE default +0.00000 0.0625000 0.00000 0.0625000 0.00000 0.0625000 0.0625000 0.250000 0.0625000 0.250000 0.0625000 0.250000 0.250000 0.562500 0.250000 0.562500 0.250000 0.562500 0.562500 1.00000 0.562500 1.00000 0.562500 1.00000 0.00000 0.0625000 0.00000 0.0625000 0.00000 0.0625000 0.0625000 0.250000 0.0625000 0.250000 0.0625000 0.250000 0.250000 0.562500 0.250000 0.562500 0.250000 0.562500 0.562500 1.00000 0.562500 1.00000 0.562500 1.00000 0.00000 0.0625000 0.00000 0.0625000 0.00000 0.0625000 0.0625000 0.250000 0.0625000 0.250000 0.0625000 0.250000 0.250000 0.562500 0.250000 0.562500 0.250000 0.562500 0.562500 1.00000 0.562500 1.00000 0.562500 1.00000 0.00000 0.0625000 0.00000 0.0625000 0.00000 0.0625000 0.0625000 0.250000 0.0625000 0.250000 0.0625000 0.250000 0.250000 0.562500 0.250000 0.562500 0.250000 0.562500 0.562500 1.00000 0.562500 1.00000 0.562500 1.00000 +# vtk DataFile Version 3.0 +#This file was generated +ASCII +DATASET UNSTRUCTURED_GRID + +POINTS 192 double +0.00000 0.00000 0 +0.250000 0.00000 0 +0.00000 0.250000 0 +0.125000 0.00000 0 +0.125000 0.125000 0 +0.00000 0.125000 0 +0.250000 0.250000 0 +0.00000 0.250000 0 +0.250000 0.00000 0 +0.125000 0.250000 0 +0.125000 0.125000 0 +0.250000 0.125000 0 +0.250000 0.00000 0 +0.500000 0.00000 0 +0.250000 0.250000 0 +0.375000 0.00000 0 +0.375000 0.125000 0 +0.250000 0.125000 0 +0.500000 0.250000 0 +0.250000 0.250000 0 +0.500000 0.00000 0 +0.375000 0.250000 0 +0.375000 0.125000 0 +0.500000 0.125000 0 +0.500000 0.00000 0 +0.750000 0.00000 0 +0.500000 0.250000 0 +0.625000 0.00000 0 +0.625000 0.125000 0 +0.500000 0.125000 0 +0.750000 0.250000 0 +0.500000 0.250000 0 +0.750000 0.00000 0 +0.625000 0.250000 0 +0.625000 0.125000 0 +0.750000 0.125000 0 +0.750000 0.00000 0 +1.00000 0.00000 0 +0.750000 0.250000 0 +0.875000 0.00000 0 +0.875000 0.125000 0 +0.750000 0.125000 0 +1.00000 0.250000 0 +0.750000 0.250000 0 +1.00000 0.00000 0 +0.875000 0.250000 0 +0.875000 0.125000 0 +1.00000 0.125000 0 +0.00000 0.250000 0 +0.250000 0.250000 0 +0.00000 0.500000 0 +0.125000 0.250000 0 +0.125000 0.375000 0 +0.00000 0.375000 0 +0.250000 0.500000 0 +0.00000 0.500000 0 +0.250000 0.250000 0 +0.125000 0.500000 0 +0.125000 0.375000 0 +0.250000 0.375000 0 +0.250000 0.250000 0 +0.500000 0.250000 0 +0.250000 0.500000 0 +0.375000 0.250000 0 +0.375000 0.375000 0 +0.250000 0.375000 0 +0.500000 0.500000 0 +0.250000 0.500000 0 +0.500000 0.250000 0 +0.375000 0.500000 0 +0.375000 0.375000 0 +0.500000 0.375000 0 +0.500000 0.250000 0 +0.750000 0.250000 0 +0.500000 0.500000 0 +0.625000 0.250000 0 +0.625000 0.375000 0 +0.500000 0.375000 0 +0.750000 0.500000 0 +0.500000 0.500000 0 +0.750000 0.250000 0 +0.625000 0.500000 0 +0.625000 0.375000 0 +0.750000 0.375000 0 +0.750000 0.250000 0 +1.00000 0.250000 0 +0.750000 0.500000 0 +0.875000 0.250000 0 +0.875000 0.375000 0 +0.750000 0.375000 0 +1.00000 0.500000 0 +0.750000 0.500000 0 +1.00000 0.250000 0 +0.875000 0.500000 0 +0.875000 0.375000 0 +1.00000 0.375000 0 +0.00000 0.500000 0 +0.250000 0.500000 0 +0.00000 0.750000 0 +0.125000 0.500000 0 +0.125000 0.625000 0 +0.00000 0.625000 0 +0.250000 0.750000 0 +0.00000 0.750000 0 +0.250000 0.500000 0 +0.125000 0.750000 0 +0.125000 0.625000 0 +0.250000 0.625000 0 +0.250000 0.500000 0 +0.500000 0.500000 0 +0.250000 0.750000 0 +0.375000 0.500000 0 +0.375000 0.625000 0 +0.250000 0.625000 0 +0.500000 0.750000 0 +0.250000 0.750000 0 +0.500000 0.500000 0 +0.375000 0.750000 0 +0.375000 0.625000 0 +0.500000 0.625000 0 +0.500000 0.500000 0 +0.750000 0.500000 0 +0.500000 0.750000 0 +0.625000 0.500000 0 +0.625000 0.625000 0 +0.500000 0.625000 0 +0.750000 0.750000 0 +0.500000 0.750000 0 +0.750000 0.500000 0 +0.625000 0.750000 0 +0.625000 0.625000 0 +0.750000 0.625000 0 +0.750000 0.500000 0 +1.00000 0.500000 0 +0.750000 0.750000 0 +0.875000 0.500000 0 +0.875000 0.625000 0 +0.750000 0.625000 0 +1.00000 0.750000 0 +0.750000 0.750000 0 +1.00000 0.500000 0 +0.875000 0.750000 0 +0.875000 0.625000 0 +1.00000 0.625000 0 +0.00000 0.750000 0 +0.250000 0.750000 0 +0.00000 1.00000 0 +0.125000 0.750000 0 +0.125000 0.875000 0 +0.00000 0.875000 0 +0.250000 1.00000 0 +0.00000 1.00000 0 +0.250000 0.750000 0 +0.125000 1.00000 0 +0.125000 0.875000 0 +0.250000 0.875000 0 +0.250000 0.750000 0 +0.500000 0.750000 0 +0.250000 1.00000 0 +0.375000 0.750000 0 +0.375000 0.875000 0 +0.250000 0.875000 0 +0.500000 1.00000 0 +0.250000 1.00000 0 +0.500000 0.750000 0 +0.375000 1.00000 0 +0.375000 0.875000 0 +0.500000 0.875000 0 +0.500000 0.750000 0 +0.750000 0.750000 0 +0.500000 1.00000 0 +0.625000 0.750000 0 +0.625000 0.875000 0 +0.500000 0.875000 0 +0.750000 1.00000 0 +0.500000 1.00000 0 +0.750000 0.750000 0 +0.625000 1.00000 0 +0.625000 0.875000 0 +0.750000 0.875000 0 +0.750000 0.750000 0 +1.00000 0.750000 0 +0.750000 1.00000 0 +0.875000 0.750000 0 +0.875000 0.875000 0 +0.750000 0.875000 0 +1.00000 1.00000 0 +0.750000 1.00000 0 +1.00000 0.750000 0 +0.875000 1.00000 0 +0.875000 0.875000 0 +1.00000 0.875000 0 + +CELLS 32 224 + 6 0 1 2 3 4 5 + 6 6 7 8 9 10 11 + 6 12 13 14 15 16 17 + 6 18 19 20 21 22 23 + 6 24 25 26 27 28 29 + 6 30 31 32 33 34 35 + 6 36 37 38 39 40 41 + 6 42 43 44 45 46 47 + 6 48 49 50 51 52 53 + 6 54 55 56 57 58 59 + 6 60 61 62 63 64 65 + 6 66 67 68 69 70 71 + 6 72 73 74 75 76 77 + 6 78 79 80 81 82 83 + 6 84 85 86 87 88 89 + 6 90 91 92 93 94 95 + 6 96 97 98 99 100 101 + 6 102 103 104 105 106 107 + 6 108 109 110 111 112 113 + 6 114 115 116 117 118 119 + 6 120 121 122 123 124 125 + 6 126 127 128 129 130 131 + 6 132 133 134 135 136 137 + 6 138 139 140 141 142 143 + 6 144 145 146 147 148 149 + 6 150 151 152 153 154 155 + 6 156 157 158 159 160 161 + 6 162 163 164 165 166 167 + 6 168 169 170 171 172 173 + 6 174 175 176 177 178 179 + 6 180 181 182 183 184 185 + 6 186 187 188 189 190 191 + +CELL_TYPES 32 + 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 +POINT_DATA 192 +SCALARS solution double 1 +LOOKUP_TABLE default +0.00000 0.0625000 0.00000 0.0156250 0.0156250 0.00000 0.0625000 0.00000 0.0625000 0.0156250 0.0156250 0.0625000 0.0625000 0.250000 0.0625000 0.140625 0.140625 0.0625000 0.250000 0.0625000 0.250000 0.140625 0.140625 0.250000 0.250000 0.562500 0.250000 0.390625 0.390625 0.250000 0.562500 0.250000 0.562500 0.390625 0.390625 0.562500 0.562500 1.00000 0.562500 0.765625 0.765625 0.562500 1.00000 0.562500 1.00000 0.765625 0.765625 1.00000 0.00000 0.0625000 0.00000 0.0156250 0.0156250 0.00000 0.0625000 0.00000 0.0625000 0.0156250 0.0156250 0.0625000 0.0625000 0.250000 0.0625000 0.140625 0.140625 0.0625000 0.250000 0.0625000 0.250000 0.140625 0.140625 0.250000 0.250000 0.562500 0.250000 0.390625 0.390625 0.250000 0.562500 0.250000 0.562500 0.390625 0.390625 0.562500 0.562500 1.00000 0.562500 0.765625 0.765625 0.562500 1.00000 0.562500 1.00000 0.765625 0.765625 1.00000 0.00000 0.0625000 0.00000 0.0156250 0.0156250 0.00000 0.0625000 0.00000 0.0625000 0.0156250 0.0156250 0.0625000 0.0625000 0.250000 0.0625000 0.140625 0.140625 0.0625000 0.250000 0.0625000 0.250000 0.140625 0.140625 0.250000 0.250000 0.562500 0.250000 0.390625 0.390625 0.250000 0.562500 0.250000 0.562500 0.390625 0.390625 0.562500 0.562500 1.00000 0.562500 0.765625 0.765625 0.562500 1.00000 0.562500 1.00000 0.765625 0.765625 1.00000 0.00000 0.0625000 0.00000 0.0156250 0.0156250 0.00000 0.0625000 0.00000 0.0625000 0.0156250 0.0156250 0.0625000 0.0625000 0.250000 0.0625000 0.140625 0.140625 0.0625000 0.250000 0.0625000 0.250000 0.140625 0.140625 0.250000 0.250000 0.562500 0.250000 0.390625 0.390625 0.250000 0.562500 0.250000 0.562500 0.390625 0.390625 0.562500 0.562500 1.00000 0.562500 0.765625 0.765625 0.562500 1.00000 0.562500 1.00000 0.765625 0.765625 1.00000 +# vtk DataFile Version 3.0 +#This file was generated +ASCII +DATASET UNSTRUCTURED_GRID + +POINTS 96 double +0.00000 0.00000 0 +0.250000 0.00000 0 +0.00000 0.250000 0 +0.250000 0.250000 0 +0.00000 0.250000 0 +0.250000 0.00000 0 +0.250000 0.00000 0 +0.500000 0.00000 0 +0.250000 0.250000 0 +0.500000 0.250000 0 +0.250000 0.250000 0 +0.500000 0.00000 0 +0.500000 0.00000 0 +0.750000 0.00000 0 +0.500000 0.250000 0 +0.750000 0.250000 0 +0.500000 0.250000 0 +0.750000 0.00000 0 +0.750000 0.00000 0 +1.00000 0.00000 0 +0.750000 0.250000 0 +1.00000 0.250000 0 +0.750000 0.250000 0 +1.00000 0.00000 0 +0.00000 0.250000 0 +0.250000 0.250000 0 +0.00000 0.500000 0 +0.250000 0.500000 0 +0.00000 0.500000 0 +0.250000 0.250000 0 +0.250000 0.250000 0 +0.500000 0.250000 0 +0.250000 0.500000 0 +0.500000 0.500000 0 +0.250000 0.500000 0 +0.500000 0.250000 0 +0.500000 0.250000 0 +0.750000 0.250000 0 +0.500000 0.500000 0 +0.750000 0.500000 0 +0.500000 0.500000 0 +0.750000 0.250000 0 +0.750000 0.250000 0 +1.00000 0.250000 0 +0.750000 0.500000 0 +1.00000 0.500000 0 +0.750000 0.500000 0 +1.00000 0.250000 0 +0.00000 0.500000 0 +0.250000 0.500000 0 +0.00000 0.750000 0 +0.250000 0.750000 0 +0.00000 0.750000 0 +0.250000 0.500000 0 +0.250000 0.500000 0 +0.500000 0.500000 0 +0.250000 0.750000 0 +0.500000 0.750000 0 +0.250000 0.750000 0 +0.500000 0.500000 0 +0.500000 0.500000 0 +0.750000 0.500000 0 +0.500000 0.750000 0 +0.750000 0.750000 0 +0.500000 0.750000 0 +0.750000 0.500000 0 +0.750000 0.500000 0 +1.00000 0.500000 0 +0.750000 0.750000 0 +1.00000 0.750000 0 +0.750000 0.750000 0 +1.00000 0.500000 0 +0.00000 0.750000 0 +0.250000 0.750000 0 +0.00000 1.00000 0 +0.250000 1.00000 0 +0.00000 1.00000 0 +0.250000 0.750000 0 +0.250000 0.750000 0 +0.500000 0.750000 0 +0.250000 1.00000 0 +0.500000 1.00000 0 +0.250000 1.00000 0 +0.500000 0.750000 0 +0.500000 0.750000 0 +0.750000 0.750000 0 +0.500000 1.00000 0 +0.750000 1.00000 0 +0.500000 1.00000 0 +0.750000 0.750000 0 +0.750000 0.750000 0 +1.00000 0.750000 0 +0.750000 1.00000 0 +1.00000 1.00000 0 +0.750000 1.00000 0 +1.00000 0.750000 0 + +CELLS 32 128 + 3 0 1 2 + 3 3 4 5 + 3 6 7 8 + 3 9 10 11 + 3 12 13 14 + 3 15 16 17 + 3 18 19 20 + 3 21 22 23 + 3 24 25 26 + 3 27 28 29 + 3 30 31 32 + 3 33 34 35 + 3 36 37 38 + 3 39 40 41 + 3 42 43 44 + 3 45 46 47 + 3 48 49 50 + 3 51 52 53 + 3 54 55 56 + 3 57 58 59 + 3 60 61 62 + 3 63 64 65 + 3 66 67 68 + 3 69 70 71 + 3 72 73 74 + 3 75 76 77 + 3 78 79 80 + 3 81 82 83 + 3 84 85 86 + 3 87 88 89 + 3 90 91 92 + 3 93 94 95 + +CELL_TYPES 32 + 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 +POINT_DATA 96 +SCALARS solution_0 double 1 +LOOKUP_TABLE default +0.00000 0.0625000 0.00000 0.0625000 0.00000 0.0625000 0.0625000 0.250000 0.0625000 0.250000 0.0625000 0.250000 0.250000 0.562500 0.250000 0.562500 0.250000 0.562500 0.562500 1.00000 0.562500 1.00000 0.562500 1.00000 0.00000 0.0625000 0.00000 0.0625000 0.00000 0.0625000 0.0625000 0.250000 0.0625000 0.250000 0.0625000 0.250000 0.250000 0.562500 0.250000 0.562500 0.250000 0.562500 0.562500 1.00000 0.562500 1.00000 0.562500 1.00000 0.00000 0.0625000 0.00000 0.0625000 0.00000 0.0625000 0.0625000 0.250000 0.0625000 0.250000 0.0625000 0.250000 0.250000 0.562500 0.250000 0.562500 0.250000 0.562500 0.562500 1.00000 0.562500 1.00000 0.562500 1.00000 0.00000 0.0625000 0.00000 0.0625000 0.00000 0.0625000 0.0625000 0.250000 0.0625000 0.250000 0.0625000 0.250000 0.250000 0.562500 0.250000 0.562500 0.250000 0.562500 0.562500 1.00000 0.562500 1.00000 0.562500 1.00000 +SCALARS solution_1 double 1 +LOOKUP_TABLE default +0.00000 0.00000 0.0625000 0.0625000 0.0625000 0.00000 0.00000 0.00000 0.0625000 0.0625000 0.0625000 0.00000 0.00000 0.00000 0.0625000 0.0625000 0.0625000 0.00000 0.00000 0.00000 0.0625000 0.0625000 0.0625000 0.00000 0.0625000 0.0625000 0.250000 0.250000 0.250000 0.0625000 0.0625000 0.0625000 0.250000 0.250000 0.250000 0.0625000 0.0625000 0.0625000 0.250000 0.250000 0.250000 0.0625000 0.0625000 0.0625000 0.250000 0.250000 0.250000 0.0625000 0.250000 0.250000 0.562500 0.562500 0.562500 0.250000 0.250000 0.250000 0.562500 0.562500 0.562500 0.250000 0.250000 0.250000 0.562500 0.562500 0.562500 0.250000 0.250000 0.250000 0.562500 0.562500 0.562500 0.250000 0.562500 0.562500 1.00000 1.00000 1.00000 0.562500 0.562500 0.562500 1.00000 1.00000 1.00000 0.562500 0.562500 0.562500 1.00000 1.00000 1.00000 0.562500 0.562500 0.562500 1.00000 1.00000 1.00000 0.562500 +# vtk DataFile Version 3.0 +#This file was generated +ASCII +DATASET UNSTRUCTURED_GRID + +POINTS 192 double +0.00000 0.00000 0 +0.250000 0.00000 0 +0.00000 0.250000 0 +0.125000 0.00000 0 +0.125000 0.125000 0 +0.00000 0.125000 0 +0.250000 0.250000 0 +0.00000 0.250000 0 +0.250000 0.00000 0 +0.125000 0.250000 0 +0.125000 0.125000 0 +0.250000 0.125000 0 +0.250000 0.00000 0 +0.500000 0.00000 0 +0.250000 0.250000 0 +0.375000 0.00000 0 +0.375000 0.125000 0 +0.250000 0.125000 0 +0.500000 0.250000 0 +0.250000 0.250000 0 +0.500000 0.00000 0 +0.375000 0.250000 0 +0.375000 0.125000 0 +0.500000 0.125000 0 +0.500000 0.00000 0 +0.750000 0.00000 0 +0.500000 0.250000 0 +0.625000 0.00000 0 +0.625000 0.125000 0 +0.500000 0.125000 0 +0.750000 0.250000 0 +0.500000 0.250000 0 +0.750000 0.00000 0 +0.625000 0.250000 0 +0.625000 0.125000 0 +0.750000 0.125000 0 +0.750000 0.00000 0 +1.00000 0.00000 0 +0.750000 0.250000 0 +0.875000 0.00000 0 +0.875000 0.125000 0 +0.750000 0.125000 0 +1.00000 0.250000 0 +0.750000 0.250000 0 +1.00000 0.00000 0 +0.875000 0.250000 0 +0.875000 0.125000 0 +1.00000 0.125000 0 +0.00000 0.250000 0 +0.250000 0.250000 0 +0.00000 0.500000 0 +0.125000 0.250000 0 +0.125000 0.375000 0 +0.00000 0.375000 0 +0.250000 0.500000 0 +0.00000 0.500000 0 +0.250000 0.250000 0 +0.125000 0.500000 0 +0.125000 0.375000 0 +0.250000 0.375000 0 +0.250000 0.250000 0 +0.500000 0.250000 0 +0.250000 0.500000 0 +0.375000 0.250000 0 +0.375000 0.375000 0 +0.250000 0.375000 0 +0.500000 0.500000 0 +0.250000 0.500000 0 +0.500000 0.250000 0 +0.375000 0.500000 0 +0.375000 0.375000 0 +0.500000 0.375000 0 +0.500000 0.250000 0 +0.750000 0.250000 0 +0.500000 0.500000 0 +0.625000 0.250000 0 +0.625000 0.375000 0 +0.500000 0.375000 0 +0.750000 0.500000 0 +0.500000 0.500000 0 +0.750000 0.250000 0 +0.625000 0.500000 0 +0.625000 0.375000 0 +0.750000 0.375000 0 +0.750000 0.250000 0 +1.00000 0.250000 0 +0.750000 0.500000 0 +0.875000 0.250000 0 +0.875000 0.375000 0 +0.750000 0.375000 0 +1.00000 0.500000 0 +0.750000 0.500000 0 +1.00000 0.250000 0 +0.875000 0.500000 0 +0.875000 0.375000 0 +1.00000 0.375000 0 +0.00000 0.500000 0 +0.250000 0.500000 0 +0.00000 0.750000 0 +0.125000 0.500000 0 +0.125000 0.625000 0 +0.00000 0.625000 0 +0.250000 0.750000 0 +0.00000 0.750000 0 +0.250000 0.500000 0 +0.125000 0.750000 0 +0.125000 0.625000 0 +0.250000 0.625000 0 +0.250000 0.500000 0 +0.500000 0.500000 0 +0.250000 0.750000 0 +0.375000 0.500000 0 +0.375000 0.625000 0 +0.250000 0.625000 0 +0.500000 0.750000 0 +0.250000 0.750000 0 +0.500000 0.500000 0 +0.375000 0.750000 0 +0.375000 0.625000 0 +0.500000 0.625000 0 +0.500000 0.500000 0 +0.750000 0.500000 0 +0.500000 0.750000 0 +0.625000 0.500000 0 +0.625000 0.625000 0 +0.500000 0.625000 0 +0.750000 0.750000 0 +0.500000 0.750000 0 +0.750000 0.500000 0 +0.625000 0.750000 0 +0.625000 0.625000 0 +0.750000 0.625000 0 +0.750000 0.500000 0 +1.00000 0.500000 0 +0.750000 0.750000 0 +0.875000 0.500000 0 +0.875000 0.625000 0 +0.750000 0.625000 0 +1.00000 0.750000 0 +0.750000 0.750000 0 +1.00000 0.500000 0 +0.875000 0.750000 0 +0.875000 0.625000 0 +1.00000 0.625000 0 +0.00000 0.750000 0 +0.250000 0.750000 0 +0.00000 1.00000 0 +0.125000 0.750000 0 +0.125000 0.875000 0 +0.00000 0.875000 0 +0.250000 1.00000 0 +0.00000 1.00000 0 +0.250000 0.750000 0 +0.125000 1.00000 0 +0.125000 0.875000 0 +0.250000 0.875000 0 +0.250000 0.750000 0 +0.500000 0.750000 0 +0.250000 1.00000 0 +0.375000 0.750000 0 +0.375000 0.875000 0 +0.250000 0.875000 0 +0.500000 1.00000 0 +0.250000 1.00000 0 +0.500000 0.750000 0 +0.375000 1.00000 0 +0.375000 0.875000 0 +0.500000 0.875000 0 +0.500000 0.750000 0 +0.750000 0.750000 0 +0.500000 1.00000 0 +0.625000 0.750000 0 +0.625000 0.875000 0 +0.500000 0.875000 0 +0.750000 1.00000 0 +0.500000 1.00000 0 +0.750000 0.750000 0 +0.625000 1.00000 0 +0.625000 0.875000 0 +0.750000 0.875000 0 +0.750000 0.750000 0 +1.00000 0.750000 0 +0.750000 1.00000 0 +0.875000 0.750000 0 +0.875000 0.875000 0 +0.750000 0.875000 0 +1.00000 1.00000 0 +0.750000 1.00000 0 +1.00000 0.750000 0 +0.875000 1.00000 0 +0.875000 0.875000 0 +1.00000 0.875000 0 + +CELLS 32 224 + 6 0 1 2 3 4 5 + 6 6 7 8 9 10 11 + 6 12 13 14 15 16 17 + 6 18 19 20 21 22 23 + 6 24 25 26 27 28 29 + 6 30 31 32 33 34 35 + 6 36 37 38 39 40 41 + 6 42 43 44 45 46 47 + 6 48 49 50 51 52 53 + 6 54 55 56 57 58 59 + 6 60 61 62 63 64 65 + 6 66 67 68 69 70 71 + 6 72 73 74 75 76 77 + 6 78 79 80 81 82 83 + 6 84 85 86 87 88 89 + 6 90 91 92 93 94 95 + 6 96 97 98 99 100 101 + 6 102 103 104 105 106 107 + 6 108 109 110 111 112 113 + 6 114 115 116 117 118 119 + 6 120 121 122 123 124 125 + 6 126 127 128 129 130 131 + 6 132 133 134 135 136 137 + 6 138 139 140 141 142 143 + 6 144 145 146 147 148 149 + 6 150 151 152 153 154 155 + 6 156 157 158 159 160 161 + 6 162 163 164 165 166 167 + 6 168 169 170 171 172 173 + 6 174 175 176 177 178 179 + 6 180 181 182 183 184 185 + 6 186 187 188 189 190 191 + +CELL_TYPES 32 + 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 +POINT_DATA 192 +SCALARS solution_0 double 1 +LOOKUP_TABLE default +0.00000 0.0625000 0.00000 0.0156250 0.0156250 0.00000 0.0625000 0.00000 0.0625000 0.0156250 0.0156250 0.0625000 0.0625000 0.250000 0.0625000 0.140625 0.140625 0.0625000 0.250000 0.0625000 0.250000 0.140625 0.140625 0.250000 0.250000 0.562500 0.250000 0.390625 0.390625 0.250000 0.562500 0.250000 0.562500 0.390625 0.390625 0.562500 0.562500 1.00000 0.562500 0.765625 0.765625 0.562500 1.00000 0.562500 1.00000 0.765625 0.765625 1.00000 0.00000 0.0625000 0.00000 0.0156250 0.0156250 0.00000 0.0625000 0.00000 0.0625000 0.0156250 0.0156250 0.0625000 0.0625000 0.250000 0.0625000 0.140625 0.140625 0.0625000 0.250000 0.0625000 0.250000 0.140625 0.140625 0.250000 0.250000 0.562500 0.250000 0.390625 0.390625 0.250000 0.562500 0.250000 0.562500 0.390625 0.390625 0.562500 0.562500 1.00000 0.562500 0.765625 0.765625 0.562500 1.00000 0.562500 1.00000 0.765625 0.765625 1.00000 0.00000 0.0625000 0.00000 0.0156250 0.0156250 0.00000 0.0625000 0.00000 0.0625000 0.0156250 0.0156250 0.0625000 0.0625000 0.250000 0.0625000 0.140625 0.140625 0.0625000 0.250000 0.0625000 0.250000 0.140625 0.140625 0.250000 0.250000 0.562500 0.250000 0.390625 0.390625 0.250000 0.562500 0.250000 0.562500 0.390625 0.390625 0.562500 0.562500 1.00000 0.562500 0.765625 0.765625 0.562500 1.00000 0.562500 1.00000 0.765625 0.765625 1.00000 0.00000 0.0625000 0.00000 0.0156250 0.0156250 0.00000 0.0625000 0.00000 0.0625000 0.0156250 0.0156250 0.0625000 0.0625000 0.250000 0.0625000 0.140625 0.140625 0.0625000 0.250000 0.0625000 0.250000 0.140625 0.140625 0.250000 0.250000 0.562500 0.250000 0.390625 0.390625 0.250000 0.562500 0.250000 0.562500 0.390625 0.390625 0.562500 0.562500 1.00000 0.562500 0.765625 0.765625 0.562500 1.00000 0.562500 1.00000 0.765625 0.765625 1.00000 +SCALARS solution_1 double 1 +LOOKUP_TABLE default +0.00000 0.00000 0.0625000 0.00000 0.0156250 0.0156250 0.0625000 0.0625000 0.00000 0.0625000 0.0156250 0.0156250 0.00000 0.00000 0.0625000 0.00000 0.0156250 0.0156250 0.0625000 0.0625000 0.00000 0.0625000 0.0156250 0.0156250 0.00000 0.00000 0.0625000 0.00000 0.0156250 0.0156250 0.0625000 0.0625000 0.00000 0.0625000 0.0156250 0.0156250 0.00000 0.00000 0.0625000 0.00000 0.0156250 0.0156250 0.0625000 0.0625000 0.00000 0.0625000 0.0156250 0.0156250 0.0625000 0.0625000 0.250000 0.0625000 0.140625 0.140625 0.250000 0.250000 0.0625000 0.250000 0.140625 0.140625 0.0625000 0.0625000 0.250000 0.0625000 0.140625 0.140625 0.250000 0.250000 0.0625000 0.250000 0.140625 0.140625 0.0625000 0.0625000 0.250000 0.0625000 0.140625 0.140625 0.250000 0.250000 0.0625000 0.250000 0.140625 0.140625 0.0625000 0.0625000 0.250000 0.0625000 0.140625 0.140625 0.250000 0.250000 0.0625000 0.250000 0.140625 0.140625 0.250000 0.250000 0.562500 0.250000 0.390625 0.390625 0.562500 0.562500 0.250000 0.562500 0.390625 0.390625 0.250000 0.250000 0.562500 0.250000 0.390625 0.390625 0.562500 0.562500 0.250000 0.562500 0.390625 0.390625 0.250000 0.250000 0.562500 0.250000 0.390625 0.390625 0.562500 0.562500 0.250000 0.562500 0.390625 0.390625 0.250000 0.250000 0.562500 0.250000 0.390625 0.390625 0.562500 0.562500 0.250000 0.562500 0.390625 0.390625 0.562500 0.562500 1.00000 0.562500 0.765625 0.765625 1.00000 1.00000 0.562500 1.00000 0.765625 0.765625 0.562500 0.562500 1.00000 0.562500 0.765625 0.765625 1.00000 1.00000 0.562500 1.00000 0.765625 0.765625 0.562500 0.562500 1.00000 0.562500 0.765625 0.765625 1.00000 1.00000 0.562500 1.00000 0.765625 0.765625 0.562500 0.562500 1.00000 0.562500 0.765625 0.765625 1.00000 1.00000 0.562500 1.00000 0.765625 0.765625 +# vtk DataFile Version 3.0 +#This file was generated +ASCII +DATASET UNSTRUCTURED_GRID + +POINTS 96 double +0.00000 0.00000 0 +0.250000 0.00000 0 +0.00000 0.250000 0 +0.250000 0.250000 0 +0.00000 0.250000 0 +0.250000 0.00000 0 +0.250000 0.00000 0 +0.500000 0.00000 0 +0.250000 0.250000 0 +0.500000 0.250000 0 +0.250000 0.250000 0 +0.500000 0.00000 0 +0.500000 0.00000 0 +0.750000 0.00000 0 +0.500000 0.250000 0 +0.750000 0.250000 0 +0.500000 0.250000 0 +0.750000 0.00000 0 +0.750000 0.00000 0 +1.00000 0.00000 0 +0.750000 0.250000 0 +1.00000 0.250000 0 +0.750000 0.250000 0 +1.00000 0.00000 0 +0.00000 0.250000 0 +0.250000 0.250000 0 +0.00000 0.500000 0 +0.250000 0.500000 0 +0.00000 0.500000 0 +0.250000 0.250000 0 +0.250000 0.250000 0 +0.500000 0.250000 0 +0.250000 0.500000 0 +0.500000 0.500000 0 +0.250000 0.500000 0 +0.500000 0.250000 0 +0.500000 0.250000 0 +0.750000 0.250000 0 +0.500000 0.500000 0 +0.750000 0.500000 0 +0.500000 0.500000 0 +0.750000 0.250000 0 +0.750000 0.250000 0 +1.00000 0.250000 0 +0.750000 0.500000 0 +1.00000 0.500000 0 +0.750000 0.500000 0 +1.00000 0.250000 0 +0.00000 0.500000 0 +0.250000 0.500000 0 +0.00000 0.750000 0 +0.250000 0.750000 0 +0.00000 0.750000 0 +0.250000 0.500000 0 +0.250000 0.500000 0 +0.500000 0.500000 0 +0.250000 0.750000 0 +0.500000 0.750000 0 +0.250000 0.750000 0 +0.500000 0.500000 0 +0.500000 0.500000 0 +0.750000 0.500000 0 +0.500000 0.750000 0 +0.750000 0.750000 0 +0.500000 0.750000 0 +0.750000 0.500000 0 +0.750000 0.500000 0 +1.00000 0.500000 0 +0.750000 0.750000 0 +1.00000 0.750000 0 +0.750000 0.750000 0 +1.00000 0.500000 0 +0.00000 0.750000 0 +0.250000 0.750000 0 +0.00000 1.00000 0 +0.250000 1.00000 0 +0.00000 1.00000 0 +0.250000 0.750000 0 +0.250000 0.750000 0 +0.500000 0.750000 0 +0.250000 1.00000 0 +0.500000 1.00000 0 +0.250000 1.00000 0 +0.500000 0.750000 0 +0.500000 0.750000 0 +0.750000 0.750000 0 +0.500000 1.00000 0 +0.750000 1.00000 0 +0.500000 1.00000 0 +0.750000 0.750000 0 +0.750000 0.750000 0 +1.00000 0.750000 0 +0.750000 1.00000 0 +1.00000 1.00000 0 +0.750000 1.00000 0 +1.00000 0.750000 0 + +CELLS 32 128 + 3 0 1 2 + 3 3 4 5 + 3 6 7 8 + 3 9 10 11 + 3 12 13 14 + 3 15 16 17 + 3 18 19 20 + 3 21 22 23 + 3 24 25 26 + 3 27 28 29 + 3 30 31 32 + 3 33 34 35 + 3 36 37 38 + 3 39 40 41 + 3 42 43 44 + 3 45 46 47 + 3 48 49 50 + 3 51 52 53 + 3 54 55 56 + 3 57 58 59 + 3 60 61 62 + 3 63 64 65 + 3 66 67 68 + 3 69 70 71 + 3 72 73 74 + 3 75 76 77 + 3 78 79 80 + 3 81 82 83 + 3 84 85 86 + 3 87 88 89 + 3 90 91 92 + 3 93 94 95 + +CELL_TYPES 32 + 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 +POINT_DATA 96 +SCALARS solution_0 double 1 +LOOKUP_TABLE default +0.00000 0.0625000 0.00000 0.0625000 0.00000 0.0625000 0.0625000 0.250000 0.0625000 0.250000 0.0625000 0.250000 0.250000 0.562500 0.250000 0.562500 0.250000 0.562500 0.562500 1.00000 0.562500 1.00000 0.562500 1.00000 0.00000 0.0625000 0.00000 0.0625000 0.00000 0.0625000 0.0625000 0.250000 0.0625000 0.250000 0.0625000 0.250000 0.250000 0.562500 0.250000 0.562500 0.250000 0.562500 0.562500 1.00000 0.562500 1.00000 0.562500 1.00000 0.00000 0.0625000 0.00000 0.0625000 0.00000 0.0625000 0.0625000 0.250000 0.0625000 0.250000 0.0625000 0.250000 0.250000 0.562500 0.250000 0.562500 0.250000 0.562500 0.562500 1.00000 0.562500 1.00000 0.562500 1.00000 0.00000 0.0625000 0.00000 0.0625000 0.00000 0.0625000 0.0625000 0.250000 0.0625000 0.250000 0.0625000 0.250000 0.250000 0.562500 0.250000 0.562500 0.250000 0.562500 0.562500 1.00000 0.562500 1.00000 0.562500 1.00000 +SCALARS solution_1 double 1 +LOOKUP_TABLE default +0.00000 0.00000 0.0625000 0.0625000 0.0625000 0.00000 0.00000 0.00000 0.0625000 0.0625000 0.0625000 0.00000 0.00000 0.00000 0.0625000 0.0625000 0.0625000 0.00000 0.00000 0.00000 0.0625000 0.0625000 0.0625000 0.00000 0.0625000 0.0625000 0.250000 0.250000 0.250000 0.0625000 0.0625000 0.0625000 0.250000 0.250000 0.250000 0.0625000 0.0625000 0.0625000 0.250000 0.250000 0.250000 0.0625000 0.0625000 0.0625000 0.250000 0.250000 0.250000 0.0625000 0.250000 0.250000 0.562500 0.562500 0.562500 0.250000 0.250000 0.250000 0.562500 0.562500 0.562500 0.250000 0.250000 0.250000 0.562500 0.562500 0.562500 0.250000 0.250000 0.250000 0.562500 0.562500 0.562500 0.250000 0.562500 0.562500 1.00000 1.00000 1.00000 0.562500 0.562500 0.562500 1.00000 1.00000 1.00000 0.562500 0.562500 0.562500 1.00000 1.00000 1.00000 0.562500 0.562500 0.562500 1.00000 1.00000 1.00000 0.562500 +SCALARS solution_2 double 1 +LOOKUP_TABLE default +0.00000 0.0625000 0.00000 0.0625000 0.00000 0.0625000 0.0625000 0.250000 0.0625000 0.250000 0.0625000 0.250000 0.250000 0.562500 0.250000 0.562500 0.250000 0.562500 0.562500 1.00000 0.562500 1.00000 0.562500 1.00000 0.00000 0.0625000 0.00000 0.0625000 0.00000 0.0625000 0.0625000 0.250000 0.0625000 0.250000 0.0625000 0.250000 0.250000 0.562500 0.250000 0.562500 0.250000 0.562500 0.562500 1.00000 0.562500 1.00000 0.562500 1.00000 0.00000 0.0625000 0.00000 0.0625000 0.00000 0.0625000 0.0625000 0.250000 0.0625000 0.250000 0.0625000 0.250000 0.250000 0.562500 0.250000 0.562500 0.250000 0.562500 0.562500 1.00000 0.562500 1.00000 0.562500 1.00000 0.00000 0.0625000 0.00000 0.0625000 0.00000 0.0625000 0.0625000 0.250000 0.0625000 0.250000 0.0625000 0.250000 0.250000 0.562500 0.250000 0.562500 0.250000 0.562500 0.562500 1.00000 0.562500 1.00000 0.562500 1.00000 +# vtk DataFile Version 3.0 +#This file was generated +ASCII +DATASET UNSTRUCTURED_GRID + +POINTS 192 double +0.00000 0.00000 0 +0.250000 0.00000 0 +0.00000 0.250000 0 +0.125000 0.00000 0 +0.125000 0.125000 0 +0.00000 0.125000 0 +0.250000 0.250000 0 +0.00000 0.250000 0 +0.250000 0.00000 0 +0.125000 0.250000 0 +0.125000 0.125000 0 +0.250000 0.125000 0 +0.250000 0.00000 0 +0.500000 0.00000 0 +0.250000 0.250000 0 +0.375000 0.00000 0 +0.375000 0.125000 0 +0.250000 0.125000 0 +0.500000 0.250000 0 +0.250000 0.250000 0 +0.500000 0.00000 0 +0.375000 0.250000 0 +0.375000 0.125000 0 +0.500000 0.125000 0 +0.500000 0.00000 0 +0.750000 0.00000 0 +0.500000 0.250000 0 +0.625000 0.00000 0 +0.625000 0.125000 0 +0.500000 0.125000 0 +0.750000 0.250000 0 +0.500000 0.250000 0 +0.750000 0.00000 0 +0.625000 0.250000 0 +0.625000 0.125000 0 +0.750000 0.125000 0 +0.750000 0.00000 0 +1.00000 0.00000 0 +0.750000 0.250000 0 +0.875000 0.00000 0 +0.875000 0.125000 0 +0.750000 0.125000 0 +1.00000 0.250000 0 +0.750000 0.250000 0 +1.00000 0.00000 0 +0.875000 0.250000 0 +0.875000 0.125000 0 +1.00000 0.125000 0 +0.00000 0.250000 0 +0.250000 0.250000 0 +0.00000 0.500000 0 +0.125000 0.250000 0 +0.125000 0.375000 0 +0.00000 0.375000 0 +0.250000 0.500000 0 +0.00000 0.500000 0 +0.250000 0.250000 0 +0.125000 0.500000 0 +0.125000 0.375000 0 +0.250000 0.375000 0 +0.250000 0.250000 0 +0.500000 0.250000 0 +0.250000 0.500000 0 +0.375000 0.250000 0 +0.375000 0.375000 0 +0.250000 0.375000 0 +0.500000 0.500000 0 +0.250000 0.500000 0 +0.500000 0.250000 0 +0.375000 0.500000 0 +0.375000 0.375000 0 +0.500000 0.375000 0 +0.500000 0.250000 0 +0.750000 0.250000 0 +0.500000 0.500000 0 +0.625000 0.250000 0 +0.625000 0.375000 0 +0.500000 0.375000 0 +0.750000 0.500000 0 +0.500000 0.500000 0 +0.750000 0.250000 0 +0.625000 0.500000 0 +0.625000 0.375000 0 +0.750000 0.375000 0 +0.750000 0.250000 0 +1.00000 0.250000 0 +0.750000 0.500000 0 +0.875000 0.250000 0 +0.875000 0.375000 0 +0.750000 0.375000 0 +1.00000 0.500000 0 +0.750000 0.500000 0 +1.00000 0.250000 0 +0.875000 0.500000 0 +0.875000 0.375000 0 +1.00000 0.375000 0 +0.00000 0.500000 0 +0.250000 0.500000 0 +0.00000 0.750000 0 +0.125000 0.500000 0 +0.125000 0.625000 0 +0.00000 0.625000 0 +0.250000 0.750000 0 +0.00000 0.750000 0 +0.250000 0.500000 0 +0.125000 0.750000 0 +0.125000 0.625000 0 +0.250000 0.625000 0 +0.250000 0.500000 0 +0.500000 0.500000 0 +0.250000 0.750000 0 +0.375000 0.500000 0 +0.375000 0.625000 0 +0.250000 0.625000 0 +0.500000 0.750000 0 +0.250000 0.750000 0 +0.500000 0.500000 0 +0.375000 0.750000 0 +0.375000 0.625000 0 +0.500000 0.625000 0 +0.500000 0.500000 0 +0.750000 0.500000 0 +0.500000 0.750000 0 +0.625000 0.500000 0 +0.625000 0.625000 0 +0.500000 0.625000 0 +0.750000 0.750000 0 +0.500000 0.750000 0 +0.750000 0.500000 0 +0.625000 0.750000 0 +0.625000 0.625000 0 +0.750000 0.625000 0 +0.750000 0.500000 0 +1.00000 0.500000 0 +0.750000 0.750000 0 +0.875000 0.500000 0 +0.875000 0.625000 0 +0.750000 0.625000 0 +1.00000 0.750000 0 +0.750000 0.750000 0 +1.00000 0.500000 0 +0.875000 0.750000 0 +0.875000 0.625000 0 +1.00000 0.625000 0 +0.00000 0.750000 0 +0.250000 0.750000 0 +0.00000 1.00000 0 +0.125000 0.750000 0 +0.125000 0.875000 0 +0.00000 0.875000 0 +0.250000 1.00000 0 +0.00000 1.00000 0 +0.250000 0.750000 0 +0.125000 1.00000 0 +0.125000 0.875000 0 +0.250000 0.875000 0 +0.250000 0.750000 0 +0.500000 0.750000 0 +0.250000 1.00000 0 +0.375000 0.750000 0 +0.375000 0.875000 0 +0.250000 0.875000 0 +0.500000 1.00000 0 +0.250000 1.00000 0 +0.500000 0.750000 0 +0.375000 1.00000 0 +0.375000 0.875000 0 +0.500000 0.875000 0 +0.500000 0.750000 0 +0.750000 0.750000 0 +0.500000 1.00000 0 +0.625000 0.750000 0 +0.625000 0.875000 0 +0.500000 0.875000 0 +0.750000 1.00000 0 +0.500000 1.00000 0 +0.750000 0.750000 0 +0.625000 1.00000 0 +0.625000 0.875000 0 +0.750000 0.875000 0 +0.750000 0.750000 0 +1.00000 0.750000 0 +0.750000 1.00000 0 +0.875000 0.750000 0 +0.875000 0.875000 0 +0.750000 0.875000 0 +1.00000 1.00000 0 +0.750000 1.00000 0 +1.00000 0.750000 0 +0.875000 1.00000 0 +0.875000 0.875000 0 +1.00000 0.875000 0 + +CELLS 32 224 + 6 0 1 2 3 4 5 + 6 6 7 8 9 10 11 + 6 12 13 14 15 16 17 + 6 18 19 20 21 22 23 + 6 24 25 26 27 28 29 + 6 30 31 32 33 34 35 + 6 36 37 38 39 40 41 + 6 42 43 44 45 46 47 + 6 48 49 50 51 52 53 + 6 54 55 56 57 58 59 + 6 60 61 62 63 64 65 + 6 66 67 68 69 70 71 + 6 72 73 74 75 76 77 + 6 78 79 80 81 82 83 + 6 84 85 86 87 88 89 + 6 90 91 92 93 94 95 + 6 96 97 98 99 100 101 + 6 102 103 104 105 106 107 + 6 108 109 110 111 112 113 + 6 114 115 116 117 118 119 + 6 120 121 122 123 124 125 + 6 126 127 128 129 130 131 + 6 132 133 134 135 136 137 + 6 138 139 140 141 142 143 + 6 144 145 146 147 148 149 + 6 150 151 152 153 154 155 + 6 156 157 158 159 160 161 + 6 162 163 164 165 166 167 + 6 168 169 170 171 172 173 + 6 174 175 176 177 178 179 + 6 180 181 182 183 184 185 + 6 186 187 188 189 190 191 + +CELL_TYPES 32 + 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 22 +POINT_DATA 192 +SCALARS solution_0 double 1 +LOOKUP_TABLE default +0.00000 0.0625000 0.00000 0.0156250 0.0156250 0.00000 0.0625000 0.00000 0.0625000 0.0156250 0.0156250 0.0625000 0.0625000 0.250000 0.0625000 0.140625 0.140625 0.0625000 0.250000 0.0625000 0.250000 0.140625 0.140625 0.250000 0.250000 0.562500 0.250000 0.390625 0.390625 0.250000 0.562500 0.250000 0.562500 0.390625 0.390625 0.562500 0.562500 1.00000 0.562500 0.765625 0.765625 0.562500 1.00000 0.562500 1.00000 0.765625 0.765625 1.00000 0.00000 0.0625000 0.00000 0.0156250 0.0156250 0.00000 0.0625000 0.00000 0.0625000 0.0156250 0.0156250 0.0625000 0.0625000 0.250000 0.0625000 0.140625 0.140625 0.0625000 0.250000 0.0625000 0.250000 0.140625 0.140625 0.250000 0.250000 0.562500 0.250000 0.390625 0.390625 0.250000 0.562500 0.250000 0.562500 0.390625 0.390625 0.562500 0.562500 1.00000 0.562500 0.765625 0.765625 0.562500 1.00000 0.562500 1.00000 0.765625 0.765625 1.00000 0.00000 0.0625000 0.00000 0.0156250 0.0156250 0.00000 0.0625000 0.00000 0.0625000 0.0156250 0.0156250 0.0625000 0.0625000 0.250000 0.0625000 0.140625 0.140625 0.0625000 0.250000 0.0625000 0.250000 0.140625 0.140625 0.250000 0.250000 0.562500 0.250000 0.390625 0.390625 0.250000 0.562500 0.250000 0.562500 0.390625 0.390625 0.562500 0.562500 1.00000 0.562500 0.765625 0.765625 0.562500 1.00000 0.562500 1.00000 0.765625 0.765625 1.00000 0.00000 0.0625000 0.00000 0.0156250 0.0156250 0.00000 0.0625000 0.00000 0.0625000 0.0156250 0.0156250 0.0625000 0.0625000 0.250000 0.0625000 0.140625 0.140625 0.0625000 0.250000 0.0625000 0.250000 0.140625 0.140625 0.250000 0.250000 0.562500 0.250000 0.390625 0.390625 0.250000 0.562500 0.250000 0.562500 0.390625 0.390625 0.562500 0.562500 1.00000 0.562500 0.765625 0.765625 0.562500 1.00000 0.562500 1.00000 0.765625 0.765625 1.00000 +SCALARS solution_1 double 1 +LOOKUP_TABLE default +0.00000 0.00000 0.0625000 0.00000 0.0156250 0.0156250 0.0625000 0.0625000 0.00000 0.0625000 0.0156250 0.0156250 0.00000 0.00000 0.0625000 0.00000 0.0156250 0.0156250 0.0625000 0.0625000 0.00000 0.0625000 0.0156250 0.0156250 0.00000 0.00000 0.0625000 0.00000 0.0156250 0.0156250 0.0625000 0.0625000 0.00000 0.0625000 0.0156250 0.0156250 0.00000 0.00000 0.0625000 0.00000 0.0156250 0.0156250 0.0625000 0.0625000 0.00000 0.0625000 0.0156250 0.0156250 0.0625000 0.0625000 0.250000 0.0625000 0.140625 0.140625 0.250000 0.250000 0.0625000 0.250000 0.140625 0.140625 0.0625000 0.0625000 0.250000 0.0625000 0.140625 0.140625 0.250000 0.250000 0.0625000 0.250000 0.140625 0.140625 0.0625000 0.0625000 0.250000 0.0625000 0.140625 0.140625 0.250000 0.250000 0.0625000 0.250000 0.140625 0.140625 0.0625000 0.0625000 0.250000 0.0625000 0.140625 0.140625 0.250000 0.250000 0.0625000 0.250000 0.140625 0.140625 0.250000 0.250000 0.562500 0.250000 0.390625 0.390625 0.562500 0.562500 0.250000 0.562500 0.390625 0.390625 0.250000 0.250000 0.562500 0.250000 0.390625 0.390625 0.562500 0.562500 0.250000 0.562500 0.390625 0.390625 0.250000 0.250000 0.562500 0.250000 0.390625 0.390625 0.562500 0.562500 0.250000 0.562500 0.390625 0.390625 0.250000 0.250000 0.562500 0.250000 0.390625 0.390625 0.562500 0.562500 0.250000 0.562500 0.390625 0.390625 0.562500 0.562500 1.00000 0.562500 0.765625 0.765625 1.00000 1.00000 0.562500 1.00000 0.765625 0.765625 0.562500 0.562500 1.00000 0.562500 0.765625 0.765625 1.00000 1.00000 0.562500 1.00000 0.765625 0.765625 0.562500 0.562500 1.00000 0.562500 0.765625 0.765625 1.00000 1.00000 0.562500 1.00000 0.765625 0.765625 0.562500 0.562500 1.00000 0.562500 0.765625 0.765625 1.00000 1.00000 0.562500 1.00000 0.765625 0.765625 +SCALARS solution_2 double 1 +LOOKUP_TABLE default +0.00000 0.0625000 0.00000 0.0312500 0.0312500 0.00000 0.0625000 0.00000 0.0625000 0.0312500 0.0312500 0.0625000 0.0625000 0.250000 0.0625000 0.156250 0.156250 0.0625000 0.250000 0.0625000 0.250000 0.156250 0.156250 0.250000 0.250000 0.562500 0.250000 0.406250 0.406250 0.250000 0.562500 0.250000 0.562500 0.406250 0.406250 0.562500 0.562500 1.00000 0.562500 0.781250 0.781250 0.562500 1.00000 0.562500 1.00000 0.781250 0.781250 1.00000 0.00000 0.0625000 0.00000 0.0312500 0.0312500 0.00000 0.0625000 0.00000 0.0625000 0.0312500 0.0312500 0.0625000 0.0625000 0.250000 0.0625000 0.156250 0.156250 0.0625000 0.250000 0.0625000 0.250000 0.156250 0.156250 0.250000 0.250000 0.562500 0.250000 0.406250 0.406250 0.250000 0.562500 0.250000 0.562500 0.406250 0.406250 0.562500 0.562500 1.00000 0.562500 0.781250 0.781250 0.562500 1.00000 0.562500 1.00000 0.781250 0.781250 1.00000 0.00000 0.0625000 0.00000 0.0312500 0.0312500 0.00000 0.0625000 0.00000 0.0625000 0.0312500 0.0312500 0.0625000 0.0625000 0.250000 0.0625000 0.156250 0.156250 0.0625000 0.250000 0.0625000 0.250000 0.156250 0.156250 0.250000 0.250000 0.562500 0.250000 0.406250 0.406250 0.250000 0.562500 0.250000 0.562500 0.406250 0.406250 0.562500 0.562500 1.00000 0.562500 0.781250 0.781250 0.562500 1.00000 0.562500 1.00000 0.781250 0.781250 1.00000 0.00000 0.0625000 0.00000 0.0312500 0.0312500 0.00000 0.0625000 0.00000 0.0625000 0.0312500 0.0312500 0.0625000 0.0625000 0.250000 0.0625000 0.156250 0.156250 0.0625000 0.250000 0.0625000 0.250000 0.156250 0.156250 0.250000 0.250000 0.562500 0.250000 0.406250 0.406250 0.250000 0.562500 0.250000 0.562500 0.406250 0.406250 0.562500 0.562500 1.00000 0.562500 0.781250 0.781250 0.562500 1.00000 0.562500 1.00000 0.781250 0.781250 1.00000 +# vtk DataFile Version 3.0 +#This file was generated +ASCII +DATASET UNSTRUCTURED_GRID + +POINTS 160 double +0.00000 0.00000 0.00000 +0.500000 0.00000 0.00000 +0.00000 0.500000 0.00000 +0.00000 0.00000 0.500000 +0.00000 0.500000 0.00000 +0.500000 0.00000 0.00000 +0.500000 0.500000 0.00000 +0.500000 0.500000 0.500000 +0.500000 0.00000 0.00000 +0.00000 0.00000 0.500000 +0.500000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.00000 0.500000 0.00000 +0.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.00000 0.500000 0.500000 +0.500000 0.00000 0.00000 +0.00000 0.500000 0.00000 +0.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.500000 0.00000 0.00000 +1.00000 0.00000 0.00000 +1.00000 0.500000 0.00000 +1.00000 0.00000 0.500000 +0.500000 0.00000 0.00000 +1.00000 0.500000 0.00000 +0.500000 0.500000 0.00000 +0.500000 0.500000 0.500000 +0.500000 0.00000 0.00000 +0.500000 0.00000 0.500000 +1.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +1.00000 0.500000 0.00000 +1.00000 0.00000 0.500000 +1.00000 0.500000 0.500000 +0.500000 0.500000 0.500000 +0.500000 0.00000 0.00000 +1.00000 0.500000 0.00000 +0.500000 0.500000 0.500000 +1.00000 0.00000 0.500000 +0.00000 0.500000 0.00000 +0.500000 0.500000 0.00000 +0.500000 1.00000 0.00000 +0.500000 0.500000 0.500000 +0.00000 0.500000 0.00000 +0.500000 1.00000 0.00000 +0.00000 1.00000 0.00000 +0.00000 1.00000 0.500000 +0.00000 0.500000 0.00000 +0.00000 0.500000 0.500000 +0.500000 0.500000 0.500000 +0.00000 1.00000 0.500000 +0.500000 1.00000 0.00000 +0.500000 0.500000 0.500000 +0.500000 1.00000 0.500000 +0.00000 1.00000 0.500000 +0.00000 0.500000 0.00000 +0.500000 1.00000 0.00000 +0.00000 1.00000 0.500000 +0.500000 0.500000 0.500000 +0.500000 0.500000 0.00000 +1.00000 0.500000 0.00000 +0.500000 1.00000 0.00000 +0.500000 0.500000 0.500000 +0.500000 1.00000 0.00000 +1.00000 0.500000 0.00000 +1.00000 1.00000 0.00000 +1.00000 1.00000 0.500000 +1.00000 0.500000 0.00000 +0.500000 0.500000 0.500000 +1.00000 0.500000 0.500000 +1.00000 1.00000 0.500000 +0.500000 1.00000 0.00000 +0.500000 0.500000 0.500000 +1.00000 1.00000 0.500000 +0.500000 1.00000 0.500000 +1.00000 0.500000 0.00000 +0.500000 1.00000 0.00000 +0.500000 0.500000 0.500000 +1.00000 1.00000 0.500000 +0.00000 0.00000 0.500000 +0.500000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.500000 0.00000 1.00000 +0.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.00000 0.500000 0.500000 +0.00000 0.500000 1.00000 +0.00000 0.00000 0.500000 +0.00000 0.00000 1.00000 +0.500000 0.00000 1.00000 +0.00000 0.500000 1.00000 +0.500000 0.500000 0.500000 +0.500000 0.00000 1.00000 +0.500000 0.500000 1.00000 +0.00000 0.500000 1.00000 +0.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.00000 0.500000 1.00000 +0.500000 0.00000 1.00000 +0.500000 0.00000 0.500000 +1.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.500000 0.00000 1.00000 +0.500000 0.500000 0.500000 +1.00000 0.00000 0.500000 +1.00000 0.500000 0.500000 +1.00000 0.500000 1.00000 +1.00000 0.00000 0.500000 +0.500000 0.00000 1.00000 +1.00000 0.00000 1.00000 +1.00000 0.500000 1.00000 +0.500000 0.500000 0.500000 +0.500000 0.00000 1.00000 +1.00000 0.500000 1.00000 +0.500000 0.500000 1.00000 +1.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.500000 0.00000 1.00000 +1.00000 0.500000 1.00000 +0.00000 0.500000 0.500000 +0.500000 0.500000 0.500000 +0.00000 1.00000 0.500000 +0.00000 0.500000 1.00000 +0.00000 1.00000 0.500000 +0.500000 0.500000 0.500000 +0.500000 1.00000 0.500000 +0.500000 1.00000 1.00000 +0.500000 0.500000 0.500000 +0.00000 0.500000 1.00000 +0.500000 0.500000 1.00000 +0.500000 1.00000 1.00000 +0.00000 1.00000 0.500000 +0.00000 0.500000 1.00000 +0.500000 1.00000 1.00000 +0.00000 1.00000 1.00000 +0.500000 0.500000 0.500000 +0.00000 1.00000 0.500000 +0.00000 0.500000 1.00000 +0.500000 1.00000 1.00000 +0.500000 0.500000 0.500000 +1.00000 0.500000 0.500000 +1.00000 1.00000 0.500000 +1.00000 0.500000 1.00000 +0.500000 0.500000 0.500000 +1.00000 1.00000 0.500000 +0.500000 1.00000 0.500000 +0.500000 1.00000 1.00000 +0.500000 0.500000 0.500000 +0.500000 0.500000 1.00000 +1.00000 0.500000 1.00000 +0.500000 1.00000 1.00000 +1.00000 1.00000 0.500000 +1.00000 0.500000 1.00000 +1.00000 1.00000 1.00000 +0.500000 1.00000 1.00000 +0.500000 0.500000 0.500000 +1.00000 1.00000 0.500000 +0.500000 1.00000 1.00000 +1.00000 0.500000 1.00000 + +CELLS 40 200 + 4 0 1 2 3 + 4 4 5 6 7 + 4 8 9 10 11 + 4 12 13 14 15 + 4 16 17 18 19 + 4 20 21 22 23 + 4 24 25 26 27 + 4 28 29 30 31 + 4 32 33 34 35 + 4 36 37 38 39 + 4 40 41 42 43 + 4 44 45 46 47 + 4 48 49 50 51 + 4 52 53 54 55 + 4 56 57 58 59 + 4 60 61 62 63 + 4 64 65 66 67 + 4 68 69 70 71 + 4 72 73 74 75 + 4 76 77 78 79 + 4 80 81 82 83 + 4 84 85 86 87 + 4 88 89 90 91 + 4 92 93 94 95 + 4 96 97 98 99 + 4 100 101 102 103 + 4 104 105 106 107 + 4 108 109 110 111 + 4 112 113 114 115 + 4 116 117 118 119 + 4 120 121 122 123 + 4 124 125 126 127 + 4 128 129 130 131 + 4 132 133 134 135 + 4 136 137 138 139 + 4 140 141 142 143 + 4 144 145 146 147 + 4 148 149 150 151 + 4 152 153 154 155 + 4 156 157 158 159 + +CELL_TYPES 40 + 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 +POINT_DATA 160 +SCALARS solution double 1 +LOOKUP_TABLE default +0.00000 0.250000 0.00000 0.00000 0.00000 0.250000 0.250000 0.250000 0.250000 0.00000 0.250000 0.250000 0.00000 0.00000 0.250000 0.00000 0.250000 0.00000 0.00000 0.250000 0.250000 1.00000 1.00000 1.00000 0.250000 1.00000 0.250000 0.250000 0.250000 0.250000 1.00000 0.250000 1.00000 1.00000 1.00000 0.250000 0.250000 1.00000 0.250000 1.00000 0.00000 0.250000 0.250000 0.250000 0.00000 0.250000 0.00000 0.00000 0.00000 0.00000 0.250000 0.00000 0.250000 0.250000 0.250000 0.00000 0.00000 0.250000 0.00000 0.250000 0.250000 1.00000 0.250000 0.250000 0.250000 1.00000 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 0.250000 0.250000 1.00000 0.250000 1.00000 0.250000 0.250000 1.00000 0.00000 0.250000 0.250000 0.250000 0.00000 0.250000 0.00000 0.00000 0.00000 0.00000 0.250000 0.00000 0.250000 0.250000 0.250000 0.00000 0.00000 0.250000 0.00000 0.250000 0.250000 1.00000 0.250000 0.250000 0.250000 1.00000 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 0.250000 0.250000 1.00000 0.250000 1.00000 0.250000 0.250000 1.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.250000 0.250000 0.250000 0.250000 0.00000 0.250000 0.250000 0.00000 0.00000 0.250000 0.00000 0.250000 0.00000 0.00000 0.250000 0.250000 1.00000 1.00000 1.00000 0.250000 1.00000 0.250000 0.250000 0.250000 0.250000 1.00000 0.250000 1.00000 1.00000 1.00000 0.250000 0.250000 1.00000 0.250000 1.00000 +# vtk DataFile Version 3.0 +#This file was generated +ASCII +DATASET UNSTRUCTURED_GRID + +POINTS 400 double +0.00000 0.00000 0.00000 +0.500000 0.00000 0.00000 +0.00000 0.500000 0.00000 +0.00000 0.00000 0.500000 +0.250000 0.00000 0.00000 +0.250000 0.250000 0.00000 +0.00000 0.250000 0.00000 +0.00000 0.00000 0.250000 +0.250000 0.00000 0.250000 +0.00000 0.250000 0.250000 +0.00000 0.500000 0.00000 +0.500000 0.00000 0.00000 +0.500000 0.500000 0.00000 +0.500000 0.500000 0.500000 +0.250000 0.250000 0.00000 +0.500000 0.250000 0.00000 +0.250000 0.500000 0.00000 +0.250000 0.500000 0.250000 +0.500000 0.250000 0.250000 +0.500000 0.500000 0.250000 +0.500000 0.00000 0.00000 +0.00000 0.00000 0.500000 +0.500000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.250000 0.00000 0.250000 +0.250000 0.00000 0.500000 +0.500000 0.00000 0.250000 +0.500000 0.250000 0.250000 +0.250000 0.250000 0.500000 +0.500000 0.250000 0.500000 +0.00000 0.500000 0.00000 +0.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.00000 0.500000 0.500000 +0.00000 0.250000 0.250000 +0.250000 0.250000 0.500000 +0.250000 0.500000 0.250000 +0.00000 0.500000 0.250000 +0.00000 0.250000 0.500000 +0.250000 0.500000 0.500000 +0.500000 0.00000 0.00000 +0.00000 0.500000 0.00000 +0.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.250000 0.250000 0.00000 +0.00000 0.250000 0.250000 +0.250000 0.00000 0.250000 +0.500000 0.250000 0.250000 +0.250000 0.500000 0.250000 +0.250000 0.250000 0.500000 +0.500000 0.00000 0.00000 +1.00000 0.00000 0.00000 +1.00000 0.500000 0.00000 +1.00000 0.00000 0.500000 +0.750000 0.00000 0.00000 +1.00000 0.250000 0.00000 +0.750000 0.250000 0.00000 +0.750000 0.00000 0.250000 +1.00000 0.00000 0.250000 +1.00000 0.250000 0.250000 +0.500000 0.00000 0.00000 +1.00000 0.500000 0.00000 +0.500000 0.500000 0.00000 +0.500000 0.500000 0.500000 +0.750000 0.250000 0.00000 +0.750000 0.500000 0.00000 +0.500000 0.250000 0.00000 +0.500000 0.250000 0.250000 +0.750000 0.500000 0.250000 +0.500000 0.500000 0.250000 +0.500000 0.00000 0.00000 +0.500000 0.00000 0.500000 +1.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.500000 0.00000 0.250000 +0.750000 0.00000 0.500000 +0.750000 0.00000 0.250000 +0.500000 0.250000 0.250000 +0.500000 0.250000 0.500000 +0.750000 0.250000 0.500000 +1.00000 0.500000 0.00000 +1.00000 0.00000 0.500000 +1.00000 0.500000 0.500000 +0.500000 0.500000 0.500000 +1.00000 0.250000 0.250000 +1.00000 0.250000 0.500000 +1.00000 0.500000 0.250000 +0.750000 0.500000 0.250000 +0.750000 0.250000 0.500000 +0.750000 0.500000 0.500000 +0.500000 0.00000 0.00000 +1.00000 0.500000 0.00000 +0.500000 0.500000 0.500000 +1.00000 0.00000 0.500000 +0.750000 0.250000 0.00000 +0.750000 0.500000 0.250000 +0.500000 0.250000 0.250000 +0.750000 0.00000 0.250000 +1.00000 0.250000 0.250000 +0.750000 0.250000 0.500000 +0.00000 0.500000 0.00000 +0.500000 0.500000 0.00000 +0.500000 1.00000 0.00000 +0.500000 0.500000 0.500000 +0.250000 0.500000 0.00000 +0.500000 0.750000 0.00000 +0.250000 0.750000 0.00000 +0.250000 0.500000 0.250000 +0.500000 0.500000 0.250000 +0.500000 0.750000 0.250000 +0.00000 0.500000 0.00000 +0.500000 1.00000 0.00000 +0.00000 1.00000 0.00000 +0.00000 1.00000 0.500000 +0.250000 0.750000 0.00000 +0.250000 1.00000 0.00000 +0.00000 0.750000 0.00000 +0.00000 0.750000 0.250000 +0.250000 1.00000 0.250000 +0.00000 1.00000 0.250000 +0.00000 0.500000 0.00000 +0.00000 0.500000 0.500000 +0.500000 0.500000 0.500000 +0.00000 1.00000 0.500000 +0.00000 0.500000 0.250000 +0.250000 0.500000 0.500000 +0.250000 0.500000 0.250000 +0.00000 0.750000 0.250000 +0.00000 0.750000 0.500000 +0.250000 0.750000 0.500000 +0.500000 1.00000 0.00000 +0.500000 0.500000 0.500000 +0.500000 1.00000 0.500000 +0.00000 1.00000 0.500000 +0.500000 0.750000 0.250000 +0.500000 0.750000 0.500000 +0.500000 1.00000 0.250000 +0.250000 1.00000 0.250000 +0.250000 0.750000 0.500000 +0.250000 1.00000 0.500000 +0.00000 0.500000 0.00000 +0.500000 1.00000 0.00000 +0.00000 1.00000 0.500000 +0.500000 0.500000 0.500000 +0.250000 0.750000 0.00000 +0.250000 1.00000 0.250000 +0.00000 0.750000 0.250000 +0.250000 0.500000 0.250000 +0.500000 0.750000 0.250000 +0.250000 0.750000 0.500000 +0.500000 0.500000 0.00000 +1.00000 0.500000 0.00000 +0.500000 1.00000 0.00000 +0.500000 0.500000 0.500000 +0.750000 0.500000 0.00000 +0.750000 0.750000 0.00000 +0.500000 0.750000 0.00000 +0.500000 0.500000 0.250000 +0.750000 0.500000 0.250000 +0.500000 0.750000 0.250000 +0.500000 1.00000 0.00000 +1.00000 0.500000 0.00000 +1.00000 1.00000 0.00000 +1.00000 1.00000 0.500000 +0.750000 0.750000 0.00000 +1.00000 0.750000 0.00000 +0.750000 1.00000 0.00000 +0.750000 1.00000 0.250000 +1.00000 0.750000 0.250000 +1.00000 1.00000 0.250000 +1.00000 0.500000 0.00000 +0.500000 0.500000 0.500000 +1.00000 0.500000 0.500000 +1.00000 1.00000 0.500000 +0.750000 0.500000 0.250000 +0.750000 0.500000 0.500000 +1.00000 0.500000 0.250000 +1.00000 0.750000 0.250000 +0.750000 0.750000 0.500000 +1.00000 0.750000 0.500000 +0.500000 1.00000 0.00000 +0.500000 0.500000 0.500000 +1.00000 1.00000 0.500000 +0.500000 1.00000 0.500000 +0.500000 0.750000 0.250000 +0.750000 0.750000 0.500000 +0.750000 1.00000 0.250000 +0.500000 1.00000 0.250000 +0.500000 0.750000 0.500000 +0.750000 1.00000 0.500000 +1.00000 0.500000 0.00000 +0.500000 1.00000 0.00000 +0.500000 0.500000 0.500000 +1.00000 1.00000 0.500000 +0.750000 0.750000 0.00000 +0.500000 0.750000 0.250000 +0.750000 0.500000 0.250000 +1.00000 0.750000 0.250000 +0.750000 1.00000 0.250000 +0.750000 0.750000 0.500000 +0.00000 0.00000 0.500000 +0.500000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.500000 0.00000 1.00000 +0.250000 0.00000 0.500000 +0.500000 0.250000 0.500000 +0.250000 0.250000 0.500000 +0.250000 0.00000 0.750000 +0.500000 0.00000 0.750000 +0.500000 0.250000 0.750000 +0.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.00000 0.500000 0.500000 +0.00000 0.500000 1.00000 +0.250000 0.250000 0.500000 +0.250000 0.500000 0.500000 +0.00000 0.250000 0.500000 +0.00000 0.250000 0.750000 +0.250000 0.500000 0.750000 +0.00000 0.500000 0.750000 +0.00000 0.00000 0.500000 +0.00000 0.00000 1.00000 +0.500000 0.00000 1.00000 +0.00000 0.500000 1.00000 +0.00000 0.00000 0.750000 +0.250000 0.00000 1.00000 +0.250000 0.00000 0.750000 +0.00000 0.250000 0.750000 +0.00000 0.250000 1.00000 +0.250000 0.250000 1.00000 +0.500000 0.500000 0.500000 +0.500000 0.00000 1.00000 +0.500000 0.500000 1.00000 +0.00000 0.500000 1.00000 +0.500000 0.250000 0.750000 +0.500000 0.250000 1.00000 +0.500000 0.500000 0.750000 +0.250000 0.500000 0.750000 +0.250000 0.250000 1.00000 +0.250000 0.500000 1.00000 +0.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.00000 0.500000 1.00000 +0.500000 0.00000 1.00000 +0.250000 0.250000 0.500000 +0.250000 0.500000 0.750000 +0.00000 0.250000 0.750000 +0.250000 0.00000 0.750000 +0.500000 0.250000 0.750000 +0.250000 0.250000 1.00000 +0.500000 0.00000 0.500000 +1.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.500000 0.00000 1.00000 +0.750000 0.00000 0.500000 +0.750000 0.250000 0.500000 +0.500000 0.250000 0.500000 +0.500000 0.00000 0.750000 +0.750000 0.00000 0.750000 +0.500000 0.250000 0.750000 +0.500000 0.500000 0.500000 +1.00000 0.00000 0.500000 +1.00000 0.500000 0.500000 +1.00000 0.500000 1.00000 +0.750000 0.250000 0.500000 +1.00000 0.250000 0.500000 +0.750000 0.500000 0.500000 +0.750000 0.500000 0.750000 +1.00000 0.250000 0.750000 +1.00000 0.500000 0.750000 +1.00000 0.00000 0.500000 +0.500000 0.00000 1.00000 +1.00000 0.00000 1.00000 +1.00000 0.500000 1.00000 +0.750000 0.00000 0.750000 +0.750000 0.00000 1.00000 +1.00000 0.00000 0.750000 +1.00000 0.250000 0.750000 +0.750000 0.250000 1.00000 +1.00000 0.250000 1.00000 +0.500000 0.500000 0.500000 +0.500000 0.00000 1.00000 +1.00000 0.500000 1.00000 +0.500000 0.500000 1.00000 +0.500000 0.250000 0.750000 +0.750000 0.250000 1.00000 +0.750000 0.500000 0.750000 +0.500000 0.500000 0.750000 +0.500000 0.250000 1.00000 +0.750000 0.500000 1.00000 +1.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.500000 0.00000 1.00000 +1.00000 0.500000 1.00000 +0.750000 0.250000 0.500000 +0.500000 0.250000 0.750000 +0.750000 0.00000 0.750000 +1.00000 0.250000 0.750000 +0.750000 0.500000 0.750000 +0.750000 0.250000 1.00000 +0.00000 0.500000 0.500000 +0.500000 0.500000 0.500000 +0.00000 1.00000 0.500000 +0.00000 0.500000 1.00000 +0.250000 0.500000 0.500000 +0.250000 0.750000 0.500000 +0.00000 0.750000 0.500000 +0.00000 0.500000 0.750000 +0.250000 0.500000 0.750000 +0.00000 0.750000 0.750000 +0.00000 1.00000 0.500000 +0.500000 0.500000 0.500000 +0.500000 1.00000 0.500000 +0.500000 1.00000 1.00000 +0.250000 0.750000 0.500000 +0.500000 0.750000 0.500000 +0.250000 1.00000 0.500000 +0.250000 1.00000 0.750000 +0.500000 0.750000 0.750000 +0.500000 1.00000 0.750000 +0.500000 0.500000 0.500000 +0.00000 0.500000 1.00000 +0.500000 0.500000 1.00000 +0.500000 1.00000 1.00000 +0.250000 0.500000 0.750000 +0.250000 0.500000 1.00000 +0.500000 0.500000 0.750000 +0.500000 0.750000 0.750000 +0.250000 0.750000 1.00000 +0.500000 0.750000 1.00000 +0.00000 1.00000 0.500000 +0.00000 0.500000 1.00000 +0.500000 1.00000 1.00000 +0.00000 1.00000 1.00000 +0.00000 0.750000 0.750000 +0.250000 0.750000 1.00000 +0.250000 1.00000 0.750000 +0.00000 1.00000 0.750000 +0.00000 0.750000 1.00000 +0.250000 1.00000 1.00000 +0.500000 0.500000 0.500000 +0.00000 1.00000 0.500000 +0.00000 0.500000 1.00000 +0.500000 1.00000 1.00000 +0.250000 0.750000 0.500000 +0.00000 0.750000 0.750000 +0.250000 0.500000 0.750000 +0.500000 0.750000 0.750000 +0.250000 1.00000 0.750000 +0.250000 0.750000 1.00000 +0.500000 0.500000 0.500000 +1.00000 0.500000 0.500000 +1.00000 1.00000 0.500000 +1.00000 0.500000 1.00000 +0.750000 0.500000 0.500000 +1.00000 0.750000 0.500000 +0.750000 0.750000 0.500000 +0.750000 0.500000 0.750000 +1.00000 0.500000 0.750000 +1.00000 0.750000 0.750000 +0.500000 0.500000 0.500000 +1.00000 1.00000 0.500000 +0.500000 1.00000 0.500000 +0.500000 1.00000 1.00000 +0.750000 0.750000 0.500000 +0.750000 1.00000 0.500000 +0.500000 0.750000 0.500000 +0.500000 0.750000 0.750000 +0.750000 1.00000 0.750000 +0.500000 1.00000 0.750000 +0.500000 0.500000 0.500000 +0.500000 0.500000 1.00000 +1.00000 0.500000 1.00000 +0.500000 1.00000 1.00000 +0.500000 0.500000 0.750000 +0.750000 0.500000 1.00000 +0.750000 0.500000 0.750000 +0.500000 0.750000 0.750000 +0.500000 0.750000 1.00000 +0.750000 0.750000 1.00000 +1.00000 1.00000 0.500000 +1.00000 0.500000 1.00000 +1.00000 1.00000 1.00000 +0.500000 1.00000 1.00000 +1.00000 0.750000 0.750000 +1.00000 0.750000 1.00000 +1.00000 1.00000 0.750000 +0.750000 1.00000 0.750000 +0.750000 0.750000 1.00000 +0.750000 1.00000 1.00000 +0.500000 0.500000 0.500000 +1.00000 1.00000 0.500000 +0.500000 1.00000 1.00000 +1.00000 0.500000 1.00000 +0.750000 0.750000 0.500000 +0.750000 1.00000 0.750000 +0.500000 0.750000 0.750000 +0.750000 0.500000 0.750000 +1.00000 0.750000 0.750000 +0.750000 0.750000 1.00000 + +CELLS 40 440 + 10 0 1 2 3 4 5 6 7 8 9 + 10 10 11 12 13 14 15 16 17 18 19 + 10 20 21 22 23 24 25 26 27 28 29 + 10 30 31 32 33 34 35 36 37 38 39 + 10 40 41 42 43 44 45 46 47 48 49 + 10 50 51 52 53 54 55 56 57 58 59 + 10 60 61 62 63 64 65 66 67 68 69 + 10 70 71 72 73 74 75 76 77 78 79 + 10 80 81 82 83 84 85 86 87 88 89 + 10 90 91 92 93 94 95 96 97 98 99 + 10 100 101 102 103 104 105 106 107 108 109 + 10 110 111 112 113 114 115 116 117 118 119 + 10 120 121 122 123 124 125 126 127 128 129 + 10 130 131 132 133 134 135 136 137 138 139 + 10 140 141 142 143 144 145 146 147 148 149 + 10 150 151 152 153 154 155 156 157 158 159 + 10 160 161 162 163 164 165 166 167 168 169 + 10 170 171 172 173 174 175 176 177 178 179 + 10 180 181 182 183 184 185 186 187 188 189 + 10 190 191 192 193 194 195 196 197 198 199 + 10 200 201 202 203 204 205 206 207 208 209 + 10 210 211 212 213 214 215 216 217 218 219 + 10 220 221 222 223 224 225 226 227 228 229 + 10 230 231 232 233 234 235 236 237 238 239 + 10 240 241 242 243 244 245 246 247 248 249 + 10 250 251 252 253 254 255 256 257 258 259 + 10 260 261 262 263 264 265 266 267 268 269 + 10 270 271 272 273 274 275 276 277 278 279 + 10 280 281 282 283 284 285 286 287 288 289 + 10 290 291 292 293 294 295 296 297 298 299 + 10 300 301 302 303 304 305 306 307 308 309 + 10 310 311 312 313 314 315 316 317 318 319 + 10 320 321 322 323 324 325 326 327 328 329 + 10 330 331 332 333 334 335 336 337 338 339 + 10 340 341 342 343 344 345 346 347 348 349 + 10 350 351 352 353 354 355 356 357 358 359 + 10 360 361 362 363 364 365 366 367 368 369 + 10 370 371 372 373 374 375 376 377 378 379 + 10 380 381 382 383 384 385 386 387 388 389 + 10 390 391 392 393 394 395 396 397 398 399 + +CELL_TYPES 40 + 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 +POINT_DATA 400 +SCALARS solution double 1 +LOOKUP_TABLE default +0.00000 0.250000 0.00000 0.00000 0.0625000 0.0625000 0.00000 0.00000 0.0625000 0.00000 0.00000 0.250000 0.250000 0.250000 0.0625000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.250000 0.00000 0.250000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.0625000 0.250000 0.00000 0.00000 0.250000 0.00000 0.00000 0.0625000 0.0625000 0.00000 0.00000 0.0625000 0.250000 0.00000 0.00000 0.250000 0.0625000 0.00000 0.0625000 0.250000 0.0625000 0.0625000 0.250000 1.00000 1.00000 1.00000 0.562500 1.00000 0.562500 0.562500 1.00000 1.00000 0.250000 1.00000 0.250000 0.250000 0.562500 0.562500 0.250000 0.250000 0.562500 0.250000 0.250000 0.250000 1.00000 0.250000 0.250000 0.562500 0.562500 0.250000 0.250000 0.562500 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 1.00000 0.562500 0.562500 0.562500 0.250000 1.00000 0.250000 1.00000 0.562500 0.562500 0.250000 0.562500 1.00000 0.562500 0.00000 0.250000 0.250000 0.250000 0.0625000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.00000 0.250000 0.00000 0.00000 0.0625000 0.0625000 0.00000 0.00000 0.0625000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.0625000 0.0625000 0.00000 0.00000 0.0625000 0.250000 0.250000 0.250000 0.00000 0.250000 0.250000 0.250000 0.0625000 0.0625000 0.0625000 0.00000 0.250000 0.00000 0.250000 0.0625000 0.0625000 0.00000 0.0625000 0.250000 0.0625000 0.250000 1.00000 0.250000 0.250000 0.562500 0.562500 0.250000 0.250000 0.562500 0.250000 0.250000 1.00000 1.00000 1.00000 0.562500 1.00000 0.562500 0.562500 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 0.562500 0.562500 1.00000 1.00000 0.562500 1.00000 0.250000 0.250000 1.00000 0.250000 0.250000 0.562500 0.562500 0.250000 0.250000 0.562500 1.00000 0.250000 0.250000 1.00000 0.562500 0.250000 0.562500 1.00000 0.562500 0.562500 0.00000 0.250000 0.250000 0.250000 0.0625000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.00000 0.250000 0.00000 0.00000 0.0625000 0.0625000 0.00000 0.00000 0.0625000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.0625000 0.0625000 0.00000 0.00000 0.0625000 0.250000 0.250000 0.250000 0.00000 0.250000 0.250000 0.250000 0.0625000 0.0625000 0.0625000 0.00000 0.250000 0.00000 0.250000 0.0625000 0.0625000 0.00000 0.0625000 0.250000 0.0625000 0.250000 1.00000 0.250000 0.250000 0.562500 0.562500 0.250000 0.250000 0.562500 0.250000 0.250000 1.00000 1.00000 1.00000 0.562500 1.00000 0.562500 0.562500 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 0.562500 0.562500 1.00000 1.00000 0.562500 1.00000 0.250000 0.250000 1.00000 0.250000 0.250000 0.562500 0.562500 0.250000 0.250000 0.562500 1.00000 0.250000 0.250000 1.00000 0.562500 0.250000 0.562500 1.00000 0.562500 0.562500 0.00000 0.250000 0.00000 0.00000 0.0625000 0.0625000 0.00000 0.00000 0.0625000 0.00000 0.00000 0.250000 0.250000 0.250000 0.0625000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.250000 0.00000 0.250000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.0625000 0.250000 0.00000 0.00000 0.250000 0.00000 0.00000 0.0625000 0.0625000 0.00000 0.00000 0.0625000 0.250000 0.00000 0.00000 0.250000 0.0625000 0.00000 0.0625000 0.250000 0.0625000 0.0625000 0.250000 1.00000 1.00000 1.00000 0.562500 1.00000 0.562500 0.562500 1.00000 1.00000 0.250000 1.00000 0.250000 0.250000 0.562500 0.562500 0.250000 0.250000 0.562500 0.250000 0.250000 0.250000 1.00000 0.250000 0.250000 0.562500 0.562500 0.250000 0.250000 0.562500 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 1.00000 0.562500 0.562500 0.562500 0.250000 1.00000 0.250000 1.00000 0.562500 0.562500 0.250000 0.562500 1.00000 0.562500 +# vtk DataFile Version 3.0 +#This file was generated +ASCII +DATASET UNSTRUCTURED_GRID + +POINTS 160 double +0.00000 0.00000 0.00000 +0.500000 0.00000 0.00000 +0.00000 0.500000 0.00000 +0.00000 0.00000 0.500000 +0.00000 0.500000 0.00000 +0.500000 0.00000 0.00000 +0.500000 0.500000 0.00000 +0.500000 0.500000 0.500000 +0.500000 0.00000 0.00000 +0.00000 0.00000 0.500000 +0.500000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.00000 0.500000 0.00000 +0.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.00000 0.500000 0.500000 +0.500000 0.00000 0.00000 +0.00000 0.500000 0.00000 +0.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.500000 0.00000 0.00000 +1.00000 0.00000 0.00000 +1.00000 0.500000 0.00000 +1.00000 0.00000 0.500000 +0.500000 0.00000 0.00000 +1.00000 0.500000 0.00000 +0.500000 0.500000 0.00000 +0.500000 0.500000 0.500000 +0.500000 0.00000 0.00000 +0.500000 0.00000 0.500000 +1.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +1.00000 0.500000 0.00000 +1.00000 0.00000 0.500000 +1.00000 0.500000 0.500000 +0.500000 0.500000 0.500000 +0.500000 0.00000 0.00000 +1.00000 0.500000 0.00000 +0.500000 0.500000 0.500000 +1.00000 0.00000 0.500000 +0.00000 0.500000 0.00000 +0.500000 0.500000 0.00000 +0.500000 1.00000 0.00000 +0.500000 0.500000 0.500000 +0.00000 0.500000 0.00000 +0.500000 1.00000 0.00000 +0.00000 1.00000 0.00000 +0.00000 1.00000 0.500000 +0.00000 0.500000 0.00000 +0.00000 0.500000 0.500000 +0.500000 0.500000 0.500000 +0.00000 1.00000 0.500000 +0.500000 1.00000 0.00000 +0.500000 0.500000 0.500000 +0.500000 1.00000 0.500000 +0.00000 1.00000 0.500000 +0.00000 0.500000 0.00000 +0.500000 1.00000 0.00000 +0.00000 1.00000 0.500000 +0.500000 0.500000 0.500000 +0.500000 0.500000 0.00000 +1.00000 0.500000 0.00000 +0.500000 1.00000 0.00000 +0.500000 0.500000 0.500000 +0.500000 1.00000 0.00000 +1.00000 0.500000 0.00000 +1.00000 1.00000 0.00000 +1.00000 1.00000 0.500000 +1.00000 0.500000 0.00000 +0.500000 0.500000 0.500000 +1.00000 0.500000 0.500000 +1.00000 1.00000 0.500000 +0.500000 1.00000 0.00000 +0.500000 0.500000 0.500000 +1.00000 1.00000 0.500000 +0.500000 1.00000 0.500000 +1.00000 0.500000 0.00000 +0.500000 1.00000 0.00000 +0.500000 0.500000 0.500000 +1.00000 1.00000 0.500000 +0.00000 0.00000 0.500000 +0.500000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.500000 0.00000 1.00000 +0.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.00000 0.500000 0.500000 +0.00000 0.500000 1.00000 +0.00000 0.00000 0.500000 +0.00000 0.00000 1.00000 +0.500000 0.00000 1.00000 +0.00000 0.500000 1.00000 +0.500000 0.500000 0.500000 +0.500000 0.00000 1.00000 +0.500000 0.500000 1.00000 +0.00000 0.500000 1.00000 +0.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.00000 0.500000 1.00000 +0.500000 0.00000 1.00000 +0.500000 0.00000 0.500000 +1.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.500000 0.00000 1.00000 +0.500000 0.500000 0.500000 +1.00000 0.00000 0.500000 +1.00000 0.500000 0.500000 +1.00000 0.500000 1.00000 +1.00000 0.00000 0.500000 +0.500000 0.00000 1.00000 +1.00000 0.00000 1.00000 +1.00000 0.500000 1.00000 +0.500000 0.500000 0.500000 +0.500000 0.00000 1.00000 +1.00000 0.500000 1.00000 +0.500000 0.500000 1.00000 +1.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.500000 0.00000 1.00000 +1.00000 0.500000 1.00000 +0.00000 0.500000 0.500000 +0.500000 0.500000 0.500000 +0.00000 1.00000 0.500000 +0.00000 0.500000 1.00000 +0.00000 1.00000 0.500000 +0.500000 0.500000 0.500000 +0.500000 1.00000 0.500000 +0.500000 1.00000 1.00000 +0.500000 0.500000 0.500000 +0.00000 0.500000 1.00000 +0.500000 0.500000 1.00000 +0.500000 1.00000 1.00000 +0.00000 1.00000 0.500000 +0.00000 0.500000 1.00000 +0.500000 1.00000 1.00000 +0.00000 1.00000 1.00000 +0.500000 0.500000 0.500000 +0.00000 1.00000 0.500000 +0.00000 0.500000 1.00000 +0.500000 1.00000 1.00000 +0.500000 0.500000 0.500000 +1.00000 0.500000 0.500000 +1.00000 1.00000 0.500000 +1.00000 0.500000 1.00000 +0.500000 0.500000 0.500000 +1.00000 1.00000 0.500000 +0.500000 1.00000 0.500000 +0.500000 1.00000 1.00000 +0.500000 0.500000 0.500000 +0.500000 0.500000 1.00000 +1.00000 0.500000 1.00000 +0.500000 1.00000 1.00000 +1.00000 1.00000 0.500000 +1.00000 0.500000 1.00000 +1.00000 1.00000 1.00000 +0.500000 1.00000 1.00000 +0.500000 0.500000 0.500000 +1.00000 1.00000 0.500000 +0.500000 1.00000 1.00000 +1.00000 0.500000 1.00000 + +CELLS 40 200 + 4 0 1 2 3 + 4 4 5 6 7 + 4 8 9 10 11 + 4 12 13 14 15 + 4 16 17 18 19 + 4 20 21 22 23 + 4 24 25 26 27 + 4 28 29 30 31 + 4 32 33 34 35 + 4 36 37 38 39 + 4 40 41 42 43 + 4 44 45 46 47 + 4 48 49 50 51 + 4 52 53 54 55 + 4 56 57 58 59 + 4 60 61 62 63 + 4 64 65 66 67 + 4 68 69 70 71 + 4 72 73 74 75 + 4 76 77 78 79 + 4 80 81 82 83 + 4 84 85 86 87 + 4 88 89 90 91 + 4 92 93 94 95 + 4 96 97 98 99 + 4 100 101 102 103 + 4 104 105 106 107 + 4 108 109 110 111 + 4 112 113 114 115 + 4 116 117 118 119 + 4 120 121 122 123 + 4 124 125 126 127 + 4 128 129 130 131 + 4 132 133 134 135 + 4 136 137 138 139 + 4 140 141 142 143 + 4 144 145 146 147 + 4 148 149 150 151 + 4 152 153 154 155 + 4 156 157 158 159 + +CELL_TYPES 40 + 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 +POINT_DATA 160 +SCALARS solution_0 double 1 +LOOKUP_TABLE default +0.00000 0.250000 0.00000 0.00000 0.00000 0.250000 0.250000 0.250000 0.250000 0.00000 0.250000 0.250000 0.00000 0.00000 0.250000 0.00000 0.250000 0.00000 0.00000 0.250000 0.250000 1.00000 1.00000 1.00000 0.250000 1.00000 0.250000 0.250000 0.250000 0.250000 1.00000 0.250000 1.00000 1.00000 1.00000 0.250000 0.250000 1.00000 0.250000 1.00000 0.00000 0.250000 0.250000 0.250000 0.00000 0.250000 0.00000 0.00000 0.00000 0.00000 0.250000 0.00000 0.250000 0.250000 0.250000 0.00000 0.00000 0.250000 0.00000 0.250000 0.250000 1.00000 0.250000 0.250000 0.250000 1.00000 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 0.250000 0.250000 1.00000 0.250000 1.00000 0.250000 0.250000 1.00000 0.00000 0.250000 0.250000 0.250000 0.00000 0.250000 0.00000 0.00000 0.00000 0.00000 0.250000 0.00000 0.250000 0.250000 0.250000 0.00000 0.00000 0.250000 0.00000 0.250000 0.250000 1.00000 0.250000 0.250000 0.250000 1.00000 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 0.250000 0.250000 1.00000 0.250000 1.00000 0.250000 0.250000 1.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.250000 0.250000 0.250000 0.250000 0.00000 0.250000 0.250000 0.00000 0.00000 0.250000 0.00000 0.250000 0.00000 0.00000 0.250000 0.250000 1.00000 1.00000 1.00000 0.250000 1.00000 0.250000 0.250000 0.250000 0.250000 1.00000 0.250000 1.00000 1.00000 1.00000 0.250000 0.250000 1.00000 0.250000 1.00000 +SCALARS solution_1 double 1 +LOOKUP_TABLE default +0.00000 0.00000 0.250000 0.00000 0.250000 0.00000 0.250000 0.250000 0.00000 0.00000 0.00000 0.250000 0.250000 0.00000 0.250000 0.250000 0.00000 0.250000 0.00000 0.250000 0.00000 0.00000 0.250000 0.00000 0.00000 0.250000 0.250000 0.250000 0.00000 0.00000 0.00000 0.250000 0.250000 0.00000 0.250000 0.250000 0.00000 0.250000 0.250000 0.00000 0.250000 0.250000 1.00000 0.250000 0.250000 1.00000 1.00000 1.00000 0.250000 0.250000 0.250000 1.00000 1.00000 0.250000 1.00000 1.00000 0.250000 1.00000 1.00000 0.250000 0.250000 0.250000 1.00000 0.250000 1.00000 0.250000 1.00000 1.00000 0.250000 0.250000 0.250000 1.00000 1.00000 0.250000 1.00000 1.00000 0.250000 1.00000 0.250000 1.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.250000 0.250000 0.250000 0.00000 0.00000 0.00000 0.250000 0.250000 0.00000 0.250000 0.250000 0.00000 0.250000 0.250000 0.00000 0.00000 0.00000 0.250000 0.00000 0.250000 0.00000 0.250000 0.250000 0.00000 0.00000 0.00000 0.250000 0.250000 0.00000 0.250000 0.250000 0.00000 0.250000 0.00000 0.250000 0.250000 0.250000 1.00000 0.250000 1.00000 0.250000 1.00000 1.00000 0.250000 0.250000 0.250000 1.00000 1.00000 0.250000 1.00000 1.00000 0.250000 1.00000 0.250000 1.00000 0.250000 0.250000 1.00000 0.250000 0.250000 1.00000 1.00000 1.00000 0.250000 0.250000 0.250000 1.00000 1.00000 0.250000 1.00000 1.00000 0.250000 1.00000 1.00000 0.250000 +SCALARS solution_2 double 1 +LOOKUP_TABLE default +0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.250000 0.00000 0.250000 0.250000 0.250000 0.00000 0.250000 0.250000 0.250000 0.00000 0.00000 0.250000 0.250000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.250000 0.00000 0.250000 0.250000 0.250000 0.00000 0.250000 0.250000 0.250000 0.00000 0.00000 0.250000 0.250000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.250000 0.00000 0.250000 0.250000 0.250000 0.00000 0.250000 0.250000 0.250000 0.00000 0.00000 0.250000 0.250000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.250000 0.00000 0.250000 0.250000 0.250000 0.00000 0.250000 0.250000 0.250000 0.00000 0.00000 0.250000 0.250000 0.250000 0.250000 0.250000 1.00000 0.250000 0.250000 0.250000 1.00000 0.250000 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 1.00000 0.250000 0.250000 1.00000 1.00000 0.250000 0.250000 0.250000 1.00000 0.250000 0.250000 0.250000 1.00000 0.250000 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 1.00000 0.250000 0.250000 1.00000 1.00000 0.250000 0.250000 0.250000 1.00000 0.250000 0.250000 0.250000 1.00000 0.250000 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 1.00000 0.250000 0.250000 1.00000 1.00000 0.250000 0.250000 0.250000 1.00000 0.250000 0.250000 0.250000 1.00000 0.250000 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 1.00000 0.250000 0.250000 1.00000 1.00000 +# vtk DataFile Version 3.0 +#This file was generated +ASCII +DATASET UNSTRUCTURED_GRID + +POINTS 400 double +0.00000 0.00000 0.00000 +0.500000 0.00000 0.00000 +0.00000 0.500000 0.00000 +0.00000 0.00000 0.500000 +0.250000 0.00000 0.00000 +0.250000 0.250000 0.00000 +0.00000 0.250000 0.00000 +0.00000 0.00000 0.250000 +0.250000 0.00000 0.250000 +0.00000 0.250000 0.250000 +0.00000 0.500000 0.00000 +0.500000 0.00000 0.00000 +0.500000 0.500000 0.00000 +0.500000 0.500000 0.500000 +0.250000 0.250000 0.00000 +0.500000 0.250000 0.00000 +0.250000 0.500000 0.00000 +0.250000 0.500000 0.250000 +0.500000 0.250000 0.250000 +0.500000 0.500000 0.250000 +0.500000 0.00000 0.00000 +0.00000 0.00000 0.500000 +0.500000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.250000 0.00000 0.250000 +0.250000 0.00000 0.500000 +0.500000 0.00000 0.250000 +0.500000 0.250000 0.250000 +0.250000 0.250000 0.500000 +0.500000 0.250000 0.500000 +0.00000 0.500000 0.00000 +0.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.00000 0.500000 0.500000 +0.00000 0.250000 0.250000 +0.250000 0.250000 0.500000 +0.250000 0.500000 0.250000 +0.00000 0.500000 0.250000 +0.00000 0.250000 0.500000 +0.250000 0.500000 0.500000 +0.500000 0.00000 0.00000 +0.00000 0.500000 0.00000 +0.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.250000 0.250000 0.00000 +0.00000 0.250000 0.250000 +0.250000 0.00000 0.250000 +0.500000 0.250000 0.250000 +0.250000 0.500000 0.250000 +0.250000 0.250000 0.500000 +0.500000 0.00000 0.00000 +1.00000 0.00000 0.00000 +1.00000 0.500000 0.00000 +1.00000 0.00000 0.500000 +0.750000 0.00000 0.00000 +1.00000 0.250000 0.00000 +0.750000 0.250000 0.00000 +0.750000 0.00000 0.250000 +1.00000 0.00000 0.250000 +1.00000 0.250000 0.250000 +0.500000 0.00000 0.00000 +1.00000 0.500000 0.00000 +0.500000 0.500000 0.00000 +0.500000 0.500000 0.500000 +0.750000 0.250000 0.00000 +0.750000 0.500000 0.00000 +0.500000 0.250000 0.00000 +0.500000 0.250000 0.250000 +0.750000 0.500000 0.250000 +0.500000 0.500000 0.250000 +0.500000 0.00000 0.00000 +0.500000 0.00000 0.500000 +1.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.500000 0.00000 0.250000 +0.750000 0.00000 0.500000 +0.750000 0.00000 0.250000 +0.500000 0.250000 0.250000 +0.500000 0.250000 0.500000 +0.750000 0.250000 0.500000 +1.00000 0.500000 0.00000 +1.00000 0.00000 0.500000 +1.00000 0.500000 0.500000 +0.500000 0.500000 0.500000 +1.00000 0.250000 0.250000 +1.00000 0.250000 0.500000 +1.00000 0.500000 0.250000 +0.750000 0.500000 0.250000 +0.750000 0.250000 0.500000 +0.750000 0.500000 0.500000 +0.500000 0.00000 0.00000 +1.00000 0.500000 0.00000 +0.500000 0.500000 0.500000 +1.00000 0.00000 0.500000 +0.750000 0.250000 0.00000 +0.750000 0.500000 0.250000 +0.500000 0.250000 0.250000 +0.750000 0.00000 0.250000 +1.00000 0.250000 0.250000 +0.750000 0.250000 0.500000 +0.00000 0.500000 0.00000 +0.500000 0.500000 0.00000 +0.500000 1.00000 0.00000 +0.500000 0.500000 0.500000 +0.250000 0.500000 0.00000 +0.500000 0.750000 0.00000 +0.250000 0.750000 0.00000 +0.250000 0.500000 0.250000 +0.500000 0.500000 0.250000 +0.500000 0.750000 0.250000 +0.00000 0.500000 0.00000 +0.500000 1.00000 0.00000 +0.00000 1.00000 0.00000 +0.00000 1.00000 0.500000 +0.250000 0.750000 0.00000 +0.250000 1.00000 0.00000 +0.00000 0.750000 0.00000 +0.00000 0.750000 0.250000 +0.250000 1.00000 0.250000 +0.00000 1.00000 0.250000 +0.00000 0.500000 0.00000 +0.00000 0.500000 0.500000 +0.500000 0.500000 0.500000 +0.00000 1.00000 0.500000 +0.00000 0.500000 0.250000 +0.250000 0.500000 0.500000 +0.250000 0.500000 0.250000 +0.00000 0.750000 0.250000 +0.00000 0.750000 0.500000 +0.250000 0.750000 0.500000 +0.500000 1.00000 0.00000 +0.500000 0.500000 0.500000 +0.500000 1.00000 0.500000 +0.00000 1.00000 0.500000 +0.500000 0.750000 0.250000 +0.500000 0.750000 0.500000 +0.500000 1.00000 0.250000 +0.250000 1.00000 0.250000 +0.250000 0.750000 0.500000 +0.250000 1.00000 0.500000 +0.00000 0.500000 0.00000 +0.500000 1.00000 0.00000 +0.00000 1.00000 0.500000 +0.500000 0.500000 0.500000 +0.250000 0.750000 0.00000 +0.250000 1.00000 0.250000 +0.00000 0.750000 0.250000 +0.250000 0.500000 0.250000 +0.500000 0.750000 0.250000 +0.250000 0.750000 0.500000 +0.500000 0.500000 0.00000 +1.00000 0.500000 0.00000 +0.500000 1.00000 0.00000 +0.500000 0.500000 0.500000 +0.750000 0.500000 0.00000 +0.750000 0.750000 0.00000 +0.500000 0.750000 0.00000 +0.500000 0.500000 0.250000 +0.750000 0.500000 0.250000 +0.500000 0.750000 0.250000 +0.500000 1.00000 0.00000 +1.00000 0.500000 0.00000 +1.00000 1.00000 0.00000 +1.00000 1.00000 0.500000 +0.750000 0.750000 0.00000 +1.00000 0.750000 0.00000 +0.750000 1.00000 0.00000 +0.750000 1.00000 0.250000 +1.00000 0.750000 0.250000 +1.00000 1.00000 0.250000 +1.00000 0.500000 0.00000 +0.500000 0.500000 0.500000 +1.00000 0.500000 0.500000 +1.00000 1.00000 0.500000 +0.750000 0.500000 0.250000 +0.750000 0.500000 0.500000 +1.00000 0.500000 0.250000 +1.00000 0.750000 0.250000 +0.750000 0.750000 0.500000 +1.00000 0.750000 0.500000 +0.500000 1.00000 0.00000 +0.500000 0.500000 0.500000 +1.00000 1.00000 0.500000 +0.500000 1.00000 0.500000 +0.500000 0.750000 0.250000 +0.750000 0.750000 0.500000 +0.750000 1.00000 0.250000 +0.500000 1.00000 0.250000 +0.500000 0.750000 0.500000 +0.750000 1.00000 0.500000 +1.00000 0.500000 0.00000 +0.500000 1.00000 0.00000 +0.500000 0.500000 0.500000 +1.00000 1.00000 0.500000 +0.750000 0.750000 0.00000 +0.500000 0.750000 0.250000 +0.750000 0.500000 0.250000 +1.00000 0.750000 0.250000 +0.750000 1.00000 0.250000 +0.750000 0.750000 0.500000 +0.00000 0.00000 0.500000 +0.500000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.500000 0.00000 1.00000 +0.250000 0.00000 0.500000 +0.500000 0.250000 0.500000 +0.250000 0.250000 0.500000 +0.250000 0.00000 0.750000 +0.500000 0.00000 0.750000 +0.500000 0.250000 0.750000 +0.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.00000 0.500000 0.500000 +0.00000 0.500000 1.00000 +0.250000 0.250000 0.500000 +0.250000 0.500000 0.500000 +0.00000 0.250000 0.500000 +0.00000 0.250000 0.750000 +0.250000 0.500000 0.750000 +0.00000 0.500000 0.750000 +0.00000 0.00000 0.500000 +0.00000 0.00000 1.00000 +0.500000 0.00000 1.00000 +0.00000 0.500000 1.00000 +0.00000 0.00000 0.750000 +0.250000 0.00000 1.00000 +0.250000 0.00000 0.750000 +0.00000 0.250000 0.750000 +0.00000 0.250000 1.00000 +0.250000 0.250000 1.00000 +0.500000 0.500000 0.500000 +0.500000 0.00000 1.00000 +0.500000 0.500000 1.00000 +0.00000 0.500000 1.00000 +0.500000 0.250000 0.750000 +0.500000 0.250000 1.00000 +0.500000 0.500000 0.750000 +0.250000 0.500000 0.750000 +0.250000 0.250000 1.00000 +0.250000 0.500000 1.00000 +0.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.00000 0.500000 1.00000 +0.500000 0.00000 1.00000 +0.250000 0.250000 0.500000 +0.250000 0.500000 0.750000 +0.00000 0.250000 0.750000 +0.250000 0.00000 0.750000 +0.500000 0.250000 0.750000 +0.250000 0.250000 1.00000 +0.500000 0.00000 0.500000 +1.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.500000 0.00000 1.00000 +0.750000 0.00000 0.500000 +0.750000 0.250000 0.500000 +0.500000 0.250000 0.500000 +0.500000 0.00000 0.750000 +0.750000 0.00000 0.750000 +0.500000 0.250000 0.750000 +0.500000 0.500000 0.500000 +1.00000 0.00000 0.500000 +1.00000 0.500000 0.500000 +1.00000 0.500000 1.00000 +0.750000 0.250000 0.500000 +1.00000 0.250000 0.500000 +0.750000 0.500000 0.500000 +0.750000 0.500000 0.750000 +1.00000 0.250000 0.750000 +1.00000 0.500000 0.750000 +1.00000 0.00000 0.500000 +0.500000 0.00000 1.00000 +1.00000 0.00000 1.00000 +1.00000 0.500000 1.00000 +0.750000 0.00000 0.750000 +0.750000 0.00000 1.00000 +1.00000 0.00000 0.750000 +1.00000 0.250000 0.750000 +0.750000 0.250000 1.00000 +1.00000 0.250000 1.00000 +0.500000 0.500000 0.500000 +0.500000 0.00000 1.00000 +1.00000 0.500000 1.00000 +0.500000 0.500000 1.00000 +0.500000 0.250000 0.750000 +0.750000 0.250000 1.00000 +0.750000 0.500000 0.750000 +0.500000 0.500000 0.750000 +0.500000 0.250000 1.00000 +0.750000 0.500000 1.00000 +1.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.500000 0.00000 1.00000 +1.00000 0.500000 1.00000 +0.750000 0.250000 0.500000 +0.500000 0.250000 0.750000 +0.750000 0.00000 0.750000 +1.00000 0.250000 0.750000 +0.750000 0.500000 0.750000 +0.750000 0.250000 1.00000 +0.00000 0.500000 0.500000 +0.500000 0.500000 0.500000 +0.00000 1.00000 0.500000 +0.00000 0.500000 1.00000 +0.250000 0.500000 0.500000 +0.250000 0.750000 0.500000 +0.00000 0.750000 0.500000 +0.00000 0.500000 0.750000 +0.250000 0.500000 0.750000 +0.00000 0.750000 0.750000 +0.00000 1.00000 0.500000 +0.500000 0.500000 0.500000 +0.500000 1.00000 0.500000 +0.500000 1.00000 1.00000 +0.250000 0.750000 0.500000 +0.500000 0.750000 0.500000 +0.250000 1.00000 0.500000 +0.250000 1.00000 0.750000 +0.500000 0.750000 0.750000 +0.500000 1.00000 0.750000 +0.500000 0.500000 0.500000 +0.00000 0.500000 1.00000 +0.500000 0.500000 1.00000 +0.500000 1.00000 1.00000 +0.250000 0.500000 0.750000 +0.250000 0.500000 1.00000 +0.500000 0.500000 0.750000 +0.500000 0.750000 0.750000 +0.250000 0.750000 1.00000 +0.500000 0.750000 1.00000 +0.00000 1.00000 0.500000 +0.00000 0.500000 1.00000 +0.500000 1.00000 1.00000 +0.00000 1.00000 1.00000 +0.00000 0.750000 0.750000 +0.250000 0.750000 1.00000 +0.250000 1.00000 0.750000 +0.00000 1.00000 0.750000 +0.00000 0.750000 1.00000 +0.250000 1.00000 1.00000 +0.500000 0.500000 0.500000 +0.00000 1.00000 0.500000 +0.00000 0.500000 1.00000 +0.500000 1.00000 1.00000 +0.250000 0.750000 0.500000 +0.00000 0.750000 0.750000 +0.250000 0.500000 0.750000 +0.500000 0.750000 0.750000 +0.250000 1.00000 0.750000 +0.250000 0.750000 1.00000 +0.500000 0.500000 0.500000 +1.00000 0.500000 0.500000 +1.00000 1.00000 0.500000 +1.00000 0.500000 1.00000 +0.750000 0.500000 0.500000 +1.00000 0.750000 0.500000 +0.750000 0.750000 0.500000 +0.750000 0.500000 0.750000 +1.00000 0.500000 0.750000 +1.00000 0.750000 0.750000 +0.500000 0.500000 0.500000 +1.00000 1.00000 0.500000 +0.500000 1.00000 0.500000 +0.500000 1.00000 1.00000 +0.750000 0.750000 0.500000 +0.750000 1.00000 0.500000 +0.500000 0.750000 0.500000 +0.500000 0.750000 0.750000 +0.750000 1.00000 0.750000 +0.500000 1.00000 0.750000 +0.500000 0.500000 0.500000 +0.500000 0.500000 1.00000 +1.00000 0.500000 1.00000 +0.500000 1.00000 1.00000 +0.500000 0.500000 0.750000 +0.750000 0.500000 1.00000 +0.750000 0.500000 0.750000 +0.500000 0.750000 0.750000 +0.500000 0.750000 1.00000 +0.750000 0.750000 1.00000 +1.00000 1.00000 0.500000 +1.00000 0.500000 1.00000 +1.00000 1.00000 1.00000 +0.500000 1.00000 1.00000 +1.00000 0.750000 0.750000 +1.00000 0.750000 1.00000 +1.00000 1.00000 0.750000 +0.750000 1.00000 0.750000 +0.750000 0.750000 1.00000 +0.750000 1.00000 1.00000 +0.500000 0.500000 0.500000 +1.00000 1.00000 0.500000 +0.500000 1.00000 1.00000 +1.00000 0.500000 1.00000 +0.750000 0.750000 0.500000 +0.750000 1.00000 0.750000 +0.500000 0.750000 0.750000 +0.750000 0.500000 0.750000 +1.00000 0.750000 0.750000 +0.750000 0.750000 1.00000 + +CELLS 40 440 + 10 0 1 2 3 4 5 6 7 8 9 + 10 10 11 12 13 14 15 16 17 18 19 + 10 20 21 22 23 24 25 26 27 28 29 + 10 30 31 32 33 34 35 36 37 38 39 + 10 40 41 42 43 44 45 46 47 48 49 + 10 50 51 52 53 54 55 56 57 58 59 + 10 60 61 62 63 64 65 66 67 68 69 + 10 70 71 72 73 74 75 76 77 78 79 + 10 80 81 82 83 84 85 86 87 88 89 + 10 90 91 92 93 94 95 96 97 98 99 + 10 100 101 102 103 104 105 106 107 108 109 + 10 110 111 112 113 114 115 116 117 118 119 + 10 120 121 122 123 124 125 126 127 128 129 + 10 130 131 132 133 134 135 136 137 138 139 + 10 140 141 142 143 144 145 146 147 148 149 + 10 150 151 152 153 154 155 156 157 158 159 + 10 160 161 162 163 164 165 166 167 168 169 + 10 170 171 172 173 174 175 176 177 178 179 + 10 180 181 182 183 184 185 186 187 188 189 + 10 190 191 192 193 194 195 196 197 198 199 + 10 200 201 202 203 204 205 206 207 208 209 + 10 210 211 212 213 214 215 216 217 218 219 + 10 220 221 222 223 224 225 226 227 228 229 + 10 230 231 232 233 234 235 236 237 238 239 + 10 240 241 242 243 244 245 246 247 248 249 + 10 250 251 252 253 254 255 256 257 258 259 + 10 260 261 262 263 264 265 266 267 268 269 + 10 270 271 272 273 274 275 276 277 278 279 + 10 280 281 282 283 284 285 286 287 288 289 + 10 290 291 292 293 294 295 296 297 298 299 + 10 300 301 302 303 304 305 306 307 308 309 + 10 310 311 312 313 314 315 316 317 318 319 + 10 320 321 322 323 324 325 326 327 328 329 + 10 330 331 332 333 334 335 336 337 338 339 + 10 340 341 342 343 344 345 346 347 348 349 + 10 350 351 352 353 354 355 356 357 358 359 + 10 360 361 362 363 364 365 366 367 368 369 + 10 370 371 372 373 374 375 376 377 378 379 + 10 380 381 382 383 384 385 386 387 388 389 + 10 390 391 392 393 394 395 396 397 398 399 + +CELL_TYPES 40 + 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 +POINT_DATA 400 +SCALARS solution_0 double 1 +LOOKUP_TABLE default +0.00000 0.250000 0.00000 0.00000 0.0625000 0.0625000 0.00000 0.00000 0.0625000 0.00000 0.00000 0.250000 0.250000 0.250000 0.0625000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.250000 0.00000 0.250000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.0625000 0.250000 0.00000 0.00000 0.250000 0.00000 0.00000 0.0625000 0.0625000 0.00000 0.00000 0.0625000 0.250000 0.00000 0.00000 0.250000 0.0625000 0.00000 0.0625000 0.250000 0.0625000 0.0625000 0.250000 1.00000 1.00000 1.00000 0.562500 1.00000 0.562500 0.562500 1.00000 1.00000 0.250000 1.00000 0.250000 0.250000 0.562500 0.562500 0.250000 0.250000 0.562500 0.250000 0.250000 0.250000 1.00000 0.250000 0.250000 0.562500 0.562500 0.250000 0.250000 0.562500 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 1.00000 0.562500 0.562500 0.562500 0.250000 1.00000 0.250000 1.00000 0.562500 0.562500 0.250000 0.562500 1.00000 0.562500 0.00000 0.250000 0.250000 0.250000 0.0625000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.00000 0.250000 0.00000 0.00000 0.0625000 0.0625000 0.00000 0.00000 0.0625000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.0625000 0.0625000 0.00000 0.00000 0.0625000 0.250000 0.250000 0.250000 0.00000 0.250000 0.250000 0.250000 0.0625000 0.0625000 0.0625000 0.00000 0.250000 0.00000 0.250000 0.0625000 0.0625000 0.00000 0.0625000 0.250000 0.0625000 0.250000 1.00000 0.250000 0.250000 0.562500 0.562500 0.250000 0.250000 0.562500 0.250000 0.250000 1.00000 1.00000 1.00000 0.562500 1.00000 0.562500 0.562500 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 0.562500 0.562500 1.00000 1.00000 0.562500 1.00000 0.250000 0.250000 1.00000 0.250000 0.250000 0.562500 0.562500 0.250000 0.250000 0.562500 1.00000 0.250000 0.250000 1.00000 0.562500 0.250000 0.562500 1.00000 0.562500 0.562500 0.00000 0.250000 0.250000 0.250000 0.0625000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.00000 0.250000 0.00000 0.00000 0.0625000 0.0625000 0.00000 0.00000 0.0625000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.0625000 0.0625000 0.00000 0.00000 0.0625000 0.250000 0.250000 0.250000 0.00000 0.250000 0.250000 0.250000 0.0625000 0.0625000 0.0625000 0.00000 0.250000 0.00000 0.250000 0.0625000 0.0625000 0.00000 0.0625000 0.250000 0.0625000 0.250000 1.00000 0.250000 0.250000 0.562500 0.562500 0.250000 0.250000 0.562500 0.250000 0.250000 1.00000 1.00000 1.00000 0.562500 1.00000 0.562500 0.562500 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 0.562500 0.562500 1.00000 1.00000 0.562500 1.00000 0.250000 0.250000 1.00000 0.250000 0.250000 0.562500 0.562500 0.250000 0.250000 0.562500 1.00000 0.250000 0.250000 1.00000 0.562500 0.250000 0.562500 1.00000 0.562500 0.562500 0.00000 0.250000 0.00000 0.00000 0.0625000 0.0625000 0.00000 0.00000 0.0625000 0.00000 0.00000 0.250000 0.250000 0.250000 0.0625000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.250000 0.00000 0.250000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.0625000 0.250000 0.00000 0.00000 0.250000 0.00000 0.00000 0.0625000 0.0625000 0.00000 0.00000 0.0625000 0.250000 0.00000 0.00000 0.250000 0.0625000 0.00000 0.0625000 0.250000 0.0625000 0.0625000 0.250000 1.00000 1.00000 1.00000 0.562500 1.00000 0.562500 0.562500 1.00000 1.00000 0.250000 1.00000 0.250000 0.250000 0.562500 0.562500 0.250000 0.250000 0.562500 0.250000 0.250000 0.250000 1.00000 0.250000 0.250000 0.562500 0.562500 0.250000 0.250000 0.562500 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 1.00000 0.562500 0.562500 0.562500 0.250000 1.00000 0.250000 1.00000 0.562500 0.562500 0.250000 0.562500 1.00000 0.562500 +SCALARS solution_1 double 1 +LOOKUP_TABLE default +0.00000 0.00000 0.250000 0.00000 0.00000 0.0625000 0.0625000 0.00000 0.00000 0.0625000 0.250000 0.00000 0.250000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.0625000 0.250000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.0625000 0.0625000 0.0625000 0.250000 0.00000 0.250000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.0625000 0.250000 0.00000 0.250000 0.00000 0.250000 0.0625000 0.0625000 0.00000 0.0625000 0.250000 0.0625000 0.00000 0.00000 0.250000 0.00000 0.00000 0.0625000 0.0625000 0.00000 0.00000 0.0625000 0.00000 0.250000 0.250000 0.250000 0.0625000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.0625000 0.0625000 0.0625000 0.250000 0.00000 0.250000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.0625000 0.250000 0.00000 0.250000 0.250000 0.00000 0.0625000 0.250000 0.0625000 0.00000 0.0625000 0.0625000 0.250000 0.250000 1.00000 0.250000 0.250000 0.562500 0.562500 0.250000 0.250000 0.562500 0.250000 1.00000 1.00000 1.00000 0.562500 1.00000 0.562500 0.562500 1.00000 1.00000 0.250000 0.250000 0.250000 1.00000 0.250000 0.250000 0.250000 0.562500 0.562500 0.562500 1.00000 0.250000 1.00000 1.00000 0.562500 0.562500 1.00000 1.00000 0.562500 1.00000 0.250000 1.00000 1.00000 0.250000 0.562500 1.00000 0.562500 0.250000 0.562500 0.562500 0.250000 0.250000 1.00000 0.250000 0.250000 0.562500 0.562500 0.250000 0.250000 0.562500 1.00000 0.250000 1.00000 1.00000 0.562500 0.562500 1.00000 1.00000 0.562500 1.00000 0.250000 0.250000 0.250000 1.00000 0.250000 0.250000 0.250000 0.562500 0.562500 0.562500 1.00000 0.250000 1.00000 1.00000 0.562500 0.562500 1.00000 1.00000 0.562500 1.00000 0.250000 1.00000 0.250000 1.00000 0.562500 0.562500 0.250000 0.562500 1.00000 0.562500 0.00000 0.00000 0.250000 0.00000 0.00000 0.0625000 0.0625000 0.00000 0.00000 0.0625000 0.00000 0.250000 0.250000 0.250000 0.0625000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.0625000 0.0625000 0.0625000 0.250000 0.00000 0.250000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.0625000 0.250000 0.00000 0.250000 0.250000 0.00000 0.0625000 0.250000 0.0625000 0.00000 0.0625000 0.0625000 0.00000 0.00000 0.250000 0.00000 0.00000 0.0625000 0.0625000 0.00000 0.00000 0.0625000 0.250000 0.00000 0.250000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.0625000 0.250000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.0625000 0.0625000 0.0625000 0.250000 0.00000 0.250000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.0625000 0.250000 0.00000 0.250000 0.00000 0.250000 0.0625000 0.0625000 0.00000 0.0625000 0.250000 0.0625000 0.250000 0.250000 1.00000 0.250000 0.250000 0.562500 0.562500 0.250000 0.250000 0.562500 1.00000 0.250000 1.00000 1.00000 0.562500 0.562500 1.00000 1.00000 0.562500 1.00000 0.250000 0.250000 0.250000 1.00000 0.250000 0.250000 0.250000 0.562500 0.562500 0.562500 1.00000 0.250000 1.00000 1.00000 0.562500 0.562500 1.00000 1.00000 0.562500 1.00000 0.250000 1.00000 0.250000 1.00000 0.562500 0.562500 0.250000 0.562500 1.00000 0.562500 0.250000 0.250000 1.00000 0.250000 0.250000 0.562500 0.562500 0.250000 0.250000 0.562500 0.250000 1.00000 1.00000 1.00000 0.562500 1.00000 0.562500 0.562500 1.00000 1.00000 0.250000 0.250000 0.250000 1.00000 0.250000 0.250000 0.250000 0.562500 0.562500 0.562500 1.00000 0.250000 1.00000 1.00000 0.562500 0.562500 1.00000 1.00000 0.562500 1.00000 0.250000 1.00000 1.00000 0.250000 0.562500 1.00000 0.562500 0.250000 0.562500 0.562500 +SCALARS solution_2 double 1 +LOOKUP_TABLE default +0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.0625000 0.0625000 0.0625000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.0625000 0.0625000 0.0625000 0.00000 0.250000 0.250000 0.250000 0.0625000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.00000 0.250000 0.250000 0.250000 0.0625000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.00000 0.00000 0.250000 0.250000 0.00000 0.0625000 0.0625000 0.0625000 0.0625000 0.250000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.0625000 0.0625000 0.0625000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.0625000 0.0625000 0.0625000 0.00000 0.250000 0.250000 0.250000 0.0625000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.00000 0.250000 0.250000 0.250000 0.0625000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.00000 0.00000 0.250000 0.250000 0.00000 0.0625000 0.0625000 0.0625000 0.0625000 0.250000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.0625000 0.0625000 0.0625000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.0625000 0.0625000 0.0625000 0.00000 0.250000 0.250000 0.250000 0.0625000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.00000 0.250000 0.250000 0.250000 0.0625000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.00000 0.00000 0.250000 0.250000 0.00000 0.0625000 0.0625000 0.0625000 0.0625000 0.250000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.0625000 0.0625000 0.0625000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.0625000 0.0625000 0.0625000 0.00000 0.250000 0.250000 0.250000 0.0625000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.00000 0.250000 0.250000 0.250000 0.0625000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.00000 0.00000 0.250000 0.250000 0.00000 0.0625000 0.0625000 0.0625000 0.0625000 0.250000 0.250000 0.250000 0.250000 1.00000 0.250000 0.250000 0.250000 0.562500 0.562500 0.562500 0.250000 0.250000 0.250000 1.00000 0.250000 0.250000 0.250000 0.562500 0.562500 0.562500 0.250000 1.00000 1.00000 1.00000 0.562500 1.00000 0.562500 0.562500 1.00000 1.00000 0.250000 1.00000 1.00000 1.00000 0.562500 1.00000 0.562500 0.562500 1.00000 1.00000 0.250000 0.250000 1.00000 1.00000 0.250000 0.562500 0.562500 0.562500 0.562500 1.00000 0.250000 0.250000 0.250000 1.00000 0.250000 0.250000 0.250000 0.562500 0.562500 0.562500 0.250000 0.250000 0.250000 1.00000 0.250000 0.250000 0.250000 0.562500 0.562500 0.562500 0.250000 1.00000 1.00000 1.00000 0.562500 1.00000 0.562500 0.562500 1.00000 1.00000 0.250000 1.00000 1.00000 1.00000 0.562500 1.00000 0.562500 0.562500 1.00000 1.00000 0.250000 0.250000 1.00000 1.00000 0.250000 0.562500 0.562500 0.562500 0.562500 1.00000 0.250000 0.250000 0.250000 1.00000 0.250000 0.250000 0.250000 0.562500 0.562500 0.562500 0.250000 0.250000 0.250000 1.00000 0.250000 0.250000 0.250000 0.562500 0.562500 0.562500 0.250000 1.00000 1.00000 1.00000 0.562500 1.00000 0.562500 0.562500 1.00000 1.00000 0.250000 1.00000 1.00000 1.00000 0.562500 1.00000 0.562500 0.562500 1.00000 1.00000 0.250000 0.250000 1.00000 1.00000 0.250000 0.562500 0.562500 0.562500 0.562500 1.00000 0.250000 0.250000 0.250000 1.00000 0.250000 0.250000 0.250000 0.562500 0.562500 0.562500 0.250000 0.250000 0.250000 1.00000 0.250000 0.250000 0.250000 0.562500 0.562500 0.562500 0.250000 1.00000 1.00000 1.00000 0.562500 1.00000 0.562500 0.562500 1.00000 1.00000 0.250000 1.00000 1.00000 1.00000 0.562500 1.00000 0.562500 0.562500 1.00000 1.00000 0.250000 0.250000 1.00000 1.00000 0.250000 0.562500 0.562500 0.562500 0.562500 1.00000 +# vtk DataFile Version 3.0 +#This file was generated +ASCII +DATASET UNSTRUCTURED_GRID + +POINTS 160 double +0.00000 0.00000 0.00000 +0.500000 0.00000 0.00000 +0.00000 0.500000 0.00000 +0.00000 0.00000 0.500000 +0.00000 0.500000 0.00000 +0.500000 0.00000 0.00000 +0.500000 0.500000 0.00000 +0.500000 0.500000 0.500000 +0.500000 0.00000 0.00000 +0.00000 0.00000 0.500000 +0.500000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.00000 0.500000 0.00000 +0.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.00000 0.500000 0.500000 +0.500000 0.00000 0.00000 +0.00000 0.500000 0.00000 +0.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.500000 0.00000 0.00000 +1.00000 0.00000 0.00000 +1.00000 0.500000 0.00000 +1.00000 0.00000 0.500000 +0.500000 0.00000 0.00000 +1.00000 0.500000 0.00000 +0.500000 0.500000 0.00000 +0.500000 0.500000 0.500000 +0.500000 0.00000 0.00000 +0.500000 0.00000 0.500000 +1.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +1.00000 0.500000 0.00000 +1.00000 0.00000 0.500000 +1.00000 0.500000 0.500000 +0.500000 0.500000 0.500000 +0.500000 0.00000 0.00000 +1.00000 0.500000 0.00000 +0.500000 0.500000 0.500000 +1.00000 0.00000 0.500000 +0.00000 0.500000 0.00000 +0.500000 0.500000 0.00000 +0.500000 1.00000 0.00000 +0.500000 0.500000 0.500000 +0.00000 0.500000 0.00000 +0.500000 1.00000 0.00000 +0.00000 1.00000 0.00000 +0.00000 1.00000 0.500000 +0.00000 0.500000 0.00000 +0.00000 0.500000 0.500000 +0.500000 0.500000 0.500000 +0.00000 1.00000 0.500000 +0.500000 1.00000 0.00000 +0.500000 0.500000 0.500000 +0.500000 1.00000 0.500000 +0.00000 1.00000 0.500000 +0.00000 0.500000 0.00000 +0.500000 1.00000 0.00000 +0.00000 1.00000 0.500000 +0.500000 0.500000 0.500000 +0.500000 0.500000 0.00000 +1.00000 0.500000 0.00000 +0.500000 1.00000 0.00000 +0.500000 0.500000 0.500000 +0.500000 1.00000 0.00000 +1.00000 0.500000 0.00000 +1.00000 1.00000 0.00000 +1.00000 1.00000 0.500000 +1.00000 0.500000 0.00000 +0.500000 0.500000 0.500000 +1.00000 0.500000 0.500000 +1.00000 1.00000 0.500000 +0.500000 1.00000 0.00000 +0.500000 0.500000 0.500000 +1.00000 1.00000 0.500000 +0.500000 1.00000 0.500000 +1.00000 0.500000 0.00000 +0.500000 1.00000 0.00000 +0.500000 0.500000 0.500000 +1.00000 1.00000 0.500000 +0.00000 0.00000 0.500000 +0.500000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.500000 0.00000 1.00000 +0.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.00000 0.500000 0.500000 +0.00000 0.500000 1.00000 +0.00000 0.00000 0.500000 +0.00000 0.00000 1.00000 +0.500000 0.00000 1.00000 +0.00000 0.500000 1.00000 +0.500000 0.500000 0.500000 +0.500000 0.00000 1.00000 +0.500000 0.500000 1.00000 +0.00000 0.500000 1.00000 +0.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.00000 0.500000 1.00000 +0.500000 0.00000 1.00000 +0.500000 0.00000 0.500000 +1.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.500000 0.00000 1.00000 +0.500000 0.500000 0.500000 +1.00000 0.00000 0.500000 +1.00000 0.500000 0.500000 +1.00000 0.500000 1.00000 +1.00000 0.00000 0.500000 +0.500000 0.00000 1.00000 +1.00000 0.00000 1.00000 +1.00000 0.500000 1.00000 +0.500000 0.500000 0.500000 +0.500000 0.00000 1.00000 +1.00000 0.500000 1.00000 +0.500000 0.500000 1.00000 +1.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.500000 0.00000 1.00000 +1.00000 0.500000 1.00000 +0.00000 0.500000 0.500000 +0.500000 0.500000 0.500000 +0.00000 1.00000 0.500000 +0.00000 0.500000 1.00000 +0.00000 1.00000 0.500000 +0.500000 0.500000 0.500000 +0.500000 1.00000 0.500000 +0.500000 1.00000 1.00000 +0.500000 0.500000 0.500000 +0.00000 0.500000 1.00000 +0.500000 0.500000 1.00000 +0.500000 1.00000 1.00000 +0.00000 1.00000 0.500000 +0.00000 0.500000 1.00000 +0.500000 1.00000 1.00000 +0.00000 1.00000 1.00000 +0.500000 0.500000 0.500000 +0.00000 1.00000 0.500000 +0.00000 0.500000 1.00000 +0.500000 1.00000 1.00000 +0.500000 0.500000 0.500000 +1.00000 0.500000 0.500000 +1.00000 1.00000 0.500000 +1.00000 0.500000 1.00000 +0.500000 0.500000 0.500000 +1.00000 1.00000 0.500000 +0.500000 1.00000 0.500000 +0.500000 1.00000 1.00000 +0.500000 0.500000 0.500000 +0.500000 0.500000 1.00000 +1.00000 0.500000 1.00000 +0.500000 1.00000 1.00000 +1.00000 1.00000 0.500000 +1.00000 0.500000 1.00000 +1.00000 1.00000 1.00000 +0.500000 1.00000 1.00000 +0.500000 0.500000 0.500000 +1.00000 1.00000 0.500000 +0.500000 1.00000 1.00000 +1.00000 0.500000 1.00000 + +CELLS 40 200 + 4 0 1 2 3 + 4 4 5 6 7 + 4 8 9 10 11 + 4 12 13 14 15 + 4 16 17 18 19 + 4 20 21 22 23 + 4 24 25 26 27 + 4 28 29 30 31 + 4 32 33 34 35 + 4 36 37 38 39 + 4 40 41 42 43 + 4 44 45 46 47 + 4 48 49 50 51 + 4 52 53 54 55 + 4 56 57 58 59 + 4 60 61 62 63 + 4 64 65 66 67 + 4 68 69 70 71 + 4 72 73 74 75 + 4 76 77 78 79 + 4 80 81 82 83 + 4 84 85 86 87 + 4 88 89 90 91 + 4 92 93 94 95 + 4 96 97 98 99 + 4 100 101 102 103 + 4 104 105 106 107 + 4 108 109 110 111 + 4 112 113 114 115 + 4 116 117 118 119 + 4 120 121 122 123 + 4 124 125 126 127 + 4 128 129 130 131 + 4 132 133 134 135 + 4 136 137 138 139 + 4 140 141 142 143 + 4 144 145 146 147 + 4 148 149 150 151 + 4 152 153 154 155 + 4 156 157 158 159 + +CELL_TYPES 40 + 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 10 +POINT_DATA 160 +SCALARS solution_0 double 1 +LOOKUP_TABLE default +0.00000 0.250000 0.00000 0.00000 0.00000 0.250000 0.250000 0.250000 0.250000 0.00000 0.250000 0.250000 0.00000 0.00000 0.250000 0.00000 0.250000 0.00000 0.00000 0.250000 0.250000 1.00000 1.00000 1.00000 0.250000 1.00000 0.250000 0.250000 0.250000 0.250000 1.00000 0.250000 1.00000 1.00000 1.00000 0.250000 0.250000 1.00000 0.250000 1.00000 0.00000 0.250000 0.250000 0.250000 0.00000 0.250000 0.00000 0.00000 0.00000 0.00000 0.250000 0.00000 0.250000 0.250000 0.250000 0.00000 0.00000 0.250000 0.00000 0.250000 0.250000 1.00000 0.250000 0.250000 0.250000 1.00000 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 0.250000 0.250000 1.00000 0.250000 1.00000 0.250000 0.250000 1.00000 0.00000 0.250000 0.250000 0.250000 0.00000 0.250000 0.00000 0.00000 0.00000 0.00000 0.250000 0.00000 0.250000 0.250000 0.250000 0.00000 0.00000 0.250000 0.00000 0.250000 0.250000 1.00000 0.250000 0.250000 0.250000 1.00000 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 0.250000 0.250000 1.00000 0.250000 1.00000 0.250000 0.250000 1.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.250000 0.250000 0.250000 0.250000 0.00000 0.250000 0.250000 0.00000 0.00000 0.250000 0.00000 0.250000 0.00000 0.00000 0.250000 0.250000 1.00000 1.00000 1.00000 0.250000 1.00000 0.250000 0.250000 0.250000 0.250000 1.00000 0.250000 1.00000 1.00000 1.00000 0.250000 0.250000 1.00000 0.250000 1.00000 +SCALARS solution_1 double 1 +LOOKUP_TABLE default +0.00000 0.00000 0.250000 0.00000 0.250000 0.00000 0.250000 0.250000 0.00000 0.00000 0.00000 0.250000 0.250000 0.00000 0.250000 0.250000 0.00000 0.250000 0.00000 0.250000 0.00000 0.00000 0.250000 0.00000 0.00000 0.250000 0.250000 0.250000 0.00000 0.00000 0.00000 0.250000 0.250000 0.00000 0.250000 0.250000 0.00000 0.250000 0.250000 0.00000 0.250000 0.250000 1.00000 0.250000 0.250000 1.00000 1.00000 1.00000 0.250000 0.250000 0.250000 1.00000 1.00000 0.250000 1.00000 1.00000 0.250000 1.00000 1.00000 0.250000 0.250000 0.250000 1.00000 0.250000 1.00000 0.250000 1.00000 1.00000 0.250000 0.250000 0.250000 1.00000 1.00000 0.250000 1.00000 1.00000 0.250000 1.00000 0.250000 1.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.250000 0.250000 0.250000 0.00000 0.00000 0.00000 0.250000 0.250000 0.00000 0.250000 0.250000 0.00000 0.250000 0.250000 0.00000 0.00000 0.00000 0.250000 0.00000 0.250000 0.00000 0.250000 0.250000 0.00000 0.00000 0.00000 0.250000 0.250000 0.00000 0.250000 0.250000 0.00000 0.250000 0.00000 0.250000 0.250000 0.250000 1.00000 0.250000 1.00000 0.250000 1.00000 1.00000 0.250000 0.250000 0.250000 1.00000 1.00000 0.250000 1.00000 1.00000 0.250000 1.00000 0.250000 1.00000 0.250000 0.250000 1.00000 0.250000 0.250000 1.00000 1.00000 1.00000 0.250000 0.250000 0.250000 1.00000 1.00000 0.250000 1.00000 1.00000 0.250000 1.00000 1.00000 0.250000 +SCALARS solution_2 double 1 +LOOKUP_TABLE default +0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.250000 0.00000 0.250000 0.250000 0.250000 0.00000 0.250000 0.250000 0.250000 0.00000 0.00000 0.250000 0.250000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.250000 0.00000 0.250000 0.250000 0.250000 0.00000 0.250000 0.250000 0.250000 0.00000 0.00000 0.250000 0.250000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.250000 0.00000 0.250000 0.250000 0.250000 0.00000 0.250000 0.250000 0.250000 0.00000 0.00000 0.250000 0.250000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.250000 0.00000 0.250000 0.250000 0.250000 0.00000 0.250000 0.250000 0.250000 0.00000 0.00000 0.250000 0.250000 0.250000 0.250000 0.250000 1.00000 0.250000 0.250000 0.250000 1.00000 0.250000 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 1.00000 0.250000 0.250000 1.00000 1.00000 0.250000 0.250000 0.250000 1.00000 0.250000 0.250000 0.250000 1.00000 0.250000 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 1.00000 0.250000 0.250000 1.00000 1.00000 0.250000 0.250000 0.250000 1.00000 0.250000 0.250000 0.250000 1.00000 0.250000 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 1.00000 0.250000 0.250000 1.00000 1.00000 0.250000 0.250000 0.250000 1.00000 0.250000 0.250000 0.250000 1.00000 0.250000 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 1.00000 0.250000 0.250000 1.00000 1.00000 +SCALARS solution_3 double 1 +LOOKUP_TABLE default +0.00000 0.250000 0.00000 0.00000 0.00000 0.250000 0.250000 0.250000 0.250000 0.00000 0.250000 0.250000 0.00000 0.00000 0.250000 0.00000 0.250000 0.00000 0.00000 0.250000 0.250000 1.00000 1.00000 1.00000 0.250000 1.00000 0.250000 0.250000 0.250000 0.250000 1.00000 0.250000 1.00000 1.00000 1.00000 0.250000 0.250000 1.00000 0.250000 1.00000 0.00000 0.250000 0.250000 0.250000 0.00000 0.250000 0.00000 0.00000 0.00000 0.00000 0.250000 0.00000 0.250000 0.250000 0.250000 0.00000 0.00000 0.250000 0.00000 0.250000 0.250000 1.00000 0.250000 0.250000 0.250000 1.00000 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 0.250000 0.250000 1.00000 0.250000 1.00000 0.250000 0.250000 1.00000 0.00000 0.250000 0.250000 0.250000 0.00000 0.250000 0.00000 0.00000 0.00000 0.00000 0.250000 0.00000 0.250000 0.250000 0.250000 0.00000 0.00000 0.250000 0.00000 0.250000 0.250000 1.00000 0.250000 0.250000 0.250000 1.00000 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 0.250000 0.250000 1.00000 0.250000 1.00000 0.250000 0.250000 1.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.250000 0.250000 0.250000 0.250000 0.00000 0.250000 0.250000 0.00000 0.00000 0.250000 0.00000 0.250000 0.00000 0.00000 0.250000 0.250000 1.00000 1.00000 1.00000 0.250000 1.00000 0.250000 0.250000 0.250000 0.250000 1.00000 0.250000 1.00000 1.00000 1.00000 0.250000 0.250000 1.00000 0.250000 1.00000 +# vtk DataFile Version 3.0 +#This file was generated +ASCII +DATASET UNSTRUCTURED_GRID + +POINTS 400 double +0.00000 0.00000 0.00000 +0.500000 0.00000 0.00000 +0.00000 0.500000 0.00000 +0.00000 0.00000 0.500000 +0.250000 0.00000 0.00000 +0.250000 0.250000 0.00000 +0.00000 0.250000 0.00000 +0.00000 0.00000 0.250000 +0.250000 0.00000 0.250000 +0.00000 0.250000 0.250000 +0.00000 0.500000 0.00000 +0.500000 0.00000 0.00000 +0.500000 0.500000 0.00000 +0.500000 0.500000 0.500000 +0.250000 0.250000 0.00000 +0.500000 0.250000 0.00000 +0.250000 0.500000 0.00000 +0.250000 0.500000 0.250000 +0.500000 0.250000 0.250000 +0.500000 0.500000 0.250000 +0.500000 0.00000 0.00000 +0.00000 0.00000 0.500000 +0.500000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.250000 0.00000 0.250000 +0.250000 0.00000 0.500000 +0.500000 0.00000 0.250000 +0.500000 0.250000 0.250000 +0.250000 0.250000 0.500000 +0.500000 0.250000 0.500000 +0.00000 0.500000 0.00000 +0.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.00000 0.500000 0.500000 +0.00000 0.250000 0.250000 +0.250000 0.250000 0.500000 +0.250000 0.500000 0.250000 +0.00000 0.500000 0.250000 +0.00000 0.250000 0.500000 +0.250000 0.500000 0.500000 +0.500000 0.00000 0.00000 +0.00000 0.500000 0.00000 +0.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.250000 0.250000 0.00000 +0.00000 0.250000 0.250000 +0.250000 0.00000 0.250000 +0.500000 0.250000 0.250000 +0.250000 0.500000 0.250000 +0.250000 0.250000 0.500000 +0.500000 0.00000 0.00000 +1.00000 0.00000 0.00000 +1.00000 0.500000 0.00000 +1.00000 0.00000 0.500000 +0.750000 0.00000 0.00000 +1.00000 0.250000 0.00000 +0.750000 0.250000 0.00000 +0.750000 0.00000 0.250000 +1.00000 0.00000 0.250000 +1.00000 0.250000 0.250000 +0.500000 0.00000 0.00000 +1.00000 0.500000 0.00000 +0.500000 0.500000 0.00000 +0.500000 0.500000 0.500000 +0.750000 0.250000 0.00000 +0.750000 0.500000 0.00000 +0.500000 0.250000 0.00000 +0.500000 0.250000 0.250000 +0.750000 0.500000 0.250000 +0.500000 0.500000 0.250000 +0.500000 0.00000 0.00000 +0.500000 0.00000 0.500000 +1.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.500000 0.00000 0.250000 +0.750000 0.00000 0.500000 +0.750000 0.00000 0.250000 +0.500000 0.250000 0.250000 +0.500000 0.250000 0.500000 +0.750000 0.250000 0.500000 +1.00000 0.500000 0.00000 +1.00000 0.00000 0.500000 +1.00000 0.500000 0.500000 +0.500000 0.500000 0.500000 +1.00000 0.250000 0.250000 +1.00000 0.250000 0.500000 +1.00000 0.500000 0.250000 +0.750000 0.500000 0.250000 +0.750000 0.250000 0.500000 +0.750000 0.500000 0.500000 +0.500000 0.00000 0.00000 +1.00000 0.500000 0.00000 +0.500000 0.500000 0.500000 +1.00000 0.00000 0.500000 +0.750000 0.250000 0.00000 +0.750000 0.500000 0.250000 +0.500000 0.250000 0.250000 +0.750000 0.00000 0.250000 +1.00000 0.250000 0.250000 +0.750000 0.250000 0.500000 +0.00000 0.500000 0.00000 +0.500000 0.500000 0.00000 +0.500000 1.00000 0.00000 +0.500000 0.500000 0.500000 +0.250000 0.500000 0.00000 +0.500000 0.750000 0.00000 +0.250000 0.750000 0.00000 +0.250000 0.500000 0.250000 +0.500000 0.500000 0.250000 +0.500000 0.750000 0.250000 +0.00000 0.500000 0.00000 +0.500000 1.00000 0.00000 +0.00000 1.00000 0.00000 +0.00000 1.00000 0.500000 +0.250000 0.750000 0.00000 +0.250000 1.00000 0.00000 +0.00000 0.750000 0.00000 +0.00000 0.750000 0.250000 +0.250000 1.00000 0.250000 +0.00000 1.00000 0.250000 +0.00000 0.500000 0.00000 +0.00000 0.500000 0.500000 +0.500000 0.500000 0.500000 +0.00000 1.00000 0.500000 +0.00000 0.500000 0.250000 +0.250000 0.500000 0.500000 +0.250000 0.500000 0.250000 +0.00000 0.750000 0.250000 +0.00000 0.750000 0.500000 +0.250000 0.750000 0.500000 +0.500000 1.00000 0.00000 +0.500000 0.500000 0.500000 +0.500000 1.00000 0.500000 +0.00000 1.00000 0.500000 +0.500000 0.750000 0.250000 +0.500000 0.750000 0.500000 +0.500000 1.00000 0.250000 +0.250000 1.00000 0.250000 +0.250000 0.750000 0.500000 +0.250000 1.00000 0.500000 +0.00000 0.500000 0.00000 +0.500000 1.00000 0.00000 +0.00000 1.00000 0.500000 +0.500000 0.500000 0.500000 +0.250000 0.750000 0.00000 +0.250000 1.00000 0.250000 +0.00000 0.750000 0.250000 +0.250000 0.500000 0.250000 +0.500000 0.750000 0.250000 +0.250000 0.750000 0.500000 +0.500000 0.500000 0.00000 +1.00000 0.500000 0.00000 +0.500000 1.00000 0.00000 +0.500000 0.500000 0.500000 +0.750000 0.500000 0.00000 +0.750000 0.750000 0.00000 +0.500000 0.750000 0.00000 +0.500000 0.500000 0.250000 +0.750000 0.500000 0.250000 +0.500000 0.750000 0.250000 +0.500000 1.00000 0.00000 +1.00000 0.500000 0.00000 +1.00000 1.00000 0.00000 +1.00000 1.00000 0.500000 +0.750000 0.750000 0.00000 +1.00000 0.750000 0.00000 +0.750000 1.00000 0.00000 +0.750000 1.00000 0.250000 +1.00000 0.750000 0.250000 +1.00000 1.00000 0.250000 +1.00000 0.500000 0.00000 +0.500000 0.500000 0.500000 +1.00000 0.500000 0.500000 +1.00000 1.00000 0.500000 +0.750000 0.500000 0.250000 +0.750000 0.500000 0.500000 +1.00000 0.500000 0.250000 +1.00000 0.750000 0.250000 +0.750000 0.750000 0.500000 +1.00000 0.750000 0.500000 +0.500000 1.00000 0.00000 +0.500000 0.500000 0.500000 +1.00000 1.00000 0.500000 +0.500000 1.00000 0.500000 +0.500000 0.750000 0.250000 +0.750000 0.750000 0.500000 +0.750000 1.00000 0.250000 +0.500000 1.00000 0.250000 +0.500000 0.750000 0.500000 +0.750000 1.00000 0.500000 +1.00000 0.500000 0.00000 +0.500000 1.00000 0.00000 +0.500000 0.500000 0.500000 +1.00000 1.00000 0.500000 +0.750000 0.750000 0.00000 +0.500000 0.750000 0.250000 +0.750000 0.500000 0.250000 +1.00000 0.750000 0.250000 +0.750000 1.00000 0.250000 +0.750000 0.750000 0.500000 +0.00000 0.00000 0.500000 +0.500000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.500000 0.00000 1.00000 +0.250000 0.00000 0.500000 +0.500000 0.250000 0.500000 +0.250000 0.250000 0.500000 +0.250000 0.00000 0.750000 +0.500000 0.00000 0.750000 +0.500000 0.250000 0.750000 +0.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.00000 0.500000 0.500000 +0.00000 0.500000 1.00000 +0.250000 0.250000 0.500000 +0.250000 0.500000 0.500000 +0.00000 0.250000 0.500000 +0.00000 0.250000 0.750000 +0.250000 0.500000 0.750000 +0.00000 0.500000 0.750000 +0.00000 0.00000 0.500000 +0.00000 0.00000 1.00000 +0.500000 0.00000 1.00000 +0.00000 0.500000 1.00000 +0.00000 0.00000 0.750000 +0.250000 0.00000 1.00000 +0.250000 0.00000 0.750000 +0.00000 0.250000 0.750000 +0.00000 0.250000 1.00000 +0.250000 0.250000 1.00000 +0.500000 0.500000 0.500000 +0.500000 0.00000 1.00000 +0.500000 0.500000 1.00000 +0.00000 0.500000 1.00000 +0.500000 0.250000 0.750000 +0.500000 0.250000 1.00000 +0.500000 0.500000 0.750000 +0.250000 0.500000 0.750000 +0.250000 0.250000 1.00000 +0.250000 0.500000 1.00000 +0.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.00000 0.500000 1.00000 +0.500000 0.00000 1.00000 +0.250000 0.250000 0.500000 +0.250000 0.500000 0.750000 +0.00000 0.250000 0.750000 +0.250000 0.00000 0.750000 +0.500000 0.250000 0.750000 +0.250000 0.250000 1.00000 +0.500000 0.00000 0.500000 +1.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.500000 0.00000 1.00000 +0.750000 0.00000 0.500000 +0.750000 0.250000 0.500000 +0.500000 0.250000 0.500000 +0.500000 0.00000 0.750000 +0.750000 0.00000 0.750000 +0.500000 0.250000 0.750000 +0.500000 0.500000 0.500000 +1.00000 0.00000 0.500000 +1.00000 0.500000 0.500000 +1.00000 0.500000 1.00000 +0.750000 0.250000 0.500000 +1.00000 0.250000 0.500000 +0.750000 0.500000 0.500000 +0.750000 0.500000 0.750000 +1.00000 0.250000 0.750000 +1.00000 0.500000 0.750000 +1.00000 0.00000 0.500000 +0.500000 0.00000 1.00000 +1.00000 0.00000 1.00000 +1.00000 0.500000 1.00000 +0.750000 0.00000 0.750000 +0.750000 0.00000 1.00000 +1.00000 0.00000 0.750000 +1.00000 0.250000 0.750000 +0.750000 0.250000 1.00000 +1.00000 0.250000 1.00000 +0.500000 0.500000 0.500000 +0.500000 0.00000 1.00000 +1.00000 0.500000 1.00000 +0.500000 0.500000 1.00000 +0.500000 0.250000 0.750000 +0.750000 0.250000 1.00000 +0.750000 0.500000 0.750000 +0.500000 0.500000 0.750000 +0.500000 0.250000 1.00000 +0.750000 0.500000 1.00000 +1.00000 0.00000 0.500000 +0.500000 0.500000 0.500000 +0.500000 0.00000 1.00000 +1.00000 0.500000 1.00000 +0.750000 0.250000 0.500000 +0.500000 0.250000 0.750000 +0.750000 0.00000 0.750000 +1.00000 0.250000 0.750000 +0.750000 0.500000 0.750000 +0.750000 0.250000 1.00000 +0.00000 0.500000 0.500000 +0.500000 0.500000 0.500000 +0.00000 1.00000 0.500000 +0.00000 0.500000 1.00000 +0.250000 0.500000 0.500000 +0.250000 0.750000 0.500000 +0.00000 0.750000 0.500000 +0.00000 0.500000 0.750000 +0.250000 0.500000 0.750000 +0.00000 0.750000 0.750000 +0.00000 1.00000 0.500000 +0.500000 0.500000 0.500000 +0.500000 1.00000 0.500000 +0.500000 1.00000 1.00000 +0.250000 0.750000 0.500000 +0.500000 0.750000 0.500000 +0.250000 1.00000 0.500000 +0.250000 1.00000 0.750000 +0.500000 0.750000 0.750000 +0.500000 1.00000 0.750000 +0.500000 0.500000 0.500000 +0.00000 0.500000 1.00000 +0.500000 0.500000 1.00000 +0.500000 1.00000 1.00000 +0.250000 0.500000 0.750000 +0.250000 0.500000 1.00000 +0.500000 0.500000 0.750000 +0.500000 0.750000 0.750000 +0.250000 0.750000 1.00000 +0.500000 0.750000 1.00000 +0.00000 1.00000 0.500000 +0.00000 0.500000 1.00000 +0.500000 1.00000 1.00000 +0.00000 1.00000 1.00000 +0.00000 0.750000 0.750000 +0.250000 0.750000 1.00000 +0.250000 1.00000 0.750000 +0.00000 1.00000 0.750000 +0.00000 0.750000 1.00000 +0.250000 1.00000 1.00000 +0.500000 0.500000 0.500000 +0.00000 1.00000 0.500000 +0.00000 0.500000 1.00000 +0.500000 1.00000 1.00000 +0.250000 0.750000 0.500000 +0.00000 0.750000 0.750000 +0.250000 0.500000 0.750000 +0.500000 0.750000 0.750000 +0.250000 1.00000 0.750000 +0.250000 0.750000 1.00000 +0.500000 0.500000 0.500000 +1.00000 0.500000 0.500000 +1.00000 1.00000 0.500000 +1.00000 0.500000 1.00000 +0.750000 0.500000 0.500000 +1.00000 0.750000 0.500000 +0.750000 0.750000 0.500000 +0.750000 0.500000 0.750000 +1.00000 0.500000 0.750000 +1.00000 0.750000 0.750000 +0.500000 0.500000 0.500000 +1.00000 1.00000 0.500000 +0.500000 1.00000 0.500000 +0.500000 1.00000 1.00000 +0.750000 0.750000 0.500000 +0.750000 1.00000 0.500000 +0.500000 0.750000 0.500000 +0.500000 0.750000 0.750000 +0.750000 1.00000 0.750000 +0.500000 1.00000 0.750000 +0.500000 0.500000 0.500000 +0.500000 0.500000 1.00000 +1.00000 0.500000 1.00000 +0.500000 1.00000 1.00000 +0.500000 0.500000 0.750000 +0.750000 0.500000 1.00000 +0.750000 0.500000 0.750000 +0.500000 0.750000 0.750000 +0.500000 0.750000 1.00000 +0.750000 0.750000 1.00000 +1.00000 1.00000 0.500000 +1.00000 0.500000 1.00000 +1.00000 1.00000 1.00000 +0.500000 1.00000 1.00000 +1.00000 0.750000 0.750000 +1.00000 0.750000 1.00000 +1.00000 1.00000 0.750000 +0.750000 1.00000 0.750000 +0.750000 0.750000 1.00000 +0.750000 1.00000 1.00000 +0.500000 0.500000 0.500000 +1.00000 1.00000 0.500000 +0.500000 1.00000 1.00000 +1.00000 0.500000 1.00000 +0.750000 0.750000 0.500000 +0.750000 1.00000 0.750000 +0.500000 0.750000 0.750000 +0.750000 0.500000 0.750000 +1.00000 0.750000 0.750000 +0.750000 0.750000 1.00000 + +CELLS 40 440 + 10 0 1 2 3 4 5 6 7 8 9 + 10 10 11 12 13 14 15 16 17 18 19 + 10 20 21 22 23 24 25 26 27 28 29 + 10 30 31 32 33 34 35 36 37 38 39 + 10 40 41 42 43 44 45 46 47 48 49 + 10 50 51 52 53 54 55 56 57 58 59 + 10 60 61 62 63 64 65 66 67 68 69 + 10 70 71 72 73 74 75 76 77 78 79 + 10 80 81 82 83 84 85 86 87 88 89 + 10 90 91 92 93 94 95 96 97 98 99 + 10 100 101 102 103 104 105 106 107 108 109 + 10 110 111 112 113 114 115 116 117 118 119 + 10 120 121 122 123 124 125 126 127 128 129 + 10 130 131 132 133 134 135 136 137 138 139 + 10 140 141 142 143 144 145 146 147 148 149 + 10 150 151 152 153 154 155 156 157 158 159 + 10 160 161 162 163 164 165 166 167 168 169 + 10 170 171 172 173 174 175 176 177 178 179 + 10 180 181 182 183 184 185 186 187 188 189 + 10 190 191 192 193 194 195 196 197 198 199 + 10 200 201 202 203 204 205 206 207 208 209 + 10 210 211 212 213 214 215 216 217 218 219 + 10 220 221 222 223 224 225 226 227 228 229 + 10 230 231 232 233 234 235 236 237 238 239 + 10 240 241 242 243 244 245 246 247 248 249 + 10 250 251 252 253 254 255 256 257 258 259 + 10 260 261 262 263 264 265 266 267 268 269 + 10 270 271 272 273 274 275 276 277 278 279 + 10 280 281 282 283 284 285 286 287 288 289 + 10 290 291 292 293 294 295 296 297 298 299 + 10 300 301 302 303 304 305 306 307 308 309 + 10 310 311 312 313 314 315 316 317 318 319 + 10 320 321 322 323 324 325 326 327 328 329 + 10 330 331 332 333 334 335 336 337 338 339 + 10 340 341 342 343 344 345 346 347 348 349 + 10 350 351 352 353 354 355 356 357 358 359 + 10 360 361 362 363 364 365 366 367 368 369 + 10 370 371 372 373 374 375 376 377 378 379 + 10 380 381 382 383 384 385 386 387 388 389 + 10 390 391 392 393 394 395 396 397 398 399 + +CELL_TYPES 40 + 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 24 +POINT_DATA 400 +SCALARS solution_0 double 1 +LOOKUP_TABLE default +0.00000 0.250000 0.00000 0.00000 0.0625000 0.0625000 0.00000 0.00000 0.0625000 0.00000 0.00000 0.250000 0.250000 0.250000 0.0625000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.250000 0.00000 0.250000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.0625000 0.250000 0.00000 0.00000 0.250000 0.00000 0.00000 0.0625000 0.0625000 0.00000 0.00000 0.0625000 0.250000 0.00000 0.00000 0.250000 0.0625000 0.00000 0.0625000 0.250000 0.0625000 0.0625000 0.250000 1.00000 1.00000 1.00000 0.562500 1.00000 0.562500 0.562500 1.00000 1.00000 0.250000 1.00000 0.250000 0.250000 0.562500 0.562500 0.250000 0.250000 0.562500 0.250000 0.250000 0.250000 1.00000 0.250000 0.250000 0.562500 0.562500 0.250000 0.250000 0.562500 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 1.00000 0.562500 0.562500 0.562500 0.250000 1.00000 0.250000 1.00000 0.562500 0.562500 0.250000 0.562500 1.00000 0.562500 0.00000 0.250000 0.250000 0.250000 0.0625000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.00000 0.250000 0.00000 0.00000 0.0625000 0.0625000 0.00000 0.00000 0.0625000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.0625000 0.0625000 0.00000 0.00000 0.0625000 0.250000 0.250000 0.250000 0.00000 0.250000 0.250000 0.250000 0.0625000 0.0625000 0.0625000 0.00000 0.250000 0.00000 0.250000 0.0625000 0.0625000 0.00000 0.0625000 0.250000 0.0625000 0.250000 1.00000 0.250000 0.250000 0.562500 0.562500 0.250000 0.250000 0.562500 0.250000 0.250000 1.00000 1.00000 1.00000 0.562500 1.00000 0.562500 0.562500 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 0.562500 0.562500 1.00000 1.00000 0.562500 1.00000 0.250000 0.250000 1.00000 0.250000 0.250000 0.562500 0.562500 0.250000 0.250000 0.562500 1.00000 0.250000 0.250000 1.00000 0.562500 0.250000 0.562500 1.00000 0.562500 0.562500 0.00000 0.250000 0.250000 0.250000 0.0625000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.00000 0.250000 0.00000 0.00000 0.0625000 0.0625000 0.00000 0.00000 0.0625000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.0625000 0.0625000 0.00000 0.00000 0.0625000 0.250000 0.250000 0.250000 0.00000 0.250000 0.250000 0.250000 0.0625000 0.0625000 0.0625000 0.00000 0.250000 0.00000 0.250000 0.0625000 0.0625000 0.00000 0.0625000 0.250000 0.0625000 0.250000 1.00000 0.250000 0.250000 0.562500 0.562500 0.250000 0.250000 0.562500 0.250000 0.250000 1.00000 1.00000 1.00000 0.562500 1.00000 0.562500 0.562500 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 0.562500 0.562500 1.00000 1.00000 0.562500 1.00000 0.250000 0.250000 1.00000 0.250000 0.250000 0.562500 0.562500 0.250000 0.250000 0.562500 1.00000 0.250000 0.250000 1.00000 0.562500 0.250000 0.562500 1.00000 0.562500 0.562500 0.00000 0.250000 0.00000 0.00000 0.0625000 0.0625000 0.00000 0.00000 0.0625000 0.00000 0.00000 0.250000 0.250000 0.250000 0.0625000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.250000 0.00000 0.250000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.0625000 0.250000 0.00000 0.00000 0.250000 0.00000 0.00000 0.0625000 0.0625000 0.00000 0.00000 0.0625000 0.250000 0.00000 0.00000 0.250000 0.0625000 0.00000 0.0625000 0.250000 0.0625000 0.0625000 0.250000 1.00000 1.00000 1.00000 0.562500 1.00000 0.562500 0.562500 1.00000 1.00000 0.250000 1.00000 0.250000 0.250000 0.562500 0.562500 0.250000 0.250000 0.562500 0.250000 0.250000 0.250000 1.00000 0.250000 0.250000 0.562500 0.562500 0.250000 0.250000 0.562500 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 1.00000 0.562500 0.562500 0.562500 0.250000 1.00000 0.250000 1.00000 0.562500 0.562500 0.250000 0.562500 1.00000 0.562500 +SCALARS solution_1 double 1 +LOOKUP_TABLE default +0.00000 0.00000 0.250000 0.00000 0.00000 0.0625000 0.0625000 0.00000 0.00000 0.0625000 0.250000 0.00000 0.250000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.0625000 0.250000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.0625000 0.0625000 0.0625000 0.250000 0.00000 0.250000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.0625000 0.250000 0.00000 0.250000 0.00000 0.250000 0.0625000 0.0625000 0.00000 0.0625000 0.250000 0.0625000 0.00000 0.00000 0.250000 0.00000 0.00000 0.0625000 0.0625000 0.00000 0.00000 0.0625000 0.00000 0.250000 0.250000 0.250000 0.0625000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.0625000 0.0625000 0.0625000 0.250000 0.00000 0.250000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.0625000 0.250000 0.00000 0.250000 0.250000 0.00000 0.0625000 0.250000 0.0625000 0.00000 0.0625000 0.0625000 0.250000 0.250000 1.00000 0.250000 0.250000 0.562500 0.562500 0.250000 0.250000 0.562500 0.250000 1.00000 1.00000 1.00000 0.562500 1.00000 0.562500 0.562500 1.00000 1.00000 0.250000 0.250000 0.250000 1.00000 0.250000 0.250000 0.250000 0.562500 0.562500 0.562500 1.00000 0.250000 1.00000 1.00000 0.562500 0.562500 1.00000 1.00000 0.562500 1.00000 0.250000 1.00000 1.00000 0.250000 0.562500 1.00000 0.562500 0.250000 0.562500 0.562500 0.250000 0.250000 1.00000 0.250000 0.250000 0.562500 0.562500 0.250000 0.250000 0.562500 1.00000 0.250000 1.00000 1.00000 0.562500 0.562500 1.00000 1.00000 0.562500 1.00000 0.250000 0.250000 0.250000 1.00000 0.250000 0.250000 0.250000 0.562500 0.562500 0.562500 1.00000 0.250000 1.00000 1.00000 0.562500 0.562500 1.00000 1.00000 0.562500 1.00000 0.250000 1.00000 0.250000 1.00000 0.562500 0.562500 0.250000 0.562500 1.00000 0.562500 0.00000 0.00000 0.250000 0.00000 0.00000 0.0625000 0.0625000 0.00000 0.00000 0.0625000 0.00000 0.250000 0.250000 0.250000 0.0625000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.0625000 0.0625000 0.0625000 0.250000 0.00000 0.250000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.0625000 0.250000 0.00000 0.250000 0.250000 0.00000 0.0625000 0.250000 0.0625000 0.00000 0.0625000 0.0625000 0.00000 0.00000 0.250000 0.00000 0.00000 0.0625000 0.0625000 0.00000 0.00000 0.0625000 0.250000 0.00000 0.250000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.0625000 0.250000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.0625000 0.0625000 0.0625000 0.250000 0.00000 0.250000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.0625000 0.250000 0.00000 0.250000 0.00000 0.250000 0.0625000 0.0625000 0.00000 0.0625000 0.250000 0.0625000 0.250000 0.250000 1.00000 0.250000 0.250000 0.562500 0.562500 0.250000 0.250000 0.562500 1.00000 0.250000 1.00000 1.00000 0.562500 0.562500 1.00000 1.00000 0.562500 1.00000 0.250000 0.250000 0.250000 1.00000 0.250000 0.250000 0.250000 0.562500 0.562500 0.562500 1.00000 0.250000 1.00000 1.00000 0.562500 0.562500 1.00000 1.00000 0.562500 1.00000 0.250000 1.00000 0.250000 1.00000 0.562500 0.562500 0.250000 0.562500 1.00000 0.562500 0.250000 0.250000 1.00000 0.250000 0.250000 0.562500 0.562500 0.250000 0.250000 0.562500 0.250000 1.00000 1.00000 1.00000 0.562500 1.00000 0.562500 0.562500 1.00000 1.00000 0.250000 0.250000 0.250000 1.00000 0.250000 0.250000 0.250000 0.562500 0.562500 0.562500 1.00000 0.250000 1.00000 1.00000 0.562500 0.562500 1.00000 1.00000 0.562500 1.00000 0.250000 1.00000 1.00000 0.250000 0.562500 1.00000 0.562500 0.250000 0.562500 0.562500 +SCALARS solution_2 double 1 +LOOKUP_TABLE default +0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.0625000 0.0625000 0.0625000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.0625000 0.0625000 0.0625000 0.00000 0.250000 0.250000 0.250000 0.0625000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.00000 0.250000 0.250000 0.250000 0.0625000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.00000 0.00000 0.250000 0.250000 0.00000 0.0625000 0.0625000 0.0625000 0.0625000 0.250000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.0625000 0.0625000 0.0625000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.0625000 0.0625000 0.0625000 0.00000 0.250000 0.250000 0.250000 0.0625000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.00000 0.250000 0.250000 0.250000 0.0625000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.00000 0.00000 0.250000 0.250000 0.00000 0.0625000 0.0625000 0.0625000 0.0625000 0.250000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.0625000 0.0625000 0.0625000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.0625000 0.0625000 0.0625000 0.00000 0.250000 0.250000 0.250000 0.0625000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.00000 0.250000 0.250000 0.250000 0.0625000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.00000 0.00000 0.250000 0.250000 0.00000 0.0625000 0.0625000 0.0625000 0.0625000 0.250000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.0625000 0.0625000 0.0625000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.00000 0.0625000 0.0625000 0.0625000 0.00000 0.250000 0.250000 0.250000 0.0625000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.00000 0.250000 0.250000 0.250000 0.0625000 0.250000 0.0625000 0.0625000 0.250000 0.250000 0.00000 0.00000 0.250000 0.250000 0.00000 0.0625000 0.0625000 0.0625000 0.0625000 0.250000 0.250000 0.250000 0.250000 1.00000 0.250000 0.250000 0.250000 0.562500 0.562500 0.562500 0.250000 0.250000 0.250000 1.00000 0.250000 0.250000 0.250000 0.562500 0.562500 0.562500 0.250000 1.00000 1.00000 1.00000 0.562500 1.00000 0.562500 0.562500 1.00000 1.00000 0.250000 1.00000 1.00000 1.00000 0.562500 1.00000 0.562500 0.562500 1.00000 1.00000 0.250000 0.250000 1.00000 1.00000 0.250000 0.562500 0.562500 0.562500 0.562500 1.00000 0.250000 0.250000 0.250000 1.00000 0.250000 0.250000 0.250000 0.562500 0.562500 0.562500 0.250000 0.250000 0.250000 1.00000 0.250000 0.250000 0.250000 0.562500 0.562500 0.562500 0.250000 1.00000 1.00000 1.00000 0.562500 1.00000 0.562500 0.562500 1.00000 1.00000 0.250000 1.00000 1.00000 1.00000 0.562500 1.00000 0.562500 0.562500 1.00000 1.00000 0.250000 0.250000 1.00000 1.00000 0.250000 0.562500 0.562500 0.562500 0.562500 1.00000 0.250000 0.250000 0.250000 1.00000 0.250000 0.250000 0.250000 0.562500 0.562500 0.562500 0.250000 0.250000 0.250000 1.00000 0.250000 0.250000 0.250000 0.562500 0.562500 0.562500 0.250000 1.00000 1.00000 1.00000 0.562500 1.00000 0.562500 0.562500 1.00000 1.00000 0.250000 1.00000 1.00000 1.00000 0.562500 1.00000 0.562500 0.562500 1.00000 1.00000 0.250000 0.250000 1.00000 1.00000 0.250000 0.562500 0.562500 0.562500 0.562500 1.00000 0.250000 0.250000 0.250000 1.00000 0.250000 0.250000 0.250000 0.562500 0.562500 0.562500 0.250000 0.250000 0.250000 1.00000 0.250000 0.250000 0.250000 0.562500 0.562500 0.562500 0.250000 1.00000 1.00000 1.00000 0.562500 1.00000 0.562500 0.562500 1.00000 1.00000 0.250000 1.00000 1.00000 1.00000 0.562500 1.00000 0.562500 0.562500 1.00000 1.00000 0.250000 0.250000 1.00000 1.00000 0.250000 0.562500 0.562500 0.562500 0.562500 1.00000 +SCALARS solution_3 double 1 +LOOKUP_TABLE default +0.00000 0.250000 0.00000 0.00000 0.125000 0.125000 0.00000 0.00000 0.125000 0.00000 0.00000 0.250000 0.250000 0.250000 0.125000 0.250000 0.125000 0.125000 0.250000 0.250000 0.250000 0.00000 0.250000 0.250000 0.125000 0.125000 0.250000 0.250000 0.125000 0.250000 0.00000 0.00000 0.250000 0.00000 0.00000 0.125000 0.125000 0.00000 0.00000 0.125000 0.250000 0.00000 0.00000 0.250000 0.125000 0.00000 0.125000 0.250000 0.125000 0.125000 0.250000 1.00000 1.00000 1.00000 0.625000 1.00000 0.625000 0.625000 1.00000 1.00000 0.250000 1.00000 0.250000 0.250000 0.625000 0.625000 0.250000 0.250000 0.625000 0.250000 0.250000 0.250000 1.00000 0.250000 0.250000 0.625000 0.625000 0.250000 0.250000 0.625000 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 1.00000 0.625000 0.625000 0.625000 0.250000 1.00000 0.250000 1.00000 0.625000 0.625000 0.250000 0.625000 1.00000 0.625000 0.00000 0.250000 0.250000 0.250000 0.125000 0.250000 0.125000 0.125000 0.250000 0.250000 0.00000 0.250000 0.00000 0.00000 0.125000 0.125000 0.00000 0.00000 0.125000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.125000 0.125000 0.00000 0.00000 0.125000 0.250000 0.250000 0.250000 0.00000 0.250000 0.250000 0.250000 0.125000 0.125000 0.125000 0.00000 0.250000 0.00000 0.250000 0.125000 0.125000 0.00000 0.125000 0.250000 0.125000 0.250000 1.00000 0.250000 0.250000 0.625000 0.625000 0.250000 0.250000 0.625000 0.250000 0.250000 1.00000 1.00000 1.00000 0.625000 1.00000 0.625000 0.625000 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 0.625000 0.625000 1.00000 1.00000 0.625000 1.00000 0.250000 0.250000 1.00000 0.250000 0.250000 0.625000 0.625000 0.250000 0.250000 0.625000 1.00000 0.250000 0.250000 1.00000 0.625000 0.250000 0.625000 1.00000 0.625000 0.625000 0.00000 0.250000 0.250000 0.250000 0.125000 0.250000 0.125000 0.125000 0.250000 0.250000 0.00000 0.250000 0.00000 0.00000 0.125000 0.125000 0.00000 0.00000 0.125000 0.00000 0.00000 0.00000 0.250000 0.00000 0.00000 0.125000 0.125000 0.00000 0.00000 0.125000 0.250000 0.250000 0.250000 0.00000 0.250000 0.250000 0.250000 0.125000 0.125000 0.125000 0.00000 0.250000 0.00000 0.250000 0.125000 0.125000 0.00000 0.125000 0.250000 0.125000 0.250000 1.00000 0.250000 0.250000 0.625000 0.625000 0.250000 0.250000 0.625000 0.250000 0.250000 1.00000 1.00000 1.00000 0.625000 1.00000 0.625000 0.625000 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 0.625000 0.625000 1.00000 1.00000 0.625000 1.00000 0.250000 0.250000 1.00000 0.250000 0.250000 0.625000 0.625000 0.250000 0.250000 0.625000 1.00000 0.250000 0.250000 1.00000 0.625000 0.250000 0.625000 1.00000 0.625000 0.625000 0.00000 0.250000 0.00000 0.00000 0.125000 0.125000 0.00000 0.00000 0.125000 0.00000 0.00000 0.250000 0.250000 0.250000 0.125000 0.250000 0.125000 0.125000 0.250000 0.250000 0.250000 0.00000 0.250000 0.250000 0.125000 0.125000 0.250000 0.250000 0.125000 0.250000 0.00000 0.00000 0.250000 0.00000 0.00000 0.125000 0.125000 0.00000 0.00000 0.125000 0.250000 0.00000 0.00000 0.250000 0.125000 0.00000 0.125000 0.250000 0.125000 0.125000 0.250000 1.00000 1.00000 1.00000 0.625000 1.00000 0.625000 0.625000 1.00000 1.00000 0.250000 1.00000 0.250000 0.250000 0.625000 0.625000 0.250000 0.250000 0.625000 0.250000 0.250000 0.250000 1.00000 0.250000 0.250000 0.625000 0.625000 0.250000 0.250000 0.625000 1.00000 1.00000 1.00000 0.250000 1.00000 1.00000 1.00000 0.625000 0.625000 0.625000 0.250000 1.00000 0.250000 1.00000 0.625000 0.625000 0.250000 0.625000 1.00000 0.625000