+ New: Long requested but never implemented before in the
+ library: there is now a function GridTool::find_active_cell_around_point
that, given a point, finds the active cell in which this point
lies.
diff --git a/include/deal.II/algorithms/theta_timestepping.h b/include/deal.II/algorithms/theta_timestepping.h
index f6a30bc600..42c85e92e9 100644
--- a/include/deal.II/algorithms/theta_timestepping.h
+++ b/include/deal.II/algorithms/theta_timestepping.h
@@ -351,7 +351,7 @@ namespace Algorithms
* where f is the dual space vector found in the "Previous
* time" entry of the input data, M the mass matrix,
* F the operator in space and c is the adjusted
- * time step size \f$ \theta \Delta t\f$
+ * time step size $ \theta \Delta t$
*/
SmartPointer, ThetaTimestepping > op_implicit;
diff --git a/include/deal.II/base/time_stepping.h b/include/deal.II/base/time_stepping.h
index 6d656e6fa0..b0b8e7c11c 100644
--- a/include/deal.II/base/time_stepping.h
+++ b/include/deal.II/base/time_stepping.h
@@ -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
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.
*/
diff --git a/include/deal.II/grid/manifold.h b/include/deal.II/grid/manifold.h
index b020a43e8d..ad79cd4f2e 100644
--- a/include/deal.II/grid/manifold.h
+++ b/include/deal.II/grid/manifold.h
@@ -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}}
diff --git a/include/deal.II/numerics/vector_tools.h b/include/deal.II/numerics/vector_tools.h
index d88087d583..07f74c317f 100644
--- a/include/deal.II/numerics/vector_tools.h
+++ b/include/deal.II/numerics/vector_tools.h
@@ -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