]> https://gitweb.dealii.org/ - code-gallery.git/commitdiff
Fix several more mark-up problems. 208/head
authorWolfgang Bangerth <bangerth@colostate.edu>
Fri, 10 Jan 2025 21:04:14 +0000 (14:04 -0700)
committerWolfgang Bangerth <bangerth@colostate.edu>
Fri, 10 Jan 2025 21:04:14 +0000 (14:04 -0700)
CeresFE/support_code/local_math.h
Distributed_Moving_Laser_Heating/README.md
MultipointFluxMixedFiniteElementMethods/mfmfe.cc
NavierStokes_TRBDF2_DG/equation_data.h
NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc
NavierStokes_TRBDF2_DG/runtime_parameters.h
Nonlinear_PoroViscoelasticity/nonlinear-poro-viscoelasticity.cc
Quasi_static_Finite_strain_Compressible_Elasticity/README.md
TravelingWaves/README.md

index 881725811a32591ac69b12a1043b2a82a3eea6f8..6ed66a1f3ae06def6579f88d214c7841077dac75 100644 (file)
@@ -11,7 +11,6 @@
 #define PI 3.14159265358979323846
 #define TWOPI 6.283185307179586476925287
 #define SECSINYEAR 3.155692608e+07
-//#define ABS(a) ((a) < 0 ? -(a) : (a))
 
 //double factorial(int n)
 //{
index b15210194041ab911e625c7187464374830b94fe..45333712a6538e27b59f4d0306a9693670e276b6 100644 (file)
@@ -1,6 +1,6 @@
 
 # Introduction
-In this tutorial, the studied problem is to simulate temperature distributions of a sample under a moving laser. Light penetrates the substrate without loss. The top-covered thin-film is, however, a light absorbing material. For simplicity, the thin-film is assumed to be TiO$_2$ mixed with silver nanoparticles, which supports light heating of the material by absorbing light energy. For this tutorial, we only consider the isotropic absorption. Figure \ref{fgr:s1} illustrates the sketch of the problem. The absorption coefficient is assumed to be $10^4 m^{-1}$. The substrate is glass. The thickness of the thin-film is assumed to be 400 nm. The spot size at the top of thin film is $20 \mu m$ at $e^{-2}$. The writing speed is assumed to be 10 mm/s. The laser power is 0.4 W. The time step is set as 10 $\mu s$. The initial position of laser center is $-50 \mu m$ with 50 $\mu m$ distance away from the left boundary to avoid boundary effects.
+In this tutorial, the studied problem is to simulate temperature distributions of a sample under a moving laser. Light penetrates the substrate without loss. The top-covered thin-film is, however, a light absorbing material. For simplicity, the thin-film is assumed to be TiO$_2$ mixed with silver nanoparticles, which supports light heating of the material by absorbing light energy. For this tutorial, we only consider the isotropic absorption. The Figure below illustrates the sketch of the problem. The absorption coefficient is assumed to be $10^4 m^{-1}$. The substrate is glass. The thickness of the thin-film is assumed to be 400 nm. The spot size at the top of thin film is $20 \mu m$ at $e^{-2}$. The writing speed is assumed to be 10 mm/s. The laser power is 0.4 W. The time step is set as 10 $\mu s$. The initial position of laser center is $-50 \mu m$ with 50 $\mu m$ distance away from the left boundary to avoid boundary effects.
 
 ## Illustration of the problem
 
@@ -33,7 +33,7 @@ since the test function is time invariant (because the grid is not changed), we
     \int T T^{'}_{i} dV &= u_{i}
 @f}
 
-\noindent let 
+Let 
 @f{align*}
     M &= \int \rho C_m T^{'_i} T^{'_j} dV  \\
     A & = \int k \nabla T^{'_i} \cdot \nabla T^{'_j} dV \\
@@ -135,8 +135,7 @@ The colors stand for different cores.
 ![threads](./images/threads-2d.png)
 
 # References
-<code>
-       
+```    
 @article{ma2021numerical,
   title={Numerical study of laser micro-and nano-processing of nanocomposite porous materials},
   author={Ma, Hongfeng},
@@ -179,5 +178,4 @@ The colors stand for different cores.
   year={1947},
   organization={Cambridge University Press}
 }
-
-</code>
+```
index d5e64118c880f187784adf90038bac0c6cf957a5..4896d9904319450a25129776b403abaed1731237 100644 (file)
@@ -843,7 +843,7 @@ namespace MFMFE
 
   // The implementation of this function is almost identical to step-20.
   // We use @ref ComponentSelectFunction as masks to use the right
-  // solution component (velocity or pressure) and @ref integrate_difference
+  // solution component (velocity or pressure) and `integrate_difference()`
   // to compute the errors. Since we also want to compute Hdiv seminorm of the
   // velocity error, one must provide gradients in the <code>ExactSolution</code>
   // class implementation to avoid exceptions. The only noteworthy thing here
index 6e9d651edcf4ab174aab38fedc1027fbe50af020..1667d7d18eff280351f31b9328b2258f04613aab 100644 (file)
@@ -13,7 +13,7 @@
 #include <deal.II/base/point.h>
 #include <deal.II/base/function.h>
 
-// @sect{Equation data}
+// @sect3{Equation data}
 
 // In the next namespace, we declare and implement suitable functions that may be used for the initial and boundary conditions
 //
