--- /dev/null
+Added: Add a new particle generation function that can generate particles at
+random positions controlled by a probability density function.
+<br>
+(Rene Gassmoeller, 2019/09/13)
--- /dev/null
+// ---------------------------------------------------------------------
+//
+// Copyright (C) 2017 - 2018 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.
+//
+// ---------------------------------------------------------------------
+
+
+
+// check the creation and destruction of a random particle in a cell
+
+#include <deal.II/distributed/tria.h>
+
+#include <deal.II/fe/mapping_q.h>
+
+#include <deal.II/grid/grid_generator.h>
+#include <deal.II/grid/grid_tools.h>
+
+#include <deal.II/particles/generators.h>
+#include <deal.II/particles/particle_handler.h>
+
+#include "../tests.h"
+
+template <int dim, int spacedim>
+void
+test()
+{
+ {
+ parallel::distributed::Triangulation<dim, spacedim> tr(MPI_COMM_WORLD);
+
+ GridGenerator::hyper_cube(tr);
+ MappingQ<dim, spacedim> mapping(1);
+
+ std::mt19937 random_number_generator(time(nullptr));
+
+ const Particles::Particle<dim, spacedim> particle =
+ Particles::Generators::random_particle_in_cell(tr.begin_active(),
+ 42,
+ random_number_generator,
+ mapping);
+
+ const Point<dim> p_unit =
+ mapping.transform_real_to_unit_cell(tr.begin_active(),
+ particle.get_location());
+
+ deallog << "Particle is inside cell 1: "
+ << GeometryInfo<dim>::is_inside_unit_cell(p_unit) << std::endl;
+ deallog << "Particle id: " << particle.get_id() << std::endl;
+ }
+
+ deallog << "OK" << std::endl;
+}
+
+
+
+int
+main(int argc, char *argv[])
+{
+ Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
+
+ initlog();
+
+ deallog.push("2d/2d");
+ test<2, 2>();
+ deallog.pop();
+ deallog.push("2d/3d");
+ test<2, 3>();
+ deallog.pop();
+ deallog.push("3d/3d");
+ test<3, 3>();
+ deallog.pop();
+}
--- /dev/null
+
+DEAL:2d/2d::Particle is inside cell 1: 1
+DEAL:2d/2d::Particle id: 42
+DEAL:2d/2d::OK
+DEAL:2d/3d::Particle is inside cell 1: 1
+DEAL:2d/3d::Particle id: 42
+DEAL:2d/3d::OK
+DEAL:3d/3d::Particle is inside cell 1: 1
+DEAL:3d/3d::Particle id: 42
+DEAL:3d/3d::OK
--- /dev/null
+// ---------------------------------------------------------------------
+//
+// Copyright (C) 2017 - 2018 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.
+//
+// ---------------------------------------------------------------------
+
+
+
+// check the particle generation using the
+// Particles::Generator::probabilistic_locations function
+// using different probability distributions. In particular
+// check that for a non-random cell selection each cell
+// has the expected number of particles according to its
+// part of the probability density distribution.
+
+#include <deal.II/base/function_lib.h>
+
+#include <deal.II/distributed/tria.h>
+
+#include <deal.II/dofs/dof_handler.h>
+
+#include <deal.II/fe/fe_nothing.h>
+#include <deal.II/fe/mapping_q.h>
+
+#include <deal.II/grid/grid_generator.h>
+#include <deal.II/grid/grid_tools.h>
+
+#include <deal.II/particles/generators.h>
+#include <deal.II/particles/particle_handler.h>
+
+#include "../tests.h"
+
+template <int dim, int spacedim>
+void
+test(Function<spacedim> &probability_density_function)
+{
+ {
+ parallel::distributed::Triangulation<dim, spacedim> tr(MPI_COMM_WORLD);
+
+ GridGenerator::hyper_cube(tr);
+ tr.refine_global(1);
+
+ MappingQ<dim, spacedim> mapping(1);
+
+ Particles::ParticleHandler<dim, spacedim> particle_handler(tr, mapping);
+
+ Particles::Generators::probabilistic_locations(
+ tr, probability_density_function, false, 16, particle_handler, mapping);
+
+ if (Utilities::MPI::this_mpi_process(MPI_COMM_WORLD) == 0)
+ {
+ deallog << "Locally owned active cells: "
+ << tr.n_locally_owned_active_cells() << std::endl;
+
+ deallog << "Global particles: " << particle_handler.n_global_particles()
+ << std::endl;
+
+ for (const auto &cell : tr.active_cell_iterators())
+ {
+ if (cell->is_locally_owned())
+ {
+ deallog << "Cell " << cell << " has "
+ << particle_handler.n_particles_in_cell(cell)
+ << " particles." << std::endl;
+ }
+ }
+
+ for (const auto &particle : particle_handler)
+ {
+ deallog << "Particle index " << particle.get_id() << " is in cell "
+ << particle.get_surrounding_cell(tr) << std::endl;
+ deallog << "Particle location: " << particle.get_location()
+ << std::endl;
+ }
+ }
+ }
+
+ deallog << "OK" << std::endl;
+}
+
+
+
+int
+main(int argc, char *argv[])
+{
+ Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
+
+ initlog();
+
+ {
+ deallog.push("2d/2d");
+ Functions::ConstantFunction<2> probability_density_function(1.0);
+ test<2, 2>(probability_density_function);
+ deallog.pop();
+ }
+ {
+ deallog.push("2d/3d");
+ Functions::ConstantFunction<3> probability_density_function(1.0);
+ test<2, 3>(probability_density_function);
+ }
+ {
+ deallog.pop();
+ deallog.push("3d/3d");
+ Functions::ConstantFunction<3> probability_density_function(1.0);
+ test<3, 3>(probability_density_function);
+ deallog.pop();
+ }
+
+ {
+ deallog.push("2d/2d");
+ Functions::Q1WedgeFunction<2> probability_density_function;
+ test<2, 2>(probability_density_function);
+ deallog.pop();
+ }
+ {
+ deallog.push("2d/3d");
+ Functions::Q1WedgeFunction<3> probability_density_function;
+ test<2, 3>(probability_density_function);
+ }
+ {
+ deallog.pop();
+ deallog.push("3d/3d");
+ Functions::Q1WedgeFunction<3> probability_density_function;
+ test<3, 3>(probability_density_function);
+ deallog.pop();
+ }
+}
--- /dev/null
+
+DEAL:2d/2d::OK
+DEAL:2d/3d::OK
+DEAL:3d/3d::OK
+DEAL:2d/2d::OK
+DEAL:2d/3d::OK
+DEAL:3d/3d::OK
+l 1.0 has 4 particles.
+DEAL:2d/2d::Cell 1.1 has 4 particles.
+DEAL:2d/2d::Cell 1.2 has 4 particles.
+DEAL:2d/2d::Cell 1.3 has 4 particles.
+DEAL:2d/2d::Particle index 0 is in cell 1.0
+DEAL:2d/2d::Particle location: 0.401688 0.250988
+DEAL:2d/2d::Particle index 1 is in cell 1.0
+DEAL:2d/2d::Particle location: 0.371205 0.395688
+DEAL:2d/2d::Particle index 2 is in cell 1.0
+DEAL:2d/2d::Particle location: 0.257272 0.406244
+DEAL:2d/2d::Particle index 3 is in cell 1.0
+DEAL:2d/2d::Particle location: 0.0826766 0.0399059
+DEAL:2d/2d::Particle index 4 is in cell 1.1
+DEAL:2d/2d::Particle location: 0.599587 0.434531
+DEAL:2d/2d::Particle index 5 is in cell 1.1
+DEAL:2d/2d::Particle location: 0.864727 0.193256
+DEAL:2d/2d::Particle index 6 is in cell 1.1
+DEAL:2d/2d::Particle location: 0.939147 0.00693176
+DEAL:2d/2d::Particle index 7 is in cell 1.1
+DEAL:2d/2d::Particle location: 0.565261 0.00512822
+DEAL:2d/2d::Particle index 8 is in cell 1.2
+DEAL:2d/2d::Particle location: 0.413003 0.848169
+DEAL:2d/2d::Particle index 9 is in cell 1.2
+DEAL:2d/2d::Particle location: 0.151281 0.544827
+DEAL:2d/2d::Particle index 10 is in cell 1.2
+DEAL:2d/2d::Particle location: 0.440571 0.602781
+DEAL:2d/2d::Particle index 11 is in cell 1.2
+DEAL:2d/2d::Particle location: 0.420640 0.708781
+DEAL:2d/2d::Particle index 12 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.800562 0.943394
+DEAL:2d/2d::Particle index 13 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.766607 0.625789
+DEAL:2d/2d::Particle index 14 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.711571 0.836786
+DEAL:2d/2d::Particle index 15 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.511057 0.933580
+DEAL:2d/2d::OK
+DEAL:2d/3d::Locally owned active cells: 4
+DEAL:2d/3d::Global particles: 16
+DEAL:2d/3d::Cell 1.0 has 4 particles.
+DEAL:2d/3d::Cell 1.1 has 4 particles.
+DEAL:2d/3d::Cell 1.2 has 4 particles.
+DEAL:2d/3d::Cell 1.3 has 4 particles.
+DEAL:2d/3d::Particle index 0 is in cell 1.0
+DEAL:2d/3d::Particle location: 0.401688 0.250988 0.00000
+DEAL:2d/3d::Particle index 1 is in cell 1.0
+DEAL:2d/3d::Particle location: 0.395688 0.257272 0.00000
+DEAL:2d/3d::Particle index 2 is in cell 1.0
+DEAL:2d/3d::Particle location: 0.0826766 0.0399059 0.00000
+DEAL:2d/3d::Particle index 3 is in cell 1.0
+DEAL:2d/3d::Particle location: 0.434531 0.364727 0.00000
+DEAL:2d/3d::Particle index 4 is in cell 1.1
+DEAL:2d/3d::Particle location: 0.939147 0.00693176 0.00000
+DEAL:2d/3d::Particle index 5 is in cell 1.1
+DEAL:2d/3d::Particle location: 0.505128 0.413003 0.00000
+DEAL:2d/3d::Particle index 6 is in cell 1.1
+DEAL:2d/3d::Particle location: 0.651281 0.0448272 0.00000
+DEAL:2d/3d::Particle index 7 is in cell 1.1
+DEAL:2d/3d::Particle location: 0.602781 0.420640 0.00000
+DEAL:2d/3d::Particle index 8 is in cell 1.2
+DEAL:2d/3d::Particle location: 0.300562 0.943394 0.00000
+DEAL:2d/3d::Particle index 9 is in cell 1.2
+DEAL:2d/3d::Particle location: 0.125789 0.711571 0.00000
+DEAL:2d/3d::Particle index 10 is in cell 1.2
+DEAL:2d/3d::Particle location: 0.0110567 0.933580 0.00000
+DEAL:2d/3d::Particle index 11 is in cell 1.2
+DEAL:2d/3d::Particle location: 0.131928 0.976939 0.00000
+DEAL:2d/3d::Particle index 12 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.541758 0.909401 0.00000
+DEAL:2d/3d::Particle index 13 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.784775 0.879733 0.00000
+DEAL:2d/3d::Particle index 14 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.633419 0.815470 0.00000
+DEAL:2d/3d::Particle index 15 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.893669 0.912352 0.00000
+DEAL:2d/3d::OK
+DEAL:3d/3d::Locally owned active cells: 8
+DEAL:3d/3d::Global particles: 16
+DEAL:3d/3d::Cell 1.0 has 2 particles.
+DEAL:3d/3d::Cell 1.1 has 2 particles.
+DEAL:3d/3d::Cell 1.2 has 2 particles.
+DEAL:3d/3d::Cell 1.3 has 2 particles.
+DEAL:3d/3d::Cell 1.4 has 2 particles.
+DEAL:3d/3d::Cell 1.5 has 2 particles.
+DEAL:3d/3d::Cell 1.6 has 2 particles.
+DEAL:3d/3d::Cell 1.7 has 2 particles.
+DEAL:3d/3d::Particle index 0 is in cell 1.0
+DEAL:3d/3d::Particle location: 0.401688 0.250988 0.371205
+DEAL:3d/3d::Particle index 1 is in cell 1.0
+DEAL:3d/3d::Particle location: 0.395688 0.257272 0.406244
+DEAL:3d/3d::Particle index 2 is in cell 1.1
+DEAL:3d/3d::Particle location: 0.582677 0.0399059 0.0995873
+DEAL:3d/3d::Particle index 3 is in cell 1.1
+DEAL:3d/3d::Particle location: 0.934531 0.364727 0.193256
+DEAL:3d/3d::Particle index 4 is in cell 1.2
+DEAL:3d/3d::Particle location: 0.439147 0.506932 0.0652610
+DEAL:3d/3d::Particle index 5 is in cell 1.2
+DEAL:3d/3d::Particle location: 0.00512822 0.913003 0.348169
+DEAL:3d/3d::Particle index 6 is in cell 1.3
+DEAL:3d/3d::Particle location: 0.651281 0.544827 0.440571
+DEAL:3d/3d::Particle index 7 is in cell 1.3
+DEAL:3d/3d::Particle location: 0.602781 0.920640 0.208781
+DEAL:3d/3d::Particle index 8 is in cell 1.4
+DEAL:3d/3d::Particle location: 0.300562 0.443394 0.766607
+DEAL:3d/3d::Particle index 9 is in cell 1.4
+DEAL:3d/3d::Particle location: 0.125789 0.211571 0.836786
+DEAL:3d/3d::Particle index 10 is in cell 1.5
+DEAL:3d/3d::Particle location: 0.511057 0.433580 0.685746
+DEAL:3d/3d::Particle index 11 is in cell 1.5
+DEAL:3d/3d::Particle location: 0.631928 0.476939 0.524336
+DEAL:3d/3d::Particle index 12 is in cell 1.6
+DEAL:3d/3d::Particle location: 0.0417576 0.909401 0.685604
+DEAL:3d/3d::Particle index 13 is in cell 1.6
+DEAL:3d/3d::Particle location: 0.284775 0.879733 0.566942
+DEAL:3d/3d::Particle index 14 is in cell 1.7
+DEAL:3d/3d::Particle location: 0.633419 0.815470 0.866549
+DEAL:3d/3d::Particle index 15 is in cell 1.7
+DEAL:3d/3d::Particle location: 0.893669 0.912352 0.869950
+DEAL:3d/3d::OK
+DEAL:2d/2d::Locally owned active cells: 4
+DEAL:2d/2d::Global particles: 16
+DEAL:2d/2d::Cell 1.0 has 1 particles.
+DEAL:2d/2d::Cell 1.1 has 3 particles.
+DEAL:2d/2d::Cell 1.2 has 3 particles.
+DEAL:2d/2d::Cell 1.3 has 9 particles.
+DEAL:2d/2d::Particle index 0 is in cell 1.0
+DEAL:2d/2d::Particle location: 0.401688 0.250988
+DEAL:2d/2d::Particle index 1 is in cell 1.1
+DEAL:2d/2d::Particle location: 0.871205 0.395688
+DEAL:2d/2d::Particle index 2 is in cell 1.1
+DEAL:2d/2d::Particle location: 0.757272 0.406244
+DEAL:2d/2d::Particle index 3 is in cell 1.1
+DEAL:2d/2d::Particle location: 0.582677 0.0399059
+DEAL:2d/2d::Particle index 4 is in cell 1.2
+DEAL:2d/2d::Particle location: 0.0995873 0.934531
+DEAL:2d/2d::Particle index 5 is in cell 1.2
+DEAL:2d/2d::Particle location: 0.364727 0.693256
+DEAL:2d/2d::Particle index 6 is in cell 1.2
+DEAL:2d/2d::Particle location: 0.439147 0.506932
+DEAL:2d/2d::Particle index 7 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.565261 0.505128
+DEAL:2d/2d::Particle index 8 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.913003 0.848169
+DEAL:2d/2d::Particle index 9 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.651281 0.544827
+DEAL:2d/2d::Particle index 10 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.940571 0.602781
+DEAL:2d/2d::Particle index 11 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.920640 0.708781
+DEAL:2d/2d::Particle index 12 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.800562 0.943394
+DEAL:2d/2d::Particle index 13 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.766607 0.625789
+DEAL:2d/2d::Particle index 14 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.711571 0.836786
+DEAL:2d/2d::Particle index 15 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.511057 0.933580
+DEAL:2d/2d::OK
+DEAL:2d/3d::Locally owned active cells: 4
+DEAL:2d/3d::Global particles: 16
+DEAL:2d/3d::Cell 1.0 has 1 particles.
+DEAL:2d/3d::Cell 1.1 has 3 particles.
+DEAL:2d/3d::Cell 1.2 has 3 particles.
+DEAL:2d/3d::Cell 1.3 has 9 particles.
+DEAL:2d/3d::Particle index 0 is in cell 1.0
+DEAL:2d/3d::Particle location: 0.401688 0.250988 0.00000
+DEAL:2d/3d::Particle index 1 is in cell 1.1
+DEAL:2d/3d::Particle location: 0.895688 0.257272 0.00000
+DEAL:2d/3d::Particle index 2 is in cell 1.1
+DEAL:2d/3d::Particle location: 0.582677 0.0399059 0.00000
+DEAL:2d/3d::Particle index 3 is in cell 1.1
+DEAL:2d/3d::Particle location: 0.934531 0.364727 0.00000
+DEAL:2d/3d::Particle index 4 is in cell 1.2
+DEAL:2d/3d::Particle location: 0.439147 0.506932 0.00000
+DEAL:2d/3d::Particle index 5 is in cell 1.2
+DEAL:2d/3d::Particle location: 0.00512822 0.913003 0.00000
+DEAL:2d/3d::Particle index 6 is in cell 1.2
+DEAL:2d/3d::Particle location: 0.151281 0.544827 0.00000
+DEAL:2d/3d::Particle index 7 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.602781 0.920640 0.00000
+DEAL:2d/3d::Particle index 8 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.800562 0.943394 0.00000
+DEAL:2d/3d::Particle index 9 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.625789 0.711571 0.00000
+DEAL:2d/3d::Particle index 10 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.511057 0.933580 0.00000
+DEAL:2d/3d::Particle index 11 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.631928 0.976939 0.00000
+DEAL:2d/3d::Particle index 12 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.541758 0.909401 0.00000
+DEAL:2d/3d::Particle index 13 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.784775 0.879733 0.00000
+DEAL:2d/3d::Particle index 14 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.633419 0.815470 0.00000
+DEAL:2d/3d::Particle index 15 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.893669 0.912352 0.00000
+DEAL:2d/3d::OK
+DEAL:3d/3d::Locally owned active cells: 8
+DEAL:3d/3d::Global particles: 16
+DEAL:3d/3d::Cell 1.0 has 1 particles.
+DEAL:3d/3d::Cell 1.1 has 1 particles.
+DEAL:3d/3d::Cell 1.2 has 2 particles.
+DEAL:3d/3d::Cell 1.3 has 4 particles.
+DEAL:3d/3d::Cell 1.4 has 1 particles.
+DEAL:3d/3d::Cell 1.5 has 1 particles.
+DEAL:3d/3d::Cell 1.6 has 2 particles.
+DEAL:3d/3d::Cell 1.7 has 4 particles.
+DEAL:3d/3d::Particle index 0 is in cell 1.0
+DEAL:3d/3d::Particle location: 0.401688 0.250988 0.371205
+DEAL:3d/3d::Particle index 1 is in cell 1.1
+DEAL:3d/3d::Particle location: 0.895688 0.257272 0.406244
+DEAL:3d/3d::Particle index 2 is in cell 1.2
+DEAL:3d/3d::Particle location: 0.0826766 0.539906 0.0995873
+DEAL:3d/3d::Particle index 3 is in cell 1.2
+DEAL:3d/3d::Particle location: 0.434531 0.864727 0.193256
+DEAL:3d/3d::Particle index 4 is in cell 1.3
+DEAL:3d/3d::Particle location: 0.939147 0.506932 0.0652610
+DEAL:3d/3d::Particle index 5 is in cell 1.3
+DEAL:3d/3d::Particle location: 0.505128 0.913003 0.348169
+DEAL:3d/3d::Particle index 6 is in cell 1.3
+DEAL:3d/3d::Particle location: 0.651281 0.544827 0.440571
+DEAL:3d/3d::Particle index 7 is in cell 1.3
+DEAL:3d/3d::Particle location: 0.602781 0.920640 0.208781
+DEAL:3d/3d::Particle index 8 is in cell 1.4
+DEAL:3d/3d::Particle location: 0.300562 0.443394 0.766607
+DEAL:3d/3d::Particle index 9 is in cell 1.5
+DEAL:3d/3d::Particle location: 0.625789 0.211571 0.836786
+DEAL:3d/3d::Particle index 10 is in cell 1.6
+DEAL:3d/3d::Particle location: 0.0110567 0.933580 0.685746
+DEAL:3d/3d::Particle index 11 is in cell 1.6
+DEAL:3d/3d::Particle location: 0.131928 0.976939 0.524336
+DEAL:3d/3d::Particle index 12 is in cell 1.7
+DEAL:3d/3d::Particle location: 0.541758 0.909401 0.685604
+DEAL:3d/3d::Particle index 13 is in cell 1.7
+DEAL:3d/3d::Particle location: 0.784775 0.879733 0.566942
+DEAL:3d/3d::Particle index 14 is in cell 1.7
+DEAL:3d/3d::Particle location: 0.633419 0.815470 0.866549
+DEAL:3d/3d::Particle index 15 is in cell 1.7
+DEAL:3d/3d::Particle location: 0.893669 0.912352 0.869950
+DEAL:3d/3d::OK
--- /dev/null
+
+DEAL:2d/2d::Locally owned active cells: 4
+DEAL:2d/2d::Global particles: 16
+DEAL:2d/2d::Cell 1.0 has 4 particles.
+DEAL:2d/2d::Cell 1.1 has 4 particles.
+DEAL:2d/2d::Cell 1.2 has 4 particles.
+DEAL:2d/2d::Cell 1.3 has 4 particles.
+DEAL:2d/2d::Particle index 0 is in cell 1.0
+DEAL:2d/2d::Particle location: 0.401688 0.250988
+DEAL:2d/2d::Particle index 1 is in cell 1.0
+DEAL:2d/2d::Particle location: 0.371205 0.395688
+DEAL:2d/2d::Particle index 2 is in cell 1.0
+DEAL:2d/2d::Particle location: 0.257272 0.406244
+DEAL:2d/2d::Particle index 3 is in cell 1.0
+DEAL:2d/2d::Particle location: 0.0826766 0.0399059
+DEAL:2d/2d::Particle index 4 is in cell 1.1
+DEAL:2d/2d::Particle location: 0.599587 0.434531
+DEAL:2d/2d::Particle index 5 is in cell 1.1
+DEAL:2d/2d::Particle location: 0.864727 0.193256
+DEAL:2d/2d::Particle index 6 is in cell 1.1
+DEAL:2d/2d::Particle location: 0.939147 0.00693176
+DEAL:2d/2d::Particle index 7 is in cell 1.1
+DEAL:2d/2d::Particle location: 0.565261 0.00512822
+DEAL:2d/2d::Particle index 8 is in cell 1.2
+DEAL:2d/2d::Particle location: 0.413003 0.848169
+DEAL:2d/2d::Particle index 9 is in cell 1.2
+DEAL:2d/2d::Particle location: 0.151281 0.544827
+DEAL:2d/2d::Particle index 10 is in cell 1.2
+DEAL:2d/2d::Particle location: 0.440571 0.602781
+DEAL:2d/2d::Particle index 11 is in cell 1.2
+DEAL:2d/2d::Particle location: 0.420640 0.708781
+DEAL:2d/2d::Particle index 12 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.800562 0.943394
+DEAL:2d/2d::Particle index 13 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.766607 0.625789
+DEAL:2d/2d::Particle index 14 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.711571 0.836786
+DEAL:2d/2d::Particle index 15 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.511057 0.933580
+DEAL:2d/2d::OK
+DEAL:2d/3d::Locally owned active cells: 4
+DEAL:2d/3d::Global particles: 16
+DEAL:2d/3d::Cell 1.0 has 4 particles.
+DEAL:2d/3d::Cell 1.1 has 4 particles.
+DEAL:2d/3d::Cell 1.2 has 4 particles.
+DEAL:2d/3d::Cell 1.3 has 4 particles.
+DEAL:2d/3d::Particle index 0 is in cell 1.0
+DEAL:2d/3d::Particle location: 0.401688 0.250988 0.00000
+DEAL:2d/3d::Particle index 1 is in cell 1.0
+DEAL:2d/3d::Particle location: 0.395688 0.257272 0.00000
+DEAL:2d/3d::Particle index 2 is in cell 1.0
+DEAL:2d/3d::Particle location: 0.0826766 0.0399059 0.00000
+DEAL:2d/3d::Particle index 3 is in cell 1.0
+DEAL:2d/3d::Particle location: 0.434531 0.364727 0.00000
+DEAL:2d/3d::Particle index 4 is in cell 1.1
+DEAL:2d/3d::Particle location: 0.939147 0.00693176 0.00000
+DEAL:2d/3d::Particle index 5 is in cell 1.1
+DEAL:2d/3d::Particle location: 0.505128 0.413003 0.00000
+DEAL:2d/3d::Particle index 6 is in cell 1.1
+DEAL:2d/3d::Particle location: 0.651281 0.0448272 0.00000
+DEAL:2d/3d::Particle index 7 is in cell 1.1
+DEAL:2d/3d::Particle location: 0.602781 0.420640 0.00000
+DEAL:2d/3d::Particle index 8 is in cell 1.2
+DEAL:2d/3d::Particle location: 0.300562 0.943394 0.00000
+DEAL:2d/3d::Particle index 9 is in cell 1.2
+DEAL:2d/3d::Particle location: 0.125789 0.711571 0.00000
+DEAL:2d/3d::Particle index 10 is in cell 1.2
+DEAL:2d/3d::Particle location: 0.0110567 0.933580 0.00000
+DEAL:2d/3d::Particle index 11 is in cell 1.2
+DEAL:2d/3d::Particle location: 0.131928 0.976939 0.00000
+DEAL:2d/3d::Particle index 12 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.541758 0.909401 0.00000
+DEAL:2d/3d::Particle index 13 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.784775 0.879733 0.00000
+DEAL:2d/3d::Particle index 14 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.633419 0.815470 0.00000
+DEAL:2d/3d::Particle index 15 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.893669 0.912352 0.00000
+DEAL:2d/3d::OK
+DEAL:3d/3d::Locally owned active cells: 8
+DEAL:3d/3d::Global particles: 16
+DEAL:3d/3d::Cell 1.0 has 2 particles.
+DEAL:3d/3d::Cell 1.1 has 2 particles.
+DEAL:3d/3d::Cell 1.2 has 2 particles.
+DEAL:3d/3d::Cell 1.3 has 2 particles.
+DEAL:3d/3d::Cell 1.4 has 2 particles.
+DEAL:3d/3d::Cell 1.5 has 2 particles.
+DEAL:3d/3d::Cell 1.6 has 2 particles.
+DEAL:3d/3d::Cell 1.7 has 2 particles.
+DEAL:3d/3d::Particle index 0 is in cell 1.0
+DEAL:3d/3d::Particle location: 0.401688 0.250988 0.371205
+DEAL:3d/3d::Particle index 1 is in cell 1.0
+DEAL:3d/3d::Particle location: 0.395688 0.257272 0.406244
+DEAL:3d/3d::Particle index 2 is in cell 1.1
+DEAL:3d/3d::Particle location: 0.582677 0.0399059 0.0995873
+DEAL:3d/3d::Particle index 3 is in cell 1.1
+DEAL:3d/3d::Particle location: 0.934531 0.364727 0.193256
+DEAL:3d/3d::Particle index 4 is in cell 1.2
+DEAL:3d/3d::Particle location: 0.439147 0.506932 0.0652610
+DEAL:3d/3d::Particle index 5 is in cell 1.2
+DEAL:3d/3d::Particle location: 0.00512822 0.913003 0.348169
+DEAL:3d/3d::Particle index 6 is in cell 1.3
+DEAL:3d/3d::Particle location: 0.651281 0.544827 0.440571
+DEAL:3d/3d::Particle index 7 is in cell 1.3
+DEAL:3d/3d::Particle location: 0.602781 0.920640 0.208781
+DEAL:3d/3d::Particle index 8 is in cell 1.4
+DEAL:3d/3d::Particle location: 0.300562 0.443394 0.766607
+DEAL:3d/3d::Particle index 9 is in cell 1.4
+DEAL:3d/3d::Particle location: 0.125789 0.211571 0.836786
+DEAL:3d/3d::Particle index 10 is in cell 1.5
+DEAL:3d/3d::Particle location: 0.511057 0.433580 0.685746
+DEAL:3d/3d::Particle index 11 is in cell 1.5
+DEAL:3d/3d::Particle location: 0.631928 0.476939 0.524336
+DEAL:3d/3d::Particle index 12 is in cell 1.6
+DEAL:3d/3d::Particle location: 0.0417576 0.909401 0.685604
+DEAL:3d/3d::Particle index 13 is in cell 1.6
+DEAL:3d/3d::Particle location: 0.284775 0.879733 0.566942
+DEAL:3d/3d::Particle index 14 is in cell 1.7
+DEAL:3d/3d::Particle location: 0.633419 0.815470 0.866549
+DEAL:3d/3d::Particle index 15 is in cell 1.7
+DEAL:3d/3d::Particle location: 0.893669 0.912352 0.869950
+DEAL:3d/3d::OK
+DEAL:2d/2d::Locally owned active cells: 4
+DEAL:2d/2d::Global particles: 16
+DEAL:2d/2d::Cell 1.0 has 1 particles.
+DEAL:2d/2d::Cell 1.1 has 3 particles.
+DEAL:2d/2d::Cell 1.2 has 3 particles.
+DEAL:2d/2d::Cell 1.3 has 9 particles.
+DEAL:2d/2d::Particle index 0 is in cell 1.0
+DEAL:2d/2d::Particle location: 0.401688 0.250988
+DEAL:2d/2d::Particle index 1 is in cell 1.1
+DEAL:2d/2d::Particle location: 0.871205 0.395688
+DEAL:2d/2d::Particle index 2 is in cell 1.1
+DEAL:2d/2d::Particle location: 0.757272 0.406244
+DEAL:2d/2d::Particle index 3 is in cell 1.1
+DEAL:2d/2d::Particle location: 0.582677 0.0399059
+DEAL:2d/2d::Particle index 4 is in cell 1.2
+DEAL:2d/2d::Particle location: 0.0995873 0.934531
+DEAL:2d/2d::Particle index 5 is in cell 1.2
+DEAL:2d/2d::Particle location: 0.364727 0.693256
+DEAL:2d/2d::Particle index 6 is in cell 1.2
+DEAL:2d/2d::Particle location: 0.439147 0.506932
+DEAL:2d/2d::Particle index 7 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.565261 0.505128
+DEAL:2d/2d::Particle index 8 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.913003 0.848169
+DEAL:2d/2d::Particle index 9 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.651281 0.544827
+DEAL:2d/2d::Particle index 10 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.940571 0.602781
+DEAL:2d/2d::Particle index 11 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.920640 0.708781
+DEAL:2d/2d::Particle index 12 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.800562 0.943394
+DEAL:2d/2d::Particle index 13 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.766607 0.625789
+DEAL:2d/2d::Particle index 14 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.711571 0.836786
+DEAL:2d/2d::Particle index 15 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.511057 0.933580
+DEAL:2d/2d::OK
+DEAL:2d/3d::Locally owned active cells: 4
+DEAL:2d/3d::Global particles: 16
+DEAL:2d/3d::Cell 1.0 has 1 particles.
+DEAL:2d/3d::Cell 1.1 has 3 particles.
+DEAL:2d/3d::Cell 1.2 has 3 particles.
+DEAL:2d/3d::Cell 1.3 has 9 particles.
+DEAL:2d/3d::Particle index 0 is in cell 1.0
+DEAL:2d/3d::Particle location: 0.401688 0.250988 0.00000
+DEAL:2d/3d::Particle index 1 is in cell 1.1
+DEAL:2d/3d::Particle location: 0.895688 0.257272 0.00000
+DEAL:2d/3d::Particle index 2 is in cell 1.1
+DEAL:2d/3d::Particle location: 0.582677 0.0399059 0.00000
+DEAL:2d/3d::Particle index 3 is in cell 1.1
+DEAL:2d/3d::Particle location: 0.934531 0.364727 0.00000
+DEAL:2d/3d::Particle index 4 is in cell 1.2
+DEAL:2d/3d::Particle location: 0.439147 0.506932 0.00000
+DEAL:2d/3d::Particle index 5 is in cell 1.2
+DEAL:2d/3d::Particle location: 0.00512822 0.913003 0.00000
+DEAL:2d/3d::Particle index 6 is in cell 1.2
+DEAL:2d/3d::Particle location: 0.151281 0.544827 0.00000
+DEAL:2d/3d::Particle index 7 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.602781 0.920640 0.00000
+DEAL:2d/3d::Particle index 8 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.800562 0.943394 0.00000
+DEAL:2d/3d::Particle index 9 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.625789 0.711571 0.00000
+DEAL:2d/3d::Particle index 10 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.511057 0.933580 0.00000
+DEAL:2d/3d::Particle index 11 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.631928 0.976939 0.00000
+DEAL:2d/3d::Particle index 12 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.541758 0.909401 0.00000
+DEAL:2d/3d::Particle index 13 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.784775 0.879733 0.00000
+DEAL:2d/3d::Particle index 14 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.633419 0.815470 0.00000
+DEAL:2d/3d::Particle index 15 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.893669 0.912352 0.00000
+DEAL:2d/3d::OK
+DEAL:3d/3d::Locally owned active cells: 8
+DEAL:3d/3d::Global particles: 16
+DEAL:3d/3d::Cell 1.0 has 1 particles.
+DEAL:3d/3d::Cell 1.1 has 1 particles.
+DEAL:3d/3d::Cell 1.2 has 2 particles.
+DEAL:3d/3d::Cell 1.3 has 4 particles.
+DEAL:3d/3d::Cell 1.4 has 1 particles.
+DEAL:3d/3d::Cell 1.5 has 1 particles.
+DEAL:3d/3d::Cell 1.6 has 2 particles.
+DEAL:3d/3d::Cell 1.7 has 4 particles.
+DEAL:3d/3d::Particle index 0 is in cell 1.0
+DEAL:3d/3d::Particle location: 0.401688 0.250988 0.371205
+DEAL:3d/3d::Particle index 1 is in cell 1.1
+DEAL:3d/3d::Particle location: 0.895688 0.257272 0.406244
+DEAL:3d/3d::Particle index 2 is in cell 1.2
+DEAL:3d/3d::Particle location: 0.0826766 0.539906 0.0995873
+DEAL:3d/3d::Particle index 3 is in cell 1.2
+DEAL:3d/3d::Particle location: 0.434531 0.864727 0.193256
+DEAL:3d/3d::Particle index 4 is in cell 1.3
+DEAL:3d/3d::Particle location: 0.939147 0.506932 0.0652610
+DEAL:3d/3d::Particle index 5 is in cell 1.3
+DEAL:3d/3d::Particle location: 0.505128 0.913003 0.348169
+DEAL:3d/3d::Particle index 6 is in cell 1.3
+DEAL:3d/3d::Particle location: 0.651281 0.544827 0.440571
+DEAL:3d/3d::Particle index 7 is in cell 1.3
+DEAL:3d/3d::Particle location: 0.602781 0.920640 0.208781
+DEAL:3d/3d::Particle index 8 is in cell 1.4
+DEAL:3d/3d::Particle location: 0.300562 0.443394 0.766607
+DEAL:3d/3d::Particle index 9 is in cell 1.5
+DEAL:3d/3d::Particle location: 0.625789 0.211571 0.836786
+DEAL:3d/3d::Particle index 10 is in cell 1.6
+DEAL:3d/3d::Particle location: 0.0110567 0.933580 0.685746
+DEAL:3d/3d::Particle index 11 is in cell 1.6
+DEAL:3d/3d::Particle location: 0.131928 0.976939 0.524336
+DEAL:3d/3d::Particle index 12 is in cell 1.7
+DEAL:3d/3d::Particle location: 0.541758 0.909401 0.685604
+DEAL:3d/3d::Particle index 13 is in cell 1.7
+DEAL:3d/3d::Particle location: 0.784775 0.879733 0.566942
+DEAL:3d/3d::Particle index 14 is in cell 1.7
+DEAL:3d/3d::Particle location: 0.633419 0.815470 0.866549
+DEAL:3d/3d::Particle index 15 is in cell 1.7
+DEAL:3d/3d::Particle location: 0.893669 0.912352 0.869950
+DEAL:3d/3d::OK
--- /dev/null
+// ---------------------------------------------------------------------
+//
+// Copyright (C) 2017 - 2018 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.
+//
+// ---------------------------------------------------------------------
+
+
+
+// like generators_05.cc, but using a random cell selection.
+// Here we no longer know how many particles per cell we expect,
+// therefore we can only check that the numbers are not changing
+// compared to the initial test, and that they are statistically
+// "reasonable".
+
+#include <deal.II/base/function_lib.h>
+
+#include <deal.II/distributed/tria.h>
+
+#include <deal.II/dofs/dof_handler.h>
+
+#include <deal.II/fe/fe_nothing.h>
+#include <deal.II/fe/mapping_q.h>
+
+#include <deal.II/grid/grid_generator.h>
+#include <deal.II/grid/grid_tools.h>
+
+#include <deal.II/particles/generators.h>
+#include <deal.II/particles/particle_handler.h>
+
+#include "../tests.h"
+
+template <int dim, int spacedim>
+void
+test(Function<spacedim> &probability_density_function)
+{
+ {
+ parallel::distributed::Triangulation<dim, spacedim> tr(MPI_COMM_WORLD);
+
+ GridGenerator::hyper_cube(tr);
+ tr.refine_global(1);
+
+ DoFHandler<dim, spacedim> dof_handler;
+ FE_Nothing<dim, spacedim> fe_nothing;
+ dof_handler.initialize(tr, fe_nothing);
+
+ MappingQ<dim, spacedim> mapping(1);
+
+ Particles::ParticleHandler<dim, spacedim> particle_handler(tr, mapping);
+
+ Particles::Generators::probabilistic_locations(
+ tr, probability_density_function, true, 16, particle_handler, mapping);
+
+ if (Utilities::MPI::this_mpi_process(MPI_COMM_WORLD) == 0)
+ {
+ deallog << "Locally owned active cells: "
+ << tr.n_locally_owned_active_cells() << std::endl;
+
+ deallog << "Global particles: " << particle_handler.n_global_particles()
+ << std::endl;
+
+ for (const auto &cell : tr.active_cell_iterators())
+ {
+ if (cell->is_locally_owned())
+ {
+ deallog << "Cell " << cell << " has "
+ << particle_handler.n_particles_in_cell(cell)
+ << " particles." << std::endl;
+ }
+ }
+
+ for (const auto &particle : particle_handler)
+ {
+ deallog << "Particle index " << particle.get_id() << " is in cell "
+ << particle.get_surrounding_cell(tr) << std::endl;
+ deallog << "Particle location: " << particle.get_location()
+ << std::endl;
+ }
+ }
+ }
+
+ deallog << "OK" << std::endl;
+}
+
+
+
+int
+main(int argc, char *argv[])
+{
+ Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
+
+ initlog();
+
+ {
+ deallog.push("2d/2d");
+ Functions::ConstantFunction<2> probability_density_function(1.0);
+ test<2, 2>(probability_density_function);
+ deallog.pop();
+ }
+ {
+ deallog.push("2d/3d");
+ Functions::ConstantFunction<3> probability_density_function(1.0);
+ test<2, 3>(probability_density_function);
+ }
+ {
+ deallog.pop();
+ deallog.push("3d/3d");
+ Functions::ConstantFunction<3> probability_density_function(1.0);
+ test<3, 3>(probability_density_function);
+ deallog.pop();
+ }
+
+ {
+ deallog.push("2d/2d");
+ Functions::Q1WedgeFunction<2> probability_density_function;
+ test<2, 2>(probability_density_function);
+ deallog.pop();
+ }
+ {
+ deallog.push("2d/3d");
+ Functions::Q1WedgeFunction<3> probability_density_function;
+ test<2, 3>(probability_density_function);
+ }
+ {
+ deallog.pop();
+ deallog.push("3d/3d");
+ Functions::Q1WedgeFunction<3> probability_density_function;
+ test<3, 3>(probability_density_function);
+ deallog.pop();
+ }
+}
--- /dev/null
+
+DEAL:2d/2d::OK
+DEAL:2d/3d::OK
+DEAL:3d/3d::OK
+DEAL:2d/2d::OK
+DEAL:2d/3d::OK
+DEAL:3d/3d::OK
+l 1.0 has 6 particles.
+DEAL:2d/2d::Cell 1.1 has 1 particles.
+DEAL:2d/2d::Cell 1.2 has 4 particles.
+DEAL:2d/2d::Cell 1.3 has 5 particles.
+DEAL:2d/2d::Particle index 0 is in cell 1.0
+DEAL:2d/2d::Particle location: 0.413003 0.348169
+DEAL:2d/2d::Particle index 1 is in cell 1.0
+DEAL:2d/2d::Particle location: 0.151281 0.0448272
+DEAL:2d/2d::Particle index 2 is in cell 1.0
+DEAL:2d/2d::Particle location: 0.440571 0.102781
+DEAL:2d/2d::Particle index 3 is in cell 1.0
+DEAL:2d/2d::Particle location: 0.420640 0.208781
+DEAL:2d/2d::Particle index 4 is in cell 1.0
+DEAL:2d/2d::Particle location: 0.300562 0.443394
+DEAL:2d/2d::Particle index 5 is in cell 1.0
+DEAL:2d/2d::Particle location: 0.266607 0.125789
+DEAL:2d/2d::Particle index 6 is in cell 1.1
+DEAL:2d/2d::Particle location: 0.711571 0.336786
+DEAL:2d/2d::Particle index 7 is in cell 1.2
+DEAL:2d/2d::Particle location: 0.0110567 0.933580
+DEAL:2d/2d::Particle index 8 is in cell 1.2
+DEAL:2d/2d::Particle location: 0.185746 0.631928
+DEAL:2d/2d::Particle index 9 is in cell 1.2
+DEAL:2d/2d::Particle location: 0.476939 0.524336
+DEAL:2d/2d::Particle index 10 is in cell 1.2
+DEAL:2d/2d::Particle location: 0.0417576 0.909401
+DEAL:2d/2d::Particle index 11 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.685604 0.784775
+DEAL:2d/2d::Particle index 12 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.879733 0.566942
+DEAL:2d/2d::Particle index 13 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.633419 0.815470
+DEAL:2d/2d::Particle index 14 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.866549 0.893669
+DEAL:2d/2d::Particle index 15 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.912352 0.869950
+DEAL:2d/2d::OK
+DEAL:2d/3d::Locally owned active cells: 4
+DEAL:2d/3d::Global particles: 16
+DEAL:2d/3d::Cell 1.0 has 6 particles.
+DEAL:2d/3d::Cell 1.1 has 1 particles.
+DEAL:2d/3d::Cell 1.2 has 4 particles.
+DEAL:2d/3d::Cell 1.3 has 5 particles.
+DEAL:2d/3d::Particle index 0 is in cell 1.0
+DEAL:2d/3d::Particle location: 0.413003 0.348169 0.00000
+DEAL:2d/3d::Particle index 1 is in cell 1.0
+DEAL:2d/3d::Particle location: 0.0448272 0.440571 0.00000
+DEAL:2d/3d::Particle index 2 is in cell 1.0
+DEAL:2d/3d::Particle location: 0.420640 0.208781 0.00000
+DEAL:2d/3d::Particle index 3 is in cell 1.0
+DEAL:2d/3d::Particle location: 0.443394 0.266607 0.00000
+DEAL:2d/3d::Particle index 4 is in cell 1.0
+DEAL:2d/3d::Particle location: 0.211571 0.336786 0.00000
+DEAL:2d/3d::Particle index 5 is in cell 1.0
+DEAL:2d/3d::Particle location: 0.433580 0.185746 0.00000
+DEAL:2d/3d::Particle index 6 is in cell 1.1
+DEAL:2d/3d::Particle location: 0.976939 0.0243363 0.00000
+DEAL:2d/3d::Particle index 7 is in cell 1.2
+DEAL:2d/3d::Particle location: 0.409401 0.685604 0.00000
+DEAL:2d/3d::Particle index 8 is in cell 1.2
+DEAL:2d/3d::Particle location: 0.379733 0.566942 0.00000
+DEAL:2d/3d::Particle index 9 is in cell 1.2
+DEAL:2d/3d::Particle location: 0.315470 0.866549 0.00000
+DEAL:2d/3d::Particle index 10 is in cell 1.2
+DEAL:2d/3d::Particle location: 0.412352 0.869950 0.00000
+DEAL:2d/3d::Particle index 11 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.978207 0.535190 0.00000
+DEAL:2d/3d::Particle index 12 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.635020 0.771499 0.00000
+DEAL:2d/3d::Particle index 13 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.831545 0.655147 0.00000
+DEAL:2d/3d::Particle index 14 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.616304 0.601936 0.00000
+DEAL:2d/3d::Particle index 15 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.986958 0.788586 0.00000
+DEAL:2d/3d::OK
+DEAL:3d/3d::Locally owned active cells: 8
+DEAL:3d/3d::Global particles: 16
+DEAL:3d/3d::Cell 1.0 has 3 particles.
+DEAL:3d/3d::Cell 1.1 has 3 particles.
+DEAL:3d/3d::Cell 1.2 has 0 particles.
+DEAL:3d/3d::Cell 1.3 has 1 particles.
+DEAL:3d/3d::Cell 1.4 has 2 particles.
+DEAL:3d/3d::Cell 1.5 has 2 particles.
+DEAL:3d/3d::Cell 1.6 has 4 particles.
+DEAL:3d/3d::Cell 1.7 has 1 particles.
+DEAL:3d/3d::Particle index 0 is in cell 1.0
+DEAL:3d/3d::Particle location: 0.413003 0.348169 0.151281
+DEAL:3d/3d::Particle index 1 is in cell 1.0
+DEAL:3d/3d::Particle location: 0.0448272 0.440571 0.102781
+DEAL:3d/3d::Particle index 2 is in cell 1.0
+DEAL:3d/3d::Particle location: 0.420640 0.208781 0.300562
+DEAL:3d/3d::Particle index 3 is in cell 1.1
+DEAL:3d/3d::Particle location: 0.943394 0.266607 0.125789
+DEAL:3d/3d::Particle index 4 is in cell 1.1
+DEAL:3d/3d::Particle location: 0.711571 0.336786 0.0110567
+DEAL:3d/3d::Particle index 5 is in cell 1.1
+DEAL:3d/3d::Particle location: 0.933580 0.185746 0.131928
+DEAL:3d/3d::Particle index 6 is in cell 1.3
+DEAL:3d/3d::Particle location: 0.976939 0.524336 0.0417576
+DEAL:3d/3d::Particle index 7 is in cell 1.4
+DEAL:3d/3d::Particle location: 0.409401 0.185604 0.784775
+DEAL:3d/3d::Particle index 8 is in cell 1.4
+DEAL:3d/3d::Particle location: 0.379733 0.0669421 0.633419
+DEAL:3d/3d::Particle index 9 is in cell 1.5
+DEAL:3d/3d::Particle location: 0.815470 0.366549 0.893669
+DEAL:3d/3d::Particle index 10 is in cell 1.5
+DEAL:3d/3d::Particle location: 0.912352 0.369950 0.623975
+DEAL:3d/3d::Particle index 11 is in cell 1.6
+DEAL:3d/3d::Particle location: 0.478207 0.535190 0.753639
+DEAL:3d/3d::Particle index 12 is in cell 1.6
+DEAL:3d/3d::Particle location: 0.135020 0.771499 0.776105
+DEAL:3d/3d::Particle index 13 is in cell 1.6
+DEAL:3d/3d::Particle location: 0.331545 0.655147 0.914224
+DEAL:3d/3d::Particle index 14 is in cell 1.6
+DEAL:3d/3d::Particle location: 0.116304 0.601936 0.949338
+DEAL:3d/3d::Particle index 15 is in cell 1.7
+DEAL:3d/3d::Particle location: 0.986958 0.788586 0.839888
+DEAL:3d/3d::OK
+DEAL:2d/2d::Locally owned active cells: 4
+DEAL:2d/2d::Global particles: 16
+DEAL:2d/2d::Cell 1.0 has 2 particles.
+DEAL:2d/2d::Cell 1.1 has 4 particles.
+DEAL:2d/2d::Cell 1.2 has 1 particles.
+DEAL:2d/2d::Cell 1.3 has 9 particles.
+DEAL:2d/2d::Particle index 0 is in cell 1.0
+DEAL:2d/2d::Particle location: 0.413003 0.348169
+DEAL:2d/2d::Particle index 1 is in cell 1.0
+DEAL:2d/2d::Particle location: 0.151281 0.0448272
+DEAL:2d/2d::Particle index 2 is in cell 1.1
+DEAL:2d/2d::Particle location: 0.940571 0.102781
+DEAL:2d/2d::Particle index 3 is in cell 1.1
+DEAL:2d/2d::Particle location: 0.920640 0.208781
+DEAL:2d/2d::Particle index 4 is in cell 1.1
+DEAL:2d/2d::Particle location: 0.800562 0.443394
+DEAL:2d/2d::Particle index 5 is in cell 1.1
+DEAL:2d/2d::Particle location: 0.766607 0.125789
+DEAL:2d/2d::Particle index 6 is in cell 1.2
+DEAL:2d/2d::Particle location: 0.211571 0.836786
+DEAL:2d/2d::Particle index 7 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.511057 0.933580
+DEAL:2d/2d::Particle index 8 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.685746 0.631928
+DEAL:2d/2d::Particle index 9 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.976939 0.524336
+DEAL:2d/2d::Particle index 10 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.541758 0.909401
+DEAL:2d/2d::Particle index 11 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.685604 0.784775
+DEAL:2d/2d::Particle index 12 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.879733 0.566942
+DEAL:2d/2d::Particle index 13 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.633419 0.815470
+DEAL:2d/2d::Particle index 14 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.866549 0.893669
+DEAL:2d/2d::Particle index 15 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.912352 0.869950
+DEAL:2d/2d::OK
+DEAL:2d/3d::Locally owned active cells: 4
+DEAL:2d/3d::Global particles: 16
+DEAL:2d/3d::Cell 1.0 has 2 particles.
+DEAL:2d/3d::Cell 1.1 has 4 particles.
+DEAL:2d/3d::Cell 1.2 has 1 particles.
+DEAL:2d/3d::Cell 1.3 has 9 particles.
+DEAL:2d/3d::Particle index 0 is in cell 1.0
+DEAL:2d/3d::Particle location: 0.413003 0.348169 0.00000
+DEAL:2d/3d::Particle index 1 is in cell 1.0
+DEAL:2d/3d::Particle location: 0.0448272 0.440571 0.00000
+DEAL:2d/3d::Particle index 2 is in cell 1.1
+DEAL:2d/3d::Particle location: 0.920640 0.208781 0.00000
+DEAL:2d/3d::Particle index 3 is in cell 1.1
+DEAL:2d/3d::Particle location: 0.943394 0.266607 0.00000
+DEAL:2d/3d::Particle index 4 is in cell 1.1
+DEAL:2d/3d::Particle location: 0.711571 0.336786 0.00000
+DEAL:2d/3d::Particle index 5 is in cell 1.1
+DEAL:2d/3d::Particle location: 0.933580 0.185746 0.00000
+DEAL:2d/3d::Particle index 6 is in cell 1.2
+DEAL:2d/3d::Particle location: 0.476939 0.524336 0.00000
+DEAL:2d/3d::Particle index 7 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.909401 0.685604 0.00000
+DEAL:2d/3d::Particle index 8 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.879733 0.566942 0.00000
+DEAL:2d/3d::Particle index 9 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.815470 0.866549 0.00000
+DEAL:2d/3d::Particle index 10 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.912352 0.869950 0.00000
+DEAL:2d/3d::Particle index 11 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.978207 0.535190 0.00000
+DEAL:2d/3d::Particle index 12 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.635020 0.771499 0.00000
+DEAL:2d/3d::Particle index 13 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.831545 0.655147 0.00000
+DEAL:2d/3d::Particle index 14 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.616304 0.601936 0.00000
+DEAL:2d/3d::Particle index 15 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.986958 0.788586 0.00000
+DEAL:2d/3d::OK
+DEAL:3d/3d::Locally owned active cells: 8
+DEAL:3d/3d::Global particles: 16
+DEAL:3d/3d::Cell 1.0 has 2 particles.
+DEAL:3d/3d::Cell 1.1 has 1 particles.
+DEAL:3d/3d::Cell 1.2 has 3 particles.
+DEAL:3d/3d::Cell 1.3 has 1 particles.
+DEAL:3d/3d::Cell 1.4 has 2 particles.
+DEAL:3d/3d::Cell 1.5 has 0 particles.
+DEAL:3d/3d::Cell 1.6 has 0 particles.
+DEAL:3d/3d::Cell 1.7 has 7 particles.
+DEAL:3d/3d::Particle index 0 is in cell 1.0
+DEAL:3d/3d::Particle location: 0.413003 0.348169 0.151281
+DEAL:3d/3d::Particle index 1 is in cell 1.0
+DEAL:3d/3d::Particle location: 0.0448272 0.440571 0.102781
+DEAL:3d/3d::Particle index 2 is in cell 1.1
+DEAL:3d/3d::Particle location: 0.920640 0.208781 0.300562
+DEAL:3d/3d::Particle index 3 is in cell 1.2
+DEAL:3d/3d::Particle location: 0.443394 0.766607 0.125789
+DEAL:3d/3d::Particle index 4 is in cell 1.2
+DEAL:3d/3d::Particle location: 0.211571 0.836786 0.0110567
+DEAL:3d/3d::Particle index 5 is in cell 1.2
+DEAL:3d/3d::Particle location: 0.433580 0.685746 0.131928
+DEAL:3d/3d::Particle index 6 is in cell 1.3
+DEAL:3d/3d::Particle location: 0.976939 0.524336 0.0417576
+DEAL:3d/3d::Particle index 7 is in cell 1.4
+DEAL:3d/3d::Particle location: 0.409401 0.185604 0.784775
+DEAL:3d/3d::Particle index 8 is in cell 1.4
+DEAL:3d/3d::Particle location: 0.379733 0.0669421 0.633419
+DEAL:3d/3d::Particle index 9 is in cell 1.7
+DEAL:3d/3d::Particle location: 0.815470 0.866549 0.893669
+DEAL:3d/3d::Particle index 10 is in cell 1.7
+DEAL:3d/3d::Particle location: 0.912352 0.869950 0.623975
+DEAL:3d/3d::Particle index 11 is in cell 1.7
+DEAL:3d/3d::Particle location: 0.978207 0.535190 0.753639
+DEAL:3d/3d::Particle index 12 is in cell 1.7
+DEAL:3d/3d::Particle location: 0.635020 0.771499 0.776105
+DEAL:3d/3d::Particle index 13 is in cell 1.7
+DEAL:3d/3d::Particle location: 0.831545 0.655147 0.914224
+DEAL:3d/3d::Particle index 14 is in cell 1.7
+DEAL:3d/3d::Particle location: 0.616304 0.601936 0.949338
+DEAL:3d/3d::Particle index 15 is in cell 1.7
+DEAL:3d/3d::Particle location: 0.986958 0.788586 0.839888
+DEAL:3d/3d::OK
--- /dev/null
+
+DEAL:2d/2d::Locally owned active cells: 4
+DEAL:2d/2d::Global particles: 16
+DEAL:2d/2d::Cell 1.0 has 6 particles.
+DEAL:2d/2d::Cell 1.1 has 1 particles.
+DEAL:2d/2d::Cell 1.2 has 4 particles.
+DEAL:2d/2d::Cell 1.3 has 5 particles.
+DEAL:2d/2d::Particle index 0 is in cell 1.0
+DEAL:2d/2d::Particle location: 0.413003 0.348169
+DEAL:2d/2d::Particle index 1 is in cell 1.0
+DEAL:2d/2d::Particle location: 0.151281 0.0448272
+DEAL:2d/2d::Particle index 2 is in cell 1.0
+DEAL:2d/2d::Particle location: 0.440571 0.102781
+DEAL:2d/2d::Particle index 3 is in cell 1.0
+DEAL:2d/2d::Particle location: 0.420640 0.208781
+DEAL:2d/2d::Particle index 4 is in cell 1.0
+DEAL:2d/2d::Particle location: 0.300562 0.443394
+DEAL:2d/2d::Particle index 5 is in cell 1.0
+DEAL:2d/2d::Particle location: 0.266607 0.125789
+DEAL:2d/2d::Particle index 6 is in cell 1.1
+DEAL:2d/2d::Particle location: 0.711571 0.336786
+DEAL:2d/2d::Particle index 7 is in cell 1.2
+DEAL:2d/2d::Particle location: 0.0110567 0.933580
+DEAL:2d/2d::Particle index 8 is in cell 1.2
+DEAL:2d/2d::Particle location: 0.185746 0.631928
+DEAL:2d/2d::Particle index 9 is in cell 1.2
+DEAL:2d/2d::Particle location: 0.476939 0.524336
+DEAL:2d/2d::Particle index 10 is in cell 1.2
+DEAL:2d/2d::Particle location: 0.0417576 0.909401
+DEAL:2d/2d::Particle index 11 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.685604 0.784775
+DEAL:2d/2d::Particle index 12 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.879733 0.566942
+DEAL:2d/2d::Particle index 13 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.633419 0.815470
+DEAL:2d/2d::Particle index 14 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.866549 0.893669
+DEAL:2d/2d::Particle index 15 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.912352 0.869950
+DEAL:2d/2d::OK
+DEAL:2d/3d::Locally owned active cells: 4
+DEAL:2d/3d::Global particles: 16
+DEAL:2d/3d::Cell 1.0 has 6 particles.
+DEAL:2d/3d::Cell 1.1 has 1 particles.
+DEAL:2d/3d::Cell 1.2 has 4 particles.
+DEAL:2d/3d::Cell 1.3 has 5 particles.
+DEAL:2d/3d::Particle index 0 is in cell 1.0
+DEAL:2d/3d::Particle location: 0.413003 0.348169 0.00000
+DEAL:2d/3d::Particle index 1 is in cell 1.0
+DEAL:2d/3d::Particle location: 0.0448272 0.440571 0.00000
+DEAL:2d/3d::Particle index 2 is in cell 1.0
+DEAL:2d/3d::Particle location: 0.420640 0.208781 0.00000
+DEAL:2d/3d::Particle index 3 is in cell 1.0
+DEAL:2d/3d::Particle location: 0.443394 0.266607 0.00000
+DEAL:2d/3d::Particle index 4 is in cell 1.0
+DEAL:2d/3d::Particle location: 0.211571 0.336786 0.00000
+DEAL:2d/3d::Particle index 5 is in cell 1.0
+DEAL:2d/3d::Particle location: 0.433580 0.185746 0.00000
+DEAL:2d/3d::Particle index 6 is in cell 1.1
+DEAL:2d/3d::Particle location: 0.976939 0.0243363 0.00000
+DEAL:2d/3d::Particle index 7 is in cell 1.2
+DEAL:2d/3d::Particle location: 0.409401 0.685604 0.00000
+DEAL:2d/3d::Particle index 8 is in cell 1.2
+DEAL:2d/3d::Particle location: 0.379733 0.566942 0.00000
+DEAL:2d/3d::Particle index 9 is in cell 1.2
+DEAL:2d/3d::Particle location: 0.315470 0.866549 0.00000
+DEAL:2d/3d::Particle index 10 is in cell 1.2
+DEAL:2d/3d::Particle location: 0.412352 0.869950 0.00000
+DEAL:2d/3d::Particle index 11 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.978207 0.535190 0.00000
+DEAL:2d/3d::Particle index 12 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.635020 0.771499 0.00000
+DEAL:2d/3d::Particle index 13 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.831545 0.655147 0.00000
+DEAL:2d/3d::Particle index 14 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.616304 0.601936 0.00000
+DEAL:2d/3d::Particle index 15 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.986958 0.788586 0.00000
+DEAL:2d/3d::OK
+DEAL:3d/3d::Locally owned active cells: 8
+DEAL:3d/3d::Global particles: 16
+DEAL:3d/3d::Cell 1.0 has 3 particles.
+DEAL:3d/3d::Cell 1.1 has 3 particles.
+DEAL:3d/3d::Cell 1.2 has 0 particles.
+DEAL:3d/3d::Cell 1.3 has 1 particles.
+DEAL:3d/3d::Cell 1.4 has 2 particles.
+DEAL:3d/3d::Cell 1.5 has 2 particles.
+DEAL:3d/3d::Cell 1.6 has 4 particles.
+DEAL:3d/3d::Cell 1.7 has 1 particles.
+DEAL:3d/3d::Particle index 0 is in cell 1.0
+DEAL:3d/3d::Particle location: 0.413003 0.348169 0.151281
+DEAL:3d/3d::Particle index 1 is in cell 1.0
+DEAL:3d/3d::Particle location: 0.0448272 0.440571 0.102781
+DEAL:3d/3d::Particle index 2 is in cell 1.0
+DEAL:3d/3d::Particle location: 0.420640 0.208781 0.300562
+DEAL:3d/3d::Particle index 3 is in cell 1.1
+DEAL:3d/3d::Particle location: 0.943394 0.266607 0.125789
+DEAL:3d/3d::Particle index 4 is in cell 1.1
+DEAL:3d/3d::Particle location: 0.711571 0.336786 0.0110567
+DEAL:3d/3d::Particle index 5 is in cell 1.1
+DEAL:3d/3d::Particle location: 0.933580 0.185746 0.131928
+DEAL:3d/3d::Particle index 6 is in cell 1.3
+DEAL:3d/3d::Particle location: 0.976939 0.524336 0.0417576
+DEAL:3d/3d::Particle index 7 is in cell 1.4
+DEAL:3d/3d::Particle location: 0.409401 0.185604 0.784775
+DEAL:3d/3d::Particle index 8 is in cell 1.4
+DEAL:3d/3d::Particle location: 0.379733 0.0669421 0.633419
+DEAL:3d/3d::Particle index 9 is in cell 1.5
+DEAL:3d/3d::Particle location: 0.815470 0.366549 0.893669
+DEAL:3d/3d::Particle index 10 is in cell 1.5
+DEAL:3d/3d::Particle location: 0.912352 0.369950 0.623975
+DEAL:3d/3d::Particle index 11 is in cell 1.6
+DEAL:3d/3d::Particle location: 0.478207 0.535190 0.753639
+DEAL:3d/3d::Particle index 12 is in cell 1.6
+DEAL:3d/3d::Particle location: 0.135020 0.771499 0.776105
+DEAL:3d/3d::Particle index 13 is in cell 1.6
+DEAL:3d/3d::Particle location: 0.331545 0.655147 0.914224
+DEAL:3d/3d::Particle index 14 is in cell 1.6
+DEAL:3d/3d::Particle location: 0.116304 0.601936 0.949338
+DEAL:3d/3d::Particle index 15 is in cell 1.7
+DEAL:3d/3d::Particle location: 0.986958 0.788586 0.839888
+DEAL:3d/3d::OK
+DEAL:2d/2d::Locally owned active cells: 4
+DEAL:2d/2d::Global particles: 16
+DEAL:2d/2d::Cell 1.0 has 2 particles.
+DEAL:2d/2d::Cell 1.1 has 4 particles.
+DEAL:2d/2d::Cell 1.2 has 1 particles.
+DEAL:2d/2d::Cell 1.3 has 9 particles.
+DEAL:2d/2d::Particle index 0 is in cell 1.0
+DEAL:2d/2d::Particle location: 0.413003 0.348169
+DEAL:2d/2d::Particle index 1 is in cell 1.0
+DEAL:2d/2d::Particle location: 0.151281 0.0448272
+DEAL:2d/2d::Particle index 2 is in cell 1.1
+DEAL:2d/2d::Particle location: 0.940571 0.102781
+DEAL:2d/2d::Particle index 3 is in cell 1.1
+DEAL:2d/2d::Particle location: 0.920640 0.208781
+DEAL:2d/2d::Particle index 4 is in cell 1.1
+DEAL:2d/2d::Particle location: 0.800562 0.443394
+DEAL:2d/2d::Particle index 5 is in cell 1.1
+DEAL:2d/2d::Particle location: 0.766607 0.125789
+DEAL:2d/2d::Particle index 6 is in cell 1.2
+DEAL:2d/2d::Particle location: 0.211571 0.836786
+DEAL:2d/2d::Particle index 7 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.511057 0.933580
+DEAL:2d/2d::Particle index 8 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.685746 0.631928
+DEAL:2d/2d::Particle index 9 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.976939 0.524336
+DEAL:2d/2d::Particle index 10 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.541758 0.909401
+DEAL:2d/2d::Particle index 11 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.685604 0.784775
+DEAL:2d/2d::Particle index 12 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.879733 0.566942
+DEAL:2d/2d::Particle index 13 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.633419 0.815470
+DEAL:2d/2d::Particle index 14 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.866549 0.893669
+DEAL:2d/2d::Particle index 15 is in cell 1.3
+DEAL:2d/2d::Particle location: 0.912352 0.869950
+DEAL:2d/2d::OK
+DEAL:2d/3d::Locally owned active cells: 4
+DEAL:2d/3d::Global particles: 16
+DEAL:2d/3d::Cell 1.0 has 2 particles.
+DEAL:2d/3d::Cell 1.1 has 4 particles.
+DEAL:2d/3d::Cell 1.2 has 1 particles.
+DEAL:2d/3d::Cell 1.3 has 9 particles.
+DEAL:2d/3d::Particle index 0 is in cell 1.0
+DEAL:2d/3d::Particle location: 0.413003 0.348169 0.00000
+DEAL:2d/3d::Particle index 1 is in cell 1.0
+DEAL:2d/3d::Particle location: 0.0448272 0.440571 0.00000
+DEAL:2d/3d::Particle index 2 is in cell 1.1
+DEAL:2d/3d::Particle location: 0.920640 0.208781 0.00000
+DEAL:2d/3d::Particle index 3 is in cell 1.1
+DEAL:2d/3d::Particle location: 0.943394 0.266607 0.00000
+DEAL:2d/3d::Particle index 4 is in cell 1.1
+DEAL:2d/3d::Particle location: 0.711571 0.336786 0.00000
+DEAL:2d/3d::Particle index 5 is in cell 1.1
+DEAL:2d/3d::Particle location: 0.933580 0.185746 0.00000
+DEAL:2d/3d::Particle index 6 is in cell 1.2
+DEAL:2d/3d::Particle location: 0.476939 0.524336 0.00000
+DEAL:2d/3d::Particle index 7 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.909401 0.685604 0.00000
+DEAL:2d/3d::Particle index 8 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.879733 0.566942 0.00000
+DEAL:2d/3d::Particle index 9 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.815470 0.866549 0.00000
+DEAL:2d/3d::Particle index 10 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.912352 0.869950 0.00000
+DEAL:2d/3d::Particle index 11 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.978207 0.535190 0.00000
+DEAL:2d/3d::Particle index 12 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.635020 0.771499 0.00000
+DEAL:2d/3d::Particle index 13 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.831545 0.655147 0.00000
+DEAL:2d/3d::Particle index 14 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.616304 0.601936 0.00000
+DEAL:2d/3d::Particle index 15 is in cell 1.3
+DEAL:2d/3d::Particle location: 0.986958 0.788586 0.00000
+DEAL:2d/3d::OK
+DEAL:3d/3d::Locally owned active cells: 8
+DEAL:3d/3d::Global particles: 16
+DEAL:3d/3d::Cell 1.0 has 2 particles.
+DEAL:3d/3d::Cell 1.1 has 1 particles.
+DEAL:3d/3d::Cell 1.2 has 3 particles.
+DEAL:3d/3d::Cell 1.3 has 1 particles.
+DEAL:3d/3d::Cell 1.4 has 2 particles.
+DEAL:3d/3d::Cell 1.5 has 0 particles.
+DEAL:3d/3d::Cell 1.6 has 0 particles.
+DEAL:3d/3d::Cell 1.7 has 7 particles.
+DEAL:3d/3d::Particle index 0 is in cell 1.0
+DEAL:3d/3d::Particle location: 0.413003 0.348169 0.151281
+DEAL:3d/3d::Particle index 1 is in cell 1.0
+DEAL:3d/3d::Particle location: 0.0448272 0.440571 0.102781
+DEAL:3d/3d::Particle index 2 is in cell 1.1
+DEAL:3d/3d::Particle location: 0.920640 0.208781 0.300562
+DEAL:3d/3d::Particle index 3 is in cell 1.2
+DEAL:3d/3d::Particle location: 0.443394 0.766607 0.125789
+DEAL:3d/3d::Particle index 4 is in cell 1.2
+DEAL:3d/3d::Particle location: 0.211571 0.836786 0.0110567
+DEAL:3d/3d::Particle index 5 is in cell 1.2
+DEAL:3d/3d::Particle location: 0.433580 0.685746 0.131928
+DEAL:3d/3d::Particle index 6 is in cell 1.3
+DEAL:3d/3d::Particle location: 0.976939 0.524336 0.0417576
+DEAL:3d/3d::Particle index 7 is in cell 1.4
+DEAL:3d/3d::Particle location: 0.409401 0.185604 0.784775
+DEAL:3d/3d::Particle index 8 is in cell 1.4
+DEAL:3d/3d::Particle location: 0.379733 0.0669421 0.633419
+DEAL:3d/3d::Particle index 9 is in cell 1.7
+DEAL:3d/3d::Particle location: 0.815470 0.866549 0.893669
+DEAL:3d/3d::Particle index 10 is in cell 1.7
+DEAL:3d/3d::Particle location: 0.912352 0.869950 0.623975
+DEAL:3d/3d::Particle index 11 is in cell 1.7
+DEAL:3d/3d::Particle location: 0.978207 0.535190 0.753639
+DEAL:3d/3d::Particle index 12 is in cell 1.7
+DEAL:3d/3d::Particle location: 0.635020 0.771499 0.776105
+DEAL:3d/3d::Particle index 13 is in cell 1.7
+DEAL:3d/3d::Particle location: 0.831545 0.655147 0.914224
+DEAL:3d/3d::Particle index 14 is in cell 1.7
+DEAL:3d/3d::Particle location: 0.616304 0.601936 0.949338
+DEAL:3d/3d::Particle index 15 is in cell 1.7
+DEAL:3d/3d::Particle location: 0.986958 0.788586 0.839888
+DEAL:3d/3d::OK