]> https://gitweb.dealii.org/ - dealii.git/commitdiff
fix several doxygen warnings 66/head
authorTimo Heister <timo.heister@gmail.com>
Thu, 7 Aug 2014 12:36:08 +0000 (08:36 -0400)
committerTimo Heister <timo.heister@gmail.com>
Thu, 7 Aug 2014 12:36:08 +0000 (08:36 -0400)
doc/news/3.2.0-vs-3.3.0.h
doc/news/4.0.0-vs-5.0.0.h
include/deal.II/algorithms/theta_timestepping.h
include/deal.II/base/time_stepping.h
include/deal.II/grid/manifold.h
include/deal.II/numerics/vector_tools.h

index 02c980b268b5800161a581930ea7f20fa57b5c6f..5694de1698f55caa05cdbb5b6c8c2ae84ff7918d 100644 (file)
@@ -68,8 +68,8 @@ All entries are signed with the names of the author.
        (GK 2001/12/07)
        </p>
 
-  <li> <p> Fixed: Previously, the $(INCLUDE) variable in Makefiles
-       included the values of the $INCLUDE environment variable. This
+  <li> <p> Fixed: Previously, the \$(INCLUDE) variable in Makefiles
+       included the values of the \$INCLUDE environment variable. This
        is not desirable, since the compiler evaluates that variable
        anyway and the Makefile variable has <code>-I</code> prefixed
        to all paths while the environment variable has not.
index 5dd3246bc01fb4a41e17488d108e0544ec64b168..0a42215dedb3167d2c5f11ba37ee5fc3833b2b59 100644 (file)
@@ -698,7 +698,19 @@ inconvenience this causes.
        <br>
        (GK 2003/11/28)
        </p>
-<code>FiniteElementData</code> has a function>tensor_degree()</code>, returning the degree of thesuitable for choosing a tensor product quadratureimplemented before in theis now a function <code>GridTool</code>::<code>find_active_cell_around_point</code>
+
+  <li> <p>
+       Improved: <code>FiniteElementData</code> has a function
+       <code>tensor_degree()</code>, returning the degree of the
+       polynomial space suitable for choosing a tensor product quadrature
+       formula. 
+       <br>
+       (GK 2003/11/28)
+       </p>
+
+  <li> <p>
+       New: Long requested but never implemented before in the
+       library: there is now a function <code>GridTool::find_active_cell_around_point</code>
        that, given a point, finds the active cell in which this point
        lies.
        <br>
index f6a30bc600d513b37797d8cc6649722d8f46f0a1..42c85e92e9f7660ab2cadcfd4c98ebd28cd38319 100644 (file)
@@ -351,7 +351,7 @@ namespace Algorithms
      * where <i>f</i> is the dual space vector found in the "Previous
      * time" entry of the input data, <i>M</i> the mass matrix,
      * <i>F</i> the operator in space and <i>c</i> is the adjusted
-     * time step size \f$ \theta \Delta t\f$
+     * time step size $ \theta \Delta t$
      */
     SmartPointer<Operator<VECTOR>, ThetaTimestepping<VECTOR> > op_implicit;
 
index 6d656e6fa0eb264d8ca6e457a18bc5c18f81656f..b0b8e7c11ce4bddc2d82ae2b5394209e807e0e14 100644 (file)
@@ -72,7 +72,7 @@ namespace TimeStepping
 
   /**
    * Abstract class for time stepping methods. These methods assume that the
-   * equation has the form: \f$ \frac{\partial y}{\partial t} = f(t,y) \f$.
+   * equation has the form: $ \frac{\partial y}{\partial t} = f(t,y) $.
    */
   template <typename VECTOR>
   class TimeStepping
@@ -85,12 +85,12 @@ namespace TimeStepping
 
     /**
      * Purely virtual function. This function is used to advance from time @p
-     * t to t+ @p delta_t. @p F is a vector of functions \f$ f(t,y) \f$ that should be
+     * t to t+ @p delta_t. @p F is a vector of functions $ f(t,y) $ that should be
      * integrated, the input parameters are the time t and the vector y and the
      * output is value of f at this point. @p J_inverse is a vector
      * functions that compute the inverse of the Jacobians associated to the
      * implicit problems. The input parameters are the
-     * time, \f$ \tau \f$, and a vector. The output is the value of function
+     * time, $ \tau $, and a vector. The output is the value of function
      * at this point. This function returns the time at the end of the
      * time step.
      */
@@ -135,12 +135,12 @@ namespace TimeStepping
     virtual void initialize(runge_kutta_method method) = 0;
     /**
      * This function is used to advance from time @p
-     * t to t+ @p delta_t. @p F is a vector of functions \f$ f(t,y) \f$ that should be
+     * t to t+ @p delta_t. @p F is a vector of functions $ f(t,y) $ that should be
      * integrated, the input parameters are the time t and the vector y and the
      * output is value of f at this point. @p J_inverse is a vector
      * functions that compute the inverse of the Jacobians associated to the
      * implicit problems. The input parameters are the
-     * time, \f$ \tau \f$, and a vector. The output is the value of function
+     * time, $ \tau $, and a vector. The output is the value of function
      * at this point. This function returns the time at the end of the
      * time step. When using Runge-Kutta methods, @p F and @ J_inverse can
      * only contain one element.
@@ -154,12 +154,12 @@ namespace TimeStepping
 
     /**
      * Purely virtual function. This function is used to advance from time @p t
-     * to t+ @p delta_t. @p f  is the function \f$ f(t,y) \f$ that should be
+     * to t+ @p delta_t. @p f  is the function $ f(t,y) $ that should be
      * integrated, the input parameters are the time t and the vector y and the
      * output is value of f at this point. @p id_minus_tau_J_inverse is a function
-     * that computes \f$ inv(I-\tau J)\f$ where \f$ I \f$ is the identity matrix,
-     * \f$ \tau \f$ is given, and \f$ J \f$ is the Jacobian \f$ \frac{\partial
-     * J}{\partial y} \f$. The input parameters are the time, \f$ \tau \f$, and
+     * that computes $ inv(I-\tau J)$ where $ I $ is the identity matrix,
+     * $ \tau $ is given, and $ J $ is the Jacobian $ \frac{\partial
+     * J}{\partial y} $. The input parameters are the time, $ \tau $, and
      * a vector. The output is the value of function at this point.
      * evolve_one_time_step returns the time at the end of the time step.
      */
