]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Fix doc entries
authorDaniel Arndt <arndtd@ornl.gov>
Sun, 12 Apr 2020 23:04:42 +0000 (19:04 -0400)
committerDaniel Arndt <arndtd@ornl.gov>
Fri, 17 Apr 2020 16:21:12 +0000 (12:21 -0400)
13 files changed:
doc/doxygen/headers/coding_conventions.h
doc/doxygen/headers/glossary.h
doc/doxygen/headers/matrixfree.h
doc/news/3.0.0-vs-3.1.0.h
doc/news/3.1.0-vs-3.2.0.h
doc/news/3.4.0-vs-4.0.0.h
doc/news/4.0.0-vs-5.0.0.h
doc/news/5.0.0-vs-5.1.0.h
doc/news/5.2.0-vs-6.0.0.h
doc/news/8.0.0-vs-8.1.0.h
doc/news/8.2.1-vs-8.3.0.h
doc/news/9.0.0-vs-9.0.1.h
doc/news/9.0.1-vs-9.1.0.h

index 7ff9a6661d42ab3e5269f12aa51dfc75a6f3c9d5..f60776098627d507b6267641645349088fc3fef3 100644 (file)
@@ -225,12 +225,12 @@ instantiate these functions for any other template arguments anyway. </li>
 <li> If we can not enumerate all possible template arguments (e.g., vector
 types -- because users might want to define their own vector kinds) but at
 least know a few common usage cases, then the function is put into a
-<code>.templates.h</code> file. We #include it into the <code>.cc</code> file
+<code>.templates.h</code> file. We \#include it into the <code>.cc</code> 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 <code>.templates.h</code> file will not
 be of any interest. It will also not slow down their compilations because
-nothing they see will #include the <code>.templates.h</code> file. But users who
+nothing they see will \#include the <code>.templates.h</code> file. But users who
 define their own (vector, matrix, ...) types can instantiate the template
 functions with their own user-defined types by including the
 <code>.templates.h</code> files.
@@ -238,8 +238,8 @@ functions with their own user-defined types by including the
 <li> Finally, if we can not assume in advance which values template arguments
 will take (e.g., any class derived from Subscriptor can be used as an argument),
 the definitions of functions are provided at the bottom of the header
-file with declarations. The definitions should be guarded with <code>#ifndef
-DOXYGEN ... #endif</code> to prevent Doxygen from picking them up.</li>
+file with declarations. The definitions should be guarded with <code>\#ifndef
+DOXYGEN ... \#endif</code> to prevent Doxygen from picking them up.</li>
 
 </ol>
 
index 631b410fb6be9be33f7013caba6379079bc7f04d..13ad568a1552bf20e947ad76a1bab2f5bf18391b 100644 (file)
  * parallel::distributed::Triangulation .
  * </dd>
  *
- * @see @ref boundary "The module on boundaries".
- *
  *
  * <dt class="glossary">@anchor GlossCoarseMesh <b>Coarse mesh</b></dt>
  * <dd>
  * </dd>
  *
  *
- * <dt class="glossary">@anchor GlossDimension <b>Dimensions @p dim and @p spacedim</b></dt>
+ * <dt class="glossary">@anchor GlossDimension <b>Dimensions `dim` and `spacedim`</b></dt>
  *
  * <dd> Many classes and functions in deal.II have two template parameters,
  * @p dim and @p spacedim. An example is the basic Triangulation class:
  *   template <int dim, int spacedim=dim>
  *   class Triangulation {...};
  * @endcode
- * In all of these contexts where you see @p dim and @p spacedim referenced,
+ * In all of these contexts where you see `dim` and `spacedim` referenced,
  * these arguments have the following meaning:
  *
  * <ul>
index 352c0fba15afef7f521102542aeb0708cb35e3db..cbc9fe88d6aac4b3a16e34696fa172919ed16fc2 100644 (file)
@@ -301,7 +301,7 @@ digraph G
  * access is thus not linear. Furthermore, the support for multi-component
  * systems becomes transparent if we provide a <i>start index</i> to every
  * single component separately. Thus, the `row_starts` field is of length