index 5f028993b592b06c7db2edb4cd1dee534a25c39c..9efb708e53d0a627b5a0f82b99d940cc20c351f3 100644 (file)
@@ -230,7 +230,7 @@ namespace NS_TRBDF2 {
   };
 
 
-  // @sect{ <code>NavierStokesProjectionOperator::NavierStokesProjectionOperator</code> }
+  // @sect3{ <code>NavierStokesProjectionOperator::NavierStokesProjectionOperator</code> }
 
   // The following class sets effectively the weak formulation of the problems for the different stages
   // and for both velocity and pressure.
@@ -2060,7 +2060,7 @@ namespace NS_TRBDF2 {
   }
 
 
-  // @sect{The <code>NavierStokesProjection</code> class}
+  // @sect3{The <code>NavierStokesProjection</code> class}
 
   // Now we are ready for the main class of the program. It implements the calls to the various steps
   // of the projection method for Navier-Stokes equations.
@@ -2633,7 +2633,7 @@ namespace NS_TRBDF2 {
   }
 
 
-  // @sect{<code>NavierStokesProjection::compute_lift_and_drag</code>}
+  // @sect3{<code>NavierStokesProjection::compute_lift_and_drag</code>}
 
   // This routine computes the lift and the drag forces in a non-dimensional framework
   // (so basically for the classical coefficients, it is necessary to multiply by a factor 2).
@@ -2708,7 +2708,7 @@ namespace NS_TRBDF2 {
   }
 
 
-  // @sect{ <code>NavierStokesProjection::refine_mesh</code>}
+  // @sect3{ <code>NavierStokesProjection::refine_mesh</code>}
 
   // After finding a good initial guess on the coarse mesh, we hope to
   // decrease the error through refining the mesh. We also need to transfer the current solution to the
@@ -2914,7 +2914,7 @@ namespace NS_TRBDF2 {
   }
 
 
-  // @sect{ <code>NavierStokesProjection::run</code> }
+  // @sect3{ <code>NavierStokesProjection::run</code> }
 
   // This is the time marching function, which starting at <code>t_0</code>
   // advances in time using the projection method with time step <code>dt</code>
@@ -3022,7 +3022,7 @@ namespace NS_TRBDF2 {
 } // namespace NS_TRBDF2
 
 
-// @sect{ The main function }
+// @sect3{ The main function }
 
 // The main function looks very much like in all the other tutorial programs. We first initialize MPI,
 // we initialize the class 'NavierStokesProjection' with the dimension as template parameter and then
index 437427e2e726a04f65b716a69fbdbf32ee02d760..fd1172166128b8aef5892c9375ce65fe5aff1c32 100644 (file)
@@ -12,7 +12,7 @@
 //
 #include <deal.II/base/parameter_handler.h>
 
-// @sect{Run time parameters}
+// @sect3{Run time parameters}
 //
 // Since our method has several parameters that can be fine-tuned we put them
 // into an external file, so that they can be determined at run-time.
index b81cf8acbf9b2ffd4e4a26e278ba88f460cd0ff7..ff91d433944840251fff8eaedbe8404b68f85346 100644 (file)
@@ -1588,7 +1588,7 @@ namespace NonLinearPoroViscoElasticity
             std::vector<types::global_dof_index>   element_indices_p_fluid;
 
             //Declare an instance of dealii QGauss class (The Gauss-Legendre family of quadrature rules for numerical integration)
-            //Gauss Points in element, with n quadrature points (in each space direction <dim> )
+            //Gauss Points in element, with n quadrature points (in each of the dim space directions)
             const QGauss<dim>                qf_cell;
             //Gauss Points on element faces (used for definition of BCs)
             const QGauss<dim - 1>            qf_face;
index c786ef879fb119664ea307200f13d57170922ba3..a44a64f647e32a188d1d4c394ff2da11e7337b44 100644 (file)
@@ -104,7 +104,7 @@ midway point on the traction surface for the compressible 3d case.
 Since the material is compressible, shear-locking is not exhibited by the
 beam for low-order elements.
 
-#### Number of degrees of freedom
+### Number of degrees of freedom
 
 Elements per edge |        Q1       |        Q2
 :---------------: | :-------------: | :-------------:
index b65a3d66218b9726cc2d665faf81402774545c93..83ce184685034c9126ff3c825785be96d30cff8c 100644 (file)
@@ -196,7 +196,7 @@ for the reaction-progress variable. The value in the interval $(0, 1)$ is chosen
 
 
 ### Boundary conditions
-In the numerical solution, the boundary conditions described in the [beginning](#problem) are imposed at the ends of the interval $I$. In addition, a homogeneous Neumann condition is applied to the function $d\lambda$ at the left boundary.
+In the numerical solution, the boundary conditions described in the beginning are imposed at the ends of the interval $I$. In addition, a homogeneous Neumann condition is applied to the function $d\lambda$ at the left boundary.
 
 
 ## Program
@@ -216,7 +216,7 @@ Decreasing the dissipation parameter $\delta$ leads to the appearance of large g
 
 
 ### Error estimation
-Integration of the [governing equations](#problem) over the real line gives the following relations:
+Integration of the governing equations over the real line gives the following relations:
 @f{align*}{
     u_l (1 - c) + \frac{\epsilon}{2} u_l^2 + \frac{\epsilon}{2} T_l &=  u_r (1 - c) + \frac{\epsilon}{2} u_r^2 + \frac{\epsilon}{2} T_r , \\
     T_l - u_l &= T_r - u_r + q.

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.