if (update_flags & update_quadrature_points)
scratch_data.patch_values_scalar.evaluation_points = this_fe_patch_values.get_quadrature_points();
+ const typename DoFHandlerType::active_cell_iterator dh_cell(&cell_and_index->first->get_triangulation(),
+ cell_and_index->first->level(),
+ cell_and_index->first->index(),
+ this->dof_data[dataset]->dof_handler);
+ scratch_data.patch_values_scalar.template set_cell<DoFHandlerType> (dh_cell);
postprocessor->
evaluate_scalar_field(scratch_data.patch_values_scalar,
if (update_flags & update_quadrature_points)
scratch_data.patch_values_system.evaluation_points = this_fe_patch_values.get_quadrature_points();
+ const typename DoFHandlerType::active_cell_iterator dh_cell(&cell_and_index->first->get_triangulation(),
+ cell_and_index->first->level(),
+ cell_and_index->first->index(),
+ this->dof_data[dataset]->dof_handler);
+ scratch_data.patch_values_system.template set_cell<DoFHandlerType> (dh_cell);
+
postprocessor->
evaluate_vector_field(scratch_data.patch_values_system,
scratch_data.postprocessed_values[dataset]);
--- /dev/null
+// ---------------------------------------------------------------------
+//
+// Copyright (C) 2016 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 at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
+
+// tests DataPostprocessor: access the cell we are currently working
+// on for a scalar finite element
+
+
+#include "../tests.h"
+#include <deal.II/grid/tria.h>
+#include <deal.II/dofs/dof_handler.h>
+#include <deal.II/grid/grid_generator.h>
+#include <deal.II/grid/tria_accessor.h>
+#include <deal.II/grid/tria_iterator.h>
+#include <deal.II/dofs/dof_accessor.h>
+#include <deal.II/fe/fe_dgq.h>
+#include <deal.II/fe/fe_system.h>
+#include <deal.II/base/function.h>
+#include <deal.II/numerics/vector_tools.h>
+#include <deal.II/numerics/matrix_tools.h>
+#include <deal.II/lac/vector.h>
+
+#include <deal.II/numerics/data_out.h>
+#include <deal.II/numerics/data_postprocessor.h>
+#include <fstream>
+
+#include <deal.II/base/logstream.h>
+
+
+std::ofstream logfile("output");
+
+
+template <int dim>
+class MyPostprocessor : public DataPostprocessorScalar<dim>
+{
+public:
+ MyPostprocessor ()
+ :
+ DataPostprocessorScalar<dim> ("data", update_values)
+ {}
+
+ virtual
+ void
+ evaluate_scalar_field (const DataPostprocessorInputs::Scalar<dim> &input_data,
+ std::vector<Vector<double> > &computed_quantities) const
+ {
+ for (unsigned int q=0; q<input_data.solution_values.size(); ++q)
+ {
+ Assert (computed_quantities[q].size() == 1,
+ ExcInternalError());
+
+ // get the cell this all belongs to
+ typename DoFHandler<dim>::cell_iterator
+ cell = input_data.template get_cell<DoFHandler<dim> >();
+
+ Assert (input_data.solution_values[q]
+ ==
+ double(cell->active_cell_index()),
+ ExcInternalError());
+
+ computed_quantities[q][0] = input_data.solution_values[q];
+ }
+ }
+};
+
+
+
+template <int dim>
+void test ()
+{
+ Triangulation<dim> triangulation;
+ FE_DGQ<dim> fe(1);
+ DoFHandler<dim> dof_handler(triangulation);
+
+ GridGenerator::hyper_cube (triangulation, 0, 1);
+ triangulation.refine_global (1);
+ triangulation.begin_active()->set_refine_flag ();
+ triangulation.execute_coarsening_and_refinement ();
+
+ dof_handler.distribute_dofs (fe);
+
+ // create a vector with piecewise constants, and set the elements of
+ // the vector so that on each cell the field has values equal to the
+ // cell's active_cell_index
+ Vector<double> solution (dof_handler.n_dofs());
+ for (typename DoFHandler<dim>::active_cell_iterator cell = dof_handler.begin_active();
+ cell != dof_handler.end(); ++cell)
+ {
+ std::vector<types::global_dof_index> local_dof_indices (cell->get_fe().dofs_per_cell);
+ cell->get_dof_indices (local_dof_indices);
+ for (unsigned int i=0; i<local_dof_indices.size(); ++i)
+ solution(local_dof_indices[i]) = cell->active_cell_index();
+ }
+
+ MyPostprocessor<dim> p;
+ DataOut<dim> data_out;
+ data_out.attach_dof_handler (dof_handler);
+ data_out.add_data_vector (solution, p);
+ data_out.build_patches ();
+ data_out.write_gnuplot (logfile);
+}
+
+
+int main ()
+{
+ logfile << std::setprecision(2);
+ deallog << std::setprecision(2);
+
+ test<1>();
+ test<2>();
+ test<3>();
+
+ return 0;
+}
--- /dev/null
+# This file was generated by the deal.II library.
+
+
+#
+# For a description of the GNUPLOT format see the GNUPLOT manual.
+#
+# <x> <data>
+0.5 0
+1 0
+
+
+0 1
+0.25 1
+
+
+0.25 2
+0.5 2
+
+
+# This file was generated by the deal.II library.
+
+
+#
+# For a description of the GNUPLOT format see the GNUPLOT manual.
+#
+# <x> <y> <data>
+0.5 0 0
+1 0 0
+
+0.5 0.5 0
+1 0.5 0
+
+
+0 0.5 1
+0.5 0.5 1
+
+0 1 1
+0.5 1 1
+
+
+0.5 0.5 2
+1 0.5 2
+
+0.5 1 2
+1 1 2
+
+
+0 0 3
+0.25 0 3
+
+0 0.25 3
+0.25 0.25 3
+
+
+0.25 0 4
+0.5 0 4
+
+0.25 0.25 4
+0.5 0.25 4
+
+
+0 0.25 5
+0.25 0.25 5
+
+0 0.5 5
+0.25 0.5 5
+
+
+0.25 0.25 6
+0.5 0.25 6
+
+0.25 0.5 6
+0.5 0.5 6
+
+
+# This file was generated by the deal.II library.
+
+
+#
+# For a description of the GNUPLOT format see the GNUPLOT manual.
+#
+# <x> <y> <z> <data>
+0.5 0 0 0
+1 0 0 0
+
+
+0.5 0 0 0
+0.5 0.5 0 0
+
+
+0.5 0 0 0
+0.5 0 0.5 0
+
+
+1 0 0 0
+1 0.5 0 0
+
+
+1 0 0 0
+1 0 0.5 0
+
+
+0.5 0.5 0 0
+1 0.5 0 0
+
+
+0.5 0.5 0 0
+0.5 0.5 0.5 0
+
+
+1 0.5 0 0
+1 0.5 0.5 0
+
+
+0.5 0 0.5 0
+1 0 0.5 0
+
+
+0.5 0 0.5 0
+0.5 0.5 0.5 0
+
+
+1 0 0.5 0
+1 0.5 0.5 0
+
+
+0.5 0.5 0.5 0
+1 0.5 0.5 0
+
+
+0 0.5 0 1
+0.5 0.5 0 1
+
+
+0 0.5 0 1
+0 1 0 1
+
+
+0 0.5 0 1
+0 0.5 0.5 1
+
+
+0.5 0.5 0 1
+0.5 1 0 1
+
+
+0.5 0.5 0 1
+0.5 0.5 0.5 1
+
+
+0 1 0 1
+0.5 1 0 1
+
+
+0 1 0 1
+0 1 0.5 1
+
+
+0.5 1 0 1
+0.5 1 0.5 1
+
+
+0 0.5 0.5 1
+0.5 0.5 0.5 1
+
+
+0 0.5 0.5 1
+0 1 0.5 1
+
+
+0.5 0.5 0.5 1
+0.5 1 0.5 1
+
+
+0 1 0.5 1
+0.5 1 0.5 1
+
+
+0.5 0.5 0 2
+1 0.5 0 2
+
+
+0.5 0.5 0 2
+0.5 1 0 2
+
+
+0.5 0.5 0 2
+0.5 0.5 0.5 2
+
+
+1 0.5 0 2
+1 1 0 2
+
+
+1 0.5 0 2
+1 0.5 0.5 2
+
+
+0.5 1 0 2
+1 1 0 2
+
+
+0.5 1 0 2
+0.5 1 0.5 2
+
+
+1 1 0 2
+1 1 0.5 2
+
+
+0.5 0.5 0.5 2
+1 0.5 0.5 2
+
+
+0.5 0.5 0.5 2
+0.5 1 0.5 2
+
+
+1 0.5 0.5 2
+1 1 0.5 2
+
+
+0.5 1 0.5 2
+1 1 0.5 2
+
+
+0 0 0.5 3
+0.5 0 0.5 3
+
+
+0 0 0.5 3
+0 0.5 0.5 3
+
+
+0 0 0.5 3
+0 0 1 3
+
+
+0.5 0 0.5 3
+0.5 0.5 0.5 3
+
+
+0.5 0 0.5 3
+0.5 0 1 3
+
+
+0 0.5 0.5 3
+0.5 0.5 0.5 3
+
+
+0 0.5 0.5 3
+0 0.5 1 3
+
+
+0.5 0.5 0.5 3
+0.5 0.5 1 3
+
+
+0 0 1 3
+0.5 0 1 3
+
+
+0 0 1 3
+0 0.5 1 3
+
+
+0.5 0 1 3
+0.5 0.5 1 3
+
+
+0 0.5 1 3
+0.5 0.5 1 3
+
+
+0.5 0 0.5 4
+1 0 0.5 4
+
+
+0.5 0 0.5 4
+0.5 0.5 0.5 4
+
+
+0.5 0 0.5 4
+0.5 0 1 4
+
+
+1 0 0.5 4
+1 0.5 0.5 4
+
+
+1 0 0.5 4
+1 0 1 4
+
+
+0.5 0.5 0.5 4
+1 0.5 0.5 4
+
+
+0.5 0.5 0.5 4
+0.5 0.5 1 4
+
+
+1 0.5 0.5 4
+1 0.5 1 4
+
+
+0.5 0 1 4
+1 0 1 4
+
+
+0.5 0 1 4
+0.5 0.5 1 4
+
+
+1 0 1 4
+1 0.5 1 4
+
+
+0.5 0.5 1 4
+1 0.5 1 4
+
+
+0 0.5 0.5 5
+0.5 0.5 0.5 5
+
+
+0 0.5 0.5 5
+0 1 0.5 5
+
+
+0 0.5 0.5 5
+0 0.5 1 5
+
+
+0.5 0.5 0.5 5
+0.5 1 0.5 5
+
+
+0.5 0.5 0.5 5
+0.5 0.5 1 5
+
+
+0 1 0.5 5
+0.5 1 0.5 5
+
+
+0 1 0.5 5
+0 1 1 5
+
+
+0.5 1 0.5 5
+0.5 1 1 5
+
+
+0 0.5 1 5
+0.5 0.5 1 5
+
+
+0 0.5 1 5
+0 1 1 5
+
+
+0.5 0.5 1 5
+0.5 1 1 5
+
+
+0 1 1 5
+0.5 1 1 5
+
+
+0.5 0.5 0.5 6
+1 0.5 0.5 6
+
+
+0.5 0.5 0.5 6
+0.5 1 0.5 6
+
+
+0.5 0.5 0.5 6
+0.5 0.5 1 6
+
+
+1 0.5 0.5 6
+1 1 0.5 6
+
+
+1 0.5 0.5 6
+1 0.5 1 6
+
+
+0.5 1 0.5 6
+1 1 0.5 6
+
+
+0.5 1 0.5 6
+0.5 1 1 6
+
+
+1 1 0.5 6
+1 1 1 6
+
+
+0.5 0.5 1 6
+1 0.5 1 6
+
+
+0.5 0.5 1 6
+0.5 1 1 6
+
+
+1 0.5 1 6
+1 1 1 6
+
+
+0.5 1 1 6
+1 1 1 6
+
+
+0 0 0 7
+0.25 0 0 7
+
+
+0 0 0 7
+0 0.25 0 7
+
+
+0 0 0 7
+0 0 0.25 7
+
+
+0.25 0 0 7
+0.25 0.25 0 7
+
+
+0.25 0 0 7
+0.25 0 0.25 7
+
+
+0 0.25 0 7
+0.25 0.25 0 7
+
+
+0 0.25 0 7
+0 0.25 0.25 7
+
+
+0.25 0.25 0 7
+0.25 0.25 0.25 7
+
+
+0 0 0.25 7
+0.25 0 0.25 7
+
+
+0 0 0.25 7
+0 0.25 0.25 7
+
+
+0.25 0 0.25 7
+0.25 0.25 0.25 7
+
+
+0 0.25 0.25 7
+0.25 0.25 0.25 7
+
+
+0.25 0 0 8
+0.5 0 0 8
+
+
+0.25 0 0 8
+0.25 0.25 0 8
+
+
+0.25 0 0 8
+0.25 0 0.25 8
+
+
+0.5 0 0 8
+0.5 0.25 0 8
+
+
+0.5 0 0 8
+0.5 0 0.25 8
+
+
+0.25 0.25 0 8
+0.5 0.25 0 8
+
+
+0.25 0.25 0 8
+0.25 0.25 0.25 8
+
+
+0.5 0.25 0 8
+0.5 0.25 0.25 8
+
+
+0.25 0 0.25 8
+0.5 0 0.25 8
+
+
+0.25 0 0.25 8
+0.25 0.25 0.25 8
+
+
+0.5 0 0.25 8
+0.5 0.25 0.25 8
+
+
+0.25 0.25 0.25 8
+0.5 0.25 0.25 8
+
+
+0 0.25 0 9
+0.25 0.25 0 9
+
+
+0 0.25 0 9
+0 0.5 0 9
+
+
+0 0.25 0 9
+0 0.25 0.25 9
+
+
+0.25 0.25 0 9
+0.25 0.5 0 9
+
+
+0.25 0.25 0 9
+0.25 0.25 0.25 9
+
+
+0 0.5 0 9
+0.25 0.5 0 9
+
+
+0 0.5 0 9
+0 0.5 0.25 9
+
+
+0.25 0.5 0 9
+0.25 0.5 0.25 9
+
+
+0 0.25 0.25 9
+0.25 0.25 0.25 9
+
+
+0 0.25 0.25 9
+0 0.5 0.25 9
+
+
+0.25 0.25 0.25 9
+0.25 0.5 0.25 9
+
+
+0 0.5 0.25 9
+0.25 0.5 0.25 9
+
+
+0.25 0.25 0 10
+0.5 0.25 0 10
+
+
+0.25 0.25 0 10
+0.25 0.5 0 10
+
+
+0.25 0.25 0 10
+0.25 0.25 0.25 10
+
+
+0.5 0.25 0 10
+0.5 0.5 0 10
+
+
+0.5 0.25 0 10
+0.5 0.25 0.25 10
+
+
+0.25 0.5 0 10
+0.5 0.5 0 10
+
+
+0.25 0.5 0 10
+0.25 0.5 0.25 10
+
+
+0.5 0.5 0 10
+0.5 0.5 0.25 10
+
+
+0.25 0.25 0.25 10
+0.5 0.25 0.25 10
+
+
+0.25 0.25 0.25 10
+0.25 0.5 0.25 10
+
+
+0.5 0.25 0.25 10
+0.5 0.5 0.25 10
+
+
+0.25 0.5 0.25 10
+0.5 0.5 0.25 10
+
+
+0 0 0.25 11
+0.25 0 0.25 11
+
+
+0 0 0.25 11
+0 0.25 0.25 11
+
+
+0 0 0.25 11
+0 0 0.5 11
+
+
+0.25 0 0.25 11
+0.25 0.25 0.25 11
+
+
+0.25 0 0.25 11
+0.25 0 0.5 11
+
+
+0 0.25 0.25 11
+0.25 0.25 0.25 11
+
+
+0 0.25 0.25 11
+0 0.25 0.5 11
+
+
+0.25 0.25 0.25 11
+0.25 0.25 0.5 11
+
+
+0 0 0.5 11
+0.25 0 0.5 11
+
+
+0 0 0.5 11
+0 0.25 0.5 11
+
+
+0.25 0 0.5 11
+0.25 0.25 0.5 11
+
+
+0 0.25 0.5 11
+0.25 0.25 0.5 11
+
+
+0.25 0 0.25 12
+0.5 0 0.25 12
+
+
+0.25 0 0.25 12
+0.25 0.25 0.25 12
+
+
+0.25 0 0.25 12
+0.25 0 0.5 12
+
+
+0.5 0 0.25 12
+0.5 0.25 0.25 12
+
+
+0.5 0 0.25 12
+0.5 0 0.5 12
+
+
+0.25 0.25 0.25 12
+0.5 0.25 0.25 12
+
+
+0.25 0.25 0.25 12
+0.25 0.25 0.5 12
+
+
+0.5 0.25 0.25 12
+0.5 0.25 0.5 12
+
+
+0.25 0 0.5 12
+0.5 0 0.5 12
+
+
+0.25 0 0.5 12
+0.25 0.25 0.5 12
+
+
+0.5 0 0.5 12
+0.5 0.25 0.5 12
+
+
+0.25 0.25 0.5 12
+0.5 0.25 0.5 12
+
+
+0 0.25 0.25 13
+0.25 0.25 0.25 13
+
+
+0 0.25 0.25 13
+0 0.5 0.25 13
+
+
+0 0.25 0.25 13
+0 0.25 0.5 13
+
+
+0.25 0.25 0.25 13
+0.25 0.5 0.25 13
+
+
+0.25 0.25 0.25 13
+0.25 0.25 0.5 13
+
+
+0 0.5 0.25 13
+0.25 0.5 0.25 13
+
+
+0 0.5 0.25 13
+0 0.5 0.5 13
+
+
+0.25 0.5 0.25 13
+0.25 0.5 0.5 13
+
+
+0 0.25 0.5 13
+0.25 0.25 0.5 13
+
+
+0 0.25 0.5 13
+0 0.5 0.5 13
+
+
+0.25 0.25 0.5 13
+0.25 0.5 0.5 13
+
+
+0 0.5 0.5 13
+0.25 0.5 0.5 13
+
+
+0.25 0.25 0.25 14
+0.5 0.25 0.25 14
+
+
+0.25 0.25 0.25 14
+0.25 0.5 0.25 14
+
+
+0.25 0.25 0.25 14
+0.25 0.25 0.5 14
+
+
+0.5 0.25 0.25 14
+0.5 0.5 0.25 14
+
+
+0.5 0.25 0.25 14
+0.5 0.25 0.5 14
+
+
+0.25 0.5 0.25 14
+0.5 0.5 0.25 14
+
+
+0.25 0.5 0.25 14
+0.25 0.5 0.5 14
+
+
+0.5 0.5 0.25 14
+0.5 0.5 0.5 14
+
+
+0.25 0.25 0.5 14
+0.5 0.25 0.5 14
+
+
+0.25 0.25 0.5 14
+0.25 0.5 0.5 14
+
+
+0.5 0.25 0.5 14
+0.5 0.5 0.5 14
+
+
+0.25 0.5 0.5 14
+0.5 0.5 0.5 14
+
+
--- /dev/null
+// ---------------------------------------------------------------------
+//
+// Copyright (C) 2016 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 at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
+
+// tests DataPostprocessor: access the cell we are currently working
+// on for a vector finite element
+
+
+#include "../tests.h"
+#include <deal.II/grid/tria.h>
+#include <deal.II/dofs/dof_handler.h>
+#include <deal.II/grid/grid_generator.h>
+#include <deal.II/grid/tria_accessor.h>
+#include <deal.II/grid/tria_iterator.h>
+#include <deal.II/dofs/dof_accessor.h>
+#include <deal.II/fe/fe_dgq.h>
+#include <deal.II/fe/fe_system.h>
+#include <deal.II/base/function.h>
+#include <deal.II/numerics/vector_tools.h>
+#include <deal.II/numerics/matrix_tools.h>
+#include <deal.II/lac/vector.h>
+
+#include <deal.II/numerics/data_out.h>
+#include <deal.II/numerics/data_postprocessor.h>
+#include <fstream>
+
+#include <deal.II/base/logstream.h>
+
+
+std::ofstream logfile("output");
+
+
+template <int dim>
+class MyPostprocessor : public DataPostprocessorVector<dim>
+{
+public:
+ MyPostprocessor ()
+ :
+ DataPostprocessorVector<dim> ("data", update_values)
+ {}
+
+ virtual
+ void
+ evaluate_vector_field (const DataPostprocessorInputs::Vector<dim> &input_data,
+ std::vector<Vector<double> > &computed_quantities) const
+ {
+ for (unsigned int q=0; q<input_data.solution_values.size(); ++q)
+ {
+ // we only have one scalar field to output
+ Assert (input_data.solution_values[q].size() == 2,
+ ExcInternalError());
+ Assert (computed_quantities[q].size() == dim,
+ ExcInternalError());
+
+ // get the cell this all belongs to
+ typename DoFHandler<dim>::cell_iterator
+ cell = input_data.template get_cell<DoFHandler<dim> >();
+
+ Assert (input_data.solution_values[q](0)
+ ==
+ double(cell->active_cell_index()),
+ ExcInternalError());
+
+ computed_quantities[q][0] = input_data.solution_values[q](0);
+ }
+ }
+};
+
+
+
+template <int dim>
+void test ()
+{
+ Triangulation<dim> triangulation;
+ FESystem<dim> fe(FE_DGQ<dim>(0),2);
+ DoFHandler<dim> dof_handler(triangulation);
+
+ GridGenerator::hyper_cube (triangulation, 0, 1);
+ triangulation.refine_global (1);
+ triangulation.begin_active()->set_refine_flag ();
+ triangulation.execute_coarsening_and_refinement ();
+
+ dof_handler.distribute_dofs (fe);
+
+ // create a vector with piecewise constants, and set the elements of
+ // the vector so that on each cell the field has values equal to the
+ // cell's active_cell_index
+ Vector<double> solution (dof_handler.n_dofs());
+ for (typename DoFHandler<dim>::active_cell_iterator cell = dof_handler.begin_active();
+ cell != dof_handler.end(); ++cell)
+ {
+ std::vector<types::global_dof_index> local_dof_indices (cell->get_fe().dofs_per_cell);
+ cell->get_dof_indices (local_dof_indices);
+ for (unsigned int i=0; i<local_dof_indices.size(); ++i)
+ solution(local_dof_indices[i]) = cell->active_cell_index();
+ }
+
+ MyPostprocessor<dim> p;
+ DataOut<dim> data_out;
+ data_out.attach_dof_handler (dof_handler);
+ data_out.add_data_vector (solution, p);
+ data_out.build_patches ();
+ data_out.write_gnuplot (logfile);
+}
+
+
+int main ()
+{
+ logfile << std::setprecision(2);
+ deallog << std::setprecision(2);
+
+ test<1>();
+ test<2>();
+ test<3>();
+
+ return 0;
+}
--- /dev/null
+# This file was generated by the deal.II library.
+
+
+#
+# For a description of the GNUPLOT format see the GNUPLOT manual.
+#
+# <x> <data>
+0.5 0
+1 0
+
+
+0 1
+0.25 1
+
+
+0.25 2
+0.5 2
+
+
+# This file was generated by the deal.II library.
+
+
+#
+# For a description of the GNUPLOT format see the GNUPLOT manual.
+#
+# <x> <y> <data> <data>
+0.5 0 0 0
+1 0 0 0
+
+0.5 0.5 0 0
+1 0.5 0 0
+
+
+0 0.5 1 0
+0.5 0.5 1 0
+
+0 1 1 0
+0.5 1 1 0
+
+
+0.5 0.5 2 0
+1 0.5 2 0
+
+0.5 1 2 0
+1 1 2 0
+
+
+0 0 3 0
+0.25 0 3 0
+
+0 0.25 3 0
+0.25 0.25 3 0
+
+
+0.25 0 4 0
+0.5 0 4 0
+
+0.25 0.25 4 0
+0.5 0.25 4 0
+
+
+0 0.25 5 0
+0.25 0.25 5 0
+
+0 0.5 5 0
+0.25 0.5 5 0
+
+
+0.25 0.25 6 0
+0.5 0.25 6 0
+
+0.25 0.5 6 0
+0.5 0.5 6 0
+
+
+# This file was generated by the deal.II library.
+
+
+#
+# For a description of the GNUPLOT format see the GNUPLOT manual.
+#
+# <x> <y> <z> <data> <data> <data>
+0.5 0 0 0 0 0
+1 0 0 0 0 0
+
+
+0.5 0 0 0 0 0
+0.5 0.5 0 0 0 0
+
+
+0.5 0 0 0 0 0
+0.5 0 0.5 0 0 0
+
+
+1 0 0 0 0 0
+1 0.5 0 0 0 0
+
+
+1 0 0 0 0 0
+1 0 0.5 0 0 0
+
+
+0.5 0.5 0 0 0 0
+1 0.5 0 0 0 0
+
+
+0.5 0.5 0 0 0 0
+0.5 0.5 0.5 0 0 0
+
+
+1 0.5 0 0 0 0
+1 0.5 0.5 0 0 0
+
+
+0.5 0 0.5 0 0 0
+1 0 0.5 0 0 0
+
+
+0.5 0 0.5 0 0 0
+0.5 0.5 0.5 0 0 0
+
+
+1 0 0.5 0 0 0
+1 0.5 0.5 0 0 0
+
+
+0.5 0.5 0.5 0 0 0
+1 0.5 0.5 0 0 0
+
+
+0 0.5 0 1 0 0
+0.5 0.5 0 1 0 0
+
+
+0 0.5 0 1 0 0
+0 1 0 1 0 0
+
+
+0 0.5 0 1 0 0
+0 0.5 0.5 1 0 0
+
+
+0.5 0.5 0 1 0 0
+0.5 1 0 1 0 0
+
+
+0.5 0.5 0 1 0 0
+0.5 0.5 0.5 1 0 0
+
+
+0 1 0 1 0 0
+0.5 1 0 1 0 0
+
+
+0 1 0 1 0 0
+0 1 0.5 1 0 0
+
+
+0.5 1 0 1 0 0
+0.5 1 0.5 1 0 0
+
+
+0 0.5 0.5 1 0 0
+0.5 0.5 0.5 1 0 0
+
+
+0 0.5 0.5 1 0 0
+0 1 0.5 1 0 0
+
+
+0.5 0.5 0.5 1 0 0
+0.5 1 0.5 1 0 0
+
+
+0 1 0.5 1 0 0
+0.5 1 0.5 1 0 0
+
+
+0.5 0.5 0 2 0 0
+1 0.5 0 2 0 0
+
+
+0.5 0.5 0 2 0 0
+0.5 1 0 2 0 0
+
+
+0.5 0.5 0 2 0 0
+0.5 0.5 0.5 2 0 0
+
+
+1 0.5 0 2 0 0
+1 1 0 2 0 0
+
+
+1 0.5 0 2 0 0
+1 0.5 0.5 2 0 0
+
+
+0.5 1 0 2 0 0
+1 1 0 2 0 0
+
+
+0.5 1 0 2 0 0
+0.5 1 0.5 2 0 0
+
+
+1 1 0 2 0 0
+1 1 0.5 2 0 0
+
+
+0.5 0.5 0.5 2 0 0
+1 0.5 0.5 2 0 0
+
+
+0.5 0.5 0.5 2 0 0
+0.5 1 0.5 2 0 0
+
+
+1 0.5 0.5 2 0 0
+1 1 0.5 2 0 0
+
+
+0.5 1 0.5 2 0 0
+1 1 0.5 2 0 0
+
+
+0 0 0.5 3 0 0
+0.5 0 0.5 3 0 0
+
+
+0 0 0.5 3 0 0
+0 0.5 0.5 3 0 0
+
+
+0 0 0.5 3 0 0
+0 0 1 3 0 0
+
+
+0.5 0 0.5 3 0 0
+0.5 0.5 0.5 3 0 0
+
+
+0.5 0 0.5 3 0 0
+0.5 0 1 3 0 0
+
+
+0 0.5 0.5 3 0 0
+0.5 0.5 0.5 3 0 0
+
+
+0 0.5 0.5 3 0 0
+0 0.5 1 3 0 0
+
+
+0.5 0.5 0.5 3 0 0
+0.5 0.5 1 3 0 0
+
+
+0 0 1 3 0 0
+0.5 0 1 3 0 0
+
+
+0 0 1 3 0 0
+0 0.5 1 3 0 0
+
+
+0.5 0 1 3 0 0
+0.5 0.5 1 3 0 0
+
+
+0 0.5 1 3 0 0
+0.5 0.5 1 3 0 0
+
+
+0.5 0 0.5 4 0 0
+1 0 0.5 4 0 0
+
+
+0.5 0 0.5 4 0 0
+0.5 0.5 0.5 4 0 0
+
+
+0.5 0 0.5 4 0 0
+0.5 0 1 4 0 0
+
+
+1 0 0.5 4 0 0
+1 0.5 0.5 4 0 0
+
+
+1 0 0.5 4 0 0
+1 0 1 4 0 0
+
+
+0.5 0.5 0.5 4 0 0
+1 0.5 0.5 4 0 0
+
+
+0.5 0.5 0.5 4 0 0
+0.5 0.5 1 4 0 0
+
+
+1 0.5 0.5 4 0 0
+1 0.5 1 4 0 0
+
+
+0.5 0 1 4 0 0
+1 0 1 4 0 0
+
+
+0.5 0 1 4 0 0
+0.5 0.5 1 4 0 0
+
+
+1 0 1 4 0 0
+1 0.5 1 4 0 0
+
+
+0.5 0.5 1 4 0 0
+1 0.5 1 4 0 0
+
+
+0 0.5 0.5 5 0 0
+0.5 0.5 0.5 5 0 0
+
+
+0 0.5 0.5 5 0 0
+0 1 0.5 5 0 0
+
+
+0 0.5 0.5 5 0 0
+0 0.5 1 5 0 0
+
+
+0.5 0.5 0.5 5 0 0
+0.5 1 0.5 5 0 0
+
+
+0.5 0.5 0.5 5 0 0
+0.5 0.5 1 5 0 0
+
+
+0 1 0.5 5 0 0
+0.5 1 0.5 5 0 0
+
+
+0 1 0.5 5 0 0
+0 1 1 5 0 0
+
+
+0.5 1 0.5 5 0 0
+0.5 1 1 5 0 0
+
+
+0 0.5 1 5 0 0
+0.5 0.5 1 5 0 0
+
+
+0 0.5 1 5 0 0
+0 1 1 5 0 0
+
+
+0.5 0.5 1 5 0 0
+0.5 1 1 5 0 0
+
+
+0 1 1 5 0 0
+0.5 1 1 5 0 0
+
+
+0.5 0.5 0.5 6 0 0
+1 0.5 0.5 6 0 0
+
+
+0.5 0.5 0.5 6 0 0
+0.5 1 0.5 6 0 0
+
+
+0.5 0.5 0.5 6 0 0
+0.5 0.5 1 6 0 0
+
+
+1 0.5 0.5 6 0 0
+1 1 0.5 6 0 0
+
+
+1 0.5 0.5 6 0 0
+1 0.5 1 6 0 0
+
+
+0.5 1 0.5 6 0 0
+1 1 0.5 6 0 0
+
+
+0.5 1 0.5 6 0 0
+0.5 1 1 6 0 0
+
+
+1 1 0.5 6 0 0
+1 1 1 6 0 0
+
+
+0.5 0.5 1 6 0 0
+1 0.5 1 6 0 0
+
+
+0.5 0.5 1 6 0 0
+0.5 1 1 6 0 0
+
+
+1 0.5 1 6 0 0
+1 1 1 6 0 0
+
+
+0.5 1 1 6 0 0
+1 1 1 6 0 0
+
+
+0 0 0 7 0 0
+0.25 0 0 7 0 0
+
+
+0 0 0 7 0 0
+0 0.25 0 7 0 0
+
+
+0 0 0 7 0 0
+0 0 0.25 7 0 0
+
+
+0.25 0 0 7 0 0
+0.25 0.25 0 7 0 0
+
+
+0.25 0 0 7 0 0
+0.25 0 0.25 7 0 0
+
+
+0 0.25 0 7 0 0
+0.25 0.25 0 7 0 0
+
+
+0 0.25 0 7 0 0
+0 0.25 0.25 7 0 0
+
+
+0.25 0.25 0 7 0 0
+0.25 0.25 0.25 7 0 0
+
+
+0 0 0.25 7 0 0
+0.25 0 0.25 7 0 0
+
+
+0 0 0.25 7 0 0
+0 0.25 0.25 7 0 0
+
+
+0.25 0 0.25 7 0 0
+0.25 0.25 0.25 7 0 0
+
+
+0 0.25 0.25 7 0 0
+0.25 0.25 0.25 7 0 0
+
+
+0.25 0 0 8 0 0
+0.5 0 0 8 0 0
+
+
+0.25 0 0 8 0 0
+0.25 0.25 0 8 0 0
+
+
+0.25 0 0 8 0 0
+0.25 0 0.25 8 0 0
+
+
+0.5 0 0 8 0 0
+0.5 0.25 0 8 0 0
+
+
+0.5 0 0 8 0 0
+0.5 0 0.25 8 0 0
+
+
+0.25 0.25 0 8 0 0
+0.5 0.25 0 8 0 0
+
+
+0.25 0.25 0 8 0 0
+0.25 0.25 0.25 8 0 0
+
+
+0.5 0.25 0 8 0 0
+0.5 0.25 0.25 8 0 0
+
+
+0.25 0 0.25 8 0 0
+0.5 0 0.25 8 0 0
+
+
+0.25 0 0.25 8 0 0
+0.25 0.25 0.25 8 0 0
+
+
+0.5 0 0.25 8 0 0
+0.5 0.25 0.25 8 0 0
+
+
+0.25 0.25 0.25 8 0 0
+0.5 0.25 0.25 8 0 0
+
+
+0 0.25 0 9 0 0
+0.25 0.25 0 9 0 0
+
+
+0 0.25 0 9 0 0
+0 0.5 0 9 0 0
+
+
+0 0.25 0 9 0 0
+0 0.25 0.25 9 0 0
+
+
+0.25 0.25 0 9 0 0
+0.25 0.5 0 9 0 0
+
+
+0.25 0.25 0 9 0 0
+0.25 0.25 0.25 9 0 0
+
+
+0 0.5 0 9 0 0
+0.25 0.5 0 9 0 0
+
+
+0 0.5 0 9 0 0
+0 0.5 0.25 9 0 0
+
+
+0.25 0.5 0 9 0 0
+0.25 0.5 0.25 9 0 0
+
+
+0 0.25 0.25 9 0 0
+0.25 0.25 0.25 9 0 0
+
+
+0 0.25 0.25 9 0 0
+0 0.5 0.25 9 0 0
+
+
+0.25 0.25 0.25 9 0 0
+0.25 0.5 0.25 9 0 0
+
+
+0 0.5 0.25 9 0 0
+0.25 0.5 0.25 9 0 0
+
+
+0.25 0.25 0 10 0 0
+0.5 0.25 0 10 0 0
+
+
+0.25 0.25 0 10 0 0
+0.25 0.5 0 10 0 0
+
+
+0.25 0.25 0 10 0 0
+0.25 0.25 0.25 10 0 0
+
+
+0.5 0.25 0 10 0 0
+0.5 0.5 0 10 0 0
+
+
+0.5 0.25 0 10 0 0
+0.5 0.25 0.25 10 0 0
+
+
+0.25 0.5 0 10 0 0
+0.5 0.5 0 10 0 0
+
+
+0.25 0.5 0 10 0 0
+0.25 0.5 0.25 10 0 0
+
+
+0.5 0.5 0 10 0 0
+0.5 0.5 0.25 10 0 0
+
+
+0.25 0.25 0.25 10 0 0
+0.5 0.25 0.25 10 0 0
+
+
+0.25 0.25 0.25 10 0 0
+0.25 0.5 0.25 10 0 0
+
+
+0.5 0.25 0.25 10 0 0
+0.5 0.5 0.25 10 0 0
+
+
+0.25 0.5 0.25 10 0 0
+0.5 0.5 0.25 10 0 0
+
+
+0 0 0.25 11 0 0
+0.25 0 0.25 11 0 0
+
+
+0 0 0.25 11 0 0
+0 0.25 0.25 11 0 0
+
+
+0 0 0.25 11 0 0
+0 0 0.5 11 0 0
+
+
+0.25 0 0.25 11 0 0
+0.25 0.25 0.25 11 0 0
+
+
+0.25 0 0.25 11 0 0
+0.25 0 0.5 11 0 0
+
+
+0 0.25 0.25 11 0 0
+0.25 0.25 0.25 11 0 0
+
+
+0 0.25 0.25 11 0 0
+0 0.25 0.5 11 0 0
+
+
+0.25 0.25 0.25 11 0 0
+0.25 0.25 0.5 11 0 0
+
+
+0 0 0.5 11 0 0
+0.25 0 0.5 11 0 0
+
+
+0 0 0.5 11 0 0
+0 0.25 0.5 11 0 0
+
+
+0.25 0 0.5 11 0 0
+0.25 0.25 0.5 11 0 0
+
+
+0 0.25 0.5 11 0 0
+0.25 0.25 0.5 11 0 0
+
+
+0.25 0 0.25 12 0 0
+0.5 0 0.25 12 0 0
+
+
+0.25 0 0.25 12 0 0
+0.25 0.25 0.25 12 0 0
+
+
+0.25 0 0.25 12 0 0
+0.25 0 0.5 12 0 0
+
+
+0.5 0 0.25 12 0 0
+0.5 0.25 0.25 12 0 0
+
+
+0.5 0 0.25 12 0 0
+0.5 0 0.5 12 0 0
+
+
+0.25 0.25 0.25 12 0 0
+0.5 0.25 0.25 12 0 0
+
+
+0.25 0.25 0.25 12 0 0
+0.25 0.25 0.5 12 0 0
+
+
+0.5 0.25 0.25 12 0 0
+0.5 0.25 0.5 12 0 0
+
+
+0.25 0 0.5 12 0 0
+0.5 0 0.5 12 0 0
+
+
+0.25 0 0.5 12 0 0
+0.25 0.25 0.5 12 0 0
+
+
+0.5 0 0.5 12 0 0
+0.5 0.25 0.5 12 0 0
+
+
+0.25 0.25 0.5 12 0 0
+0.5 0.25 0.5 12 0 0
+
+
+0 0.25 0.25 13 0 0
+0.25 0.25 0.25 13 0 0
+
+
+0 0.25 0.25 13 0 0
+0 0.5 0.25 13 0 0
+
+
+0 0.25 0.25 13 0 0
+0 0.25 0.5 13 0 0
+
+
+0.25 0.25 0.25 13 0 0
+0.25 0.5 0.25 13 0 0
+
+
+0.25 0.25 0.25 13 0 0
+0.25 0.25 0.5 13 0 0
+
+
+0 0.5 0.25 13 0 0
+0.25 0.5 0.25 13 0 0
+
+
+0 0.5 0.25 13 0 0
+0 0.5 0.5 13 0 0
+
+
+0.25 0.5 0.25 13 0 0
+0.25 0.5 0.5 13 0 0
+
+
+0 0.25 0.5 13 0 0
+0.25 0.25 0.5 13 0 0
+
+
+0 0.25 0.5 13 0 0
+0 0.5 0.5 13 0 0
+
+
+0.25 0.25 0.5 13 0 0
+0.25 0.5 0.5 13 0 0
+
+
+0 0.5 0.5 13 0 0
+0.25 0.5 0.5 13 0 0
+
+
+0.25 0.25 0.25 14 0 0
+0.5 0.25 0.25 14 0 0
+
+
+0.25 0.25 0.25 14 0 0
+0.25 0.5 0.25 14 0 0
+
+
+0.25 0.25 0.25 14 0 0
+0.25 0.25 0.5 14 0 0
+
+
+0.5 0.25 0.25 14 0 0
+0.5 0.5 0.25 14 0 0
+
+
+0.5 0.25 0.25 14 0 0
+0.5 0.25 0.5 14 0 0
+
+
+0.25 0.5 0.25 14 0 0
+0.5 0.5 0.25 14 0 0
+
+
+0.25 0.5 0.25 14 0 0
+0.25 0.5 0.5 14 0 0
+
+
+0.5 0.5 0.25 14 0 0
+0.5 0.5 0.5 14 0 0
+
+
+0.25 0.25 0.5 14 0 0
+0.5 0.25 0.5 14 0 0
+
+
+0.25 0.25 0.5 14 0 0
+0.25 0.5 0.5 14 0 0
+
+
+0.5 0.25 0.5 14 0 0
+0.5 0.5 0.5 14 0 0
+
+
+0.25 0.5 0.5 14 0 0
+0.5 0.5 0.5 14 0 0
+
+