From eea41347d151c73dfde85efd5964954aad083a79 Mon Sep 17 00:00:00 2001 From: Rene Gassmoeller Date: Thu, 18 Feb 2021 16:15:26 -0500 Subject: [PATCH] Move particle ids into PropertyPool --- include/deal.II/particles/particle.h | 76 +-- include/deal.II/particles/property_pool.h | 120 ++++- source/particles/particle.cc | 31 +- source/particles/property_pool.cc | 7 + tests/particles/generators_06.cc | 2 +- ...erators_06.with_p4est=true.mpirun=1.output | 484 ++++++++--------- ...erators_06.with_p4est=true.mpirun=2.output | 496 +++++++++--------- 7 files changed, 645 insertions(+), 571 deletions(-) diff --git a/include/deal.II/particles/particle.h b/include/deal.II/particles/particle.h index d676baf9c5..a42bdb9889 100644 --- a/include/deal.II/particles/particle.h +++ b/include/deal.II/particles/particle.h @@ -28,56 +28,6 @@ DEAL_II_NAMESPACE_OPEN -namespace types -{ - /* Type definitions */ - -#ifdef DEAL_II_WITH_64BIT_INDICES - /** - * The type used for indices of particles. While in - * sequential computations the 4 billion indices of 32-bit unsigned integers - * is plenty, parallel computations using hundreds of processes can overflow - * this number and we need a bigger index space. We here utilize the same - * build variable that controls the dof indices because the number - * of degrees of freedom and the number of particles are typically on the same - * order of magnitude. - * - * The data type always indicates an unsigned integer type. - */ - using particle_index = uint64_t; - -# ifdef DEAL_II_WITH_MPI - /** - * An identifier that denotes the MPI type associated with - * types::global_dof_index. - */ -# define DEAL_II_PARTICLE_INDEX_MPI_TYPE MPI_UINT64_T -# endif - -#else - /** - * The type used for indices of particles. While in - * sequential computations the 4 billion indices of 32-bit unsigned integers - * is plenty, parallel computations using hundreds of processes can overflow - * this number and we need a bigger index space. We here utilize the same - * build variable that controls the dof indices because the number - * of degrees of freedom and the number of particles are typically on the same - * order of magnitude. - * - * The data type always indicates an unsigned integer type. - */ - using particle_index = unsigned int; - -# ifdef DEAL_II_WITH_MPI - /** - * An identifier that denotes the MPI type associated with - * types::global_dof_index. - */ -# define DEAL_II_PARTICLE_INDEX_MPI_TYPE MPI_UNSIGNED -# endif -#endif -} // namespace types - /** * A namespace that contains all classes that are related to the particle * implementation, in particular the fundamental Particle class. @@ -479,11 +429,6 @@ namespace Particles */ static PropertyPool global_property_pool; - /** - * Globally unique ID of particle. - */ - types::particle_index id; - /** * A pointer to the property pool. Necessary to translate from the * handle to the actual memory locations. @@ -507,12 +452,14 @@ namespace Particles { unsigned int n_properties = 0; - Point location; - Point reference_location; + Point location; + Point reference_location; + types::particle_index id; ar &location &reference_location &id &n_properties; set_location(location); set_reference_location(reference_location); + set_id(id); if (n_properties > 0) { @@ -542,8 +489,9 @@ namespace Particles (property_pool_handle != PropertyPool::invalid_handle)) n_properties = get_properties().size(); - Point location = get_location(); - Point reference_location = get_reference_location(); + Point location = get_location(); + Point reference_location = get_reference_location(); + types::particle_index id = get_id(); ar &location &reference_location &id &n_properties; @@ -594,7 +542,7 @@ namespace Particles inline types::particle_index Particle::get_id() const { - return id; + return property_pool->get_id(property_pool_handle); } @@ -603,7 +551,7 @@ namespace Particles inline void Particle::set_id(const types::particle_index &new_id) { - id = new_id; + property_pool->set_id(property_pool_handle, new_id); } @@ -627,8 +575,9 @@ namespace Particles const typename PropertyPool::Handle new_handle = new_property_pool.register_particle(); - const Point location = get_location(); - const Point reference_location = get_reference_location(); + const Point location = get_location(); + const Point reference_location = get_reference_location(); + const types::particle_index id = get_id(); if (/* old pool */ has_properties()) { @@ -652,6 +601,7 @@ namespace Particles // Now also store the saved locations set_location(location); set_reference_location(reference_location); + set_id(id); } diff --git a/include/deal.II/particles/property_pool.h b/include/deal.II/particles/property_pool.h index b696e206b2..fecb665d71 100644 --- a/include/deal.II/particles/property_pool.h +++ b/include/deal.II/particles/property_pool.h @@ -24,6 +24,56 @@ DEAL_II_NAMESPACE_OPEN +namespace types +{ + /* Type definitions */ + +#ifdef DEAL_II_WITH_64BIT_INDICES + /** + * The type used for indices of particles. While in + * sequential computations the 4 billion indices of 32-bit unsigned integers + * is plenty, parallel computations using hundreds of processes can overflow + * this number and we need a bigger index space. We here utilize the same + * build variable that controls the dof indices because the number + * of degrees of freedom and the number of particles are typically on the same + * order of magnitude. + * + * The data type always indicates an unsigned integer type. + */ + using particle_index = uint64_t; + +# ifdef DEAL_II_WITH_MPI + /** + * An identifier that denotes the MPI type associated with + * types::global_dof_index. + */ +# define DEAL_II_PARTICLE_INDEX_MPI_TYPE MPI_UINT64_T +# endif + +#else + /** + * The type used for indices of particles. While in + * sequential computations the 4 billion indices of 32-bit unsigned integers + * is plenty, parallel computations using hundreds of processes can overflow + * this number and we need a bigger index space. We here utilize the same + * build variable that controls the dof indices because the number + * of degrees of freedom and the number of particles are typically on the same + * order of magnitude. + * + * The data type always indicates an unsigned integer type. + */ + using particle_index = unsigned int; + +# ifdef DEAL_II_WITH_MPI + /** + * An identifier that denotes the MPI type associated with + * types::global_dof_index. + */ +# define DEAL_II_PARTICLE_INDEX_MPI_TYPE MPI_UNSIGNED +# endif +#endif +} // namespace types + namespace Particles { /** @@ -127,6 +177,20 @@ namespace Particles set_reference_location(const Handle handle, const Point &new_reference_location); + /** + * Return the ID number of this particle identified by the given + * `handle`. + */ + types::particle_index + get_id(const Handle handle) const; + + /** + * Set the ID number of this particle identified by the given + * `handle`. + */ + void + set_id(const Handle handle, const types::particle_index &new_id); + /** * Return an ArrayView to the properties that correspond to the given * handle @p handle. @@ -167,6 +231,13 @@ namespace Particles */ std::vector> reference_locations; + /** + * A vector that stores the unique identifiers of particles. It is indexed + * in the same way as the `locations` and `properties` arrays, i.e., via + * handles. + */ + std::vector ids; + /** * The currently allocated properties (whether assigned to * a particle or available for assignment). It is indexed the same way as @@ -273,7 +344,7 @@ namespace Particles // just check against the array range, and rely on the fact // that handles are invalidated when handed over to // deallocate_properties_array(). - Assert(data_index <= locations.size() - 1, + Assert(data_index <= reference_locations.size() - 1, ExcMessage("Invalid location handle. This can happen if the " "handle was duplicated and then one copy was deallocated " "before trying to access the properties.")); @@ -283,6 +354,53 @@ namespace Particles + template + inline types::particle_index + PropertyPool::get_id(const Handle handle) const + { + const std::vector::size_type data_index = + (handle != invalid_handle) ? handle : 0; + + // Ideally we would need to assert that 'handle' has not been deallocated + // by searching through 'currently_available_handles'. However, this + // is expensive and this function is performance critical, so instead + // just check against the array range, and rely on the fact + // that handles are invalidated when handed over to + // deallocate_properties_array(). + Assert(data_index <= ids.size() - 1, + ExcMessage("Invalid location handle. This can happen if the " + "handle was duplicated and then one copy was deallocated " + "before trying to access the properties.")); + + return ids[data_index]; + } + + + + template + inline void + PropertyPool::set_id(const Handle handle, + const types::particle_index &new_id) + { + const std::vector::size_type data_index = + (handle != invalid_handle) ? handle : 0; + + // Ideally we would need to assert that 'handle' has not been deallocated + // by searching through 'currently_available_handles'. However, this + // is expensive and this function is performance critical, so instead + // just check against the array range, and rely on the fact + // that handles are invalidated when handed over to + // deallocate_properties_array(). + Assert(data_index <= ids.size() - 1, + ExcMessage("Invalid location handle. This can happen if the " + "handle was duplicated and then one copy was deallocated " + "before trying to access the properties.")); + + ids[data_index] = new_id; + } + + + template inline ArrayView PropertyPool::get_properties(const Handle handle) diff --git a/source/particles/particle.cc b/source/particles/particle.cc index d94efaa0cf..9dc5cb1571 100644 --- a/source/particles/particle.cc +++ b/source/particles/particle.cc @@ -28,8 +28,7 @@ namespace Particles template Particle::Particle() - : id(0) - , property_pool(&global_property_pool) + : property_pool(&global_property_pool) , property_pool_handle(property_pool->register_particle()) {} @@ -39,24 +38,24 @@ namespace Particles Particle::Particle(const Point &location, const Point & reference_location, const types::particle_index id) - : id(id) - , property_pool(&global_property_pool) + : property_pool(&global_property_pool) , property_pool_handle(property_pool->register_particle()) { set_location(location); set_reference_location(reference_location); + set_id(id); } template Particle::Particle(const Particle &particle) - : id(particle.get_id()) - , property_pool(particle.property_pool) + : property_pool(particle.property_pool) , property_pool_handle(property_pool->register_particle()) { set_location(particle.get_location()); set_reference_location(particle.get_reference_location()); + set_id(particle.get_id()); if (particle.has_properties()) { @@ -77,14 +76,13 @@ namespace Particles Particle::Particle( const void *& data, PropertyPool *const new_property_pool) - : id(0) - , property_pool(new_property_pool != nullptr ? new_property_pool : + : property_pool(new_property_pool != nullptr ? new_property_pool : &global_property_pool) , property_pool_handle(property_pool->register_particle()) { const types::particle_index *id_data = static_cast(data); - id = *id_data++; + set_id(*id_data++); const double *pdata = reinterpret_cast(id_data); Point location; @@ -113,11 +111,10 @@ namespace Particles template Particle::Particle(Particle &&particle) noexcept - : id(std::move(particle.id)) - , property_pool(std::move(particle.property_pool)) + : property_pool(std::move(particle.property_pool)) , property_pool_handle(std::move(particle.property_pool_handle)) { - // There is no need to copy locations and properties -- we simply + // There is no need to copy locations, properties, and id -- we simply // inherit them from the object we move from. // We stole the rhs's properties, so we need to invalidate @@ -134,14 +131,13 @@ namespace Particles { if (this != &particle) { - id = particle.id; - Assert(this->property_pool->n_properties_per_slot() == particle.property_pool->n_properties_per_slot(), ExcInternalError()); set_location(particle.get_location()); set_reference_location(particle.get_reference_location()); + set_id(particle.get_id()); if (particle.has_properties()) { @@ -174,11 +170,10 @@ namespace Particles if (property_pool_handle != PropertyPool::invalid_handle) property_pool->deregister_particle(property_pool_handle); - id = std::move(particle.id); property_pool = std::move(particle.property_pool); property_pool_handle = std::move(particle.property_pool_handle); - // No need to copy locations and properties -- we just get them + // No need to copy locations, properties, and id -- we just get them // by taking over the property pool handle. // We stole the rhs's properties, so we need to invalidate @@ -224,7 +219,7 @@ namespace Particles Particle::write_data(void *&data) const { types::particle_index *id_data = static_cast(data); - *id_data = id; + *id_data = get_id(); ++id_data; double *pdata = reinterpret_cast(id_data); @@ -256,7 +251,7 @@ namespace Particles { const types::particle_index *id_data = static_cast(data); - id = *id_data++; + set_id(*id_data++); const double *pdata = reinterpret_cast(id_data); Point location; diff --git a/source/particles/property_pool.cc b/source/particles/property_pool.cc index 4f315eecea..f4221756dd 100644 --- a/source/particles/property_pool.cc +++ b/source/particles/property_pool.cc @@ -69,6 +69,9 @@ namespace Particles reference_locations.clear(); reference_locations.shrink_to_fit(); + ids.clear(); + ids.shrink_to_fit(); + properties.clear(); properties.shrink_to_fit(); @@ -94,6 +97,7 @@ namespace Particles locations.resize(locations.size() + 1); reference_locations.resize(reference_locations.size() + 1); + ids.resize(ids.size() + 1); properties.resize(properties.size() + n_properties); } @@ -101,6 +105,7 @@ namespace Particles // but initialize properties with zero. set_location(handle, numbers::signaling_nan>()); set_reference_location(handle, numbers::signaling_nan>()); + set_id(handle, numbers::invalid_unsigned_int); for (double &x : get_properties(handle)) x = 0; @@ -130,6 +135,7 @@ namespace Particles properties.clear(); locations.clear(); reference_locations.clear(); + ids.clear(); } } @@ -142,6 +148,7 @@ namespace Particles locations.reserve(size); reference_locations.reserve(size); properties.reserve(size * n_properties); + ids.reserve(size); } diff --git a/tests/particles/generators_06.cc b/tests/particles/generators_06.cc index ddeec32747..a8e241f4e3 100644 --- a/tests/particles/generators_06.cc +++ b/tests/particles/generators_06.cc @@ -97,7 +97,7 @@ main(int argc, char *argv[]) { Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1); - initlog(); + MPILogInitAll all; { deallog.push("2d/2d"); diff --git a/tests/particles/generators_06.with_p4est=true.mpirun=1.output b/tests/particles/generators_06.with_p4est=true.mpirun=1.output index 810bba81cc..d4a640f385 100644 --- a/tests/particles/generators_06.with_p4est=true.mpirun=1.output +++ b/tests/particles/generators_06.with_p4est=true.mpirun=1.output @@ -1,243 +1,243 @@ -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 +DEAL:0:2d/2d::Locally owned active cells: 4 +DEAL:0:2d/2d::Global particles: 16 +DEAL:0:2d/2d::Cell 1.0 has 6 particles. +DEAL:0:2d/2d::Cell 1.1 has 1 particles. +DEAL:0:2d/2d::Cell 1.2 has 4 particles. +DEAL:0:2d/2d::Cell 1.3 has 5 particles. +DEAL:0:2d/2d::Particle index 0 is in cell 1.0 +DEAL:0:2d/2d::Particle location: 0.413003 0.348169 +DEAL:0:2d/2d::Particle index 1 is in cell 1.0 +DEAL:0:2d/2d::Particle location: 0.151281 0.0448272 +DEAL:0:2d/2d::Particle index 2 is in cell 1.0 +DEAL:0:2d/2d::Particle location: 0.440571 0.102781 +DEAL:0:2d/2d::Particle index 3 is in cell 1.0 +DEAL:0:2d/2d::Particle location: 0.420640 0.208781 +DEAL:0:2d/2d::Particle index 4 is in cell 1.0 +DEAL:0:2d/2d::Particle location: 0.300562 0.443394 +DEAL:0:2d/2d::Particle index 5 is in cell 1.0 +DEAL:0:2d/2d::Particle location: 0.266607 0.125789 +DEAL:0:2d/2d::Particle index 6 is in cell 1.1 +DEAL:0:2d/2d::Particle location: 0.711571 0.336786 +DEAL:0:2d/2d::Particle index 7 is in cell 1.2 +DEAL:0:2d/2d::Particle location: 0.0110567 0.933580 +DEAL:0:2d/2d::Particle index 8 is in cell 1.2 +DEAL:0:2d/2d::Particle location: 0.185746 0.631928 +DEAL:0:2d/2d::Particle index 9 is in cell 1.2 +DEAL:0:2d/2d::Particle location: 0.476939 0.524336 +DEAL:0:2d/2d::Particle index 10 is in cell 1.2 +DEAL:0:2d/2d::Particle location: 0.0417576 0.909401 +DEAL:0:2d/2d::Particle index 11 is in cell 1.3 +DEAL:0:2d/2d::Particle location: 0.685604 0.784775 +DEAL:0:2d/2d::Particle index 12 is in cell 1.3 +DEAL:0:2d/2d::Particle location: 0.879733 0.566942 +DEAL:0:2d/2d::Particle index 13 is in cell 1.3 +DEAL:0:2d/2d::Particle location: 0.633419 0.815470 +DEAL:0:2d/2d::Particle index 14 is in cell 1.3 +DEAL:0:2d/2d::Particle location: 0.866549 0.893669 +DEAL:0:2d/2d::Particle index 15 is in cell 1.3 +DEAL:0:2d/2d::Particle location: 0.912352 0.869950 +DEAL:0:2d/2d::OK +DEAL:0:2d/3d::Locally owned active cells: 4 +DEAL:0:2d/3d::Global particles: 16 +DEAL:0:2d/3d::Cell 1.0 has 6 particles. +DEAL:0:2d/3d::Cell 1.1 has 1 particles. +DEAL:0:2d/3d::Cell 1.2 has 4 particles. +DEAL:0:2d/3d::Cell 1.3 has 5 particles. +DEAL:0:2d/3d::Particle index 0 is in cell 1.0 +DEAL:0:2d/3d::Particle location: 0.413003 0.348169 0.00000 +DEAL:0:2d/3d::Particle index 1 is in cell 1.0 +DEAL:0:2d/3d::Particle location: 0.0448272 0.440571 0.00000 +DEAL:0:2d/3d::Particle index 2 is in cell 1.0 +DEAL:0:2d/3d::Particle location: 0.420640 0.208781 0.00000 +DEAL:0:2d/3d::Particle index 3 is in cell 1.0 +DEAL:0:2d/3d::Particle location: 0.443394 0.266607 0.00000 +DEAL:0:2d/3d::Particle index 4 is in cell 1.0 +DEAL:0:2d/3d::Particle location: 0.211571 0.336786 0.00000 +DEAL:0:2d/3d::Particle index 5 is in cell 1.0 +DEAL:0:2d/3d::Particle location: 0.433580 0.185746 0.00000 +DEAL:0:2d/3d::Particle index 6 is in cell 1.1 +DEAL:0:2d/3d::Particle location: 0.976939 0.0243363 0.00000 +DEAL:0:2d/3d::Particle index 7 is in cell 1.2 +DEAL:0:2d/3d::Particle location: 0.409401 0.685604 0.00000 +DEAL:0:2d/3d::Particle index 8 is in cell 1.2 +DEAL:0:2d/3d::Particle location: 0.379733 0.566942 0.00000 +DEAL:0:2d/3d::Particle index 9 is in cell 1.2 +DEAL:0:2d/3d::Particle location: 0.315470 0.866549 0.00000 +DEAL:0:2d/3d::Particle index 10 is in cell 1.2 +DEAL:0:2d/3d::Particle location: 0.412352 0.869950 0.00000 +DEAL:0:2d/3d::Particle index 11 is in cell 1.3 +DEAL:0:2d/3d::Particle location: 0.978207 0.535190 0.00000 +DEAL:0:2d/3d::Particle index 12 is in cell 1.3 +DEAL:0:2d/3d::Particle location: 0.635020 0.771499 0.00000 +DEAL:0:2d/3d::Particle index 13 is in cell 1.3 +DEAL:0:2d/3d::Particle location: 0.831545 0.655147 0.00000 +DEAL:0:2d/3d::Particle index 14 is in cell 1.3 +DEAL:0:2d/3d::Particle location: 0.616304 0.601936 0.00000 +DEAL:0:2d/3d::Particle index 15 is in cell 1.3 +DEAL:0:2d/3d::Particle location: 0.986958 0.788586 0.00000 +DEAL:0:2d/3d::OK +DEAL:0:3d/3d::Locally owned active cells: 8 +DEAL:0:3d/3d::Global particles: 16 +DEAL:0:3d/3d::Cell 1.0 has 3 particles. +DEAL:0:3d/3d::Cell 1.1 has 3 particles. +DEAL:0:3d/3d::Cell 1.2 has 0 particles. +DEAL:0:3d/3d::Cell 1.3 has 1 particles. +DEAL:0:3d/3d::Cell 1.4 has 2 particles. +DEAL:0:3d/3d::Cell 1.5 has 2 particles. +DEAL:0:3d/3d::Cell 1.6 has 4 particles. +DEAL:0:3d/3d::Cell 1.7 has 1 particles. +DEAL:0:3d/3d::Particle index 0 is in cell 1.0 +DEAL:0:3d/3d::Particle location: 0.413003 0.348169 0.151281 +DEAL:0:3d/3d::Particle index 1 is in cell 1.0 +DEAL:0:3d/3d::Particle location: 0.0448272 0.440571 0.102781 +DEAL:0:3d/3d::Particle index 2 is in cell 1.0 +DEAL:0:3d/3d::Particle location: 0.420640 0.208781 0.300562 +DEAL:0:3d/3d::Particle index 3 is in cell 1.1 +DEAL:0:3d/3d::Particle location: 0.943394 0.266607 0.125789 +DEAL:0:3d/3d::Particle index 4 is in cell 1.1 +DEAL:0:3d/3d::Particle location: 0.711571 0.336786 0.0110567 +DEAL:0:3d/3d::Particle index 5 is in cell 1.1 +DEAL:0:3d/3d::Particle location: 0.933580 0.185746 0.131928 +DEAL:0:3d/3d::Particle index 6 is in cell 1.3 +DEAL:0:3d/3d::Particle location: 0.976939 0.524336 0.0417576 +DEAL:0:3d/3d::Particle index 7 is in cell 1.4 +DEAL:0:3d/3d::Particle location: 0.409401 0.185604 0.784775 +DEAL:0:3d/3d::Particle index 8 is in cell 1.4 +DEAL:0:3d/3d::Particle location: 0.379733 0.0669421 0.633419 +DEAL:0:3d/3d::Particle index 9 is in cell 1.5 +DEAL:0:3d/3d::Particle location: 0.815470 0.366549 0.893669 +DEAL:0:3d/3d::Particle index 10 is in cell 1.5 +DEAL:0:3d/3d::Particle location: 0.912352 0.369950 0.623975 +DEAL:0:3d/3d::Particle index 11 is in cell 1.6 +DEAL:0:3d/3d::Particle location: 0.478207 0.535190 0.753639 +DEAL:0:3d/3d::Particle index 12 is in cell 1.6 +DEAL:0:3d/3d::Particle location: 0.135020 0.771499 0.776105 +DEAL:0:3d/3d::Particle index 13 is in cell 1.6 +DEAL:0:3d/3d::Particle location: 0.331545 0.655147 0.914224 +DEAL:0:3d/3d::Particle index 14 is in cell 1.6 +DEAL:0:3d/3d::Particle location: 0.116304 0.601936 0.949338 +DEAL:0:3d/3d::Particle index 15 is in cell 1.7 +DEAL:0:3d/3d::Particle location: 0.986958 0.788586 0.839888 +DEAL:0:3d/3d::OK +DEAL:0:2d/2d::Locally owned active cells: 4 +DEAL:0:2d/2d::Global particles: 16 +DEAL:0:2d/2d::Cell 1.0 has 2 particles. +DEAL:0:2d/2d::Cell 1.1 has 4 particles. +DEAL:0:2d/2d::Cell 1.2 has 1 particles. +DEAL:0:2d/2d::Cell 1.3 has 9 particles. +DEAL:0:2d/2d::Particle index 0 is in cell 1.0 +DEAL:0:2d/2d::Particle location: 0.413003 0.348169 +DEAL:0:2d/2d::Particle index 1 is in cell 1.0 +DEAL:0:2d/2d::Particle location: 0.151281 0.0448272 +DEAL:0:2d/2d::Particle index 2 is in cell 1.1 +DEAL:0:2d/2d::Particle location: 0.940571 0.102781 +DEAL:0:2d/2d::Particle index 3 is in cell 1.1 +DEAL:0:2d/2d::Particle location: 0.920640 0.208781 +DEAL:0:2d/2d::Particle index 4 is in cell 1.1 +DEAL:0:2d/2d::Particle location: 0.800562 0.443394 +DEAL:0:2d/2d::Particle index 5 is in cell 1.1 +DEAL:0:2d/2d::Particle location: 0.766607 0.125789 +DEAL:0:2d/2d::Particle index 6 is in cell 1.2 +DEAL:0:2d/2d::Particle location: 0.211571 0.836786 +DEAL:0:2d/2d::Particle index 7 is in cell 1.3 +DEAL:0:2d/2d::Particle location: 0.511057 0.933580 +DEAL:0:2d/2d::Particle index 8 is in cell 1.3 +DEAL:0:2d/2d::Particle location: 0.685746 0.631928 +DEAL:0:2d/2d::Particle index 9 is in cell 1.3 +DEAL:0:2d/2d::Particle location: 0.976939 0.524336 +DEAL:0:2d/2d::Particle index 10 is in cell 1.3 +DEAL:0:2d/2d::Particle location: 0.541758 0.909401 +DEAL:0:2d/2d::Particle index 11 is in cell 1.3 +DEAL:0:2d/2d::Particle location: 0.685604 0.784775 +DEAL:0:2d/2d::Particle index 12 is in cell 1.3 +DEAL:0:2d/2d::Particle location: 0.879733 0.566942 +DEAL:0:2d/2d::Particle index 13 is in cell 1.3 +DEAL:0:2d/2d::Particle location: 0.633419 0.815470 +DEAL:0:2d/2d::Particle index 14 is in cell 1.3 +DEAL:0:2d/2d::Particle location: 0.866549 0.893669 +DEAL:0:2d/2d::Particle index 15 is in cell 1.3 +DEAL:0:2d/2d::Particle location: 0.912352 0.869950 +DEAL:0:2d/2d::OK +DEAL:0:2d/3d::Locally owned active cells: 4 +DEAL:0:2d/3d::Global particles: 16 +DEAL:0:2d/3d::Cell 1.0 has 2 particles. +DEAL:0:2d/3d::Cell 1.1 has 4 particles. +DEAL:0:2d/3d::Cell 1.2 has 1 particles. +DEAL:0:2d/3d::Cell 1.3 has 9 particles. +DEAL:0:2d/3d::Particle index 0 is in cell 1.0 +DEAL:0:2d/3d::Particle location: 0.413003 0.348169 0.00000 +DEAL:0:2d/3d::Particle index 1 is in cell 1.0 +DEAL:0:2d/3d::Particle location: 0.0448272 0.440571 0.00000 +DEAL:0:2d/3d::Particle index 2 is in cell 1.1 +DEAL:0:2d/3d::Particle location: 0.920640 0.208781 0.00000 +DEAL:0:2d/3d::Particle index 3 is in cell 1.1 +DEAL:0:2d/3d::Particle location: 0.943394 0.266607 0.00000 +DEAL:0:2d/3d::Particle index 4 is in cell 1.1 +DEAL:0:2d/3d::Particle location: 0.711571 0.336786 0.00000 +DEAL:0:2d/3d::Particle index 5 is in cell 1.1 +DEAL:0:2d/3d::Particle location: 0.933580 0.185746 0.00000 +DEAL:0:2d/3d::Particle index 6 is in cell 1.2 +DEAL:0:2d/3d::Particle location: 0.476939 0.524336 0.00000 +DEAL:0:2d/3d::Particle index 7 is in cell 1.3 +DEAL:0:2d/3d::Particle location: 0.909401 0.685604 0.00000 +DEAL:0:2d/3d::Particle index 8 is in cell 1.3 +DEAL:0:2d/3d::Particle location: 0.879733 0.566942 0.00000 +DEAL:0:2d/3d::Particle index 9 is in cell 1.3 +DEAL:0:2d/3d::Particle location: 0.815470 0.866549 0.00000 +DEAL:0:2d/3d::Particle index 10 is in cell 1.3 +DEAL:0:2d/3d::Particle location: 0.912352 0.869950 0.00000 +DEAL:0:2d/3d::Particle index 11 is in cell 1.3 +DEAL:0:2d/3d::Particle location: 0.978207 0.535190 0.00000 +DEAL:0:2d/3d::Particle index 12 is in cell 1.3 +DEAL:0:2d/3d::Particle location: 0.635020 0.771499 0.00000 +DEAL:0:2d/3d::Particle index 13 is in cell 1.3 +DEAL:0:2d/3d::Particle location: 0.831545 0.655147 0.00000 +DEAL:0:2d/3d::Particle index 14 is in cell 1.3 +DEAL:0:2d/3d::Particle location: 0.616304 0.601936 0.00000 +DEAL:0:2d/3d::Particle index 15 is in cell 1.3 +DEAL:0:2d/3d::Particle location: 0.986958 0.788586 0.00000 +DEAL:0:2d/3d::OK +DEAL:0:3d/3d::Locally owned active cells: 8 +DEAL:0:3d/3d::Global particles: 16 +DEAL:0:3d/3d::Cell 1.0 has 2 particles. +DEAL:0:3d/3d::Cell 1.1 has 1 particles. +DEAL:0:3d/3d::Cell 1.2 has 3 particles. +DEAL:0:3d/3d::Cell 1.3 has 1 particles. +DEAL:0:3d/3d::Cell 1.4 has 2 particles. +DEAL:0:3d/3d::Cell 1.5 has 0 particles. +DEAL:0:3d/3d::Cell 1.6 has 0 particles. +DEAL:0:3d/3d::Cell 1.7 has 7 particles. +DEAL:0:3d/3d::Particle index 0 is in cell 1.0 +DEAL:0:3d/3d::Particle location: 0.413003 0.348169 0.151281 +DEAL:0:3d/3d::Particle index 1 is in cell 1.0 +DEAL:0:3d/3d::Particle location: 0.0448272 0.440571 0.102781 +DEAL:0:3d/3d::Particle index 2 is in cell 1.1 +DEAL:0:3d/3d::Particle location: 0.920640 0.208781 0.300562 +DEAL:0:3d/3d::Particle index 3 is in cell 1.2 +DEAL:0:3d/3d::Particle location: 0.443394 0.766607 0.125789 +DEAL:0:3d/3d::Particle index 4 is in cell 1.2 +DEAL:0:3d/3d::Particle location: 0.211571 0.836786 0.0110567 +DEAL:0:3d/3d::Particle index 5 is in cell 1.2 +DEAL:0:3d/3d::Particle location: 0.433580 0.685746 0.131928 +DEAL:0:3d/3d::Particle index 6 is in cell 1.3 +DEAL:0:3d/3d::Particle location: 0.976939 0.524336 0.0417576 +DEAL:0:3d/3d::Particle index 7 is in cell 1.4 +DEAL:0:3d/3d::Particle location: 0.409401 0.185604 0.784775 +DEAL:0:3d/3d::Particle index 8 is in cell 1.4 +DEAL:0:3d/3d::Particle location: 0.379733 0.0669421 0.633419 +DEAL:0:3d/3d::Particle index 9 is in cell 1.7 +DEAL:0:3d/3d::Particle location: 0.815470 0.866549 0.893669 +DEAL:0:3d/3d::Particle index 10 is in cell 1.7 +DEAL:0:3d/3d::Particle location: 0.912352 0.869950 0.623975 +DEAL:0:3d/3d::Particle index 11 is in cell 1.7 +DEAL:0:3d/3d::Particle location: 0.978207 0.535190 0.753639 +DEAL:0:3d/3d::Particle index 12 is in cell 1.7 +DEAL:0:3d/3d::Particle location: 0.635020 0.771499 0.776105 +DEAL:0:3d/3d::Particle index 13 is in cell 1.7 +DEAL:0:3d/3d::Particle location: 0.831545 0.655147 0.914224 +DEAL:0:3d/3d::Particle index 14 is in cell 1.7 +DEAL:0:3d/3d::Particle location: 0.616304 0.601936 0.949338 +DEAL:0:3d/3d::Particle index 15 is in cell 1.7 +DEAL:0:3d/3d::Particle location: 0.986958 0.788586 0.839888 +DEAL:0:3d/3d::OK diff --git a/tests/particles/generators_06.with_p4est=true.mpirun=2.output b/tests/particles/generators_06.with_p4est=true.mpirun=2.output index b7d4d42e81..20591e7d4a 100644 --- a/tests/particles/generators_06.with_p4est=true.mpirun=2.output +++ b/tests/particles/generators_06.with_p4est=true.mpirun=2.output @@ -1,247 +1,251 @@ -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 +DEAL:0:2d/2d::Locally owned active cells: 4 +DEAL:0:2d/2d::Global particles: 16 +DEAL:0:2d/2d::Cell 1.0 has 6 particles. +DEAL:0:2d/2d::Cell 1.1 has 1 particles. +DEAL:0:2d/2d::Cell 1.2 has 4 particles. +DEAL:0:2d/2d::Cell 1.3 has 5 particles. +DEAL:0:2d/2d::Particle index 0 is in cell 1.0 +DEAL:0:2d/2d::Particle location: 0.413003 0.348169 +DEAL:0:2d/2d::Particle index 1 is in cell 1.0 +DEAL:0:2d/2d::Particle location: 0.151281 0.0448272 +DEAL:0:2d/2d::Particle index 2 is in cell 1.0 +DEAL:0:2d/2d::Particle location: 0.440571 0.102781 +DEAL:0:2d/2d::Particle index 3 is in cell 1.0 +DEAL:0:2d/2d::Particle location: 0.420640 0.208781 +DEAL:0:2d/2d::Particle index 4 is in cell 1.0 +DEAL:0:2d/2d::Particle location: 0.300562 0.443394 +DEAL:0:2d/2d::Particle index 5 is in cell 1.0 +DEAL:0:2d/2d::Particle location: 0.266607 0.125789 +DEAL:0:2d/2d::Particle index 6 is in cell 1.1 +DEAL:0:2d/2d::Particle location: 0.711571 0.336786 +DEAL:0:2d/2d::Particle index 7 is in cell 1.2 +DEAL:0:2d/2d::Particle location: 0.0110567 0.933580 +DEAL:0:2d/2d::Particle index 8 is in cell 1.2 +DEAL:0:2d/2d::Particle location: 0.185746 0.631928 +DEAL:0:2d/2d::Particle index 9 is in cell 1.2 +DEAL:0:2d/2d::Particle location: 0.476939 0.524336 +DEAL:0:2d/2d::Particle index 10 is in cell 1.2 +DEAL:0:2d/2d::Particle location: 0.0417576 0.909401 +DEAL:0:2d/2d::Particle index 11 is in cell 1.3 +DEAL:0:2d/2d::Particle location: 0.685604 0.784775 +DEAL:0:2d/2d::Particle index 12 is in cell 1.3 +DEAL:0:2d/2d::Particle location: 0.879733 0.566942 +DEAL:0:2d/2d::Particle index 13 is in cell 1.3 +DEAL:0:2d/2d::Particle location: 0.633419 0.815470 +DEAL:0:2d/2d::Particle index 14 is in cell 1.3 +DEAL:0:2d/2d::Particle location: 0.866549 0.893669 +DEAL:0:2d/2d::Particle index 15 is in cell 1.3 +DEAL:0:2d/2d::Particle location: 0.912352 0.869950 +DEAL:0:2d/2d::OK +DEAL:0:2d/3d::Locally owned active cells: 4 +DEAL:0:2d/3d::Global particles: 16 +DEAL:0:2d/3d::Cell 1.0 has 6 particles. +DEAL:0:2d/3d::Cell 1.1 has 1 particles. +DEAL:0:2d/3d::Cell 1.2 has 4 particles. +DEAL:0:2d/3d::Cell 1.3 has 5 particles. +DEAL:0:2d/3d::Particle index 0 is in cell 1.0 +DEAL:0:2d/3d::Particle location: 0.413003 0.348169 0.00000 +DEAL:0:2d/3d::Particle index 1 is in cell 1.0 +DEAL:0:2d/3d::Particle location: 0.0448272 0.440571 0.00000 +DEAL:0:2d/3d::Particle index 2 is in cell 1.0 +DEAL:0:2d/3d::Particle location: 0.420640 0.208781 0.00000 +DEAL:0:2d/3d::Particle index 3 is in cell 1.0 +DEAL:0:2d/3d::Particle location: 0.443394 0.266607 0.00000 +DEAL:0:2d/3d::Particle index 4 is in cell 1.0 +DEAL:0:2d/3d::Particle location: 0.211571 0.336786 0.00000 +DEAL:0:2d/3d::Particle index 5 is in cell 1.0 +DEAL:0:2d/3d::Particle location: 0.433580 0.185746 0.00000 +DEAL:0:2d/3d::Particle index 6 is in cell 1.1 +DEAL:0:2d/3d::Particle location: 0.976939 0.0243363 0.00000 +DEAL:0:2d/3d::Particle index 7 is in cell 1.2 +DEAL:0:2d/3d::Particle location: 0.409401 0.685604 0.00000 +DEAL:0:2d/3d::Particle index 8 is in cell 1.2 +DEAL:0:2d/3d::Particle location: 0.379733 0.566942 0.00000 +DEAL:0:2d/3d::Particle index 9 is in cell 1.2 +DEAL:0:2d/3d::Particle location: 0.315470 0.866549 0.00000 +DEAL:0:2d/3d::Particle index 10 is in cell 1.2 +DEAL:0:2d/3d::Particle location: 0.412352 0.869950 0.00000 +DEAL:0:2d/3d::Particle index 11 is in cell 1.3 +DEAL:0:2d/3d::Particle location: 0.978207 0.535190 0.00000 +DEAL:0:2d/3d::Particle index 12 is in cell 1.3 +DEAL:0:2d/3d::Particle location: 0.635020 0.771499 0.00000 +DEAL:0:2d/3d::Particle index 13 is in cell 1.3 +DEAL:0:2d/3d::Particle location: 0.831545 0.655147 0.00000 +DEAL:0:2d/3d::Particle index 14 is in cell 1.3 +DEAL:0:2d/3d::Particle location: 0.616304 0.601936 0.00000 +DEAL:0:2d/3d::Particle index 15 is in cell 1.3 +DEAL:0:2d/3d::Particle location: 0.986958 0.788586 0.00000 +DEAL:0:2d/3d::OK +DEAL:0:3d/3d::Locally owned active cells: 8 +DEAL:0:3d/3d::Global particles: 16 +DEAL:0:3d/3d::Cell 1.0 has 3 particles. +DEAL:0:3d/3d::Cell 1.1 has 3 particles. +DEAL:0:3d/3d::Cell 1.2 has 0 particles. +DEAL:0:3d/3d::Cell 1.3 has 1 particles. +DEAL:0:3d/3d::Cell 1.4 has 2 particles. +DEAL:0:3d/3d::Cell 1.5 has 2 particles. +DEAL:0:3d/3d::Cell 1.6 has 4 particles. +DEAL:0:3d/3d::Cell 1.7 has 1 particles. +DEAL:0:3d/3d::Particle index 0 is in cell 1.0 +DEAL:0:3d/3d::Particle location: 0.413003 0.348169 0.151281 +DEAL:0:3d/3d::Particle index 1 is in cell 1.0 +DEAL:0:3d/3d::Particle location: 0.0448272 0.440571 0.102781 +DEAL:0:3d/3d::Particle index 2 is in cell 1.0 +DEAL:0:3d/3d::Particle location: 0.420640 0.208781 0.300562 +DEAL:0:3d/3d::Particle index 3 is in cell 1.1 +DEAL:0:3d/3d::Particle location: 0.943394 0.266607 0.125789 +DEAL:0:3d/3d::Particle index 4 is in cell 1.1 +DEAL:0:3d/3d::Particle location: 0.711571 0.336786 0.0110567 +DEAL:0:3d/3d::Particle index 5 is in cell 1.1 +DEAL:0:3d/3d::Particle location: 0.933580 0.185746 0.131928 +DEAL:0:3d/3d::Particle index 6 is in cell 1.3 +DEAL:0:3d/3d::Particle location: 0.976939 0.524336 0.0417576 +DEAL:0:3d/3d::Particle index 7 is in cell 1.4 +DEAL:0:3d/3d::Particle location: 0.409401 0.185604 0.784775 +DEAL:0:3d/3d::Particle index 8 is in cell 1.4 +DEAL:0:3d/3d::Particle location: 0.379733 0.0669421 0.633419 +DEAL:0:3d/3d::Particle index 9 is in cell 1.5 +DEAL:0:3d/3d::Particle location: 0.815470 0.366549 0.893669 +DEAL:0:3d/3d::Particle index 10 is in cell 1.5 +DEAL:0:3d/3d::Particle location: 0.912352 0.369950 0.623975 +DEAL:0:3d/3d::Particle index 11 is in cell 1.6 +DEAL:0:3d/3d::Particle location: 0.478207 0.535190 0.753639 +DEAL:0:3d/3d::Particle index 12 is in cell 1.6 +DEAL:0:3d/3d::Particle location: 0.135020 0.771499 0.776105 +DEAL:0:3d/3d::Particle index 13 is in cell 1.6 +DEAL:0:3d/3d::Particle location: 0.331545 0.655147 0.914224 +DEAL:0:3d/3d::Particle index 14 is in cell 1.6 +DEAL:0:3d/3d::Particle location: 0.116304 0.601936 0.949338 +DEAL:0:3d/3d::Particle index 15 is in cell 1.7 +DEAL:0:3d/3d::Particle location: 0.986958 0.788586 0.839888 +DEAL:0:3d/3d::OK +DEAL:0:2d/2d::Locally owned active cells: 4 +DEAL:0:2d/2d::Global particles: 16 +DEAL:0:2d/2d::Cell 1.0 has 2 particles. +DEAL:0:2d/2d::Cell 1.1 has 4 particles. +DEAL:0:2d/2d::Cell 1.2 has 1 particles. +DEAL:0:2d/2d::Cell 1.3 has 9 particles. +DEAL:0:2d/2d::Particle index 0 is in cell 1.0 +DEAL:0:2d/2d::Particle location: 0.413003 0.348169 +DEAL:0:2d/2d::Particle index 1 is in cell 1.0 +DEAL:0:2d/2d::Particle location: 0.151281 0.0448272 +DEAL:0:2d/2d::Particle index 2 is in cell 1.1 +DEAL:0:2d/2d::Particle location: 0.940571 0.102781 +DEAL:0:2d/2d::Particle index 3 is in cell 1.1 +DEAL:0:2d/2d::Particle location: 0.920640 0.208781 +DEAL:0:2d/2d::Particle index 4 is in cell 1.1 +DEAL:0:2d/2d::Particle location: 0.800562 0.443394 +DEAL:0:2d/2d::Particle index 5 is in cell 1.1 +DEAL:0:2d/2d::Particle location: 0.766607 0.125789 +DEAL:0:2d/2d::Particle index 6 is in cell 1.2 +DEAL:0:2d/2d::Particle location: 0.211571 0.836786 +DEAL:0:2d/2d::Particle index 7 is in cell 1.3 +DEAL:0:2d/2d::Particle location: 0.511057 0.933580 +DEAL:0:2d/2d::Particle index 8 is in cell 1.3 +DEAL:0:2d/2d::Particle location: 0.685746 0.631928 +DEAL:0:2d/2d::Particle index 9 is in cell 1.3 +DEAL:0:2d/2d::Particle location: 0.976939 0.524336 +DEAL:0:2d/2d::Particle index 10 is in cell 1.3 +DEAL:0:2d/2d::Particle location: 0.541758 0.909401 +DEAL:0:2d/2d::Particle index 11 is in cell 1.3 +DEAL:0:2d/2d::Particle location: 0.685604 0.784775 +DEAL:0:2d/2d::Particle index 12 is in cell 1.3 +DEAL:0:2d/2d::Particle location: 0.879733 0.566942 +DEAL:0:2d/2d::Particle index 13 is in cell 1.3 +DEAL:0:2d/2d::Particle location: 0.633419 0.815470 +DEAL:0:2d/2d::Particle index 14 is in cell 1.3 +DEAL:0:2d/2d::Particle location: 0.866549 0.893669 +DEAL:0:2d/2d::Particle index 15 is in cell 1.3 +DEAL:0:2d/2d::Particle location: 0.912352 0.869950 +DEAL:0:2d/2d::OK +DEAL:0:2d/3d::Locally owned active cells: 4 +DEAL:0:2d/3d::Global particles: 16 +DEAL:0:2d/3d::Cell 1.0 has 2 particles. +DEAL:0:2d/3d::Cell 1.1 has 4 particles. +DEAL:0:2d/3d::Cell 1.2 has 1 particles. +DEAL:0:2d/3d::Cell 1.3 has 9 particles. +DEAL:0:2d/3d::Particle index 0 is in cell 1.0 +DEAL:0:2d/3d::Particle location: 0.413003 0.348169 0.00000 +DEAL:0:2d/3d::Particle index 1 is in cell 1.0 +DEAL:0:2d/3d::Particle location: 0.0448272 0.440571 0.00000 +DEAL:0:2d/3d::Particle index 2 is in cell 1.1 +DEAL:0:2d/3d::Particle location: 0.920640 0.208781 0.00000 +DEAL:0:2d/3d::Particle index 3 is in cell 1.1 +DEAL:0:2d/3d::Particle location: 0.943394 0.266607 0.00000 +DEAL:0:2d/3d::Particle index 4 is in cell 1.1 +DEAL:0:2d/3d::Particle location: 0.711571 0.336786 0.00000 +DEAL:0:2d/3d::Particle index 5 is in cell 1.1 +DEAL:0:2d/3d::Particle location: 0.933580 0.185746 0.00000 +DEAL:0:2d/3d::Particle index 6 is in cell 1.2 +DEAL:0:2d/3d::Particle location: 0.476939 0.524336 0.00000 +DEAL:0:2d/3d::Particle index 7 is in cell 1.3 +DEAL:0:2d/3d::Particle location: 0.909401 0.685604 0.00000 +DEAL:0:2d/3d::Particle index 8 is in cell 1.3 +DEAL:0:2d/3d::Particle location: 0.879733 0.566942 0.00000 +DEAL:0:2d/3d::Particle index 9 is in cell 1.3 +DEAL:0:2d/3d::Particle location: 0.815470 0.866549 0.00000 +DEAL:0:2d/3d::Particle index 10 is in cell 1.3 +DEAL:0:2d/3d::Particle location: 0.912352 0.869950 0.00000 +DEAL:0:2d/3d::Particle index 11 is in cell 1.3 +DEAL:0:2d/3d::Particle location: 0.978207 0.535190 0.00000 +DEAL:0:2d/3d::Particle index 12 is in cell 1.3 +DEAL:0:2d/3d::Particle location: 0.635020 0.771499 0.00000 +DEAL:0:2d/3d::Particle index 13 is in cell 1.3 +DEAL:0:2d/3d::Particle location: 0.831545 0.655147 0.00000 +DEAL:0:2d/3d::Particle index 14 is in cell 1.3 +DEAL:0:2d/3d::Particle location: 0.616304 0.601936 0.00000 +DEAL:0:2d/3d::Particle index 15 is in cell 1.3 +DEAL:0:2d/3d::Particle location: 0.986958 0.788586 0.00000 +DEAL:0:2d/3d::OK +DEAL:0:3d/3d::Locally owned active cells: 8 +DEAL:0:3d/3d::Global particles: 16 +DEAL:0:3d/3d::Cell 1.0 has 2 particles. +DEAL:0:3d/3d::Cell 1.1 has 1 particles. +DEAL:0:3d/3d::Cell 1.2 has 3 particles. +DEAL:0:3d/3d::Cell 1.3 has 1 particles. +DEAL:0:3d/3d::Cell 1.4 has 2 particles. +DEAL:0:3d/3d::Cell 1.5 has 0 particles. +DEAL:0:3d/3d::Cell 1.6 has 0 particles. +DEAL:0:3d/3d::Cell 1.7 has 7 particles. +DEAL:0:3d/3d::Particle index 0 is in cell 1.0 +DEAL:0:3d/3d::Particle location: 0.413003 0.348169 0.151281 +DEAL:0:3d/3d::Particle index 1 is in cell 1.0 +DEAL:0:3d/3d::Particle location: 0.0448272 0.440571 0.102781 +DEAL:0:3d/3d::Particle index 2 is in cell 1.1 +DEAL:0:3d/3d::Particle location: 0.920640 0.208781 0.300562 +DEAL:0:3d/3d::Particle index 3 is in cell 1.2 +DEAL:0:3d/3d::Particle location: 0.443394 0.766607 0.125789 +DEAL:0:3d/3d::Particle index 4 is in cell 1.2 +DEAL:0:3d/3d::Particle location: 0.211571 0.836786 0.0110567 +DEAL:0:3d/3d::Particle index 5 is in cell 1.2 +DEAL:0:3d/3d::Particle location: 0.433580 0.685746 0.131928 +DEAL:0:3d/3d::Particle index 6 is in cell 1.3 +DEAL:0:3d/3d::Particle location: 0.976939 0.524336 0.0417576 +DEAL:0:3d/3d::Particle index 7 is in cell 1.4 +DEAL:0:3d/3d::Particle location: 0.409401 0.185604 0.784775 +DEAL:0:3d/3d::Particle index 8 is in cell 1.4 +DEAL:0:3d/3d::Particle location: 0.379733 0.0669421 0.633419 +DEAL:0:3d/3d::Particle index 9 is in cell 1.7 +DEAL:0:3d/3d::Particle location: 0.815470 0.866549 0.893669 +DEAL:0:3d/3d::Particle index 10 is in cell 1.7 +DEAL:0:3d/3d::Particle location: 0.912352 0.869950 0.623975 +DEAL:0:3d/3d::Particle index 11 is in cell 1.7 +DEAL:0:3d/3d::Particle location: 0.978207 0.535190 0.753639 +DEAL:0:3d/3d::Particle index 12 is in cell 1.7 +DEAL:0:3d/3d::Particle location: 0.635020 0.771499 0.776105 +DEAL:0:3d/3d::Particle index 13 is in cell 1.7 +DEAL:0:3d/3d::Particle location: 0.831545 0.655147 0.914224 +DEAL:0:3d/3d::Particle index 14 is in cell 1.7 +DEAL:0:3d/3d::Particle location: 0.616304 0.601936 0.949338 +DEAL:0:3d/3d::Particle index 15 is in cell 1.7 +DEAL:0:3d/3d::Particle location: 0.986958 0.788586 0.839888 +DEAL:0:3d/3d::OK + +DEAL:1:2d/2d::OK +DEAL:1:2d/3d::OK +DEAL:1:3d/3d::OK +DEAL:1:2d/2d::OK +DEAL:1:2d/3d::OK +DEAL:1:3d/3d::OK + -- 2.39.5