- * `n_cell_batches()*VectorizedArray<Number>::size()*n_components`.
+ * `n_cell_batches()*VectorizedArray<Number>::%size()*n_components`.
  * </li>
  * <li> The translation between components within a system of multiple base
  * elements is controlled by the four variables
index 2f0602b5f202fe7cb363d77f1675f23fcc299901..1650b331f7d11bfb3a692df6b6bf1f2c70fefd51 100644 (file)
@@ -356,8 +356,7 @@ All entries are signed with the names of the author.
        </p>
 
   <li> <p>
-       Improved: <code>PreconditionBlockSOR</code><code
-       class="member">::Tvmult(...)</code> is implemented.
+       Improved: <code>PreconditionBlockSOR::Tvmult()</code> is implemented.
        <br>
        (GK 2000/07/07)
        </p>
@@ -834,9 +833,8 @@ All entries are signed with the names of the author.
        </p>
 
   <li> <p>
-       New: Function <code>VectorTools</code><code
-       class="member">::compute_mean_value</code> integrates the mean
-       value of one component of a finite element function.
+       New: Function <code>VectorTools::compute_mean_value()</code> integrates
+       the mean value of one component of a finite element function.
        <br>
        (GK 2000/07/12)
        </p>
index d60602470798117796db3eb1baf909c6b610585e..56dfcc2153498183fbfa6d26337a1028d46f4a52 100644 (file)
@@ -704,8 +704,9 @@ All entries are signed with the names of the author.
        </p>
 
   <li> <p>
-       New: <code>FE*Values::get_quadrature</code>
-       returns a reference to the quadrature formula used by a
+       New: <code>FEValues::get_quadrature()</code> and
+       <code>FEFaceValuesBase::get_quadrature()</code>
+       return a reference to the quadrature formula used by a
        FEValues object.
        <br>
        (WB 2001/06/21)
index d232304d95f32d79eb77f6df026b07c18bb73e53..a1a99846af63dd57d93355d123e285e7e185ff6a 100644 (file)
@@ -156,7 +156,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
        Changed: Previously, we just set the preprocessor variable
        <code>DEAL_II_USE_MT</code>, when <code>--with-multithreading</code> was
        given as argument to <code>./configure</code>. Tests in the code
-       therefore looked like <code>#ifdef DEAL_II_USE_MT</code>. This has been
+       therefore looked like <code>\#ifdef DEAL_II_USE_MT</code>. This has been
        changed so that the variable is always defined, but its value is now
        equal to <code>1</code>
        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 <code>#ifdef
-       DEAL_II_USE_MT</code> be changed to <code>#if DEAL_II_USE_MT ==
+       this change requires that all appearances of <code>\#ifdef
+       DEAL_II_USE_MT</code> be changed to <code>\#if DEAL_II_USE_MT ==
        1</code>, since the variable is now defined unconditionally.
        <br>
        (WB 2002/11/14)
@@ -190,7 +190,7 @@ contributor's names are abbreviated by WB (Wolfgang Bangerth), GK
        </p>
 
   <li> <p>
-       Fixed: On CygWin, one header files has a <code>#define quad
+       Fixed: On CygWin, one header files has a <code>\#define quad
        quad_t</code>. This is annoying, since we have local variables and
        member functions with the name <code>quad</code>, 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
        </p>
 
   <li> <p> Changed: The class <code
-       class="member">Table&lt;2&gt;::fill</code> function, which is also
+       class="member">Table::fill()</code> function, which is also
        inherited from the <code>FullMatrix</code> 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</code> now returns 0,
        instead of throwing an assertion, as before. The same holds for
        similar functions like <code
-       class="member">Triangulation&lt;dim&gt;::n_hexs</code> that now
+       class="member">Triangulation::n_hexs</code> that now
        returns 0 for <code>dim<3</code>.
        <br>
        (RH 2002/06/14)
