]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Fix invalid memory access in particle properties after transfer 7661/head
authorRene Gassmoeller <rene.gassmoeller@mailbox.org>
Thu, 31 Jan 2019 00:42:20 +0000 (16:42 -0800)
committerRene Gassmoeller <rene.gassmoeller@mailbox.org>
Thu, 31 Jan 2019 01:05:21 +0000 (17:05 -0800)
include/deal.II/particles/particle.h
source/particles/particle.cc
source/particles/particle_handler.cc
tests/particles/particle_handler_08.cc [new file with mode: 0644]
tests/particles/particle_handler_08.with_p4est=true.output [new file with mode: 0644]

index b4d3de0581b3b6b1233a3ee40e11d590a3999d34..df6ebd17418e08a417335de142b8d74ff2fd4dde 100644 (file)
@@ -256,7 +256,12 @@ namespace Particles
     set_properties(const ArrayView<const double> &new_properties);
 
     /**
-     * Get write-access to properties of this particle.
+     * Get write-access to properties of this particle. If the
+     * particle has no properties yet, but has access to a
+     * PropertyPool object it will allocate properties to
+     * allow writing into them. If it has no properties and
+     * has no access to a PropertyPool this function will
+     * throw an exception.
      *
      * @return An ArrayView of the properties of this particle.
      */
@@ -264,7 +269,8 @@ namespace Particles
     get_properties();
 
     /**
-     * Get read-access to properties of this particle.
+     * Get read-access to properties of this particle. If the particle
+     * has no properties this function throws an exception.
      *
      * @return An ArrayView of the properties of this particle.
      */
index b5dea11fa8d06e0c96392b72d57874c8c1fc81e8..03f90811b333584cb03f7ff17cf4d843bd551b27 100644 (file)
@@ -284,6 +284,8 @@ namespace Particles
   Particle<dim, spacedim>::set_properties(
     const ArrayView<const double> &new_properties)
   {
+    Assert(property_pool != nullptr, ExcInternalError());
+
     if (properties == PropertyPool::invalid_handle)
       properties = property_pool->allocate_properties_array();
 
@@ -313,7 +315,7 @@ namespace Particles
   const ArrayView<const double>
   Particle<dim, spacedim>::get_properties() const
   {
-    Assert(property_pool != nullptr, ExcInternalError());
+    Assert(has_properties(), ExcInternalError());
 
     return property_pool->get_properties(properties);
   }
@@ -326,6 +328,9 @@ namespace Particles
   {
     Assert(property_pool != nullptr, ExcInternalError());
 
+    if (properties == PropertyPool::invalid_handle)
+      properties = property_pool->allocate_properties_array();
+
     return property_pool->get_properties(properties);
   }
 
index 84f61ff4da79e847af4c1e64e65a99408774598c..af3b69a031601fc886924ba8846c62df721b0551 100644 (file)
@@ -1200,6 +1200,12 @@ namespace Particles
         data_range.end(),
         /*allow_compression=*/true);
 
