]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Fixed data out according to comments
authorBruno Blais <blais.bruno@gmail.com>
Tue, 26 Nov 2019 22:05:00 +0000 (17:05 -0500)
committerBruno Blais <blais.bruno@gmail.com>
Tue, 26 Nov 2019 22:05:00 +0000 (17:05 -0500)
- Removed now useless comments
- Pruned out includes that were not needed
- Added documentation for constructor and destructor
- Removed useless line in the test documentation

include/deal.II/particles/data_out.h
source/particles/data_out.cc
tests/particles/data_out_01.cc

index 67ef100a04eb6f672ebba35b75528998be21fc35..39374a2544c0cf942025481cad39a54fdc203ac1 100644 (file)
 #ifndef dealii_particles_data_out_h
 #define dealii_particles_data_out_h
 
-#include <deal.II/base/array_view.h>
+#include <deal.II/base/config.h>
+
 #include <deal.II/base/data_out_base.h>
 #include <deal.II/base/mpi.h>
-#include <deal.II/base/smartpointer.h>
-#include <deal.II/base/subscriptor.h>
-
-#include <deal.II/distributed/tria.h>
 
-#include <deal.II/fe/mapping.h>
+#include <deal.II/particles/particle_handler.h>
 
-#include <deal.II/particles/particle.h>
-#include <deal.II/particles/particle_iterator.h>
-#include <deal.II/particles/property_pool.h>
+#include <string>
+#include <vector>
 
-#include <boost/range/iterator_range.hpp>
-#include <boost/serialization/map.hpp>
 
 DEAL_II_NAMESPACE_OPEN
 
-#ifdef DEAL_II_WITH_P4EST
-
 namespace Particles
 {
   /**
@@ -49,24 +41,28 @@ namespace Particles
    *
    * @author Bruno Blais, Luca Heltai 2019
    */
-
   template <int dim, int spacedim>
   class DataOut : public dealii::DataOutInterface<0, spacedim>
   {
   public:
+    /**
+     *Default constructor for the Particles::DataOut class.
+     */
     DataOut() = default;
 
+    /**
+     *Default destructor for the Particles::DataOut class.
+     */
     ~DataOut() = default;
 
 
     /**
-     * Build the particles for a given partcle handler
+     * Build the patches for a given particles handler.
      *
-     * @param [in] particle_handler A particle handler for which the patches will be build
-     * A dim=0 patch is build for each particle. The position of the particle is
+     * @param [in] particle_handler A particle handler for which the patches will be built
+     * A dim=0 patch is built for each particle. The position of the particle is
      * used to build the node position and the ID of the particle is added as a
-     * single data element
-     *
+     * single data element.
      *
      * @author Bruno Blais, Luca Heltai 2019
      */
@@ -80,9 +76,6 @@ namespace Particles
      */
     virtual const std::vector<DataOutBase::Patch<0, spacedim>> &
     get_patches() const override;
-    //    {
-    //      return patches;
-    //    }
 
     /**
      * Returns the name of the data sets associated with the patches. In the
@@ -90,9 +83,6 @@ namespace Particles
      */
     virtual std::vector<std::string>
     get_dataset_names() const override;
-    //    {
-    //      return dataset_names;
-    //    }
 
   private:
     std::vector<DataOutBase::Patch<0, spacedim>> patches;
@@ -105,8 +95,6 @@ namespace Particles
 
 } // namespace Particles
 
-#endif // DEAL_II_WITH_P4EST
-
 DEAL_II_NAMESPACE_CLOSE
 
 #endif
index 68b7e4ba081096c02a3a6537ad33e1ac29245c88..44a249a14dc52e330041b0fd666c11f8e71aedd6 100644 (file)
@@ -18,8 +18,6 @@
 
 DEAL_II_NAMESPACE_OPEN
 
-#ifdef DEAL_II_WITH_P4EST
-
 namespace Particles
 {
   template <int dim, int spacedim>
@@ -59,14 +57,10 @@ namespace Particles
 
 } // namespace Particles
 
-#endif // DEAL_II_WITH_P4EST
-
 DEAL_II_NAMESPACE_CLOSE
 
 DEAL_II_NAMESPACE_OPEN
 
-#ifdef DEAL_II_WITH_P4EST
-#  include "data_out.inst"
-#endif
+#include "data_out.inst"
 
 DEAL_II_NAMESPACE_CLOSE
index 027cff7dbe9b45e158beaa923f76a0f89d979f89..560f905e8b5196c725c9e3c49e97594fc3ba93d4 100644 (file)
@@ -43,8 +43,7 @@ test()
     tr.refine_global(2);
     MappingQ<dim, spacedim> mapping(1);
 
-    // both processes create a particle handler, but only the first creates
-    // particles
+    // Create a particle handler using two manually created particles
     Particles::ParticleHandler<dim, spacedim> particle_handler(tr, mapping);
     std::vector<Point<spacedim>>              position(2);
     std::vector<Point<dim>>                   reference_position(2);
@@ -72,13 +71,9 @@ test()
     particle_handler.insert_particle(particle1, cell1);
     particle_handler.insert_particle(particle2, cell2);
 
-    Particles::DataOut<dim, spacedim> particle_viz;
-    particle_viz.build_patches(particle_handler);
-    particle_viz.write_gnuplot(deallog.get_file_stream());
-
-    //    for (const auto &particle : particle_handler)
-    //      deallog << "Particle id " << particle.get_id() << " is in cell "
-    //              << particle.get_surrounding_cell(tr) << std::endl;
+    Particles::DataOut<dim, spacedim> particle_output;
+    particle_output.build_patches(particle_handler);
+    particle_output.write_gnuplot(deallog.get_file_stream());
   }
 
   deallog << "OK" << std::endl;

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.