ExcNeedsExodusII,
"You are attempting to use functionality that is only available if deal.II "
"was configured to use Trilinos' SEACAS library (which provides ExodusII), "
- "but cmake did not find find a valid SEACAS library.");
+ "but cmake did not find a valid SEACAS library.");
#ifdef DEAL_II_WITH_MPI
/**
const unsigned int fe_index_,
const bool count_level_dofs)
{
- // note: we cannot rely on the the template parameter level_dof_access
- // here, since the function get_mg_dof_indices()/set_mg_dof_indices()
- // can be called even if level_dof_access==false.
+ // note: we cannot rely on the template parameter level_dof_access here,
+ // since the function get_mg_dof_indices()/set_mg_dof_indices() can be
+ // called even if level_dof_access==false.
if (count_level_dofs)
{
const auto &fe = accessor.get_fe(fe_index_);
const DoFOperation &dof_operation,
const bool count_level_dofs)
{
- // we cannot rely on the the template parameter level_dof_access
- // here, since the function get_mg_dof_indices()/set_mg_dof_indices()
- // can be called even if level_dof_access==false.
+ // we cannot rely on the template parameter level_dof_access here, since
+ // the function get_mg_dof_indices()/set_mg_dof_indices() can be called
+ // even if level_dof_access==false.
(void)count_level_dofs;
AssertIndexRange(n_dof_indices(accessor, fe_index, count_level_dofs),
* dof_index / n</code> (integer division). The indices <code>i</code> and
* <code>j</code> can then be used to compute the offset.
*
- * For our example of Raviart-Thomas elements this means if if the
+ * For our example of Raviart-Thomas elements this means if the
* switches are <code>(true | true | true)</code> that means we rotate the
* face first by + 90 degree(counterclockwise) then by another +180
* degrees but we do not flip it since the face has standard
*
* @p con_cf connectivity cell-face
* @p con_cc connectivity cell-cell (for each cell-face it contains the
- * the index of the neighboring cell or -1 for boundary face)
+ * index of the neighboring cell or -1 for boundary face)
*/
template <typename T>
void
/**
* Construct and store in this object the sparsity pattern corresponding to
- * the product of transposed @p left and and non-transpose @p right sparsity pattern.
+ * the product of transposed @p left and non-transpose @p right sparsity pattern.
*/
template <typename SparsityPatternTypeLeft, typename SparsityPatternTypeRight>
void
* (including the MPI data exchange), allowing to execute some vector update
* that the `src` vector depends upon. The `operation_after_loop` is similar
* - it starts to execute on a range of DoFs once all DoFs in that range
- * have been touched for the last time time by the `cell_operation`
+ * have been touched for the last time by the `cell_operation`
* (including the MPI data exchange), allowing e.g. to compute some vector
* operations that depend on the result of the current cell loop in `dst` or
* want to modify `src`. The efficiency of caching depends on the numbering
if (reference_cell != temp.first)
{
// TODO: this might happen if the quadrature rule and the
- // the FE do not match
+ // FE do not match
this->n_q_points_face = 0;
}
else
// (C_e^T(j,:) * A_e(:,i)) * C_e(i,j)
// or
// (C_e^T(j,:) * A_e(:,i)) * C_e^T(j,i)
- // This gives a contribution the the j-th entry of the
+ // This gives a contribution the j-th entry of the
// locally-relevant diagonal and comprises the multiplication
// by the locally-relevant constraint matrix from the left and
// the right. There is no contribution to the j-th vector
* Like the above function but also taking @p mapping as argument.
* This will introduce an additional approximation between the true geometry
* specified by the manifold if the degree of the mapping is lower than the
- * degree of the finite finite element in the DoFHandler @p dh, but more
+ * degree of the finite element in the DoFHandler @p dh, but more
* importantly it allows to fill location vectors for mappings that do not
* preserve vertex locations (like Eulerian mappings).
*/
/**
* Temporary storage that holds the data of the particles to receive
* the ghost particles information from other processors in
- * in update_ghost_particles()
+ * update_ghost_particles()
* send_recv_particles_properties_and_location()
*/
std::vector<char> recv_data;