]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Fix broken doxygen formatting
authorMatthias Maier <tamiko@43-1.org>
Wed, 13 Jun 2018 19:13:43 +0000 (14:13 -0500)
committerMatthias Maier <tamiko@43-1.org>
Thu, 14 Jun 2018 19:08:08 +0000 (14:08 -0500)
48 files changed:
include/deal.II/base/array_view.h
include/deal.II/base/geometry_info.h
include/deal.II/base/parameter_acceptor.h
include/deal.II/base/parameter_handler.h
include/deal.II/base/polynomial.h
include/deal.II/base/polynomials_rt_bubbles.h
include/deal.II/base/quadrature_point_data.h
include/deal.II/base/symmetric_tensor.h
include/deal.II/base/thread_management.h
include/deal.II/differentiation/ad/ad_number_traits.h
include/deal.II/differentiation/ad/adolc_number_types.h
include/deal.II/distributed/shared_tria.h
include/deal.II/dofs/dof_renumbering.h
include/deal.II/fe/fe.h
include/deal.II/fe/fe_dgp.h
include/deal.II/fe/fe_dgp_monomial.h
include/deal.II/fe/fe_dgp_nonparametric.h
include/deal.II/fe/fe_enriched.h
include/deal.II/fe/fe_nedelec_sz.h
include/deal.II/fe/fe_q.h
include/deal.II/fe/fe_q_hierarchical.h
include/deal.II/fe/fe_q_iso_q1.h
include/deal.II/fe/fe_series.h
include/deal.II/grid/grid_generator.h
include/deal.II/grid/grid_tools.h
include/deal.II/grid/manifold.h
include/deal.II/lac/arpack_solver.h
include/deal.II/lac/lapack_full_matrix.h
include/deal.II/lac/parpack_solver.h
include/deal.II/lac/petsc_parallel_vector.h
include/deal.II/lac/read_write_vector.h
include/deal.II/lac/scalapack.h
include/deal.II/lac/scalapack.templates.h
include/deal.II/lac/tensor_product_matrix.h
include/deal.II/lac/trilinos_precondition.h
include/deal.II/matrix_free/cuda_fe_evaluation.h
include/deal.II/matrix_free/tensor_product_kernels.h
include/deal.II/meshworker/mesh_loop.h
include/deal.II/multigrid/mg_constrained_dofs.h
include/deal.II/multigrid/multigrid.h
include/deal.II/numerics/data_postprocessor.h
include/deal.II/numerics/vector_tools.h
include/deal.II/opencascade/boundary_lib.h
include/deal.II/physics/elasticity/standard_tensors.h
source/dofs/dof_tools_constraints.cc
source/fe/mapping_manifold.cc
source/fe/mapping_q_generic.cc
source/grid/tria.cc

index 1eccd861255dd21b51d2a9dbbddfd870b5804297..b50ee7854ef11a0789b53cf0b709c556cfacb3a1 100644 (file)
@@ -549,8 +549,8 @@ make_array_view(const ArrayView<Number> &array_view)
 /**
  * Create a view from an ArrayView itself.
  *
- * This function is used for non-@p const references to objects of ArrayView type.
- * It only exists for compatibility purposes.
+ * This function is used for non-@p const references to objects of ArrayView
+ * type. It only exists for compatibility purposes.
  *
  * @param[in] array_view The ArrayView that we wish to make a copy of.
  *
index ab8e2799b16589f5ae69e561fc4e3f7e996e41c6..b586b2284d22bb8989f5a733c492ee2c5e8f2980 100644 (file)
@@ -911,8 +911,8 @@ namespace internal
    *
    * *---*---*
    * | 1 | 3 |
-   * *---*---*    case_x1y2y   (successive refinement: first cut_x, then cut_y
-   * for both children) | 0 | 2 |
+   * *---*---*    case_x1y2y   (successive refinement: first cut_x, then cut_y for both children)
+   * | 0 | 2 |
    * *---*---*
    *
    * *-------*
@@ -935,8 +935,8 @@ namespace internal
    *
    * *---*---*
    * | 2 | 3 |
-   * *---*---*    case_y1x2x   (successive refinement: first cut_y, then cut_x
-   * for both children) | 0 | 1 |
+   * *---*---*    case_y1x2x   (successive refinement: first cut_y, then cut_x for both children)
+   * | 0 | 1 |
    * *---+---*
    *
    * *---*---*
index ba1303c541eb7fa8fdb04939c7a5d8aff75f3b58..df955e207e2715ee106202d5fa7e512c52168df7 100644 (file)
@@ -59,7 +59,8 @@ DEAL_II_NAMESPACE_OPEN
  * ParameterAcceptor::add_parameter() method for each parameter we want to
  * have, or by constructing a ParameterAcceptorProxy class with your own class,
  * provided that your class implements the @p declare_parameters and
- * @p parse_parameters functions (the first can be a static member in this case).
+ * @p parse_parameters functions (the first can be a static member in this
+ * case).
  *
  * By using the add_parameter method, ParameterAcceptor makes sure that the
  * given parameter is registered in the global parameter handler (by calling
index cf571cb201d41b9c20bf8806f6d686c7d57701a1..f056df7049e3f2e4f017bf52c791bb12cf04a4e4 100644 (file)
@@ -792,8 +792,7 @@ class MultipleParameterLoop;
  *
  *
  * @ingroup input
- * @author Wolfgang Bangerth, October 1997, revised February 1998, 2010, 2011,
- * 2017
+ * @author Wolfgang Bangerth, October 1997, revised February 1998, 2010, 2011, 2017
  * @author Alberto Sartori, 2015
  * @author David Wells, 2016
  */
index d81c85fdd89a86aca9b7f320703ec23cef36eedd..93de2a51e6ee98031b6c8badc2a1eff3cfb03802 100644 (file)
@@ -56,8 +56,7 @@ namespace Polynomials
    * must be used. In case a manipulation is done that changes the roots, the
    * representation is switched to the coefficient form.
    *
-   * @author Ralf Hartmann, Guido Kanschat, 2000, 2006, Martin Kronbichler,
-   * 2011, 2017
+   * @author Ralf Hartmann, Guido Kanschat, 2000, 2006, Martin Kronbichler, 2011, 2017
    */
   template <typename number>
   class Polynomial : public Subscriptor
index c8a2cd55e0cd803a839ea889e97a26899b97a9ce..458982e778b115c434a6fe1e67026424630007ff 100644 (file)
@@ -65,9 +65,8 @@ DEAL_II_NAMESPACE_OPEN
  * </dl>
  * where $0 \le a_1, a_2, a_3 \le k$.
  *
- * @note Unlike the classical Raviart-Thomas space, the lowest order for the
- * enhanced space is 1, similarly to the Brezzi-Douglas-Marini (BDM) polynomial
- * space.
+ * @note Unlike the classical Raviart-Thomas space, the lowest order for the enhanced space
+ * is 1, similarly to the Brezzi-Douglas-Marini (BDM) polynomial space.
  *
  * The total dimension of the space <i>dim(V<sub>k</sub>) = d*(k+1)^d</i>, where
  * <i>d</i> is the space dimension. This allows to associate shape functions
index 23c8af64a0c88ed00902af82acf8cb644bb8d165..1c1c3cfddacdbeb6a9945c8a1db0c60a6d1ccb0c 100644 (file)
@@ -315,15 +315,15 @@ namespace parallel
      *
      * @note Currently coarsening is not supported.
      *
-     * @note The functionality provided by this class can alternatively be
-     * achieved using parallel::distributed::SolutionTransfer. However, that
-     * would require the following steps: (i) create an auxiliary DoFHandler
-     * with a (discontinuous Galerkin) FiniteElement which has enough components
-     * to represent all data stored at the quadrature points; (ii) project the
-     * data to the FiniteElement space and thereby store results in global
-     * vectors; (iii) use parallel::distributed::SolutionTransfer to project FE
-     * vectors to the new mesh; and (iv) finally project the data back to the
-     * quadrature points on the new mesh via FEValues class. The
+     * @note The functionality provided by this class can alternatively be achieved
+     * using parallel::distributed::SolutionTransfer. However, that would
+     * require the following steps: (i) create an auxiliary DoFHandler with a
+     * (discontinuous Galerkin) FiniteElement which has enough components to
+     * represent all data stored at the quadrature points; (ii) project the data
+     * to the FiniteElement space and thereby store results in global vectors;
+     * (iii) use parallel::distributed::SolutionTransfer to project FE vectors
+     * to the new mesh; and (iv) finally project the data back to the quadrature
+     * points on the new mesh via FEValues class. The
      * ContinuousQuadratureDataTransfer class aims at simplifying the whole
      * process by only requiring that the quadrature point data class is derived
      * from the TransferableQuadraturePointData. Everything else will be done
@@ -377,8 +377,8 @@ namespace parallel
 
       /**
        * Prepare for coarsening and refinement of a triangulation @p tria .
-       * @p data_storage represents the cell data which should be transferred and
-       * it should be initialized for each locally owned active cell.
+       * @p data_storage represents the cell data which should be transferred
+       * and it should be initialized for each locally owned active cell.
        *
        * @note Although CellDataStorage class allows storing on different cells
        * different objects derived from the base class, here we assume that
index 2e00bc982d9831317f88822967414bae663e6eaa..af3a4801840ac1fee74868d77299f6c5b83ae2be 100644 (file)
@@ -2981,8 +2981,8 @@ namespace internal
      * @param[in] A The tensor of which the eigenvectors and eigenvalues are
      * to be computed.
      *
-     * @return An array containing the eigenvectors and the associated
-     * eigenvalues. The array is not sorted in any particular order.
+     * @return An array containing the eigenvectors and the associated eigenvalues.
+     * The array is not sorted in any particular order.
      *
      * @author Joachim Kopp, Jean-Paul Pelteret, 2017
      */
@@ -3023,8 +3023,8 @@ namespace internal
      * @param[in] A The tensor of which the eigenvectors and eigenvalues are
      * to be computed.
      *
-     * @return An array containing the eigenvectors and the associated
-     * eigenvalues. The array is not sorted in any particular order.
+     * @return An array containing the eigenvectors and the associated eigenvalues.
+     * The array is not sorted in any particular order.
      *
      * @author Joachim Kopp, Jean-Paul Pelteret, 2017
      */
@@ -3044,8 +3044,8 @@ namespace internal
      * @param[in] A The tensor of which the eigenvectors and eigenvalues are
      * to be computed.
      *
-     * @return An array containing the eigenvectors and the associated
-     * eigenvalues. The array is not sorted in any particular order.
+     * @return An array containing the eigenvectors and the associated eigenvalues.
+     * The array is not sorted in any particular order.
      *
      * @author Joachim Kopp, Jean-Paul Pelteret, 2017
      */
@@ -3081,8 +3081,8 @@ namespace internal
      * @param[in] A The tensor of which the eigenvectors and eigenvalues are
      * to be computed.
      *
-     * @return An array containing the eigenvectors and the associated
-     * eigenvalues. The array is not sorted in any particular order.
+     * @return An array containing the eigenvectors and the associated eigenvalues.
+     * The array is not sorted in any particular order.
      *
      * @author Joachim Kopp, Jean-Paul Pelteret, 2017
      */
index ca70dc82f0fce9660f627d653d74178bede58b1b..7b4171499fe411d6b0b19e2f9105325c9b961804 100644 (file)
@@ -1091,8 +1091,8 @@ namespace Threads
      * t.return_value();   // i is now 42
      * @endcode
      * You will rarely have a need to write such code. On the other hand,
-     * the function needs to return a writable (non-@p const) reference to support
-     * code such as this:
+     * the function needs to return a writable (non-@p const) reference to
+     * support code such as this:
      * @code
      *   std::unique_ptr<int> create_int (const std::string &s) { ... }
      *
@@ -1799,8 +1799,8 @@ namespace Threads
      * t.return_value();   // i is now 42
      * @endcode
      * You will rarely have a need to write such code. On the other hand,
-     * the function needs to return a writable (non-@p const) reference to support
-     * code such as this:
+     * the function needs to return a writable (non-@p const) reference to
+     * support code such as this:
      * @code
      *   std::unique_ptr<int> create_int (const std::string &s) { ... }
      *
index ae8bd2fa970d694079634babad5e190449994e01..769bbc580a454d3346d0b9d3e2613afc6d2c04fb 100644 (file)
@@ -189,9 +189,9 @@ namespace Differentiation
        * default it is assumed that the input type does not satisfy the
        * necessary conditions to construct this class.
        *
-       * @tparam ADNumberTrait A class that examined whether it contains the
-       * necessary information to satisfy the requirements for being an
-       * internally supported auto-differentiable number.
+       * @tparam ADNumberTrait A class that examined whether it contains the necessary
+       *         information to satisfy the requirements for being an internally
+       *         supported auto-differentiable number.
        * @tparam T An arbitrary type resulting from the application of
        *         the SFINAE idiom to selectively specialize this class.
        *
