* filled, which reflects the block structure of the degrees of
* freedom.
*
- * BlockInfo consists of deveral BlockIndices objects. The member
+ * BlockInfo consists of several BlockIndices objects. The member
* global() reflects the block structure of the system on the active
* cell level, usually referred to as the global system. As soon as
* DoFHandler::distribute_dofs() has been called, the function
* behavior of the MeshWorker::Assembler classes relying on
* BlockInfo. They must be initialized by hand through initialize_local().
*
+ * <h3>Usage</h3>
+ *
+ * The most common usage for this object is initializing vectors as in
+ * the following code:
+ *
+ * <code>
+ * MGDofHandler<dim> dof_handler(triangulation);
+ * dof_handler.distribute_dofs(fesystem);
+ * DoFRenumbering::block_wise(dof_handler);
+ *
+ * BlockVector<double> solution(dof_handler.block_info().global());
+ *
+ * MGLevelObject<BlockVector<double> > mg_vector(0, triangulation.n_levels()-1);
+ * for (unsigned int i=0;i<triangulation.n_levels();++i)
+ * mg_vector[i].reinit(dof_handler.block_info().level(i));
+ *</code>
+ * In this example, <tt>solution</tt> obtains the block structure needed to
+ * represent a finite element function on the DoFHandler. Similarly,
+ * all levels of <tt>mg_vector</tt> will have the block structure
+ * needed on that level.
+ *
* @todo Extend the functions local() and renumber() to the concept to
* hpDoFHandler.
*
+ * @ingroup dofs
* @author Guido Kanschat, 2009
*/
class BlockInfo : public Subscriptor
// $Id$
// Version: $Name$
//
-// Copyright (C) 2006, 2007, 2008 by the deal.II authors
+// Copyright (C) 2006, 2007, 2008, 2010 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
* setter functions. Knowledge of the actual data format is therefore encapsulated to the
* present hierarchy of classes as well as the dealii::DoFHandler class.
*
- * @ingroup dofs
* @author Tobias Leicht, 2006
*/
template<int dim>
* Store the indices of degrees of freedom on faces in 1D. As these would be vertices, which
* are treted seperately, don't do anything.
*
- * @ingroup dofs
* @author Tobias Leicht, 2006
*/
template<>
/**
* Store the indices of degrees of freedom on faces in 2D, which are lines.
*
- * @ingroup dofs
* @author Tobias Leicht, 2006
*/
template<>
/**
* Store the indices of degrees of freedom on faces in 3D, which are quads, additionaly also on lines.
*
- * @ingroup dofs
* @author Tobias Leicht, 2006
*/
template<>
// $Id$
// Version: $Name$
//
-// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2008 by the deal.II authors
+// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2008, 2010 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
* encapsulated to the present hierarchy of classes as well as the
* dealii::DoFHandler class.
*
- * @ingroup dofs
* @author Wolfgang Bangerth, 1998, 2006
*/
template <int N>
* Store the indices of the degrees of freedom which are located on
* lines. See the general template DoFLevel for more information.
*
- * @ingroup dofs
* @author Wolfgang Bangerth, 1998, 2006
*/
template <>
* Store the indices of the degrees of freedom which are located on
* quads. See the general template DoFLevel for more information.
*
- * @ingroup dofs
* @author Wolfgang Bangerth, 1998, 2006
*/
template <>
* Store the indices of the degrees of freedom which are located on
* hexhedra. See the general template DoFLevel for more information.
*
- * @ingroup dofs
* @author Wolfgang Bangerth, 1998, 2006
*/
template <>
{
namespace MGDoFHandler
{
-/*!@addtogroup mg */
-/*@{*/
-
template <int dim, int spacedim>
class Iterators;