From d3f237fc22c678489ff56900dc534b653642c2b6 Mon Sep 17 00:00:00 2001 From: Luca Heltai Date: Tue, 5 May 2020 17:10:01 +0200 Subject: [PATCH] Apply suggestions from code review Co-authored-by: Daniel Arndt --- include/deal.II/particles/utilities.h | 6 +++--- source/particles/utilities.cc | 3 +-- 2 files changed, 4 insertions(+), 5 deletions(-) diff --git a/include/deal.II/particles/utilities.h b/include/deal.II/particles/utilities.h index da9acdfb28..d4bae7beda 100644 --- a/include/deal.II/particles/utilities.h +++ b/include/deal.II/particles/utilities.h @@ -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 diff --git a/source/particles/utilities.cc b/source/particles/utilities.cc index 0f75650b12..2493aa9c91 100644 --- a/source/particles/utilities.cc +++ b/source/particles/utilities.cc @@ -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) : -- 2.39.5