// ---------------------------------------------------------------------
//
-// 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.
//
/**
* 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
// ---------------------------------------------------------------------
//
-// 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.
//
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) :