From: Wolfgang Bangerth Date: Fri, 10 Jan 2025 21:04:14 +0000 (-0700) Subject: Fix several more mark-up problems. X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=refs%2Fpull%2F208%2Fhead;p=code-gallery.git Fix several more mark-up problems. --- diff --git a/CeresFE/support_code/local_math.h b/CeresFE/support_code/local_math.h index 8817258..6ed66a1 100644 --- a/CeresFE/support_code/local_math.h +++ b/CeresFE/support_code/local_math.h @@ -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) //{ diff --git a/Distributed_Moving_Laser_Heating/README.md b/Distributed_Moving_Laser_Heating/README.md index b152101..4533371 100644 --- a/Distributed_Moving_Laser_Heating/README.md +++ b/Distributed_Moving_Laser_Heating/README.md @@ -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 - - +``` @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} } - - +``` diff --git a/MultipointFluxMixedFiniteElementMethods/mfmfe.cc b/MultipointFluxMixedFiniteElementMethods/mfmfe.cc index d5e6411..4896d99 100644 --- a/MultipointFluxMixedFiniteElementMethods/mfmfe.cc +++ b/MultipointFluxMixedFiniteElementMethods/mfmfe.cc @@ -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 ExactSolution // class implementation to avoid exceptions. The only noteworthy thing here diff --git a/NavierStokes_TRBDF2_DG/equation_data.h b/NavierStokes_TRBDF2_DG/equation_data.h index 6e9d651..1667d7d 100644 --- a/NavierStokes_TRBDF2_DG/equation_data.h +++ b/NavierStokes_TRBDF2_DG/equation_data.h @@ -13,7 +13,7 @@ #include #include -// @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 // diff --git a/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc b/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc index 5f02899..9efb708 100644 --- a/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc +++ b/NavierStokes_TRBDF2_DG/navier_stokes_TRBDF2_DG.cc @@ -230,7 +230,7 @@ namespace NS_TRBDF2 { }; - // @sect{ NavierStokesProjectionOperator::NavierStokesProjectionOperator } + // @sect3{ NavierStokesProjectionOperator::NavierStokesProjectionOperator } // 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 NavierStokesProjection class} + // @sect3{The NavierStokesProjection 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{NavierStokesProjection::compute_lift_and_drag} + // @sect3{NavierStokesProjection::compute_lift_and_drag} // 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{ NavierStokesProjection::refine_mesh} + // @sect3{ NavierStokesProjection::refine_mesh} // 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{ NavierStokesProjection::run } + // @sect3{ NavierStokesProjection::run } // This is the time marching function, which starting at t_0 // advances in time using the projection method with time step dt @@ -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 diff --git a/NavierStokes_TRBDF2_DG/runtime_parameters.h b/NavierStokes_TRBDF2_DG/runtime_parameters.h index 437427e..fd11721 100644 --- a/NavierStokes_TRBDF2_DG/runtime_parameters.h +++ b/NavierStokes_TRBDF2_DG/runtime_parameters.h @@ -12,7 +12,7 @@ // #include -// @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. diff --git a/Nonlinear_PoroViscoelasticity/nonlinear-poro-viscoelasticity.cc b/Nonlinear_PoroViscoelasticity/nonlinear-poro-viscoelasticity.cc index b81cf8a..ff91d43 100644 --- a/Nonlinear_PoroViscoelasticity/nonlinear-poro-viscoelasticity.cc +++ b/Nonlinear_PoroViscoelasticity/nonlinear-poro-viscoelasticity.cc @@ -1588,7 +1588,7 @@ namespace NonLinearPoroViscoElasticity std::vector 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 ) + //Gauss Points in element, with n quadrature points (in each of the dim space directions) const QGauss qf_cell; //Gauss Points on element faces (used for definition of BCs) const QGauss qf_face; diff --git a/Quasi_static_Finite_strain_Compressible_Elasticity/README.md b/Quasi_static_Finite_strain_Compressible_Elasticity/README.md index c786ef8..a44a64f 100644 --- a/Quasi_static_Finite_strain_Compressible_Elasticity/README.md +++ b/Quasi_static_Finite_strain_Compressible_Elasticity/README.md @@ -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 :---------------: | :-------------: | :-------------: diff --git a/TravelingWaves/README.md b/TravelingWaves/README.md index b65a3d6..83ce184 100644 --- a/TravelingWaves/README.md +++ b/TravelingWaves/README.md @@ -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.