From 2df21a79a9f474fa16488aee2033264273091f3e Mon Sep 17 00:00:00 2001 From: wolf Date: Mon, 19 Apr 2004 20:08:26 +0000 Subject: [PATCH] Last few doxygen markups. git-svn-id: https://svn.dealii.org/trunk@9062 0785d39b-7218-0410-832d-ea1e28bc413d --- deal.II/deal.II/include/dofs/dof_levels.h | 10 +++++----- deal.II/deal.II/include/dofs/dof_tools.h | 10 +++++----- deal.II/deal.II/include/grid/grid_reordering.h | 2 +- deal.II/deal.II/include/grid/persistent_tria.h | 6 +++--- deal.II/deal.II/include/grid/tria.h | 8 ++++---- deal.II/deal.II/include/grid/tria_boundary_lib.h | 10 +++++----- deal.II/deal.II/include/grid/tria_levels.h | 4 ++-- deal.II/deal.II/include/numerics/data_out_faces.h | 4 ++-- deal.II/deal.II/include/numerics/error_estimator.h | 2 +- deal.II/deal.II/include/numerics/matrices.h | 2 +- deal.II/deal.II/include/numerics/solution_transfer.h | 4 ++-- deal.II/deal.II/include/numerics/vectors.h | 8 ++++---- 12 files changed, 35 insertions(+), 35 deletions(-) diff --git a/deal.II/deal.II/include/dofs/dof_levels.h b/deal.II/deal.II/include/dofs/dof_levels.h index c587d38a15..7a755d96ef 100644 --- a/deal.II/deal.II/include/dofs/dof_levels.h +++ b/deal.II/deal.II/include/dofs/dof_levels.h @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003 by the deal.II authors +// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -45,7 +45,7 @@ class DoFLevel * * @sect3{Information for all DoFLevel classes} * - * The DoFLevel classes + * The DoFLevel classes * store the global indices of the degrees of freedom for each cell on a * certain level. The index or number of a degree of freedom is the zero-based * index of the according value in the solution vector and the row and column @@ -63,19 +63,19 @@ class DoFLevel * $\ldots, u_1^m, u_2^m, u_1^{m+1}, u_2^{m+1},\ldots$ with $m$ denoting the * $m$th basis function, or $\ldots, u_1^m, u_1^{m+1}, u_1^{m+2}, \ldots, * u_2^m, u_2^{m+1}, u_2^{m+2}, \ldots$, respectively). Likewise, the - * constraint matrix returned by DoFHandler::make_hanging_node_constraints () + * constraint matrix returned by DoFHandler::make_hanging_node_constraints() * is then * to be understood as a block matrix. * * The storage format of the degrees of freedom indices (short: DoF * indices) is somewhat like a mirror of the data structures of the * triangulation classes. There is a hierarchy of - * DoFLevel classes for the different dimensions which + * DoFLevel classes for the different dimensions which * have objects named @p line_dofs, @p quad_dofs and so on, in which * the indices of DoFs located on lines and quads, respectively, are * stored. The indices are stored levelwise. The layout in these * arrays is as follows: if for a selected finite element (use - * DoFHandler::distribute_dofs() to select a finite element) + * DoFHandler::distribute_dofs() to select a finite element) * the number of DoFs on each line (without those in the vertices) is * @p N, then the length of the @p line_dofs array is @p N times * the number of lines on this level. The DoF indices for the @p ith diff --git a/deal.II/deal.II/include/dofs/dof_tools.h b/deal.II/deal.II/include/dofs/dof_tools.h index 24ff517b5c..dffee2e726 100644 --- a/deal.II/deal.II/include/dofs/dof_tools.h +++ b/deal.II/deal.II/include/dofs/dof_tools.h @@ -183,11 +183,11 @@ class DoFTools * of hanging nodes. They have * to be taken care of by a call * to - * ConstraintMatrix::condense() + * ConstraintMatrix::condense() * afterwards. * * Remember using - * SparsityPattern::compress() + * SparsityPattern::compress() * after generating the pattern. * * The actual type of the @@ -316,14 +316,14 @@ class DoFTools * nodes. The sparsity pattern * is not compressed, since if * you want to call - * ConstraintMatrix::condense(1) + * ConstraintMatrix::condense() * afterwards, new entries have * to be added. However, if you * don't want to call - * ConstraintMatrix::condense(1), + * ConstraintMatrix::condense(), * you have to compress the * matrix yourself, using - * SparsityPattern::compress(). + * SparsityPattern::compress() * * The actual type of the * sparsity pattern may be diff --git a/deal.II/deal.II/include/grid/grid_reordering.h b/deal.II/deal.II/include/grid/grid_reordering.h index b9a772417e..f81c7b875d 100644 --- a/deal.II/deal.II/include/grid/grid_reordering.h +++ b/deal.II/deal.II/include/grid/grid_reordering.h @@ -583,7 +583,7 @@ * smaller (for example by one order of magnitude) than the time * needed to read the data from a file, and also to actually generate * the triangulation from this data using the - * Triangulation::create_triangulation function. + * Triangulation::create_triangulation() function. * * @author Wolfgang Bangerth, 2000, Michael Anderson 2003 */ diff --git a/deal.II/deal.II/include/grid/persistent_tria.h b/deal.II/deal.II/include/grid/persistent_tria.h index 4c9baf73b2..07a15833d8 100644 --- a/deal.II/deal.II/include/grid/persistent_tria.h +++ b/deal.II/deal.II/include/grid/persistent_tria.h @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003 by the deal.II authors +// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -91,10 +91,10 @@ * constitute a triangulation; it only becomes one after @p restore is first * called. Note also that the @p execute_coarsening_and_refinement stores * all necessary flags for later reconstruction using the @p restore function. - * Triangulation::clear () resets the underlying triangulation to a + * Triangulation::clear() resets the underlying triangulation to a * virgin state, but does not affect the stored refinement flags needed for * later reconstruction and does also not touch the coarse grid which is - * used withing restore(). + * used within restore(). * * @author Wolfgang Bangerth, 1999 */ diff --git a/deal.II/deal.II/include/grid/tria.h b/deal.II/deal.II/include/grid/tria.h index 0257ee3cb9..0ded2fd825 100644 --- a/deal.II/deal.II/include/grid/tria.h +++ b/deal.II/deal.II/include/grid/tria.h @@ -41,7 +41,7 @@ template class MGDoFHandler; /** * Structure which is passed to the - * Triangulation::create_triangulation function. It + * Triangulation::create_triangulation function. It * contains all data needed to construct a cell, namely the indices * of the vertices and the material indicator. */ @@ -102,7 +102,7 @@ struct CellData /** - * Structure to be passed to the Triangulation::create_triangulation + * Structure to be passed to the Triangulation::create_triangulation * function to describe boundary information. * * This structure is the same for all dimensions, since we use an input @@ -819,8 +819,8 @@ struct TriaNumberCache<3> : public TriaNumberCache<2> * by providing a list of vertices and a list of cells. Each such cell * consists of a vector storing the indices of the vertices of this cell * in the vertex list. To see how this works, you can take a look at the - * GridIn::read_* functions. The appropriate function to be - * called is Triangulation::create_triangulation (). + * GridIn::read_* functions. The appropriate function to be + * called is create_triangulation(). * * Creating the hierarchical information needed for this * library from cells storing only vertex information can be diff --git a/deal.II/deal.II/include/grid/tria_boundary_lib.h b/deal.II/deal.II/include/grid/tria_boundary_lib.h index 8f6a9419f5..8b2c7c9216 100644 --- a/deal.II/deal.II/include/grid/tria_boundary_lib.h +++ b/deal.II/deal.II/include/grid/tria_boundary_lib.h @@ -29,11 +29,11 @@ * @p cylinder function of GridGenerator. It should be used for * the hull of the cylinder only (boundary indicator 0). * - * This class is derived from StraightBoundary rather than from - * Boundary, which would seem natural, since this way we can use the - * StraightBoundary::in_between(neighbors) function. + * This class is derived from StraightBoundary rather than from + * Boundary, which would seem natural, since this way we can use the + * StraightBoundary::in_between() function. * - * @author Guido Kanschat, 2001 + * @author Guido Kanschat, 2001 */ template class CylinderBoundary : public StraightBoundary @@ -151,7 +151,7 @@ class CylinderBoundary : public StraightBoundary * * This class is derived from StraightBoundary rather than from * Boundary, which would seem natural, since this way we can use the - * StraightBoundary::in_between(neighbors) function. + * StraightBoundary::in_between() function. * * @author Wolfgang Bangerth, 1998, Ralf Hartmann, 2001 */ diff --git a/deal.II/deal.II/include/grid/tria_levels.h b/deal.II/deal.II/include/grid/tria_levels.h index fd39a55051..f5c4694670 100644 --- a/deal.II/deal.II/include/grid/tria_levels.h +++ b/deal.II/deal.II/include/grid/tria_levels.h @@ -239,7 +239,7 @@ class TriangulationLevel<1> : public TriangulationLevel<0> * stored in this list. A line is * called active if it has no * children. The function - * TriaIterator::active() + * TriaAccessor::has_children() * tests for this. */ std::vector children; @@ -267,7 +267,7 @@ class TriangulationLevel<1> : public TriangulationLevel<0> * already been processed. * * You can clear all used flags using - * Triangulation::clear_user_flags(). + * Triangulation::clear_user_flags(). */ std::vector user_flags; diff --git a/deal.II/deal.II/include/numerics/data_out_faces.h b/deal.II/deal.II/include/numerics/data_out_faces.h index 72790424bf..820a19a1c6 100644 --- a/deal.II/deal.II/include/numerics/data_out_faces.h +++ b/deal.II/deal.II/include/numerics/data_out_faces.h @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003 by the deal.II authors +// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -109,7 +109,7 @@ class DataOutFaces : public DataOut_DoFData * generate output for. The usual * way would, of course, be to * use an object of type - * DoFHandler::fec_iterator, + * DoFHandler::face_iterator, * but since we have to describe * faces to objects of type * FEValues, we can only diff --git a/deal.II/deal.II/include/numerics/error_estimator.h b/deal.II/deal.II/include/numerics/error_estimator.h index 8cc8b3f5fe..bb98eee989 100644 --- a/deal.II/deal.II/include/numerics/error_estimator.h +++ b/deal.II/deal.II/include/numerics/error_estimator.h @@ -49,7 +49,7 @@ template class FESubfaceValues; * the conormal derivative $a\frac{du}{dn} = g$. * * The error estimator returns a vector of estimated errors per cell which - * can be used to feed the Triangulation::refine_* functions. This + * can be used to feed the Triangulation::refine_* functions. This * vector contains elements of data type @p float, rather than @p double, * since accuracy is not so important here, and since this can save rather * a lot of memory, when using many cells. diff --git a/deal.II/deal.II/include/numerics/matrices.h b/deal.II/deal.II/include/numerics/matrices.h index a2d1a8a2f8..4d8ba71df8 100644 --- a/deal.II/deal.II/include/numerics/matrices.h +++ b/deal.II/deal.II/include/numerics/matrices.h @@ -74,7 +74,7 @@ namespace PETScWrappers * created. The functions assume that the matrix is initialized with a * sparsity pattern (SparsityPattern) corresponding to the given degree * of freedom handler, i.e. the sparsity structure is already as needed. - * You can do this by calling the DoFHandler::make_sparsity_pattern + * You can do this by calling the DoFTools::make_sparsity_pattern() * function. * * Furthermore it is assumed that no relevant data is in the matrix. All diff --git a/deal.II/deal.II/include/numerics/solution_transfer.h b/deal.II/deal.II/include/numerics/solution_transfer.h index 893648602b..2a0d297a54 100644 --- a/deal.II/deal.II/include/numerics/solution_transfer.h +++ b/deal.II/deal.II/include/numerics/solution_transfer.h @@ -138,12 +138,12 @@ * solution vector on the current (original) grid. * Each entry of this vector belongs to one of the * DoFs of the discretisation. If we now refine the grid then the calling of - * DoFHandler::distribute_dofs(...) will change at least some of the + * DoFHandler::distribute_dofs() will change at least some of the * DoF indices. Hence we need to store the DoF indices of all active cells * before the refinement. The @p user_pointer of each active cell * is used to point to the vector of these DoF indices of that cell, all other * @p user_pointers are cleared. All this is - * done by prepare_for_pure_refinement(). + * done by prepare_for_pure_refinement(). * * In the function refine_interpolate(in,out) and on each cell where the * @p user_pointer is set (i.e. the cells that were active in the original grid) diff --git a/deal.II/deal.II/include/numerics/vectors.h b/deal.II/deal.II/include/numerics/vectors.h index 86e78e0402..2a0584c162 100644 --- a/deal.II/deal.II/include/numerics/vectors.h +++ b/deal.II/deal.II/include/numerics/vectors.h @@ -153,7 +153,7 @@ class ConstraintMatrix; *
  • Creation of right hand side vectors: * The @p create_right_hand_side function computes the vector * $f_i = \int_\Omega f(x) \phi_i(x) dx$. This is the same as what the - * MatrixCreator::create_* functions which take a right hand side do, + * MatrixCreator::create_* functions which take a right hand side do, * but without assembling a matrix. * *
  • Creation of boundary right hand side vectors: The @@ -268,17 +268,17 @@ class ConstraintMatrix; * * To get the global L1 error, you have to sum up the * entries in @p difference, e.g. using - * Vector::l1_norm function. For the global L2 + * Vector::l1_norm function. For the global L2 * difference, you have to sum up the squares of the entries and * take the root of the sum, e.g. using - * Vector::l2_norm. These two operations + * Vector::l2_norm. These two operations * represent the $l_1$ and $l_2$ norms of the vectors, but you need * not take the absolute value of each entry, since the cellwise * norms are already positive. * * To get the global mean difference, simply sum up the elements as above. * To get the $L_\infty$ norm, take the maximum of the vector elements, e.g. - * using the Vector::linfty_norm function. + * using the Vector::linfty_norm function. * * For the global H1 norm and seminorm, the same rule applies as for the * L2 norm: compute the $l_2$ norm of the cell error vector. -- 2.39.5