index 337b9ecabfa93d5bd824d53464c9ecf443812af3..148c1968e9dd9d8846571759878d5e24fb65c0c6 100644 (file)
@@ -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 <code>vector=0</code> and <code>matrix=0</code>. To
        reset the elements of a table over arbitrary objects, use
-       <code>Table&lt;T&gt;::reset_values()</code>.
+       <code>Table::reset_values()</code>.
        <br>
        (WB 2004/05/10)
        </p>
@@ -136,8 +136,9 @@ inconvenience this causes.
   <li> <p> Moved and changed: The header file
        <tt>include/numerics/dof_renumbering.h</tt> has been moved to the
        directory <tt>include/dofs</tt>, where it logically
-       belongs. Furthermore, the sorting parameter of the function <code>DoFRenumbering</code><code>::component_wise</code> has changed its meaning. See
-       the reference documentation for details.
+       belongs. Furthermore, the sorting parameter of the function
+       <code>DoFRenumbering::component_wise()</code> has changed its meaning.
+       See the reference documentation for details.
        <br>
        (GK 2003/07/03)
        </p>
index c84dae49cac334f8ee0eea9cc6b33c4bf9f419e3..62f83e99eafb092f7fa3377cace8550f1bdc5709 100644 (file)
@@ -171,7 +171,7 @@ inconvenience this causes.
 
   <li> <p>
        Fixed: <code
-       class="member">DataOutBase&lt;2,3&gt;::write_tecplot</code>
+       class="member">DataOutBase::write_tecplot</code> for dim=2 and spacedim=3
        sometimes did not write the variable name <code>z</code> when
        only outputting faces of cells. This is now fixed.
        <br>
index 2c8461135f0a80d23c3aaef5283d0bf8384255a4..6015d6379c19f4026031914ee6973bda5b2754d8 100644 (file)
@@ -736,9 +736,9 @@ inconvenience this causes.
        </p>
 
   <li> <p>
-       Fixed: <code>DataOutBase&lt;2,3&gt;::write_tecplot_binary</code>
-       did not write the <code>z</code> coordinates. This is now
-       fixed.
+       Fixed: <code>DataOutBase::write_tecplot_binary()</code> with
+       dim=2 and spacedim=3 did not write the <code>z</code> coordinates.
+       This is now fixed.
        <br>
        (RH 2005/09/28)
        </p>
@@ -1206,7 +1206,7 @@ inconvenience this causes.
        </p>
 
    <li> <p>Fixed: A local variable in
-       <code>TriaAccessor&lt;3,3&gt;::measure</code> was
+       <code>TriaAccessor::measure()</code> was
        erroneously marked as static could lead to
        wrong results and crashes in multithreaded mode. This is now fixed.
        <br>
@@ -1382,10 +1382,13 @@ inconvenience this causes.
   <li> <p>
        Extended: <code >DerivativeApproximation</code> 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 <code>DerivativeApproximation</code><code>::approximate_derivative_tensor</code> function. If the
-       norm of this tensor is required later on, the new <code >DerivativeApproximation</code><code>::derivative_norm</code> 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 <code >Tensor&lt;rank_,dim&gt;</code><code>::norm</code> function.
+       information can be requested for a single cell by means of the
+       <code>DerivativeApproximation::approximate_derivative_tensor()</code>
+       function. If the norm of this tensor is required later on, the new
+       <code>DerivativeApproximation::derivative_norm()</code> 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
+       <code >Tensor::()norm</code> function.
        <br>
        (Tobias Leicht 2006/08/03)
        </p>
@@ -1422,7 +1425,7 @@ inconvenience this causes.
        </p>
 
   <li> <p>
-       Fixed: <code >Triangulation&lt;dim&gt;::fix_coarsen_flags</code>
+       Fixed: <code >Triangulation::fix_coarsen_flags()</code>
        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 <code>refine_flag</code> set, whereas it was allowed, if
@@ -1705,8 +1708,7 @@ inconvenience this causes.
        </p>
 
   <li> <p>
