const ComponentMask &space_comps = ComponentMask());
/**
- * Interpolate a field to the position of the particles of a
- * particle_handler
- *
- * Given a DoFHandler and a ParticleHandler, interpolates a vector field
+ * Given a DoFHandler and a ParticleHandler, interpolate a vector field
* at the position of the particles. The result is stored in an output
* vector whose size corresponds to the number of locally owned particles *
* number of active components
*
* @param[in,out] interpolated_field The interpolated value of the field at
* the position of the particles. The size of the vector must be
- * n_locally_owned_particles * n_components
+ * n_locally_owned_particles times the n_components
*
* @param[in] field_comps An optional component mask that decides which
* subset of the vector fields are interpolated
#include <deal.II/dofs/dof_tools.h>
#include <deal.II/fe/fe_q.h>
-#include <deal.II/fe/fe_system.h>
#include <deal.II/grid/grid_generator.h>
-#include <deal.II/lac/dynamic_sparsity_pattern.h>
-#include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/sparsity_pattern.h>
-#include <deal.II/lac/sparsity_tools.h>
-#include <deal.II/lac/trilinos_sparse_matrix.h>
-#include <deal.II/lac/trilinos_sparsity_pattern.h>
+#include <deal.II/lac/trilinos_vector.h>
#include <deal.II/numerics/vector_tools.h>