From 7736ae104d6d3ca798e76bf91bb3e95e5ecce61c Mon Sep 17 00:00:00 2001 From: bangerth Date: Tue, 19 Oct 2010 12:47:10 +0000 Subject: [PATCH] Fix doxygen markup. git-svn-id: https://svn.dealii.org/trunk@22386 0785d39b-7218-0410-832d-ea1e28bc413d --- deal.II/deal.II/include/integrators/laplace.h | 22 +++++++++---------- .../include/integrators/local_integrators.h | 10 ++++----- 2 files changed, 16 insertions(+), 16 deletions(-) diff --git a/deal.II/deal.II/include/integrators/laplace.h b/deal.II/deal.II/include/integrators/laplace.h index 1b26578d5a..fd39122aed 100644 --- a/deal.II/deal.II/include/integrators/laplace.h +++ b/deal.II/deal.II/include/integrators/laplace.h @@ -55,7 +55,7 @@ namespace LocalIntegrators { const unsigned int n_dofs = fe.dofs_per_cell; const unsigned int n_components = fe.get_fe().n_components(); - + for (unsigned k=0;kpenalty parameter suitably computed + * Here, $\gamma$ is the penalty parameter suitably computed * with compute_penalty(). * * @author Guido Kanschat @@ -89,10 +89,10 @@ namespace LocalIntegrators { const unsigned int n_dofs = fe.dofs_per_cell; const unsigned int n_comp = fe.get_fe().n_components(); - + Assert (M.m() == n_dofs, ExcDimensionMismatch(M.m(), n_dofs)); Assert (M.n() == n_dofs, ExcDimensionMismatch(M.n(), n_dofs)); - + for (unsigned k=0;ku is the finite element function whose values and * gradient are given in the arguments input and * Dinput, respectively. g is the inhomogeneous - * boundary value in the argument data. γ is the usual + * boundary value in the argument data. $\gamma$ is the usual * penalty parameter. */ template @@ -136,7 +136,7 @@ namespace LocalIntegrators AssertVectorVectorDimension(input, n_comp, fe.n_quadrature_points); AssertVectorVectorDimension(Dinput, n_comp, fe.n_quadrature_points); AssertVectorVectorDimension(data, n_comp, fe.n_quadrature_points); - + for (unsigned k=0;k * void * cell_matrix ( @@ -61,7 +61,7 @@ DEAL_II_NAMESPACE_OPEN * const FEValuesBase& fe, * const std::vector >& input, * const double factor = 1.); - * \end{code} + * @endcode * * There is typically a pair of functions for the same operator, the * function cell_residual implementing the mapping of the @@ -73,7 +73,7 @@ DEAL_II_NAMESPACE_OPEN *
    *
  • FullMatrix<double> for matrices *
  • BlockVector<double> for vectors - *
  • + *
* * The next argument is the FEValuesBase object representing the * finite element for integration. If the integrated operator maps @@ -104,7 +104,7 @@ DEAL_II_NAMESPACE_OPEN * * With these matrices, the function called by MeshWorker::loop() * could be written like - * \begin{code} + * @code using namespace ::dealii:: LocalIntegrators; template @@ -116,7 +116,7 @@ void MatrixIntegrator::cell( Differential::div_primal_matrix(dinfo.matrix(1,false).matrix, info.fe_values(0), info.fe_values(1)); L2::cell_matrix(dinfo.matrix(2,false).matrix, info.fe_values(1)); } - * \end{code} + * @endcode * See step-42 for a worked out example of this code. */ namespace LocalIntegrators -- 2.39.5