]> https://gitweb.dealii.org/ - dealii.git/commitdiff
remove references to step-19
authorTimo Heister <timo.heister@gmail.com>
Mon, 16 Mar 2020 17:39:23 +0000 (13:39 -0400)
committerTimo Heister <timo.heister@gmail.com>
Tue, 17 Mar 2020 15:42:27 +0000 (11:42 -0400)
part of #2046

doc/doxygen/tutorial/tutorial.h.in
examples/step-28/doc/intro.dox
examples/step-28/step-28.cc
examples/step-29/doc/intro.dox
examples/step-29/doc/results.dox
examples/step-33/step-33.cc
examples/step-35/step-35.cc
examples/step-36/doc/intro.dox
include/deal.II/base/data_out_base.h
include/deal.II/base/parameter_handler.h
source/base/data_out_base.cc

index 04c4ce757972b1571e1d83ebe714b197122fa056..4a7d7c7966e3c96fa03ca21e1aaf974ab62aec26 100644 (file)
  *       </td></tr>
  *
  *   <tr valign="top">
- *       <td>step-19</td>
- *       <td> Input parameter file handling. Merging
- *       output of a parallel program.
- *       </td></tr>
- *
- *   <tr valign="top">
  *       <td>step-20</td>
  *       <td> Mixed finite elements. Using block
  *       matrices and block vectors to define more complicated solvers and
  *     <td>
  *       step-17,
  *       step-18,
- *       step-19,
  *       step-40,
  *       step-55
  *     </td>
  *     <td> Input parameter handling
  *     </td>
  *     <td>
- *       step-19,
  *       step-28,
  *       step-29,
  *       step-32,
index 2949fa03a484c2874637d90f92f8065058401f54..b2370b688bc15ee5f1817f4a034c7a6e30c488dc 100644 (file)
@@ -633,7 +633,7 @@ cheaper than if we omitted this step. After doing so, we resume our eigenvalue
 iterations on the next set of meshes.
 
 The program is controlled by a parameter file, using the ParameterHandler
