/**
* Same as the previous function, except that it uses two (possibly) different
- * index sets to correctly handle inhomogeneties when the local matrix is
+ * index sets to correctly handle inhomogeneities when the local matrix is
* computed from a combination of two neighboring elements, for example for an
* edge integral term in DG. Note that in the case that these two elements have
* different polynomial degree, the local matrix is rectangular.
*
- * <tt>local_dof_indices_row<tt> is the set of row indices and
- * <tt>local_dof_indices_col<tt> is the set of column indices of the local matrix.
- * <tt>diagonal=false<tt> says whether the two index sets are equal or not.
+ * <tt>local_dof_indices_row</tt> is the set of row indices and
+ * <tt>local_dof_indices_col</tt> is the set of column indices of the local matrix.
+ * <tt>diagonal=false</tt> says whether the two index sets are equal or not.
*
- * If both index sets are equal, <tt>diagonal<tt> must be set to true or we
+ * If both index sets are equal, <tt>diagonal</tt> must be set to true or we
* simply use the previous function. If both index sets are different (diagonal=false)
- * the <tt>global_vector<tt> is modified to handle inhomogeneties but no
- * entries from <tt>local_vector<tt> are added. Note that the edge integrals for inner
+ * the <tt>global_vector</tt> is modified to handle inhomogeneities but no
+ * entries from <tt>local_vector</tt> are added. Note that the edge integrals for inner
* edged for DG do not contribute any values to the right hand side.
*/
template <typename VectorType, typename LocalType>
// diagonal checks if we have only one index set (if both are equal
// diagonal should be set to true).
- // If true we do both, assemply of the right hand side (next lines)
+ // If true we do both, assembly of the right hand side (next lines)
// and (see further below) modifications of the right hand side
// according to the inhomogeneous constraints.
// Otherwise we only modify the right hand side according to
- // local_matrix and the inhomogeneos constraints, and omit the vector add.
+ // local_matrix and the inhomogeneous constraints, and omit the vector add.
const size_type m_local_dofs = local_dof_indices_row.size();
const size_type n_local_dofs = local_dof_indices_col.size();
* structure in DoFInfo is being used.
*
* Store information on the local block structure. If the assembler is
- * inititialized with this function, initialize_info() will generate one
+ * initialized with this function, initialize_info() will generate one
* local matrix for each block row and column, which will be numbered
* lexicographically, row by row.
*
- * In spite of using local block structure, all blocks will be enteres
+ * In spite of using local block structure, all blocks will be entered
* into the same global matrix, disregarding any global block structure.
*/
const DOFINFO &info2);
protected:
/**
- * The global residal vectors filled by assemble().
+ * The global residual vectors filled by assemble().
*/
AnyData residuals;
for (unsigned int k=0; k<i2.size(); ++k)
if (std::fabs(M(j,k)) >= threshold)
// Enter values into matrix only if j corresponds to a
- // degree of freedom on the refinemenent edge, k does
+ // degree of freedom on the refinement edge, k does
// not, and both are not on the boundary. This is part
// the difference between the complete matrix with no
// boundary condition at the refinement edge and and