]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Fix doxygen markup.
authorbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 19 Oct 2010 12:47:10 +0000 (12:47 +0000)
committerbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 19 Oct 2010 12:47:10 +0000 (12:47 +0000)
git-svn-id: https://svn.dealii.org/trunk@22386 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/deal.II/include/integrators/laplace.h
deal.II/deal.II/include/integrators/local_integrators.h

index 1b26578d5a5b27c7158aa9846417512d4f59625f..fd39122aedbfab436b62e10e3d893ed9bfe4b986 100644 (file)
@@ -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;k<fe.n_quadrature_points;++k)
        {
          const double dx = fe.JxW(k) * factor;
@@ -74,7 +74,7 @@ namespace LocalIntegrators
  * \int_F \Bigl(\gamma u v - \partial_n u v - u \partial_n v\Bigr)\;ds.
  * @f]
  *
- * Here, &gamma; is the <tt>penalty</tt> parameter suitably computed
+ * Here, $\gamma$ is the <tt>penalty</tt> 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;k<fe.n_quadrature_points;++k)
        {
          const double dx = fe.JxW(k) * factor;
@@ -117,7 +117,7 @@ namespace LocalIntegrators
  * Here, <i>u</i> is the finite element function whose values and
  * gradient are given in the arguments <tt>input</tt> and
  * <tt>Dinput</tt>, respectively. <i>g</i> is the inhomogeneous
- * boundary value in the argument <tt>data</tt>. &gamma; is the usual
+ * boundary value in the argument <tt>data</tt>. $\gamma$ is the usual
  * penalty parameter.
  */
       template <int dim>
@@ -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<fe.n_quadrature_points;++k)
          {
            const double dx = factor * fe.JxW(k);
@@ -149,7 +149,7 @@ namespace LocalIntegrators
                  const double v= fe.shape_value_component(i,k,d);
                  const double u= input[d][k];
                  const double g= data[d][k];
-                 
+
                  result(i) += dx*(2.*penalty*(u-g)*v - dnv*(u-g) - dnu*v);
                }
          }
@@ -195,10 +195,10 @@ namespace LocalIntegrators
       AssertDimension(M21.m(), n_dofs);
       AssertDimension(M22.n(), n_dofs);
       AssertDimension(M22.m(), n_dofs);
-       
+
       const double nui = factor1;
       const double nue = (factor2 < 0) ? factor1 : factor2;
-       
+
       for (unsigned k=0;k<fe1.n_quadrature_points;++k)
        {
          const double dx = fe1.JxW(k);
@@ -217,7 +217,7 @@ namespace LocalIntegrators
                      const double dnui = n * fe1.shape_grad(j,k);
                      const double ue = fe2.shape_value(j,k);
                      const double dnue = n * fe2.shape_grad(j,k);
-                       
+
                      M11(i,j) += dx*(-.5*nui*dnvi*ui-.5*nui*dnui*vi+penalty*ui*vi);
                      M12(i,j) += dx*( .5*nui*dnvi*ue-.5*nue*dnue*vi-penalty*vi*ue);
                      M21(i,j) += dx*(-.5*nue*dnve*ui+.5*nui*dnui*ve-penalty*ui*ve);
@@ -234,7 +234,7 @@ namespace LocalIntegrators
                        const double dnui = n * fe1.shape_grad_component(j,k,d);
                        const double ue = fe2.shape_value_component(j,k,d);
                        const double dnue = n * fe2.shape_grad_component(j,k,d);
-                         
+
                        M11(i,j) += dx*(-.5*nui*dnvi*ui-.5*nui*dnui*vi+penalty*ui*vi);
                        M12(i,j) += dx*( .5*nui*dnvi*ue-.5*nue*dnue*vi-penalty*vi*ue);
                        M21(i,j) += dx*(-.5*nue*dnve*ui+.5*nui*dnui*ve-penalty*ui*ve);
index 2a05d39d40520f6e7a128f36515610b009cdcec0..bbd5c1881b37760186787a0feffe5f0d6da38b92 100644 (file)
@@ -46,7 +46,7 @@ DEAL_II_NAMESPACE_OPEN
  *
  * Functions in this namespace follow a generic signature. In the
  * simplest case, you have two related functions
- * \begin{code}
+ * @code
  *   template <int dim>
  *   void
  *   cell_matrix (
@@ -61,7 +61,7 @@ DEAL_II_NAMESPACE_OPEN
  *     const FEValuesBase<dim>& fe,
  *     const std::vector<Tensor<1,dim> >& input,
  *     const double factor = 1.);
- * \end{code}
+ * @endcode
  *
  * There is typically a pair of functions for the same operator, the
  * function <tt>cell_residual</tt> implementing the mapping of the
@@ -73,7 +73,7 @@ DEAL_II_NAMESPACE_OPEN
  * <ul>
  * <li> FullMatrix&lt;double&gt; for matrices
  * <li> BlockVector&ltdouble&gt; for vectors
- * </li>
+ * </ul>
  *
  * 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 <int dim>
@@ -116,7 +116,7 @@ void MatrixIntegrator<dim>::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

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.