From: Peter Munch Date: Mon, 12 Sep 2022 17:37:44 +0000 (+0200) Subject: DataOutResample for multiple components X-Git-Tag: v9.5.0-rc1~965^2 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=refs%2Fpull%2F14258%2Fhead;p=dealii.git DataOutResample for multiple components --- diff --git a/doc/news/changes/minor/20220912Munch_1 b/doc/news/changes/minor/20220912Munch_1 new file mode 100644 index 0000000000..81e485449e --- /dev/null +++ b/doc/news/changes/minor/20220912Munch_1 @@ -0,0 +1,6 @@ +Improved: The functions VectorTools::point_values()/::point_gradients() and +the class Utilities::MPI::RemotePointEvaluation now allow to specify the first +component to be selected. The feature is used in the class DataOutResample +to output multi-component solutions. +
+(Peter Munch, Magdalena Schreter, 2022/09/12) diff --git a/include/deal.II/numerics/vector_tools_evaluate.h b/include/deal.II/numerics/vector_tools_evaluate.h index b8e7132d6b..0d29e988ba 100644 --- a/include/deal.II/numerics/vector_tools_evaluate.h +++ b/include/deal.II/numerics/vector_tools_evaluate.h @@ -111,6 +111,12 @@ namespace VectorTools * cache, dof_handler_2, vector_2); * @endcode * + * The function also works with FiniteElement objects with multiple + * components. If one is interested only in a range of components, one can + * select these by the parameters @p first_selected_component and + * @p n_components. For further details on supported FiniteElement + * objects, see the documentation of FEPointEvaluation. + * * The function can also be used to evaluate cell-data vectors. For this * purpose, one passes in a Triangulation instead of a DoFHandler and a * vector of size Trinagulation::n_active_cells() or a vector, which @@ -142,7 +148,8 @@ namespace VectorTools const VectorType & vector, const std::vector> & evaluation_points, Utilities::MPI::RemotePointEvaluation &cache, - const EvaluationFlags::EvaluationFlags flags = EvaluationFlags::avg); + const EvaluationFlags::EvaluationFlags flags = EvaluationFlags::avg, + const unsigned int first_selected_component = 0); /** * Given a (distributed) solution vector @p vector, evaluate the values at @@ -171,7 +178,8 @@ namespace VectorTools const Utilities::MPI::RemotePointEvaluation &cache, const MeshType & mesh, const VectorType & vector, - const EvaluationFlags::EvaluationFlags flags = EvaluationFlags::avg); + const EvaluationFlags::EvaluationFlags flags = EvaluationFlags::avg, + const unsigned int first_selected_component = 0); /** * Given a (distributed) solution vector @p vector, evaluate the gradients at @@ -200,7 +208,8 @@ namespace VectorTools const VectorType & vector, const std::vector> & evaluation_points, Utilities::MPI::RemotePointEvaluation &cache, - const EvaluationFlags::EvaluationFlags flags = EvaluationFlags::avg); + const EvaluationFlags::EvaluationFlags flags = EvaluationFlags::avg, + const unsigned int first_selected_component = 0); /** * Given a (distributed) solution vector @p vector, evaluate the gradients at @@ -228,7 +237,8 @@ namespace VectorTools const Utilities::MPI::RemotePointEvaluation &cache, const MeshType & mesh, const VectorType & vector, - const EvaluationFlags::EvaluationFlags flags = EvaluationFlags::avg); + const EvaluationFlags::EvaluationFlags flags = EvaluationFlags::avg, + const unsigned int first_selected_component = 0); @@ -252,11 +262,13 @@ namespace VectorTools const VectorType & vector, const std::vector> &evaluation_points, Utilities::MPI::RemotePointEvaluation &cache, - const EvaluationFlags::EvaluationFlags flags) + const EvaluationFlags::EvaluationFlags flags, + const unsigned int first_selected_component) { cache.reinit(evaluation_points, mesh.get_triangulation(), mapping); - return point_values(cache, mesh, vector, flags); + return point_values( + cache, mesh, vector, flags, first_selected_component); } @@ -277,11 +289,13 @@ namespace VectorTools const VectorType & vector, const std::vector> &evaluation_points, Utilities::MPI::RemotePointEvaluation &cache, - const EvaluationFlags::EvaluationFlags flags) + const EvaluationFlags::EvaluationFlags flags, + const unsigned int first_selected_component) { cache.reinit(evaluation_points, mesh.get_triangulation(), mapping); - return point_gradients(cache, mesh, vector, flags); + return point_gradients( + cache, mesh, vector, flags, first_selected_component); } @@ -396,6 +410,7 @@ namespace VectorTools const VectorType & vector, const UpdateFlags update_flags, const dealii::EvaluationFlags::EvaluationFlags evaluation_flags, + const unsigned int first_selected_component, const std::function< value_type(const FEPointEvaluation>( - cache.get_mapping(), cell->get_fe(), update_flags); + cache.get_mapping(), + cell->get_fe(), + update_flags, + first_selected_component); auto &evaluator = *evaluators[cell->active_fe_index()]; evaluator.reinit(cell, unit_points); @@ -532,6 +550,7 @@ namespace VectorTools const VectorType & vector, const UpdateFlags, const dealii::EvaluationFlags::EvaluationFlags evaluation_flags, + const unsigned int first_selected_component, const std::function< value_type(const FEPointEvaluation>> &) { (void)evaluation_flags; + (void)first_selected_component; - Assert(n_components == 1, + Assert(n_components == 1 && first_selected_component == 0, ExcMessage( "A cell-data vector can only have a single component.")); @@ -581,7 +601,8 @@ namespace VectorTools const MeshType & mesh, const VectorType & vector, const EvaluationFlags::EvaluationFlags flags, - const UpdateFlags update_flags, + const unsigned int first_selected_component, + const UpdateFlags update_flags, const dealii::EvaluationFlags::EvaluationFlags evaluation_flags, const std::function< value_type(const FEPointEvaluation &cache, const MeshType & mesh, const VectorType & vector, - const EvaluationFlags::EvaluationFlags flags) + const EvaluationFlags::EvaluationFlags flags, + const unsigned int first_selected_component) { return internal::evaluate_at_points< n_components, @@ -704,6 +727,7 @@ namespace VectorTools mesh, vector, flags, + first_selected_component, update_values, dealii::EvaluationFlags::values, [](const auto &evaluator, const auto &q) { @@ -726,7 +750,8 @@ namespace VectorTools const Utilities::MPI::RemotePointEvaluation &cache, const MeshType & mesh, const VectorType & vector, - const EvaluationFlags::EvaluationFlags flags) + const EvaluationFlags::EvaluationFlags flags, + const unsigned int first_selected_component) { return internal::evaluate_at_points< n_components, @@ -743,6 +768,7 @@ namespace VectorTools mesh, vector, flags, + first_selected_component, update_gradients, dealii::EvaluationFlags::gradients, [](const auto &evaluator, const unsigned &q) { diff --git a/source/numerics/data_out_resample.cc b/source/numerics/data_out_resample.cc index 156a7ffbc5..1c7a35d098 100644 --- a/source/numerics/data_out_resample.cc +++ b/source/numerics/data_out_resample.cc @@ -151,32 +151,42 @@ DataOutResample::build_patches( const auto &dh = *data_ptr->dof_handler; - // TODO: enable more components - AssertDimension(dh.get_fe_collection().n_components(), 1); - - const auto values = - VectorTools::point_values<1>(rpe, dh, data_ptr->vector); - - vectors.emplace_back( - std::make_shared>( - partitioner)); - - for (unsigned int j = 0; j < values.size(); ++j) - vectors.back()->local_element(point_to_local_vector_indices[j]) = - values[j]; - - vectors.back()->set_ghost_state(true); - - // we can give the vectors arbitrary names ("temp_*") here, since these - // are only used internally (by patch_data_out) but not later on during - // the actual output to file - patch_data_out.add_data_vector( - *vectors.back(), - std::string("temp_" + std::to_string(counter)), - DataOut_DoFData:: - DataVectorType::type_dof_data); - - counter++; +#ifdef DEBUG + for (const auto &fe : dh.get_fe_collection()) + Assert( + fe.n_base_elements() == 1, + ExcMessage( + "This class currently only supports scalar elements and elements " + "with a single base element.")); +#endif + + for (unsigned int comp = 0; comp < dh.get_fe_collection().n_components(); + ++comp) + { + const auto values = VectorTools::point_values<1>( + rpe, dh, data_ptr->vector, VectorTools::EvaluationFlags::avg, comp); + + vectors.emplace_back( + std::make_shared>( + partitioner)); + + for (unsigned int j = 0; j < values.size(); ++j) + vectors.back()->local_element(point_to_local_vector_indices[j]) = + values[j]; + + vectors.back()->set_ghost_state(true); + + // we can give the vectors arbitrary names ("temp_*") here, since + // these are only used internally (by patch_data_out) but not later on + // during the actual output to file + patch_data_out.add_data_vector( + *vectors.back(), + std::string("temp_" + std::to_string(counter)), + DataOut_DoFData:: + DataVectorType::type_dof_data); + + counter++; + } } patch_data_out.build_patches(*patch_mapping, diff --git a/tests/remote_point_evaluation/data_out_resample_02.cc b/tests/remote_point_evaluation/data_out_resample_02.cc new file mode 100644 index 0000000000..747197f9fb --- /dev/null +++ b/tests/remote_point_evaluation/data_out_resample_02.cc @@ -0,0 +1,124 @@ +// --------------------------------------------------------------------- +// +// Copyright (C) 2021 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 DataOutResample to create a slice for FESystem with multiple +// components. + +#include +#include + +#include + +#include +#include + +#include +#include +#include + +#include + +#include +#include + +#include "../tests.h" + +using namespace dealii; + +template +class AnalyticalFunction : public Function +{ +public: + AnalyticalFunction(const unsigned n_components) + : Function(n_components) + {} + + virtual double + value(const Point &p, const unsigned int component = 0) const + { + return p[component] * (component + 1.0) + component; + } +}; + + +template +std::shared_ptr +create_partitioner(const DoFHandler &dof_handler) +{ + IndexSet locally_relevant_dofs; + + DoFTools::extract_locally_relevant_dofs(dof_handler, locally_relevant_dofs); + + return std::make_shared( + dof_handler.locally_owned_dofs(), + locally_relevant_dofs, + dof_handler.get_communicator()); +} + + + +int +main(int argc, char **argv) +{ + Utilities::MPI::MPI_InitFinalize mpi(argc, argv, 1); + MPILogInitAll all; + + const int dim = 3; + const int patch_dim = 2; + const int spacedim = 3; + const int n_components = dim; + + const unsigned int n_refinements_1 = 3; + const unsigned int n_refinements_2 = 3; + const MPI_Comm comm = MPI_COMM_WORLD; + + parallel::distributed::Triangulation tria_slice(comm); + GridGenerator::hyper_cube(tria_slice, -1.0, +1.0); + tria_slice.refine_global(n_refinements_2); + + MappingQ1 mapping_slice; + + parallel::distributed::Triangulation tria_backround(comm); + GridGenerator::hyper_cube(tria_backround, -1.0, +1.0); + tria_backround.refine_global(n_refinements_1); + + DoFHandler dof_handler(tria_backround); + dof_handler.distribute_dofs( + FESystem(FE_Q{1}, n_components)); + + MappingQ1 mapping; + + LinearAlgebra::distributed::Vector vector( + create_partitioner(dof_handler)); + + VectorTools::interpolate(mapping, + dof_handler, + AnalyticalFunction(n_components), + vector); + + vector.update_ghost_values(); + + DataOutResample data_out(tria_slice, mapping_slice); + data_out.add_data_vector(dof_handler, vector, "solution_0"); + data_out.add_data_vector(dof_handler, vector, "solution_1"); + data_out.update_mapping(mapping); + data_out.build_patches(); + +#if 1 + data_out.write_vtk(deallog.get_file_stream()); +#else + data_out.write_vtu_with_pvtu_record("./", "data_out_01", 0, comm, 1, 1); +#endif +} diff --git a/tests/remote_point_evaluation/data_out_resample_02.with_p4est=true.mpirun=1.output b/tests/remote_point_evaluation/data_out_resample_02.with_p4est=true.mpirun=1.output new file mode 100644 index 0000000000..f7cbd8989b --- /dev/null +++ b/tests/remote_point_evaluation/data_out_resample_02.with_p4est=true.mpirun=1.output @@ -0,0 +1,351 @@ + +# vtk DataFile Version 3.0 +#This file was generated +ASCII +DATASET UNSTRUCTURED_GRID + +POINTS 256 double +-1.00000 -1.00000 0.00000 +-0.750000 -1.00000 0.00000 +-1.00000 -0.750000 0.00000 +-0.750000 -0.750000 0.00000 +-0.750000 -1.00000 0.00000 +-0.500000 -1.00000 0.00000 +-0.750000 -0.750000 0.00000 +-0.500000 -0.750000 0.00000 +-1.00000 -0.750000 0.00000 +-0.750000 -0.750000 0.00000 +-1.00000 -0.500000 0.00000 +-0.750000 -0.500000 0.00000 +-0.750000 -0.750000 0.00000 +-0.500000 -0.750000 0.00000 +-0.750000 -0.500000 0.00000 +-0.500000 -0.500000 0.00000 +-0.500000 -1.00000 0.00000 +-0.250000 -1.00000 0.00000 +-0.500000 -0.750000 0.00000 +-0.250000 -0.750000 0.00000 +-0.250000 -1.00000 0.00000 +0.00000 -1.00000 0.00000 +-0.250000 -0.750000 0.00000 +0.00000 -0.750000 0.00000 +-0.500000 -0.750000 0.00000 +-0.250000 -0.750000 0.00000 +-0.500000 -0.500000 0.00000 +-0.250000 -0.500000 0.00000 +-0.250000 -0.750000 0.00000 +0.00000 -0.750000 0.00000 +-0.250000 -0.500000 0.00000 +0.00000 -0.500000 0.00000 +-1.00000 -0.500000 0.00000 +-0.750000 -0.500000 0.00000 +-1.00000 -0.250000 0.00000 +-0.750000 -0.250000 0.00000 +-0.750000 -0.500000 0.00000 +-0.500000 -0.500000 0.00000 +-0.750000 -0.250000 0.00000 +-0.500000 -0.250000 0.00000 +-1.00000 -0.250000 0.00000 +-0.750000 -0.250000 0.00000 +-1.00000 0.00000 0.00000 +-0.750000 0.00000 0.00000 +-0.750000 -0.250000 0.00000 +-0.500000 -0.250000 0.00000 +-0.750000 0.00000 0.00000 +-0.500000 0.00000 0.00000 +-0.500000 -0.500000 0.00000 +-0.250000 -0.500000 0.00000 +-0.500000 -0.250000 0.00000 +-0.250000 -0.250000 0.00000 +-0.250000 -0.500000 0.00000 +0.00000 -0.500000 0.00000 +-0.250000 -0.250000 0.00000 +0.00000 -0.250000 0.00000 +-0.500000 -0.250000 0.00000 +-0.250000 -0.250000 0.00000 +-0.500000 0.00000 0.00000 +-0.250000 0.00000 0.00000 +-0.250000 -0.250000 0.00000 +0.00000 -0.250000 0.00000 +-0.250000 0.00000 0.00000 +0.00000 0.00000 0.00000 +0.00000 -1.00000 0.00000 +0.250000 -1.00000 0.00000 +0.00000 -0.750000 0.00000 +0.250000 -0.750000 0.00000 +0.250000 -1.00000 0.00000 +0.500000 -1.00000 0.00000 +0.250000 -0.750000 0.00000 +0.500000 -0.750000 0.00000 +0.00000 -0.750000 0.00000 +0.250000 -0.750000 0.00000 +0.00000 -0.500000 0.00000 +0.250000 -0.500000 0.00000 +0.250000 -0.750000 0.00000 +0.500000 -0.750000 0.00000 +0.250000 -0.500000 0.00000 +0.500000 -0.500000 0.00000 +0.500000 -1.00000 0.00000 +0.750000 -1.00000 0.00000 +0.500000 -0.750000 0.00000 +0.750000 -0.750000 0.00000 +0.750000 -1.00000 0.00000 +1.00000 -1.00000 0.00000 +0.750000 -0.750000 0.00000 +1.00000 -0.750000 0.00000 +0.500000 -0.750000 0.00000 +0.750000 -0.750000 0.00000 +0.500000 -0.500000 0.00000 +0.750000 -0.500000 0.00000 +0.750000 -0.750000 0.00000 +1.00000 -0.750000 0.00000 +0.750000 -0.500000 0.00000 +1.00000 -0.500000 0.00000 +0.00000 -0.500000 0.00000 +0.250000 -0.500000 0.00000 +0.00000 -0.250000 0.00000 +0.250000 -0.250000 0.00000 +0.250000 -0.500000 0.00000 +0.500000 -0.500000 0.00000 +0.250000 -0.250000 0.00000 +0.500000 -0.250000 0.00000 +0.00000 -0.250000 0.00000 +0.250000 -0.250000 0.00000 +0.00000 0.00000 0.00000 +0.250000 0.00000 0.00000 +0.250000 -0.250000 0.00000 +0.500000 -0.250000 0.00000 +0.250000 0.00000 0.00000 +0.500000 0.00000 0.00000 +0.500000 -0.500000 0.00000 +0.750000 -0.500000 0.00000 +0.500000 -0.250000 0.00000 +0.750000 -0.250000 0.00000 +0.750000 -0.500000 0.00000 +1.00000 -0.500000 0.00000 +0.750000 -0.250000 0.00000 +1.00000 -0.250000 0.00000 +0.500000 -0.250000 0.00000 +0.750000 -0.250000 0.00000 +0.500000 0.00000 0.00000 +0.750000 0.00000 0.00000 +0.750000 -0.250000 0.00000 +1.00000 -0.250000 0.00000 +0.750000 0.00000 0.00000 +1.00000 0.00000 0.00000 +-1.00000 0.00000 0.00000 +-0.750000 0.00000 0.00000 +-1.00000 0.250000 0.00000 +-0.750000 0.250000 0.00000 +-0.750000 0.00000 0.00000 +-0.500000 0.00000 0.00000 +-0.750000 0.250000 0.00000 +-0.500000 0.250000 0.00000 +-1.00000 0.250000 0.00000 +-0.750000 0.250000 0.00000 +-1.00000 0.500000 0.00000 +-0.750000 0.500000 0.00000 +-0.750000 0.250000 0.00000 +-0.500000 0.250000 0.00000 +-0.750000 0.500000 0.00000 +-0.500000 0.500000 0.00000 +-0.500000 0.00000 0.00000 +-0.250000 0.00000 0.00000 +-0.500000 0.250000 0.00000 +-0.250000 0.250000 0.00000 +-0.250000 0.00000 0.00000 +0.00000 0.00000 0.00000 +-0.250000 0.250000 0.00000 +0.00000 0.250000 0.00000 +-0.500000 0.250000 0.00000 +-0.250000 0.250000 0.00000 +-0.500000 0.500000 0.00000 +-0.250000 0.500000 0.00000 +-0.250000 0.250000 0.00000 +0.00000 0.250000 0.00000 +-0.250000 0.500000 0.00000 +0.00000 0.500000 0.00000 +-1.00000 0.500000 0.00000 +-0.750000 0.500000 0.00000 +-1.00000 0.750000 0.00000 +-0.750000 0.750000 0.00000 +-0.750000 0.500000 0.00000 +-0.500000 0.500000 0.00000 +-0.750000 0.750000 0.00000 +-0.500000 0.750000 0.00000 +-1.00000 0.750000 0.00000 +-0.750000 0.750000 0.00000 +-1.00000 1.00000 0.00000 +-0.750000 1.00000 0.00000 +-0.750000 0.750000 0.00000 +-0.500000 0.750000 0.00000 +-0.750000 1.00000 0.00000 +-0.500000 1.00000 0.00000 +-0.500000 0.500000 0.00000 +-0.250000 0.500000 0.00000 +-0.500000 0.750000 0.00000 +-0.250000 0.750000 0.00000 +-0.250000 0.500000 0.00000 +0.00000 0.500000 0.00000 +-0.250000 0.750000 0.00000 +0.00000 0.750000 0.00000 +-0.500000 0.750000 0.00000 +-0.250000 0.750000 0.00000 +-0.500000 1.00000 0.00000 +-0.250000 1.00000 0.00000 +-0.250000 0.750000 0.00000 +0.00000 0.750000 0.00000 +-0.250000 1.00000 0.00000 +0.00000 1.00000 0.00000 +0.00000 0.00000 0.00000 +0.250000 0.00000 0.00000 +0.00000 0.250000 0.00000 +0.250000 0.250000 0.00000 +0.250000 0.00000 0.00000 +0.500000 0.00000 0.00000 +0.250000 0.250000 0.00000 +0.500000 0.250000 0.00000 +0.00000 0.250000 0.00000 +0.250000 0.250000 0.00000 +0.00000 0.500000 0.00000 +0.250000 0.500000 0.00000 +0.250000 0.250000 0.00000 +0.500000 0.250000 0.00000 +0.250000 0.500000 0.00000 +0.500000 0.500000 0.00000 +0.500000 0.00000 0.00000 +0.750000 0.00000 0.00000 +0.500000 0.250000 0.00000 +0.750000 0.250000 0.00000 +0.750000 0.00000 0.00000 +1.00000 0.00000 0.00000 +0.750000 0.250000 0.00000 +1.00000 0.250000 0.00000 +0.500000 0.250000 0.00000 +0.750000 0.250000 0.00000 +0.500000 0.500000 0.00000 +0.750000 0.500000 0.00000 +0.750000 0.250000 0.00000 +1.00000 0.250000 0.00000 +0.750000 0.500000 0.00000 +1.00000 0.500000 0.00000 +0.00000 0.500000 0.00000 +0.250000 0.500000 0.00000 +0.00000 0.750000 0.00000 +0.250000 0.750000 0.00000 +0.250000 0.500000 0.00000 +0.500000 0.500000 0.00000 +0.250000 0.750000 0.00000 +0.500000 0.750000 0.00000 +0.00000 0.750000 0.00000 +0.250000 0.750000 0.00000 +0.00000 1.00000 0.00000 +0.250000 1.00000 0.00000 +0.250000 0.750000 0.00000 +0.500000 0.750000 0.00000 +0.250000 1.00000 0.00000 +0.500000 1.00000 0.00000 +0.500000 0.500000 0.00000 +0.750000 0.500000 0.00000 +0.500000 0.750000 0.00000 +0.750000 0.750000 0.00000 +0.750000 0.500000 0.00000 +1.00000 0.500000 0.00000 +0.750000 0.750000 0.00000 +1.00000 0.750000 0.00000 +0.500000 0.750000 0.00000 +0.750000 0.750000 0.00000 +0.500000 1.00000 0.00000 +0.750000 1.00000 0.00000 +0.750000 0.750000 0.00000 +1.00000 0.750000 0.00000 +0.750000 1.00000 0.00000 +1.00000 1.00000 0.00000 + +CELLS 64 320 +4 0 1 3 2 +4 4 5 7 6 +4 8 9 11 10 +4 12 13 15 14 +4 16 17 19 18 +4 20 21 23 22 +4 24 25 27 26 +4 28 29 31 30 +4 32 33 35 34 +4 36 37 39 38 +4 40 41 43 42 +4 44 45 47 46 +4 48 49 51 50 +4 52 53 55 54 +4 56 57 59 58 +4 60 61 63 62 +4 64 65 67 66 +4 68 69 71 70 +4 72 73 75 74 +4 76 77 79 78 +4 80 81 83 82 +4 84 85 87 86 +4 88 89 91 90 +4 92 93 95 94 +4 96 97 99 98 +4 100 101 103 102 +4 104 105 107 106 +4 108 109 111 110 +4 112 113 115 114 +4 116 117 119 118 +4 120 121 123 122 +4 124 125 127 126 +4 128 129 131 130 +4 132 133 135 134 +4 136 137 139 138 +4 140 141 143 142 +4 144 145 147 146 +4 148 149 151 150 +4 152 153 155 154 +4 156 157 159 158 +4 160 161 163 162 +4 164 165 167 166 +4 168 169 171 170 +4 172 173 175 174 +4 176 177 179 178 +4 180 181 183 182 +4 184 185 187 186 +4 188 189 191 190 +4 192 193 195 194 +4 196 197 199 198 +4 200 201 203 202 +4 204 205 207 206 +4 208 209 211 210 +4 212 213 215 214 +4 216 217 219 218 +4 220 221 223 222 +4 224 225 227 226 +4 228 229 231 230 +4 232 233 235 234 +4 236 237 239 238 +4 240 241 243 242 +4 244 245 247 246 +4 248 249 251 250 +4 252 253 255 254 + +CELL_TYPES 64 + 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 +POINT_DATA 256 +SCALARS solution_0_0 double 1 +LOOKUP_TABLE default +-1.00000 -0.750000 -1.00000 -0.750000 -0.750000 -0.500000 -0.750000 -0.500000 -1.00000 -0.750000 -1.00000 -0.750000 -0.750000 -0.500000 -0.750000 -0.500000 -0.500000 -0.250000 -0.500000 -0.250000 -0.250000 0.00000 -0.250000 0.00000 -0.500000 -0.250000 -0.500000 -0.250000 -0.250000 0.00000 -0.250000 0.00000 -1.00000 -0.750000 -1.00000 -0.750000 -0.750000 -0.500000 -0.750000 -0.500000 -1.00000 -0.750000 -1.00000 -0.750000 -0.750000 -0.500000 -0.750000 -0.500000 -0.500000 -0.250000 -0.500000 -0.250000 -0.250000 0.00000 -0.250000 0.00000 -0.500000 -0.250000 -0.500000 -0.250000 -0.250000 0.00000 -0.250000 0.00000 0.00000 0.250000 0.00000 0.250000 0.250000 0.500000 0.250000 0.500000 0.00000 0.250000 0.00000 0.250000 0.250000 0.500000 0.250000 0.500000 0.500000 0.750000 0.500000 0.750000 0.750000 1.00000 0.750000 1.00000 0.500000 0.750000 0.500000 0.750000 0.750000 1.00000 0.750000 1.00000 0.00000 0.250000 0.00000 0.250000 0.250000 0.500000 0.250000 0.500000 0.00000 0.250000 0.00000 0.250000 0.250000 0.500000 0.250000 0.500000 0.500000 0.750000 0.500000 0.750000 0.750000 1.00000 0.750000 1.00000 0.500000 0.750000 0.500000 0.750000 0.750000 1.00000 0.750000 1.00000 -1.00000 -0.750000 -1.00000 -0.750000 -0.750000 -0.500000 -0.750000 -0.500000 -1.00000 -0.750000 -1.00000 -0.750000 -0.750000 -0.500000 -0.750000 -0.500000 -0.500000 -0.250000 -0.500000 -0.250000 -0.250000 0.00000 -0.250000 0.00000 -0.500000 -0.250000 -0.500000 -0.250000 -0.250000 0.00000 -0.250000 0.00000 -1.00000 -0.750000 -1.00000 -0.750000 -0.750000 -0.500000 -0.750000 -0.500000 -1.00000 -0.750000 -1.00000 -0.750000 -0.750000 -0.500000 -0.750000 -0.500000 -0.500000 -0.250000 -0.500000 -0.250000 -0.250000 0.00000 -0.250000 0.00000 -0.500000 -0.250000 -0.500000 -0.250000 -0.250000 0.00000 -0.250000 0.00000 0.00000 0.250000 0.00000 0.250000 0.250000 0.500000 0.250000 0.500000 0.00000 0.250000 0.00000 0.250000 0.250000 0.500000 0.250000 0.500000 0.500000 0.750000 0.500000 0.750000 0.750000 1.00000 0.750000 1.00000 0.500000 0.750000 0.500000 0.750000 0.750000 1.00000 0.750000 1.00000 0.00000 0.250000 0.00000 0.250000 0.250000 0.500000 0.250000 0.500000 0.00000 0.250000 0.00000 0.250000 0.250000 0.500000 0.250000 0.500000 0.500000 0.750000 0.500000 0.750000 0.750000 1.00000 0.750000 1.00000 0.500000 0.750000 0.500000 0.750000 0.750000 1.00000 0.750000 1.00000 +SCALARS solution_0_1 double 1 +LOOKUP_TABLE default +-1.00000 -1.00000 -0.500000 -0.500000 -1.00000 -1.00000 -0.500000 -0.500000 -0.500000 -0.500000 0.00000 0.00000 -0.500000 -0.500000 0.00000 0.00000 -1.00000 -1.00000 -0.500000 -0.500000 -1.00000 -1.00000 -0.500000 -0.500000 -0.500000 -0.500000 0.00000 0.00000 -0.500000 -0.500000 0.00000 0.00000 0.00000 0.00000 0.500000 0.500000 0.00000 0.00000 0.500000 0.500000 0.500000 0.500000 1.00000 1.00000 0.500000 0.500000 1.00000 1.00000 0.00000 0.00000 0.500000 0.500000 0.00000 0.00000 0.500000 0.500000 0.500000 0.500000 1.00000 1.00000 0.500000 0.500000 1.00000 1.00000 -1.00000 -1.00000 -0.500000 -0.500000 -1.00000 -1.00000 -0.500000 -0.500000 -0.500000 -0.500000 0.00000 0.00000 -0.500000 -0.500000 0.00000 0.00000 -1.00000 -1.00000 -0.500000 -0.500000 -1.00000 -1.00000 -0.500000 -0.500000 -0.500000 -0.500000 0.00000 0.00000 -0.500000 -0.500000 0.00000 0.00000 0.00000 0.00000 0.500000 0.500000 0.00000 0.00000 0.500000 0.500000 0.500000 0.500000 1.00000 1.00000 0.500000 0.500000 1.00000 1.00000 0.00000 0.00000 0.500000 0.500000 0.00000 0.00000 0.500000 0.500000 0.500000 0.500000 1.00000 1.00000 0.500000 0.500000 1.00000 1.00000 1.00000 1.00000 1.50000 1.50000 1.00000 1.00000 1.50000 1.50000 1.50000 1.50000 2.00000 2.00000 1.50000 1.50000 2.00000 2.00000 1.00000 1.00000 1.50000 1.50000 1.00000 1.00000 1.50000 1.50000 1.50000 1.50000 2.00000 2.00000 1.50000 1.50000 2.00000 2.00000 2.00000 2.00000 2.50000 2.50000 2.00000 2.00000 2.50000 2.50000 2.50000 2.50000 3.00000 3.00000 2.50000 2.50000 3.00000 3.00000 2.00000 2.00000 2.50000 2.50000 2.00000 2.00000 2.50000 2.50000 2.50000 2.50000 3.00000 3.00000 2.50000 2.50000 3.00000 3.00000 1.00000 1.00000 1.50000 1.50000 1.00000 1.00000 1.50000 1.50000 1.50000 1.50000 2.00000 2.00000 1.50000 1.50000 2.00000 2.00000 1.00000 1.00000 1.50000 1.50000 1.00000 1.00000 1.50000 1.50000 1.50000 1.50000 2.00000 2.00000 1.50000 1.50000 2.00000 2.00000 2.00000 2.00000 2.50000 2.50000 2.00000 2.00000 2.50000 2.50000 2.50000 2.50000 3.00000 3.00000 2.50000 2.50000 3.00000 3.00000 2.00000 2.00000 2.50000 2.50000 2.00000 2.00000 2.50000 2.50000 2.50000 2.50000 3.00000 3.00000 2.50000 2.50000 3.00000 3.00000 +SCALARS solution_0_2 double 1 +LOOKUP_TABLE default +2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 +SCALARS solution_1_0 double 1 +LOOKUP_TABLE default +-1.00000 -0.750000 -1.00000 -0.750000 -0.750000 -0.500000 -0.750000 -0.500000 -1.00000 -0.750000 -1.00000 -0.750000 -0.750000 -0.500000 -0.750000 -0.500000 -0.500000 -0.250000 -0.500000 -0.250000 -0.250000 0.00000 -0.250000 0.00000 -0.500000 -0.250000 -0.500000 -0.250000 -0.250000 0.00000 -0.250000 0.00000 -1.00000 -0.750000 -1.00000 -0.750000 -0.750000 -0.500000 -0.750000 -0.500000 -1.00000 -0.750000 -1.00000 -0.750000 -0.750000 -0.500000 -0.750000 -0.500000 -0.500000 -0.250000 -0.500000 -0.250000 -0.250000 0.00000 -0.250000 0.00000 -0.500000 -0.250000 -0.500000 -0.250000 -0.250000 0.00000 -0.250000 0.00000 0.00000 0.250000 0.00000 0.250000 0.250000 0.500000 0.250000 0.500000 0.00000 0.250000 0.00000 0.250000 0.250000 0.500000 0.250000 0.500000 0.500000 0.750000 0.500000 0.750000 0.750000 1.00000 0.750000 1.00000 0.500000 0.750000 0.500000 0.750000 0.750000 1.00000 0.750000 1.00000 0.00000 0.250000 0.00000 0.250000 0.250000 0.500000 0.250000 0.500000 0.00000 0.250000 0.00000 0.250000 0.250000 0.500000 0.250000 0.500000 0.500000 0.750000 0.500000 0.750000 0.750000 1.00000 0.750000 1.00000 0.500000 0.750000 0.500000 0.750000 0.750000 1.00000 0.750000 1.00000 -1.00000 -0.750000 -1.00000 -0.750000 -0.750000 -0.500000 -0.750000 -0.500000 -1.00000 -0.750000 -1.00000 -0.750000 -0.750000 -0.500000 -0.750000 -0.500000 -0.500000 -0.250000 -0.500000 -0.250000 -0.250000 0.00000 -0.250000 0.00000 -0.500000 -0.250000 -0.500000 -0.250000 -0.250000 0.00000 -0.250000 0.00000 -1.00000 -0.750000 -1.00000 -0.750000 -0.750000 -0.500000 -0.750000 -0.500000 -1.00000 -0.750000 -1.00000 -0.750000 -0.750000 -0.500000 -0.750000 -0.500000 -0.500000 -0.250000 -0.500000 -0.250000 -0.250000 0.00000 -0.250000 0.00000 -0.500000 -0.250000 -0.500000 -0.250000 -0.250000 0.00000 -0.250000 0.00000 0.00000 0.250000 0.00000 0.250000 0.250000 0.500000 0.250000 0.500000 0.00000 0.250000 0.00000 0.250000 0.250000 0.500000 0.250000 0.500000 0.500000 0.750000 0.500000 0.750000 0.750000 1.00000 0.750000 1.00000 0.500000 0.750000 0.500000 0.750000 0.750000 1.00000 0.750000 1.00000 0.00000 0.250000 0.00000 0.250000 0.250000 0.500000 0.250000 0.500000 0.00000 0.250000 0.00000 0.250000 0.250000 0.500000 0.250000 0.500000 0.500000 0.750000 0.500000 0.750000 0.750000 1.00000 0.750000 1.00000 0.500000 0.750000 0.500000 0.750000 0.750000 1.00000 0.750000 1.00000 +SCALARS solution_1_1 double 1 +LOOKUP_TABLE default +-1.00000 -1.00000 -0.500000 -0.500000 -1.00000 -1.00000 -0.500000 -0.500000 -0.500000 -0.500000 0.00000 0.00000 -0.500000 -0.500000 0.00000 0.00000 -1.00000 -1.00000 -0.500000 -0.500000 -1.00000 -1.00000 -0.500000 -0.500000 -0.500000 -0.500000 0.00000 0.00000 -0.500000 -0.500000 0.00000 0.00000 0.00000 0.00000 0.500000 0.500000 0.00000 0.00000 0.500000 0.500000 0.500000 0.500000 1.00000 1.00000 0.500000 0.500000 1.00000 1.00000 0.00000 0.00000 0.500000 0.500000 0.00000 0.00000 0.500000 0.500000 0.500000 0.500000 1.00000 1.00000 0.500000 0.500000 1.00000 1.00000 -1.00000 -1.00000 -0.500000 -0.500000 -1.00000 -1.00000 -0.500000 -0.500000 -0.500000 -0.500000 0.00000 0.00000 -0.500000 -0.500000 0.00000 0.00000 -1.00000 -1.00000 -0.500000 -0.500000 -1.00000 -1.00000 -0.500000 -0.500000 -0.500000 -0.500000 0.00000 0.00000 -0.500000 -0.500000 0.00000 0.00000 0.00000 0.00000 0.500000 0.500000 0.00000 0.00000 0.500000 0.500000 0.500000 0.500000 1.00000 1.00000 0.500000 0.500000 1.00000 1.00000 0.00000 0.00000 0.500000 0.500000 0.00000 0.00000 0.500000 0.500000 0.500000 0.500000 1.00000 1.00000 0.500000 0.500000 1.00000 1.00000 1.00000 1.00000 1.50000 1.50000 1.00000 1.00000 1.50000 1.50000 1.50000 1.50000 2.00000 2.00000 1.50000 1.50000 2.00000 2.00000 1.00000 1.00000 1.50000 1.50000 1.00000 1.00000 1.50000 1.50000 1.50000 1.50000 2.00000 2.00000 1.50000 1.50000 2.00000 2.00000 2.00000 2.00000 2.50000 2.50000 2.00000 2.00000 2.50000 2.50000 2.50000 2.50000 3.00000 3.00000 2.50000 2.50000 3.00000 3.00000 2.00000 2.00000 2.50000 2.50000 2.00000 2.00000 2.50000 2.50000 2.50000 2.50000 3.00000 3.00000 2.50000 2.50000 3.00000 3.00000 1.00000 1.00000 1.50000 1.50000 1.00000 1.00000 1.50000 1.50000 1.50000 1.50000 2.00000 2.00000 1.50000 1.50000 2.00000 2.00000 1.00000 1.00000 1.50000 1.50000 1.00000 1.00000 1.50000 1.50000 1.50000 1.50000 2.00000 2.00000 1.50000 1.50000 2.00000 2.00000 2.00000 2.00000 2.50000 2.50000 2.00000 2.00000 2.50000 2.50000 2.50000 2.50000 3.00000 3.00000 2.50000 2.50000 3.00000 3.00000 2.00000 2.00000 2.50000 2.50000 2.00000 2.00000 2.50000 2.50000 2.50000 2.50000 3.00000 3.00000 2.50000 2.50000 3.00000 3.00000 +SCALARS solution_1_2 double 1 +LOOKUP_TABLE default +2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 diff --git a/tests/remote_point_evaluation/data_out_resample_02.with_p4est=true.mpirun=4.output b/tests/remote_point_evaluation/data_out_resample_02.with_p4est=true.mpirun=4.output new file mode 100644 index 0000000000..aae28fc81f --- /dev/null +++ b/tests/remote_point_evaluation/data_out_resample_02.with_p4est=true.mpirun=4.output @@ -0,0 +1,447 @@ + +# vtk DataFile Version 3.0 +#This file was generated +ASCII +DATASET UNSTRUCTURED_GRID + +POINTS 64 double +-1.00000 -1.00000 0.00000 +-0.750000 -1.00000 0.00000 +-1.00000 -0.750000 0.00000 +-0.750000 -0.750000 0.00000 +-0.750000 -1.00000 0.00000 +-0.500000 -1.00000 0.00000 +-0.750000 -0.750000 0.00000 +-0.500000 -0.750000 0.00000 +-1.00000 -0.750000 0.00000 +-0.750000 -0.750000 0.00000 +-1.00000 -0.500000 0.00000 +-0.750000 -0.500000 0.00000 +-0.750000 -0.750000 0.00000 +-0.500000 -0.750000 0.00000 +-0.750000 -0.500000 0.00000 +-0.500000 -0.500000 0.00000 +-0.500000 -1.00000 0.00000 +-0.250000 -1.00000 0.00000 +-0.500000 -0.750000 0.00000 +-0.250000 -0.750000 0.00000 +-0.250000 -1.00000 0.00000 +0.00000 -1.00000 0.00000 +-0.250000 -0.750000 0.00000 +0.00000 -0.750000 0.00000 +-0.500000 -0.750000 0.00000 +-0.250000 -0.750000 0.00000 +-0.500000 -0.500000 0.00000 +-0.250000 -0.500000 0.00000 +-0.250000 -0.750000 0.00000 +0.00000 -0.750000 0.00000 +-0.250000 -0.500000 0.00000 +0.00000 -0.500000 0.00000 +-1.00000 -0.500000 0.00000 +-0.750000 -0.500000 0.00000 +-1.00000 -0.250000 0.00000 +-0.750000 -0.250000 0.00000 +-0.750000 -0.500000 0.00000 +-0.500000 -0.500000 0.00000 +-0.750000 -0.250000 0.00000 +-0.500000 -0.250000 0.00000 +-1.00000 -0.250000 0.00000 +-0.750000 -0.250000 0.00000 +-1.00000 0.00000 0.00000 +-0.750000 0.00000 0.00000 +-0.750000 -0.250000 0.00000 +-0.500000 -0.250000 0.00000 +-0.750000 0.00000 0.00000 +-0.500000 0.00000 0.00000 +-0.500000 -0.500000 0.00000 +-0.250000 -0.500000 0.00000 +-0.500000 -0.250000 0.00000 +-0.250000 -0.250000 0.00000 +-0.250000 -0.500000 0.00000 +0.00000 -0.500000 0.00000 +-0.250000 -0.250000 0.00000 +0.00000 -0.250000 0.00000 +-0.500000 -0.250000 0.00000 +-0.250000 -0.250000 0.00000 +-0.500000 0.00000 0.00000 +-0.250000 0.00000 0.00000 +-0.250000 -0.250000 0.00000 +0.00000 -0.250000 0.00000 +-0.250000 0.00000 0.00000 +0.00000 0.00000 0.00000 + +CELLS 16 80 +4 0 1 3 2 +4 4 5 7 6 +4 8 9 11 10 +4 12 13 15 14 +4 16 17 19 18 +4 20 21 23 22 +4 24 25 27 26 +4 28 29 31 30 +4 32 33 35 34 +4 36 37 39 38 +4 40 41 43 42 +4 44 45 47 46 +4 48 49 51 50 +4 52 53 55 54 +4 56 57 59 58 +4 60 61 63 62 + +CELL_TYPES 16 + 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 +POINT_DATA 64 +SCALARS solution_0_0 double 1 +LOOKUP_TABLE default +-1.00000 -0.750000 -1.00000 -0.750000 -0.750000 -0.500000 -0.750000 -0.500000 -1.00000 -0.750000 -1.00000 -0.750000 -0.750000 -0.500000 -0.750000 -0.500000 -0.500000 -0.250000 -0.500000 -0.250000 -0.250000 0.00000 -0.250000 0.00000 -0.500000 -0.250000 -0.500000 -0.250000 -0.250000 0.00000 -0.250000 0.00000 -1.00000 -0.750000 -1.00000 -0.750000 -0.750000 -0.500000 -0.750000 -0.500000 -1.00000 -0.750000 -1.00000 -0.750000 -0.750000 -0.500000 -0.750000 -0.500000 -0.500000 -0.250000 -0.500000 -0.250000 -0.250000 0.00000 -0.250000 0.00000 -0.500000 -0.250000 -0.500000 -0.250000 -0.250000 0.00000 -0.250000 0.00000 +SCALARS solution_0_1 double 1 +LOOKUP_TABLE default +-1.00000 -1.00000 -0.500000 -0.500000 -1.00000 -1.00000 -0.500000 -0.500000 -0.500000 -0.500000 0.00000 0.00000 -0.500000 -0.500000 0.00000 0.00000 -1.00000 -1.00000 -0.500000 -0.500000 -1.00000 -1.00000 -0.500000 -0.500000 -0.500000 -0.500000 0.00000 0.00000 -0.500000 -0.500000 0.00000 0.00000 0.00000 0.00000 0.500000 0.500000 0.00000 0.00000 0.500000 0.500000 0.500000 0.500000 1.00000 1.00000 0.500000 0.500000 1.00000 1.00000 0.00000 0.00000 0.500000 0.500000 0.00000 0.00000 0.500000 0.500000 0.500000 0.500000 1.00000 1.00000 0.500000 0.500000 1.00000 1.00000 +SCALARS solution_0_2 double 1 +LOOKUP_TABLE default +2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 +SCALARS solution_1_0 double 1 +LOOKUP_TABLE default +-1.00000 -0.750000 -1.00000 -0.750000 -0.750000 -0.500000 -0.750000 -0.500000 -1.00000 -0.750000 -1.00000 -0.750000 -0.750000 -0.500000 -0.750000 -0.500000 -0.500000 -0.250000 -0.500000 -0.250000 -0.250000 0.00000 -0.250000 0.00000 -0.500000 -0.250000 -0.500000 -0.250000 -0.250000 0.00000 -0.250000 0.00000 -1.00000 -0.750000 -1.00000 -0.750000 -0.750000 -0.500000 -0.750000 -0.500000 -1.00000 -0.750000 -1.00000 -0.750000 -0.750000 -0.500000 -0.750000 -0.500000 -0.500000 -0.250000 -0.500000 -0.250000 -0.250000 0.00000 -0.250000 0.00000 -0.500000 -0.250000 -0.500000 -0.250000 -0.250000 0.00000 -0.250000 0.00000 +SCALARS solution_1_1 double 1 +LOOKUP_TABLE default +-1.00000 -1.00000 -0.500000 -0.500000 -1.00000 -1.00000 -0.500000 -0.500000 -0.500000 -0.500000 0.00000 0.00000 -0.500000 -0.500000 0.00000 0.00000 -1.00000 -1.00000 -0.500000 -0.500000 -1.00000 -1.00000 -0.500000 -0.500000 -0.500000 -0.500000 0.00000 0.00000 -0.500000 -0.500000 0.00000 0.00000 0.00000 0.00000 0.500000 0.500000 0.00000 0.00000 0.500000 0.500000 0.500000 0.500000 1.00000 1.00000 0.500000 0.500000 1.00000 1.00000 0.00000 0.00000 0.500000 0.500000 0.00000 0.00000 0.500000 0.500000 0.500000 0.500000 1.00000 1.00000 0.500000 0.500000 1.00000 1.00000 +SCALARS solution_1_2 double 1 +LOOKUP_TABLE default +2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 + +# vtk DataFile Version 3.0 +#This file was generated +ASCII +DATASET UNSTRUCTURED_GRID + +POINTS 64 double +0.00000 -1.00000 0.00000 +0.250000 -1.00000 0.00000 +0.00000 -0.750000 0.00000 +0.250000 -0.750000 0.00000 +0.250000 -1.00000 0.00000 +0.500000 -1.00000 0.00000 +0.250000 -0.750000 0.00000 +0.500000 -0.750000 0.00000 +0.00000 -0.750000 0.00000 +0.250000 -0.750000 0.00000 +0.00000 -0.500000 0.00000 +0.250000 -0.500000 0.00000 +0.250000 -0.750000 0.00000 +0.500000 -0.750000 0.00000 +0.250000 -0.500000 0.00000 +0.500000 -0.500000 0.00000 +0.500000 -1.00000 0.00000 +0.750000 -1.00000 0.00000 +0.500000 -0.750000 0.00000 +0.750000 -0.750000 0.00000 +0.750000 -1.00000 0.00000 +1.00000 -1.00000 0.00000 +0.750000 -0.750000 0.00000 +1.00000 -0.750000 0.00000 +0.500000 -0.750000 0.00000 +0.750000 -0.750000 0.00000 +0.500000 -0.500000 0.00000 +0.750000 -0.500000 0.00000 +0.750000 -0.750000 0.00000 +1.00000 -0.750000 0.00000 +0.750000 -0.500000 0.00000 +1.00000 -0.500000 0.00000 +0.00000 -0.500000 0.00000 +0.250000 -0.500000 0.00000 +0.00000 -0.250000 0.00000 +0.250000 -0.250000 0.00000 +0.250000 -0.500000 0.00000 +0.500000 -0.500000 0.00000 +0.250000 -0.250000 0.00000 +0.500000 -0.250000 0.00000 +0.00000 -0.250000 0.00000 +0.250000 -0.250000 0.00000 +0.00000 0.00000 0.00000 +0.250000 0.00000 0.00000 +0.250000 -0.250000 0.00000 +0.500000 -0.250000 0.00000 +0.250000 0.00000 0.00000 +0.500000 0.00000 0.00000 +0.500000 -0.500000 0.00000 +0.750000 -0.500000 0.00000 +0.500000 -0.250000 0.00000 +0.750000 -0.250000 0.00000 +0.750000 -0.500000 0.00000 +1.00000 -0.500000 0.00000 +0.750000 -0.250000 0.00000 +1.00000 -0.250000 0.00000 +0.500000 -0.250000 0.00000 +0.750000 -0.250000 0.00000 +0.500000 0.00000 0.00000 +0.750000 0.00000 0.00000 +0.750000 -0.250000 0.00000 +1.00000 -0.250000 0.00000 +0.750000 0.00000 0.00000 +1.00000 0.00000 0.00000 + +CELLS 16 80 +4 0 1 3 2 +4 4 5 7 6 +4 8 9 11 10 +4 12 13 15 14 +4 16 17 19 18 +4 20 21 23 22 +4 24 25 27 26 +4 28 29 31 30 +4 32 33 35 34 +4 36 37 39 38 +4 40 41 43 42 +4 44 45 47 46 +4 48 49 51 50 +4 52 53 55 54 +4 56 57 59 58 +4 60 61 63 62 + +CELL_TYPES 16 + 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 +POINT_DATA 64 +SCALARS solution_0_0 double 1 +LOOKUP_TABLE default +0.00000 0.250000 0.00000 0.250000 0.250000 0.500000 0.250000 0.500000 0.00000 0.250000 0.00000 0.250000 0.250000 0.500000 0.250000 0.500000 0.500000 0.750000 0.500000 0.750000 0.750000 1.00000 0.750000 1.00000 0.500000 0.750000 0.500000 0.750000 0.750000 1.00000 0.750000 1.00000 0.00000 0.250000 0.00000 0.250000 0.250000 0.500000 0.250000 0.500000 0.00000 0.250000 0.00000 0.250000 0.250000 0.500000 0.250000 0.500000 0.500000 0.750000 0.500000 0.750000 0.750000 1.00000 0.750000 1.00000 0.500000 0.750000 0.500000 0.750000 0.750000 1.00000 0.750000 1.00000 +SCALARS solution_0_1 double 1 +LOOKUP_TABLE default +-1.00000 -1.00000 -0.500000 -0.500000 -1.00000 -1.00000 -0.500000 -0.500000 -0.500000 -0.500000 0.00000 0.00000 -0.500000 -0.500000 0.00000 0.00000 -1.00000 -1.00000 -0.500000 -0.500000 -1.00000 -1.00000 -0.500000 -0.500000 -0.500000 -0.500000 0.00000 0.00000 -0.500000 -0.500000 0.00000 0.00000 0.00000 0.00000 0.500000 0.500000 0.00000 0.00000 0.500000 0.500000 0.500000 0.500000 1.00000 1.00000 0.500000 0.500000 1.00000 1.00000 0.00000 0.00000 0.500000 0.500000 0.00000 0.00000 0.500000 0.500000 0.500000 0.500000 1.00000 1.00000 0.500000 0.500000 1.00000 1.00000 +SCALARS solution_0_2 double 1 +LOOKUP_TABLE default +2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 +SCALARS solution_1_0 double 1 +LOOKUP_TABLE default +0.00000 0.250000 0.00000 0.250000 0.250000 0.500000 0.250000 0.500000 0.00000 0.250000 0.00000 0.250000 0.250000 0.500000 0.250000 0.500000 0.500000 0.750000 0.500000 0.750000 0.750000 1.00000 0.750000 1.00000 0.500000 0.750000 0.500000 0.750000 0.750000 1.00000 0.750000 1.00000 0.00000 0.250000 0.00000 0.250000 0.250000 0.500000 0.250000 0.500000 0.00000 0.250000 0.00000 0.250000 0.250000 0.500000 0.250000 0.500000 0.500000 0.750000 0.500000 0.750000 0.750000 1.00000 0.750000 1.00000 0.500000 0.750000 0.500000 0.750000 0.750000 1.00000 0.750000 1.00000 +SCALARS solution_1_1 double 1 +LOOKUP_TABLE default +-1.00000 -1.00000 -0.500000 -0.500000 -1.00000 -1.00000 -0.500000 -0.500000 -0.500000 -0.500000 0.00000 0.00000 -0.500000 -0.500000 0.00000 0.00000 -1.00000 -1.00000 -0.500000 -0.500000 -1.00000 -1.00000 -0.500000 -0.500000 -0.500000 -0.500000 0.00000 0.00000 -0.500000 -0.500000 0.00000 0.00000 0.00000 0.00000 0.500000 0.500000 0.00000 0.00000 0.500000 0.500000 0.500000 0.500000 1.00000 1.00000 0.500000 0.500000 1.00000 1.00000 0.00000 0.00000 0.500000 0.500000 0.00000 0.00000 0.500000 0.500000 0.500000 0.500000 1.00000 1.00000 0.500000 0.500000 1.00000 1.00000 +SCALARS solution_1_2 double 1 +LOOKUP_TABLE default +2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 + + +# vtk DataFile Version 3.0 +#This file was generated +ASCII +DATASET UNSTRUCTURED_GRID + +POINTS 64 double +-1.00000 0.00000 0.00000 +-0.750000 0.00000 0.00000 +-1.00000 0.250000 0.00000 +-0.750000 0.250000 0.00000 +-0.750000 0.00000 0.00000 +-0.500000 0.00000 0.00000 +-0.750000 0.250000 0.00000 +-0.500000 0.250000 0.00000 +-1.00000 0.250000 0.00000 +-0.750000 0.250000 0.00000 +-1.00000 0.500000 0.00000 +-0.750000 0.500000 0.00000 +-0.750000 0.250000 0.00000 +-0.500000 0.250000 0.00000 +-0.750000 0.500000 0.00000 +-0.500000 0.500000 0.00000 +-0.500000 0.00000 0.00000 +-0.250000 0.00000 0.00000 +-0.500000 0.250000 0.00000 +-0.250000 0.250000 0.00000 +-0.250000 0.00000 0.00000 +0.00000 0.00000 0.00000 +-0.250000 0.250000 0.00000 +0.00000 0.250000 0.00000 +-0.500000 0.250000 0.00000 +-0.250000 0.250000 0.00000 +-0.500000 0.500000 0.00000 +-0.250000 0.500000 0.00000 +-0.250000 0.250000 0.00000 +0.00000 0.250000 0.00000 +-0.250000 0.500000 0.00000 +0.00000 0.500000 0.00000 +-1.00000 0.500000 0.00000 +-0.750000 0.500000 0.00000 +-1.00000 0.750000 0.00000 +-0.750000 0.750000 0.00000 +-0.750000 0.500000 0.00000 +-0.500000 0.500000 0.00000 +-0.750000 0.750000 0.00000 +-0.500000 0.750000 0.00000 +-1.00000 0.750000 0.00000 +-0.750000 0.750000 0.00000 +-1.00000 1.00000 0.00000 +-0.750000 1.00000 0.00000 +-0.750000 0.750000 0.00000 +-0.500000 0.750000 0.00000 +-0.750000 1.00000 0.00000 +-0.500000 1.00000 0.00000 +-0.500000 0.500000 0.00000 +-0.250000 0.500000 0.00000 +-0.500000 0.750000 0.00000 +-0.250000 0.750000 0.00000 +-0.250000 0.500000 0.00000 +0.00000 0.500000 0.00000 +-0.250000 0.750000 0.00000 +0.00000 0.750000 0.00000 +-0.500000 0.750000 0.00000 +-0.250000 0.750000 0.00000 +-0.500000 1.00000 0.00000 +-0.250000 1.00000 0.00000 +-0.250000 0.750000 0.00000 +0.00000 0.750000 0.00000 +-0.250000 1.00000 0.00000 +0.00000 1.00000 0.00000 + +CELLS 16 80 +4 0 1 3 2 +4 4 5 7 6 +4 8 9 11 10 +4 12 13 15 14 +4 16 17 19 18 +4 20 21 23 22 +4 24 25 27 26 +4 28 29 31 30 +4 32 33 35 34 +4 36 37 39 38 +4 40 41 43 42 +4 44 45 47 46 +4 48 49 51 50 +4 52 53 55 54 +4 56 57 59 58 +4 60 61 63 62 + +CELL_TYPES 16 + 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 +POINT_DATA 64 +SCALARS solution_0_0 double 1 +LOOKUP_TABLE default +-1.00000 -0.750000 -1.00000 -0.750000 -0.750000 -0.500000 -0.750000 -0.500000 -1.00000 -0.750000 -1.00000 -0.750000 -0.750000 -0.500000 -0.750000 -0.500000 -0.500000 -0.250000 -0.500000 -0.250000 -0.250000 0.00000 -0.250000 0.00000 -0.500000 -0.250000 -0.500000 -0.250000 -0.250000 0.00000 -0.250000 0.00000 -1.00000 -0.750000 -1.00000 -0.750000 -0.750000 -0.500000 -0.750000 -0.500000 -1.00000 -0.750000 -1.00000 -0.750000 -0.750000 -0.500000 -0.750000 -0.500000 -0.500000 -0.250000 -0.500000 -0.250000 -0.250000 0.00000 -0.250000 0.00000 -0.500000 -0.250000 -0.500000 -0.250000 -0.250000 0.00000 -0.250000 0.00000 +SCALARS solution_0_1 double 1 +LOOKUP_TABLE default +1.00000 1.00000 1.50000 1.50000 1.00000 1.00000 1.50000 1.50000 1.50000 1.50000 2.00000 2.00000 1.50000 1.50000 2.00000 2.00000 1.00000 1.00000 1.50000 1.50000 1.00000 1.00000 1.50000 1.50000 1.50000 1.50000 2.00000 2.00000 1.50000 1.50000 2.00000 2.00000 2.00000 2.00000 2.50000 2.50000 2.00000 2.00000 2.50000 2.50000 2.50000 2.50000 3.00000 3.00000 2.50000 2.50000 3.00000 3.00000 2.00000 2.00000 2.50000 2.50000 2.00000 2.00000 2.50000 2.50000 2.50000 2.50000 3.00000 3.00000 2.50000 2.50000 3.00000 3.00000 +SCALARS solution_0_2 double 1 +LOOKUP_TABLE default +2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 +SCALARS solution_1_0 double 1 +LOOKUP_TABLE default +-1.00000 -0.750000 -1.00000 -0.750000 -0.750000 -0.500000 -0.750000 -0.500000 -1.00000 -0.750000 -1.00000 -0.750000 -0.750000 -0.500000 -0.750000 -0.500000 -0.500000 -0.250000 -0.500000 -0.250000 -0.250000 0.00000 -0.250000 0.00000 -0.500000 -0.250000 -0.500000 -0.250000 -0.250000 0.00000 -0.250000 0.00000 -1.00000 -0.750000 -1.00000 -0.750000 -0.750000 -0.500000 -0.750000 -0.500000 -1.00000 -0.750000 -1.00000 -0.750000 -0.750000 -0.500000 -0.750000 -0.500000 -0.500000 -0.250000 -0.500000 -0.250000 -0.250000 0.00000 -0.250000 0.00000 -0.500000 -0.250000 -0.500000 -0.250000 -0.250000 0.00000 -0.250000 0.00000 +SCALARS solution_1_1 double 1 +LOOKUP_TABLE default +1.00000 1.00000 1.50000 1.50000 1.00000 1.00000 1.50000 1.50000 1.50000 1.50000 2.00000 2.00000 1.50000 1.50000 2.00000 2.00000 1.00000 1.00000 1.50000 1.50000 1.00000 1.00000 1.50000 1.50000 1.50000 1.50000 2.00000 2.00000 1.50000 1.50000 2.00000 2.00000 2.00000 2.00000 2.50000 2.50000 2.00000 2.00000 2.50000 2.50000 2.50000 2.50000 3.00000 3.00000 2.50000 2.50000 3.00000 3.00000 2.00000 2.00000 2.50000 2.50000 2.00000 2.00000 2.50000 2.50000 2.50000 2.50000 3.00000 3.00000 2.50000 2.50000 3.00000 3.00000 +SCALARS solution_1_2 double 1 +LOOKUP_TABLE default +2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 + + +# vtk DataFile Version 3.0 +#This file was generated +ASCII +DATASET UNSTRUCTURED_GRID + +POINTS 64 double +0.00000 0.00000 0.00000 +0.250000 0.00000 0.00000 +0.00000 0.250000 0.00000 +0.250000 0.250000 0.00000 +0.250000 0.00000 0.00000 +0.500000 0.00000 0.00000 +0.250000 0.250000 0.00000 +0.500000 0.250000 0.00000 +0.00000 0.250000 0.00000 +0.250000 0.250000 0.00000 +0.00000 0.500000 0.00000 +0.250000 0.500000 0.00000 +0.250000 0.250000 0.00000 +0.500000 0.250000 0.00000 +0.250000 0.500000 0.00000 +0.500000 0.500000 0.00000 +0.500000 0.00000 0.00000 +0.750000 0.00000 0.00000 +0.500000 0.250000 0.00000 +0.750000 0.250000 0.00000 +0.750000 0.00000 0.00000 +1.00000 0.00000 0.00000 +0.750000 0.250000 0.00000 +1.00000 0.250000 0.00000 +0.500000 0.250000 0.00000 +0.750000 0.250000 0.00000 +0.500000 0.500000 0.00000 +0.750000 0.500000 0.00000 +0.750000 0.250000 0.00000 +1.00000 0.250000 0.00000 +0.750000 0.500000 0.00000 +1.00000 0.500000 0.00000 +0.00000 0.500000 0.00000 +0.250000 0.500000 0.00000 +0.00000 0.750000 0.00000 +0.250000 0.750000 0.00000 +0.250000 0.500000 0.00000 +0.500000 0.500000 0.00000 +0.250000 0.750000 0.00000 +0.500000 0.750000 0.00000 +0.00000 0.750000 0.00000 +0.250000 0.750000 0.00000 +0.00000 1.00000 0.00000 +0.250000 1.00000 0.00000 +0.250000 0.750000 0.00000 +0.500000 0.750000 0.00000 +0.250000 1.00000 0.00000 +0.500000 1.00000 0.00000 +0.500000 0.500000 0.00000 +0.750000 0.500000 0.00000 +0.500000 0.750000 0.00000 +0.750000 0.750000 0.00000 +0.750000 0.500000 0.00000 +1.00000 0.500000 0.00000 +0.750000 0.750000 0.00000 +1.00000 0.750000 0.00000 +0.500000 0.750000 0.00000 +0.750000 0.750000 0.00000 +0.500000 1.00000 0.00000 +0.750000 1.00000 0.00000 +0.750000 0.750000 0.00000 +1.00000 0.750000 0.00000 +0.750000 1.00000 0.00000 +1.00000 1.00000 0.00000 + +CELLS 16 80 +4 0 1 3 2 +4 4 5 7 6 +4 8 9 11 10 +4 12 13 15 14 +4 16 17 19 18 +4 20 21 23 22 +4 24 25 27 26 +4 28 29 31 30 +4 32 33 35 34 +4 36 37 39 38 +4 40 41 43 42 +4 44 45 47 46 +4 48 49 51 50 +4 52 53 55 54 +4 56 57 59 58 +4 60 61 63 62 + +CELL_TYPES 16 + 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 9 +POINT_DATA 64 +SCALARS solution_0_0 double 1 +LOOKUP_TABLE default +0.00000 0.250000 0.00000 0.250000 0.250000 0.500000 0.250000 0.500000 0.00000 0.250000 0.00000 0.250000 0.250000 0.500000 0.250000 0.500000 0.500000 0.750000 0.500000 0.750000 0.750000 1.00000 0.750000 1.00000 0.500000 0.750000 0.500000 0.750000 0.750000 1.00000 0.750000 1.00000 0.00000 0.250000 0.00000 0.250000 0.250000 0.500000 0.250000 0.500000 0.00000 0.250000 0.00000 0.250000 0.250000 0.500000 0.250000 0.500000 0.500000 0.750000 0.500000 0.750000 0.750000 1.00000 0.750000 1.00000 0.500000 0.750000 0.500000 0.750000 0.750000 1.00000 0.750000 1.00000 +SCALARS solution_0_1 double 1 +LOOKUP_TABLE default +1.00000 1.00000 1.50000 1.50000 1.00000 1.00000 1.50000 1.50000 1.50000 1.50000 2.00000 2.00000 1.50000 1.50000 2.00000 2.00000 1.00000 1.00000 1.50000 1.50000 1.00000 1.00000 1.50000 1.50000 1.50000 1.50000 2.00000 2.00000 1.50000 1.50000 2.00000 2.00000 2.00000 2.00000 2.50000 2.50000 2.00000 2.00000 2.50000 2.50000 2.50000 2.50000 3.00000 3.00000 2.50000 2.50000 3.00000 3.00000 2.00000 2.00000 2.50000 2.50000 2.00000 2.00000 2.50000 2.50000 2.50000 2.50000 3.00000 3.00000 2.50000 2.50000 3.00000 3.00000 +SCALARS solution_0_2 double 1 +LOOKUP_TABLE default +2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 +SCALARS solution_1_0 double 1 +LOOKUP_TABLE default +0.00000 0.250000 0.00000 0.250000 0.250000 0.500000 0.250000 0.500000 0.00000 0.250000 0.00000 0.250000 0.250000 0.500000 0.250000 0.500000 0.500000 0.750000 0.500000 0.750000 0.750000 1.00000 0.750000 1.00000 0.500000 0.750000 0.500000 0.750000 0.750000 1.00000 0.750000 1.00000 0.00000 0.250000 0.00000 0.250000 0.250000 0.500000 0.250000 0.500000 0.00000 0.250000 0.00000 0.250000 0.250000 0.500000 0.250000 0.500000 0.500000 0.750000 0.500000 0.750000 0.750000 1.00000 0.750000 1.00000 0.500000 0.750000 0.500000 0.750000 0.750000 1.00000 0.750000 1.00000 +SCALARS solution_1_1 double 1 +LOOKUP_TABLE default +1.00000 1.00000 1.50000 1.50000 1.00000 1.00000 1.50000 1.50000 1.50000 1.50000 2.00000 2.00000 1.50000 1.50000 2.00000 2.00000 1.00000 1.00000 1.50000 1.50000 1.00000 1.00000 1.50000 1.50000 1.50000 1.50000 2.00000 2.00000 1.50000 1.50000 2.00000 2.00000 2.00000 2.00000 2.50000 2.50000 2.00000 2.00000 2.50000 2.50000 2.50000 2.50000 3.00000 3.00000 2.50000 2.50000 3.00000 3.00000 2.00000 2.00000 2.50000 2.50000 2.00000 2.00000 2.50000 2.50000 2.50000 2.50000 3.00000 3.00000 2.50000 2.50000 3.00000 3.00000 +SCALARS solution_1_2 double 1 +LOOKUP_TABLE default +2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 2.00000 +