]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Cross-link tutorial programs.
authorwolf <wolf@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 28 Mar 2006 04:17:28 +0000 (04:17 +0000)
committerwolf <wolf@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 28 Mar 2006 04:17:28 +0000 (04:17 +0000)
git-svn-id: https://svn.dealii.org/trunk@12699 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/doc/tutorial/chapter-2.step-by-step/step-14.data/intro.dox
deal.II/doc/tutorial/chapter-2.step-by-step/step-20.data/intro.dox

index 220c3ccbec1ecec75a70cafafc4e556e74105cfd..6a6ffd3abd07e50bc612e51fe429572e3c67ad41 100644 (file)
@@ -177,7 +177,7 @@ turn to the actual implementation.
 <h3>The software</h3>
 
 The step-14 example program builds heavily on the techniques already used in
-the step-13 program. Its implementation of the dual weighted residual error
+the @ref step_13 "step-13" program. Its implementation of the dual weighted residual error
 estimator explained above is done by deriving a second class, properly called
 <code>DualSolver</code>, from the <code>Solver</code> base class, and having a class
 (<code>WeightedResidual</code>) that joins the two again and controls the solution
index 813fd0076c584eb9a239a8503fe77a3ee9ba8451..aa7b812e975d95664473db87460768085064e075 100644 (file)
@@ -109,14 +109,14 @@ functions to accommodate for the fact that the flow velocity is vector-valued.
 The necessary question then is: how do we do this in a program?
 
 Vector-valued elements have already been discussed in previous tutorial
-programs, the first time and in detail in step-8. The main difference there
+programs, the first time and in detail in @ref step_8 "step-8". The main difference there
 was that the vector-valued space $V_h$ is uniform in all its components: the
 $dim$ components of the displacement vector are all equal and from the same
 function space. What we could therefore do was to build $V_h$ as the outer
 product of the $dim$ times the usual $Q(1)$ finite element space, and by this
 make sure that all our shape functions have only a single non-zero vector
 component. Instead of dealing with vector-valued shape functions, all we did
-in step-8 was therefore to look at the (scalar) only non-zero component and
+in @ref step_8 "step-8" was therefore to look at the (scalar) only non-zero component and
 use the <code>fe.system_to_component_index(i).first</code> call to figure out
 which component this actually is.
 
@@ -138,7 +138,7 @@ learned that we use the <code>FEValues</code> class to determine the values and
 gradients of shape functions at quadrature points. For example, we would call
 <code>fe_values.shape_value(i,q_point)</code> to obtain the value of the
 <code>i</code>th shape function on the quadrature point with number
-<code>q_point</code>. Later, in step-8 and other tutorial programs, we learned
+<code>q_point</code>. Later, in @ref step_8 "step-8" and other tutorial programs, we learned
 that this function call also works for vector-valued shape functions (of
 primitive finite elements), and that it returned the value of the only
 non-zero component of shape function <code>i</code> at quadrature point
@@ -288,7 +288,7 @@ bilinear form and right hand side.
 There is one final term that we have to take care of: the right hand side
 contained the term $(g,{\mathbf v}\cdot {\mathbf n})_{\partial\Omega}$, constituting the
 weak enforcement of pressure boundary conditions. We have already seen in
-step-7 how to deal with face integrals: essentially exactly the same as with
+@ref step_7 "step-7" how to deal with face integrals: essentially exactly the same as with
 domain integrals, except that we have to use the <code>FEFaceValues</code> class
 instead of <code>FEValues</code>. To compute the boundary term we then simply have
 to loop over all boundary faces and integrate there. If you look closely at
@@ -461,7 +461,7 @@ void SchurComplement::vmult (Vector<double>       &dst,
 In this code, the constructor takes a reference to a block sparse matrix for
 the entire system, and a reference to an object representing the inverse of
 the mass matrix. It stores these using <code>SmartPointer</code> objects (see
-step-7), and additionally allocates two temporary vectors <code>tmp1</code> and
+@ref step_7 "step-7"), and additionally allocates two temporary vectors <code>tmp1</code> and
 <code>tmp2</code> for the vectors labeled $w,y$ in the list above.
 
 In the matrix-vector multiplication function, the product $Sv$ is performed in

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.