From: Wolfgang Bangerth Date: Wed, 3 May 2006 17:03:47 +0000 (+0000) Subject: Slight documentation improvements X-Git-Tag: v8.0.0~11784 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=b158af1696f1fac6ccbe6f867755b064eaba5e99;p=dealii.git Slight documentation improvements git-svn-id: https://svn.dealii.org/trunk@13023 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/examples/step-10/step-10.cc b/deal.II/examples/step-10/step-10.cc index b6ffb6a8e9..72d4a3443c 100644 --- a/deal.II/examples/step-10/step-10.cc +++ b/deal.II/examples/step-10/step-10.cc @@ -338,8 +338,8 @@ void compute_pi_by_area () std::cout << "Degree = " << degree << std::endl; // First generate the - // triangulation, the Boundary - // and the Mapping object as + // triangulation, the boundary + // and the mapping object as // already seen. Triangulation triangulation; GridGenerator::hyper_ball (triangulation); @@ -554,9 +554,9 @@ void compute_pi_by_perimeter () const QGauss quadrature(4); // We loop over all degrees, create - // the Triangulation, the Boundary, - // the Mapping, the dummy - // FiniteElement and the DoFHandler + // the triangulation, the boundary, + // the mapping, the dummy + // finite element and the DoFHandler // object as seen before. for (unsigned int degree=1; degree<5; ++degree) { diff --git a/deal.II/examples/step-15/step-15.cc b/deal.II/examples/step-15/step-15.cc index ed34c45056..5e1f4c5b97 100644 --- a/deal.II/examples/step-15/step-15.cc +++ b/deal.II/examples/step-15/step-15.cc @@ -567,7 +567,7 @@ void MinimizationProblem::assemble_step () hanging_node_constraints.condense (matrix); hanging_node_constraints.condense (residual); - // Boundary values are, too, but with a + // %Boundary values are, too, but with a // twist this time: in all previous example // programs, we have used that by default // (i.e. unless something else is set), all diff --git a/deal.II/examples/step-18/step-18.cc b/deal.II/examples/step-18/step-18.cc index 31d8bbda98..5dd32a5d2b 100644 --- a/deal.II/examples/step-18/step-18.cc +++ b/deal.II/examples/step-18/step-18.cc @@ -1169,7 +1169,7 @@ namespace QuasiStaticElasticity // already, but for didactic reasons it // was more appropriate to handle it // after discussing boundary - // objects). Boundary indicators in + // objects). %Boundary indicators in // deal.II, for mostly historic reasons, // serve a dual purpose: they describe // the type of a boundary for other