+    // Update the reference to the current property pool for all particles.
+    // This was not stored, because they might be transported across process
+    // domains.
+    for (auto &particle : loaded_particles_on_cell)
+      particle.set_property_pool(*property_pool);
+
     switch (status)
       {
         case parallel::distributed::Triangulation<dim, spacedim>::CELL_PERSIST:
diff --git a/tests/particles/particle_handler_08.cc b/tests/particles/particle_handler_08.cc
new file mode 100644 (file)
index 0000000..d5cd3be
--- /dev/null
@@ -0,0 +1,183 @@
+// ---------------------------------------------------------------------
+//
+// Copyright (C) 2017 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 particle_handler_05, but check that the properties of particles are
+// correctly transferred during grid
+// refinement/coarsening. Note that this in particular tests for a bug, where
+// references to the property pool where lost during particle transfer.
+
+#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/particle_handler.h>
+
+#include "../tests.h"
+
+template <int dim, int spacedim>
+void
+create_regular_particle_distribution(
+  Particles::ParticleHandler<dim, spacedim> &                particle_handler,
+  const parallel::distributed::Triangulation<dim, spacedim> &tr,
+  const unsigned int particles_per_direction = 3)
+{
+  for (unsigned int i = 0; i < particles_per_direction; ++i)
+    for (unsigned int j = 0; j < particles_per_direction; ++j)
+      {
+        Point<spacedim> position;
+        Point<dim>      reference_position;
+        unsigned int    id = i * particles_per_direction + j;
+
+        position[0] = static_cast<double>(i) /
+                      static_cast<double>(particles_per_direction - 1);
+        position[1] = static_cast<double>(j) /
+                      static_cast<double>(particles_per_direction - 1);
+
+        if (dim > 2)
+          for (unsigned int k = 0; k < particles_per_direction; ++k)
+            {
+              position[2] = static_cast<double>(j) /
+                            static_cast<double>(particles_per_direction - 1);
+              id = i * particles_per_direction * particles_per_direction +
+                   j * particles_per_direction + k;
+              Particles::Particle<dim, spacedim> particle(position,
+                                                          reference_position,
+                                                          id);
+
+              typename parallel::distributed::Triangulation<dim, spacedim>::
+                active_cell_iterator cell =
+                  GridTools::find_active_cell_around_point(
+                    tr, particle.get_location());
+
+              Particles::ParticleIterator<dim, spacedim> pit =
+                particle_handler.insert_particle(particle, cell);
+
+              for (unsigned int i = 0; i < spacedim; ++i)
+                pit->get_properties()[i] = pit->get_location()[i];
+            }
+        else
+          {
+            Particles::Particle<dim, spacedim> particle(position,
+                                                        reference_position,
+                                                        id);
+
+            typename parallel::distributed::Triangulation<dim, spacedim>::
+              active_cell_iterator cell =
+                GridTools::find_active_cell_around_point(
+                  tr, particle.get_location());
+
+            Particles::ParticleIterator<dim, spacedim> pit =
+              particle_handler.insert_particle(particle, cell);
+
+            for (unsigned int i = 0; i < spacedim; ++i)
+              pit->get_properties()[i] = pit->get_location()[i];
+          }
+      }
+}
+
+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);
+
+    const unsigned int                        n_properties = spacedim;
+    Particles::ParticleHandler<dim, spacedim> particle_handler(tr,
+                                                               mapping,
+                                                               n_properties);
+
+    // TODO: Move this into the Particle handler class. Unfortunately, there are
+    // some interactions with the SolutionTransfer class that prevent us from
+    // doing this at the moment. When doing this, check that transferring a
+    // solution and particles during the same refinement is possible (in
+    // particular that the order of serialization/deserialization is preserved).
+    tr.signals.pre_distributed_refinement.connect(std::bind(
+      &Particles::ParticleHandler<dim,
+                                  spacedim>::register_store_callback_function,
+      &particle_handler));
+
+    tr.signals.post_distributed_refinement.connect(std::bind(
+      &Particles::ParticleHandler<dim,
+                                  spacedim>::register_load_callback_function,
+      &particle_handler,
+      false));
+
+    create_regular_particle_distribution(particle_handler, tr);
+
+    for (auto particle = particle_handler.begin();
+         particle != particle_handler.end();
+         ++particle)
+      deallog << "Before refinement particle id " << particle->get_id()
+              << " has first property " << particle->get_properties()[0]
+              << " and second property " << particle->get_properties()[1]
+              << std::endl;
+
+    // Check that all particles are moved to children
+    tr.refine_global(1);
+
+    for (auto particle = particle_handler.begin();
+         particle != particle_handler.end();
+         ++particle)
+      deallog << "After refinement particle id " << particle->get_id()
+              << " has first property " << particle->get_properties()[0]
+              << " and second property " << particle->get_properties()[1]
+              << std::endl;
+
+    // Reverse the refinement and check again
+    for (auto cell = tr.begin_active(); cell != tr.end(); ++cell)
+      cell->set_coarsen_flag();
+
+    tr.execute_coarsening_and_refinement();
+
+    for (auto particle = particle_handler.begin();
+         particle != particle_handler.end();
+         ++particle)
+      deallog << "After coarsening particle id " << particle->get_id()
+              << " has first property " << particle->get_properties()[0]
+              << " and second property " << particle->get_properties()[1]
+              << std::endl;
+  }
+
+  deallog << "OK" << std::endl;
+}
+
+
+
+int
+main(int argc, char *argv[])
+{
+  Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
+
+  MPILogInitAll all;
+
+  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();
+}
diff --git a/tests/particles/particle_handler_08.with_p4est=true.output b/tests/particles/particle_handler_08.with_p4est=true.output
new file mode 100644 (file)
index 0000000..f54a16d
--- /dev/null
@@ -0,0 +1,139 @@
+
+DEAL:0:2d/2d::Before refinement particle id 0 has first property 0.00000 and second property 0.00000
+DEAL:0:2d/2d::Before refinement particle id 1 has first property 0.00000 and second property 0.500000
+DEAL:0:2d/2d::Before refinement particle id 2 has first property 0.00000 and second property 1.00000
+DEAL:0:2d/2d::Before refinement particle id 3 has first property 0.500000 and second property 0.00000
+DEAL:0:2d/2d::Before refinement particle id 4 has first property 0.500000 and second property 0.500000
+DEAL:0:2d/2d::Before refinement particle id 5 has first property 0.500000 and second property 1.00000
+DEAL:0:2d/2d::Before refinement particle id 6 has first property 1.00000 and second property 0.00000
+DEAL:0:2d/2d::Before refinement particle id 7 has first property 1.00000 and second property 0.500000
+DEAL:0:2d/2d::Before refinement particle id 8 has first property 1.00000 and second property 1.00000
+DEAL:0:2d/2d::After refinement particle id 0 has first property 0.00000 and second property 0.00000
+DEAL:0:2d/2d::After refinement particle id 1 has first property 0.00000 and second property 0.500000
+DEAL:0:2d/2d::After refinement particle id 3 has first property 0.500000 and second property 0.00000
+DEAL:0:2d/2d::After refinement particle id 4 has first property 0.500000 and second property 0.500000
+DEAL:0:2d/2d::After refinement particle id 6 has first property 1.00000 and second property 0.00000
+DEAL:0:2d/2d::After refinement particle id 7 has first property 1.00000 and second property 0.500000
+DEAL:0:2d/2d::After refinement particle id 2 has first property 0.00000 and second property 1.00000
+DEAL:0:2d/2d::After refinement particle id 5 has first property 0.500000 and second property 1.00000
+DEAL:0:2d/2d::After refinement particle id 8 has first property 1.00000 and second property 1.00000
+DEAL:0:2d/2d::After coarsening particle id 0 has first property 0.00000 and second property 0.00000
+DEAL:0:2d/2d::After coarsening particle id 1 has first property 0.00000 and second property 0.500000
+DEAL:0:2d/2d::After coarsening particle id 3 has first property 0.500000 and second property 0.00000
+DEAL:0:2d/2d::After coarsening particle id 4 has first property 0.500000 and second property 0.500000
+DEAL:0:2d/2d::After coarsening particle id 6 has first property 1.00000 and second property 0.00000
+DEAL:0:2d/2d::After coarsening particle id 7 has first property 1.00000 and second property 0.500000
+DEAL:0:2d/2d::After coarsening particle id 2 has first property 0.00000 and second property 1.00000
+DEAL:0:2d/2d::After coarsening particle id 5 has first property 0.500000 and second property 1.00000
+DEAL:0:2d/2d::After coarsening particle id 8 has first property 1.00000 and second property 1.00000
+DEAL:0:2d/2d::OK
+DEAL:0:2d/3d::Before refinement particle id 0 has first property 0.00000 and second property 0.00000
+DEAL:0:2d/3d::Before refinement particle id 1 has first property 0.00000 and second property 0.500000
+DEAL:0:2d/3d::Before refinement particle id 2 has first property 0.00000 and second property 1.00000
+DEAL:0:2d/3d::Before refinement particle id 3 has first property 0.500000 and second property 0.00000
+DEAL:0:2d/3d::Before refinement particle id 4 has first property 0.500000 and second property 0.500000
+DEAL:0:2d/3d::Before refinement particle id 5 has first property 0.500000 and second property 1.00000
+DEAL:0:2d/3d::Before refinement particle id 6 has first property 1.00000 and second property 0.00000
+DEAL:0:2d/3d::Before refinement particle id 7 has first property 1.00000 and second property 0.500000
+DEAL:0:2d/3d::Before refinement particle id 8 has first property 1.00000 and second property 1.00000
+DEAL:0:2d/3d::After refinement particle id 0 has first property 0.00000 and second property 0.00000
+DEAL:0:2d/3d::After refinement particle id 1 has first property 0.00000 and second property 0.500000
+DEAL:0:2d/3d::After refinement particle id 3 has first property 0.500000 and second property 0.00000
+DEAL:0:2d/3d::After refinement particle id 4 has first property 0.500000 and second property 0.500000
+DEAL:0:2d/3d::After refinement particle id 6 has first property 1.00000 and second property 0.00000
+DEAL:0:2d/3d::After refinement particle id 7 has first property 1.00000 and second property 0.500000
+DEAL:0:2d/3d::After refinement particle id 2 has first property 0.00000 and second property 1.00000
+DEAL:0:2d/3d::After refinement particle id 5 has first property 0.500000 and second property 1.00000
+DEAL:0:2d/3d::After refinement particle id 8 has first property 1.00000 and second property 1.00000
+DEAL:0:2d/3d::After coarsening particle id 0 has first property 0.00000 and second property 0.00000
+DEAL:0:2d/3d::After coarsening particle id 1 has first property 0.00000 and second property 0.500000
+DEAL:0:2d/3d::After coarsening particle id 3 has first property 0.500000 and second property 0.00000
+DEAL:0:2d/3d::After coarsening particle id 4 has first property 0.500000 and second property 0.500000
+DEAL:0:2d/3d::After coarsening particle id 6 has first property 1.00000 and second property 0.00000
+DEAL:0:2d/3d::After coarsening particle id 7 has first property 1.00000 and second property 0.500000
+DEAL:0:2d/3d::After coarsening particle id 2 has first property 0.00000 and second property 1.00000
+DEAL:0:2d/3d::After coarsening particle id 5 has first property 0.500000 and second property 1.00000
+DEAL:0:2d/3d::After coarsening particle id 8 has first property 1.00000 and second property 1.00000
+DEAL:0:2d/3d::OK
+DEAL:0:3d/3d::Before refinement particle id 0 has first property 0.00000 and second property 0.00000
+DEAL:0:3d/3d::Before refinement particle id 1 has first property 0.00000 and second property 0.00000
+DEAL:0:3d/3d::Before refinement particle id 2 has first property 0.00000 and second property 0.00000
+DEAL:0:3d/3d::Before refinement particle id 3 has first property 0.00000 and second property 0.500000
+DEAL:0:3d/3d::Before refinement particle id 4 has first property 0.00000 and second property 0.500000
+DEAL:0:3d/3d::Before refinement particle id 5 has first property 0.00000 and second property 0.500000
+DEAL:0:3d/3d::Before refinement particle id 6 has first property 0.00000 and second property 1.00000
+DEAL:0:3d/3d::Before refinement particle id 7 has first property 0.00000 and second property 1.00000
+DEAL:0:3d/3d::Before refinement particle id 8 has first property 0.00000 and second property 1.00000
+DEAL:0:3d/3d::Before refinement particle id 9 has first property 0.500000 and second property 0.00000
+DEAL:0:3d/3d::Before refinement particle id 10 has first property 0.500000 and second property 0.00000
+DEAL:0:3d/3d::Before refinement particle id 11 has first property 0.500000 and second property 0.00000
+DEAL:0:3d/3d::Before refinement particle id 12 has first property 0.500000 and second property 0.500000
+DEAL:0:3d/3d::Before refinement particle id 13 has first property 0.500000 and second property 0.500000
+DEAL:0:3d/3d::Before refinement particle id 14 has first property 0.500000 and second property 0.500000
+DEAL:0:3d/3d::Before refinement particle id 15 has first property 0.500000 and second property 1.00000
+DEAL:0:3d/3d::Before refinement particle id 16 has first property 0.500000 and second property 1.00000
+DEAL:0:3d/3d::Before refinement particle id 17 has first property 0.500000 and second property 1.00000
+DEAL:0:3d/3d::Before refinement particle id 18 has first property 1.00000 and second property 0.00000
+DEAL:0:3d/3d::Before refinement particle id 19 has first property 1.00000 and second property 0.00000
+DEAL:0:3d/3d::Before refinement particle id 20 has first property 1.00000 and second property 0.00000
+DEAL:0:3d/3d::Before refinement particle id 21 has first property 1.00000 and second property 0.500000
+DEAL:0:3d/3d::Before refinement particle id 22 has first property 1.00000 and second property 0.500000
+DEAL:0:3d/3d::Before refinement particle id 23 has first property 1.00000 and second property 0.500000
+DEAL:0:3d/3d::Before refinement particle id 24 has first property 1.00000 and second property 1.00000
+DEAL:0:3d/3d::Before refinement particle id 25 has first property 1.00000 and second property 1.00000
+DEAL:0:3d/3d::Before refinement particle id 26 has first property 1.00000 and second property 1.00000
+DEAL:0:3d/3d::After refinement particle id 0 has first property 0.00000 and second property 0.00000
+DEAL:0:3d/3d::After refinement particle id 1 has first property 0.00000 and second property 0.00000
+DEAL:0:3d/3d::After refinement particle id 2 has first property 0.00000 and second property 0.00000
+DEAL:0:3d/3d::After refinement particle id 3 has first property 0.00000 and second property 0.500000
+DEAL:0:3d/3d::After refinement particle id 4 has first property 0.00000 and second property 0.500000
+DEAL:0:3d/3d::After refinement particle id 5 has first property 0.00000 and second property 0.500000
+DEAL:0:3d/3d::After refinement particle id 9 has first property 0.500000 and second property 0.00000
+DEAL:0:3d/3d::After refinement particle id 10 has first property 0.500000 and second property 0.00000
+DEAL:0:3d/3d::After refinement particle id 11 has first property 0.500000 and second property 0.00000
+DEAL:0:3d/3d::After refinement particle id 12 has first property 0.500000 and second property 0.500000
+DEAL:0:3d/3d::After refinement particle id 13 has first property 0.500000 and second property 0.500000
+DEAL:0:3d/3d::After refinement particle id 14 has first property 0.500000 and second property 0.500000
+DEAL:0:3d/3d::After refinement particle id 18 has first property 1.00000 and second property 0.00000
+DEAL:0:3d/3d::After refinement particle id 19 has first property 1.00000 and second property 0.00000
+DEAL:0:3d/3d::After refinement particle id 20 has first property 1.00000 and second property 0.00000
+DEAL:0:3d/3d::After refinement particle id 21 has first property 1.00000 and second property 0.500000
+DEAL:0:3d/3d::After refinement particle id 22 has first property 1.00000 and second property 0.500000
+DEAL:0:3d/3d::After refinement particle id 23 has first property 1.00000 and second property 0.500000
+DEAL:0:3d/3d::After refinement particle id 6 has first property 0.00000 and second property 1.00000
+DEAL:0:3d/3d::After refinement particle id 7 has first property 0.00000 and second property 1.00000
+DEAL:0:3d/3d::After refinement particle id 8 has first property 0.00000 and second property 1.00000
+DEAL:0:3d/3d::After refinement particle id 15 has first property 0.500000 and second property 1.00000
+DEAL:0:3d/3d::After refinement particle id 16 has first property 0.500000 and second property 1.00000
+DEAL:0:3d/3d::After refinement particle id 17 has first property 0.500000 and second property 1.00000
+DEAL:0:3d/3d::After refinement particle id 24 has first property 1.00000 and second property 1.00000
+DEAL:0:3d/3d::After refinement particle id 25 has first property 1.00000 and second property 1.00000
+DEAL:0:3d/3d::After refinement particle id 26 has first property 1.00000 and second property 1.00000
+DEAL:0:3d/3d::After coarsening particle id 0 has first property 0.00000 and second property 0.00000
+DEAL:0:3d/3d::After coarsening particle id 1 has first property 0.00000 and second property 0.00000
+DEAL:0:3d/3d::After coarsening particle id 2 has first property 0.00000 and second property 0.00000
+DEAL:0:3d/3d::After coarsening particle id 3 has first property 0.00000 and second property 0.500000
+DEAL:0:3d/3d::After coarsening particle id 4 has first property 0.00000 and second property 0.500000
+DEAL:0:3d/3d::After coarsening particle id 5 has first property 0.00000 and second property 0.500000
+DEAL:0:3d/3d::After coarsening particle id 9 has first property 0.500000 and second property 0.00000
+DEAL:0:3d/3d::After coarsening particle id 10 has first property 0.500000 and second property 0.00000
+DEAL:0:3d/3d::After coarsening particle id 11 has first property 0.500000 and second property 0.00000
+DEAL:0:3d/3d::After coarsening particle id 12 has first property 0.500000 and second property 0.500000
+DEAL:0:3d/3d::After coarsening particle id 13 has first property 0.500000 and second property 0.500000
+DEAL:0:3d/3d::After coarsening particle id 14 has first property 0.500000 and second property 0.500000
+DEAL:0:3d/3d::After coarsening particle id 18 has first property 1.00000 and second property 0.00000
+DEAL:0:3d/3d::After coarsening particle id 19 has first property 1.00000 and second property 0.00000
+DEAL:0:3d/3d::After coarsening particle id 20 has first property 1.00000 and second property 0.00000
+DEAL:0:3d/3d::After coarsening particle id 21 has first property 1.00000 and second property 0.500000
+DEAL:0:3d/3d::After coarsening particle id 22 has first property 1.00000 and second property 0.500000
+DEAL:0:3d/3d::After coarsening particle id 23 has first property 1.00000 and second property 0.500000
+DEAL:0:3d/3d::After coarsening particle id 6 has first property 0.00000 and second property 1.00000
+DEAL:0:3d/3d::After coarsening particle id 7 has first property 0.00000 and second property 1.00000
+DEAL:0:3d/3d::After coarsening particle id 8 has first property 0.00000 and second property 1.00000
+DEAL:0:3d/3d::After coarsening particle id 15 has first property 0.500000 and second property 1.00000
+DEAL:0:3d/3d::After coarsening particle id 16 has first property 0.500000 and second property 1.00000
+DEAL:0:3d/3d::After coarsening particle id 17 has first property 0.500000 and second property 1.00000
+DEAL:0:3d/3d::After coarsening particle id 24 has first property 1.00000 and second property 1.00000
+DEAL:0:3d/3d::After coarsening particle id 25 has first property 1.00000 and second property 1.00000
+DEAL:0:3d/3d::After coarsening particle id 26 has first property 1.00000 and second property 1.00000
+DEAL:0:3d/3d::OK

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.