From c0f9e3daf66eb7e5be6560fc57408bcef78143fe Mon Sep 17 00:00:00 2001
From: Daniel Arndt .templates.h
file. We #include it into the .cc
file
+.templates.h
file. We \#include it into the .cc
file
and instantiate the functions for all of the common arguments. For almost all
users, this will be just fine -- they only use the (vector, matrix, ...) types
we already instantiate, and for them the .templates.h
file will not
be of any interest. It will also not slow down their compilations because
-nothing they see will #include the .templates.h
file. But users who
+nothing they see will \#include the .templates.h
file. But users who
define their own (vector, matrix, ...) types can instantiate the template
functions with their own user-defined types by including the
.templates.h
files.
@@ -238,8 +238,8 @@ functions with their own user-defined types by including the
#ifndef
-DOXYGEN ... #endif
to prevent Doxygen from picking them up.\#ifndef
+DOXYGEN ... \#endif
to prevent Doxygen from picking them up.
diff --git a/doc/doxygen/headers/glossary.h b/doc/doxygen/headers/glossary.h
index 631b410fb6..13ad568a15 100644
--- a/doc/doxygen/headers/glossary.h
+++ b/doc/doxygen/headers/glossary.h
@@ -374,8 +374,6 @@
* parallel::distributed::Triangulation .
*
*
- * @see @ref boundary "The module on boundaries".
- *
*
*
diff --git a/doc/doxygen/headers/matrixfree.h b/doc/doxygen/headers/matrixfree.h
index 352c0fba15..cbc9fe88d6 100644
--- a/doc/doxygen/headers/matrixfree.h
+++ b/doc/doxygen/headers/matrixfree.h
@@ -301,7 +301,7 @@ digraph G
* access is thus not linear. Furthermore, the support for multi-component
* systems becomes transparent if we provide a start index to every
* single component separately. Thus, the `row_starts` field is of length
- * `n_cell_batches()*VectorizedArray
- Improved: PreconditionBlockSOR
::Tvmult(...)
is implemented.
+ Improved: PreconditionBlockSOR::Tvmult()
is implemented.
(GK 2000/07/07)
- New: Function VectorTools
::compute_mean_value
integrates the mean
- value of one component of a finite element function.
+ New: Function VectorTools::compute_mean_value()
integrates
+ the mean value of one component of a finite element function.
(GK 2000/07/12)
- New: FE*Values::get_quadrature
- returns a reference to the quadrature formula used by a
+ New: FEValues::get_quadrature()
and
+ FEFaceValuesBase::get_quadrature()
+ return a reference to the quadrature formula used by a
FEValues object.
(WB 2001/06/21)
diff --git a/doc/news/3.4.0-vs-4.0.0.h b/doc/news/3.4.0-vs-4.0.0.h
index d232304d95..a1a99846af 100644
--- a/doc/news/3.4.0-vs-4.0.0.h
+++ b/doc/news/3.4.0-vs-4.0.0.h
@@ -156,7 +156,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
Changed: Previously, we just set the preprocessor variable
DEAL_II_USE_MT
, when --with-multithreading
was
given as argument to ./configure
. Tests in the code
- therefore looked like #ifdef DEAL_II_USE_MT
. This has been
+ therefore looked like \#ifdef DEAL_II_USE_MT
. This has been
changed so that the variable is always defined, but its value is now
equal to 1
when multithreading was requested, and zero otherwise. The reason for
@@ -164,8 +164,8 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
conditions, and need not interleave if-else clauses from regular code
and the preprocessor, if conditions involve both the state of this
preprocessor variable and the run-time state of your program. However,
- this change requires that all appearances of #ifdef
- DEAL_II_USE_MT
be changed to #if DEAL_II_USE_MT ==
+ this change requires that all appearances of
\#ifdef
+ DEAL_II_USE_MT
be changed to \#if DEAL_II_USE_MT ==
1
, since the variable is now defined unconditionally.
(WB 2002/11/14)
@@ -190,7 +190,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
- Fixed: On CygWin, one header files has a #define quad
+ Fixed: On CygWin, one header files has a
\#define quad
quad_t
. This is annoying, since we have local variables and
member functions with the name quad
, and in fact it breaks
compilation on those versions of CygWin that has this. Fortunately, the
@@ -492,7 +492,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
Changed: The class Table<2>::fill
function, which is also
+ class="member">Table::fill() function, which is also
inherited from the FullMatrix
class, used to
work also when the size of the matrix was zero, by simply not copying
something. This led to difficult to detect errors. It is therefore no
@@ -1276,7 +1276,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
class="member">Triangulation<1>::n_quads now returns 0,
instead of throwing an assertion, as before. The same holds for
similar functions like Triangulation<dim>::n_hexs
that now
+ class="member">Triangulation::n_hexs that now
returns 0 for dim<3
.
(RH 2002/06/14)
diff --git a/doc/news/4.0.0-vs-5.0.0.h b/doc/news/4.0.0-vs-5.0.0.h
index 337b9ecabf..148c1968e9 100644
--- a/doc/news/4.0.0-vs-5.0.0.h
+++ b/doc/news/4.0.0-vs-5.0.0.h
@@ -73,7 +73,7 @@ inconvenience this causes.
elements of a matrix or vector to zero without changing its size, the
recommended way is to use the more obvious notation vector=0
and matrix=0
. To
reset the elements of a table over arbitrary objects, use
- Table<T>::reset_values()
.
+ Table::reset_values()
.
(WB 2004/05/10)
Moved and changed: The header file
include/numerics/dof_renumbering.h has been moved to the
directory include/dofs, where it logically
- belongs. Furthermore, the sorting parameter of the function DoFRenumbering
::component_wise
has changed its meaning. See
- the reference documentation for details.
+ belongs. Furthermore, the sorting parameter of the function
+ DoFRenumbering::component_wise()
has changed its meaning.
+ See the reference documentation for details.
(GK 2003/07/03)
Fixed: DataOutBase<2,3>::write_tecplot
+ class="member">DataOutBase::write_tecplot for dim=2 and spacedim=3
sometimes did not write the variable name z
when
only outputting faces of cells. This is now fixed.
diff --git a/doc/news/5.2.0-vs-6.0.0.h b/doc/news/5.2.0-vs-6.0.0.h
index 2c8461135f..6015d6379c 100644
--- a/doc/news/5.2.0-vs-6.0.0.h
+++ b/doc/news/5.2.0-vs-6.0.0.h
@@ -736,9 +736,9 @@ inconvenience this causes.
- Fixed: DataOutBase<2,3>::write_tecplot_binary
- did not write the z
coordinates. This is now
- fixed.
+ Fixed: DataOutBase::write_tecplot_binary()
with
+ dim=2 and spacedim=3 did not write the z
coordinates.
+ This is now fixed.
(RH 2005/09/28)
Fixed: A local variable in
- TriaAccessor<3,3>::measure
was
+ TriaAccessor::measure()
was
erroneously marked as static could lead to
wrong results and crashes in multithreaded mode. This is now fixed.
@@ -1382,10 +1382,13 @@ inconvenience this causes.
Extended: DerivativeApproximation
now offers access to the
full tensor of derivatives of orders one, two and three. This
- information can be requested for a single cell by means of the DerivativeApproximation
::approximate_derivative_tensor
function. If the
- norm of this tensor is required later on, the new DerivativeApproximation
::derivative_norm
function can be used. Note, that
- for second order derivatives, this returns the largest eigenvalue
- instead of the Frobenius norm, which is returned by the Tensor<rank_,dim>
::norm
function.
+ information can be requested for a single cell by means of the
+ DerivativeApproximation::approximate_derivative_tensor()
+ function. If the norm of this tensor is required later on, the new
+ DerivativeApproximation::derivative_norm()
function can be
+ used. Note, that for second order derivatives, this returns the largest
+ eigenvalue instead of the Frobenius norm, which is returned by the
+ Tensor::()norm
function.
(Tobias Leicht 2006/08/03)
- Fixed: Triangulation<dim>::fix_coarsen_flags
+ Fixed: Triangulation::fix_coarsen_flags()
has been modified to allow coarsening in all possible cases. Up
to now, coarsening was forbidden, if the neighbor cell was not refined
but had the refine_flag
set, whereas it was allowed, if
@@ -1705,8 +1708,7 @@ inconvenience this causes.
- New: The GridIn<dim>::read_netcdf(string
- &filename)
function reads grids from NetCDF files. The
+ New: The GridIn::read_netcdf()
function reads grids from NetCDF files. The
only data format currently supported is the TAU grid
format.
@@ -1714,7 +1716,7 @@ inconvenience this causes.
- Fixed: The GridIn<dim>::read(filename, format)
+ Fixed: The GridIn::read()
function ran into an exception when called with
Default format and a filename which does not include
/. This is now fixed.
diff --git a/doc/news/8.0.0-vs-8.1.0.h b/doc/news/8.0.0-vs-8.1.0.h
index a0e3817556..5535b6d2c5 100644
--- a/doc/news/8.0.0-vs-8.1.0.h
+++ b/doc/news/8.0.0-vs-8.1.0.h
@@ -336,7 +336,7 @@ inconvenience this causes.
(Matthias Maier, 2013/11/20)
[...]/include/deal.II
. Thus it is now mandatory to prefix
all includes of deal.II headers with deal.II/
, i.e.
- #include <deal.II/[...]>
.
+ \#include <deal.II/[...]>
.
optimize_diagonal
argument.
@@ -1060,7 +1060,7 @@ inconvenience this causes.
(Wolfgang Bangerth, 2015/01/16)
-