index 506dfae0526a3ca63c072991a4ef89d8b89e1a2d..8b9aa3f9195398144ec7f5e869d30908c66b2417 100644 (file)
@@ -337,8 +337,7 @@ namespace Differentiation
      * This specialization is for the case where @p ADNumberType is an
      * taped Adol-C (real) double.
      *
-     * @note In this case the number traits are the same as those for a taped
-     * double.
+     * @note In this case the number traits are the same as those for a taped double.
      *
      * @author Jean-Paul Pelteret, 2017
      */
@@ -361,8 +360,8 @@ namespace Differentiation
      * This specialization is for the case where @p ADNumberType is an
      * taped Adol-C complex double.
      *
-     * @note In this case the number traits are the same as those for a taped
-     * complex double.
+     * @note In this case the number traits are the same as those for a taped complex
+     * double.
      *
      * @author Jean-Paul Pelteret, 2017
      */
@@ -386,8 +385,7 @@ namespace Differentiation
      * This specialization is for the case where @p ADNumberType is an
      * tapeless Adol-C (real) double.
      *
-     * @note In this case the number traits are the same as those for a tapeless
-     * double.
+     * @note In this case the number traits are the same as those for a tapeless double.
      *
      * @author Jean-Paul Pelteret, 2017
      */
index 87ad225651864a9489456e52b68969afea23d49a..fc6a1e3d40f44385a6ddae49648d702fa002e192 100644 (file)
@@ -278,10 +278,9 @@ namespace parallel
        * This function also partitions triangulation based on the MPI
        * communicator provided to the constructor.
        *