@@ -221,12 +221,12 @@ namespace TimeStepping
 
     /**
      * This function is used to advance from time @p t to t+ @p delta_t. @p f
-     * is the function \f$ f(t,y) \f$ that should be integrated, the input
+     * is the function $ f(t,y) $ that should be integrated, the input
      * parameters are the time t and the vector y and the output is value of
      * f at this point. @p id_minus_tau_J_inverse is a function that computes
-     * \f$ inv(I-\tau J)\f$ where \f$ I \f$ is the identity matrix, \f$ \tau
-     * \f$ is given, and \f$ J \f$ is the Jacobian \f$ \frac{\partial
-     * J}{\partial y} \f$. The input parameter are the time, \f$ \tau \f$, and
+     * $ inv(I-\tau J)$ where $ I $ is the identity matrix, $ \tau
+     * $ is given, and $ J $ is the Jacobian $ \frac{\partial
+     * J}{\partial y} $. The input parameter are the time, $ \tau $, and
      * a vector. The output is the value of function at this point.
      * evolve_one_time_step returns the time at the end of the time step.
      */
@@ -312,12 +312,12 @@ namespace TimeStepping
 
     /**
      * This function is used to advance from time @p t to t+ @p delta_t. @p f
-     * is the function \f$ f(t,y) \f$ that should be integrated, the input
+     * is the function $ f(t,y) $ that should be integrated, the input
      * parameters are the time t and the vector y and the output is value of
      * f at this point. @p id_minus_tau_J_inverse is a function that computes
-     * \f$ inv(I-\tau J)\f$ where \f$ I \f$ is the identity matrix, \f$ \tau
-     * \f$ is given, and \f$ J \f$ is the Jacobian \f$ \frac{\partial
-     * J}{\partial y} \f$. The input parameters are the time, \f$ \tau \f$, and
+     * $ inv(I-\tau J)$ where $ I $ is the identity matrix, $ \tau
+     * $ is given, and $ J $ is the Jacobian $ \frac{\partial
+     * J}{\partial y} $. The input parameters are the time, $ \tau $, and
      * a vector. The output is the value of function at this point.
      * evolve_one_time_step returns the time at the end of the time step.
      */
@@ -455,12 +455,12 @@ namespace TimeStepping
 
     /**
      * This function is used to advance from time @p t to t+ @p delta_t. @p f
-     * is the function \f$ f(t,y) \f$ that should be integrated, the input
+     * is the function $ f(t,y) $ that should be integrated, the input
      * parameters are the time t and the vector y and the output is value of
      * f at this point. @p id_minus_tau_J_inverse is a function that computes
-     * \f$ inv(I-\tau J)\f$ where \f$ I \f$ is the identity matrix, \f$ \tau
-     * \f$ is given, and \f$ J \f$ is the Jacobian \f$ \frac{\partial
-     * J}{\partial y} \f$. The input parameters are the time, \f$ \tau \f$, and
+     * $ inv(I-\tau J)$ where $ I $ is the identity matrix, $ \tau
+     * $ is given, and $ J $ is the Jacobian $ \frac{\partial
+     * J}{\partial y} $. The input parameters are the time, $ \tau $, and
      * a vector. The output is the value of function at this point.
      * evolve_one_time_step returns the time at the end of the time step.
      */
index b020a43e8d11906b4404df0bb5e437b36ad76045..ad79cd4f2e2fc381e1b73f48332700e23e038adb 100644 (file)
@@ -353,7 +353,7 @@ private:
  *   This is an helper class which is useful when you have an explicit
  *   map from an Euclidean space of dimension chartdim to an Euclidean
  *   space of dimension spacedim which represents your manifold, i.e.,
- *   when your manifold \f$\mathcal{M}\f$ can be represented by a map
+ *   when your manifold $\mathcal{M}$ can be represented by a map
  *   \f[
  *   F: \mathcal{B} \subset R^{\text{chartdim}} \mapsto \mathcal{M}
  *   \subset R^{\text{spacedim}}
index d88087d583268d2a6b040d345a7f93da02ca7891..07f74c317f19dd1c76ecb5f4d15e0d4b83b4b43a 100644 (file)
@@ -1127,7 +1127,7 @@ namespace VectorTools
    *   of degrees of freedom.
    * @param boundary_functions A map from boundary indicators to pointers to functions
    *   that describe the desired values on those parts of the boundary marked
-   *   with this boundary indicator (see @GlossBoundaryIndicator "Boundary indicator").
+   *   with this boundary indicator (see @ref GlossBoundaryIndicator "Boundary indicator").
    *   The projection happens on only those parts of the boundary whose indicators
    *   are represented in this map.
    * @param q The face quadrature used in the integration necessary to compute the

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.