-       New: The <code>GridIn&lt;dim&gt;::read_netcdf(string
-       &filename)</code> function reads grids from NetCDF files. The
+       New: The <code>GridIn::read_netcdf()</code> function reads grids from NetCDF files. The
        only data format currently supported is the <tt>TAU grid
        format</tt>.
        <br>
@@ -1714,7 +1716,7 @@ inconvenience this causes.
        </p>
 
   <li> <p>
-       Fixed: The <code>GridIn&lt;dim&gt;::read(filename, format)</code>
+       Fixed: The <code>GridIn::read()</code>
        function ran into an exception when called with
        <tt>Default</tt> format and a filename which does not include
        <tt>/</tt>. This is now fixed.
index a0e3817556998995cd2887c092b66f1ab9a68aa1..5535b6d2c5133dfca8e509d4348ab0d5a12d281a 100644 (file)
@@ -336,7 +336,7 @@ inconvenience this causes.
   (Matthias Maier, 2013/11/20)
   </li>
 
-  <li> Changed: when a dealii::Exception is thrown, defer the symbol lookup of the
+  <li> Changed: when a dealii::%Exception is thrown, defer the symbol lookup of the
   stack trace to when it is needed. This improves performance if what() is never
   called.
   <br>
index 4421af515763b18d53a8d00f97f6c396e7d10428..2cdfa53ca1d66bceec40e2306f0fe7d778718619 100644 (file)
@@ -130,7 +130,7 @@ inconvenience this causes.
   <li> Changed: The project configuration no longer exports
   <code>[...]/include/deal.II</code>. Thus it is now mandatory to prefix
   all includes of deal.II headers with <code>deal.II/</code>, i.e.
-  <code>#include &lt;deal.II/[...]&gt;</code>.
+  <code>\#include &lt;deal.II/[...]&gt;</code>.
   <br>
   (Matthias Maier, 2015/01/19)
   </li>
@@ -244,7 +244,7 @@ inconvenience this causes.
     classes. You should use the versions with a VectorOperation
     argument instead.
   - Vector::scale.
-  - TrilinosWrappers::*Vector*::compress with an Epetra_CombineMode
+  - TrilinosWrappers::*Vector*::%compress with an Epetra_CombineMode
     argument.
   - SparsityPattern and ChunkSparsityPattern functions that take an
     <code>optimize_diagonal</code> argument.
@@ -1060,7 +1060,7 @@ inconvenience this causes.
   (Wolfgang Bangerth, 2015/01/16)
   </li>
 
-  <li> New: dealii::multithread_info.n_cpus returns the correct number of CPU
+  <li> New: MultithreadInfo::n_cpus() returns the correct number of CPU
   on FreeBSD.
   <br>
   (Bruno Turcksin, 2015/01/14)
index 6be9803780dae9bf821f90e3ef9a7c9c916cec01..46a55078df8908a56b47579a3c7886dfad2d547e 100644 (file)
@@ -38,20 +38,12 @@ modifications to application programs. We apologize for the
 inconvenience this causes.
 </p>
 
-<ol>
-
-</ol>
-
 
 <!-- ----------- GENERAL IMPROVEMENTS ----------------- -->
 
 <a name="general"></a>
 <h3>General</h3>
 
-<ol>
-
-</ol>
-
 
 <!-- ----------- SPECIFIC IMPROVEMENTS ----------------- -->
 
index 7e744aaa2e30b88bd7c4f3d0eb65b72626982965..e5c82827ce4ffcd2ebabb06d6e71740789a57cdc 100644 (file)
@@ -138,7 +138,7 @@ inconvenience this causes.
   which returns the buffer of the packed data.
   parallel::distributed::Triangulation::notify_ready_to_unpack()
   requires `std::function<void(const cell_iterator &, const CellStatus,
-  const boost::iterator_range<std::vector<char>::const_iterator &>`, where
+  const boost::iterator_range<std::vector<char>::%const_iterator &>`, where
   the last argument describes an iterator range, from which the callback
   function is allowed to read.
   <br>

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.