-       * @note This function can not be used with
-       * parallel::distributed::Triangulation, since it only stores those cells
-       * that it owns, one layer of ghost cells around the ones it locally owns,
-       * and a number of artificial cells.
+       * @note This function can not be used with parallel::distributed::Triangulation,
+       * since it only stores those cells that it owns, one layer of ghost cells
+       * around the ones it locally owns, and a number of artificial cells.
        */
       virtual void
       copy_triangulation(
index 3ab75b6b9b871b554d8deda729c835803d7930f2..0b317cb18f9d0c7be73253bbe9aacea4a6dcca53 100644 (file)
@@ -827,9 +827,9 @@ namespace DoFRenumbering
    * degrees of freedom on this cell <i>earlier</i> indices than
    * all of the indices owned by processor 1.
    *
-   * @note This function generates an ordering that is independent of the
-   * previous numbering of degrees of freedom. In other words, any information
-   * that may have been produced by a previous call to a renumbering function is
+   * @note This function generates an ordering that is independent of the previous
+   * numbering of degrees of freedom. In other words, any information that may
+   * have been produced by a previous call to a renumbering function is
    * ignored.
    */
   template <int dim>
index 05e15ef072820fc1e1f1368293f294fba24b5706..96a9f2119254c6aa0c372a5404093d5c0ad31bd8 100644 (file)
@@ -183,28 +183,30 @@ class FESystem;
  * @endcode
  * which will result in:
  *
- * | DoF    | Component  | Base element | Shape function within base |
- * Multiplicity | | :----: | :--------: | :----------: |
- * :------------------------: | :----------: | |      0 |          0 | 0 | 0 |
- * 0 | |      1 |          1 |            0 |                          0 | 1 |
- * |      2 |          2 |            1 |                          0 | 0 | | 3 |
- * 0 |            0 |                          1 |            0 | |      4 | 1 |
- * 0 |                          1 |            1 | |      5 |          2 | 1 |
- * 1 |            0 | |      6 |          0 |            0 | 2 |            0 |
- * |      7 |          1 |            0 |                          2 | 1 | | 8 |
- * 2 |            1 |                          2 |            0 | |      9 | 0 |
- * 0 |                          3 |            0 | |     10 |          1 | 0 |
- * 3 |            1 | |     11 |          2 |            1 | 3 |            0 |
- * |     12 |          0 |            0 |                          4 | 0 | | 13
- * |          1 |            0 |                          4 |            1 | |
- * 14 |          0 |            0 |                          5 |            0 |
- * |     15 |          1 |            0 |                          5 | 1 | | 16
- * |          0 |            0 |                          6 |            0 | |
- * 17 |          1 |            0 |                          6 |            1 |
- * |     18 |          0 |            0 |                          7 | 0 | | 19
- * |          1 |            0 |                          7 |            1 | |
- * 20 |          0 |            0 |                          8 |            0 |
- * |     21 |          1 |            0 |                          8 | 1 |
+ * | DoF    | Component  | Base element | Shape function within base | Multiplicity |
+ * | :----: | :--------: | :----------: | :------------------------: | :----------: |
+ * |      0 |          0 |            0 |                          0 |            0 |
+ * |      1 |          1 |            0 |                          0 |            1 |
+ * |      2 |          2 |            1 |                          0 |            0 |
+ * |      3 |          0 |            0 |                          1 |            0 |
+ * |      4 |          1 |            0 |                          1 |            1 |
+ * |      5 |          2 |            1 |                          1 |            0 |
+ * |      6 |          0 |            0 |                          2 |            0 |
+ * |      7 |          1 |            0 |                          2 |            1 |
+ * |      8 |          2 |            1 |                          2 |            0 |
+ * |      9 |          0 |            0 |                          3 |            0 |
+ * |     10 |          1 |            0 |                          3 |            1 |
+ * |     11 |          2 |            1 |                          3 |            0 |
+ * |     12 |          0 |            0 |                          4 |            0 |
+ * |     13 |          1 |            0 |                          4 |            1 |
+ * |     14 |          0 |            0 |                          5 |            0 |
+ * |     15 |          1 |            0 |                          5 |            1 |
+ * |     16 |          0 |            0 |                          6 |            0 |
+ * |     17 |          1 |            0 |                          6 |            1 |
+ * |     18 |          0 |            0 |                          7 |            0 |
+ * |     19 |          1 |            0 |                          7 |            1 |
+ * |     20 |          0 |            0 |                          8 |            0 |
+ * |     21 |          1 |            0 |                          8 |            1 |
  *
  * What we see is the following: there are a total of 22 degrees-of-freedom on
  * this element with components ranging from 0 to 2. Each DoF corresponds to one
index bd537f46cbda170e5321f213eef32332da8bf4a6..5016822b7a06e1589339f7b4fa8f575b78eee2a9 100644 (file)
@@ -110,8 +110,7 @@ DEAL_II_NAMESPACE_OPEN
  * <h4>$P_0$ element</h4>
  *
  * <table> <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGP/P1/P1_DGP_shape0000.png
+ * @image html http://www.dealii.org/images/shape-functions/DGP/P1/P1_DGP_shape0000.png
  * </td>
  *
  * <td align="center"> </td> </tr> <tr> <td align="center"> $P_0$ element,
@@ -122,20 +121,17 @@ DEAL_II_NAMESPACE_OPEN
  * <h4>$P_1$ element</h4>
  *
  * <table> <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGP/P1/P1_DGP_shape0000.png
+ * @image html http://www.dealii.org/images/shape-functions/DGP/P1/P1_DGP_shape0000.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGP/P1/P1_DGP_shape0001.png
+ * @image html http://www.dealii.org/images/shape-functions/DGP/P1/P1_DGP_shape0001.png
  * </td> </tr> <tr> <td align="center"> $P_1$ element, shape function 0 </td>
  *
  * <td align="center"> $P_1$ element, shape function 1 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGP/P1/P1_DGP_shape0002.png
+ * @image html http://www.dealii.org/images/shape-functions/DGP/P1/P1_DGP_shape0002.png
  * </td>
  *
  * <td align="center"> </td> </tr> <tr> <td align="center"> $P_1$ element,
@@ -147,37 +143,31 @@ DEAL_II_NAMESPACE_OPEN
  * <h4>$P_2$ element</h4>
  *
  * <table> <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGP/P2/P2_DGP_shape0000.png
+ * @image html http://www.dealii.org/images/shape-functions/DGP/P2/P2_DGP_shape0000.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGP/P2/P2_DGP_shape0001.png
+ * @image html http://www.dealii.org/images/shape-functions/DGP/P2/P2_DGP_shape0001.png
  * </td> </tr> <tr> <td align="center"> $P_2$ element, shape function 0 </td>
  *
  * <td align="center"> $P_2$ element, shape function 1 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGP/P2/P2_DGP_shape0002.png
+ * @image html http://www.dealii.org/images/shape-functions/DGP/P2/P2_DGP_shape0002.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGP/P2/P2_DGP_shape0003.png
+ * @image html http://www.dealii.org/images/shape-functions/DGP/P2/P2_DGP_shape0003.png
  * </td> </tr> <tr> <td align="center"> $P_2$ element, shape function 2 </td>
  *
  * <td align="center"> $P_2$ element, shape function 3 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGP/P2/P2_DGP_shape0004.png
+ * @image html http://www.dealii.org/images/shape-functions/DGP/P2/P2_DGP_shape0004.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGP/P2/P2_DGP_shape0005.png
+ * @image html http://www.dealii.org/images/shape-functions/DGP/P2/P2_DGP_shape0005.png
  * </td> </tr> <tr> <td align="center"> $P_2$ element, shape function 4 </td>
  *
  * <td align="center"> $P_2$ element, shape function 5 </td> </tr> </table>
@@ -186,153 +176,128 @@ DEAL_II_NAMESPACE_OPEN
  * <h4>$P_3$ element</h4>
  *
  * <table> <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGP/P3/P3_DGP_shape0000.png
+ * @image html http://www.dealii.org/images/shape-functions/DGP/P3/P3_DGP_shape0000.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGP/P3/P3_DGP_shape0001.png
+ * @image html http://www.dealii.org/images/shape-functions/DGP/P3/P3_DGP_shape0001.png
  * </td> </tr> <tr> <td align="center"> $P_3$ element, shape function 0 </td>
  *
  * <td align="center"> $P_3$ element, shape function 1 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGP/P3/P3_DGP_shape0002.png
+ * @image html http://www.dealii.org/images/shape-functions/DGP/P3/P3_DGP_shape0002.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGP/P3/P3_DGP_shape0003.png
+ * @image html http://www.dealii.org/images/shape-functions/DGP/P3/P3_DGP_shape0003.png
  * </td> </tr> <tr> <td align="center"> $P_3$ element, shape function 2 </td>
  *
  * <td align="center"> $P_3$ element, shape function 3 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGP/P3/P3_DGP_shape0004.png
+ * @image html http://www.dealii.org/images/shape-functions/DGP/P3/P3_DGP_shape0004.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGP/P3/P3_DGP_shape0005.png
+ * @image html http://www.dealii.org/images/shape-functions/DGP/P3/P3_DGP_shape0005.png
  * </td> </tr> <tr> <td align="center"> $P_3$ element, shape function 4 </td>
  *
  * <td align="center"> $P_3$ element, shape function 5 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGP/P3/P3_DGP_shape0006.png
+ * @image html http://www.dealii.org/images/shape-functions/DGP/P3/P3_DGP_shape0006.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGP/P3/P3_DGP_shape0007.png
+ * @image html http://www.dealii.org/images/shape-functions/DGP/P3/P3_DGP_shape0007.png
  * </td> </tr> <tr> <td align="center"> $P_3$ element, shape function 6 </td>
  *
  * <td align="center"> $P_3$ element, shape function 7 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGP/P3/P3_DGP_shape0008.png
+ * @image html http://www.dealii.org/images/shape-functions/DGP/P3/P3_DGP_shape0008.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGP/P3/P3_DGP_shape0009.png
+ * @image html http://www.dealii.org/images/shape-functions/DGP/P3/P3_DGP_shape0009.png
  * </td> </tr> <tr> <td align="center"> $P_3$ element, shape function 8 </td>
  *
  * <td align="center"> $P_3$ element, shape function 9 </td> </tr> </table>
  *
  *
  * <h4>$P_4$ element</h4> <table> <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGP/P4/P4_DGP_shape0000.png
+ * @image html http://www.dealii.org/images/shape-functions/DGP/P4/P4_DGP_shape0000.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGP/P4/P4_DGP_shape0001.png
+ * @image html http://www.dealii.org/images/shape-functions/DGP/P4/P4_DGP_shape0001.png
  * </td> </tr> <tr> <td align="center"> $P_4$ element, shape function 0 </td>
  *
  * <td align="center"> $P_4$ element, shape function 1 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGP/P4/P4_DGP_shape0002.png
+ * @image html http://www.dealii.org/images/shape-functions/DGP/P4/P4_DGP_shape0002.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGP/P4/P4_DGP_shape0003.png
+ * @image html http://www.dealii.org/images/shape-functions/DGP/P4/P4_DGP_shape0003.png
  * </td> </tr> <tr> <td align="center"> $P_4$ element, shape function 2 </td>
  *
  * <td align="center"> $P_4$ element, shape function 3 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGP/P4/P4_DGP_shape0004.png
+ * @image html http://www.dealii.org/images/shape-functions/DGP/P4/P4_DGP_shape0004.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGP/P4/P4_DGP_shape0005.png
+ * @image html http://www.dealii.org/images/shape-functions/DGP/P4/P4_DGP_shape0005.png
  * </td> </tr> <tr> <td align="center"> $P_4$ element, shape function 4 </td>
  *
  * <td align="center"> $P_4$ element, shape function 5 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGP/P4/P4_DGP_shape0006.png
+ * @image html http://www.dealii.org/images/shape-functions/DGP/P4/P4_DGP_shape0006.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGP/P4/P4_DGP_shape0007.png
+ * @image html http://www.dealii.org/images/shape-functions/DGP/P4/P4_DGP_shape0007.png
  * </td> </tr> <tr> <td align="center"> $P_4$ element, shape function 6 </td>
  *
  * <td align="center"> $P_4$ element, shape function 7 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGP/P4/P4_DGP_shape0008.png
+ * @image html http://www.dealii.org/images/shape-functions/DGP/P4/P4_DGP_shape0008.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGP/P4/P4_DGP_shape0009.png
+ * @image html http://www.dealii.org/images/shape-functions/DGP/P4/P4_DGP_shape0009.png
  * </td> </tr> <tr> <td align="center"> $P_4$ element, shape function 8 </td>
  *
  * <td align="center"> $P_4$ element, shape function 9 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGP/P4/P4_DGP_shape0010.png
+ * @image html http://www.dealii.org/images/shape-functions/DGP/P4/P4_DGP_shape0010.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGP/P4/P4_DGP_shape0011.png
+ * @image html http://www.dealii.org/images/shape-functions/DGP/P4/P4_DGP_shape0011.png
  * </td> </tr> <tr> <td align="center"> $P_4$ element, shape function 10 </td>
  *
  * <td align="center"> $P_4$ element, shape function 11 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGP/P4/P4_DGP_shape0012.png
+ * @image html http://www.dealii.org/images/shape-functions/DGP/P4/P4_DGP_shape0012.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGP/P4/P4_DGP_shape0013.png
+ * @image html http://www.dealii.org/images/shape-functions/DGP/P4/P4_DGP_shape0013.png
  * </td> </tr> <tr> <td align="center"> $P_4$ element, shape function 12 </td>
  *
  * <td align="center"> $P_4$ element, shape function 13 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGP/P4/P4_DGP_shape0014.png
+ * @image html http://www.dealii.org/images/shape-functions/DGP/P4/P4_DGP_shape0014.png
  * </td>
  *
  * <td align="center"> </td> </tr> <tr> <td align="center"> $P_4$ element,
index 6ca4abbf110d26964fbc194ffb0636d1d1d6176f..11be38054dbdcc2912803c9ea7bb99f29403d647 100644 (file)
@@ -85,8 +85,7 @@ DEAL_II_NAMESPACE_OPEN
  * <h4>$P_0$ element</h4>
  *
  * <table> <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPMonomial/P1/P1_DGPMonomial_shape0000.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPMonomial/P1/P1_DGPMonomial_shape0000.png
  * </td>
  *
  * <td align="center"> </td> </tr> <tr> <td align="center"> $P_0$ element,
@@ -97,20 +96,17 @@ DEAL_II_NAMESPACE_OPEN
  * <h4>$P_1$ element</h4>
  *
  * <table> <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPMonomial/P1/P1_DGPMonomial_shape0000.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPMonomial/P1/P1_DGPMonomial_shape0000.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPMonomial/P1/P1_DGPMonomial_shape0001.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPMonomial/P1/P1_DGPMonomial_shape0001.png
  * </td> </tr> <tr> <td align="center"> $P_1$ element, shape function 0 </td>
  *
  * <td align="center"> $P_1$ element, shape function 1 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPMonomial/P1/P1_DGPMonomial_shape0002.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPMonomial/P1/P1_DGPMonomial_shape0002.png
  * </td>
  *
  * <td align="center"> </td> </tr> <tr> <td align="center"> $P_1$ element,
@@ -122,37 +118,31 @@ DEAL_II_NAMESPACE_OPEN
  * <h4>$P_2$ element</h4>
  *
  * <table> <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPMonomial/P2/P2_DGPMonomial_shape0000.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPMonomial/P2/P2_DGPMonomial_shape0000.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPMonomial/P2/P2_DGPMonomial_shape0001.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPMonomial/P2/P2_DGPMonomial_shape0001.png
  * </td> </tr> <tr> <td align="center"> $P_2$ element, shape function 0 </td>
  *
  * <td align="center"> $P_2$ element, shape function 1 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPMonomial/P2/P2_DGPMonomial_shape0002.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPMonomial/P2/P2_DGPMonomial_shape0002.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPMonomial/P2/P2_DGPMonomial_shape0003.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPMonomial/P2/P2_DGPMonomial_shape0003.png
  * </td> </tr> <tr> <td align="center"> $P_2$ element, shape function 2 </td>
  *
  * <td align="center"> $P_2$ element, shape function 3 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPMonomial/P2/P2_DGPMonomial_shape0004.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPMonomial/P2/P2_DGPMonomial_shape0004.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPMonomial/P2/P2_DGPMonomial_shape0005.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPMonomial/P2/P2_DGPMonomial_shape0005.png
  * </td> </tr> <tr> <td align="center"> $P_2$ element, shape function 4 </td>
  *
  * <td align="center"> $P_2$ element, shape function 5 </td> </tr> </table>
@@ -161,153 +151,128 @@ DEAL_II_NAMESPACE_OPEN
  * <h4>$P_3$ element</h4>
  *
  * <table> <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPMonomial/P3/P3_DGPMonomial_shape0000.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPMonomial/P3/P3_DGPMonomial_shape0000.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPMonomial/P3/P3_DGPMonomial_shape0001.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPMonomial/P3/P3_DGPMonomial_shape0001.png
  * </td> </tr> <tr> <td align="center"> $P_3$ element, shape function 0 </td>
  *
  * <td align="center"> $P_3$ element, shape function 1 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPMonomial/P3/P3_DGPMonomial_shape0002.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPMonomial/P3/P3_DGPMonomial_shape0002.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPMonomial/P3/P3_DGPMonomial_shape0003.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPMonomial/P3/P3_DGPMonomial_shape0003.png
  * </td> </tr> <tr> <td align="center"> $P_3$ element, shape function 2 </td>
  *
  * <td align="center"> $P_3$ element, shape function 3 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPMonomial/P3/P3_DGPMonomial_shape0004.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPMonomial/P3/P3_DGPMonomial_shape0004.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPMonomial/P3/P3_DGPMonomial_shape0005.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPMonomial/P3/P3_DGPMonomial_shape0005.png
  * </td> </tr> <tr> <td align="center"> $P_3$ element, shape function 4 </td>
  *
  * <td align="center"> $P_3$ element, shape function 5 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPMonomial/P3/P3_DGPMonomial_shape0006.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPMonomial/P3/P3_DGPMonomial_shape0006.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPMonomial/P3/P3_DGPMonomial_shape0007.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPMonomial/P3/P3_DGPMonomial_shape0007.png
  * </td> </tr> <tr> <td align="center"> $P_3$ element, shape function 6 </td>
  *
  * <td align="center"> $P_3$ element, shape function 7 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPMonomial/P3/P3_DGPMonomial_shape0008.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPMonomial/P3/P3_DGPMonomial_shape0008.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPMonomial/P3/P3_DGPMonomial_shape0009.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPMonomial/P3/P3_DGPMonomial_shape0009.png
  * </td> </tr> <tr> <td align="center"> $P_3$ element, shape function 8 </td>
  *
  * <td align="center"> $P_3$ element, shape function 9 </td> </tr> </table>
  *
  *
  * <h4>$P_4$ element</h4> <table> <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPMonomial/P4/P4_DGPMonomial_shape0000.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPMonomial/P4/P4_DGPMonomial_shape0000.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPMonomial/P4/P4_DGPMonomial_shape0001.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPMonomial/P4/P4_DGPMonomial_shape0001.png
  * </td> </tr> <tr> <td align="center"> $P_4$ element, shape function 0 </td>
  *
  * <td align="center"> $P_4$ element, shape function 1 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPMonomial/P4/P4_DGPMonomial_shape0002.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPMonomial/P4/P4_DGPMonomial_shape0002.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPMonomial/P4/P4_DGPMonomial_shape0003.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPMonomial/P4/P4_DGPMonomial_shape0003.png
  * </td> </tr> <tr> <td align="center"> $P_4$ element, shape function 2 </td>
  *
  * <td align="center"> $P_4$ element, shape function 3 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPMonomial/P4/P4_DGPMonomial_shape0004.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPMonomial/P4/P4_DGPMonomial_shape0004.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPMonomial/P4/P4_DGPMonomial_shape0005.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPMonomial/P4/P4_DGPMonomial_shape0005.png
  * </td> </tr> <tr> <td align="center"> $P_4$ element, shape function 4 </td>
  *
  * <td align="center"> $P_4$ element, shape function 5 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPMonomial/P4/P4_DGPMonomial_shape0006.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPMonomial/P4/P4_DGPMonomial_shape0006.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPMonomial/P4/P4_DGPMonomial_shape0007.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPMonomial/P4/P4_DGPMonomial_shape0007.png
  * </td> </tr> <tr> <td align="center"> $P_4$ element, shape function 6 </td>
  *
  * <td align="center"> $P_4$ element, shape function 7 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPMonomial/P4/P4_DGPMonomial_shape0008.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPMonomial/P4/P4_DGPMonomial_shape0008.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPMonomial/P4/P4_DGPMonomial_shape0009.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPMonomial/P4/P4_DGPMonomial_shape0009.png
  * </td> </tr> <tr> <td align="center"> $P_4$ element, shape function 8 </td>
  *
  * <td align="center"> $P_4$ element, shape function 9 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPMonomial/P4/P4_DGPMonomial_shape0010.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPMonomial/P4/P4_DGPMonomial_shape0010.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPMonomial/P4/P4_DGPMonomial_shape0011.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPMonomial/P4/P4_DGPMonomial_shape0011.png
  * </td> </tr> <tr> <td align="center"> $P_4$ element, shape function 10 </td>
  *
  * <td align="center"> $P_4$ element, shape function 11 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPMonomial/P4/P4_DGPMonomial_shape0012.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPMonomial/P4/P4_DGPMonomial_shape0012.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPMonomial/P4/P4_DGPMonomial_shape0013.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPMonomial/P4/P4_DGPMonomial_shape0013.png
  * </td> </tr> <tr> <td align="center"> $P_4$ element, shape function 12 </td>
  *
  * <td align="center"> $P_4$ element, shape function 13 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPMonomial/P4/P4_DGPMonomial_shape0014.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPMonomial/P4/P4_DGPMonomial_shape0014.png
  * </td>
  *
  * <td align="center"> </td> </tr> <tr> <td align="center"> $P_4$ element,
index dcf93e02a4209e00a78f98717fd84a85dd9c809c..c6c1b534fbbc8b5e78f38efc2da4f000654eee55 100644 (file)
@@ -56,8 +56,7 @@ DEAL_II_NAMESPACE_OPEN
  * <h4>$P_0$ element</h4>
  *
  * <table> <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPNonparametric/P1/P1_DGPNonparametric_shape0000.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPNonparametric/P1/P1_DGPNonparametric_shape0000.png
  * </td>
  *
  * <td align="center"> </td> </tr> <tr> <td align="center"> $P_0$ element,
@@ -68,20 +67,17 @@ DEAL_II_NAMESPACE_OPEN
  * <h4>$P_1$ element</h4>
  *
  * <table> <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPNonparametric/P1/P1_DGPNonparametric_shape0000.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPNonparametric/P1/P1_DGPNonparametric_shape0000.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPNonparametric/P1/P1_DGPNonparametric_shape0001.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPNonparametric/P1/P1_DGPNonparametric_shape0001.png
  * </td> </tr> <tr> <td align="center"> $P_1$ element, shape function 0 </td>
  *
  * <td align="center"> $P_1$ element, shape function 1 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPNonparametric/P1/P1_DGPNonparametric_shape0002.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPNonparametric/P1/P1_DGPNonparametric_shape0002.png
  * </td>
  *
  * <td align="center"> </td> </tr> <tr> <td align="center"> $P_1$ element,
@@ -93,37 +89,31 @@ DEAL_II_NAMESPACE_OPEN
  * <h4>$P_2$ element</h4>
  *
  * <table> <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPNonparametric/P2/P2_DGPNonparametric_shape0000.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPNonparametric/P2/P2_DGPNonparametric_shape0000.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPNonparametric/P2/P2_DGPNonparametric_shape0001.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPNonparametric/P2/P2_DGPNonparametric_shape0001.png
  * </td> </tr> <tr> <td align="center"> $P_2$ element, shape function 0 </td>
  *
  * <td align="center"> $P_2$ element, shape function 1 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPNonparametric/P2/P2_DGPNonparametric_shape0002.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPNonparametric/P2/P2_DGPNonparametric_shape0002.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPNonparametric/P2/P2_DGPNonparametric_shape0003.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPNonparametric/P2/P2_DGPNonparametric_shape0003.png
  * </td> </tr> <tr> <td align="center"> $P_2$ element, shape function 2 </td>
  *
  * <td align="center"> $P_2$ element, shape function 3 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPNonparametric/P2/P2_DGPNonparametric_shape0004.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPNonparametric/P2/P2_DGPNonparametric_shape0004.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPNonparametric/P2/P2_DGPNonparametric_shape0005.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPNonparametric/P2/P2_DGPNonparametric_shape0005.png
  * </td> </tr> <tr> <td align="center"> $P_2$ element, shape function 4 </td>
  *
  * <td align="center"> $P_2$ element, shape function 5 </td> </tr> </table>
@@ -132,153 +122,128 @@ DEAL_II_NAMESPACE_OPEN
  * <h4>$P_3$ element</h4>
  *
  * <table> <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPNonparametric/P3/P3_DGPNonparametric_shape0000.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPNonparametric/P3/P3_DGPNonparametric_shape0000.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPNonparametric/P3/P3_DGPNonparametric_shape0001.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPNonparametric/P3/P3_DGPNonparametric_shape0001.png
  * </td> </tr> <tr> <td align="center"> $P_3$ element, shape function 0 </td>
  *
  * <td align="center"> $P_3$ element, shape function 1 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPNonparametric/P3/P3_DGPNonparametric_shape0002.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPNonparametric/P3/P3_DGPNonparametric_shape0002.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPNonparametric/P3/P3_DGPNonparametric_shape0003.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPNonparametric/P3/P3_DGPNonparametric_shape0003.png
  * </td> </tr> <tr> <td align="center"> $P_3$ element, shape function 2 </td>
  *
  * <td align="center"> $P_3$ element, shape function 3 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPNonparametric/P3/P3_DGPNonparametric_shape0004.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPNonparametric/P3/P3_DGPNonparametric_shape0004.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPNonparametric/P3/P3_DGPNonparametric_shape0005.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPNonparametric/P3/P3_DGPNonparametric_shape0005.png
  * </td> </tr> <tr> <td align="center"> $P_3$ element, shape function 4 </td>
  *
  * <td align="center"> $P_3$ element, shape function 5 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPNonparametric/P3/P3_DGPNonparametric_shape0006.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPNonparametric/P3/P3_DGPNonparametric_shape0006.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPNonparametric/P3/P3_DGPNonparametric_shape0007.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPNonparametric/P3/P3_DGPNonparametric_shape0007.png
  * </td> </tr> <tr> <td align="center"> $P_3$ element, shape function 6 </td>
  *
  * <td align="center"> $P_3$ element, shape function 7 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPNonparametric/P3/P3_DGPNonparametric_shape0008.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPNonparametric/P3/P3_DGPNonparametric_shape0008.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPNonparametric/P3/P3_DGPNonparametric_shape0009.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPNonparametric/P3/P3_DGPNonparametric_shape0009.png
  * </td> </tr> <tr> <td align="center"> $P_3$ element, shape function 8 </td>
  *
  * <td align="center"> $P_3$ element, shape function 9 </td> </tr> </table>
  *
  *
  * <h4>$P_4$ element</h4> <table> <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPNonparametric/P4/P4_DGPNonparametric_shape0000.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPNonparametric/P4/P4_DGPNonparametric_shape0000.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPNonparametric/P4/P4_DGPNonparametric_shape0001.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPNonparametric/P4/P4_DGPNonparametric_shape0001.png
  * </td> </tr> <tr> <td align="center"> $P_4$ element, shape function 0 </td>
  *
  * <td align="center"> $P_4$ element, shape function 1 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPNonparametric/P4/P4_DGPNonparametric_shape0002.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPNonparametric/P4/P4_DGPNonparametric_shape0002.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPNonparametric/P4/P4_DGPNonparametric_shape0003.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPNonparametric/P4/P4_DGPNonparametric_shape0003.png
  * </td> </tr> <tr> <td align="center"> $P_4$ element, shape function 2 </td>
  *
  * <td align="center"> $P_4$ element, shape function 3 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPNonparametric/P4/P4_DGPNonparametric_shape0004.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPNonparametric/P4/P4_DGPNonparametric_shape0004.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPNonparametric/P4/P4_DGPNonparametric_shape0005.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPNonparametric/P4/P4_DGPNonparametric_shape0005.png
  * </td> </tr> <tr> <td align="center"> $P_4$ element, shape function 4 </td>
  *
  * <td align="center"> $P_4$ element, shape function 5 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPNonparametric/P4/P4_DGPNonparametric_shape0006.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPNonparametric/P4/P4_DGPNonparametric_shape0006.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPNonparametric/P4/P4_DGPNonparametric_shape0007.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPNonparametric/P4/P4_DGPNonparametric_shape0007.png
  * </td> </tr> <tr> <td align="center"> $P_4$ element, shape function 6 </td>
  *
  * <td align="center"> $P_4$ element, shape function 7 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPNonparametric/P4/P4_DGPNonparametric_shape0008.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPNonparametric/P4/P4_DGPNonparametric_shape0008.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPNonparametric/P4/P4_DGPNonparametric_shape0009.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPNonparametric/P4/P4_DGPNonparametric_shape0009.png
  * </td> </tr> <tr> <td align="center"> $P_4$ element, shape function 8 </td>
  *
  * <td align="center"> $P_4$ element, shape function 9 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPNonparametric/P4/P4_DGPNonparametric_shape0010.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPNonparametric/P4/P4_DGPNonparametric_shape0010.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPNonparametric/P4/P4_DGPNonparametric_shape0011.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPNonparametric/P4/P4_DGPNonparametric_shape0011.png
  * </td> </tr> <tr> <td align="center"> $P_4$ element, shape function 10 </td>
  *
  * <td align="center"> $P_4$ element, shape function 11 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPNonparametric/P4/P4_DGPNonparametric_shape0012.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPNonparametric/P4/P4_DGPNonparametric_shape0012.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPNonparametric/P4/P4_DGPNonparametric_shape0013.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPNonparametric/P4/P4_DGPNonparametric_shape0013.png
  * </td> </tr> <tr> <td align="center"> $P_4$ element, shape function 12 </td>
  *
  * <td align="center"> $P_4$ element, shape function 13 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/DGPNonparametric/P4/P4_DGPNonparametric_shape0014.png
+ * @image html http://www.dealii.org/images/shape-functions/DGPNonparametric/P4/P4_DGPNonparametric_shape0014.png
  * </td>
  *
  * <td align="center"> </td> </tr> <tr> <td align="center"> $P_4$ element,
index 8ee2c37a2e75f2c23d0cded4d874add355ac85f0..55e66f67201e0ec328445d8485837aee5c73f974 100644 (file)
@@ -522,10 +522,10 @@ protected:
      * The variable is made mutable as InternalData's provided to fill_fe_values
      * and alike are const.
      *
-     * @note We do not want to store this information in the finite element
-     * object itself, because this would mean that (i) only one FEValues object
-     * could use a finite element object at a time, and (ii) that these objects
-     * could not be used in a multithreaded context.
+     * @note We do not want to store this information in the finite element object itself,
+     * because this would mean that (i) only one FEValues object could use a
+     * finite element object at a time, and (ii) that these objects could not be
+     * used in a multithreaded context.
      */
     mutable std::vector<std::vector<EnrichmentValues>> enrichment;
   };
