]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Slight documentation improvements
authorWolfgang Bangerth <bangerth@math.tamu.edu>
Wed, 3 May 2006 17:03:47 +0000 (17:03 +0000)
committerWolfgang Bangerth <bangerth@math.tamu.edu>
Wed, 3 May 2006 17:03:47 +0000 (17:03 +0000)
git-svn-id: https://svn.dealii.org/trunk@13023 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/examples/step-10/step-10.cc
deal.II/examples/step-15/step-15.cc
deal.II/examples/step-18/step-18.cc

index b6ffb6a8e96d7a8ca399fdbd0f6e1dd94c7ff913..72d4a3443cf84be7dcae37a505a565a4bc873ff9 100644 (file)
@@ -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<dim> triangulation;
       GridGenerator::hyper_ball (triangulation);
@@ -554,9 +554,9 @@ void compute_pi_by_perimeter ()
   const QGauss<dim-1> 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)
     {
index ed34c4505689040365994fc1b7b0be233afb8e25..5e1f4c5b97c0d49feec946ecb5e85abdd8cb5df0 100644 (file)
@@ -567,7 +567,7 @@ void MinimizationProblem<dim>::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
index 31d8bbda9823a4cd12836123df282baab14efbbe..5dd32a5d2bd5af5f395e53da7d5a925f0b326e1d 100644 (file)
@@ -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

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.