+++ /dev/null
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2000 - 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: create a FE field that has two components of
-// the kind cos(something) and sin(something) and then have a postprocessor
-// that computes the sum of squares. should always be equal to one
-
-
-#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_q.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 LaplaceProblem
-{
-public:
- LaplaceProblem ();
- void run ();
-
-private:
- void make_grid_and_dofs ();
- void solve ();
- void output_results () const;
-
- Triangulation<dim> triangulation;
- FESystem<dim> fe;
- DoFHandler<dim> dof_handler;
-
- Vector<double> solution;
-};
-
-
-template <int dim>
-LaplaceProblem<dim>::LaplaceProblem ()
- :
- fe (FE_Q<dim>(1),2),
- dof_handler (triangulation)
-{}
-
-
-
-template <int dim>
-void LaplaceProblem<dim>::make_grid_and_dofs ()
-{
- 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);
- solution.reinit (dof_handler.n_dofs());
-}
-
-
-
-template <int dim>
-class SinesAndCosines : public Function<dim>
-{
-public:
- SinesAndCosines ()
- :
- Function<dim> (2)
- {}
-
- double value (const Point<dim> &p,
- const unsigned int component) const
- {
- switch (component)
- {
- case 0:
- return std::sin (p.norm());
- case 1:
- return std::cos (p.norm());
- default:
- Assert (false, ExcNotImplemented());
- return 0;
- }
- }
-};
-
-
-
-template <int dim>
-void LaplaceProblem<dim>::solve ()
-{
- // dummy solve. just insert some
- // values as mentioned at the top
- // of the file
- VectorTools::interpolate (dof_handler,
- SinesAndCosines<dim>(),
- solution);
-}
-
-
-template <int dim>
-class MyPostprocessor : public DataPostprocessor<dim>
-{
-public:
- virtual std::vector<std::string> get_names () const
- {
- return std::vector<std::string>(1,"magnitude");
- }
-
- virtual
- std::vector<DataComponentInterpretation::DataComponentInterpretation>
- get_data_component_interpretation () const
- {
- return
- std::vector<DataComponentInterpretation::DataComponentInterpretation>
- (1,DataComponentInterpretation::component_is_scalar);
- }
-
- virtual UpdateFlags get_needed_update_flags () const
- {
- return update_values;
- }
-
- virtual
- void
- compute_derived_quantities_vector (const std::vector<Vector<double> > &solution_values,
- const std::vector<std::vector<Tensor<1,dim> > > &,
- const std::vector<std::vector<Tensor<2,dim> > > &,
- const std::vector<Point<dim> > &,
- const std::vector<Point<dim> > &,
- std::vector<Vector<double> > &computed_quantities) const
- {
- for (unsigned int q=0; q<solution_values.size(); ++q)
- {
- AssertThrow (computed_quantities[q].size() == 1,
- ExcInternalError());
-
- computed_quantities[q](0) = solution_values[q](0)*solution_values[q](0) + solution_values[q](1)*solution_values[q](1);
- AssertThrow (std::fabs(computed_quantities[q](0)-1) < 1e-12,
- ExcInternalError());
- }
- }
-};
-
-
-
-template <int dim>
-void LaplaceProblem<dim>::output_results () const
-{
- 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);
-}
-
-
-
-template <int dim>
-void LaplaceProblem<dim>::run ()
-{
- make_grid_and_dofs();
- solve ();
- output_results ();
-}
-
-
-
-int main ()
-{
- logfile << std::setprecision(2);
- deallog << std::setprecision(2);
-
- LaplaceProblem<2> laplace_problem_2d;
- laplace_problem_2d.run ();
-
- LaplaceProblem<3> laplace_problem_3d;
- laplace_problem_3d.run ();
-
- 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> <y> <magnitude>
-0.5 0 1
-1 0 1
-
-0.5 0.5 1
-1 0.5 1
-
-
-0 0.5 1
-0.5 0.5 1
-
-0 1 1
-0.5 1 1
-
-
-0.5 0.5 1
-1 0.5 1
-
-0.5 1 1
-1 1 1
-
-
-0 0 1
-0.25 0 1
-
-0 0.25 1
-0.25 0.25 1
-
-
-0.25 0 1
-0.5 0 1
-
-0.25 0.25 1
-0.5 0.25 1
-
-
-0 0.25 1
-0.25 0.25 1
-
-0 0.5 1
-0.25 0.5 1
-
-
-0.25 0.25 1
-0.5 0.25 1
-
-0.25 0.5 1
-0.5 0.5 1
-
-
-# This file was generated by the deal.II library.
-
-
-#
-# For a description of the GNUPLOT format see the GNUPLOT manual.
-#
-# <x> <y> <z> <magnitude>
-0.5 0 0 1
-1 0 0 1
-
-
-0.5 0 0 1
-0.5 0.5 0 1
-
-
-0.5 0 0 1
-0.5 0 0.5 1
-
-
-1 0 0 1
-1 0.5 0 1
-
-
-1 0 0 1
-1 0 0.5 1
-
-
-0.5 0.5 0 1
-1 0.5 0 1
-
-
-0.5 0.5 0 1
-0.5 0.5 0.5 1
-
-
-1 0.5 0 1
-1 0.5 0.5 1
-
-
-0.5 0 0.5 1
-1 0 0.5 1
-
-
-0.5 0 0.5 1
-0.5 0.5 0.5 1
-
-
-1 0 0.5 1
-1 0.5 0.5 1
-
-
-0.5 0.5 0.5 1
-1 0.5 0.5 1
-
-
-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 1
-1 0.5 0 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
-
-
-1 0.5 0 1
-1 1 0 1
-
-
-1 0.5 0 1
-1 0.5 0.5 1
-
-
-0.5 1 0 1
-1 1 0 1
-
-
-0.5 1 0 1
-0.5 1 0.5 1
-
-
-1 1 0 1
-1 1 0.5 1
-
-
-0.5 0.5 0.5 1
-1 0.5 0.5 1
-
-
-0.5 0.5 0.5 1
-0.5 1 0.5 1
-
-
-1 0.5 0.5 1
-1 1 0.5 1
-
-
-0.5 1 0.5 1
-1 1 0.5 1
-
-
-0 0 0.5 1
-0.5 0 0.5 1
-
-
-0 0 0.5 1
-0 0.5 0.5 1
-
-
-0 0 0.5 1
-0 0 1 1
-
-
-0.5 0 0.5 1
-0.5 0.5 0.5 1
-
-
-0.5 0 0.5 1
-0.5 0 1 1
-
-
-0 0.5 0.5 1
-0.5 0.5 0.5 1
-
-
-0 0.5 0.5 1
-0 0.5 1 1
-
-
-0.5 0.5 0.5 1
-0.5 0.5 1 1
-
-
-0 0 1 1
-0.5 0 1 1
-
-
-0 0 1 1
-0 0.5 1 1
-
-
-0.5 0 1 1
-0.5 0.5 1 1
-
-
-0 0.5 1 1
-0.5 0.5 1 1
-
-
-0.5 0 0.5 1
-1 0 0.5 1
-
-
-0.5 0 0.5 1
-0.5 0.5 0.5 1
-
-
-0.5 0 0.5 1
-0.5 0 1 1
-
-
-1 0 0.5 1
-1 0.5 0.5 1
-
-
-1 0 0.5 1
-1 0 1 1
-
-
-0.5 0.5 0.5 1
-1 0.5 0.5 1
-
-
-0.5 0.5 0.5 1
-0.5 0.5 1 1
-
-
-1 0.5 0.5 1
-1 0.5 1 1
-
-
-0.5 0 1 1
-1 0 1 1
-
-
-0.5 0 1 1
-0.5 0.5 1 1
-
-
-1 0 1 1
-1 0.5 1 1
-
-
-0.5 0.5 1 1
-1 0.5 1 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 0.5 0.5 1
-0 0.5 1 1
-
-
-0.5 0.5 0.5 1
-0.5 1 0.5 1
-
-
-0.5 0.5 0.5 1
-0.5 0.5 1 1
-
-
-0 1 0.5 1
-0.5 1 0.5 1
-
-
-0 1 0.5 1
-0 1 1 1
-
-
-0.5 1 0.5 1
-0.5 1 1 1
-
-
-0 0.5 1 1
-0.5 0.5 1 1
-
-
-0 0.5 1 1
-0 1 1 1
-
-
-0.5 0.5 1 1
-0.5 1 1 1
-
-
-0 1 1 1
-0.5 1 1 1
-
-
-0.5 0.5 0.5 1
-1 0.5 0.5 1
-
-
-0.5 0.5 0.5 1
-0.5 1 0.5 1
-
-
-0.5 0.5 0.5 1
-0.5 0.5 1 1
-
-
-1 0.5 0.5 1
-1 1 0.5 1
-
-
-1 0.5 0.5 1
-1 0.5 1 1
-
-
-0.5 1 0.5 1
-1 1 0.5 1
-
-
-0.5 1 0.5 1
-0.5 1 1 1
-
-
-1 1 0.5 1
-1 1 1 1
-
-
-0.5 0.5 1 1
-1 0.5 1 1
-
-
-0.5 0.5 1 1
-0.5 1 1 1
-
-
-1 0.5 1 1
-1 1 1 1
-
-
-0.5 1 1 1
-1 1 1 1
-
-
-0 0 0 1
-0.25 0 0 1
-
-
-0 0 0 1
-0 0.25 0 1
-
-
-0 0 0 1
-0 0 0.25 1
-
-
-0.25 0 0 1
-0.25 0.25 0 1
-
-
-0.25 0 0 1
-0.25 0 0.25 1
-
-
-0 0.25 0 1
-0.25 0.25 0 1
-
-
-0 0.25 0 1
-0 0.25 0.25 1
-
-
-0.25 0.25 0 1
-0.25 0.25 0.25 1
-
-
-0 0 0.25 1
-0.25 0 0.25 1
-
-
-0 0 0.25 1
-0 0.25 0.25 1
-
-
-0.25 0 0.25 1
-0.25 0.25 0.25 1
-
-
-0 0.25 0.25 1
-0.25 0.25 0.25 1
-
-
-0.25 0 0 1
-0.5 0 0 1
-
-
-0.25 0 0 1
-0.25 0.25 0 1
-
-
-0.25 0 0 1
-0.25 0 0.25 1
-
-
-0.5 0 0 1
-0.5 0.25 0 1
-
-
-0.5 0 0 1
-0.5 0 0.25 1
-
-
-0.25 0.25 0 1
-0.5 0.25 0 1
-
-
-0.25 0.25 0 1
-0.25 0.25 0.25 1
-
-
-0.5 0.25 0 1
-0.5 0.25 0.25 1
-
-
-0.25 0 0.25 1
-0.5 0 0.25 1
-
-
-0.25 0 0.25 1
-0.25 0.25 0.25 1
-
-
-0.5 0 0.25 1
-0.5 0.25 0.25 1
-
-
-0.25 0.25 0.25 1
-0.5 0.25 0.25 1
-
-
-0 0.25 0 1
-0.25 0.25 0 1
-
-
-0 0.25 0 1
-0 0.5 0 1
-
-
-0 0.25 0 1
-0 0.25 0.25 1
-
-
-0.25 0.25 0 1
-0.25 0.5 0 1
-
-
-0.25 0.25 0 1
-0.25 0.25 0.25 1
-
-
-0 0.5 0 1
-0.25 0.5 0 1
-
-
-0 0.5 0 1
-0 0.5 0.25 1
-
-
-0.25 0.5 0 1
-0.25 0.5 0.25 1
-
-
-0 0.25 0.25 1
-0.25 0.25 0.25 1
-
-
-0 0.25 0.25 1
-0 0.5 0.25 1
-
-
-0.25 0.25 0.25 1
-0.25 0.5 0.25 1
-
-
-0 0.5 0.25 1
-0.25 0.5 0.25 1
-
-
-0.25 0.25 0 1
-0.5 0.25 0 1
-
-
-0.25 0.25 0 1
-0.25 0.5 0 1
-
-
-0.25 0.25 0 1
-0.25 0.25 0.25 1
-
-
-0.5 0.25 0 1
-0.5 0.5 0 1
-
-
-0.5 0.25 0 1
-0.5 0.25 0.25 1
-
-
-0.25 0.5 0 1
-0.5 0.5 0 1
-
-
-0.25 0.5 0 1
-0.25 0.5 0.25 1
-
-
-0.5 0.5 0 1
-0.5 0.5 0.25 1
-
-
-0.25 0.25 0.25 1
-0.5 0.25 0.25 1
-
-
-0.25 0.25 0.25 1
-0.25 0.5 0.25 1
-
-
-0.5 0.25 0.25 1
-0.5 0.5 0.25 1
-
-
-0.25 0.5 0.25 1
-0.5 0.5 0.25 1
-
-
-0 0 0.25 1
-0.25 0 0.25 1
-
-
-0 0 0.25 1
-0 0.25 0.25 1
-
-
-0 0 0.25 1
-0 0 0.5 1
-
-
-0.25 0 0.25 1
-0.25 0.25 0.25 1
-
-
-0.25 0 0.25 1
-0.25 0 0.5 1
-
-
-0 0.25 0.25 1
-0.25 0.25 0.25 1
-
-
-0 0.25 0.25 1
-0 0.25 0.5 1
-
-
-0.25 0.25 0.25 1
-0.25 0.25 0.5 1
-
-
-0 0 0.5 1
-0.25 0 0.5 1
-
-
-0 0 0.5 1
-0 0.25 0.5 1
-
-
-0.25 0 0.5 1
-0.25 0.25 0.5 1
-
-
-0 0.25 0.5 1
-0.25 0.25 0.5 1
-
-
-0.25 0 0.25 1
-0.5 0 0.25 1
-
-
-0.25 0 0.25 1
-0.25 0.25 0.25 1
-
-
-0.25 0 0.25 1
-0.25 0 0.5 1
-
-
-0.5 0 0.25 1
-0.5 0.25 0.25 1
-
-
-0.5 0 0.25 1
-0.5 0 0.5 1
-
-
-0.25 0.25 0.25 1
-0.5 0.25 0.25 1
-
-
-0.25 0.25 0.25 1
-0.25 0.25 0.5 1
-
-
-0.5 0.25 0.25 1
-0.5 0.25 0.5 1
-
-
-0.25 0 0.5 1
-0.5 0 0.5 1
-
-
-0.25 0 0.5 1
-0.25 0.25 0.5 1
-
-
-0.5 0 0.5 1
-0.5 0.25 0.5 1
-
-
-0.25 0.25 0.5 1
-0.5 0.25 0.5 1
-
-
-0 0.25 0.25 1
-0.25 0.25 0.25 1
-
-
-0 0.25 0.25 1
-0 0.5 0.25 1
-
-
-0 0.25 0.25 1
-0 0.25 0.5 1
-
-
-0.25 0.25 0.25 1
-0.25 0.5 0.25 1
-
-
-0.25 0.25 0.25 1
-0.25 0.25 0.5 1
-
-
-0 0.5 0.25 1
-0.25 0.5 0.25 1
-
-
-0 0.5 0.25 1
-0 0.5 0.5 1
-
-
-0.25 0.5 0.25 1
-0.25 0.5 0.5 1
-
-
-0 0.25 0.5 1
-0.25 0.25 0.5 1
-
-
-0 0.25 0.5 1
-0 0.5 0.5 1
-
-
-0.25 0.25 0.5 1
-0.25 0.5 0.5 1
-
-
-0 0.5 0.5 1
-0.25 0.5 0.5 1
-
-
-0.25 0.25 0.25 1
-0.5 0.25 0.25 1
-
-
-0.25 0.25 0.25 1
-0.25 0.5 0.25 1
-
-
-0.25 0.25 0.25 1
-0.25 0.25 0.5 1
-
-
-0.5 0.25 0.25 1
-0.5 0.5 0.25 1
-
-
-0.5 0.25 0.25 1
-0.5 0.25 0.5 1
-
-
-0.25 0.5 0.25 1
-0.5 0.5 0.25 1
-
-
-0.25 0.5 0.25 1
-0.25 0.5 0.5 1
-
-
-0.5 0.5 0.25 1
-0.5 0.5 0.5 1
-
-
-0.25 0.25 0.5 1
-0.5 0.25 0.5 1
-
-
-0.25 0.25 0.5 1
-0.25 0.5 0.5 1
-
-
-0.5 0.25 0.5 1
-0.5 0.5 0.5 1
-
-
-0.25 0.5 0.5 1
-0.5 0.5 0.5 1
-
-
+++ /dev/null
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2000 - 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: create a FE field that has two components of
-// the kind cos(something) and sin(something) and then have a postprocessor
-// that computes the sum of squares. should always be equal to one
-//
-// this test uses the shortcut class DataPostprocessorScalar to make
-// writing postprocessors simpler
-
-
-#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_q.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 LaplaceProblem
-{
-public:
- LaplaceProblem ();
- void run ();
-
-private:
- void make_grid_and_dofs ();
- void solve ();
- void output_results () const;
-
- Triangulation<dim> triangulation;
- FESystem<dim> fe;
- DoFHandler<dim> dof_handler;
-
- Vector<double> solution;
-};
-
-
-template <int dim>
-LaplaceProblem<dim>::LaplaceProblem ()
- :
- fe (FE_Q<dim>(1),2),
- dof_handler (triangulation)
-{}
-
-
-
-template <int dim>
-void LaplaceProblem<dim>::make_grid_and_dofs ()
-{
- 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);
- solution.reinit (dof_handler.n_dofs());
-}
-
-
-
-template <int dim>
-class SinesAndCosines : public Function<dim>
-{
-public:
- SinesAndCosines ()
- :
- Function<dim> (2)
- {}
-
- double value (const Point<dim> &p,
- const unsigned int component) const
- {
- switch (component)
- {
- case 0:
- return std::sin (p.norm());
- case 1:
- return std::cos (p.norm());
- default:
- Assert (false, ExcNotImplemented());
- return 0;
- }
- }
-};
-
-
-
-template <int dim>
-void LaplaceProblem<dim>::solve ()
-{
- // dummy solve. just insert some
- // values as mentioned at the top
- // of the file
- VectorTools::interpolate (dof_handler,
- SinesAndCosines<dim>(),
- solution);
-}
-
-
-template <int dim>
-class MyPostprocessor : public DataPostprocessorScalar<dim>
-{
-public:
- MyPostprocessor ()
- :
- DataPostprocessorScalar<dim> ("magnitude", update_values)
- {}
-
- virtual
- void
- compute_derived_quantities_vector (const std::vector<Vector<double> > &solution_values,
- const std::vector<std::vector<Tensor<1,dim> > > &,
- const std::vector<std::vector<Tensor<2,dim> > > &,
- const std::vector<Point<dim> > &,
- const std::vector<Point<dim> > &,
- std::vector<Vector<double> > &computed_quantities) const
- {
- for (unsigned int q=0; q<solution_values.size(); ++q)
- {
- Assert (computed_quantities[q].size() == 1,
- ExcInternalError());
-
- computed_quantities[q](0) = solution_values[q](0)*solution_values[q](0) + solution_values[q](1)*solution_values[q](1);
- AssertThrow (std::fabs(computed_quantities[q](0)-1) < 1e-12,
- ExcInternalError());
- }
- }
-};
-
-
-
-template <int dim>
-void LaplaceProblem<dim>::output_results () const
-{
- 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);
-}
-
-
-
-template <int dim>
-void LaplaceProblem<dim>::run ()
-{
- make_grid_and_dofs();
- solve ();
- output_results ();
-}
-
-
-
-int main ()
-{
- logfile << std::setprecision(2);
- deallog << std::setprecision(2);
-
- LaplaceProblem<2> laplace_problem_2d;
- laplace_problem_2d.run ();
-
- LaplaceProblem<3> laplace_problem_3d;
- laplace_problem_3d.run ();
-
- 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> <y> <magnitude>
-0.5 0 1
-1 0 1
-
-0.5 0.5 1
-1 0.5 1
-
-
-0 0.5 1
-0.5 0.5 1
-
-0 1 1
-0.5 1 1
-
-
-0.5 0.5 1
-1 0.5 1
-
-0.5 1 1
-1 1 1
-
-
-0 0 1
-0.25 0 1
-
-0 0.25 1
-0.25 0.25 1
-
-
-0.25 0 1
-0.5 0 1
-
-0.25 0.25 1
-0.5 0.25 1
-
-
-0 0.25 1
-0.25 0.25 1
-
-0 0.5 1
-0.25 0.5 1
-
-
-0.25 0.25 1
-0.5 0.25 1
-
-0.25 0.5 1
-0.5 0.5 1
-
-
-# This file was generated by the deal.II library.
-
-
-#
-# For a description of the GNUPLOT format see the GNUPLOT manual.
-#
-# <x> <y> <z> <magnitude>
-0.5 0 0 1
-1 0 0 1
-
-
-0.5 0 0 1
-0.5 0.5 0 1
-
-
-0.5 0 0 1
-0.5 0 0.5 1
-
-
-1 0 0 1
-1 0.5 0 1
-
-
-1 0 0 1
-1 0 0.5 1
-
-
-0.5 0.5 0 1
-1 0.5 0 1
-
-
-0.5 0.5 0 1
-0.5 0.5 0.5 1
-
-
-1 0.5 0 1
-1 0.5 0.5 1
-
-
-0.5 0 0.5 1
-1 0 0.5 1
-
-
-0.5 0 0.5 1
-0.5 0.5 0.5 1
-
-
-1 0 0.5 1
-1 0.5 0.5 1
-
-
-0.5 0.5 0.5 1
-1 0.5 0.5 1
-
-
-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 1
-1 0.5 0 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
-
-
-1 0.5 0 1
-1 1 0 1
-
-
-1 0.5 0 1
-1 0.5 0.5 1
-
-
-0.5 1 0 1
-1 1 0 1
-
-
-0.5 1 0 1
-0.5 1 0.5 1
-
-
-1 1 0 1
-1 1 0.5 1
-
-
-0.5 0.5 0.5 1
-1 0.5 0.5 1
-
-
-0.5 0.5 0.5 1
-0.5 1 0.5 1
-
-
-1 0.5 0.5 1
-1 1 0.5 1
-
-
-0.5 1 0.5 1
-1 1 0.5 1
-
-
-0 0 0.5 1
-0.5 0 0.5 1
-
-
-0 0 0.5 1
-0 0.5 0.5 1
-
-
-0 0 0.5 1
-0 0 1 1
-
-
-0.5 0 0.5 1
-0.5 0.5 0.5 1
-
-
-0.5 0 0.5 1
-0.5 0 1 1
-
-
-0 0.5 0.5 1
-0.5 0.5 0.5 1
-
-
-0 0.5 0.5 1
-0 0.5 1 1
-
-
-0.5 0.5 0.5 1
-0.5 0.5 1 1
-
-
-0 0 1 1
-0.5 0 1 1
-
-
-0 0 1 1
-0 0.5 1 1
-
-
-0.5 0 1 1
-0.5 0.5 1 1
-
-
-0 0.5 1 1
-0.5 0.5 1 1
-
-
-0.5 0 0.5 1
-1 0 0.5 1
-
-
-0.5 0 0.5 1
-0.5 0.5 0.5 1
-
-
-0.5 0 0.5 1
-0.5 0 1 1
-
-
-1 0 0.5 1
-1 0.5 0.5 1
-
-
-1 0 0.5 1
-1 0 1 1
-
-
-0.5 0.5 0.5 1
-1 0.5 0.5 1
-
-
-0.5 0.5 0.5 1
-0.5 0.5 1 1
-
-
-1 0.5 0.5 1
-1 0.5 1 1
-
-
-0.5 0 1 1
-1 0 1 1
-
-
-0.5 0 1 1
-0.5 0.5 1 1
-
-
-1 0 1 1
-1 0.5 1 1
-
-
-0.5 0.5 1 1
-1 0.5 1 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 0.5 0.5 1
-0 0.5 1 1
-
-
-0.5 0.5 0.5 1
-0.5 1 0.5 1
-
-
-0.5 0.5 0.5 1
-0.5 0.5 1 1
-
-
-0 1 0.5 1
-0.5 1 0.5 1
-
-
-0 1 0.5 1
-0 1 1 1
-
-
-0.5 1 0.5 1
-0.5 1 1 1
-
-
-0 0.5 1 1
-0.5 0.5 1 1
-
-
-0 0.5 1 1
-0 1 1 1
-
-
-0.5 0.5 1 1
-0.5 1 1 1
-
-
-0 1 1 1
-0.5 1 1 1
-
-
-0.5 0.5 0.5 1
-1 0.5 0.5 1
-
-
-0.5 0.5 0.5 1
-0.5 1 0.5 1
-
-
-0.5 0.5 0.5 1
-0.5 0.5 1 1
-
-
-1 0.5 0.5 1
-1 1 0.5 1
-
-
-1 0.5 0.5 1
-1 0.5 1 1
-
-
-0.5 1 0.5 1
-1 1 0.5 1
-
-
-0.5 1 0.5 1
-0.5 1 1 1
-
-
-1 1 0.5 1
-1 1 1 1
-
-
-0.5 0.5 1 1
-1 0.5 1 1
-
-
-0.5 0.5 1 1
-0.5 1 1 1
-
-
-1 0.5 1 1
-1 1 1 1
-
-
-0.5 1 1 1
-1 1 1 1
-
-
-0 0 0 1
-0.25 0 0 1
-
-
-0 0 0 1
-0 0.25 0 1
-
-
-0 0 0 1
-0 0 0.25 1
-
-
-0.25 0 0 1
-0.25 0.25 0 1
-
-
-0.25 0 0 1
-0.25 0 0.25 1
-
-
-0 0.25 0 1
-0.25 0.25 0 1
-
-
-0 0.25 0 1
-0 0.25 0.25 1
-
-
-0.25 0.25 0 1
-0.25 0.25 0.25 1
-
-
-0 0 0.25 1
-0.25 0 0.25 1
-
-
-0 0 0.25 1
-0 0.25 0.25 1
-
-
-0.25 0 0.25 1
-0.25 0.25 0.25 1
-
-
-0 0.25 0.25 1
-0.25 0.25 0.25 1
-
-
-0.25 0 0 1
-0.5 0 0 1
-
-
-0.25 0 0 1
-0.25 0.25 0 1
-
-
-0.25 0 0 1
-0.25 0 0.25 1
-
-
-0.5 0 0 1
-0.5 0.25 0 1
-
-
-0.5 0 0 1
-0.5 0 0.25 1
-
-
-0.25 0.25 0 1
-0.5 0.25 0 1
-
-
-0.25 0.25 0 1
-0.25 0.25 0.25 1
-
-
-0.5 0.25 0 1
-0.5 0.25 0.25 1
-
-
-0.25 0 0.25 1
-0.5 0 0.25 1
-
-
-0.25 0 0.25 1
-0.25 0.25 0.25 1
-
-
-0.5 0 0.25 1
-0.5 0.25 0.25 1
-
-
-0.25 0.25 0.25 1
-0.5 0.25 0.25 1
-
-
-0 0.25 0 1
-0.25 0.25 0 1
-
-
-0 0.25 0 1
-0 0.5 0 1
-
-
-0 0.25 0 1
-0 0.25 0.25 1
-
-
-0.25 0.25 0 1
-0.25 0.5 0 1
-
-
-0.25 0.25 0 1
-0.25 0.25 0.25 1
-
-
-0 0.5 0 1
-0.25 0.5 0 1
-
-
-0 0.5 0 1
-0 0.5 0.25 1
-
-
-0.25 0.5 0 1
-0.25 0.5 0.25 1
-
-
-0 0.25 0.25 1
-0.25 0.25 0.25 1
-
-
-0 0.25 0.25 1
-0 0.5 0.25 1
-
-
-0.25 0.25 0.25 1
-0.25 0.5 0.25 1
-
-
-0 0.5 0.25 1
-0.25 0.5 0.25 1
-
-
-0.25 0.25 0 1
-0.5 0.25 0 1
-
-
-0.25 0.25 0 1
-0.25 0.5 0 1
-
-
-0.25 0.25 0 1
-0.25 0.25 0.25 1
-
-
-0.5 0.25 0 1
-0.5 0.5 0 1
-
-
-0.5 0.25 0 1
-0.5 0.25 0.25 1
-
-
-0.25 0.5 0 1
-0.5 0.5 0 1
-
-
-0.25 0.5 0 1
-0.25 0.5 0.25 1
-
-
-0.5 0.5 0 1
-0.5 0.5 0.25 1
-
-
-0.25 0.25 0.25 1
-0.5 0.25 0.25 1
-
-
-0.25 0.25 0.25 1
-0.25 0.5 0.25 1
-
-
-0.5 0.25 0.25 1
-0.5 0.5 0.25 1
-
-
-0.25 0.5 0.25 1
-0.5 0.5 0.25 1
-
-
-0 0 0.25 1
-0.25 0 0.25 1
-
-
-0 0 0.25 1
-0 0.25 0.25 1
-
-
-0 0 0.25 1
-0 0 0.5 1
-
-
-0.25 0 0.25 1
-0.25 0.25 0.25 1
-
-
-0.25 0 0.25 1
-0.25 0 0.5 1
-
-
-0 0.25 0.25 1
-0.25 0.25 0.25 1
-
-
-0 0.25 0.25 1
-0 0.25 0.5 1
-
-
-0.25 0.25 0.25 1
-0.25 0.25 0.5 1
-
-
-0 0 0.5 1
-0.25 0 0.5 1
-
-
-0 0 0.5 1
-0 0.25 0.5 1
-
-
-0.25 0 0.5 1
-0.25 0.25 0.5 1
-
-
-0 0.25 0.5 1
-0.25 0.25 0.5 1
-
-
-0.25 0 0.25 1
-0.5 0 0.25 1
-
-
-0.25 0 0.25 1
-0.25 0.25 0.25 1
-
-
-0.25 0 0.25 1
-0.25 0 0.5 1
-
-
-0.5 0 0.25 1
-0.5 0.25 0.25 1
-
-
-0.5 0 0.25 1
-0.5 0 0.5 1
-
-
-0.25 0.25 0.25 1
-0.5 0.25 0.25 1
-
-
-0.25 0.25 0.25 1
-0.25 0.25 0.5 1
-
-
-0.5 0.25 0.25 1
-0.5 0.25 0.5 1
-
-
-0.25 0 0.5 1
-0.5 0 0.5 1
-
-
-0.25 0 0.5 1
-0.25 0.25 0.5 1
-
-
-0.5 0 0.5 1
-0.5 0.25 0.5 1
-
-
-0.25 0.25 0.5 1
-0.5 0.25 0.5 1
-
-
-0 0.25 0.25 1
-0.25 0.25 0.25 1
-
-
-0 0.25 0.25 1
-0 0.5 0.25 1
-
-
-0 0.25 0.25 1
-0 0.25 0.5 1
-
-
-0.25 0.25 0.25 1
-0.25 0.5 0.25 1
-
-
-0.25 0.25 0.25 1
-0.25 0.25 0.5 1
-
-
-0 0.5 0.25 1
-0.25 0.5 0.25 1
-
-
-0 0.5 0.25 1
-0 0.5 0.5 1
-
-
-0.25 0.5 0.25 1
-0.25 0.5 0.5 1
-
-
-0 0.25 0.5 1
-0.25 0.25 0.5 1
-
-
-0 0.25 0.5 1
-0 0.5 0.5 1
-
-
-0.25 0.25 0.5 1
-0.25 0.5 0.5 1
-
-
-0 0.5 0.5 1
-0.25 0.5 0.5 1
-
-
-0.25 0.25 0.25 1
-0.5 0.25 0.25 1
-
-
-0.25 0.25 0.25 1
-0.25 0.5 0.25 1
-
-
-0.25 0.25 0.25 1
-0.25 0.25 0.5 1
-
-
-0.5 0.25 0.25 1
-0.5 0.5 0.25 1
-
-
-0.5 0.25 0.25 1
-0.5 0.25 0.5 1
-
-
-0.25 0.5 0.25 1
-0.5 0.5 0.25 1
-
-
-0.25 0.5 0.25 1
-0.25 0.5 0.5 1
-
-
-0.5 0.5 0.25 1
-0.5 0.5 0.5 1
-
-
-0.25 0.25 0.5 1
-0.5 0.25 0.5 1
-
-
-0.25 0.25 0.5 1
-0.25 0.5 0.5 1
-
-
-0.5 0.25 0.5 1
-0.5 0.5 0.5 1
-
-
-0.25 0.5 0.5 1
-0.5 0.5 0.5 1
-
-
+++ /dev/null
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2000 - 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: create a FE field that has two components of
-// the kind cos(something) and sin(something) and then have a postprocessor
-// that computes the sum of squares. should always be equal to one
-//
-// this test uses the shortcut class DataPostprocessorVector to make
-// writing postprocessors simpler
-
-
-#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_q.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 LaplaceProblem
-{
-public:
- LaplaceProblem ();
- void run ();
-
-private:
- void make_grid_and_dofs ();
- void solve ();
- void output_results () const;
-
- Triangulation<dim> triangulation;
- FESystem<dim> fe;
- DoFHandler<dim> dof_handler;
-
- Vector<double> solution;
-};
-
-
-template <int dim>
-LaplaceProblem<dim>::LaplaceProblem ()
- :
- fe (FE_Q<dim>(1),2),
- dof_handler (triangulation)
-{}
-
-
-
-template <int dim>
-void LaplaceProblem<dim>::make_grid_and_dofs ()
-{
- 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);
- solution.reinit (dof_handler.n_dofs());
-}
-
-
-
-template <int dim>
-class SinesAndCosines : public Function<dim>
-{
-public:
- SinesAndCosines ()
- :
- Function<dim> (2)
- {}
-
- double value (const Point<dim> &p,
- const unsigned int component) const
- {
- switch (component)
- {
- case 0:
- return std::sin (p.norm());
- case 1:
- return std::cos (p.norm());
- default:
- Assert (false, ExcNotImplemented());
- return 0;
- }
- }
-};
-
-
-
-template <int dim>
-void LaplaceProblem<dim>::solve ()
-{
- // dummy solve. just insert some
- // values as mentioned at the top
- // of the file
- VectorTools::interpolate (dof_handler,
- SinesAndCosines<dim>(),
- solution);
-}
-
-
-template <int dim>
-class MyPostprocessor : public DataPostprocessorVector<dim>
-{
-public:
- MyPostprocessor ()
- :
- DataPostprocessorVector<dim> ("magnitude_times_d", update_values)
- {}
-
- virtual
- void
- compute_derived_quantities_vector (const std::vector<Vector<double> > &solution_values,
- const std::vector<std::vector<Tensor<1,dim> > > &,
- const std::vector<std::vector<Tensor<2,dim> > > &,
- const std::vector<Point<dim> > &,
- const std::vector<Point<dim> > &,
- std::vector<Vector<double> > &computed_quantities) const
- {
- for (unsigned int q=0; q<solution_values.size(); ++q)
- {
- Assert (computed_quantities[q].size() == dim,
- ExcInternalError());
-
- for (unsigned int d=0; d<dim; ++d)
- computed_quantities[q](d) = solution_values[q](0)*solution_values[q](0) + solution_values[q](1)*solution_values[q](1);
- AssertThrow (std::fabs(computed_quantities[q](0)-1) < 1e-12,
- ExcInternalError());
- }
- }
-};
-
-
-
-template <int dim>
-void LaplaceProblem<dim>::output_results () const
-{
- 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);
-}
-
-
-
-template <int dim>
-void LaplaceProblem<dim>::run ()
-{
- make_grid_and_dofs();
- solve ();
- output_results ();
-}
-
-
-
-int main ()
-{
- logfile << std::setprecision(2);
- deallog << std::setprecision(2);
-
- LaplaceProblem<2> laplace_problem_2d;
- laplace_problem_2d.run ();
-
- LaplaceProblem<3> laplace_problem_3d;
- laplace_problem_3d.run ();
-
- 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> <y> <magnitude_times_d> <magnitude_times_d>
-0.5 0 1 1
-1 0 1 1
-
-0.5 0.5 1 1
-1 0.5 1 1
-
-
-0 0.5 1 1
-0.5 0.5 1 1
-
-0 1 1 1
-0.5 1 1 1
-
-
-0.5 0.5 1 1
-1 0.5 1 1
-
-0.5 1 1 1
-1 1 1 1
-
-
-0 0 1 1
-0.25 0 1 1
-
-0 0.25 1 1
-0.25 0.25 1 1
-
-
-0.25 0 1 1
-0.5 0 1 1
-
-0.25 0.25 1 1
-0.5 0.25 1 1
-
-
-0 0.25 1 1
-0.25 0.25 1 1
-
-0 0.5 1 1
-0.25 0.5 1 1
-
-
-0.25 0.25 1 1
-0.5 0.25 1 1
-
-0.25 0.5 1 1
-0.5 0.5 1 1
-
-
-# This file was generated by the deal.II library.
-
-
-#
-# For a description of the GNUPLOT format see the GNUPLOT manual.
-#
-# <x> <y> <z> <magnitude_times_d> <magnitude_times_d> <magnitude_times_d>
-0.5 0 0 1 1 1
-1 0 0 1 1 1
-
-
-0.5 0 0 1 1 1
-0.5 0.5 0 1 1 1
-
-
-0.5 0 0 1 1 1
-0.5 0 0.5 1 1 1
-
-
-1 0 0 1 1 1
-1 0.5 0 1 1 1
-
-
-1 0 0 1 1 1
-1 0 0.5 1 1 1
-
-
-0.5 0.5 0 1 1 1
-1 0.5 0 1 1 1
-
-
-0.5 0.5 0 1 1 1
-0.5 0.5 0.5 1 1 1
-
-
-1 0.5 0 1 1 1
-1 0.5 0.5 1 1 1
-
-
-0.5 0 0.5 1 1 1
-1 0 0.5 1 1 1
-
-
-0.5 0 0.5 1 1 1
-0.5 0.5 0.5 1 1 1
-
-
-1 0 0.5 1 1 1
-1 0.5 0.5 1 1 1
-
-
-0.5 0.5 0.5 1 1 1
-1 0.5 0.5 1 1 1
-
-
-0 0.5 0 1 1 1
-0.5 0.5 0 1 1 1
-
-
-0 0.5 0 1 1 1
-0 1 0 1 1 1
-
-
-0 0.5 0 1 1 1
-0 0.5 0.5 1 1 1
-
-
-0.5 0.5 0 1 1 1
-0.5 1 0 1 1 1
-
-
-0.5 0.5 0 1 1 1
-0.5 0.5 0.5 1 1 1
-
-
-0 1 0 1 1 1
-0.5 1 0 1 1 1
-
-
-0 1 0 1 1 1
-0 1 0.5 1 1 1
-
-
-0.5 1 0 1 1 1
-0.5 1 0.5 1 1 1
-
-
-0 0.5 0.5 1 1 1
-0.5 0.5 0.5 1 1 1
-
-
-0 0.5 0.5 1 1 1
-0 1 0.5 1 1 1
-
-
-0.5 0.5 0.5 1 1 1
-0.5 1 0.5 1 1 1
-
-
-0 1 0.5 1 1 1
-0.5 1 0.5 1 1 1
-
-
-0.5 0.5 0 1 1 1
-1 0.5 0 1 1 1
-
-
-0.5 0.5 0 1 1 1
-0.5 1 0 1 1 1
-
-
-0.5 0.5 0 1 1 1
-0.5 0.5 0.5 1 1 1
-
-
-1 0.5 0 1 1 1
-1 1 0 1 1 1
-
-
-1 0.5 0 1 1 1
-1 0.5 0.5 1 1 1
-
-
-0.5 1 0 1 1 1
-1 1 0 1 1 1
-
-
-0.5 1 0 1 1 1
-0.5 1 0.5 1 1 1
-
-
-1 1 0 1 1 1
-1 1 0.5 1 1 1
-
-
-0.5 0.5 0.5 1 1 1
-1 0.5 0.5 1 1 1
-
-
-0.5 0.5 0.5 1 1 1
-0.5 1 0.5 1 1 1
-
-
-1 0.5 0.5 1 1 1
-1 1 0.5 1 1 1
-
-
-0.5 1 0.5 1 1 1
-1 1 0.5 1 1 1
-
-
-0 0 0.5 1 1 1
-0.5 0 0.5 1 1 1
-
-
-0 0 0.5 1 1 1
-0 0.5 0.5 1 1 1
-
-
-0 0 0.5 1 1 1
-0 0 1 1 1 1
-
-
-0.5 0 0.5 1 1 1
-0.5 0.5 0.5 1 1 1
-
-
-0.5 0 0.5 1 1 1
-0.5 0 1 1 1 1
-
-
-0 0.5 0.5 1 1 1
-0.5 0.5 0.5 1 1 1
-
-
-0 0.5 0.5 1 1 1
-0 0.5 1 1 1 1
-
-
-0.5 0.5 0.5 1 1 1
-0.5 0.5 1 1 1 1
-
-
-0 0 1 1 1 1
-0.5 0 1 1 1 1
-
-
-0 0 1 1 1 1
-0 0.5 1 1 1 1
-
-
-0.5 0 1 1 1 1
-0.5 0.5 1 1 1 1
-
-
-0 0.5 1 1 1 1
-0.5 0.5 1 1 1 1
-
-
-0.5 0 0.5 1 1 1
-1 0 0.5 1 1 1
-
-
-0.5 0 0.5 1 1 1
-0.5 0.5 0.5 1 1 1
-
-
-0.5 0 0.5 1 1 1
-0.5 0 1 1 1 1
-
-
-1 0 0.5 1 1 1
-1 0.5 0.5 1 1 1
-
-
-1 0 0.5 1 1 1
-1 0 1 1 1 1
-
-
-0.5 0.5 0.5 1 1 1
-1 0.5 0.5 1 1 1
-
-
-0.5 0.5 0.5 1 1 1
-0.5 0.5 1 1 1 1
-
-
-1 0.5 0.5 1 1 1
-1 0.5 1 1 1 1
-
-
-0.5 0 1 1 1 1
-1 0 1 1 1 1
-
-
-0.5 0 1 1 1 1
-0.5 0.5 1 1 1 1
-
-
-1 0 1 1 1 1
-1 0.5 1 1 1 1
-
-
-0.5 0.5 1 1 1 1
-1 0.5 1 1 1 1
-
-
-0 0.5 0.5 1 1 1
-0.5 0.5 0.5 1 1 1
-
-
-0 0.5 0.5 1 1 1
-0 1 0.5 1 1 1
-
-
-0 0.5 0.5 1 1 1
-0 0.5 1 1 1 1
-
-
-0.5 0.5 0.5 1 1 1
-0.5 1 0.5 1 1 1
-
-
-0.5 0.5 0.5 1 1 1
-0.5 0.5 1 1 1 1
-
-
-0 1 0.5 1 1 1
-0.5 1 0.5 1 1 1
-
-
-0 1 0.5 1 1 1
-0 1 1 1 1 1
-
-
-0.5 1 0.5 1 1 1
-0.5 1 1 1 1 1
-
-
-0 0.5 1 1 1 1
-0.5 0.5 1 1 1 1
-
-
-0 0.5 1 1 1 1
-0 1 1 1 1 1
-
-
-0.5 0.5 1 1 1 1
-0.5 1 1 1 1 1
-
-
-0 1 1 1 1 1
-0.5 1 1 1 1 1
-
-
-0.5 0.5 0.5 1 1 1
-1 0.5 0.5 1 1 1
-
-
-0.5 0.5 0.5 1 1 1
-0.5 1 0.5 1 1 1
-
-
-0.5 0.5 0.5 1 1 1
-0.5 0.5 1 1 1 1
-
-
-1 0.5 0.5 1 1 1
-1 1 0.5 1 1 1
-
-
-1 0.5 0.5 1 1 1
-1 0.5 1 1 1 1
-
-
-0.5 1 0.5 1 1 1
-1 1 0.5 1 1 1
-
-
-0.5 1 0.5 1 1 1
-0.5 1 1 1 1 1
-
-
-1 1 0.5 1 1 1
-1 1 1 1 1 1
-
-
-0.5 0.5 1 1 1 1
-1 0.5 1 1 1 1
-
-
-0.5 0.5 1 1 1 1
-0.5 1 1 1 1 1
-
-
-1 0.5 1 1 1 1
-1 1 1 1 1 1
-
-
-0.5 1 1 1 1 1
-1 1 1 1 1 1
-
-
-0 0 0 1 1 1
-0.25 0 0 1 1 1
-
-
-0 0 0 1 1 1
-0 0.25 0 1 1 1
-
-
-0 0 0 1 1 1
-0 0 0.25 1 1 1
-
-
-0.25 0 0 1 1 1
-0.25 0.25 0 1 1 1
-
-
-0.25 0 0 1 1 1
-0.25 0 0.25 1 1 1
-
-
-0 0.25 0 1 1 1
-0.25 0.25 0 1 1 1
-
-
-0 0.25 0 1 1 1
-0 0.25 0.25 1 1 1
-
-
-0.25 0.25 0 1 1 1
-0.25 0.25 0.25 1 1 1
-
-
-0 0 0.25 1 1 1
-0.25 0 0.25 1 1 1
-
-
-0 0 0.25 1 1 1
-0 0.25 0.25 1 1 1
-
-
-0.25 0 0.25 1 1 1
-0.25 0.25 0.25 1 1 1
-
-
-0 0.25 0.25 1 1 1
-0.25 0.25 0.25 1 1 1
-
-
-0.25 0 0 1 1 1
-0.5 0 0 1 1 1
-
-
-0.25 0 0 1 1 1
-0.25 0.25 0 1 1 1
-
-
-0.25 0 0 1 1 1
-0.25 0 0.25 1 1 1
-
-
-0.5 0 0 1 1 1
-0.5 0.25 0 1 1 1
-
-
-0.5 0 0 1 1 1
-0.5 0 0.25 1 1 1
-
-
-0.25 0.25 0 1 1 1
-0.5 0.25 0 1 1 1
-
-
-0.25 0.25 0 1 1 1
-0.25 0.25 0.25 1 1 1
-
-
-0.5 0.25 0 1 1 1
-0.5 0.25 0.25 1 1 1
-
-
-0.25 0 0.25 1 1 1
-0.5 0 0.25 1 1 1
-
-
-0.25 0 0.25 1 1 1
-0.25 0.25 0.25 1 1 1
-
-
-0.5 0 0.25 1 1 1
-0.5 0.25 0.25 1 1 1
-
-
-0.25 0.25 0.25 1 1 1
-0.5 0.25 0.25 1 1 1
-
-
-0 0.25 0 1 1 1
-0.25 0.25 0 1 1 1
-
-
-0 0.25 0 1 1 1
-0 0.5 0 1 1 1
-
-
-0 0.25 0 1 1 1
-0 0.25 0.25 1 1 1
-
-
-0.25 0.25 0 1 1 1
-0.25 0.5 0 1 1 1
-
-
-0.25 0.25 0 1 1 1
-0.25 0.25 0.25 1 1 1
-
-
-0 0.5 0 1 1 1
-0.25 0.5 0 1 1 1
-
-
-0 0.5 0 1 1 1
-0 0.5 0.25 1 1 1
-
-
-0.25 0.5 0 1 1 1
-0.25 0.5 0.25 1 1 1
-
-
-0 0.25 0.25 1 1 1
-0.25 0.25 0.25 1 1 1
-
-
-0 0.25 0.25 1 1 1
-0 0.5 0.25 1 1 1
-
-
-0.25 0.25 0.25 1 1 1
-0.25 0.5 0.25 1 1 1
-
-
-0 0.5 0.25 1 1 1
-0.25 0.5 0.25 1 1 1
-
-
-0.25 0.25 0 1 1 1
-0.5 0.25 0 1 1 1
-
-
-0.25 0.25 0 1 1 1
-0.25 0.5 0 1 1 1
-
-
-0.25 0.25 0 1 1 1
-0.25 0.25 0.25 1 1 1
-
-
-0.5 0.25 0 1 1 1
-0.5 0.5 0 1 1 1
-
-
-0.5 0.25 0 1 1 1
-0.5 0.25 0.25 1 1 1
-
-
-0.25 0.5 0 1 1 1
-0.5 0.5 0 1 1 1
-
-
-0.25 0.5 0 1 1 1
-0.25 0.5 0.25 1 1 1
-
-
-0.5 0.5 0 1 1 1
-0.5 0.5 0.25 1 1 1
-
-
-0.25 0.25 0.25 1 1 1
-0.5 0.25 0.25 1 1 1
-
-
-0.25 0.25 0.25 1 1 1
-0.25 0.5 0.25 1 1 1
-
-
-0.5 0.25 0.25 1 1 1
-0.5 0.5 0.25 1 1 1
-
-
-0.25 0.5 0.25 1 1 1
-0.5 0.5 0.25 1 1 1
-
-
-0 0 0.25 1 1 1
-0.25 0 0.25 1 1 1
-
-
-0 0 0.25 1 1 1
-0 0.25 0.25 1 1 1
-
-
-0 0 0.25 1 1 1
-0 0 0.5 1 1 1
-
-
-0.25 0 0.25 1 1 1
-0.25 0.25 0.25 1 1 1
-
-
-0.25 0 0.25 1 1 1
-0.25 0 0.5 1 1 1
-
-
-0 0.25 0.25 1 1 1
-0.25 0.25 0.25 1 1 1
-
-
-0 0.25 0.25 1 1 1
-0 0.25 0.5 1 1 1
-
-
-0.25 0.25 0.25 1 1 1
-0.25 0.25 0.5 1 1 1
-
-
-0 0 0.5 1 1 1
-0.25 0 0.5 1 1 1
-
-
-0 0 0.5 1 1 1
-0 0.25 0.5 1 1 1
-
-
-0.25 0 0.5 1 1 1
-0.25 0.25 0.5 1 1 1
-
-
-0 0.25 0.5 1 1 1
-0.25 0.25 0.5 1 1 1
-
-
-0.25 0 0.25 1 1 1
-0.5 0 0.25 1 1 1
-
-
-0.25 0 0.25 1 1 1
-0.25 0.25 0.25 1 1 1
-
-
-0.25 0 0.25 1 1 1
-0.25 0 0.5 1 1 1
-
-
-0.5 0 0.25 1 1 1
-0.5 0.25 0.25 1 1 1
-
-
-0.5 0 0.25 1 1 1
-0.5 0 0.5 1 1 1
-
-
-0.25 0.25 0.25 1 1 1
-0.5 0.25 0.25 1 1 1
-
-
-0.25 0.25 0.25 1 1 1
-0.25 0.25 0.5 1 1 1
-
-
-0.5 0.25 0.25 1 1 1
-0.5 0.25 0.5 1 1 1
-
-
-0.25 0 0.5 1 1 1
-0.5 0 0.5 1 1 1
-
-
-0.25 0 0.5 1 1 1
-0.25 0.25 0.5 1 1 1
-
-
-0.5 0 0.5 1 1 1
-0.5 0.25 0.5 1 1 1
-
-
-0.25 0.25 0.5 1 1 1
-0.5 0.25 0.5 1 1 1
-
-
-0 0.25 0.25 1 1 1
-0.25 0.25 0.25 1 1 1
-
-
-0 0.25 0.25 1 1 1
-0 0.5 0.25 1 1 1
-
-
-0 0.25 0.25 1 1 1
-0 0.25 0.5 1 1 1
-
-
-0.25 0.25 0.25 1 1 1
-0.25 0.5 0.25 1 1 1
-
-
-0.25 0.25 0.25 1 1 1
-0.25 0.25 0.5 1 1 1
-
-
-0 0.5 0.25 1 1 1
-0.25 0.5 0.25 1 1 1
-
-
-0 0.5 0.25 1 1 1
-0 0.5 0.5 1 1 1
-
-
-0.25 0.5 0.25 1 1 1
-0.25 0.5 0.5 1 1 1
-
-
-0 0.25 0.5 1 1 1
-0.25 0.25 0.5 1 1 1
-
-
-0 0.25 0.5 1 1 1
-0 0.5 0.5 1 1 1
-
-
-0.25 0.25 0.5 1 1 1
-0.25 0.5 0.5 1 1 1
-
-
-0 0.5 0.5 1 1 1
-0.25 0.5 0.5 1 1 1
-
-
-0.25 0.25 0.25 1 1 1
-0.5 0.25 0.25 1 1 1
-
-
-0.25 0.25 0.25 1 1 1
-0.25 0.5 0.25 1 1 1
-
-
-0.25 0.25 0.25 1 1 1
-0.25 0.25 0.5 1 1 1
-
-
-0.5 0.25 0.25 1 1 1
-0.5 0.5 0.25 1 1 1
-
-
-0.5 0.25 0.25 1 1 1
-0.5 0.25 0.5 1 1 1
-
-
-0.25 0.5 0.25 1 1 1
-0.5 0.5 0.25 1 1 1
-
-
-0.25 0.5 0.25 1 1 1
-0.25 0.5 0.5 1 1 1
-
-
-0.5 0.5 0.25 1 1 1
-0.5 0.5 0.5 1 1 1
-
-
-0.25 0.25 0.5 1 1 1
-0.5 0.25 0.5 1 1 1
-
-
-0.25 0.25 0.5 1 1 1
-0.25 0.5 0.5 1 1 1
-
-
-0.5 0.25 0.5 1 1 1
-0.5 0.5 0.5 1 1 1
-
-
-0.25 0.5 0.5 1 1 1
-0.5 0.5 0.5 1 1 1
-
-