@@ -533,8 +533,8 @@ protected:
   /**
    * For each finite element @p i used in enrichment and each enrichment function
    * @p j associated with it (essentially its multiplicity),
-   * @p base_no_mult_local_enriched_dofs[i][j] contains the associated local DoFs
-   * on the FE_Enriched finite element.
+   * @p base_no_mult_local_enriched_dofs[i][j] contains the associated local
+   * DoFs on the FE_Enriched finite element.
    */
   std::vector<std::vector<std::vector<unsigned int>>>
     base_no_mult_local_enriched_dofs;
index 317470d42bd70ff1664841f75c1714366c8e851f..ab86e24fb56bbf69c0918d79d67f26c28588dde9 100644 (file)
@@ -225,8 +225,7 @@ protected:
    * <ul>
    * <li> $\lambda_{i}$ - trilinear function, equal to one at the $i$-th vertex
    * and zero at all other vertices.</li>
-   * <li> $\sigma_{i}$ - linear functional associated with the $i$-th
-   * vertex.</li>
+   * <li> $\sigma_{i}$ - linear functional associated with the $i$-th vertex.</li>
    * </ul>
    *
    * The definitions of these functionals, as well as the edge and face
index d54d530d4439cead7f47cecc11291da191fbf02a..0487ac76557ac11636b1acd36c86dd0ba68026f9 100644 (file)
@@ -142,25 +142,21 @@ DEAL_II_NAMESPACE_OPEN
  *
  * In 2d, these shape functions look as follows: <table> <tr> <td
  * align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q1/Q1_shape0000.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q1/Q1_shape0000.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q1/Q1_shape0001.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q1/Q1_shape0001.png
  * </td> </tr> <tr> <td align="center"> $Q_1$ element, shape function 0 </td>
  *
  * <td align="center"> $Q_1$ element, shape function 1 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q1/Q1_shape0002.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q1/Q1_shape0002.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q1/Q1_shape0003.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q1/Q1_shape0003.png
  * </td> </tr> <tr> <td align="center"> $Q_1$ element, shape function 2 </td>
  *
  * <td align="center"> $Q_1$ element, shape function 3 </td> </tr> </table>
@@ -245,56 +241,47 @@ DEAL_II_NAMESPACE_OPEN
  * In 2d, these shape functions look as follows (the black plane corresponds
  * to zero; negative shape function values may not be visible): <table> <tr>
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q2/Q2_shape0000.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q2/Q2_shape0000.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q2/Q2_shape0001.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q2/Q2_shape0001.png
  * </td> </tr> <tr> <td align="center"> $Q_2$ element, shape function 0 </td>
  *
  * <td align="center"> $Q_2$ element, shape function 1 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q2/Q2_shape0002.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q2/Q2_shape0002.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q2/Q2_shape0003.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q2/Q2_shape0003.png
  * </td> </tr> <tr> <td align="center"> $Q_2$ element, shape function 2 </td>
  *
  * <td align="center"> $Q_2$ element, shape function 3 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q2/Q2_shape0004.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q2/Q2_shape0004.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q2/Q2_shape0005.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q2/Q2_shape0005.png
  * </td> </tr> <tr> <td align="center"> $Q_2$ element, shape function 4 </td>
  *
  * <td align="center"> $Q_2$ element, shape function 5 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q2/Q2_shape0006.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q2/Q2_shape0006.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q2/Q2_shape0007.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q2/Q2_shape0007.png
  * </td> </tr> <tr> <td align="center"> $Q_2$ element, shape function 6 </td>
  *
  * <td align="center"> $Q_2$ element, shape function 7 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q2/Q2_shape0008.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q2/Q2_shape0008.png
  * </td>
  *
  * <td align="center"> </td> </tr> <tr> <td align="center"> $Q_2$ element,
@@ -325,97 +312,81 @@ DEAL_II_NAMESPACE_OPEN
  * In 2d, these shape functions look as follows (the black plane corresponds
  * to zero; negative shape function values may not be visible): <table> <tr>
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q3/Q3_shape0000.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q3/Q3_shape0000.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q3/Q3_shape0001.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q3/Q3_shape0001.png
  * </td> </tr> <tr> <td align="center"> $Q_3$ element, shape function 0 </td>
  *
  * <td align="center"> $Q_3$ element, shape function 1 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q3/Q3_shape0002.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q3/Q3_shape0002.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q3/Q3_shape0003.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q3/Q3_shape0003.png
  * </td> </tr> <tr> <td align="center"> $Q_3$ element, shape function 2 </td>
  *
  * <td align="center"> $Q_3$ element, shape function 3 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q3/Q3_shape0004.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q3/Q3_shape0004.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q3/Q3_shape0005.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q3/Q3_shape0005.png
  * </td> </tr> <tr> <td align="center"> $Q_3$ element, shape function 4 </td>
  *
  * <td align="center"> $Q_3$ element, shape function 5 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q3/Q3_shape0006.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q3/Q3_shape0006.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q3/Q3_shape0007.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q3/Q3_shape0007.png
  * </td> </tr> <tr> <td align="center"> $Q_3$ element, shape function 6 </td>
  *
  * <td align="center"> $Q_3$ element, shape function 7 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q3/Q3_shape0008.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q3/Q3_shape0008.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q3/Q3_shape0009.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q3/Q3_shape0009.png
  * </td> </tr> <tr> <td align="center"> $Q_3$ element, shape function 8 </td>
  *
  * <td align="center"> $Q_3$ element, shape function 9 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q3/Q3_shape0010.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q3/Q3_shape0010.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q3/Q3_shape0011.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q3/Q3_shape0011.png
  * </td> </tr> <tr> <td align="center"> $Q_3$ element, shape function 10 </td>
  *
  * <td align="center"> $Q_3$ element, shape function 11 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q3/Q3_shape0012.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q3/Q3_shape0012.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q3/Q3_shape0013.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q3/Q3_shape0013.png
  * </td> </tr> <tr> <td align="center"> $Q_3$ element, shape function 12 </td>
  *
  * <td align="center"> $Q_3$ element, shape function 13 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q3/Q3_shape0014.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q3/Q3_shape0014.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q3/Q3_shape0015.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q3/Q3_shape0015.png
  * </td> </tr> <tr> <td align="center"> $Q_3$ element, shape function 14 </td>
  *
  * <td align="center"> $Q_3$ element, shape function 15 </td> </tr> </table>
