]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Apply suggestions from code review
authorLuca Heltai <luca.heltai@sissa.it>
Tue, 5 May 2020 15:10:01 +0000 (17:10 +0200)
committerGitHub <noreply@github.com>
Tue, 5 May 2020 15:10:01 +0000 (17:10 +0200)
Co-authored-by: Daniel Arndt <arndtd@ornl.gov>
include/deal.II/particles/utilities.h
source/particles/utilities.cc

index da9acdfb2845945ec9bc12d7f878e925e7b15af5..d4bae7bedaad1cb9e84f0729d0fcfdd17cd234bf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -49,12 +49,12 @@ namespace Particles
     /**
      * Create an interpolation sparsity pattern for particles.
      *
-     * Given a triangulation representing the domains $\Omega$, a particle
+     * Given a triangulation representing the domain $\Omega$, a particle
      * handler of particles in $\Omega$, and a scalar finite element space
      * $V(\Omega) = \text{span}\{v_j\}_{j=0}^n$, compute the sparsity pattern
      * that would be necessary to assemble the matrix
      * \f[
-     * M_{ij} \dealcoloneq v_j(x_i) ,
+     * M_{i,j} \dealcoloneq v_j(x_i) ,
      * \f]
      * where $V(\Omega)$ is the finite element space associated with the
      * `space_dh`, and the index `i` is given by the particle id whose position
index 0f75650b12f1c0eee80ba84e258d360256d456e1..2493aa9c91e2a0eb86995a1c2f2b751ba9c2fe72 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -44,7 +44,6 @@ namespace Particles
       const auto  max_particles_per_cell =
         particle_handler.n_global_max_particles_per_cell();
 
-
       // Take care of components
       const ComponentMask comps =
         (space_comps.size() == 0 ? ComponentMask(fe.n_components(), true) :

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.