]> https://gitweb.dealii.org/ - dealii.git/commitdiff
step-57: Use blank lines after equations. 7391/head
authorDavid Wells <drwells@email.unc.edu>
Sat, 27 Oct 2018 20:17:36 +0000 (16:17 -0400)
committerDavid Wells <drwells@email.unc.edu>
Sat, 27 Oct 2018 20:17:36 +0000 (16:17 -0400)
This improves pagination.

examples/step-57/doc/intro.dox

index d16ed6a45b6e00d5714042b357764bfea70af2d5..76b4fd629f36c8663186a44fcb68b04dd0bd2b53 100644 (file)
@@ -22,7 +22,6 @@ is assumed to be steady. In a domain $\Omega \subset
 $\partial \Omega$, and a given force field $\textbf{f}$, we seek
 a velocity field $\textbf{u}$ and a pressure field $\textbf{p}$
 satisfying
-
 @f{eqnarray*}
 - \nu \Delta\textbf{u} + (\textbf{u} \cdot \nabla)\textbf{u} + \nabla p &=& \textbf{f}\\
 - \nabla \cdot \textbf{u} &=& 0.
@@ -39,7 +38,6 @@ solve is necessary.
 <h3> Linearization of Navier-Stokes Equations </h3>
 
 We define a nonlinear function whose root is a solution to the NSE by
-
 @f{eqnarray*}
 F(\mathbf{u}, p) =
   \begin{pmatrix}
@@ -55,8 +53,8 @@ can be defined as
 @f{eqnarray*}
   \textbf{x}^{k+1} = \textbf{x}^{k} - (\nabla F(\textbf{x}^{k}))^{-1} F(\textbf{x}^{k}),
 @f}
-where
-$\textbf{x}^{k+1}$ is the approximate solution in step $k+1$,
+
+where $\textbf{x}^{k+1}$ is the approximate solution in step $k+1$,
 $\textbf{x}^{k}$ represents the solution from the previous step, and $\nabla
 F(\textbf{x}^{k})$ is the Jacobian matrix evaluated at
 $\textbf{x}^{k}$.
@@ -66,20 +64,20 @@ The Newton iteration formula implies the new
 solution is obtained by adding an update term to the old solution. Instead
 of evaluating the Jacobian matrix and taking its inverse, we consider
 the update term as a whole, that is
-
 @f{eqnarray*}
   \delta \textbf{x}^{k} = - (\nabla F(\textbf{x}^{k}))^{-1} F(\textbf{x}^{k}),
 @f}
+
 where $\textbf{x}^{k+1}=\textbf{x}^{k}+\delta \textbf{x}^{k}$.
 
 We can find the update term by solving the system
 @f{eqnarray*}
   \nabla F(\textbf{x}^{k}) \delta \textbf{x}^{k} = -F(\textbf{x}^{k}).
 @f}
+
 Here, the left of the previous equation represents the
 directional gradient of $F(\textbf{x})$ along $\delta
 \textbf{x}^{k}$ at $\textbf{x}^{k}$. By definition, the directional gradient is given by
-
 @f{eqnarray*}
   & &\nabla F(\mathbf{u}^{k}, p^{k}) (\delta \mathbf{u}^{k}, \delta p^{k}) \\
   \\
@@ -110,7 +108,6 @@ directional gradient of $F(\textbf{x})$ along $\delta
 @f}
 
 Therefore, we arrive at the linearized system:
-
 @f{eqnarray*}
    -\nu \Delta \delta \mathbf{u}^{k}
   + \mathbf{u}^{k} \cdot \nabla \delta \mathbf{u}^{k}
@@ -169,31 +166,28 @@ $\nu_{i}$ as the initial guess of the NSE with $\nu_{i+1}$. This can be thought
 as a staircase from the Stokes equations to the NSE we want to solve.
 
 That is, we first solve a Stokes problem
-
 @f{eqnarray*}
   -\nu_{1} \Delta \textbf{u} + \nabla p &=& \textbf{f}\\
   -\nabla \cdot \textbf{u} &=& 0
 @f}
 
 to get the initial guess for
-
 @f{eqnarray*}
   -\nu_{1} \Delta \textbf{u} + (\textbf{u} \cdot \nabla)\textbf{u} + \nabla p &=& \textbf{f},\\
   -\nabla \cdot \textbf{u} &=& 0,
 @f}
+
 which also acts as the initial guess of the continuation method.
 Here $\nu_{1}$ is relatively large so that the solution to the Stokes problem with viscosity $\nu_{1}$
 can be used as an initial guess for the NSE in Newton's iteration.
 
 Then the solution to
-
 @f{eqnarray*}
   -\nu_{i} \Delta \textbf{u} + (\textbf{u} \cdot \nabla)\textbf{u} + \nabla p &=& \textbf{f},\\
   -\nabla \cdot \textbf{u} &=& 0.
 @f}
 
 acts as the initial guess for
-
 @f{eqnarray*}
   -\nu_{i+1} \Delta \textbf{u} + (\textbf{u} \cdot \nabla)\textbf{u} + \nabla p &=& \textbf{f},\\
   -\nabla \cdot \textbf{u} &=& 0.
@@ -226,7 +220,6 @@ saddle point systems of the form
 This system matrix has the same block structure as the one in step-22. However,
 the matrix $A$ at the top left corner is not symmetric because of the nonlinear term.
 Instead of solving the above system, we can solve the equivalent system
-
 @f{eqnarray*}
     \begin{pmatrix}
       A + \gamma B^TW^{-1}B & B^{T} \\
@@ -242,13 +235,13 @@ Instead of solving the above system, we can solve the equivalent system
       0
     \end{pmatrix}
 @f}
+
 with a parameter $\gamma$ and an invertible matrix $W$. Here
 $\gamma B^TW^{-1}B$ is the Augmented Lagrangian term; see [1] for details.
 
 Denoting the system matrix of the new system by $G$ and the right-hand
 side by $b$, we solve it iteratively with right preconditioning
 $P^{-1}$ as $GP^{-1}y = b$, where
-
 @f{eqnarray*}
 P^{-1} =
   \begin{pmatrix}
@@ -261,14 +254,13 @@ with $\tilde{A} = A + \gamma B^TW^{-1}B$ and $\tilde{S}$ is the
 corresponding Schur complement $\tilde{S} = B^T \tilde{A}^{-1} B$. We
 let $W = M_p$ where $M_p$ is the pressure mass matrix, then
 $\tilde{S}^{-1}$ can be approximated by
-
 @f{eqnarray*}
 \tilde{S}^{-1} \approx -(\nu+\gamma)M_p^{-1}.
 @f}
+
 See [1] for details.
 
 We decompose $P^{-1}$ as
-
 @f{eqnarray*}
 P^{-1} =
   \begin{pmatrix}
@@ -300,7 +292,6 @@ M_p^{-1}B)_{ij}$, as explained in [2].
 We use the lid driven cavity flow as our test case; see [3] for details.
 The computational domain is the unit square and the right-hand side is
 $f=0$. The boundary condition is
-
 @f{eqnarray*}
   (u(x, y), v(x,y)) &=& (1,0) \qquad\qquad \textrm{if}\ y = 1 \\
   (u(x, y), v(x,y)) &=& (0,0) \qquad\qquad \textrm{otherwise}.

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.