@@ -445,152 +416,127 @@ DEAL_II_NAMESPACE_OPEN
  * In 2d, these shape functions look as follows (the black plane corresponds
  * to zero; negative shape function values may not be visible): <table> <tr>
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0000.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0000.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0001.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0001.png
  * </td> </tr> <tr> <td align="center"> $Q_4$ element, shape function 0 </td>
  *
  * <td align="center"> $Q_4$ element, shape function 1 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0002.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0002.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0003.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0003.png
  * </td> </tr> <tr> <td align="center"> $Q_4$ element, shape function 2 </td>
  *
  * <td align="center"> $Q_4$ element, shape function 3 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0004.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0004.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0005.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0005.png
  * </td> </tr> <tr> <td align="center"> $Q_4$ element, shape function 4 </td>
  *
  * <td align="center"> $Q_4$ element, shape function 5 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0006.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0006.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0007.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0007.png
  * </td> </tr> <tr> <td align="center"> $Q_4$ element, shape function 6 </td>
  *
  * <td align="center"> $Q_4$ element, shape function 7 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0008.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0008.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0009.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0009.png
  * </td> </tr> <tr> <td align="center"> $Q_4$ element, shape function 8 </td>
  *
  * <td align="center"> $Q_4$ element, shape function 9 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0010.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0010.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0011.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0011.png
  * </td> </tr> <tr> <td align="center"> $Q_4$ element, shape function 10 </td>
  *
  * <td align="center"> $Q_4$ element, shape function 11 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0012.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0012.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0013.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0013.png
  * </td> </tr> <tr> <td align="center"> $Q_4$ element, shape function 12 </td>
  *
  * <td align="center"> $Q_4$ element, shape function 13 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0014.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0014.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0015.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0015.png
  * </td> </tr> <tr> <td align="center"> $Q_4$ element, shape function 14 </td>
  *
  * <td align="center"> $Q_4$ element, shape function 15 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0016.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0016.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0017.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0017.png
  * </td> </tr> <tr> <td align="center"> $Q_4$ element, shape function 16 </td>
  *
  * <td align="center"> $Q_4$ element, shape function 17 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0018.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0018.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0019.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0019.png
  * </td> </tr> <tr> <td align="center"> $Q_4$ element, shape function 18 </td>
  *
  * <td align="center"> $Q_4$ element, shape function 19 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0020.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0020.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0021.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0021.png
  * </td> </tr> <tr> <td align="center"> $Q_4$ element, shape function 20 </td>
  *
  * <td align="center"> $Q_4$ element, shape function 21 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0022.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0022.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0023.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0023.png
  * </td> </tr> <tr> <td align="center"> $Q_4$ element, shape function 22 </td>
  *
  * <td align="center"> $Q_4$ element, shape function 23 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0024.png
+ * @image html http://www.dealii.org/images/shape-functions/lagrange/Q4/Q4_shape0024.png
  * </td>
  *
  * <td align="center"> </td> </tr> <tr> <td align="center"> $Q_4$ element,
index 67e02b74f949be7151a2bb92fb468d3736391778..85c4a7533f05543851d68f0cbc81361fc6eb7bd9 100644 (file)
@@ -107,26 +107,22 @@ DEAL_II_NAMESPACE_OPEN
  *
  * In 2d, these shape functions look as follows: <table> <tr> <td
  * align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q1/Q1H_shape0000.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q1/Q1H_shape0000.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q1/Q1H_shape0001.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q1/Q1H_shape0001.png
  * </td> </tr> <tr> <td align="center"> $Q_1^H$ element, shape function 0
  * </td>
  *
  * <td align="center"> $Q_1^H$ element, shape function 1 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q1/Q1H_shape0002.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q1/Q1H_shape0002.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q1/Q1H_shape0003.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q1/Q1H_shape0003.png
  * </td> </tr> <tr> <td align="center"> $Q_1^H$ element, shape function 2
  * </td>
  *
@@ -212,60 +208,51 @@ DEAL_II_NAMESPACE_OPEN
  * In 2d, these shape functions look as follows (the black plane corresponds
  * to zero; negative shape function values may not be visible): <table> <tr>
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q2/Q2H_shape0000.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q2/Q2H_shape0000.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q2/Q2H_shape0001.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q2/Q2H_shape0001.png
  * </td> </tr> <tr> <td align="center"> $Q_2^H$ element, shape function 0
  * </td>
  *
  * <td align="center"> $Q_2^H$ element, shape function 1 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q2/Q2H_shape0002.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q2/Q2H_shape0002.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q2/Q2H_shape0003.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q2/Q2H_shape0003.png
  * </td> </tr> <tr> <td align="center"> $Q_2^H$ element, shape function 2
  * </td>
  *
  * <td align="center"> $Q_2^H$ element, shape function 3 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q2/Q2H_shape0004.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q2/Q2H_shape0004.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q2/Q2H_shape0005.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q2/Q2H_shape0005.png
  * </td> </tr> <tr> <td align="center"> $Q_2^H$ element, shape function 4
  * </td>
  *
  * <td align="center"> $Q_2^H$ element, shape function 5 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q2/Q2H_shape0006.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q2/Q2H_shape0006.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q2/Q2H_shape0007.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q2/Q2H_shape0007.png
  * </td> </tr> <tr> <td align="center"> $Q_2^H$ element, shape function 6
  * </td>
  *
  * <td align="center"> $Q_2^H$ element, shape function 7 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q2/Q2H_shape0008.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q2/Q2H_shape0008.png
  * </td>
  *
  * <td align="center"> </td> </tr> <tr> <td align="center"> $Q_2^H$ element,
@@ -296,104 +283,88 @@ DEAL_II_NAMESPACE_OPEN
  * In 2d, these shape functions look as follows (the black plane corresponds
  * to zero; negative shape function values may not be visible): <table> <tr>
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q3/Q3H_shape0000.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q3/Q3H_shape0000.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q3/Q3H_shape0001.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q3/Q3H_shape0001.png
  * </td> </tr> <tr> <td align="center"> $Q_3^H$ element, shape function 0
  * </td>
  *
  * <td align="center"> $Q_3^H$ element, shape function 1 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q3/Q3H_shape0002.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q3/Q3H_shape0002.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q3/Q3H_shape0003.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q3/Q3H_shape0003.png
  * </td> </tr> <tr> <td align="center"> $Q_3^H$ element, shape function 2
  * </td>
  *
  * <td align="center"> $Q_3^H$ element, shape function 3 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q3/Q3H_shape0004.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q3/Q3H_shape0004.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q3/Q3H_shape0005.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q3/Q3H_shape0005.png
  * </td> </tr> <tr> <td align="center"> $Q_3^H$ element, shape function 4
  * </td>
  *
  * <td align="center"> $Q_3^H$ element, shape function 5 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q3/Q3H_shape0006.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q3/Q3H_shape0006.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q3/Q3H_shape0007.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q3/Q3H_shape0007.png
  * </td> </tr> <tr> <td align="center"> $Q_3^H$ element, shape function 6
  * </td>
  *
  * <td align="center"> $Q_3^H$ element, shape function 7 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q3/Q3H_shape0008.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q3/Q3H_shape0008.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q3/Q3H_shape0009.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q3/Q3H_shape0009.png
  * </td> </tr> <tr> <td align="center"> $Q_3^H$ element, shape function 8
  * </td>
  *
  * <td align="center"> $Q_3^H$ element, shape function 9 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q3/Q3H_shape0010.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q3/Q3H_shape0010.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q3/Q3H_shape0011.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q3/Q3H_shape0011.png
  * </td> </tr> <tr> <td align="center"> $Q_3^H$ element, shape function 10
  * </td>
  *
  * <td align="center"> $Q_3^H$ element, shape function 11 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q3/Q3H_shape0012.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q3/Q3H_shape0012.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q3/Q3H_shape0013.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q3/Q3H_shape0013.png
  * </td> </tr> <tr> <td align="center"> $Q_3^H$ element, shape function 12
  * </td>
  *
  * <td align="center"> $Q_3^H$ element, shape function 13 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q3/Q3H_shape0014.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q3/Q3H_shape0014.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q3/Q3H_shape0015.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q3/Q3H_shape0015.png
  * </td> </tr> <tr> <td align="center"> $Q_3^H$ element, shape function 14
  * </td>
  *
@@ -424,164 +395,139 @@ DEAL_II_NAMESPACE_OPEN
  * In 2d, these shape functions look as follows (the black plane corresponds
  * to zero; negative shape function values may not be visible): <table> <tr>
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0000.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0000.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0001.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0001.png
  * </td> </tr> <tr> <td align="center"> $Q_4^H$ element, shape function 0
  * </td>
  *
  * <td align="center"> $Q_4^H$ element, shape function 1 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0002.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0002.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0003.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0003.png
  * </td> </tr> <tr> <td align="center"> $Q_4^H$ element, shape function 2
  * </td>
  *
  * <td align="center"> $Q_4^H$ element, shape function 3 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0004.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0004.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0005.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0005.png
  * </td> </tr> <tr> <td align="center"> $Q_4^H$ element, shape function 4
  * </td>
  *
  * <td align="center"> $Q_4^H$ element, shape function 5 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0006.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0006.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0007.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0007.png
  * </td> </tr> <tr> <td align="center"> $Q_4^H$ element, shape function 6
  * </td>
  *
  * <td align="center"> $Q_4^H$ element, shape function 7 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0008.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0008.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0009.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0009.png
  * </td> </tr> <tr> <td align="center"> $Q_4^H$ element, shape function 8
  * </td>
  *
  * <td align="center"> $Q_4^H$ element, shape function 9 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0010.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0010.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0011.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0011.png
  * </td> </tr> <tr> <td align="center"> $Q_4^H$ element, shape function 10
  * </td>
  *
  * <td align="center"> $Q_4^H$ element, shape function 11 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0012.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0012.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0013.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0013.png
  * </td> </tr> <tr> <td align="center"> $Q_4^H$ element, shape function 12
  * </td>
  *
  * <td align="center"> $Q_4^H$ element, shape function 13 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0014.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0014.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0015.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0015.png
  * </td> </tr> <tr> <td align="center"> $Q_4^H$ element, shape function 14
  * </td>
  *
  * <td align="center"> $Q_4^H$ element, shape function 15 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0016.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0016.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0017.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0017.png
  * </td> </tr> <tr> <td align="center"> $Q_4^H$ element, shape function 16
  * </td>
  *
  * <td align="center"> $Q_4^H$ element, shape function 17 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0018.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0018.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0019.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0019.png
  * </td> </tr> <tr> <td align="center"> $Q_4^H$ element, shape function 18
  * </td>
  *
  * <td align="center"> $Q_4^H$ element, shape function 19 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0020.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0020.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0021.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0021.png
  * </td> </tr> <tr> <td align="center"> $Q_4^H$ element, shape function 20
  * </td>
  *
  * <td align="center"> $Q_4^H$ element, shape function 21 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0022.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0022.png
  * </td>
  *
  * <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0023.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0023.png
  * </td> </tr> <tr> <td align="center"> $Q_4^H$ element, shape function 22
  * </td>
  *
  * <td align="center"> $Q_4^H$ element, shape function 23 </td> </tr>
  *
  * <tr> <td align="center">
- * @image html
- * http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0024.png
+ * @image html http://www.dealii.org/images/shape-functions/hierarchical/Q4/Q4H_shape0024.png
  * </td>
  *
  * <td align="center"> </td> </tr> <tr> <td align="center"> $Q_4^H$ element,
index b9229e02742eed432e21fb26aaae97e495794082..ca10e762d7394da8f7d7b9281bb71de14961fb2e 100644 (file)
@@ -71,8 +71,8 @@ DEAL_II_NAMESPACE_OPEN
  * solution and stabilization techniques are used that work for linears but
  * not higher order elements. </li>
  *
- * <li> Stokes/Navier Stokes systems such as the one discussed in step-22 could
- * be solved with Q2-iso-Q1 elements for velocities instead of Q2 elements.
+ * <li> Stokes/Navier Stokes systems such as the one discussed in step-22 could be
+ * solved with Q2-iso-Q1 elements for velocities instead of Q2 elements.
  * Combined with Q1 pressures they give a stable mixed element pair. However,
  * they perform worse than the standard (Taylor-Hood $Q_2\times Q_1$)
  * approach in most situations.  </li>
index 681b4dda6fa14d2e43793aacc47943bdf10f3fa8..104b201cf5758ce06819dd22109dbe29cc5fc4aa 100644 (file)
@@ -254,10 +254,10 @@ namespace FESeries
    * @p predicate being constant. Return the pair of vectors of predicate values
    * and the vector of calculated subset norms.
    *
