--- /dev/null
+// ---------------------------------------------------------------------
+//
+// Copyright (C) 2020 - 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 DataOut::write_gnuplot() for simplex meshes.
+
+#include <deal.II/base/quadrature_lib.h>
+
+#include <deal.II/dofs/dof_handler.h>
+
+#include <deal.II/fe/fe_pyramid_p.h>
+#include <deal.II/fe/fe_simplex_p.h>
+#include <deal.II/fe/fe_simplex_p_bubbles.h>
+#include <deal.II/fe/fe_system.h>
+#include <deal.II/fe/fe_wedge_p.h>
+#include <deal.II/fe/mapping_fe.h>
+
+#include <deal.II/grid/grid_generator.h>
+#include <deal.II/grid/grid_in.h>
+#include <deal.II/grid/grid_out.h>
+#include <deal.II/grid/tria.h>
+
+#include <deal.II/numerics/data_out.h>
+#include <deal.II/numerics/vector_tools.h>
+
+#include "../tests.h"
+
+using namespace dealii;
+
+template <int dim>
+class RightHandSideFunction : public Function<dim>
+{
+public:
+ RightHandSideFunction(const unsigned int n_components)
+ : Function<dim>(n_components)
+ {}
+
+ virtual double
+ value(const Point<dim> &p, const unsigned int component = 0) const
+ {
+ return p[component % dim] * p[component % dim];
+ }
+};
+
+template <int dim, int spacedim = dim>
+void
+test(const FiniteElement<dim, spacedim> &fe,
+ const unsigned int n_components,
+ const bool do_high_order)
+{
+ Triangulation<dim, spacedim> tria;
+ GridGenerator::subdivided_hyper_cube_with_simplices(tria, dim == 2 ? 4 : 2);
+
+ DoFHandler<dim> dof_handler(tria);
+
+ dof_handler.distribute_dofs(fe);
+
+ Vector<double> solution(dof_handler.n_dofs());
+
+ MappingFE<dim> mapping(FE_SimplexP<dim>(1));
+
+ AffineConstraints<double> dummy;
+ dummy.close();
+
+ VectorTools::project(mapping,
+ dof_handler,
+ dummy,
+ QGaussSimplex<dim>(fe.tensor_degree() + 1),
+ RightHandSideFunction<dim>(n_components),
+ solution);
+
+
+ DataOut<dim> data_out;
+
+ data_out.attach_dof_handler(dof_handler);
+ data_out.add_data_vector(solution, "solution");
+
+
+ data_out.build_patches(mapping, 1);
+
+#if false
+ static unsigned int counter = 0;
+ std::ofstream output("test." + std::to_string(dim) + "." +
+ std::to_string(counter++) + ".gnuplot");
+ data_out.write_gnuplot(output);
+#else
+ data_out.write_gnuplot(deallog.get_file_stream());
+#endif
+}
+
+int
+main()
+{
+ initlog();
+
+ for (unsigned int i = 0; i < 2; ++i)
+ {
+ const bool do_high_order = (i == 1);
+
+ if (do_high_order)
+ {
+ const unsigned int dim = 2;
+ test<dim>(FE_SimplexP<dim>(2) /*=degree*/, 1, do_high_order);
+ test<dim>(FESystem<dim>(FE_SimplexP<dim>(2 /*=degree*/), dim),
+ dim,
+ do_high_order);
+ test<dim>(FESystem<dim>(FE_SimplexP<dim>(2 /*=degree*/),
+ dim,
+ FE_SimplexP<dim>(1 /*=degree*/),
+ 1),
+ dim + 1,
+ do_high_order);
+ }
+
+ if (false)
+ if (do_high_order ==
+ false /*TODO: higher-order output not working for 3D*/)
+ {
+ const unsigned int dim = 3;
+ test<dim>(FE_SimplexP<dim>(2) /*=degree*/, 1, do_high_order);
+ test<dim>(FESystem<dim>(FE_SimplexP<dim>(2 /*=degree*/), dim),
+ dim,
+ do_high_order);
+ test<dim>(FESystem<dim>(FE_SimplexP<dim>(2 /*=degree*/),
+ dim,
+ FE_SimplexP<dim>(1 /*=degree*/),
+ 1),
+ dim + 1,
+ do_high_order);
+ }
+ }
+}
--- /dev/null
+
+# This file was generated by the deal.II library.
+
+
+#
+# For a description of the GNUPLOT format see the GNUPLOT manual.
+#
+# <x> <y> <solution>
+0.00000 0.00000 -2.48113e-12
+0.250000 0.00000 0.0625000
+
+0.00000 0.250000 -2.02496e-12
+0.00000 0.250000 -2.02496e-12
+
+
+
+0.250000 0.250000 0.0625000
+0.00000 0.250000 -2.02496e-12
+
+0.250000 0.00000 0.0625000
+0.250000 0.00000 0.0625000
+
+
+
+0.250000 0.00000 0.0625000
+0.500000 0.00000 0.250000
+
+0.250000 0.250000 0.0625000
+0.250000 0.250000 0.0625000
+
+
+
+0.500000 0.250000 0.250000
+0.250000 0.250000 0.0625000
+
+0.500000 0.00000 0.250000
+0.500000 0.00000 0.250000
+
+
+
+0.500000 0.00000 0.250000
+0.750000 0.00000 0.562500
+
+0.500000 0.250000 0.250000
+0.500000 0.250000 0.250000
+
+
+
+0.750000 0.250000 0.562500
+0.500000 0.250000 0.250000
+
+0.750000 0.00000 0.562500
+0.750000 0.00000 0.562500
+
+
+
+0.750000 0.00000 0.562500
+1.00000 0.00000 1.00000
+
+0.750000 0.250000 0.562500
+0.750000 0.250000 0.562500
+
+
+
+1.00000 0.250000 1.00000
+0.750000 0.250000 0.562500
+
+1.00000 0.00000 1.00000
+1.00000 0.00000 1.00000
+
+
+
+0.00000 0.250000 -2.02496e-12
+0.250000 0.250000 0.0625000
+
+0.00000 0.500000 1.65808e-13
+0.00000 0.500000 1.65808e-13
+
+
+
+0.250000 0.500000 0.0625000
+0.00000 0.500000 1.65808e-13
+
+0.250000 0.250000 0.0625000
+0.250000 0.250000 0.0625000
+
+
+
+0.250000 0.250000 0.0625000
+0.500000 0.250000 0.250000
+
+0.250000 0.500000 0.0625000
+0.250000 0.500000 0.0625000
+
+
+
+0.500000 0.500000 0.250000
+0.250000 0.500000 0.0625000
+
+0.500000 0.250000 0.250000
+0.500000 0.250000 0.250000
+
+
+
+0.500000 0.250000 0.250000
+0.750000 0.250000 0.562500
+
+0.500000 0.500000 0.250000
+0.500000 0.500000 0.250000
+
+
+
+0.750000 0.500000 0.562500
+0.500000 0.500000 0.250000
+
+0.750000 0.250000 0.562500
+0.750000 0.250000 0.562500
+
+
+
+0.750000 0.250000 0.562500
+1.00000 0.250000 1.00000
+
+0.750000 0.500000 0.562500
+0.750000 0.500000 0.562500
+
+
+
+1.00000 0.500000 1.00000
+0.750000 0.500000 0.562500
+
+1.00000 0.250000 1.00000
+1.00000 0.250000 1.00000
+
+
+
+0.00000 0.500000 1.65808e-13
+0.250000 0.500000 0.0625000
+
+0.00000 0.750000 8.67298e-13
+0.00000 0.750000 8.67298e-13
+
+
+
+0.250000 0.750000 0.0625000
+0.00000 0.750000 8.67298e-13
+
+0.250000 0.500000 0.0625000
+0.250000 0.500000 0.0625000
+
+
+
+0.250000 0.500000 0.0625000
+0.500000 0.500000 0.250000
+
+0.250000 0.750000 0.0625000
+0.250000 0.750000 0.0625000
+
+
+
+0.500000 0.750000 0.250000
+0.250000 0.750000 0.0625000
+
+0.500000 0.500000 0.250000
+0.500000 0.500000 0.250000
+
+
+
+0.500000 0.500000 0.250000
+0.750000 0.500000 0.562500
+
+0.500000 0.750000 0.250000
+0.500000 0.750000 0.250000
+
+
+
+0.750000 0.750000 0.562500
+0.500000 0.750000 0.250000
+
+0.750000 0.500000 0.562500
+0.750000 0.500000 0.562500
+
+
+
+0.750000 0.500000 0.562500
+1.00000 0.500000 1.00000
+
+0.750000 0.750000 0.562500
+0.750000 0.750000 0.562500
+
+
+
+1.00000 0.750000 1.00000
+0.750000 0.750000 0.562500
+
+1.00000 0.500000 1.00000
+1.00000 0.500000 1.00000
+
+
+
+0.00000 0.750000 8.67298e-13
+0.250000 0.750000 0.0625000
+
+0.00000 1.00000 -2.74266e-13
+0.00000 1.00000 -2.74266e-13
+
+
+
+0.250000 1.00000 0.0625000
+0.00000 1.00000 -2.74266e-13
+
+0.250000 0.750000 0.0625000
+0.250000 0.750000 0.0625000
+
+
+
+0.250000 0.750000 0.0625000
+0.500000 0.750000 0.250000
+
+0.250000 1.00000 0.0625000
+0.250000 1.00000 0.0625000
+
+
+
+0.500000 1.00000 0.250000
+0.250000 1.00000 0.0625000
+
+0.500000 0.750000 0.250000
+0.500000 0.750000 0.250000
+
+
+
+0.500000 0.750000 0.250000
+0.750000 0.750000 0.562500
+
+0.500000 1.00000 0.250000
+0.500000 1.00000 0.250000
+
+
+
+0.750000 1.00000 0.562500
+0.500000 1.00000 0.250000
+
+0.750000 0.750000 0.562500
+0.750000 0.750000 0.562500
+
+
+
+0.750000 0.750000 0.562500
+1.00000 0.750000 1.00000
+
+0.750000 1.00000 0.562500
+0.750000 1.00000 0.562500
+
+
+
+1.00000 1.00000 1.00000
+0.750000 1.00000 0.562500
+
+1.00000 0.750000 1.00000
+1.00000 0.750000 1.00000
+
+
+
+# This file was generated by the deal.II library.
+
+
+#
+# For a description of the GNUPLOT format see the GNUPLOT manual.
+#
+# <x> <y> <solution_0> <solution_1>
+0.00000 0.00000 -2.48113e-12 -2.48113e-12
+0.250000 0.00000 0.0625000 -2.02496e-12
+
+0.00000 0.250000 -2.02495e-12 0.0625000
+0.00000 0.250000 -2.02495e-12 0.0625000
+
+
+
+0.250000 0.250000 0.0625000 0.0625000
+0.00000 0.250000 -2.02495e-12 0.0625000
+
+0.250000 0.00000 0.0625000 -2.02496e-12
+0.250000 0.00000 0.0625000 -2.02496e-12
+
+
+
+0.250000 0.00000 0.0625000 -2.02496e-12
+0.500000 0.00000 0.250000 1.65790e-13
+
+0.250000 0.250000 0.0625000 0.0625000
+0.250000 0.250000 0.0625000 0.0625000
+
+
+
+0.500000 0.250000 0.250000 0.0625000
+0.250000 0.250000 0.0625000 0.0625000
+
+0.500000 0.00000 0.250000 1.65790e-13
+0.500000 0.00000 0.250000 1.65790e-13
+
+
+
+0.500000 0.00000 0.250000 1.65790e-13
+0.750000 0.00000 0.562500 8.67305e-13
+
+0.500000 0.250000 0.250000 0.0625000
+0.500000 0.250000 0.250000 0.0625000
+
+
+
+0.750000 0.250000 0.562500 0.0625000
+0.500000 0.250000 0.250000 0.0625000
+
+0.750000 0.00000 0.562500 8.67305e-13
+0.750000 0.00000 0.562500 8.67305e-13
+
+
+
+0.750000 0.00000 0.562500 8.67305e-13
+1.00000 0.00000 1.00000 -2.74290e-13
+
+0.750000 0.250000 0.562500 0.0625000
+0.750000 0.250000 0.562500 0.0625000
+
+
+
+1.00000 0.250000 1.00000 0.0625000
+0.750000 0.250000 0.562500 0.0625000
+
+1.00000 0.00000 1.00000 -2.74290e-13
+1.00000 0.00000 1.00000 -2.74290e-13
+
+
+
+0.00000 0.250000 -2.02495e-12 0.0625000
+0.250000 0.250000 0.0625000 0.0625000
+
+0.00000 0.500000 1.65805e-13 0.250000
+0.00000 0.500000 1.65805e-13 0.250000
+
+
+
+0.250000 0.500000 0.0625000 0.250000
+0.00000 0.500000 1.65805e-13 0.250000
+
+0.250000 0.250000 0.0625000 0.0625000
+0.250000 0.250000 0.0625000 0.0625000
+
+
+
+0.250000 0.250000 0.0625000 0.0625000
+0.500000 0.250000 0.250000 0.0625000
+
+0.250000 0.500000 0.0625000 0.250000
+0.250000 0.500000 0.0625000 0.250000
+
+
+
+0.500000 0.500000 0.250000 0.250000
+0.250000 0.500000 0.0625000 0.250000
+
+0.500000 0.250000 0.250000 0.0625000
+0.500000 0.250000 0.250000 0.0625000
+
+
+
+0.500000 0.250000 0.250000 0.0625000
+0.750000 0.250000 0.562500 0.0625000
+
+0.500000 0.500000 0.250000 0.250000
+0.500000 0.500000 0.250000 0.250000
+
+
+
+0.750000 0.500000 0.562500 0.250000
+0.500000 0.500000 0.250000 0.250000
+
+0.750000 0.250000 0.562500 0.0625000
+0.750000 0.250000 0.562500 0.0625000
+
+
+
+0.750000 0.250000 0.562500 0.0625000
+1.00000 0.250000 1.00000 0.0625000
+
+0.750000 0.500000 0.562500 0.250000
+0.750000 0.500000 0.562500 0.250000
+
+
+
+1.00000 0.500000 1.00000 0.250000
+0.750000 0.500000 0.562500 0.250000
+
+1.00000 0.250000 1.00000 0.0625000
+1.00000 0.250000 1.00000 0.0625000
+
+
+
+0.00000 0.500000 1.65805e-13 0.250000
+0.250000 0.500000 0.0625000 0.250000
+
+0.00000 0.750000 8.67297e-13 0.562500
+0.00000 0.750000 8.67297e-13 0.562500
+
+
+
+0.250000 0.750000 0.0625000 0.562500
+0.00000 0.750000 8.67297e-13 0.562500
+
+0.250000 0.500000 0.0625000 0.250000
+0.250000 0.500000 0.0625000 0.250000
+
+
+
+0.250000 0.500000 0.0625000 0.250000
+0.500000 0.500000 0.250000 0.250000
+
+0.250000 0.750000 0.0625000 0.562500
+0.250000 0.750000 0.0625000 0.562500
+
+
+
+0.500000 0.750000 0.250000 0.562500
+0.250000 0.750000 0.0625000 0.562500
+
+0.500000 0.500000 0.250000 0.250000
+0.500000 0.500000 0.250000 0.250000
+
+
+
+0.500000 0.500000 0.250000 0.250000
+0.750000 0.500000 0.562500 0.250000
+
+0.500000 0.750000 0.250000 0.562500
+0.500000 0.750000 0.250000 0.562500
+
+
+
+0.750000 0.750000 0.562500 0.562500
+0.500000 0.750000 0.250000 0.562500
+
+0.750000 0.500000 0.562500 0.250000
+0.750000 0.500000 0.562500 0.250000
+
+
+
+0.750000 0.500000 0.562500 0.250000
+1.00000 0.500000 1.00000 0.250000
+
+0.750000 0.750000 0.562500 0.562500
+0.750000 0.750000 0.562500 0.562500
+
+
+
+1.00000 0.750000 1.00000 0.562500
+0.750000 0.750000 0.562500 0.562500
+
+1.00000 0.500000 1.00000 0.250000
+1.00000 0.500000 1.00000 0.250000
+
+
+
+0.00000 0.750000 8.67297e-13 0.562500
+0.250000 0.750000 0.0625000 0.562500
+
+0.00000 1.00000 -2.74276e-13 1.00000
+0.00000 1.00000 -2.74276e-13 1.00000
+
+
+
+0.250000 1.00000 0.0625000 1.00000
+0.00000 1.00000 -2.74276e-13 1.00000
+
+0.250000 0.750000 0.0625000 0.562500
+0.250000 0.750000 0.0625000 0.562500
+
+
+
+0.250000 0.750000 0.0625000 0.562500
+0.500000 0.750000 0.250000 0.562500
+
+0.250000 1.00000 0.0625000 1.00000
+0.250000 1.00000 0.0625000 1.00000
+
+
+
+0.500000 1.00000 0.250000 1.00000
+0.250000 1.00000 0.0625000 1.00000
+
+0.500000 0.750000 0.250000 0.562500
+0.500000 0.750000 0.250000 0.562500
+
+
+
+0.500000 0.750000 0.250000 0.562500
+0.750000 0.750000 0.562500 0.562500
+
+0.500000 1.00000 0.250000 1.00000
+0.500000 1.00000 0.250000 1.00000
+
+
+
+0.750000 1.00000 0.562500 1.00000
+0.500000 1.00000 0.250000 1.00000
+
+0.750000 0.750000 0.562500 0.562500
+0.750000 0.750000 0.562500 0.562500
+
+
+
+0.750000 0.750000 0.562500 0.562500
+1.00000 0.750000 1.00000 0.562500
+
+0.750000 1.00000 0.562500 1.00000
+0.750000 1.00000 0.562500 1.00000
+
+
+
+1.00000 1.00000 1.00000 1.00000
+0.750000 1.00000 0.562500 1.00000
+
+1.00000 0.750000 1.00000 0.562500
+1.00000 0.750000 1.00000 0.562500
+
+
+
+# This file was generated by the deal.II library.
+
+
+#
+# For a description of the GNUPLOT format see the GNUPLOT manual.
+#
+# <x> <y> <solution_0> <solution_1> <solution_2>
+0.00000 0.00000 5.57047e-14 -4.51329e-14 -0.00799710
+0.250000 0.00000 0.0625000 -5.58341e-14 0.0517471
+
+0.00000 0.250000 -7.37079e-14 0.0625000 -0.0107529
+0.00000 0.250000 -7.37079e-14 0.0625000 -0.0107529
+
+
+
+0.250000 0.250000 0.0625000 0.0625000 0.0522153
+0.00000 0.250000 -7.37079e-14 0.0625000 -0.0107529
+
+0.250000 0.00000 0.0625000 -5.58341e-14 0.0517471
+0.250000 0.00000 0.0625000 -5.58341e-14 0.0517471
+
+
+
+0.250000 0.00000 0.0625000 -5.58341e-14 0.0517471
+0.500000 0.00000 0.250000 -3.57049e-13 0.239590
+
+0.250000 0.250000 0.0625000 0.0625000 0.0522153
+0.250000 0.250000 0.0625000 0.0625000 0.0522153
+
+
+
+0.500000 0.250000 0.250000 0.0625000 0.239517
+0.250000 0.250000 0.0625000 0.0625000 0.0522153
+
+0.500000 0.00000 0.250000 -3.57049e-13 0.239590
+0.500000 0.00000 0.250000 -3.57049e-13 0.239590
+
+
+
+0.500000 0.00000 0.250000 -3.57049e-13 0.239590
+0.750000 0.00000 0.562500 -1.01958e-13 0.552249
+
+0.500000 0.250000 0.250000 0.0625000 0.239517
+0.500000 0.250000 0.250000 0.0625000 0.239517
+
+
+
+0.750000 0.250000 0.562500 0.0625000 0.552254
+0.500000 0.250000 0.250000 0.0625000 0.239517
+
+0.750000 0.00000 0.562500 -1.01958e-13 0.552249
+0.750000 0.00000 0.562500 -1.01958e-13 0.552249
+
+
+
+0.750000 0.00000 0.562500 -1.01958e-13 0.552249
+1.00000 0.00000 1.00000 2.58877e-13 0.988374
+
+0.750000 0.250000 0.562500 0.0625000 0.552254
+0.750000 0.250000 0.562500 0.0625000 0.552254
+
+
+
+1.00000 0.250000 1.00000 0.0625000 0.989749
+0.750000 0.250000 0.562500 0.0625000 0.552254
+
+1.00000 0.00000 1.00000 2.58877e-13 0.988374
+1.00000 0.00000 1.00000 2.58877e-13 0.988374
+
+
+
+0.00000 0.250000 -7.37079e-14 0.0625000 -0.0107529
+0.250000 0.250000 0.0625000 0.0625000 0.0522153
+
+0.00000 0.500000 -1.31873e-13 0.250000 -0.0104102
+0.00000 0.500000 -1.31873e-13 0.250000 -0.0104102
+
+
+
+0.250000 0.500000 0.0625000 0.250000 0.0520174
+0.00000 0.500000 -1.31873e-13 0.250000 -0.0104102
+
+0.250000 0.250000 0.0625000 0.0625000 0.0522153
+0.250000 0.250000 0.0625000 0.0625000 0.0522153
+
+
+
+0.250000 0.250000 0.0625000 0.0625000 0.0522153
+0.500000 0.250000 0.250000 0.0625000 0.239517
+
+0.250000 0.500000 0.0625000 0.250000 0.0520174
+0.250000 0.500000 0.0625000 0.250000 0.0520174
+
+
+
+0.500000 0.500000 0.250000 0.250000 0.239570
+0.250000 0.500000 0.0625000 0.250000 0.0520174
+
+0.500000 0.250000 0.250000 0.0625000 0.239517
+0.500000 0.250000 0.250000 0.0625000 0.239517
+
+
+
+0.500000 0.250000 0.250000 0.0625000 0.239517
+0.750000 0.250000 0.562500 0.0625000 0.552254
+
+0.500000 0.500000 0.250000 0.250000 0.239570
+0.500000 0.500000 0.250000 0.250000 0.239570
+
+
+
+0.750000 0.500000 0.562500 0.250000 0.552017
+0.500000 0.500000 0.250000 0.250000 0.239570
+
+0.750000 0.250000 0.562500 0.0625000 0.552254
+0.750000 0.250000 0.562500 0.0625000 0.552254
+
+
+
+0.750000 0.250000 0.562500 0.0625000 0.552254
+1.00000 0.250000 1.00000 0.0625000 0.989749
+
+0.750000 0.500000 0.562500 0.250000 0.552017
+0.750000 0.500000 0.562500 0.250000 0.552017
+
+
+
+1.00000 0.500000 1.00000 0.250000 0.989590
+0.750000 0.500000 0.562500 0.250000 0.552017
+
+1.00000 0.250000 1.00000 0.0625000 0.989749
+1.00000 0.250000 1.00000 0.0625000 0.989749
+
+
+
+0.00000 0.500000 -1.31873e-13 0.250000 -0.0104102
+0.250000 0.500000 0.0625000 0.250000 0.0520174
+
+0.00000 0.750000 2.72455e-13 0.562500 -0.0102510
+0.00000 0.750000 2.72455e-13 0.562500 -0.0102510
+
+
+
+0.250000 0.750000 0.0625000 0.562500 0.0522539
+0.00000 0.750000 2.72455e-13 0.562500 -0.0102510
+
+0.250000 0.500000 0.0625000 0.250000 0.0520174
+0.250000 0.500000 0.0625000 0.250000 0.0520174
+
+
+
+0.250000 0.500000 0.0625000 0.250000 0.0520174
+0.500000 0.500000 0.250000 0.250000 0.239570
+
+0.250000 0.750000 0.0625000 0.562500 0.0522539
+0.250000 0.750000 0.0625000 0.562500 0.0522539
+
+
+
+0.500000 0.750000 0.250000 0.562500 0.239517
+0.250000 0.750000 0.0625000 0.562500 0.0522539
+
+0.500000 0.500000 0.250000 0.250000 0.239570
+0.500000 0.500000 0.250000 0.250000 0.239570
+
+
+
+0.500000 0.500000 0.250000 0.250000 0.239570
+0.750000 0.500000 0.562500 0.250000 0.552017
+
+0.500000 0.750000 0.250000 0.562500 0.239517
+0.500000 0.750000 0.250000 0.562500 0.239517
+
+
+
+0.750000 0.750000 0.562500 0.562500 0.552215
+0.500000 0.750000 0.250000 0.562500 0.239517
+
+0.750000 0.500000 0.562500 0.250000 0.552017
+0.750000 0.500000 0.562500 0.250000 0.552017
+
+
+
+0.750000 0.500000 0.562500 0.250000 0.552017
+1.00000 0.500000 1.00000 0.250000 0.989590
+
+0.750000 0.750000 0.562500 0.562500 0.552215
+0.750000 0.750000 0.562500 0.562500 0.552215
+
+
+
+1.00000 0.750000 1.00000 0.562500 0.989247
+0.750000 0.750000 0.562500 0.562500 0.552215
+
+1.00000 0.500000 1.00000 0.250000 0.989590
+1.00000 0.500000 1.00000 0.250000 0.989590
+
+
+
+0.00000 0.750000 2.72455e-13 0.562500 -0.0102510
+0.250000 0.750000 0.0625000 0.562500 0.0522539
+
+0.00000 1.00000 -1.33076e-13 1.00000 -0.0116264
+0.00000 1.00000 -1.33076e-13 1.00000 -0.0116264
+
+
+
+0.250000 1.00000 0.0625000 1.00000 0.0522490
+0.00000 1.00000 -1.33076e-13 1.00000 -0.0116264
+
+0.250000 0.750000 0.0625000 0.562500 0.0522539
+0.250000 0.750000 0.0625000 0.562500 0.0522539
+
+
+
+0.250000 0.750000 0.0625000 0.562500 0.0522539
+0.500000 0.750000 0.250000 0.562500 0.239517
+
+0.250000 1.00000 0.0625000 1.00000 0.0522490
+0.250000 1.00000 0.0625000 1.00000 0.0522490
+
+
+
+0.500000 1.00000 0.250000 1.00000 0.239590
+0.250000 1.00000 0.0625000 1.00000 0.0522490
+
+0.500000 0.750000 0.250000 0.562500 0.239517
+0.500000 0.750000 0.250000 0.562500 0.239517
+
+
+
+0.500000 0.750000 0.250000 0.562500 0.239517
+0.750000 0.750000 0.562500 0.562500 0.552215
+
+0.500000 1.00000 0.250000 1.00000 0.239590
+0.500000 1.00000 0.250000 1.00000 0.239590
+
+
+
+0.750000 1.00000 0.562500 1.00000 0.551747
+0.500000 1.00000 0.250000 1.00000 0.239590
+
+0.750000 0.750000 0.562500 0.562500 0.552215
+0.750000 0.750000 0.562500 0.562500 0.552215
+
+
+
+0.750000 0.750000 0.562500 0.562500 0.552215
+1.00000 0.750000 1.00000 0.562500 0.989247
+
+0.750000 1.00000 0.562500 1.00000 0.551747
+0.750000 1.00000 0.562500 1.00000 0.551747
+
+
+
+1.00000 1.00000 1.00000 1.00000 0.992003
+0.750000 1.00000 0.562500 1.00000 0.551747
+
+1.00000 0.750000 1.00000 0.562500 0.989247
+1.00000 0.750000 1.00000 0.562500 0.989247
+
+
+