From: Timo Heister Date: Wed, 14 Jan 2015 18:18:25 +0000 (-0500) Subject: wrapcomments X-Git-Tag: v8.3.0-rc1~539^2 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=refs%2Fpull%2F443%2Fhead;p=dealii.git wrapcomments --- diff --git a/include/deal.II/dofs/dof_handler.h b/include/deal.II/dofs/dof_handler.h index 2f1b392e26..f9dafbee2f 100644 --- a/include/deal.II/dofs/dof_handler.h +++ b/include/deal.II/dofs/dof_handler.h @@ -725,10 +725,10 @@ public: * * At the end of distribute_dofs(), the number of degrees of freedom in each * block is counted, and stored in a BlockInfo object, which can be accessed - * here. If you have previously called distribute_mg_dofs(), - * the same is done on each level of the multigrid hierarchy. Additionally, - * the block structure on each cell can be generated in this object by - * calling initialize_local_block_info(). + * here. If you have previously called distribute_mg_dofs(), the same is + * done on each level of the multigrid hierarchy. Additionally, the block + * structure on each cell can be generated in this object by calling + * initialize_local_block_info(). */ const BlockInfo &block_info() const; diff --git a/include/deal.II/dofs/dof_objects.h b/include/deal.II/dofs/dof_objects.h index 7fd4b1420c..0ca9e6600d 100644 --- a/include/deal.II/dofs/dof_objects.h +++ b/include/deal.II/dofs/dof_objects.h @@ -142,8 +142,8 @@ namespace internal const unsigned int version); /** - * Declare the classes that store levels and faces of DoFs - * friends so that they can resize arrays. + * Declare the classes that store levels and faces of DoFs friends so + * that they can resize arrays. */ template friend class DoFLevel; template friend class DoFFaces; diff --git a/include/deal.II/dofs/dof_renumbering.h b/include/deal.II/dofs/dof_renumbering.h index c7c1836b0f..2a8b0c8791 100644 --- a/include/deal.II/dofs/dof_renumbering.h +++ b/include/deal.II/dofs/dof_renumbering.h @@ -925,8 +925,8 @@ namespace DoFRenumbering /** * This function computes the renumbering vector on each level needed by the * sort_selected_dofs_back() function. Does not perform the renumbering on - * the DoFHandler dofs but only computes the renumbering and returns - * the renumbering vector. + * the DoFHandler dofs but only computes the renumbering and returns the + * renumbering vector. * * @pre The @p selected_dofs array must have as many elements as the @p * dof_handler has degrees of freedom on the given level. diff --git a/include/deal.II/grid/grid_tools.h b/include/deal.II/grid/grid_tools.h index 5946c65fed..6c458a0401 100644 --- a/include/deal.II/grid/grid_tools.h +++ b/include/deal.II/grid/grid_tools.h @@ -707,11 +707,11 @@ namespace GridTools /** * Given two mesh containers (i.e. objects of type Triangulation, - * DoFHandler, or hp::DoFHandler) that are based on the same - * coarse mesh, this function figures out a set of cells that are matched - * between the two meshes and where at most one of the meshes is more - * refined on this cell. In other words, it finds the smallest cells that - * are common to both meshes, and that together completely cover the domain. + * DoFHandler, or hp::DoFHandler) that are based on the same coarse mesh, + * this function figures out a set of cells that are matched between the two + * meshes and where at most one of the meshes is more refined on this cell. + * In other words, it finds the smallest cells that are common to both + * meshes, and that together completely cover the domain. * * This function is useful, for example, in time-dependent or nonlinear * application, where one has to integrate a solution defined on one mesh @@ -756,8 +756,8 @@ namespace GridTools /** * The same function as above, but working on arguments of type DoFHandler, - * or hp::DoFHandler. This function is provided to allow - * calling have_same_coarse_mesh for all types of containers representing + * or hp::DoFHandler. This function is provided to allow calling + * have_same_coarse_mesh for all types of containers representing * triangulations or the classes built on triangulations. * * @tparam Container A type that satisfies the requirements of a mesh @@ -1152,20 +1152,19 @@ namespace GridTools /*@{*/ /** - * Copy boundary ids to manifold ids. The default manifold_id for - * new Triangulation objects is numbers::invalid_manifold_id. This - * function copies the boundary_ids of the boundary faces to the - * manifold_ids of the same faces, allowing the user to change the - * boundary_ids and use them for boundary conditions regardless of - * the geometry, which will use manifold_ids to create new - * points. Only active cells will be iterated over. This is a - * function you'd typically call when there is only one active level - * on your Triangulation. - * - * The optional parameter @p reset_boundary_ids, indicates wether - * this function should reset the boundary_ids of the Triangulation - * to its default value 0 after copying its value to the - * manifold_id. By default, boundary_ids are left untouched. + * Copy boundary ids to manifold ids. The default manifold_id for new + * Triangulation objects is numbers::invalid_manifold_id. This function + * copies the boundary_ids of the boundary faces to the manifold_ids of the + * same faces, allowing the user to change the boundary_ids and use them for + * boundary conditions regardless of the geometry, which will use + * manifold_ids to create new points. Only active cells will be iterated + * over. This is a function you'd typically call when there is only one + * active level on your Triangulation. + * + * The optional parameter @p reset_boundary_ids, indicates wether this + * function should reset the boundary_ids of the Triangulation to its + * default value 0 after copying its value to the manifold_id. By default, + * boundary_ids are left untouched. * * @ingroup manifold * @ingroup boundary @@ -1177,33 +1176,31 @@ namespace GridTools const bool reset_boundary_ids=false); /** - * Copy material ids to manifold ids. The default manifold_id for - * new Triangulation objects is numbers::invalid_manifold_id. When - * refinements occurs, the Triangulation asks where to locate new - * points to the underlying manifold. - * - * When reading a Triangulation from a supported input format, - * typical informations that can be stored in a file are boundary - * conditions for boundary faces (which we store in the boundary_id - * of the faces), material types for cells (which we store in the - * material_id of the cells) and in some cases subdomain ids for - * cells (which we store in the subdomain_id of the cell). - * - * If you read one of these grids into a Triangulation, you might - * still want to use the material_id specified in the input file as - * a manifold_id description. In this case you can associate a - * Manifold object to internal cells, and this object will be used - * by the Triangulation to query Manifold objects for new - * points. This function iterates over active cells and copies the - * material_ids to the manifold_ids. + * Copy material ids to manifold ids. The default manifold_id for new + * Triangulation objects is numbers::invalid_manifold_id. When refinements + * occurs, the Triangulation asks where to locate new points to the + * underlying manifold. + * + * When reading a Triangulation from a supported input format, typical + * informations that can be stored in a file are boundary conditions for + * boundary faces (which we store in the boundary_id of the faces), material + * types for cells (which we store in the material_id of the cells) and in + * some cases subdomain ids for cells (which we store in the subdomain_id of + * the cell). + * + * If you read one of these grids into a Triangulation, you might still want + * to use the material_id specified in the input file as a manifold_id + * description. In this case you can associate a Manifold object to internal + * cells, and this object will be used by the Triangulation to query + * Manifold objects for new points. This function iterates over active cells + * and copies the material_ids to the manifold_ids. * * The optional parameter @p compute_face_ids, indicates wether this - * function should also set the manifold_ids of the faces (both for - * internal faces and for faces on the boundary). If set to true, - * then each face will get a manifold_id equal to the minimum of the - * surrounding manifold_ids, ensuring that a unique manifold id is - * selected for each face of the Triangulation. By default, face - * manifold_ids are not computed. + * function should also set the manifold_ids of the faces (both for internal + * faces and for faces on the boundary). If set to true, then each face will + * get a manifold_id equal to the minimum of the surrounding manifold_ids, + * ensuring that a unique manifold id is selected for each face of the + * Triangulation. By default, face manifold_ids are not computed. * * @ingroup manifold * diff --git a/include/deal.II/grid/intergrid_map.h b/include/deal.II/grid/intergrid_map.h index 948487c885..76986ecebf 100644 --- a/include/deal.II/grid/intergrid_map.h +++ b/include/deal.II/grid/intergrid_map.h @@ -68,14 +68,13 @@ DEAL_II_NAMESPACE_OPEN * * The implementation of this class is such that not only cell iterators into * triangulations can be mapped, but also iterators into objects of type - * DoFHandler or hp::DoFHandler. The extension to other classes - * offering iterator functions and some minor additional requirements is - * simple. + * DoFHandler or hp::DoFHandler. The extension to other classes offering + * iterator functions and some minor additional requirements is simple. * * Note that this class could in principle be based on the C++ - * std::map data type. Instead, it uses another data format - * which is more effective both in terms of computing time for access as well - * as with regard to memory consumpion. + * std::map data type. Instead, it uses another data + * format which is more effective both in terms of computing time for access + * as well as with regard to memory consumpion. * * *

Usage

diff --git a/include/deal.II/grid/tria_iterator.h b/include/deal.II/grid/tria_iterator.h index c8fae28017..4036909527 100644 --- a/include/deal.II/grid/tria_iterator.h +++ b/include/deal.II/grid/tria_iterator.h @@ -161,8 +161,8 @@ template class TriaActiveIterator; * but you may write your own version (non-virtual, since we use templates) to * add functionality. * - * The accessors provided by the library consists of two groups, - * determined by whether they access the data of Triangulation objects or + * The accessors provided by the library consists of two groups, determined by + * whether they access the data of Triangulation objects or * DoFHandler/hp::DoFHandler objects. They are derived from TriaAccessor and * DoFAccessor, respectively. Each group also has specialized accessors for * cells (as opposed to faces and lines) that offer more functionality such as diff --git a/include/deal.II/lac/parallel_vector.h b/include/deal.II/lac/parallel_vector.h index 1d9c472316..a657fa6e5f 100644 --- a/include/deal.II/lac/parallel_vector.h +++ b/include/deal.II/lac/parallel_vector.h @@ -73,47 +73,45 @@ namespace parallel * The vector is designed for the following scheme of parallel * partitioning: *
    - *
  • The indices held by individual processes - * (locally owned part) in the MPI parallelization form a contiguous range + *
  • The indices held by individual processes (locally owned part) in + * the MPI parallelization form a contiguous range * [my_first_index,my_last_index). - *
  • Ghost indices - * residing on arbitrary positions of other processors are allowed. It is - * in general more efficient if ghost indices are clustered, since they - * are stored as a set of intervals. The communication pattern of the - * ghost indices is determined when calling the function reinit - * (locally_owned, ghost_indices, communicator), and retained until - * the partitioning is changed. This allows for efficient parallel - * communication of indices. In particular, it stores the communication - * pattern, rather than having to compute it again for every - * communication. For more information on ghost vectors, see also the + *
  • Ghost indices residing on arbitrary positions of other processors + * are allowed. It is in general more efficient if ghost indices are + * clustered, since they are stored as a set of intervals. The + * communication pattern of the ghost indices is determined when calling + * the function reinit (locally_owned, ghost_indices, + * communicator), and retained until the partitioning is changed. + * This allows for efficient parallel communication of indices. In + * particular, it stores the communication pattern, rather than having to + * compute it again for every communication. For more information on ghost + * vectors, see also the * @ref GlossGhostedVector "glossary entry on vectors with ghost elements". - *
  • Besides the usual global access operator() it is also - * possible to access vector entries in the local index space with the - * function @p local_element(). Locally owned indices are placed first, - * [0, local_size()), and then all ghost indices follow after them + *
  • Besides the usual global access operator() it is also possible to + * access vector entries in the local index space with the function @p + * local_element(). Locally owned indices are placed first, [0, + * local_size()), and then all ghost indices follow after them * contiguously, [local_size(), local_size()+n_ghost_entries()). *
* * Functions related to parallel functionality: *
    - *
  • The function - * compress() goes through the data associated with ghost - * indices and communicates it to the owner process, which can then add it - * to the correct position. This can be used e.g. after having run an - * assembly routine involving ghosts that fill this vector. Note that the - * @p insert mode of @p compress() does not set the elements included in - * ghost entries but simply discards them, assuming that the owning - * processor has set them to the desired value already (See also the + *
  • The function compress() goes through the data + * associated with ghost indices and communicates it to the owner process, + * which can then add it to the correct position. This can be used e.g. + * after having run an assembly routine involving ghosts that fill this + * vector. Note that the @p insert mode of @p compress() does not set the + * elements included in ghost entries but simply discards them, assuming + * that the owning processor has set them to the desired value already + * (See also the * @ref GlossCompress "glossary entry on compress"). - *
  • The - * update_ghost_values() function imports the data from the - * owning processor to the ghost indices in order to provide read access - * to the data associated with ghosts. - *
  • It is possible to split the - * above functions into two phases, where the first initiates the - * communication and the second one finishes it. These functions can be - * used to overlap communication with computations in other parts of the - * code. + *
  • The update_ghost_values() function imports the data + * from the owning processor to the ghost indices in order to provide read + * access to the data associated with ghosts. + *
  • It is possible to split the above functions into two phases, where + * the first initiates the communication and the second one finishes it. + * These functions can be used to overlap communication with computations + * in other parts of the code. *
  • Of course, reduction operations (like norms) make use of * collective all-to-all MPI communications. *
@@ -121,9 +119,9 @@ namespace parallel * This vector can take two different states with respect to ghost * elements: *
    - *
  • After creation and whenever zero_out_ghosts() is - * called (or operator= (0.)), the vector does only allow - * writing into ghost elements but not reading from ghost elements. + *
  • After creation and whenever zero_out_ghosts() is called (or + * operator= (0.)), the vector does only allow writing into + * ghost elements but not reading from ghost elements. *
  • After a call to update_ghost_values(), the vector does not allow * writing into ghost elements but only reading from them. This is to * avoid undesired ghost data artifacts when calling compress() after diff --git a/include/deal.II/lac/petsc_parallel_sparse_matrix.h b/include/deal.II/lac/petsc_parallel_sparse_matrix.h index 8830fc8338..c7a14049d5 100644 --- a/include/deal.II/lac/petsc_parallel_sparse_matrix.h +++ b/include/deal.II/lac/petsc_parallel_sparse_matrix.h @@ -326,8 +326,9 @@ namespace PETScWrappers const MPI_Comm &communicator); /** - * Initialize this matrix to have the same structure as @p other. This will not copy - * the values of the other matrix, but you can use copy_from() for this. + * Initialize this matrix to have the same structure as @p other. This + * will not copy the values of the other matrix, but you can use + * copy_from() for this. */ void reinit (const SparseMatrix &other); diff --git a/include/deal.II/lac/relaxation_block.h b/include/deal.II/lac/relaxation_block.h index 939fb09bb0..b2a2c071f6 100644 --- a/include/deal.II/lac/relaxation_block.h +++ b/include/deal.II/lac/relaxation_block.h @@ -220,10 +220,10 @@ protected: * * This class implements the step() and Tstep() functions expected by * SolverRelaxation and MGSmootherRelaxation. They perform an additive Schwarz - * method on the blocks provided in the block list of AdditionalData. Differing - * from PreconditionBlockJacobi, these blocks may be of varying size, non- - * contiguous, and overlapping. On the other hand, this class does not - * implement the preconditioner interface expected by Solver objects. + * method on the blocks provided in the block list of AdditionalData. + * Differing from PreconditionBlockJacobi, these blocks may be of varying + * size, non- contiguous, and overlapping. On the other hand, this class does + * not implement the preconditioner interface expected by Solver objects. * * @ingroup Preconditioners * @author Guido Kanschat @@ -383,9 +383,9 @@ public: * * This class implements the step() and Tstep() functions expected by * SolverRelaxation and MGSmootherRelaxation. They perform a multiplicative - * Schwarz method on the blocks provided in the block list of AdditionalData in - * symmetric fashion. Differing from PreconditionBlockSSOR, these blocks may - * be of varying size, non-contiguous, and overlapping. On the other hand, + * Schwarz method on the blocks provided in the block list of AdditionalData + * in symmetric fashion. Differing from PreconditionBlockSSOR, these blocks + * may be of varying size, non-contiguous, and overlapping. On the other hand, * this class does not implement the preconditioner interface expected by * Solver objects. * diff --git a/include/deal.II/lac/solver_control.h b/include/deal.II/lac/solver_control.h index b7f64bd13d..f8d6c58bcb 100644 --- a/include/deal.II/lac/solver_control.h +++ b/include/deal.II/lac/solver_control.h @@ -179,8 +179,8 @@ public: * value (@p NaN). Note, however, that this check is only performed if the * @p isnan function is provided by the operating system, which is not * always true. The @p configure scripts checks for this and sets the flag - * @p DEAL_II_HAVE_ISNAN in the include file - * deal.II/base/config.h if this function was found. + * @p DEAL_II_HAVE_ISNAN in the include file deal.II/base/config.h + * if this function was found. * * check() additionally preserves @p step and @p check_value. These * values are accessible by last_value() and last_step(). diff --git a/include/deal.II/lac/trilinos_sparse_matrix.h b/include/deal.II/lac/trilinos_sparse_matrix.h index 3fc27d1e6c..aefbecc70d 100644 --- a/include/deal.II/lac/trilinos_sparse_matrix.h +++ b/include/deal.II/lac/trilinos_sparse_matrix.h @@ -599,9 +599,9 @@ namespace TrilinosWrappers void reinit (const SparsityPattern &sparsity_pattern); /** - * This function copies the layout of @p sparse_matrix to the - * calling matrix. The values are not copied, but you can use - * copy_from() for this. + * This function copies the layout of @p sparse_matrix to the calling + * matrix. The values are not copied, but you can use copy_from() for + * this. * * This is a collective operation that needs to be called on all * processors in order to avoid a dead lock. diff --git a/include/deal.II/meshworker/dof_info.h b/include/deal.II/meshworker/dof_info.h index 6bc11b4378..6316eb80d5 100644 --- a/include/deal.II/meshworker/dof_info.h +++ b/include/deal.II/meshworker/dof_info.h @@ -77,16 +77,16 @@ namespace MeshWorker /** * The number of the current face on the current cell. * - * This number is numbers::invalid_unsigned_int if the info object - * was initialized with a cell. + * This number is numbers::invalid_unsigned_int if the info object was + * initialized with a cell. */ unsigned int face_number; /** * The number of the current subface on the current face * - * This number is numbers::invalid_unsigned_int if the info object - * was not initialized with a subface. + * This number is numbers::invalid_unsigned_int if the info object was not + * initialized with a subface. */ unsigned int sub_number; diff --git a/include/deal.II/multigrid/mg_smoother.h b/include/deal.II/multigrid/mg_smoother.h index 87b5da9ee1..ee925555d0 100644 --- a/include/deal.II/multigrid/mg_smoother.h +++ b/include/deal.II/multigrid/mg_smoother.h @@ -85,9 +85,8 @@ protected: /** * A memory object to be used for temporary vectors. * - * The object is marked as mutable since we will need to use it - * to allocate temporary vectors also in functions that are - * const. + * The object is marked as mutable since we will need to use it to allocate + * temporary vectors also in functions that are const. */ mutable GrowingVectorMemory vector_memory; diff --git a/include/deal.II/numerics/data_postprocessor.h b/include/deal.II/numerics/data_postprocessor.h index 5d609e0e3d..836c90d932 100644 --- a/include/deal.II/numerics/data_postprocessor.h +++ b/include/deal.II/numerics/data_postprocessor.h @@ -114,9 +114,9 @@ class DataPostprocessor: public Subscriptor { public: /** - * Destructor. This function doesn't actually do anything but - * is marked as virtual to ensure that data postprocessors can - * be destroyed through pointers to the base class. + * Destructor. This function doesn't actually do anything but is marked as + * virtual to ensure that data postprocessors can be destroyed through + * pointers to the base class. */ virtual ~DataPostprocessor (); diff --git a/include/deal.II/numerics/fe_field_function.h b/include/deal.II/numerics/fe_field_function.h index 9a46997c3e..c8ad4ca82c 100644 --- a/include/deal.II/numerics/fe_field_function.h +++ b/include/deal.II/numerics/fe_field_function.h @@ -54,8 +54,8 @@ namespace Functions * * Once the FEFieldFunction knows where the points lie, it creates a * quadrature formula for those points, and calls - * FEValues::get_function_values or FEValues::get_function_gradients with the - * given quadrature points. + * FEValues::get_function_values or FEValues::get_function_gradients with + * the given quadrature points. * * If you only need the quadrature points but not the values of the finite * element function (you might want this for the adjoint interpolation), you