* DoFHandler::begin_active()) and <tt>typedefs</tt> (such as
* DoFHandler::active_cell_iterator) for managing collections of cells.
*
- * Triangulation&nnbsp;s, DoFHandler&nnbsp;s, and hp::DoFHandler&nnbsp;s may
- * all be considered as containers of cells. In fact, the most important parts
+ * Triangulation, DoFHandler, and hp::DoFHandler may
+ * all be considered as a container of cells. In fact, the most important parts
* of the public interface of these classes consists simply of the ability to
* get iterators to their elements. Since these parts of the interface are
* generic, i.e., the functions have the same name in all classes, it is
(Alberto Sartori, 2015/09/04, David Wells, 2016/01/18-2016/01/28)
</li>
- <li> New: There is now a function SparsityPattern::print_svg() which prints the sparsity of the matrix
- in a .svg file which can be opened in a web browser.
+ <li> New: There is now a function SparsityPattern::print_svg() which prints
+ the sparsity of the matrix in a .svg file which can be opened in a web
+ browser.
<br>
(Conrad Clevenger, 2015/09/03)
</li>
(Wolfgang Bangerth, 2015/09/02)
</li>
- <li> New: introduced hp::FECollection::find_least_face_dominating_fe(const std::set<unsigned int> &fes)
- which aims to find the least dominating finite element w.r.t. those provided
- as fe_indices in @p fes.
+ <li> New: introduced hp::FECollection::find_least_face_dominating_fe(const
+ std::set<unsigned int> &fes) which aims to find the least dominating finite
+ element w.r.t. those provided as fe_indices in @p fes.
<br>
(Denis Davydov, Wolfgang Bangerth, 2015/08/31)
</li>
* processor. Note that this includes the ones that this subdomain "owns"
* (i.e. the ones for which get_subdomain_association() returns a value
* equal to the subdomain given here and that are selected by the
- * extract_locally_owned() function) but also all of those that sit on the
+ * extract_locally_owned_dofs() function) but also all of those that sit on the
* boundary between the given subdomain and other subdomain. In essence,
* degrees of freedom that sit on boundaries between subdomain will be in
* the index sets returned by this function for more than one subdomain.
* @param colorize Assign different boundary ids if set to true.
*
* @note Implemented for all combinations of @p dim and @p spacedim.
+ *
+ * @note You likely need to help the compiler by explicitly specifying the
+ * two template parameters when calling this function.
*/
template <int dim, int spacedim>
void
* adjacent cells that are returned. However, it will always be either a
* vertex of a cell or be a hanging node located on a face or an edge of it.
*
- * @param mesh A variable of a type that satisfies the requirements of
+ * @param container A variable of a type that satisfies the requirements of
* the @ref ConceptMeshType "MeshType concept".
* @param vertex_index The index of the vertex for which we try to find
* adjacent cells.
* of <code>Container</code> from the function call. You need to
* specify it as an explicit template argument following the
* function name. This type has to satisfy the requirements of a
- * mesh container (see @ref GlossMeshAsAContainer).
+ * mesh container (see @ref ConceptMeshType).
*
* @param[in] patch_cells A vector of active cells for which
* this function finds the parents at the coarsest common
* of <code>Container</code> from the function call. You need to
* specify it as an explicit template argument following the
* function name. This type that satisfies the requirements of a
- * mesh container (see @ref GlossMeshAsAContainer).
+ * mesh container (see @ref ConceptMeshType).
*
* @param[in] patch A vector of active cells from a common triangulation.
* These cells may or may not all be at the same refinement level.