From ac0b9bf61e993d4aa966274304c3334fbd6c77a4 Mon Sep 17 00:00:00 2001 From: Matthias Maier Date: Wed, 13 Jun 2018 14:13:43 -0500 Subject: [PATCH] Fix broken doxygen formatting --- include/deal.II/base/array_view.h | 4 +- include/deal.II/base/geometry_info.h | 8 +- include/deal.II/base/parameter_acceptor.h | 3 +- include/deal.II/base/parameter_handler.h | 3 +- include/deal.II/base/polynomial.h | 3 +- include/deal.II/base/polynomials_rt_bubbles.h | 5 +- include/deal.II/base/quadrature_point_data.h | 22 +-- include/deal.II/base/symmetric_tensor.h | 16 +- include/deal.II/base/thread_management.h | 8 +- .../differentiation/ad/ad_number_traits.h | 6 +- .../differentiation/ad/adolc_number_types.h | 10 +- include/deal.II/distributed/shared_tria.h | 7 +- include/deal.II/dofs/dof_renumbering.h | 6 +- include/deal.II/fe/fe.h | 46 ++--- include/deal.II/fe/fe_dgp.h | 105 ++++-------- include/deal.II/fe/fe_dgp_monomial.h | 105 ++++-------- include/deal.II/fe/fe_dgp_nonparametric.h | 105 ++++-------- include/deal.II/fe/fe_enriched.h | 12 +- include/deal.II/fe/fe_nedelec_sz.h | 3 +- include/deal.II/fe/fe_q.h | 162 ++++++------------ include/deal.II/fe/fe_q_hierarchical.h | 162 ++++++------------ include/deal.II/fe/fe_q_iso_q1.h | 4 +- include/deal.II/fe/fe_series.h | 8 +- include/deal.II/grid/grid_generator.h | 57 ++---- include/deal.II/grid/grid_tools.h | 10 +- include/deal.II/grid/manifold.h | 4 +- include/deal.II/lac/arpack_solver.h | 3 +- include/deal.II/lac/lapack_full_matrix.h | 12 +- include/deal.II/lac/parpack_solver.h | 4 +- include/deal.II/lac/petsc_parallel_vector.h | 4 +- include/deal.II/lac/read_write_vector.h | 4 +- include/deal.II/lac/scalapack.h | 30 ++-- include/deal.II/lac/scalapack.templates.h | 3 +- include/deal.II/lac/tensor_product_matrix.h | 6 +- include/deal.II/lac/trilinos_precondition.h | 4 +- .../deal.II/matrix_free/cuda_fe_evaluation.h | 4 +- .../matrix_free/tensor_product_kernels.h | 35 ++-- include/deal.II/meshworker/mesh_loop.h | 8 +- .../deal.II/multigrid/mg_constrained_dofs.h | 3 +- include/deal.II/multigrid/multigrid.h | 28 +-- include/deal.II/numerics/data_postprocessor.h | 3 +- include/deal.II/numerics/vector_tools.h | 4 +- include/deal.II/opencascade/boundary_lib.h | 8 +- .../physics/elasticity/standard_tensors.h | 16 +- source/dofs/dof_tools_constraints.cc | 4 +- source/fe/mapping_manifold.cc | 6 +- source/fe/mapping_q_generic.cc | 6 +- source/grid/tria.cc | 37 ++-- 48 files changed, 444 insertions(+), 672 deletions(-) diff --git a/include/deal.II/base/array_view.h b/include/deal.II/base/array_view.h index 1eccd86125..b50ee7854e 100644 --- a/include/deal.II/base/array_view.h +++ b/include/deal.II/base/array_view.h @@ -549,8 +549,8 @@ make_array_view(const ArrayView &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. * diff --git a/include/deal.II/base/geometry_info.h b/include/deal.II/base/geometry_info.h index ab8e2799b1..b586b2284d 100644 --- a/include/deal.II/base/geometry_info.h +++ b/include/deal.II/base/geometry_info.h @@ -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 | * *---+---* * * *---*---* diff --git a/include/deal.II/base/parameter_acceptor.h b/include/deal.II/base/parameter_acceptor.h index ba1303c541..df955e207e 100644 --- a/include/deal.II/base/parameter_acceptor.h +++ b/include/deal.II/base/parameter_acceptor.h @@ -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 diff --git a/include/deal.II/base/parameter_handler.h b/include/deal.II/base/parameter_handler.h index cf571cb201..f056df7049 100644 --- a/include/deal.II/base/parameter_handler.h +++ b/include/deal.II/base/parameter_handler.h @@ -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 */ diff --git a/include/deal.II/base/polynomial.h b/include/deal.II/base/polynomial.h index d81c85fdd8..93de2a51e6 100644 --- a/include/deal.II/base/polynomial.h +++ b/include/deal.II/base/polynomial.h @@ -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 class Polynomial : public Subscriptor diff --git a/include/deal.II/base/polynomials_rt_bubbles.h b/include/deal.II/base/polynomials_rt_bubbles.h index c8a2cd55e0..458982e778 100644 --- a/include/deal.II/base/polynomials_rt_bubbles.h +++ b/include/deal.II/base/polynomials_rt_bubbles.h @@ -65,9 +65,8 @@ DEAL_II_NAMESPACE_OPEN * * 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 dim(Vk) = d*(k+1)^d, where * d is the space dimension. This allows to associate shape functions diff --git a/include/deal.II/base/quadrature_point_data.h b/include/deal.II/base/quadrature_point_data.h index 23c8af64a0..1c1c3cfdda 100644 --- a/include/deal.II/base/quadrature_point_data.h +++ b/include/deal.II/base/quadrature_point_data.h @@ -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 diff --git a/include/deal.II/base/symmetric_tensor.h b/include/deal.II/base/symmetric_tensor.h index 2e00bc982d..af3a480184 100644 --- a/include/deal.II/base/symmetric_tensor.h +++ b/include/deal.II/base/symmetric_tensor.h @@ -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 */ diff --git a/include/deal.II/base/thread_management.h b/include/deal.II/base/thread_management.h index ca70dc82f0..7b4171499f 100644 --- a/include/deal.II/base/thread_management.h +++ b/include/deal.II/base/thread_management.h @@ -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 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 create_int (const std::string &s) { ... } * diff --git a/include/deal.II/differentiation/ad/ad_number_traits.h b/include/deal.II/differentiation/ad/ad_number_traits.h index ae8bd2fa97..769bbc580a 100644 --- a/include/deal.II/differentiation/ad/ad_number_traits.h +++ b/include/deal.II/differentiation/ad/ad_number_traits.h @@ -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. * diff --git a/include/deal.II/differentiation/ad/adolc_number_types.h b/include/deal.II/differentiation/ad/adolc_number_types.h index 506dfae052..8b9aa3f919 100644 --- a/include/deal.II/differentiation/ad/adolc_number_types.h +++ b/include/deal.II/differentiation/ad/adolc_number_types.h @@ -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 */ diff --git a/include/deal.II/distributed/shared_tria.h b/include/deal.II/distributed/shared_tria.h index 87ad225651..fc6a1e3d40 100644 --- a/include/deal.II/distributed/shared_tria.h +++ b/include/deal.II/distributed/shared_tria.h @@ -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( diff --git a/include/deal.II/dofs/dof_renumbering.h b/include/deal.II/dofs/dof_renumbering.h index 3ab75b6b9b..0b317cb18f 100644 --- a/include/deal.II/dofs/dof_renumbering.h +++ b/include/deal.II/dofs/dof_renumbering.h @@ -827,9 +827,9 @@ namespace DoFRenumbering * degrees of freedom on this cell earlier 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 diff --git a/include/deal.II/fe/fe.h b/include/deal.II/fe/fe.h index 05e15ef072..96a9f21192 100644 --- a/include/deal.II/fe/fe.h +++ b/include/deal.II/fe/fe.h @@ -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 diff --git a/include/deal.II/fe/fe_dgp.h b/include/deal.II/fe/fe_dgp.h index bd537f46cb..5016822b7a 100644 --- a/include/deal.II/fe/fe_dgp.h +++ b/include/deal.II/fe/fe_dgp.h @@ -110,8 +110,7 @@ DEAL_II_NAMESPACE_OPEN *

$P_0$ element

* * * *
- * @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 *
$P_0$ element, @@ -122,20 +121,17 @@ DEAL_II_NAMESPACE_OPEN *

$P_1$ element

* * * * * * * * * *
- * @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 * - * @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 *
$P_1$ element, shape function 0 $P_1$ element, shape function 1
- * @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 *
$P_1$ element, @@ -147,37 +143,31 @@ DEAL_II_NAMESPACE_OPEN *

$P_2$ element

* * * * * * * * * * * * * * * * * *
- * @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 * - * @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 *
$P_2$ element, shape function 0 $P_2$ element, shape function 1
- * @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 * - * @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 *
$P_2$ element, shape function 2 $P_2$ element, shape function 3
- * @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 * - * @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 *
$P_2$ element, shape function 4 $P_2$ element, shape function 5
@@ -186,153 +176,128 @@ DEAL_II_NAMESPACE_OPEN *

$P_3$ element

* * * * * * * * * * * * * * * * * * * * * * * * * * * * * *
- * @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 * - * @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 *
$P_3$ element, shape function 0 $P_3$ element, shape function 1
- * @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 * - * @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 *
$P_3$ element, shape function 2 $P_3$ element, shape function 3
- * @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 * - * @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 *
$P_3$ element, shape function 4 $P_3$ element, shape function 5
- * @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 * - * @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 *
$P_3$ element, shape function 6 $P_3$ element, shape function 7
- * @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 * - * @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 *
$P_3$ element, shape function 8 $P_3$ element, shape function 9
* * *

$P_4$ element

* * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * *
- * @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 * - * @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 *
$P_4$ element, shape function 0 $P_4$ element, shape function 1
- * @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 * - * @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 *
$P_4$ element, shape function 2 $P_4$ element, shape function 3
- * @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 * - * @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 *
$P_4$ element, shape function 4 $P_4$ element, shape function 5
- * @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 * - * @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 *
$P_4$ element, shape function 6 $P_4$ element, shape function 7
- * @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 * - * @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 *
$P_4$ element, shape function 8 $P_4$ element, shape function 9
- * @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 * - * @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 *
$P_4$ element, shape function 10 $P_4$ element, shape function 11
- * @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 * - * @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 *
$P_4$ element, shape function 12 $P_4$ element, shape function 13
- * @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 *
$P_4$ element, diff --git a/include/deal.II/fe/fe_dgp_monomial.h b/include/deal.II/fe/fe_dgp_monomial.h index 6ca4abbf11..11be38054d 100644 --- a/include/deal.II/fe/fe_dgp_monomial.h +++ b/include/deal.II/fe/fe_dgp_monomial.h @@ -85,8 +85,7 @@ DEAL_II_NAMESPACE_OPEN *

$P_0$ element

* * * *
- * @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 *
$P_0$ element, @@ -97,20 +96,17 @@ DEAL_II_NAMESPACE_OPEN *

$P_1$ element

* * * * * * * * * *
- * @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 * - * @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 *
$P_1$ element, shape function 0 $P_1$ element, shape function 1
- * @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 *
$P_1$ element, @@ -122,37 +118,31 @@ DEAL_II_NAMESPACE_OPEN *

$P_2$ element

* * * * * * * * * * * * * * * * * *
- * @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 * - * @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 *
$P_2$ element, shape function 0 $P_2$ element, shape function 1
- * @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 * - * @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 *
$P_2$ element, shape function 2 $P_2$ element, shape function 3
- * @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 * - * @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 *
$P_2$ element, shape function 4 $P_2$ element, shape function 5
@@ -161,153 +151,128 @@ DEAL_II_NAMESPACE_OPEN *

$P_3$ element

* * * * * * * * * * * * * * * * * * * * * * * * * * * * * *
- * @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 * - * @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 *
$P_3$ element, shape function 0 $P_3$ element, shape function 1
- * @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 * - * @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 *
$P_3$ element, shape function 2 $P_3$ element, shape function 3
- * @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 * - * @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 *
$P_3$ element, shape function 4 $P_3$ element, shape function 5
- * @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 * - * @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 *
$P_3$ element, shape function 6 $P_3$ element, shape function 7
- * @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 * - * @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 *
$P_3$ element, shape function 8 $P_3$ element, shape function 9
* * *

$P_4$ element

* * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * *
- * @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 * - * @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 *
$P_4$ element, shape function 0 $P_4$ element, shape function 1
- * @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 * - * @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 *
$P_4$ element, shape function 2 $P_4$ element, shape function 3
- * @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 * - * @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 *
$P_4$ element, shape function 4 $P_4$ element, shape function 5
- * @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 * - * @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 *
$P_4$ element, shape function 6 $P_4$ element, shape function 7
- * @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 * - * @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 *
$P_4$ element, shape function 8 $P_4$ element, shape function 9
- * @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 * - * @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 *
$P_4$ element, shape function 10 $P_4$ element, shape function 11
- * @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 * - * @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 *
$P_4$ element, shape function 12 $P_4$ element, shape function 13
- * @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 *
$P_4$ element, diff --git a/include/deal.II/fe/fe_dgp_nonparametric.h b/include/deal.II/fe/fe_dgp_nonparametric.h index dcf93e02a4..c6c1b534fb 100644 --- a/include/deal.II/fe/fe_dgp_nonparametric.h +++ b/include/deal.II/fe/fe_dgp_nonparametric.h @@ -56,8 +56,7 @@ DEAL_II_NAMESPACE_OPEN *

$P_0$ element

* * * *
- * @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 *
$P_0$ element, @@ -68,20 +67,17 @@ DEAL_II_NAMESPACE_OPEN *

$P_1$ element

* * * * * * * * * *
- * @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 * - * @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 *
$P_1$ element, shape function 0 $P_1$ element, shape function 1
- * @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 *
$P_1$ element, @@ -93,37 +89,31 @@ DEAL_II_NAMESPACE_OPEN *

$P_2$ element

* * * * * * * * * * * * * * * * * *
- * @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 * - * @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 *
$P_2$ element, shape function 0 $P_2$ element, shape function 1
- * @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 * - * @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 *
$P_2$ element, shape function 2 $P_2$ element, shape function 3
- * @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 * - * @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 *
$P_2$ element, shape function 4 $P_2$ element, shape function 5
@@ -132,153 +122,128 @@ DEAL_II_NAMESPACE_OPEN *

$P_3$ element

* * * * * * * * * * * * * * * * * * * * * * * * * * * * * *
- * @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 * - * @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 *
$P_3$ element, shape function 0 $P_3$ element, shape function 1
- * @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 * - * @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 *
$P_3$ element, shape function 2 $P_3$ element, shape function 3
- * @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 * - * @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 *
$P_3$ element, shape function 4 $P_3$ element, shape function 5
- * @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 * - * @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 *
$P_3$ element, shape function 6 $P_3$ element, shape function 7
- * @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 * - * @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 *
$P_3$ element, shape function 8 $P_3$ element, shape function 9
* * *

$P_4$ element

* * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * *
- * @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 * - * @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 *
$P_4$ element, shape function 0 $P_4$ element, shape function 1
- * @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 * - * @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 *
$P_4$ element, shape function 2 $P_4$ element, shape function 3
- * @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 * - * @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 *
$P_4$ element, shape function 4 $P_4$ element, shape function 5
- * @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 * - * @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 *
$P_4$ element, shape function 6 $P_4$ element, shape function 7
- * @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 * - * @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 *
$P_4$ element, shape function 8 $P_4$ element, shape function 9
- * @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 * - * @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 *
$P_4$ element, shape function 10 $P_4$ element, shape function 11
- * @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 * - * @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 *
$P_4$ element, shape function 12 $P_4$ element, shape function 13
- * @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 *
$P_4$ element, diff --git a/include/deal.II/fe/fe_enriched.h b/include/deal.II/fe/fe_enriched.h index 8ee2c37a2e..55e66f6720 100644 --- a/include/deal.II/fe/fe_enriched.h +++ b/include/deal.II/fe/fe_enriched.h @@ -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> 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>> base_no_mult_local_enriched_dofs; diff --git a/include/deal.II/fe/fe_nedelec_sz.h b/include/deal.II/fe/fe_nedelec_sz.h index 317470d42b..ab86e24fb5 100644 --- a/include/deal.II/fe/fe_nedelec_sz.h +++ b/include/deal.II/fe/fe_nedelec_sz.h @@ -225,8 +225,7 @@ protected: *
    *
  • $\lambda_{i}$ - trilinear function, equal to one at the $i$-th vertex * and zero at all other vertices.
  • - *
  • $\sigma_{i}$ - linear functional associated with the $i$-th - * vertex.
  • + *
  • $\sigma_{i}$ - linear functional associated with the $i$-th vertex.
  • *
* * The definitions of these functionals, as well as the edge and face diff --git a/include/deal.II/fe/fe_q.h b/include/deal.II/fe/fe_q.h index d54d530d44..0487ac7655 100644 --- a/include/deal.II/fe/fe_q.h +++ b/include/deal.II/fe/fe_q.h @@ -142,25 +142,21 @@ DEAL_II_NAMESPACE_OPEN * * In 2d, these shape functions look as follows: * * * * * * * * * *
- * @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 * - * @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 *
$Q_1$ element, shape function 0 $Q_1$ element, shape function 1
- * @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 * - * @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 *
$Q_1$ element, shape function 2 $Q_1$ element, shape function 3
@@ -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): * * * * * * * * * * * * * * * * * * * * * * * * * * *
- * @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 * - * @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 *
$Q_2$ element, shape function 0 $Q_2$ element, shape function 1
- * @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 * - * @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 *
$Q_2$ element, shape function 2 $Q_2$ element, shape function 3
- * @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 * - * @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 *
$Q_2$ element, shape function 4 $Q_2$ element, shape function 5
- * @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 * - * @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 *
$Q_2$ element, shape function 6 $Q_2$ element, shape function 7
- * @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 *
$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): * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * *
- * @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 * - * @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 *
$Q_3$ element, shape function 0 $Q_3$ element, shape function 1
- * @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 * - * @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 *
$Q_3$ element, shape function 2 $Q_3$ element, shape function 3
- * @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 * - * @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 *
$Q_3$ element, shape function 4 $Q_3$ element, shape function 5
- * @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 * - * @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 *
$Q_3$ element, shape function 6 $Q_3$ element, shape function 7
- * @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 * - * @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 *
$Q_3$ element, shape function 8 $Q_3$ element, shape function 9
- * @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 * - * @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 *
$Q_3$ element, shape function 10 $Q_3$ element, shape function 11
- * @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 * - * @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 *
$Q_3$ element, shape function 12 $Q_3$ element, shape function 13
- * @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 * - * @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 *
$Q_3$ element, shape function 14 $Q_3$ element, shape function 15
@@ -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): * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * *
- * @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 * - * @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 *
$Q_4$ element, shape function 0 $Q_4$ element, shape function 1
- * @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 * - * @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 *
$Q_4$ element, shape function 2 $Q_4$ element, shape function 3
- * @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 * - * @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 *
$Q_4$ element, shape function 4 $Q_4$ element, shape function 5
- * @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 * - * @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 *
$Q_4$ element, shape function 6 $Q_4$ element, shape function 7
- * @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 * - * @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 *
$Q_4$ element, shape function 8 $Q_4$ element, shape function 9
- * @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 * - * @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 *
$Q_4$ element, shape function 10 $Q_4$ element, shape function 11
- * @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 * - * @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 *
$Q_4$ element, shape function 12 $Q_4$ element, shape function 13
- * @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 * - * @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 *
$Q_4$ element, shape function 14 $Q_4$ element, shape function 15
- * @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 * - * @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 *
$Q_4$ element, shape function 16 $Q_4$ element, shape function 17
- * @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 * - * @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 *
$Q_4$ element, shape function 18 $Q_4$ element, shape function 19
- * @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 * - * @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 *
$Q_4$ element, shape function 20 $Q_4$ element, shape function 21
- * @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 * - * @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 *
$Q_4$ element, shape function 22 $Q_4$ element, shape function 23
- * @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 *
$Q_4$ element, diff --git a/include/deal.II/fe/fe_q_hierarchical.h b/include/deal.II/fe/fe_q_hierarchical.h index 67e02b74f9..85c4a7533f 100644 --- a/include/deal.II/fe/fe_q_hierarchical.h +++ b/include/deal.II/fe/fe_q_hierarchical.h @@ -107,26 +107,22 @@ DEAL_II_NAMESPACE_OPEN * * In 2d, these shape functions look as follows: * * * * * * * * * @@ -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):
- * @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 * - * @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 *
$Q_1^H$ element, shape function 0 * $Q_1^H$ element, shape function 1
- * @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 * - * @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 *
$Q_1^H$ element, shape function 2 *
* * * * * * * * * * * * * * * * * * * * * * * * * * *
- * @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 * - * @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 *
$Q_2^H$ element, shape function 0 * $Q_2^H$ element, shape function 1
- * @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 * - * @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 *
$Q_2^H$ element, shape function 2 * $Q_2^H$ element, shape function 3
- * @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 * - * @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 *
$Q_2^H$ element, shape function 4 * $Q_2^H$ element, shape function 5
- * @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 * - * @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 *
$Q_2^H$ element, shape function 6 * $Q_2^H$ element, shape function 7
- * @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 *
$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): * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * @@ -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):
- * @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 * - * @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 *
$Q_3^H$ element, shape function 0 * $Q_3^H$ element, shape function 1
- * @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 * - * @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 *
$Q_3^H$ element, shape function 2 * $Q_3^H$ element, shape function 3
- * @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 * - * @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 *
$Q_3^H$ element, shape function 4 * $Q_3^H$ element, shape function 5
- * @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 * - * @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 *
$Q_3^H$ element, shape function 6 * $Q_3^H$ element, shape function 7
- * @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 * - * @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 *
$Q_3^H$ element, shape function 8 * $Q_3^H$ element, shape function 9
- * @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 * - * @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 *
$Q_3^H$ element, shape function 10 * $Q_3^H$ element, shape function 11
- * @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 * - * @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 *
$Q_3^H$ element, shape function 12 * $Q_3^H$ element, shape function 13
- * @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 * - * @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 *
$Q_3^H$ element, shape function 14 *
* * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * *
- * @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 * - * @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 *
$Q_4^H$ element, shape function 0 * $Q_4^H$ element, shape function 1
- * @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 * - * @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 *
$Q_4^H$ element, shape function 2 * $Q_4^H$ element, shape function 3
- * @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 * - * @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 *
$Q_4^H$ element, shape function 4 * $Q_4^H$ element, shape function 5
- * @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 * - * @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 *
$Q_4^H$ element, shape function 6 * $Q_4^H$ element, shape function 7
- * @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 * - * @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 *
$Q_4^H$ element, shape function 8 * $Q_4^H$ element, shape function 9
- * @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 * - * @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 *
$Q_4^H$ element, shape function 10 * $Q_4^H$ element, shape function 11
- * @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 * - * @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 *
$Q_4^H$ element, shape function 12 * $Q_4^H$ element, shape function 13
- * @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 * - * @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 *
$Q_4^H$ element, shape function 14 * $Q_4^H$ element, shape function 15
- * @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 * - * @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 *
$Q_4^H$ element, shape function 16 * $Q_4^H$ element, shape function 17
- * @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 * - * @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 *
$Q_4^H$ element, shape function 18 * $Q_4^H$ element, shape function 19
- * @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 * - * @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 *
$Q_4^H$ element, shape function 20 * $Q_4^H$ element, shape function 21
- * @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 * - * @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 *
$Q_4^H$ element, shape function 22 * $Q_4^H$ element, shape function 23
- * @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 *
$Q_4^H$ element, diff --git a/include/deal.II/fe/fe_q_iso_q1.h b/include/deal.II/fe/fe_q_iso_q1.h index b9229e0274..ca10e762d7 100644 --- a/include/deal.II/fe/fe_q_iso_q1.h +++ b/include/deal.II/fe/fe_q_iso_q1.h @@ -71,8 +71,8 @@ DEAL_II_NAMESPACE_OPEN * solution and stabilization techniques are used that work for linears but * not higher order elements. * - *
  • 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. + *
  • 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.
  • diff --git a/include/deal.II/fe/fe_series.h b/include/deal.II/fe/fe_series.h index 681b4dda6f..104b201cf5 100644 --- a/include/deal.II/fe/fe_series.h +++ b/include/deal.II/fe/fe_series.h @@ -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 bool and unsigned int. - * 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 bool and unsigned + * int. 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 diff --git a/include/deal.II/grid/grid_generator.h b/include/deal.II/grid/grid_generator.h index 1290cc1b5c..38b1e6a25b 100644 --- a/include/deal.II/grid/grid_generator.h +++ b/include/deal.II/grid/grid_generator.h @@ -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 void @@ -132,8 +131,7 @@ namespace GridGenerator * dimensional space with the remaining entries set to zero. For example, a * Triangulation@<2,3@> 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 void @@ -169,8 +167,7 @@ namespace GridGenerator * Triangulation@<2,3@> 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 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 void @@ -356,8 +352,7 @@ namespace GridGenerator * vertices in the array of corners 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 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 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 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 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 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 @@ -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 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 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ü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 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 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 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 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 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 void diff --git a/include/deal.II/grid/grid_tools.h b/include/deal.II/grid/grid_tools.h index 9d2acdf4de..fa217687d5 100644 --- a/include/deal.II/grid/grid_tools.h +++ b/include/deal.II/grid/grid_tools.h @@ -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 diff --git a/include/deal.II/grid/manifold.h b/include/deal.II/grid/manifold.h index c649ce33dc..f182bda310 100644 --- a/include/deal.II/grid/manifold.h +++ b/include/deal.II/grid/manifold.h @@ -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 diff --git a/include/deal.II/lac/arpack_solver.h b/include/deal.II/lac/arpack_solver.h index 9874ad7a32..af87f1df30 100644 --- a/include/deal.II/lac/arpack_solver.h +++ b/include/deal.II/lac/arpack_solver.h @@ -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 { diff --git a/include/deal.II/lac/lapack_full_matrix.h b/include/deal.II/lac/lapack_full_matrix.h index d48df437f7..a694fc3410 100644 --- a/include/deal.II/lac/lapack_full_matrix.h +++ b/include/deal.II/lac/lapack_full_matrix.h @@ -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 & 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 * error = std::numeric_limits::epsilon * k. * Alternatively one can get the number of accurate digits diff --git a/include/deal.II/lac/parpack_solver.h b/include/deal.II/lac/parpack_solver.h index 512c08c74a..13e17c6331 100644 --- a/include/deal.II/lac/parpack_solver.h +++ b/include/deal.II/lac/parpack_solver.h @@ -382,8 +382,8 @@ public: * * If this function is not called, the shift is assumed to be zero. * - * @note only relevant for mode=3 (see the general documentation - * of this class for a definition of what the different modes are). + * @note only relevant for mode=3 (see the general documentation of this + * class for a definition of what the different modes are). */ void set_shift(const std::complex sigma); diff --git a/include/deal.II/lac/petsc_parallel_vector.h b/include/deal.II/lac/petsc_parallel_vector.h index d55969f180..6e366cdf1b 100644 --- a/include/deal.II/lac/petsc_parallel_vector.h +++ b/include/deal.II/lac/petsc_parallel_vector.h @@ -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" diff --git a/include/deal.II/lac/read_write_vector.h b/include/deal.II/lac/read_write_vector.h index 40ca5f91b2..54e21e83ff 100644 --- a/include/deal.II/lac/read_write_vector.h +++ b/include/deal.II/lac/read_write_vector.h @@ -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 void diff --git a/include/deal.II/lac/scalapack.h b/include/deal.II/lac/scalapack.h index ea5e9c3e7e..e86c8b6cdd 100644 --- a/include/deal.II/lac/scalapack.h +++ b/include/deal.II/lac/scalapack.h @@ -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$ - *
    $NB_A=NB_B$ | $\mathbf{A} = a \mathbf{A} + b \mathbf{B}$ | | true - * | $MB_A=NB_B$
    $NB_A=MB_B$ | $\mathbf{A} = a \mathbf{A} + b - * \mathbf{B}^T$ | + * | transpose_B | Block Sizes | Operation | + * | :---------: | :--------------------------: | :-------------------------------------------: | + * | false | $MB_A=MB_B$
    $NB_A=NB_B$ | $\mathbf{A} = a \mathbf{A} + b \mathbf{B}$ | + * | true | $MB_A=NB_B$
    $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$
    $NB_A=MB_B$
    $NB_B=NB_C$ | $\mathbf{C} - * = b \mathbf{A} \cdot \mathbf{B} + c \mathbf{C}$ | | false | true - * | $MB_A=MB_C$
    $NB_A=NB_B$
    $MB_B=NB_C$ | $\mathbf{C} = b - * \mathbf{A} \cdot \mathbf{B}^T + c \mathbf{C}$ | | true | false | - * $MB_A=MB_B$
    $NB_A=MB_C$
    $NB_B=NB_C$ | $\mathbf{C} = b - * \mathbf{A}^T \cdot \mathbf{B} + c \mathbf{C}$ | | true | true | - * $MB_A=NB_B$
    $NB_A=MB_C$
    $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$
    $NB_A=MB_B$
    $NB_B=NB_C$ | $\mathbf{C} = b \mathbf{A} \cdot \mathbf{B} + c \mathbf{C}$ | + * | false | true | $MB_A=MB_C$
    $NB_A=NB_B$
    $MB_B=NB_C$ | $\mathbf{C} = b \mathbf{A} \cdot \mathbf{B}^T + c \mathbf{C}$ | + * | true | false | $MB_A=MB_B$
    $NB_A=MB_C$
    $NB_B=NB_C$ | $\mathbf{C} = b \mathbf{A}^T \cdot \mathbf{B} + c \mathbf{C}$ | + * | true | true | $MB_A=NB_B$
    $NB_A=MB_C$
    $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 diff --git a/include/deal.II/lac/scalapack.templates.h b/include/deal.II/lac/scalapack.templates.h index 628a64844c..86db46b762 100644 --- a/include/deal.II/lac/scalapack.templates.h +++ b/include/deal.II/lac/scalapack.templates.h @@ -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, diff --git a/include/deal.II/lac/tensor_product_matrix.h b/include/deal.II/lac/tensor_product_matrix.h index 5d3c09e4bf..3a86de7c08 100644 --- a/include/deal.II/lac/tensor_product_matrix.h +++ b/include/deal.II/lac/tensor_product_matrix.h @@ -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 and VectorizedArray exists. This is necessary * to perform LAPACK calculations for each vectorization lane, i.e. for the diff --git a/include/deal.II/lac/trilinos_precondition.h b/include/deal.II/lac/trilinos_precondition.h index 316b245f28..a75ca3187f 100644 --- a/include/deal.II/lac/trilinos_precondition.h +++ b/include/deal.II/lac/trilinos_precondition.h @@ -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. * diff --git a/include/deal.II/matrix_free/cuda_fe_evaluation.h b/include/deal.II/matrix_free/cuda_fe_evaluation.h index 9c9e124f1f..1eec59510e 100644 --- a/include/deal.II/matrix_free/cuda_fe_evaluation.h +++ b/include/deal.II/matrix_free/cuda_fe_evaluation.h @@ -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 diff --git a/include/deal.II/matrix_free/tensor_product_kernels.h b/include/deal.II/matrix_free/tensor_product_kernels.h index 0b1d4e45f2..7c799fc226 100644 --- a/include/deal.II/matrix_free/tensor_product_kernels.h +++ b/include/deal.II/matrix_free/tensor_product_kernels.h @@ -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 diff --git a/include/deal.II/meshworker/mesh_loop.h b/include/deal.II/meshworker/mesh_loop.h index c6df1c9337..a8fe5b4e70 100644 --- a/include/deal.II/meshworker/mesh_loop.h +++ b/include/deal.II/meshworker/mesh_loop.h @@ -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. * diff --git a/include/deal.II/multigrid/mg_constrained_dofs.h b/include/deal.II/multigrid/mg_constrained_dofs.h index 2bd38545a4..0e40ae0398 100644 --- a/include/deal.II/multigrid/mg_constrained_dofs.h +++ b/include/deal.II/multigrid/mg_constrained_dofs.h @@ -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 DEAL_II_DEPRECATED void diff --git a/include/deal.II/multigrid/multigrid.h b/include/deal.II/multigrid/multigrid.h index 379eee70e4..39a5b537d8 100644 --- a/include/deal.II/multigrid/multigrid.h +++ b/include/deal.II/multigrid/multigrid.h @@ -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 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 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 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 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 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 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 diff --git a/include/deal.II/numerics/data_postprocessor.h b/include/deal.II/numerics/data_postprocessor.h index d33862632b..ff7df13dd0 100644 --- a/include/deal.II/numerics/data_postprocessor.h +++ b/include/deal.II/numerics/data_postprocessor.h @@ -716,8 +716,7 @@ private: * // like above, but now also make sure that DataOut provides * // us with coordinates of the evaluation points: * DataPostprocessorVector ("heat_flux", - * update_gradients | - * update_quadrature_points) + * update_gradients | update_quadrature_points) * {} * * virtual diff --git a/include/deal.II/numerics/vector_tools.h b/include/deal.II/numerics/vector_tools.h index 905ac1e478..dee9ad3220 100644 --- a/include/deal.II/numerics/vector_tools.h +++ b/include/deal.II/numerics/vector_tools.h @@ -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 function_map[id] + * Argument four (@p function_map) describes the boundary function $\vec + * u_\Gamma$ for each boundary id. The function function_map[id] * 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. diff --git a/include/deal.II/opencascade/boundary_lib.h b/include/deal.II/opencascade/boundary_lib.h index abb9393c23..69cd64f3ae 100644 --- a/include/deal.II/opencascade/boundary_lib.h +++ b/include/deal.II/opencascade/boundary_lib.h @@ -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 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 class DEAL_II_DEPRECATED NormalToMeshProjectionBoundary diff --git a/include/deal.II/physics/elasticity/standard_tensors.h b/include/deal.II/physics/elasticity/standard_tensors.h index 472a070c7e..512f5d52b8 100644 --- a/include/deal.II/physics/elasticity/standard_tensors.h +++ b/include/deal.II/physics/elasticity/standard_tensors.h @@ -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} diff --git a/source/dofs/dof_tools_constraints.cc b/source/dofs/dof_tools_constraints.cc index 50e5f0d307..b18b3dcaec 100644 --- a/source/dofs/dof_tools_constraints.cc +++ b/source/dofs/dof_tools_constraints.cc @@ -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 diff --git a/source/fe/mapping_manifold.cc b/source/fe/mapping_manifold.cc index 9a1b91e267..b31dc9ed80 100644 --- a/source/fe/mapping_manifold.cc +++ b/source/fe/mapping_manifold.cc @@ -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. diff --git a/source/fe/mapping_q_generic.cc b/source/fe/mapping_q_generic.cc index a991eacd2b..e2f08ad7cb 100644 --- a/source/fe/mapping_q_generic.cc +++ b/source/fe/mapping_q_generic.cc @@ -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. diff --git a/source/grid/tria.cc b/source/grid/tria.cc index 7bece82c99..e7dccc92a2 100644 --- a/source/grid/tria.cc +++ b/source/grid/tria.cc @@ -14556,8 +14556,13 @@ Triangulation::prepare_coarsening_and_refinement() // / / // / / // *---------------* - // | | | | | | | | - // | | | | / | |/ + // | | + // | | + // | | + // | | + // | | + // | | / + // | |/ // *---------------* // // @@ -14582,9 +14587,13 @@ Triangulation::prepare_coarsening_and_refinement() // / / // / / // *---------------* - // | | | | / | |/ + // | | + // | | / + // | |/ // *---------------* - // | | | | / | |/ + // | | + // | | / + // | |/ // *---------------* // // @@ -14611,11 +14620,13 @@ Triangulation::prepare_coarsening_and_refinement() // / / / // / / / // *-------*-------* - // | | | | | - // | / | | |/ + // | | | + // | | | / + // | | |/ // *-------*-------* - // | | | | | - // | / | | |/ + // | | | + // | | | / + // | | |/ // *-------*-------* // // @@ -14637,11 +14648,13 @@ Triangulation::prepare_coarsening_and_refinement() // / / / // / / / // *-------*-------* - // | | | | | - // | / | | |/ + // | | | + // | | | / + // | | |/ // *-------*-------* - // | | | | | - // | / | | |/ + // | | | + // | | | / + // | | |/ // *-------*-------* // // -- 2.39.5