-   * @p predicate should return a pair of <code>bool</code> and <code>unsigned int</code>.
-   * The former is a flag whether a given TableIndices should be used in
-   * calculation, whereas the latter is the unrolled value of indices according
-   * to which the subsets of coefficients will be formed.
+   * @p predicate should return a pair of <code>bool</code> and <code>unsigned
+   * int</code>. The former is a flag whether a given TableIndices should be
+   * used in calculation, whereas the latter is the unrolled value of indices
+   * according to which the subsets of coefficients will be formed.
    *
    * @note Only the following values of @p norm are implemented and make sense
    * in this case: mean, L1_norm, L2_norm, Linfty_norm. The mean norm can only
index 1290cc1b5c3fdaf06ed33dfdc15e342f4e9b9f12..38b1e6a25baed734312173bc2686d00b8749f0f9 100644 (file)
@@ -82,8 +82,7 @@ namespace GridGenerator
    * cells. See hyper_rectangle(), if different lengths in different ordinate
    * directions are required.
    *
-   * @note The triangulation passed as argument needs to be empty when calling
-   * this function.
+   * @note The triangulation passed as argument needs to be empty when calling this function.
    */
   template <int dim, int spacedim>
   void
@@ -132,8 +131,7 @@ namespace GridGenerator
    * dimensional space with the remaining entries set to zero. For example, a
    * <tt>Triangulation@<2,3@></tt> will be a square in the xy plane with z=0.
    *
-   * @note The triangulation passed as argument needs to be empty when calling
-   * this function.
+   * @note The triangulation passed as argument needs to be empty when calling this function.
    */
   template <int dim, int spacedim>
   void
@@ -169,8 +167,7 @@ namespace GridGenerator
    * <tt>Triangulation@<2,3@></tt> will be a rectangle in the xy plane with
    * z=0, defined by the two opposing corners @p p1 and @p p2.
    *
-   * @note The triangulation passed as argument needs to be empty when calling
-   * this function.
+   * @note The triangulation passed as argument needs to be empty when calling this function.
    */
   template <int dim, int spacedim>
   void
@@ -335,8 +332,7 @@ namespace GridGenerator
    *
    * @note This function is implemented in 2d only.
    *
-   * @note The triangulation passed as argument needs to be empty when calling
-   * this function.
+   * @note The triangulation passed as argument needs to be empty when calling this function.
    */
   template <int dim>
   void
@@ -356,8 +352,7 @@ namespace GridGenerator
    * vertices in the array of <code>corners</code> will no longer refer to the
    * same triangulation.
    *
-   * @note The triangulation passed as argument needs to be empty when calling
-   * this function.
+   * @note The triangulation passed as argument needs to be empty when calling this function.
    */
   template <int dim>
   void
@@ -373,8 +368,7 @@ namespace GridGenerator
    * of subdivisions in each of the @p dim directions. Colorizing is done
    * according to hyper_rectangle().
    *
-   * @note The triangulation passed as argument needs to be empty when calling
-   * this function.
+   * @note The triangulation passed as argument needs to be empty when calling this function.
    */
   template <int dim>
   void
@@ -388,8 +382,7 @@ namespace GridGenerator
    * number of subdivisions in each of the @p dim directions may vary.
    * Colorizing is done according to hyper_rectangle().
    *
-   * @note The triangulation passed as argument needs to be empty when calling
-   * this function.
+   * @note The triangulation passed as argument needs to be empty when calling this function.
    */
   template <int dim>
   void
@@ -445,8 +438,7 @@ namespace GridGenerator
    *
    * Presently only available in 2d and 3d.
    *
-   * @note The triangulation passed as argument needs to be empty when calling
-   * this function.
+   * @note The triangulation passed as argument needs to be empty when calling this function.
    */
   template <int dim>
   void
@@ -488,8 +480,7 @@ namespace GridGenerator
    * SphericalManifold manifold also to the boundary cells, and not only to the
    * boundary faces.
    *
-   * @note The triangulation passed as argument needs to be empty when calling
-   * this function.
+   * @note The triangulation passed as argument needs to be empty when calling this function.
    */
   template <int dim>
   void
@@ -520,8 +511,7 @@ namespace GridGenerator
    * @image html sphere.png
    * @image html sphere_section.png
    *
-   * @note The triangulation passed as argument needs to be empty when calling
-   * this function.
+   * @note The triangulation passed as argument needs to be empty when calling this function.
    */
 
   template <int spacedim>
@@ -555,8 +545,7 @@ namespace GridGenerator
    * boundary and 1 for the cut plane. The manifold id for the curved boundary
    * is set to zero, and a SphericalManifold is attached to it.
    *
-   * @note The triangulation passed as argument needs to be empty when calling
-   * this function.
+   * @note The triangulation passed as argument needs to be empty when calling this function.
    */
   template <int dim>
   void
@@ -585,8 +574,7 @@ namespace GridGenerator
    * The manifold id for the hull of the cylinder is set to zero, and a
    * CylindricalManifold is attached to it.
    *
-   * @note The triangulation passed as argument needs to be empty when calling
-   * this function.
+   * @note The triangulation passed as argument needs to be empty when calling this function.
    */
   template <int dim>
   void
@@ -614,8 +602,7 @@ namespace GridGenerator
    * In three dimensions, the manifold id of the hull is set to zero, and a
    * CylindricalManifold is attached to it.
    *
-   * @note The triangulation passed as argument needs to be empty when calling
-   * this function.
+   * @note The triangulation passed as argument needs to be empty when calling this function.
    *
    * @author Markus B&uuml;rg, 2009
    */
@@ -691,8 +678,7 @@ namespace GridGenerator
    * This function exists for triangulations of all space
    * dimensions, but throws an error if called in 1d.
    *
-   * @note The triangulation passed as argument needs to be empty when calling
-   * this function.
+   * @note The triangulation passed as argument needs to be empty when calling this function.
    */
   template <int dim>
   void
@@ -716,8 +702,7 @@ namespace GridGenerator
    * If @p colorize is set to @p true, the faces forming the slit are marked
    * with boundary id 1 and 2, respectively.
    *
-   * @note The triangulation passed as argument needs to be empty when calling
-   * this function.
+   * @note The triangulation passed as argument needs to be empty when calling this function.
    */
   template <int dim>
   void
@@ -761,8 +746,7 @@ namespace GridGenerator
    * @note This function is declared to exist for triangulations of all space
    * dimensions, but throws an error if called in 1d.
    *
-   * @note The triangulation passed as argument needs to be empty when calling
-   * this function.
+   * @note The triangulation passed as argument needs to be empty when calling this function.
    */
   template <int dim>
   void
@@ -795,8 +779,7 @@ namespace GridGenerator
    * All manifold ids are set to zero, and a SphericalManifold is attached
    * to the triangulation.
    *
-   * @note The triangulation passed as argument needs to be empty when calling
-   * this function.
+   * @note The triangulation passed as argument needs to be empty when calling this function.
    */
   template <int dim>
   void
@@ -829,8 +812,7 @@ namespace GridGenerator
    * All manifold ids are set to zero, and a SphericalManifold is attached
    * to the triangulation.
    *
-   * @note The triangulation passed as argument needs to be empty when calling
-   * this function.
+   * @note The triangulation passed as argument needs to be empty when calling this function.
    */
   template <int dim>
   void
@@ -858,8 +840,7 @@ namespace GridGenerator
    * All manifold ids are set to zero, and a CylindricalManifold is attached
    * to the triangulation.
    *
-   * @note The triangulation passed as argument needs to be empty when calling
-   * this function.
+   * @note The triangulation passed as argument needs to be empty when calling this function.
    */
   template <int dim>
   void
index 9d2acdf4de0ff65007072b892b9dcda8751d425c..fa217687d55ee9eceac3dd35423094dc913ddc34 100644 (file)
@@ -682,7 +682,8 @@ namespace GridTools
    * If @p points[a] and @p points[b] are the only two points that fall in @p cells[c],
    * then @p qpoints[c][0] and @p qpoints[c][1] are the reference positions of
    * @p points[a] and @p points[b] in @p cells[c], and @p indices[c][0] = a,
-   * @p indices[c][1] = b. The function Mapping::transform_unit_to_real(qpoints[c][0])
+   * @p indices[c][1] = b. The function
+   * Mapping::transform_unit_to_real(qpoints[c][0])
    * returns @p points[a].
    *
    * The algorithm assumes it's easier to look for a point in the cell that was
