From: David Wells Date: Sat, 12 May 2018 14:54:37 +0000 (-0400) Subject: Convert '%Boundary' to 'Boundary'. X-Git-Tag: v9.1.0-rc1~1139^2~1 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=6c788cf500c534af21f8529e110b1f85d76e6c02;p=dealii.git Convert '%Boundary' to 'Boundary'. Since this class is gone we no longer need to escape it when generating documentation. --- diff --git a/doc/doxygen/headers/glossary.h b/doc/doxygen/headers/glossary.h index 588411e53e..6f2859162a 100644 --- a/doc/doxygen/headers/glossary.h +++ b/doc/doxygen/headers/glossary.h @@ -279,7 +279,7 @@ * * * - *
@anchor GlossBoundaryForm %Boundary form
+ *
@anchor GlossBoundaryForm Boundary form
* *
For a dim-dimensional triangulation in dim-dimensional space, * the boundary form is a vector defined on faces. It is the vector @@ -307,7 +307,7 @@ *
* * - *
@anchor GlossBoundaryIndicator %Boundary indicator
+ *
@anchor GlossBoundaryIndicator Boundary indicator
* *
In a Triangulation object, every part of the boundary may be * associated with a unique number (of type types::boundary_id) that @@ -364,7 +364,7 @@ * VectorTools::interpolate_boundary_values, * VectorTools::compute_no_normal_flux_constraints. * - * @note %Boundary indicators are inherited from mother faces and edges to + * @note Boundary indicators are inherited from mother faces and edges to * their children upon mesh refinement. Some more information about boundary * indicators is also presented in a section of the documentation of the * Triangulation class. diff --git a/doc/doxygen/scripts/intro2toc b/doc/doxygen/scripts/intro2toc index f65d9db52d..1b1b67015c 100644 --- a/doc/doxygen/scripts/intro2toc +++ b/doc/doxygen/scripts/intro2toc @@ -48,11 +48,10 @@ while (<>) { # replace double dashes in comments by — $text =~ s!--!—!g; - # we sometimes escape words with % (as in "%Boundary - # conditions") because doxygen would otherwise link the word - # to a class name. This isn't necessary in the index because - # the text already appears in a hyperref, so get rid of the - # percent sign + # we sometimes escape words with % (as in "boundary %Function") + # because doxygen would otherwise link the word to a class name. This + # isn't necessary in the index because the text already appears in a + # hyperref, so get rid of the percent sign $text =~ s!\%!!g; print "
  • $text\n"; diff --git a/doc/doxygen/tutorial/tutorial.h.in b/doc/doxygen/tutorial/tutorial.h.in index cd2cade0e0..ed0a592f14 100644 --- a/doc/doxygen/tutorial/tutorial.h.in +++ b/doc/doxygen/tutorial/tutorial.h.in @@ -101,7 +101,7 @@ * step-3 * Actually solve Laplace's * problem. Object-orientation. Assembling matrices and - * vectors. %Boundary values. + * vectors. Boundary values. * * * @@ -303,7 +303,7 @@ * * * step-34 - * %Boundary element methods (BEM) of low order: Exterior irrotational + * Boundary element methods (BEM) of low order: Exterior irrotational * flow. The ParsedFunction class. * * @@ -667,7 +667,7 @@ * * * - * %Boundary element methods, curved manifolds + * Boundary element methods, curved manifolds * * * step-32, diff --git a/doc/news/6.2.0-vs-6.3.0.h b/doc/news/6.2.0-vs-6.3.0.h index a24750db3f..942731537b 100644 --- a/doc/news/6.2.0-vs-6.3.0.h +++ b/doc/news/6.2.0-vs-6.3.0.h @@ -201,7 +201,7 @@ inconvenience this causes. and Cataldo Manigrasso, SISSA, Trieste, Italy). It explains in detail how to use the library for the solution of problems defined on codimension - one manifolds, such as, for example, %Boundary Element Methods. + one manifolds, such as, for example, Boundary Element Methods.
    (Luca Heltai, 2009/09/23)

    diff --git a/examples/step-22/doc/intro.dox b/examples/step-22/doc/intro.dox index d1d28f9909..ead7896cc7 100644 --- a/examples/step-22/doc/intro.dox +++ b/examples/step-22/doc/intro.dox @@ -177,7 +177,7 @@ of the bilinear form that the Stokes equations yield a symmetric bilinear form, and consequently a symmetric (if indefinite) system matrix. -

    %Boundary conditions

    +

    Boundary conditions

    @dealiiVideoLecture{21.5} (@dealiiVideoLectureSeeAlso{21.55,21.6,21.65}) diff --git a/examples/step-23/step-23.cc b/examples/step-23/step-23.cc index dd2b38865f..0396308981 100644 --- a/examples/step-23/step-23.cc +++ b/examples/step-23/step-23.cc @@ -582,7 +582,7 @@ namespace Step23 // that this time the matrix on the left is the mass matrix (which we // copy again in order to be able to apply boundary conditions, and // the right hand side is $MV^{n-1} - k\left[ \theta A U^n + - // (1-\theta) AU^{n-1}\right]$ plus forcing terms. %Boundary values + // (1-\theta) AU^{n-1}\right]$ plus forcing terms. Boundary values // are applied in the same way as before, except that now we have to // use the BoundaryValuesV class: laplace_matrix.vmult (system_rhs, solution_u); diff --git a/examples/step-31/doc/intro.dox b/examples/step-31/doc/intro.dox index 2735157a58..96055a1093 100644 --- a/examples/step-31/doc/intro.dox +++ b/examples/step-31/doc/intro.dox @@ -125,7 +125,7 @@ problems and that you may want to investigate before trying to morph step-31 into something that can solve whatever you want to solve. -

    %Boundary and initial conditions

    +

    Boundary and initial conditions

    Since the Boussinesq equations are derived under the assumption that inertia of the fluid's motion does not play a role, the flow field is at each time diff --git a/examples/step-34/doc/intro.dox b/examples/step-34/doc/intro.dox index 30d2491375..03ebeee49d 100644 --- a/examples/step-34/doc/intro.dox +++ b/examples/step-34/doc/intro.dox @@ -230,7 +230,7 @@ $\Omega$: \quad \mathbf{x}\in \partial\Omega, \f] -which is the %Boundary Integral Equation (BIE) we were looking for, +which is the Boundary Integral Equation (BIE) we were looking for, where the quantity $\alpha(\mathbf{x})$ is the fraction of angle or solid angle by which the point $\mathbf{x}$ sees the domain of integration $\mathbb{R}^n\backslash\Omega$. @@ -472,7 +472,7 @@ This is exactly Bernoulli's law mentioned above.

    The numerical approximation

    -Numerical approximations of %Boundary Integral Equations (BIE) are commonly +Numerical approximations of Boundary Integral Equations (BIE) are commonly referred to as the boundary element method or panel method (the latter expression being used mostly in the computational fluid dynamics community). The goal of the following test problem is to solve the integral diff --git a/examples/step-52/doc/intro.dox b/examples/step-52/doc/intro.dox index ba3cc54946..d5ace992a0 100644 --- a/examples/step-52/doc/intro.dox +++ b/examples/step-52/doc/intro.dox @@ -216,7 +216,7 @@ where {\cal S}_{i}(t) &=& (\psi_i,S(x,t))_\Omega. @f} See also step-24 and step-26 to understand how we arrive here. -%Boundary terms are not necessary due to the chosen boundary conditions for +Boundary terms are not necessary due to the chosen boundary conditions for the current problem. To use the Runge-Kutta methods, we recast this as follows: @f{eqnarray*} diff --git a/examples/step-60/doc/intro.dox b/examples/step-60/doc/intro.dox index d61317a6d7..44e26cf1a2 100644 --- a/examples/step-60/doc/intro.dox +++ b/examples/step-60/doc/intro.dox @@ -299,7 +299,7 @@ example, something you read from file, or a closed sphere that you later deform to something more interesting. In the default scenario, $\Gamma$ has co-dimension one, and this tutorial -program implements the Fictitious %Boundary Method. As it turns out, the same +program implements the Fictitious Boundary Method. As it turns out, the same techniques are used in the Variational Immersed Finite Element Method, and the coupling operator $C$ defined above is the same in almost all of these non-matching methods. @@ -323,7 +323,7 @@ $\Omega$. International Journal of Multiphase Flow 25 (5). Pergamon: 755–94. - Boffi, D., L. Gastaldi, L. Heltai, and C.S. Peskin. 2008. “On the - Hyper-Elastic Formulation of the Immersed %Boundary Method.” Computer Methods + Hyper-Elastic Formulation of the Immersed Boundary Method.” Computer Methods in Applied Mechanics and Engineering 197 (25–28). - Heltai, L., and F. Costanzo. 2012. “Variational Implementation of Immersed diff --git a/examples/step-60/doc/results.dox b/examples/step-60/doc/results.dox index 8accfecaac..59627a376d 100644 --- a/examples/step-60/doc/results.dox +++ b/examples/step-60/doc/results.dox @@ -394,7 +394,7 @@ across $\Gamma$, in order to obtain the Dirichlet data $g$. So $S$ is some sort of Neumann to Dirichlet map, and we would like to have a good approximation for the Dirichlet to Neumann map. A possibility would be to -use a %Boundary Element approximation of the problem on $\Gamma$, and construct a +use a Boundary Element approximation of the problem on $\Gamma$, and construct a rough approximation of the hyper-singular operator for the Poisson problem associated to $\Gamma$, which is precisely a Dirichlet to Neumann map. diff --git a/include/deal.II/fe/fe_values.h b/include/deal.II/fe/fe_values.h index d38072c499..6e2cf0a57e 100644 --- a/include/deal.II/fe/fe_values.h +++ b/include/deal.II/fe/fe_values.h @@ -3277,7 +3277,7 @@ public: const Quadrature& quadrature); /** - * %Boundary form of the transformation of the cell at the ith + * Boundary form of the transformation of the cell at the ith * quadrature point. See * @ref GlossBoundaryForm. * diff --git a/include/deal.II/grid/tria.h b/include/deal.II/grid/tria.h index c4e1e60769..07da7c0ee5 100644 --- a/include/deal.II/grid/tria.h +++ b/include/deal.II/grid/tria.h @@ -833,13 +833,13 @@ namespace internal * to pertain to a particular region of the domain, material ids are inherited * by child cells from their parent upon mesh refinement. * - * %Boundary indicators on lower dimensional objects (these have no material + * Boundary indicators on lower dimensional objects (these have no material * id) indicate the number of a boundary component. The weak formulation of the * partial differential equation may have different boundary conditions on * different parts of the boundary. The boundary indicator can be used in * creating the matrix or the right hand side vector to indicate these * different parts of the model (this use is like the material id of cells). - * %Boundary indicators may be in the range from zero to + * Boundary indicators may be in the range from zero to * numbers::internal_face_boundary_id-1. The value * numbers::internal_face_boundary_id is reserved to denote interior lines (in * 2D) and interior lines and quads (in 3D), which do not have a boundary diff --git a/include/deal.II/numerics/error_estimator.h b/include/deal.II/numerics/error_estimator.h index 9b3300db4c..6a3f20c17c 100644 --- a/include/deal.II/numerics/error_estimator.h +++ b/include/deal.II/numerics/error_estimator.h @@ -150,7 +150,7 @@ namespace hp * coefficient which will then be used for all components. * * - *

    %Boundary values

    + *

    Boundary values

    * * If the face is at the boundary, i.e. there is no neighboring cell to which * the jump in the gradiend could be computed, there are two possibilities: diff --git a/include/deal.II/numerics/matrix_tools.h b/include/deal.II/numerics/matrix_tools.h index d15283a5a5..36525e2d40 100644 --- a/include/deal.II/numerics/matrix_tools.h +++ b/include/deal.II/numerics/matrix_tools.h @@ -572,7 +572,7 @@ namespace MatrixCreator * others. * * - *

    %Boundary conditions

    + *

    Boundary conditions

    * * The apply_boundary_values() function inserts boundary conditions into a * system of equations. To actually do this you have to specify a list of