-class already mentioned in the step-19 example program. We will show a
+class. We will show a
 parameter file in the results section of this tutorial. For the moment suffice
 it to say that it controls the polynomial degree of the finite elements used,
 the number of energy groups (even though all that is presently implemented are
index 7845afe2c442f2cfcad413374f90f2651cc7b8c3..ffb92c00f78d60f77d2bb616add3ae90f2f36e4f 100644 (file)
@@ -1142,7 +1142,7 @@ namespace Step28
   // occurred. In addition, we have a constructor of this class that sets all
   // these values to their default values, a function
   // <code>declare_parameters</code> that described to the ParameterHandler
-  // class already used in step-19 what parameters are accepted in the input
+  // class already used in step-29 what parameters are accepted in the input
   // file, and a function <code>get_parameters</code> that can extract the
   // values of these parameters from a ParameterHandler object.
   template <int dim>
index 7dcadffaba63e90ee43b77bc38ca0f5d2e3a8f55..09ae8fd037b52a265c5d830354c8884d35abbcbe 100644 (file)
@@ -24,10 +24,10 @@ element fields for discretizing each one of them. Basically this amounts to
 viewing a single complex valued equation as a system of two real valued
 equations. This short example demonstrates how this can be implemented in
 deal.II by using an <code>FE_system</code> object to stack two finite element
-fields representing real and imaginary parts. We also revisit the
-ParameterHandler class first used in step-19, which provides a
-convenient way for reading parameters from a configuration file at runtime
-without the need to recompile the program code.
+fields representing real and imaginary parts. We also discuss the
+ParameterHandler class, which provides a convenient way for reading parameters
+from a configuration file at runtime without the need to recompile the
+program code.
 
 The equations covered here fall into the class of vector-valued problems. A
 top level overview of this topic can be found in the @ref vector_valued module.
index a7bf550135077e2c340415ba260e32becf1ba111..3f54ebf19ec1223d32ceabc4a068eac040ef67ab 100644 (file)
@@ -36,9 +36,9 @@ $d=0.3$, which amounts to a focus of the transducer lens
 at $x=0.5$, $y=0.3$. The coarse mesh is refined 5 times,
 resulting in 160x160 cells, and the output is written in vtu
 format. The parameter reader understands many more parameters
-pertaining in particular to the generation of output, see the
-explanation in step-19, but we need none of these
-parameters here and therefore stick with their default values.
+pertaining in particular to the generation of output, but we
+need none of these parameters here and therefore stick with
+their default values.
 
 Here's the console output of the program in debug mode:
 
index 1f5d3bf6c653e3fbdbad96e314652cea8c53eb14..b0539f415172e86a7abb3d60b6d13f6cbf056ce2 100644 (file)
@@ -1359,7 +1359,7 @@ namespace Step33
     // only prints something if verbose output has been requested) deals with
     // the interface we have in this program to the Trilinos library that
     // provides us with linear solvers. Similarly to including PETSc matrices
-    // in step-17, step-18, and step-19, all we need to do is to create a
+    // in step-17 and step-18, all we need to do is to create a
     // Trilinos sparse matrix instead of the standard deal.II class. The
     // system matrix is used for the Jacobian in each Newton step. Since we do
     // not intend to run this program in parallel (which wouldn't be too hard
index 91c45085592eb973e4c7169b42ab49d24a0619d7..78ddf40a5a35dcdf65ad01fa2dddca7745239d89 100644 (file)
@@ -126,7 +126,7 @@ namespace Step35
 
     // In the constructor of this class we declare all the parameters. The
     // details of how this works have been discussed elsewhere, for example in
-    // step-19 and step-29.
+    // step-29.
     Data_Storage::Data_Storage()
       : form(Method::rotational)
       , dt(5e-4)
index d6d97f600855de9d35966af7767d4a2b4cde6d4c..a54a36aa7c4aaa23d75970c9840573ad09e97403 100644 (file)
@@ -256,8 +256,7 @@ or the number of eigenvalues we want to solve for. We could go much
 further with this but stop at making only a few of the things that one
 could select at run time actual input file parameters. In order to see
 what could be done in this regard, take a look at @ref step_29
-"step-29", step-33, and in particular @ref step_19
-"step-19".</li>
+"step-29" and step-33.</li>
 
 <li>We use the FunctionParser class to make the potential $V(\mathbf
 x)$ a run-time parameter that can be specified in the input file as a
index a00822a6f2ba92090a65c4489bf1575edcff33e4..bdd9088e27faa3cd00ff4dd7de79b526a70fa41b 100644 (file)
@@ -3167,15 +3167,13 @@ private:
  * This second use scenario is explained in some detail in the step-18 example
  * program.
  *
- * Both these applications are implemented in the step-19 example program.
- * There, a slight complication is also explained: in order to read data back
- * into this object, you have to know the template parameters for the space
- * dimension which were used when writing the data. If this knowledge is
- * available at compile time, then this is no problem. However, if it is not
- * (such as in a simple format converter), then it needs to be figured out at
- * run time, even though the compiler already needs it at compile time. A way
- * around using the DataOutBase::determine_intermediate_format_dimensions()
- * function is explained in step-19.
+ * In order to read data back into this object, you have to know the template
+ * parameters for the space dimension which were used when writing the
+ * data. If this knowledge is available at compile time, then this is no
+ * problem. However, if it is not (such as in a simple format converter), then
+ * it needs to be figured out at run time, even though the compiler already
+ * needs it at compile time. A way around using the
+ * DataOutBase::determine_intermediate_format_dimensions() function.
  *
  * Note that the intermediate format is what its name suggests: a direct
  * representation of internal data. It isn't standardized and will change
index 0968eb7509f896c171b240e3257a76da304a2072..483e79a5f5e051d1264110700dc438ef850071fd 100644 (file)
@@ -53,10 +53,8 @@ class MultipleParameterLoop;
  * Input may be sorted into subsection trees in order to give the input a
  * logical structure, and input files may include other files.
  *
- * The ParameterHandler class is discussed in detail in the
- * @ref step_19 "step-19"
- * example program, and is used in more realistic situations in step-29,
- * step-33 and step-34.
+ * The ParameterHandler class is discussed in in step-29,
+ * step-33, and step-34.
  *
  * <h3>Declaring entries</h3>
  *
index cb2873f3ddee2b457dc4afccfec88f6374b5a139..57c38a64a22f0c8f616790cf7301ab9e631551b2 100644 (file)
@@ -6835,7 +6835,7 @@ namespace DataOutBase
 
     // first write tokens indicating the template parameters. we need this in
     // here because we may want to read in data again even if we don't know in
-    // advance the template parameters, see step-19
+    // advance the template parameters:
     out << dim << ' ' << spacedim << '\n';
 
     // then write a header

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.