@@ -721,8 +722,8 @@ namespace GridTools
 
   /**
    * Given a @p cache and a list of
-   * @p local_points for each process, find the points lying on the locally owned
-   * part of the mesh and compute the quadrature rules for them.
+   * @p local_points for each process, find the points lying on the locally
+   * owned part of the mesh and compute the quadrature rules for them.
    * Distributed compute point locations is a function similar to
    * GridTools::compute_point_locations but working for parallel::Triangulation
    * objects and, unlike its serial version, also for a distributed
@@ -1492,7 +1493,8 @@ namespace GridTools
    *  If @p max_boxes was left as default or bigger than 1 these two boxes would be returned.
    * - 4. Because @p max_boxes = 1 the smallest bounding box is merged to the bigger one.
    * Notice it is important to choose the parameters wisely. For instance, @p allow_merge = false and
-   * @p refinement_level = 1 returns the very same bounding box but with a fraction of the computational cost.
+   * @p refinement_level = 1 returns the very same bounding box but with a
+   * fraction of the computational cost.
    *
    * This function does not take into account the curvature of cells and thus it
    * is not suited for handling curved geometry: the mapping is assumed to be
index c649ce33dcd9501fae1b0a62b18eff64e82e4b3d..f182bda310309928a7174a1fdaa6e2a0f0555bc3 100644 (file)
@@ -201,8 +201,8 @@ namespace Manifolds
  * between the two points in ${\mathbb R}^d$.
  *
  *
- * @note Unlike almost all other cases in the library, we here interpret the
- * points to be in real space, not on the reference cell.
+ * @note Unlike almost all other cases in the library, we here interpret the points
+ * to be in real space, not on the reference cell.
  *
  * Manifold::get_new_point() has a default implementation that can
  * simplify this process somewhat: Internally, the function calls the
index 9874ad7a32fa35ae2383afff170e3bc7cf2688db..af87f1df30fdb168a5ac0989ae7ed9cd355bd877 100644 (file)
@@ -164,8 +164,7 @@ dseupd_(int *         rvec,
  * @ref step_36 "step-36"
  * for an example.
  *
- * @author Baerbel Janssen, Agnieszka Miedlar, 2010, Guido Kanschat 2015, Joscha
- * Gedicke 2016
+ * @author Baerbel Janssen, Agnieszka Miedlar, 2010, Guido Kanschat 2015, Joscha Gedicke 2016
  */
 class ArpackSolver : public Subscriptor
 {
index d48df437f7d779ebaec4701fbdd5ed674d66a03e..a694fc341014889d56455a878743567f543220c5 100644 (file)
@@ -461,9 +461,8 @@ public:
    * @note It is assumed that @p A, @p B and @p V have compatible sizes and that
    * @p C already has the right size.
    *
-   * @note This function is not provided by LAPACK. The function first forms
-   * $\rm{diag}(\mathbf V) \cdot \mathbf B$ product and then uses Xgemm
-   * function.
+   * @note This function is not provided by LAPACK. The function first forms $\rm{diag}(\mathbf V) \cdot \mathbf B$ product and
+   * then uses Xgemm function.
    */
   void
   Tmmult(LAPACKFullMatrix<number> &      C,
@@ -546,8 +545,7 @@ public:
    * Compute the Cholesky factorization of the matrix using LAPACK function
    * Xpotrf.
    *
-   * @note The factorization is stored in the lower-triangular part of the
-   * matrix.
+   * @note The factorization is stored in the lower-triangular part of the matrix.
    */
   void
   compute_cholesky_factorization();
@@ -558,8 +556,8 @@ public:
    * positive definite matrix using Cholesky factorization. This function can
    * only be called if the matrix is already factorized.
    *
-   * @note The condition number $k(\mathbf A)$ can be used to estimate the
-   * numerical error related to the matrix inversion or the solution of the
+   * @note The condition number $k(\mathbf A)$ can be used to estimate the numerical
+   * error related to the matrix inversion or the solution of the
    * system of linear algebraic equations as
    * <code>error = std::numeric_limits<Number>::epsilon * k</code>.
    * Alternatively one can get the number of accurate digits
index 512c08c74ac4e5dfad3c582e0e047637a082c35a..13e17c6331da151641296db6ce517036ebcca0d5 100644 (file)
@@ -382,8 +382,8 @@ public:
    *
    * If this function is not called, the shift is assumed to be zero.
    *
-   * @note only relevant for <code>mode=3</code> (see the general documentation
-   * of this class for a definition of what the different modes are).
+   * @note only relevant for <code>mode=3</code> (see the general documentation of this
+   * class for a definition of what the different modes are).
    */
   void
   set_shift(const std::complex<double> sigma);
index d55969f18048c19dc628f2bb1ac9aed6b9185d36..6e366cdf1bca022619d78196de2d8868b9f163da 100644 (file)
@@ -239,8 +239,8 @@ namespace PETScWrappers
        * way, the ghost parameter can equal the set of locally relevant
        * degrees of freedom, see step-32.
        *
-       * @note This operation always creates a ghosted vector, which is
-       * considered read-only.
+       * @note This operation always creates a ghosted vector, which is considered
+       * read-only.
        *
        * @see
        * @ref GlossGhostedVector "vectors with ghost elements"
index 40ca5f91b2841a0534f0bf63a106db6dbfae24ec..54e21e83ffdeafeeb37575d6cbabd8487a299820 100644 (file)
@@ -240,8 +240,8 @@ namespace LinearAlgebra
      * };
      * @endcode
      *
-     * @note This function requires that the header
-     * read_write_vector.templates.h be included.
+     * @note This function requires that the header read_write_vector.templates.h
+     * be included.
      */
     template <typename Functor>
     void
index ea5e9c3e7e3088f915170685fcf21540443c57f5..e86c8b6cdd44b6f89cd42ff22eeb425fc8c158f0 100644 (file)
@@ -252,12 +252,10 @@ public:
    * The operations based on the input parameter @p transpose_B and the
    * alignment conditions are summarized in the following table:
    *
-   * | transpose_B |          Block Sizes         |                    Operation
-   * | | :---------: | :--------------------------: |
-   * :-------------------------------------------: | |   false     | $MB_A=MB_B$
-   * <br> $NB_A=NB_B$ |  $\mathbf{A} = a \mathbf{A} + b \mathbf{B}$   | |   true
-   * | $MB_A=NB_B$ <br> $NB_A=MB_B$ | $\mathbf{A} = a \mathbf{A} + b
-   * \mathbf{B}^T$  |
+   * | transpose_B |          Block Sizes         |                    Operation                  |
+   * | :---------: | :--------------------------: | :-------------------------------------------: |
+   * |   false     | $MB_A=MB_B$ <br> $NB_A=NB_B$ |  $\mathbf{A} = a \mathbf{A} + b \mathbf{B}$   |
+   * |   true      | $MB_A=NB_B$ <br> $NB_A=MB_B$ | $\mathbf{A} = a \mathbf{A} + b \mathbf{B}^T$  |
    *
    * The matrices $\mathbf{A}$ and $\mathbf{B}$ must have the same process grid.
    */
@@ -297,17 +295,12 @@ public:
    * The operations based on the input parameters and the alignment conditions
    * are summarized in the following table:
    *
-   * | transpose_A | transpose_B |                  Block Sizes | Operation | |
-   * :---------: | :---------: | :-------------------------------------------: |
-   * :-------------------------------------------------------------: | | false
-   * |   false     | $MB_A=MB_C$ <br> $NB_A=MB_B$ <br> $NB_B=NB_C$ | $\mathbf{C}
-   * = b \mathbf{A} \cdot \mathbf{B} + c \mathbf{C}$   | | false       |   true
-   * | $MB_A=MB_C$ <br> $NB_A=NB_B$ <br> $MB_B=NB_C$ |  $\mathbf{C} = b
-   * \mathbf{A} \cdot \mathbf{B}^T + c \mathbf{C}$  | | true        |   false |
-   * $MB_A=MB_B$ <br> $NB_A=MB_C$ <br> $NB_B=NB_C$ | $\mathbf{C} = b
-   * \mathbf{A}^T \cdot \mathbf{B} + c \mathbf{C}$   | | true        |   true |
-   * $MB_A=NB_B$ <br> $NB_A=MB_C$ <br> $MB_B=NB_C$ | $\mathbf{C} = b
-   * \mathbf{A}^T \cdot \mathbf{B}^T + c \mathbf{C}$ |
+   * | transpose_A | transpose_B |                  Block Sizes                  |                             Operation                           |
+   * | :---------: | :---------: | :-------------------------------------------: | :-------------------------------------------------------------: |
+   * | false       |   false     | $MB_A=MB_C$ <br> $NB_A=MB_B$ <br> $NB_B=NB_C$ |   $\mathbf{C} = b \mathbf{A} \cdot \mathbf{B} + c \mathbf{C}$   |
+   * | false       |   true      | $MB_A=MB_C$ <br> $NB_A=NB_B$ <br> $MB_B=NB_C$ |  $\mathbf{C} = b \mathbf{A} \cdot \mathbf{B}^T + c \mathbf{C}$  |
+   * | true        |   false     | $MB_A=MB_B$ <br> $NB_A=MB_C$ <br> $NB_B=NB_C$ | $\mathbf{C} = b \mathbf{A}^T \cdot \mathbf{B} + c \mathbf{C}$   |
+   * | true        |   true      | $MB_A=NB_B$ <br> $NB_A=MB_C$ <br> $MB_B=NB_C$ | $\mathbf{C} = b \mathbf{A}^T \cdot \mathbf{B}^T + c \mathbf{C}$ |
    *
    * It is assumed that $\mathbf{A}$ and $\mathbf{B}$ have compatible sizes and
    * that
@@ -816,8 +809,7 @@ private:
    *
    * If successful, the computed eigenvalues are arranged in ascending order.
    *
-   * @note Due to a bug in Netlib-ScaLAPACK, either all or no eigenvectors can
-   * be computed.
+   * @note Due to a bug in Netlib-ScaLAPACK, either all or no eigenvectors can be computed.
    * Therefore, the input @p index_limits has to be set accordingly. Using Intel-MKL this restriction is not required.
    */
   std::vector<NumberType>
index 628a64844cc1b4c0ed06ab6dee49a814aa26a9bf..86db46b762690a1362f6bfdbfc0c39216f627cf6 100644 (file)
@@ -609,7 +609,8 @@ extern "C"
    * It is not required that the matrices A and B have the same process grid or
    * block size, e.g. copying a matrix from a one-dimensional to a
    * two-dimensional process grid
-   * @p ictxt is a context which is at least a union of all processes in context A and B
+   * @p ictxt is a context which is at least a union of all processes in context
+   * A and B
    */
   void
   pdgemr2d_(const int *   m,
index 5d3c09e4bfbff4cf5ef3ba08f1768ba4599b1350..3a86de7c08f3db8900369900e97808b3d67478b5 100644 (file)
@@ -207,9 +207,9 @@ private:
  * @tparam dim Dimension of the problem. Currently, 1D, 2D, and 3D codes are
  * implemented.
  *
- * @tparam Number Arithmetic type of the underlying array elements. Note that
- * the underlying LAPACK implementation supports only float and double numbers,
- * so only these two types are currently supported by the generic class.
+ * @tparam Number Arithmetic type of the underlying array elements. Note that the
+ * underlying LAPACK implementation supports only float and double numbers, so
+ * only these two types are currently supported by the generic class.
  * Nevertheless, a template specialization for the vectorized types
  * VectorizedArray<float> and VectorizedArray<double> exists. This is necessary
  * to perform LAPACK calculations for each vectorization lane, i.e. for the
index 316b245f28659fd02bf173859c514dc70c03a0df..a75ca3187f23abdf00f3806bc87161b408e51a2d 100644 (file)
@@ -1629,8 +1629,8 @@ namespace TrilinosWrappers
    * except for the higher_order_elements parameter which does not exist in
    * PreconditionerAMGMueLu.
    *
-   * @note This class requires Trilinos 11.14 or higher. At the moment
-   * 64bit-indices are not supported.
+   * @note This class requires Trilinos 11.14 or higher. At the moment 64bit-indices
+   * are not supported.
    *
    * @warning This interface should not be considered as stable.
    *
index 9c9e124f1fd1b041b63a30474bb0dc870894f336..1eec59510e0687bf978b2f28008dbaac9d8366b7 100644 (file)
@@ -53,8 +53,8 @@ namespace CUDAWrappers
    *
    * @tparam dim Dimension in which this class is to be used
    *
-   * @tparam fe_degree Degree of the tensor prodict finite element with
-   * fe_degree+1 degrees of freedom per coordinate direction
+   * @tparam fe_degree Degree of the tensor prodict finite element with fe_degree+1
+   * degrees of freedom per coordinate direction
    *
    * @tparam n_q_points_1d Number of points in the quadrature formular in 1D,
    * defaults to fe_degree+1
index 0b1d4e45f2c401daefb06481eb09e58b050be883..7c799fc226357bfa61acef82cfb84fb70e948955 100644 (file)
@@ -76,8 +76,8 @@ namespace internal
    * @tparam variant Variant of evaluation used for creating template
    *                 specializations
    * @tparam dim Dimension of the function
-   * @tparam n_rows Number of rows in the transformation matrix, which
-   * corresponds to the number of 1d shape functions in the usual tensor
+   * @tparam n_rows Number of rows in the transformation matrix, which corresponds
+   *                to the number of 1d shape functions in the usual tensor
    *                contraction setting
    * @tparam n_columns Number of columns in the transformation matrix, which
    *                   corresponds to the number of 1d shape functions in the
@@ -103,8 +103,8 @@ namespace internal
    * tensor product form of the basis functions.
    *
    * @tparam dim Space dimension in which this class is applied
-   * @tparam n_rows Number of rows in the transformation matrix, which
-   * corresponds to the number of 1d shape functions in the usual tensor
+   * @tparam n_rows Number of rows in the transformation matrix, which corresponds
+   *                to the number of 1d shape functions in the usual tensor
    *                contraction setting
    * @tparam n_columns Number of columns in the transformation matrix, which
    *                   corresponds to the number of 1d shape functions in the
@@ -259,12 +259,15 @@ namespace internal
      * before calling any interpolation within the face.
      *
      * @tparam face_direction Direction of the normal vector (0=x, 1=y, etc)
-     * @tparam contract_onto_face If true, the input vector is of size
-     * n_rows^dim and interpolation into n_rows^(dim-1) points is performed.
-     * This is a typical scenario in FEFaceEvaluation::evaluate() calls. If
-     * false, data from n_rows^(dim-1) points is expanded into the n_rows^dim
-     * points of the higher- dimensional data array. Derivatives in the case
-     * contract_onto_face==false are summed together
+     * @tparam contract_onto_face If true, the input vector is of size n_rows^dim
+     *                            and interpolation into n_rows^(dim-1) points
+     *                            is performed. This is a typical scenario in
+     *                            FEFaceEvaluation::evaluate() calls. If false,
+     *                            data from n_rows^(dim-1) points is expanded
+     *                            into the n_rows^dim points of the higher-
+     *                            dimensional data array. Derivatives in the
+     *                            case contract_onto_face==false are summed
+     *                            together
      * @tparam add If true, the result is added to the output vector, else
      *             the computed values overwrite the content in the output
      * @tparam max_derivative Sets the number of derivatives that should be
@@ -852,8 +855,8 @@ namespace internal
    * are, too.
    *
    * @tparam dim Space dimension in which this class is applied
-   * @tparam n_rows Number of rows in the transformation matrix, which
-   * corresponds to the number of 1d shape functions in the usual tensor
+   * @tparam n_rows Number of rows in the transformation matrix, which corresponds
+   *                to the number of 1d shape functions in the usual tensor
    *                contraction setting
    * @tparam n_columns Number of columns in the transformation matrix, which
    *                   corresponds to the number of 1d shape functions in the
@@ -1432,8 +1435,8 @@ namespace internal
    * constants (templates).
    *
    * @tparam dim Space dimension in which this class is applied
-   * @tparam n_rows Number of rows in the transformation matrix, which
-   * corresponds to the number of 1d shape functions in the usual tensor
+   * @tparam n_rows Number of rows in the transformation matrix, which corresponds
+   *                to the number of 1d shape functions in the usual tensor
    *                contraction setting
    * @tparam n_columns Number of columns in the transformation matrix, which
    *                   corresponds to the number of 1d shape functions in the
@@ -1821,8 +1824,8 @@ namespace internal
    * difference is in the way the input and output quantities are symmetrized.
    *
    * @tparam dim Space dimension in which this class is applied
-   * @tparam n_rows Number of rows in the transformation matrix, which
-   * corresponds to the number of 1d shape functions in the usual tensor
+   * @tparam n_rows Number of rows in the transformation matrix, which corresponds
+   *                to the number of 1d shape functions in the usual tensor
    *                contraction setting
    * @tparam n_columns Number of columns in the transformation matrix, which
    *                   corresponds to the number of 1d shape functions in the
index c6df1c9337c572bac5e3692d077a4f4e20b586b6..a8fe5b4e707daba4cf159fa5a821485f58925c8d 100644 (file)
@@ -73,10 +73,10 @@ namespace MeshWorker
    * the same principles of WorkStream::run. Internally the function passes to
    * @p boundary_worker, in addition to the above, also a @p face_no parameter
    * that identifies the face on which the integration should be performed. The
-   * @p face_worker instead needs to identify the current face unambiguously both on
-   * the cell and on the neighboring cell, and it is therefore called with six
-   * arguments (three for each cell: the actual cell, the face index, and
-   * the subface_index. If no subface integration is needed, then the
+   * @p face_worker instead needs to identify the current face unambiguously
+   * both on the cell and on the neighboring cell, and it is therefore called
+   * with six arguments (three for each cell: the actual cell, the face index,
+   * and the subface_index. If no subface integration is needed, then the
    * subface_index is numbers::invalid_unsigned_int) in addition to the usual
    * ScratchData and CopyData objects.
    *
index 2bd38545a4d74134468cc7f4f5c492925b33bac0..0e40ae0398fd4b09bde7ec529bc14f52b4db9f7c 100644 (file)
@@ -76,8 +76,7 @@ public:
    * constrains degrees on the external boundary of the domain by calling
    * MGTools::make_boundary_list() with the given second and third argument.
    *
-   * @deprecated Use initialize() followed by make_zero_boundary_constraints()
-   * instead
+   * @deprecated Use initialize() followed by make_zero_boundary_constraints() instead
    */
   template <int dim, int spacedim>
   DEAL_II_DEPRECATED void
index 379eee70e4c8265ff001baacbb62b774635e9f8c..39a5b537d8fd39d1abf6ede55ffc53057c2f4721 100644 (file)
@@ -53,53 +53,55 @@ namespace mg
   struct Signals
   {
     /**
-     * This signal is triggered before (@p before is true) and after (@p before is
-     * false) the call to MGTransfer::copy_to_mg which transfers the vector
+     * This signal is triggered before (@p before is true) and after (@p before
+     * is false) the call to MGTransfer::copy_to_mg which transfers the vector
      * given to it to a multi-level vector.
      */
     boost::signals2::signal<void(const bool before)> transfer_to_mg;
 
     /**
-     * This signal is triggered before (@p before is true) and after (@p before is
-     * false) the call to MGTransfer::copy_from_mg which transfers the
+     * This signal is triggered before (@p before is true) and after (@p before
+     * is false) the call to MGTransfer::copy_from_mg which transfers the
      * multi-level vector given to it to a normal vector.
      */
     boost::signals2::signal<void(const bool before)> transfer_to_global;
 
     /**
-     * This signal is triggered before (@p before is true) and after (@p before is
+     * This signal is triggered before (@p before is true) and after (@p before
+     * is
      * false) the call to the coarse solver on @p level.
      */
     boost::signals2::signal<void(const bool before, const unsigned int level)>
       coarse_solve;
 
     /**
-     * This signal is triggered before (@p before is true) and after (@p before is
-     * false) the call to MGTransfer::restrict_and_add() which restricts a
+     * This signal is triggered before (@p before is true) and after (@p before
+     * is false) the call to MGTransfer::restrict_and_add() which restricts a
      * vector from @p level to the next coarser one (@p level - 1).
      */
     boost::signals2::signal<void(const bool before, const unsigned int level)>
       restriction;
 
     /**
-     * This signal is triggered before (@p before is true) and after (@p before is
-     * false) the call to MGTransfer::prolongate() which prolongs a vector to
+     * This signal is triggered before (@p before is true) and after (@p before
+     * is false) the call to MGTransfer::prolongate() which prolongs a vector to
      * @p level from the next coarser one (@p level - 1).
      */
     boost::signals2::signal<void(const bool before, const unsigned int level)>
       prolongation;
 
     /**
-     * This signal is triggered before (@p before is true) and after (@p before is
-     * false) the call to a pre-smoothing step via MGPreSmoother::apply() on
+     * This signal is triggered before (@p before is true) and after (@p before
+     * is false) the call to a pre-smoothing step via MGPreSmoother::apply() on
      * @p level.
      */
     boost::signals2::signal<void(const bool before, const unsigned int level)>
       pre_smoother_step;
 
     /**
-     * This signal is triggered before (@p before is true) and after (@p before is
-     * false) the call to a post-smoothing step via MGPostSmoother::apply() on
+     * This signal is triggered before (@p before is true) and after (@p before
+     * is false) the call to a post-smoothing step via MGPostSmoother::apply()
+     * on
      * @p level.
      */
     boost::signals2::signal<void(const bool before, const unsigned int level)>
index d33862632babf1d0dcac443056b7717f003f1e5a..ff7df13dd0a4e44c3d0d4e2b6bad964deeaea754 100644 (file)
@@ -716,8 +716,7 @@ private:
  *     // like above, but now also make sure that DataOut provides
  *     // us with coordinates of the evaluation points:
  *     DataPostprocessorVector<dim> ("heat_flux",
- *                                   update_gradients |
- * update_quadrature_points)
+ *                                   update_gradients | update_quadrature_points)
  *   {}
  *
  *   virtual
index 905ac1e478932a7b9af7e4ca92505ad12c878712..dee9ad3220d5018332d4ff122bc17134b0622eff 100644 (file)
@@ -1803,8 +1803,8 @@ namespace VectorTools
    * function multiple times with only one boundary indicator, or whether we
    * call the function once with the whole set of boundary indicators at once.
    *
-   * Argument four (@p function_map) describes the boundary function $\vec u_\Gamma$
-   * for each boundary id. The function <code>function_map[id]</code>
+   * Argument four (@p function_map) describes the boundary function $\vec
+   * u_\Gamma$ for each boundary id. The function <code>function_map[id]</code>
    * is used on boundary with id @p id taken from the set @p boundary_ids.
    * Each function in @p function_map is expected to have @p dim
    * components, which are used independent of @p first_vector_component.
index abb9393c2305e9cccce02f45dc45f7fbb4959d75..69cd64f3aeda77e96cfd972f17be133463839c23 100644 (file)
@@ -94,8 +94,8 @@ namespace OpenCASCADE
    *
    * @author Luca Heltai, Andrea Mola, 2011--2014.
    *
-   * @deprecated Use DirectionalProjectionManifold instead, which is identical
-   * to this class but satisfies the modern Manifold-based naming convention.
+   * @deprecated Use DirectionalProjectionManifold instead, which is identical to
+   * this class but satisfies the modern Manifold-based naming convention.
    */
   template <int dim, int spacedim>
   class DEAL_II_DEPRECATED DirectionalProjectionBoundary
@@ -160,8 +160,8 @@ namespace OpenCASCADE
    *
    * @author Luca Heltai, Andrea Mola, 2011--2014.
    *
-   * @deprecated Use NormalToMeshProjectionManifold instead, which is identical
-   * to this class but satisfies the modern Manifold-based naming convention.
+   * @deprecated Use NormalToMeshProjectionManifold instead, which is identical to
+   * this class but satisfies the modern Manifold-based naming convention.
    */
   template <int dim, int spacedim>
   class DEAL_II_DEPRECATED NormalToMeshProjectionBoundary
index 472a070c7e1fbc62f0ba0c48ae98e851beaa333f..512f5d52b87f64c887f546bb5ec00cafef201ad5 100644 (file)
@@ -91,8 +91,8 @@ namespace Physics
        * $\mathcal{S}$ introduced in the Physics::Elasticity namespace
        * description and that which is returned by identity_tensor().
        *
-       * @note If you apply this to a standard tensor then it doesn't behave
-       * like the fourth-order identity tensor, but rather as a symmetrization
+       * @note If you apply this to a standard tensor then it doesn't behave like
+       * the fourth-order identity tensor, but rather as a symmetrization
        * operator.
        */
       static const SymmetricTensor<4, dim> S;
@@ -201,12 +201,12 @@ namespace Physics
        * \hat{\mathcal{P}} \equiv \hat{\mathcal{P}}^{T} : \bar{\mathbf{S}} \, .
        * @f]
        *
-       * @note Comparing the definition of this tensor in Holzapfel (2001) to
-       * that adopted here, the inclusion of the extra factor
-       * $J^{-2/\textrm{dim}}$ does not, at the outset, seem to be a reasonable
-       * choice. However, in the author's view it makes direct implementation of
-       * the expressions for isochoric (referential) stress contributions and
-       * their linearization simpler in practise.
+       * @note Comparing the definition of this tensor in Holzapfel (2001) to that
+       * adopted here, the inclusion of the extra factor $J^{-2/\textrm{dim}}$
+       * does not, at the outset, seem to be a reasonable choice. However, in
+       * the author's view it makes direct implementation of the expressions for
+       * isochoric (referential) stress contributions and their linearization
+       * simpler in practise.
        *
        * @dealiiWriggersA{46,3.125}
        * @dealiiHolzapfelA{229,6.83}
index 50e5f0d307c9140b99a3647c7079e6349e5239f6..b18b3dcaec0d72527b43d73f1b05bf6efaa067c2 100644 (file)
@@ -1812,8 +1812,8 @@ namespace DoFTools
      *
      * @precondition: face_1 is supposed to be active
      *
-     * @note As bug #82 ((http://code.google.com/p/dealii/issues/detail?id=82)
-     * and the corresponding testcase bits/periodicity_05 demonstrate, we can
+     * @note As bug #82 ((http://code.google.com/p/dealii/issues/detail?id=82) and the
+     * corresponding testcase bits/periodicity_05 demonstrate, we can
      * occasionally get into trouble if we already have the constraint x1=x2 and
      * want to insert x2=x1. we avoid this by skipping an identity constraint if
      * the opposite constraint already exists
index 9a1b91e26717789175f99deead463021864621bb..b31dc9ed8080615234b0de022141bb8617b9d5c2 100644 (file)
@@ -651,9 +651,9 @@ namespace internal
     {
       /**
        * Depending on what information is called for in the update flags of the
-       * @p data object, compute the various pieces of information that is required
-       * by the fill_fe_face_values() and fill_fe_subface_values() functions.
-       * This function simply unifies the work that would be done by
+       * @p data object, compute the various pieces of information that is
+       * required by the fill_fe_face_values() and fill_fe_subface_values()
+       * functions. This function simply unifies the work that would be done by
        * those two functions.
        *
        * The resulting data is put into the @p output_data argument.
index a991eacd2b23a74a4d6d3e1f7140753f4b15ff50..e2f08ad7cbc4848cccf467f5db9f2fc7669faeb6 100644 (file)
@@ -2992,9 +2992,9 @@ namespace internal
     {
       /**
        * Depending on what information is called for in the update flags of the
-       * @p data object, compute the various pieces of information that is required
-       * by the fill_fe_face_values() and fill_fe_subface_values() functions.
-       * This function simply unifies the work that would be done by
+       * @p data object, compute the various pieces of information that is
+       * required by the fill_fe_face_values() and fill_fe_subface_values()
+       * functions. This function simply unifies the work that would be done by
        * those two functions.
        *
        * The resulting data is put into the @p output_data argument.
index 7bece82c99c4afeaecdab9d83a83f2bb7e7fbfd8..e7dccc92a2307cca5985fc49849edbf8c302e370 100644 (file)
@@ -14556,8 +14556,13 @@ Triangulation<dim, spacedim>::prepare_coarsening_and_refinement()
                                     //                            / /
                                     //                           / /
                                     //                          *---------------*
-                                    //                          | | | | | | | |
-                                    //                          | | | | / | |/
+                                    //                          |               |
+                                    //                          |               |
+                                    //                          |               |
+                                    //                          |               |
+                                    //                          |               |
+                                    //                          |               | /
+                                    //                          |               |/
                                     //                          *---------------*
                                     //
                                     //
@@ -14582,9 +14587,13 @@ Triangulation<dim, spacedim>::prepare_coarsening_and_refinement()
                                     //                            / /
                                     //                           / /
                                     //                          *---------------*
-                                    //                          | | | | / | |/
+                                    //                          |               |
+                                    //                          |               | /
+                                    //                          |               |/
                                     //                          *---------------*
-                                    //                          | | | | / | |/
+                                    //                          |               |
+                                    //                          |               | /
+                                    //                          |               |/
                                     //                          *---------------*
                                     //
                                     //
@@ -14611,11 +14620,13 @@ Triangulation<dim, spacedim>::prepare_coarsening_and_refinement()
                                     //                            /       / /
                                     //                           /       / /
                                     //                          *-------*-------*
-                                    //                          |       | | | |
-                                    //                          | / |       | |/
+                                    //                          |       |       |
+                                    //                          |       |       | /
+                                    //                          |       |       |/
                                     //                          *-------*-------*
-                                    //                          |       | | | |
-                                    //                          | / |       | |/
+                                    //                          |       |       |
+                                    //                          |       |       | /
+                                    //                          |       |       |/
                                     //                          *-------*-------*
                                     //
                                     //
@@ -14637,11 +14648,13 @@ Triangulation<dim, spacedim>::prepare_coarsening_and_refinement()
                                     //                            /       / /
                                     //                           /       / /
                                     //                          *-------*-------*
-                                    //                          |       | | | |
-                                    //                          | / |       | |/
+                                    //                          |       |       |
+                                    //                          |       |       | /
+                                    //                          |       |       |/
                                     //                          *-------*-------*
-                                    //                          |       | | | |
-                                    //                          | / |       | |/
+                                    //                          |       |       |
+                                    //                          |       |       | /
+                                    //                          |       |       |/
                                     //                          *-------*-------*
                                     //
                                     //

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.