]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Prefer hyphen for the h, p, hp terms in the documentation.
authorMarc Fehling <mafehling.git@gmail.com>
Thu, 19 Nov 2020 20:53:31 +0000 (13:53 -0700)
committerMarc Fehling <mafehling.git@gmail.com>
Fri, 18 Dec 2020 20:14:15 +0000 (13:14 -0700)
181 files changed:
doc/doxygen/headers/constraints.h
doc/doxygen/headers/glossary.h
doc/doxygen/headers/hp.h
doc/doxygen/headers/main.h
doc/doxygen/headers/matrixfree.h
doc/doxygen/tutorial/tutorial.h.in
examples/step-27/doc/intro.dox
examples/step-27/doc/tooltip
examples/step-27/step-27.cc
examples/step-30/doc/intro.dox
examples/step-46/doc/intro.dox
include/deal.II/distributed/solution_transfer.h
include/deal.II/distributed/tria.h
include/deal.II/dofs/dof_accessor.h
include/deal.II/dofs/dof_handler.h
include/deal.II/dofs/dof_objects.h
include/deal.II/dofs/dof_tools.h
include/deal.II/fe/fe.h
include/deal.II/fe/fe_base.h
include/deal.II/fe/fe_bernstein.h
include/deal.II/fe/fe_dgp.h
include/deal.II/fe/fe_dgp_monomial.h
include/deal.II/fe/fe_dgp_nonparametric.h
include/deal.II/fe/fe_dgq.h
include/deal.II/fe/fe_enriched.h
include/deal.II/fe/fe_face.h
include/deal.II/fe/fe_nedelec.h
include/deal.II/fe/fe_nothing.h
include/deal.II/fe/fe_q_base.h
include/deal.II/fe/fe_q_hierarchical.h
include/deal.II/fe/fe_system.h
include/deal.II/fe/fe_trace.h
include/deal.II/fe/fe_values.h
include/deal.II/grid/grid_tools.h
include/deal.II/hp/dof_handler.h
include/deal.II/hp/fe_collection.h
include/deal.II/hp/fe_values.h
include/deal.II/hp/refinement.h
include/deal.II/lac/affine_constraints.h
include/deal.II/matrix_free/dof_info.h
include/deal.II/matrix_free/fe_evaluation.h
include/deal.II/matrix_free/mapping_info.h
include/deal.II/matrix_free/mapping_info.templates.h
include/deal.II/matrix_free/matrix_free.h
include/deal.II/matrix_free/matrix_free.templates.h
include/deal.II/matrix_free/task_info.h
include/deal.II/multigrid/mg_transfer_global_coarsening.h
include/deal.II/numerics/error_estimator.h
include/deal.II/numerics/error_estimator.templates.h
include/deal.II/numerics/matrix_tools.h
include/deal.II/numerics/solution_transfer.h
include/deal.II/numerics/vector_tools_boundary.h
include/deal.II/numerics/vector_tools_boundary.templates.h
include/deal.II/numerics/vector_tools_interpolate.h
include/deal.II/numerics/vector_tools_rhs.h
source/dofs/dof_accessor_get.cc
source/dofs/dof_handler.cc
source/dofs/dof_handler_policy.cc
source/dofs/dof_objects.cc
source/dofs/dof_renumbering.inst.in
source/dofs/dof_tools_constraints.cc
source/dofs/dof_tools_sparsity.cc
source/fe/fe_bernstein.cc
source/fe/fe_face.cc
source/fe/fe_nedelec.cc
source/fe/fe_q_base.cc
source/fe/fe_q_hierarchical.cc
source/fe/fe_raviart_thomas_nodal.cc
source/hp/refinement.cc
source/matrix_free/task_info.cc
source/numerics/data_out_stack.cc
source/numerics/derivative_approximation.cc
source/numerics/matrix_creator.inst.in
source/numerics/solution_transfer.cc
tests/aniso/hp_constraints_dgp_08.cc
tests/aniso/hp_constraints_dgp_monomial_08.cc
tests/aniso/hp_constraints_dgp_nonparametric_08.cc
tests/aniso/hp_constraints_dgq_08.cc
tests/bits/count_dofs_per_component_hp_01.cc
tests/bits/count_dofs_per_component_hp_02.cc
tests/bits/face_orientation_crash.cc
tests/bits/map_dofs_to_support_points_hp_01.cc
tests/bits/map_dofs_to_support_points_hp_02.cc
tests/bits/point_gradient_hp_01.cc
tests/bits/point_value_hp_01.cc
tests/fail/hp_constraints_q_08.cc
tests/fail/hp_constraints_q_system_08.cc
tests/fail/hp_constraints_q_system_x_08.cc
tests/fail/hp_constraints_rt_01.cc
tests/fail/hp_constraints_rt_02.cc
tests/fail/hp_constraints_rt_03.cc
tests/fail/hp_constraints_rt_04.cc
tests/fail/hp_constraints_rt_05.cc
tests/fail/hp_constraints_rt_06.cc
tests/fail/vectors_boundary_rhs_hp_02.cc
tests/fail/vectors_rhs_hp_02.cc
tests/fe/fe_enriched_07.cc
tests/fe/fe_enriched_08.cc
tests/fe/fe_enriched_08a.cc
tests/grid/mesh_3d_18.cc
tests/grid/vertex_as_face_07.cc
tests/hp/boundary_matrices.cc
tests/hp/boundary_matrices_hp.cc
tests/hp/compare_hp_vs_nonhp_01.cc
tests/hp/crash_08.cc
tests/hp/crash_09.cc
tests/hp/crash_11.cc
tests/hp/crash_12.cc
tests/hp/crash_15.cc
tests/hp/crash_21.cc
tests/hp/dof_handler_number_cache.cc
tests/hp/error_prediction_01.cc
tests/hp/fe_nothing_11.cc
tests/hp/fe_nothing_20.cc
tests/hp/flux_sparsity.cc
tests/hp/flux_sparsity_02.cc
tests/hp/get_interpolated_dof_values_01.cc
tests/hp/get_interpolated_dof_values_02.cc
tests/hp/get_interpolated_dof_values_03.cc
tests/hp/hp_coarsening.cc
tests/hp/hp_constraints_b.cc
tests/hp/hp_constraints_common.h
tests/hp/hp_constraints_common_no_support.h
tests/hp/hp_constraints_dgp.cc
tests/hp/hp_constraints_dgp_monomial.cc
tests/hp/hp_constraints_dgp_nonparametric.cc
tests/hp/hp_constraints_dgq.cc
tests/hp/hp_constraints_neither_dominate_01.cc
tests/hp/hp_constraints_q.cc
tests/hp/hp_constraints_q_hierarchical.cc
tests/hp/hp_constraints_q_system.cc
tests/hp/hp_constraints_q_system_x.cc
tests/hp/hp_constraints_rt_nodal.cc
tests/hp/hp_hanging_nodes_01.cc
tests/hp/laplace.h
tests/hp/matrices.cc
tests/hp/n_boundary_dofs.cc
tests/hp/p_adaptivity_absolute_threshold.cc
tests/hp/p_adaptivity_fixed_number.cc
tests/hp/p_adaptivity_flags.cc
tests/hp/p_adaptivity_reference.cc
tests/hp/p_adaptivity_regularity.cc
tests/hp/p_adaptivity_relative_threshold.cc
tests/hp/set_dof_values_by_interpolation_01.cc
tests/hp/set_dof_values_by_interpolation_02.cc
tests/hp/set_dof_values_by_interpolation_03.cc
tests/hp/solution_transfer.cc
tests/hp/solution_transfer.output
tests/hp/solution_transfer_02.cc
tests/hp/solution_transfer_12.cc
tests/hp/solution_transfer_12.output
tests/hp/vectors_boundary_rhs_01.cc
tests/hp/vectors_boundary_rhs_02.cc
tests/hp/vectors_boundary_rhs_03.cc
tests/hp/vectors_boundary_rhs_hp_01.cc
tests/hp/vectors_boundary_rhs_hp_03.cc
tests/hp/vectors_point_source_01.cc
tests/hp/vectors_point_source_hp_01.cc
tests/hp/vectors_rhs_01.cc
tests/hp/vectors_rhs_02.cc
tests/hp/vectors_rhs_03.cc
tests/hp/vectors_rhs_hp_01.cc
tests/hp/vectors_rhs_hp_03.cc
tests/lac/inhomogeneous_constraints.cc
tests/matrix_free/matrix_vector_hp.cc
tests/matrix_free/matrix_vector_hp_no_template.cc
tests/matrix_free/thread_correctness_hp.cc
tests/mpi/hp_step-4.cc
tests/mpi/hp_unify_dof_indices_01.cc
tests/mpi/hp_unify_dof_indices_02.cc
tests/mpi/hp_unify_dof_indices_03.cc
tests/mpi/hp_unify_dof_indices_04.cc
tests/mpi/hp_unify_dof_indices_05.cc
tests/mpi/hp_unify_dof_indices_06.cc
tests/mpi/hp_unify_dof_indices_07.cc
tests/mpi/hp_unify_dof_indices_08.cc
tests/mpi/hp_unify_dof_indices_10.cc
tests/mpi/hp_unify_dof_indices_11.cc
tests/mpi/p_adaptivity_fixed_number.cc
tests/mpi/trilinos_step-27.cc
tests/vector_tools/boundaries_complex_hp.cc

index 6a1ad3a54765d6ef9c9ae4e50a987ca08918d6ec..be19d57795bf4f6a79263d948f4baf1c0ce1e4ef 100644 (file)
@@ -56,7 +56,7 @@
  *   are $x_{28}$ and $x_{40}$. Then, requiring that the finite element
  *   function be continuous is equivalent to requiring that $x_{12}=
  *   \frac 12 (x_{28}+x_{40})$. A similar situation occurs in the
- *   context of hp adaptive finite element methods.
+ *   context of hp-adaptive finite element methods.
  *   For example, when using Q1 and Q2 elements (i.e. using
  *   FE_Q(1) and FE_Q(2)) on the two marked cells of the mesh
  *       @image html hp-refinement-simple.png
@@ -99,7 +99,7 @@
  * This scheme of first building a linear system and then eliminating
  * constrained degrees of freedom is inefficient, and a bottleneck if there
  * are many constraints and matrices are full, i.e. especially for 3d and/or
- * higher order or hp finite elements. Furthermore, it is impossible to
+ * higher order or hp-finite elements. Furthermore, it is impossible to
  * implement for %parallel computations where a process may not have access
  * to elements of the matrix. We therefore offer a second way of
  * building linear systems, using the
  * Condensation is an expensive operation, in particular if there
  * are many constraints and/or if the matrix has many nonzero entries. Both
  * is typically the case for 3d, or high polynomial degree computations, as
- * well as for hp finite element methods, see for example the @ref hp_paper
- * "hp paper". This is the case discussed in the hp tutorial program, @ref
+ * well as for hp-finite element methods, see for example the @ref hp_paper
+ * "hp-paper". This is the case discussed in the hp-tutorial program, @ref
  * step_27 "step-27", as well as in step-22 and @ref step_31
  * "step-31".
  *
index b2ab2452c7c11694cb48191d7a5ee5430e5b9d62..e5216741584bbd0deb33d0c627264ff84c0fa897 100644 (file)
  * </dd>
  *
  *
- * <dt class="glossary">@anchor hp_paper <b>%hp paper</b></dt>
- * <dd>The "hp paper" is a paper by W. Bangerth and O. Kayser-Herold, titled
+ * <dt class="glossary">@anchor hp_paper <b>%hp-paper</b></dt>
+ * <dd>The "hp-paper" is a paper by W. Bangerth and O. Kayser-Herold, titled
  * "Data Structures and Requirements for hp Finite Element Software", that
  * describes many of the algorithms and data structures used in the implementation
- * of the hp framework of deal.II. In particular, it summarizes many of the
- * tricky points that have to be considered for %hp finite elements using continuous
+ * of the hp-framework of deal.II. In particular, it summarizes many of the
+ * tricky points that have to be considered for %hp-finite elements using continuous
  * elements.
  *
  * The full reference for this paper is as follows:
index 7a18861b87db935eefa71721c11c281cb8439659..c3ff48e3644108e7d62558cd009a1df96ee2961e 100644 (file)
 
 
 /**
- * @defgroup hp hp finite element support
+ * @defgroup hp hp-finite element support
  *
- * Classes and functions that have to do with hp finite elements. The step-27
+ * Classes and functions that have to do with hp-finite elements. The step-27
  * tutorial program gives an overview of how to use the classes in this
  * namespace. A slightly more exotic application is given in step-46.
  *
- * The hp namespace implements the algorithms and data structures used for
- * the hp framework in deal.II. An overview over the details of how these
+ * The hp-namespace implements the algorithms and data structures used for
+ * the hp-framework in deal.II. An overview over the details of how these
  * algorithms work and what data structures are used is given in the
- * @ref hp_paper "hp paper".
+ * @ref hp_paper "hp-paper".
  */
 
 /**
- * @defgroup hpcollection hp Collections
+ * @defgroup hpcollection hp-Collections
  *
- * In the implementation of the hp finite element method, each cell might have
+ * In the implementation of the hp-finite element method, each cell might have
  * a different finite element associated with it. To handle this, the
  * hp::DoFHandler must have a whole set of finite element classes associated
  * with it. This concept is represented by the hp::FECollection class: Objects
  * element object. This same observation also holds for the other collection
  * classes.
  *
- * It is customary that within an hp finite element program, one keeps
+ * It is customary that within an hp-finite element program, one keeps
  * collections of finite elements and quadrature formulas with the same number
  * of elements, each element of the one collection matching the element in the
  * other. This is not necessary, but it often makes coding a lot simpler. If a
  * collection of mappings is used, the same holds for hp::MappingCollection
  * objects as well.
  *
- * Whenever p adaptivity is considered in an hp finite element program,
+ * Whenever p-adaptivity is considered in an hp-finite element program,
  * a hierarchy of finite elements needs to be established to determine
  * succeeding finite elements for refinement and preceding ones for coarsening.
  * Typically, this hierarchy considers how finite element spaces are nested:
 
 
 /**
- * A namespace for the implementation of hp finite element specific algorithms
+ * A namespace for the implementation of hp-finite element specific algorithms
  * and data structures.
  *
  * @ingroup hp
index f95a6076b5ae091aa1363b79fd83f0203658c09a..6042c842d6dc2d38a50491bd3e0b3261477ee534 100644 (file)
  *
  *   The DoFHandler class and its associates are described in the @ref
  *   dofs module. In addition, there are specialized versions that can
- *   handle multilevel and hp discretizations. These are described in
+ *   handle multilevel and hp-discretizations. These are described in
  *   the @ref mg and @ref hp modules. Finite element methods frequently
  *   imply constraints on degrees of freedom, such as for hanging nodes
  *   or nodes at which boundary conditions apply; dealing with such
index 62cfc506779e62dda14248ab64a31e3be3217d53..98a5af2586ce832885c117b5a2cc97421fd7b739 100644 (file)
@@ -292,7 +292,7 @@ digraph G
  * array. The access granularity in terms of a <i>cell index</i> is controlled
  * by the auxiliary field internal::MatrixFreeFunctions::DoFInfo::row_starts
  * that is similar to the rowstart index in a compressed matrix storage. The
- * scheme supports variable lengths because we support hp adaptivity and index
+ * scheme supports variable lengths because we support hp-adaptivity and index
  * indirections due to constraints that are contained in the main index
  * array. Due to vectorization over cells, the access granularity would
  * initially be in terms of <i>cell batches</i>. However, we must be able to
@@ -318,7 +318,7 @@ digraph G
  * </ol>
  * </li>
  *
- * <li>Information to extract the FE index in hp adaptive computations.</li>
+ * <li>Information to extract the FE index in hp-adaptive computations.</li>
  * <li>Information about the 'first access' into a particular vector entry
  * that is used to zero out the entries in a destination vectors within the
  * MatrixFree::loop shortly before accessing them the first time. This is used
@@ -408,7 +408,7 @@ digraph G
  * element. We use an auxiliary index array that points to the start of the
  * data for each cell, namely the `data_index_offsets` field for the
  * Jacobians, JxW values, and normal vectors, and `quadrature_point_offsets`
- * for the quadrature points. This offset enables hp adaptivity with variable
+ * for the quadrature points. This offset enables hp-adaptivity with variable
  * lengths of fields similar to what is done for DoFInfo, but it also enables
  * something we call <i>geometry compression</i>. In order to reduce the data
  * access, we detect simple geometries of cells where Jacobians are constant
index 0c88c63ba6c32ea455a0b63e0ba631f7d24ee291..e74502dd43cad4612f928b736d4fd5606b8093ab 100644 (file)
  *
  *   <tr valign="top">
  *       <td>step-27</td>
- *       <td> The hp finite element method.
+ *       <td> The hp-finite element method.
  *       <br/> Keywords: hp::DoFHandler, hp::FECollection, hp::QCollection,
  *       FESeries::Fourier, Triangulation::create_triangulation()
  *       </td></tr>
  *   </tr>
  *
  *   <tr valign="top">
- *     <td> hp finite elements
+ *     <td> hp-finite elements
  *     </td>
  *     <td>
  *       step-27,
index c28a7f1463241396a6b864c7c127a7cbeff51a1f..f591b60bee41de1c08c0a27f96b99e233b281cda 100644 (file)
@@ -60,7 +60,7 @@ deal.II, and that we will only have to provide the logic of what the
 program should do, not exactly how all this is going to happen.
 
 In deal.II, the $hp$ functionality is largely packaged into
-the hp namespace. This namespace provides classes that handle
+the hp-namespace. This namespace provides classes that handle
 $hp$ discretizations, assembling matrices and vectors, and other
 tasks. We will get to know many of them further down below. In
 addition, most of the functions in the DoFTools, and VectorTools
@@ -71,7 +71,7 @@ module and the links found there.
 It may be worth giving a slightly larger perspective at the end of
 this first part of the introduction. $hp$ functionality has been
 implemented in a number of different finite element packages (see, for
-example, the list of references cited in the @ref hp_paper "hp paper").
+example, the list of references cited in the @ref hp_paper "hp-paper").
 However, by and large, most of these packages have implemented it only
 for the (i) the 2d case, and/or (ii) the discontinuous Galerkin
 method. The latter is a significant simplification because
@@ -85,7 +85,7 @@ the resulting complexity. In particular, it handles computing the
 constraints (similar to hanging node constraints) of elements of
 different degree meeting at a face or edge. The many algorithmic and
 data structure techniques necessary for this are described in the
-@ref hp_paper "hp paper" for those interested in such detail.
+@ref hp_paper "hp-paper" for those interested in such detail.
 
 We hope that providing such a general implementation will help explore
 the potential of $hp$ methods further.
@@ -177,7 +177,7 @@ the same time.
 
 
 
-<h3>Assembling matrices and vectors with hp objects</h3>
+<h3>Assembling matrices and vectors with hp-objects</h3>
 
 Following this, we have to set up matrices and vectors for the linear system
 of the correct size and assemble them. Setting them up works in exactly the
@@ -250,7 +250,7 @@ usual fashion to assemble local contributions.
 
 
 
-<h3>A simple indicator for hp refinement and estimating smoothness</h3>
+<h3>A simple indicator for hp-refinement and estimating smoothness</h3>
 
 One of the central pieces of the adaptive finite element method is that we
 inspect the computed solution (a posteriori) with an indicator that tells us
@@ -261,7 +261,7 @@ complicated strategies in some programs, most importantly in step-14.
 
 In any case, as long as the decision is only "refine this cell" or "do not
 refine this cell", the actual refinement step is not particularly
-challenging. However, here we have a code that is capable of hp refinement,
+challenging. However, here we have a code that is capable of hp-refinement,
 i.e. we suddenly have two choices whenever we detect that the error on a
 certain cell is too large for our liking: we can refine the cell by splitting
 it into several smaller ones, or we can increase the polynomial degree of the
@@ -611,7 +611,7 @@ estimated smoothness exponent will be the same in either case.
 
 
 
-<h3>Complications with linear systems for hp discretizations</h3>
+<h3>Complications with linear systems for hp-discretizations</h3>
 
 <h4>Creating the sparsity pattern</h4>
 
@@ -643,7 +643,7 @@ The early tutorial programs use first or second degree finite elements, so
 removing entries in the sparsity pattern corresponding to constrained degrees of
 freedom does not have a large impact on the overall number of zeros explicitly
 stored by the matrix. However, since as many as a third of the degrees of
-freedom may be constrained in an hp discretization (and, with higher degree
+freedom may be constrained in an hp-discretization (and, with higher degree
 elements, these constraints can couple one DoF to as many as ten or twenty other
 DoFs), it is worthwhile to take these constraints into consideration since the
 resulting matrix will be much sparser (and, therefore, matrix-vector products or
index 0e992e22fdca2871c219b85071b9db3e35ecd47b..4a56ec9039ce8fdc6416fc811462575260d594a9 100644 (file)
@@ -1 +1 @@
-Using the hp finite element method for an elliptic problem.
+Using the hp-finite element method for an elliptic problem.
index f01c7d8e5304a544eedc183649d5178461b1a8e2..fb5664b89c9d7f27b5ec5b01eaca9c133fec1a88 100644 (file)
@@ -257,7 +257,7 @@ namespace Step27
   // This function is again a verbatim copy of what we already did in
   // step-6. Despite function calls with exactly the same names and arguments,
   // the algorithms used internally are different in some aspect since the
-  // dof_handler variable here is an hp object.
+  // dof_handler variable here is an hp-object.
   template <int dim>
   void LaplaceProblem<dim>::setup_system()
   {
index d2fd5587f3fbebb048150c33ac02741a60a0fe42..20733dbcc0988d93ba18624a036dc6b12a21e3db 100644 (file)
@@ -428,7 +428,7 @@ steps:
   requested refinement, using the requested isotropic and anisotropic flags.
 </ol>
 This approach is similar to the one we have used in step-27
-for hp refinement and
+for hp-refinement and
 has the great advantage of flexibility: Any error indicator can be
 used in the anisotropic process, i.e. if you have quite involved a posteriori
 goal-oriented error indicators available you can use them as easily as a simple
index ce6e9af3b8bebacb764dbb461f8023806086eecd..9193ff397a01a31b2f4bbcbb743f05d88f5d1b74 100644 (file)
@@ -248,7 +248,7 @@ the two elements are just variations of each other in that they have the same
 number of vector components but have different polynomial degrees &mdash; this
 smells very much like what one would do in $hp$ finite element methods, and it
 is exactly what we are going to do here: we are going to (ab)use the classes
-and facilities of the hp namespace to assign different elements to different
+and facilities of the hp-namespace to assign different elements to different
 cells. In other words, we will use collect the two finite elements in an
 hp::FECollection, will integrate with an appropriate hp::QCollection using an
 hp::FEValues object, and our DoFHandler will be in <i>hp</i>-mode. You
@@ -256,7 +256,7 @@ may wish to take a look at step-27 for an overview of all of these concepts.
 
 Before going on describing the testcase, let us clarify a bit <i>why</i> this
 approach of extending the functions by zero to the entire domain and then
-mapping the problem on to the hp framework makes sense:
+mapping the problem on to the hp-framework makes sense:
 
 - It makes things uniform: On all cells, the number of vector components is
   the same (here, <code>2*dim+1</code>). This makes all sorts of
@@ -583,7 +583,7 @@ cell is on.
 Secondly, we use an object of type DoFHandler operating in <i>hp</i>-mode. This
 class needs to know which cells will use the Stokes and which the elasticity
 finite element. At the beginning of each refinement cycle we will therefore
-have to walk over all cells and set the (in hp parlance) active FE index to
+have to walk over all cells and set the (in hp-parlance) active FE index to
 whatever is appropriate in the current situation. While we can use symbolic
 names for the material id, the active FE index is in fact a number that will
 frequently be used to index into collections of objects (e.g. of type
index f0d11ac987915d695595cd3c3fedc59d62c51954..f8b7082aac7440401940b5c54ad1a4418086ab7f 100644 (file)
@@ -153,9 +153,9 @@ namespace parallel
      * @endcode
      *
      *
-     * <h3>Note on usage with DoFHandler with hp capabilities</h3>
+     * <h3>Note on usage with DoFHandler with hp-capabilities</h3>
      *
-     * Since data on DoFHandler objects with hp capabilities is associated with
+     * Since data on DoFHandler objects with hp-capabilities is associated with
      * many different FiniteElement objects, each cell's data has to be
      * processed with its corresponding `future_fe_index`. Further, if
      * refinement is involved, data will be packed on the parent cell with its
@@ -166,11 +166,11 @@ namespace parallel
      * hp::FECollection::find_dominated_fe_extended() for more information).
      *
      * Transferring a solution across refinement works exactly like in the
-     * non-hp case. However, when considering serialization, we also have to
+     * non-hp-case. However, when considering serialization, we also have to
      * store the active_fe_indices in an additional step. A code snippet
      * demonstrating serialization with the
      * parallel::distributed::SolutionTransfer class with DoFHandler objects
-     * with hp capabilities is provided in the following. Here VectorType is
+     * with hp-capabilities is provided in the following. Here VectorType is
      * your favorite vector type, e.g. PETScWrappers::MPI::Vector,
      * TrilinosWrappers::MPI::Vector, or corresponding block vectors.
      *
index 9d3e465a0956d9566377e58112083f136a6be401..6189a6169a3a1e2c10c07557c13bb05604cc294e 100644 (file)
@@ -487,7 +487,7 @@ namespace parallel
        * assembly and solving. In practice, determining this cost is of course
        * not trivial since we don't solve on isolated cells, but on the entire
        * mesh. In such cases, one could, for example, choose the weight equal
-       * to the number of unknowns per cell (in the context of hp finite
+       * to the number of unknowns per cell (in the context of hp-finite
        * element methods), or using a heuristic that estimates the cost on
        * each cell depending on whether, for example, one has to run some
        * expensive algorithm on some cells but not others (such as forming
index e32702a48edb1a04125fc413ace25bc38185ba66..bea7a6188b15ebb716d24cde50d2bae970791178 100644 (file)
@@ -399,7 +399,7 @@ public:
    * ::DoFHandler class, this value must be equal to its default value since
    * that class only supports the same finite element on all cells anyway.
    *
-   * However, when the relevant DoFHandler object has hp capabilities enabled,
+   * However, when the relevant DoFHandler object has hp-capabilities enabled,
    * different finite element objects may be used on different cells. On faces
    * between two cells, as well as vertices, there may therefore be two sets
    * of degrees of freedom, one for each of the finite elements used on the
@@ -449,7 +449,7 @@ public:
    * ::DoFHandler class, this value must be equal to its default value since
    * that class only supports the same finite element on all cells anyway.
    *
-   * However, when hp capabilities are enabled, different finite element
+   * However, when hp-capabilities are enabled, different finite element
    * objects may be used on different cells. On faces between two cells, as
    * well as vertices, there may therefore be two sets of degrees of freedom,
    * one for each of the finite elements used on the adjacent cells.  In order
@@ -483,7 +483,7 @@ public:
    * ::DoFHandler class, this value must be equal to its default value since
    * that class only supports the same finite element on all cells anyway.
    *
-   * However, when hp capabilities are enabled, different finite element
+   * However, when hp-capabilities are enabled, different finite element
    * objects may be used on different cells. On faces between two cells, as
    * well as vertices, there may therefore be two sets of degrees of freedom,
    * one for each of the finite elements used on the adjacent cells.  In order
@@ -528,8 +528,8 @@ public:
   /**
    * Return the number of finite elements that are active on a given object.
    *
-   * When hp capabilities are disabled the answer is, of course, always one.
-   * However, when hp capabilities are enabled, this isn't the case: If this
+   * When hp-capabilities are disabled the answer is, of course, always one.
+   * However, when hp-capabilities are enabled, this isn't the case: If this
    * is a cell, the answer is of course one. If it is a face, the answer may
    * be one or two, depending on whether the two adjacent cells use the same
    * finite element or not. If it is an edge in 3d, the possible return value
@@ -540,8 +540,8 @@ public:
 
   /**
    * Return the @p n-th active fe index on this object. For cells and all non-
-   * hp objects, there is only a single active fe index, so the argument must
-   * be equal to zero. For lower-dimensional hp objects, there are
+   * hp-objects, there is only a single active fe index, so the argument must
+   * be equal to zero. For lower-dimensional hp-objects, there are
    * n_active_fe_indices() active finite elements, and this function can be
    * queried for their indices.
    */
@@ -559,7 +559,7 @@ public:
 
   /**
    * Return true if the finite element with given index is active on the
-   * present object. When the current DoFHandler does not have hp
+   * present object. When the current DoFHandler does not have hp-
    * capabilities, this is of course the case only if @p fe_index equals
    * zero. For cells, it is the case if @p fe_index equals active_fe_index()
    * of this cell. For faces and other lower- dimensional objects, there may
@@ -670,7 +670,7 @@ protected:
    * ::DoFHandler class, this value must be equal to its default value since
    * that class only supports the same finite element on all cells anyway.
    *
-   * However, when the relevant DoFHandler has hp capabilities, different
+   * However, when the relevant DoFHandler has hp-capabilities, different
    * finite element objects may be used on different cells. On faces between
    * two cells, as well as vertices, there may therefore be two sets of
    * degrees of freedom, one for each of the finite elements used on the
@@ -699,7 +699,7 @@ protected:
    * ::DoFHandler class, this value must be equal to its default value since
    * that class only supports the same finite element on all cells anyway.
    *
-   * However, when the relevant DoFHandler has hp capabilities, different
+   * However, when the relevant DoFHandler has hp-capabilities, different
    * finite element objects may be used on different cells. On faces between
    * two cells, as well as vertices, there may therefore be two sets of
    * degrees of freedom, one for each of the finite elements used on the
@@ -947,7 +947,7 @@ public:
    * ::DoFHandler class, this value must be equal to its default value since
    * that class only supports the same finite element on all cells anyway.
    *
-   * However, when the relevant DoFHandler has hp capabilities, different
+   * However, when the relevant DoFHandler has hp-capabilities, different
    * finite element objects may be used on different cells. On faces between
    * two cells, as well as vertices, there may therefore be two sets of
    * degrees of freedom, one for each of the finite elements used on the
@@ -988,7 +988,7 @@ public:
    * ::DoFHandler class, this value must be equal to its default value since
    * that class only supports the same finite element on all cells anyway.
    *
-   * However, when the relevant DoFHandler has hp capabilities, different
+   * However, when the relevant DoFHandler has hp-capabilities, different
    * finite element objects may be used on different cells. On faces between
    * two cells, as well as vertices, there may therefore be two sets of
    * degrees of freedom, one for each of the finite elements used on the
@@ -1011,7 +1011,7 @@ public:
    * ::DoFHandler class, this value must be equal to its default value since
    * that class only supports the same finite element on all cells anyway.
    *
-   * However, when the relevant DoFHandler has hp capabilities, different
+   * However, when the relevant DoFHandler has hp-capabilities, different
    * finite element objects may be used on different cells. On faces between
    * two cells, as well as vertices, there may therefore be two sets of
    * degrees of freedom, one for each of the finite elements used on the
@@ -1155,7 +1155,7 @@ protected:
    * ::DoFHandler class, this value must be equal to its default value since
    * that class only supports the same finite element on all cells anyway.
    *
-   * However, when the relevant DoFHandler has hp capabilities, different
+   * However, when the relevant DoFHandler has hp-capabilities, different
    * finite element objects may be used on different cells. On faces between
    * two cells, as well as vertices, there may therefore be two sets of
    * degrees of freedom, one for each of the finite elements used on the
@@ -1179,7 +1179,7 @@ protected:
    * ::DoFHandler class, this value must be equal to its default value since
    * that class only supports the same finite element on all cells anyway.
    *
-   * However, when the relevant DoFHandler has hp capabilities, different
+   * However, when the relevant DoFHandler has hp-capabilities, different
    * finite element objects may be used on different cells. On faces between
    * two cells, as well as vertices, there may therefore be two sets of
    * degrees of freedom, one for each of the finite elements used on the
@@ -1632,11 +1632,11 @@ public:
    * we use the restriction matrices provided by the finite element class to
    * compute the interpolation from the children to the present cell.
    *
-   * If the cell is part of a DoFHandler with hp capabilities, cells only have
+   * If the cell is part of a DoFHandler with hp-capabilities, cells only have
    * an associated finite element space if they are active. However, this
    * function is supposed to also provide information on inactive cells with
    * children. Consequently, it carries a third argument that can be used in
-   * the hp context that denotes the finite element space we are supposed to
+   * the hp-context that denotes the finite element space we are supposed to
    * interpolate onto. If the cell is active, this function then obtains the
    * finite element function from the <code>values</code> vector on this cell
    * and interpolates it onto the space described by the
@@ -1685,10 +1685,10 @@ public:
    * the children of this cell. These requirements are not taken care of and
    * must be enforced by the user afterward.
    *
-   * If the cell is part of a DoFHandler with hp capabilities, cells only have
+   * If the cell is part of a DoFHandler with hp-capabilities, cells only have
    * an associated finite element space if they are active. However, this
    * function is supposed to also work on inactive cells with children.
-   * Consequently, it carries a third argument that can be used in the hp
+   * Consequently, it carries a third argument that can be used in the hp-
    * context that denotes the finite element space we are supposed to
    * interpret the input vector of this function in. If the cell is active,
    * this function then interpolates the input vector interpreted as an
@@ -1890,12 +1890,12 @@ public:
 
   /**
    * Return the finite element that is used on the cell pointed to by this
-   * iterator. For DoFHandler objects without hp capabilities, this is of
+   * iterator. For DoFHandler objects without hp-capabilities, this is of
    * course always the same element, independent of the cell we are presently
-   * on, but for hp DoFHandler objects this may change from cell to cell.
+   * on, but for hp-DoFHandler objects this may change from cell to cell.
    *
    * @note Since degrees of freedom only exist on active cells for DoFHandler
-   * objects with hp capabilities (i.e., there is currently no implementation
+   * objects with hp-capabilities (i.e., there is currently no implementation
    * of multilevel such objects), it does not make sense to query the finite
    * element on non-active cells since they do not have finite element spaces
    * associated with them without having any degrees of freedom. Consequently,
@@ -1907,10 +1907,10 @@ public:
   /**
    * Return the index inside the hp::FECollection of the FiniteElement used
    * for this cell. This function is only useful if the DoFHandler object
-   * associated with the current cell has hp capabilities enabled.
+   * associated with the current cell has hp-capabilities enabled.
    *
    * @note Since degrees of freedom only exist on active cells for DoFHandler
-   * objects with hp capabilities (i.e., there is currently no implementation
+   * objects with hp-capabilities (i.e., there is currently no implementation
    * of multilevel such objects), it does not make sense to query the finite
    * element on non-active cells since they do not have finite element spaces
    * associated with them without having any degrees of freedom. Consequently,
@@ -1935,11 +1935,11 @@ public:
   /**
    * Set the index of the FiniteElement used for this cell. This determines
    * which element in an hp::FECollection to use. This function is only useful
-   * if the DoF handler object associated with the current cell has hp
+   * if the DoF handler object associated with the current cell has hp-
    * capabilities enabled.
    *
    * @note Since degrees of freedom only exist on active cells for DoFHandler
-   * objects with hp capabilities (i.e., there is currently no implementation
+   * objects with hp-capabilities (i.e., there is currently no implementation
    * of multilevel such objects), it does not make sense to query the finite
    * element on non-active cells since they do not have finite element spaces
    * associated with them without having any degrees of freedom. Consequently,
@@ -1997,12 +1997,12 @@ public:
    * active one will remain unchanged, in which case the active finite element
    * will be returned.
    *
-   * For DoFHandlers without hp capabilities enabled, this is of course always
-   * the same element, independent of the cell we are presently on, but for hp
+   * For DoFHandlers without hp-capabilities enabled, this is of course always
+   * the same element, independent of the cell we are presently on, but for hp-
    * DoFHandler objects this may change from cell to cell.
    *
    * @note Since degrees of freedom only exist on active cells for DoFHandler
-   * objects with hp capabilities (i.e., there is currently no implementation
+   * objects with hp-capabilities (i.e., there is currently no implementation
    * of multilevel such objects), it does not make sense to query the finite
    * element on non-active cells since they do not have finite element spaces
    * associated with them without having any degrees of freedom. Consequently,
@@ -2019,7 +2019,7 @@ public:
    * which case the fe_index of the active finite element will be returned.
    *
    * @note Since degrees of freedom only exist on active cells for DoFHandler
-   * objects with hp capabilities (i.e., there is currently no implementation
+   * objects with hp-capabilities (i.e., there is currently no implementation
    * of multilevel such objects), it does not make sense to query the finite
    * element on non-active cells since they do not have finite element spaces
    * associated with them without having any degrees of freedom. Consequently,
index 363b3f7eaf8fe2d4c96df2f3ab7f6ea46db29097..a2291ac533609024375d2ace75704c6a37eb5760 100644 (file)
@@ -233,7 +233,7 @@ namespace parallel
  * The whole process of working with objects of this type is explained in
  * step-27. Many of the algorithms this class implements are described in
  * the
- * @ref hp_paper "hp paper".
+ * @ref hp_paper "hp-paper".
  *
  *
  * <h3>Active FE indices and their behavior under mesh refinement</h3>
@@ -702,7 +702,7 @@ public:
   distribute_mg_dofs();
 
   /**
-   * Returns whether this DoFHandler has hp capabilities.
+   * Returns whether this DoFHandler has hp-capabilities.
    */
   bool
   has_hp_capabilities() const;
@@ -1382,19 +1382,19 @@ public:
 
   /**
    * Exception used when a certain feature doesn't make sense when
-   * DoFHandler does not hp capabilities.
+   * DoFHandler does not hp-capabilities.
    */
   DeclExceptionMsg(ExcNotAvailableWithoutHP,
                    "The current function doesn't make sense when used with a "
-                   "DoFHandler without hp capabilities.");
+                   "DoFHandler without hp-capabilities.");
 
   /**
    * Exception used when a certain feature is not implemented when the
-   * DoFHandler has hp capabilities.
+   * DoFHandler has hp-capabilities.
    */
   DeclExceptionMsg(ExcNotImplementedWithHP,
                    "The current function has not yet been implemented for a "
-                   "DoFHandler with hp capabilities.");
+                   "DoFHandler with hp-capabilities.");
 
 private:
   /**
@@ -1525,7 +1525,7 @@ private:
   BlockInfo block_info_object;
 
   /**
-   * Boolean indicating whether or not the current DoFHandler has hp
+   * Boolean indicating whether or not the current DoFHandler has hp-
    * capabilities.
    */
   bool hp_capability_enabled;
@@ -1593,7 +1593,7 @@ private:
    * relevant active finite elements.
    *
    * @note In normal mode it is possible to access this data strucutre directly.
-   *   In hp mode, an indirection via hp_object_fe_indices/hp_object_fe_ptr is
+   *   In hp-mode, an indirection via hp_object_fe_indices/hp_object_fe_ptr is
    * necessary.
    */
   mutable std::vector<std::array<std::vector<offset_type>, dim + 1>>
@@ -1614,14 +1614,14 @@ private:
 
   /**
    * Active fe index of an active cell (identified by level and level index).
-   * This vector is only used in hp mode.
+   * This vector is only used in hp-mode.
    */
   mutable std::vector<std::vector<active_fe_index_type>>
     hp_cell_active_fe_indices;
 
   /**
    * Future fe index of an active cell (identified by level and level index).
-   * This vector is only used in hp mode.
+   * This vector is only used in hp-mode.
    */
   mutable std::vector<std::vector<active_fe_index_type>>
     hp_cell_future_fe_indices;
index e641d7324a18f739f57259e654c6bdbdeeb5e74f..2546dd7d7b80bc954253e3f2ad0eb02c2b8a5f4b 100644 (file)
@@ -84,9 +84,9 @@ namespace internal
        *
        * The third argument, @p fe_index, must equal zero. It is otherwise
        * unused, but we retain the argument so that we can use the same
-       * interface for non-hp and hp finite element methods, in effect making
-       * it possible to share the DoFAccessor class hierarchy between hp and
-       * non-hp classes.
+       * interface for non-hp- and hp-finite element methods, in effect making
+       * it possible to share the DoFAccessor class hierarchy between hp- and
+       * non-hp-classes.
        */
       template <int dh_dim, int spacedim>
       void
@@ -104,9 +104,9 @@ namespace internal
        *
        * The third argument, @p fe_index, must equal zero. It is otherwise
        * unused, but we retain the argument so that we can use the same
-       * interface for non-hp and hp finite element methods, in effect making
-       * it possible to share the DoFAccessor class hierarchy between hp and
-       * non-hp classes.
+       * interface for non-hp- and hp-finite element methods, in effect making
+       * it possible to share the DoFAccessor class hierarchy between hp- and
+       * non-hp-classes.
        */
       template <int dh_dim, int spacedim>
       types::global_dof_index
@@ -187,7 +187,7 @@ namespace internal
       Assert((fe_index ==
               dealii::DoFHandler<dh_dim, spacedim>::default_fe_index),
              ExcMessage("Only zero fe_index values are allowed for "
-                        "non-hp DoFHandlers."));
+                        "non-hp-DoFHandlers."));
       return true;
     }
 
@@ -206,7 +206,7 @@ namespace internal
       Assert(
         (fe_index == dealii::DoFHandler<dh_dim, spacedim>::default_fe_index),
         ExcMessage(
-          "Only the default FE index is allowed for non-hp DoFHandler objects"));
+          "Only the default FE index is allowed for non-hp-DoFHandler objects"));
       Assert(
         local_index < dof_handler.get_fe().template n_dofs_per_object<dim>(),
         ExcIndexRange(local_index,
index 194b49d0052a8b4f536e27bf8a79f9c9b7278d79..5e4926f8221816aa9185aed18c7cda473f6f8a3e 100644 (file)
@@ -2337,7 +2337,7 @@ namespace DoFTools
                              const ComponentMask &mask = ComponentMask());
 
   /**
-   * Same as the previous function but for the hp case.
+   * Same as the previous function but for the hp-case.
    */
   template <int dim, int spacedim>
   void
@@ -2386,7 +2386,7 @@ namespace DoFTools
     const ComponentMask &                               mask = ComponentMask());
 
   /**
-   * Same as the previous function but for the hp case.
+   * Same as the previous function but for the hp-case.
    */
   template <int dim, int spacedim>
   void
index d0e58d067c62d820a95c44c75935df7c0dd1dd4c..13c4a0b16a2bb717a53e20bb6c38a3a3c5b46c35 100644 (file)
@@ -113,7 +113,7 @@ class FESystem;
  * particular feature is implemented. An example is whether an element
  * implements the information necessary to use it in the $hp$ finite element
  * context (see
- * @ref hp "hp finite element support").
+ * @ref hp "hp-finite element support").
  *
  *
  * <h3>Nomenclature</h3>
@@ -339,7 +339,7 @@ class FESystem;
  * neighboring (but differently refined) cells. The case that the finite
  * element spaces on different sides of a face are different, i.e., the $hp$
  * case (see
- * @ref hp "hp finite element support")
+ * @ref hp "hp-finite element support")
  * is handled by separate functions. See the
  * FiniteElement::get_face_interpolation_matrix() and
  * FiniteElement::get_subface_interpolation_matrix() functions.
@@ -820,7 +820,7 @@ public:
   /**
    * This operator returns a reference to the present object if the argument
    * given equals to zero. While this does not seem particularly useful, it is
-   * helpful in writing code that works with both ::DoFHandler and the hp
+   * helpful in writing code that works with both ::DoFHandler and the hp-
    * version hp::DoFHandler, since one can then write code like this:
    * @code
    * dofs_per_cell =
@@ -833,7 +833,7 @@ public:
    * doesn't offer a <code>dofs_per_cell</code> member variable: one first has
    * to select which finite element to work on, which is done using the
    * operator[]. Fortunately, <code>cell-@>active_fe_index()</code> also works
-   * for non-hp classes and simply returns zero in that case. The present
+   * for non-hp-classes and simply returns zero in that case. The present
    * operator[] accepts this zero argument, by returning the finite element
    * with index zero within its collection (that, of course, consists only of
    * the present finite element anyway).
@@ -1230,7 +1230,7 @@ public:
 
   /**
    * Return whether this element implements its hanging node constraints in
-   * the new way, which has to be used to make elements "hp compatible".  That
+   * the new way, which has to be used to make elements "hp-compatible".  That
    * means, the element properly implements the get_face_interpolation_matrix
    * and get_subface_interpolation_matrix methods. Therefore the return value
    * also indicates whether a call to the get_face_interpolation_matrix()
@@ -1239,14 +1239,14 @@ public:
    *
    * Currently the main purpose of this function is to allow the
    * make_hanging_node_constraints method to decide whether the new
-   * procedures, which are supposed to work in the hp framework can be used,
-   * or if the old well verified but not hp capable functions should be used.
+   * procedures, which are supposed to work in the hp-framework can be used,
+   * or if the old well verified but not hp-capable functions should be used.
    * Once the transition to the new scheme for computing the interface
    * constraints is complete, this function will be superfluous and will
    * probably go away.
    *
    * Derived classes should implement this function accordingly. The default
-   * assumption is that a finite element does not provide hp capable face
+   * assumption is that a finite element does not provide hp-capable face
    * interpolation, and the default implementation therefore returns @p false.
    */
   virtual bool
@@ -1312,12 +1312,12 @@ public:
 
 
   /**
-   * @name Functions to support hp
+   * @name Functions to support hp-
    * @{
    */
 
   /**
-   * If, on a vertex, several finite elements are active, the hp code first
+   * If, on a vertex, several finite elements are active, the hp-code first
    * assigns the degrees of freedom of each of these FEs different global
    * indices. It then calls this function to find out which of them should get
    * identical values, and consequently can receive the same global DoF index.
@@ -1362,7 +1362,7 @@ public:
    *
    * For a definition of domination, see FiniteElementDomination::Domination
    * and in particular the
-   * @ref hp_paper "hp paper".
+   * @ref hp_paper "hp-paper".
    */
   virtual FiniteElementDomination::Domination
   compare_for_domination(const FiniteElement<dim, spacedim> &fe_other,
index 6a446b64e31181fd587e22a6e318628e9511fecb..ac3deeac3e0e7084c8f349b8f47e8897a8d67daa 100644 (file)
@@ -46,9 +46,9 @@ namespace FiniteElementDomination
    * Q(k') if $k\le k'$.
    *
    * This enum is used in the FiniteElement::compare_for_domination() function
-   * that is used in the context of hp finite element methods when determining
+   * that is used in the context of hp-finite element methods when determining
    * what to do at faces where two different finite elements meet (see the
-   * @ref hp_paper "hp paper"
+   * @ref hp_paper "hp-paper"
    * for a more detailed description of the following). In that case, the
    * degrees of freedom of one side need to be constrained to those on the
    * other side. The determination which side is which is based on the outcome
@@ -56,7 +56,7 @@ namespace FiniteElementDomination
    * to the dominating one.
    *
    * Note that there are situations where neither side dominates. The
-   * @ref hp_paper "hp paper"
+   * @ref hp_paper "hp-paper"
    * lists two case, with the simpler one being that a $Q_2\times Q_1$ vector-
    * valued element (i.e. a <code>FESystem(FE_Q(2),1,FE_Q(1),1)</code>) meets
    * a $Q_1\times Q_2$ element: here, for each of the two vector-components,
@@ -80,7 +80,7 @@ namespace FiniteElementDomination
    * could also be used by discontinuous elements, for example.
    *
    * More details on domination can be found in the
-   * @ref hp_paper "hp paper".
+   * @ref hp_paper "hp-paper".
    */
   enum Domination
   {
index c8fabd805abf6f75f33ebae653a6298ba6f8e599..b734bc5d66630cbed86289d00a35cb8a233c19ac 100644 (file)
@@ -138,13 +138,13 @@ public:
 
   /**
    * Return whether this element implements its hanging node constraints in
-   * the new way, which has to be used to make elements "hp compatible".
+   * the new way, which has to be used to make elements "hp-compatible".
    */
   virtual bool
   hp_constraints_are_implemented() const override;
 
   /**
-   * If, on a vertex, several finite elements are active, the hp code first
+   * If, on a vertex, several finite elements are active, the hp-code first
    * assigns the degrees of freedom of each of these FEs different global
    * indices. It then calls this function to find out which of them should get
    * identical values, and consequently can receive the same global DoF index.
index caa3b23916effa246b187ee7cfed7266d9253983..cb3b10959b8c2f715537466f90e079cbdb64de19 100644 (file)
@@ -328,7 +328,7 @@ public:
    */
 
   /**
-   * If, on a vertex, several finite elements are active, the hp code first
+   * If, on a vertex, several finite elements are active, the hp-code first
    * assigns the degrees of freedom of each of these FEs different global
    * indices. It then calls this function to find out which of them should get
    * identical values, and consequently can receive the same global DoF index.
@@ -373,7 +373,7 @@ public:
 
   /**
    * Return whether this element implements its hanging node constraints in
-   * the new way, which has to be used to make elements "hp compatible".
+   * the new way, which has to be used to make elements "hp-compatible".
    *
    * For the FE_DGP class the result is always true (independent of the degree
    * of the element), as it has no hanging nodes (being a discontinuous
index ddbc679d314000be67b67e86584c732b70870daf..4fb809269252f5180f58a08c55d8e187e20c061c 100644 (file)
@@ -303,7 +303,7 @@ public:
    */
 
   /**
-   * If, on a vertex, several finite elements are active, the hp code first
+   * If, on a vertex, several finite elements are active, the hp-code first
    * assigns the degrees of freedom of each of these FEs different global
    * indices. It then calls this function to find out which of them should get
    * identical values, and consequently can receive the same global DoF index.
@@ -346,7 +346,7 @@ public:
 
   /**
    * Return whether this element implements its hanging node constraints in
-   * the new way, which has to be used to make elements "hp compatible".
+   * the new way, which has to be used to make elements "hp-compatible".
    *
    * For the FE_DGPMonomial class the result is always true (independent of
    * the degree of the element), as it has no hanging nodes (being a
index 4944c55abc22212aa79bb05d27e58043ce73ce10..13ab9c02316db850b32aa895666603bc1ec39704 100644 (file)
@@ -420,7 +420,7 @@ public:
    */
 
   /**
-   * If, on a vertex, several finite elements are active, the hp code first
+   * If, on a vertex, several finite elements are active, the hp-code first
    * assigns the degrees of freedom of each of these FEs different global
    * indices. It then calls this function to find out which of them should get
    * identical values, and consequently can receive the same global DoF index.
@@ -465,7 +465,7 @@ public:
 
   /**
    * Return whether this element implements its hanging node constraints in
-   * the new way, which has to be used to make elements "hp compatible".
+   * the new way, which has to be used to make elements "hp-compatible".
    *
    * For the FE_DGPNonparametric class the result is always true (independent
    * of the degree of the element), as it has no hanging nodes (being a
index 7e5828a6a3933b8542afcdd24a47d52c73dfb741..90c51890e5dc6e0f5dbdb93643c19e6002f00356 100644 (file)
@@ -229,7 +229,7 @@ public:
    */
 
   /**
-   * If, on a vertex, several finite elements are active, the hp code first
+   * If, on a vertex, several finite elements are active, the hp-code first
    * assigns the degrees of freedom of each of these FEs different global
    * indices. It then calls this function to find out which of them should get
    * identical values, and consequently can receive the same global DoF index.
@@ -274,7 +274,7 @@ public:
 
   /**
    * Return whether this element implements its hanging node constraints in
-   * the new way, which has to be used to make elements "hp compatible".
+   * the new way, which has to be used to make elements "hp-compatible".
    *
    * For the FE_DGQ class the result is always true (independent of the degree
    * of the element), as it has no hanging nodes (being a discontinuous
index 821486027327c3100b1ed0166d4a178c6d2ea1e1..3747fcc6804cefe7ceab56831910f8a0d753e28d 100644 (file)
@@ -118,7 +118,7 @@ DEAL_II_NAMESPACE_OPEN
  *
  * In most applications it is beneficial to introduce enrichments only in
  * some part of the domain (e.g. around a crack tip) and use standard FE (e.g.
- * FE_Q) elsewhere. This can be achieved by using the hp finite element
+ * FE_Q) elsewhere. This can be achieved by using the hp-finite element
  * framework in deal.II that allows for the use of different elements on
  * different cells. To make the resulting space $C^0$ continuous, it is then
  * necessary for the DoFHandler class and
@@ -194,7 +194,7 @@ public:
    * element within a DoFHandler with hp-capabilities.
    *
    * See the discussion in the class documentation on how to use this element
-   * in the context of hp finite element methods.
+   * in the context of hp-finite element methods.
    */
   FE_Enriched(const FiniteElement<dim, spacedim> &fe_base);
 
@@ -336,7 +336,7 @@ public:
    */
 
   /**
-   * Return whether this element implements hp constraints.
+   * Return whether this element implements hp-constraints.
    *
    * This function returns @p true if and only if all its base elements return @p true
    * for this function.
@@ -381,7 +381,7 @@ public:
     const unsigned int                  face_no = 0) const override;
 
   /**
-   * If, on a vertex, several finite elements are active, the hp code first
+   * If, on a vertex, several finite elements are active, the hp-code first
    * assigns the degrees of freedom of each of these FEs different global
    * indices. It then calls this function to find out which of them should get
    * identical values, and consequently can receive the same global DoF index.
index 6faad3c65d03af5350ed57688a629ed290494e2a..6091ee0132211bdf7f04a8600c70db37a3c1a56a 100644 (file)
@@ -128,7 +128,7 @@ public:
    */
 
   /**
-   * If, on a vertex, several finite elements are active, the hp code first
+   * If, on a vertex, several finite elements are active, the hp-code first
    * assigns the degrees of freedom of each of these FEs different global
    * indices. It then calls this function to find out which of them should get
    * identical values, and consequently can receive the same global DoF index.
@@ -170,7 +170,7 @@ public:
 
   /**
    * Return whether this element implements its hanging node constraints in
-   * the new way, which has to be used to make elements "hp compatible".
+   * the new way, which has to be used to make elements "hp-compatible".
    */
   virtual bool
   hp_constraints_are_implemented() const override;
@@ -275,13 +275,13 @@ public:
 
   /**
    * Return whether this element implements its hanging node constraints in
-   * the new way, which has to be used to make elements "hp compatible".
+   * the new way, which has to be used to make elements "hp-compatible".
    */
   virtual bool
   hp_constraints_are_implemented() const override;
 
   /**
-   * If, on a vertex, several finite elements are active, the hp code first
+   * If, on a vertex, several finite elements are active, the hp-code first
    * assigns the degrees of freedom of each of these FEs different global
    * indices. It then calls this function to find out which of them should get
    * identical values, and consequently can receive the same global DoF index.
@@ -527,7 +527,7 @@ public:
 
   /**
    * Return whether this element implements its hanging node constraints in
-   * the new way, which has to be used to make elements "hp compatible".
+   * the new way, which has to be used to make elements "hp-compatible".
    */
   virtual bool
   hp_constraints_are_implemented() const override;
index 7e3376700c9bbd054686b0f9f69b85f385c12025..621b544f2293c2d37b686d159f9fc60860a16425 100644 (file)
@@ -177,11 +177,11 @@ public:
 
   /**
    * Return whether this element implements its hanging node constraints in
-   * the new way, which has to be used to make elements "hp compatible".
+   * the new way, which has to be used to make elements "hp-compatible".
    *
    * For the <tt>FE_Nedelec</tt> class the result is always true (independent
    * of the degree of the element), as it implements the complete set of
-   * functions necessary for hp capability.
+   * functions necessary for hp-capability.
    */
   virtual bool
   hp_constraints_are_implemented() const override;
@@ -194,7 +194,7 @@ public:
                          const unsigned int codim = 0) const override final;
 
   /**
-   * If, on a vertex, several finite elements are active, the hp code first
+   * If, on a vertex, several finite elements are active, the hp-code first
    * assigns the degrees of freedom of each of these FEs different global
    * indices. It then calls this function to find out which of them should get
    * identical values, and consequently can receive the same global DoF index.
index 4660237f3560017917bc5a25338db8e1c5676f11..089e3c33cb76a57fc9712cb43561ff01abed2cfd 100644 (file)
@@ -30,7 +30,7 @@ DEAL_II_NAMESPACE_OPEN
  * Definition of a finite element space with zero degrees of freedom and that,
  * consequently, can only represent a single function: the zero function.
  *
- * This class is useful (in the context of an hp method) to represent empty
+ * This class is useful (in the context of an hp-method) to represent empty
  * cells in the triangulation on which no degrees of freedom should be
  * allocated, or to describe a field that is extended by zero to a part of the
  * domain where we don't need it. Thus a triangulation may be divided into two
index ae2a6cffc32e55454097cb1c436639741f006feb..1340d25ad417be31fc70c7ab4ed4f855fe385d72 100644 (file)
@@ -218,17 +218,17 @@ public:
 
   /**
    * Return whether this element implements its hanging node constraints in
-   * the new way, which has to be used to make elements "hp compatible".
+   * the new way, which has to be used to make elements "hp-compatible".
    *
    * For the FE_Q class the result is always true (independent of the degree
    * of the element), as it implements the complete set of functions necessary
-   * for hp capability.
+   * for hp-capability.
    */
   virtual bool
   hp_constraints_are_implemented() const override;
 
   /**
-   * If, on a vertex, several finite elements are active, the hp code first
+   * If, on a vertex, several finite elements are active, the hp-code first
    * assigns the degrees of freedom of each of these FEs different global
    * indices. It then calls this function to find out which of them should get
    * identical values, and consequently can receive the same global DoF index.
index 47d97564b94f4bfd715994ad3fb127a04c54fc28..d133672cf01ceb77d0dcf55815c22d20487862fc 100644 (file)
@@ -570,11 +570,11 @@ public:
 
   /**
    * Return whether this element implements its hanging node constraints in
-   * the new way, which has to be used to make elements "hp compatible".
+   * the new way, which has to be used to make elements "hp-compatible".
    *
    * For the FE_Q_Hierarchical class the result is always true (independent of
    * the degree of the element), as it implements the complete set of
-   * functions necessary for hp capability.
+   * functions necessary for hp-capability.
    */
   virtual bool
   hp_constraints_are_implemented() const override;
@@ -597,7 +597,7 @@ public:
       RefinementCase<dim>::isotropic_refinement) const override;
 
   /**
-   * If, on a vertex, several finite elements are active, the hp code first
+   * If, on a vertex, several finite elements are active, the hp-code first
    * assigns the degrees of freedom of each of these FEs different global
    * indices. It then calls this function to find out which of them should get
    * identical values, and consequently can receive the same global DoF index.
index 709c6649aed6fcd598d227c0da76c3544b58a45a..d085c623807cfdc7a7228b2c8aeabe526ce5d2c9 100644 (file)
@@ -932,7 +932,7 @@ public:
 
   /**
    * Return whether this element implements its hanging node constraints in
-   * the new way, which has to be used to make elements "hp compatible".
+   * the new way, which has to be used to make elements "hp-compatible".
    *
    * This function returns @p true if and only if all its base elements return
    * @p true for this function.
@@ -978,7 +978,7 @@ public:
     const unsigned int                  face_no = 0) const override;
 
   /**
-   * If, on a vertex, several finite elements are active, the hp code first
+   * If, on a vertex, several finite elements are active, the hp-code first
    * assigns the degrees of freedom of each of these FEs different global
    * indices. It then calls this function to find out which of them should get
    * identical values, and consequently can receive the same global DoF index.
index 28c61e2b714fb929c267d6f802d8baaf8519fc17..2b640ba4377d6ec9d9bffb346d59d6492ebf4953 100644 (file)
@@ -94,7 +94,7 @@ public:
 
   /**
    * Return whether this element implements its hanging node constraints in
-   * the new way, which has to be used to make elements "hp compatible".
+   * the new way, which has to be used to make elements "hp-compatible".
    */
   virtual bool
   hp_constraints_are_implemented() const override;
index 0972902873332c12d6213e3b6d810680420c8b5c..e5c92c79ab250c911b1d6f64fb37d4873f96b251 100644 (file)
@@ -3800,7 +3800,7 @@ public:
    *
    * Though it seems that it is not very useful, this function is there to
    * provide capability to the hp::FEValues class, in which case it provides
-   * the FEValues object for the present cell (remember that for hp finite
+   * the FEValues object for the present cell (remember that for hp-finite
    * elements, the actual FE object used may change from cell to cell, so we
    * also need different FEValues objects for different cells; once you
    * reinitialize the hp::FEValues object for a specific cell, it retrieves
@@ -4039,7 +4039,7 @@ public:
    *
    * Though it seems that it is not very useful, this function is there to
    * provide capability to the hp::FEValues class, in which case it provides
-   * the FEValues object for the present cell (remember that for hp finite
+   * the FEValues object for the present cell (remember that for hp-finite
    * elements, the actual FE object used may change from cell to cell, so we
    * also need different FEValues objects for different cells; once you
    * reinitialize the hp::FEValues object for a specific cell, it retrieves
@@ -4194,7 +4194,7 @@ public:
    *
    * Though it seems that it is not very useful, this function is there to
    * provide capability to the hp::FEValues class, in which case it provides
-   * the FEValues object for the present cell (remember that for hp finite
+   * the FEValues object for the present cell (remember that for hp-finite
    * elements, the actual FE object used may change from cell to cell, so we
    * also need different FEValues objects for different cells; once you
    * reinitialize the hp::FEValues object for a specific cell, it retrieves
index ebf7e40cb18b087f902f92a6220c8dcc385607f1..59c642594285810bf87dc2982068d5525e15c287 100644 (file)
@@ -1252,7 +1252,7 @@ namespace GridTools
   /**
    * Another version where we use that mapping on a given
    * cell that corresponds to the active finite element index of that cell.
-   * This is obviously only useful for hp problems, since the active finite
+   * This is obviously only useful for hp-problems, since the active finite
    * element index for all other DoF handlers is always zero.
    */
   template <int dim, int spacedim>
index 62de381d4359d60bb8b74139c19acd38a4631140..26fd3e93cbef57bc9a17f4888f8eff62f7211b7c 100644 (file)
@@ -45,7 +45,7 @@ namespace hp
    * The whole process of working with objects of this type is explained in
    * step-27. Many of the algorithms this class implements are described in
    * the
-   * @ref hp_paper "hp paper".
+   * @ref hp_paper "hp-paper".
    *
    *
    * <h3>Active FE indices and their behavior under mesh refinement</h3>
index 4efb7d9a0d9d47769986499aa46928b734c82c78..07a32368ef2ddc315b2918e110ae4af313e785de 100644 (file)
@@ -52,7 +52,7 @@ namespace hp
   {
   public:
     /**
-     * Whenever p adaptivity is considered in an hp finite element program,
+     * Whenever p-adaptivity is considered in an hp-finite element program,
      * a hierarchy of finite elements needs to be established to determine
      * succeeding finite elements for refinement and preceding ones for
      * coarsening.
@@ -283,10 +283,10 @@ namespace hp
     /**
      * Return whether all elements in this collection implement the hanging
      * node constraints in the new way, which has to be used to make elements
-     * "hp compatible". If this is not the case, the function returns false,
+     * "hp-compatible". If this is not the case, the function returns false,
      * which implies, that at least one element in the FECollection does not
      * support the new face interface constraints. On the other hand, if this
-     * method does return true, this does not imply that the hp method will
+     * method does return true, this does not imply that the hp-method will
      * work!
      *
      * This behavior is related to the fact, that FiniteElement classes,
index 23ce1556b36785ac92cde984bfd332f4a46236df..f4dfefe931446c1c779165e3c8b63d160d554767 100644 (file)
@@ -60,7 +60,7 @@ namespace hp
    * second the dimensionality of the object that we integrate on, i.e. for
    * usual @p hp::FEValues it is equal to the first one, while for face
    * integration it is one less. The third template parameter indicates the
-   * type of underlying non-hp FE*Values base type, i.e. it could either be
+   * type of underlying non-hp-FE*Values base type, i.e. it could either be
    * ::FEValues, ::FEFaceValues, or ::FESubfaceValues.
    *
    * @ingroup hp
@@ -231,11 +231,11 @@ namespace hp
 namespace hp
 {
   /**
-   * An hp equivalent of the ::FEValues class. See the step-27 tutorial
+   * An hp-equivalent of the ::FEValues class. See the step-27 tutorial
    * program for examples of use.
    *
    * The idea of this class is as follows: when one assembled matrices in the
-   * hp finite element method, there may be different finite elements on
+   * hp-finite element method, there may be different finite elements on
    * different cells, and consequently one may also want to use different
    * quadrature formulas for different cells. On the other hand, the
    * ::FEValues efficiently handles pre-evaluating whatever information is
@@ -255,7 +255,7 @@ namespace hp
    * ::FEValues object that then fits the finite element and quadrature
    * formula for the current cell can then be accessed using the
    * get_present_fe_values() function, and one would work with it just like
-   * with any ::FEValues object for non-hp DoF handler objects.
+   * with any ::FEValues object for non-hp-DoFHandler objects.
    *
    * The reinit() functions have additional arguments with default values. If
    * not specified, the function takes the index into the hp::FECollection,
@@ -336,7 +336,7 @@ namespace hp
      * quadrature formula for each finite element in the hp::FECollection. As
      * a special case, if the quadrature collection contains only a single
      * element (a frequent case if one wants to use the same quadrature object
-     * for all finite elements in an hp discretization, even if that may not
+     * for all finite elements in an hp-discretization, even if that may not
      * be the most efficient), then this single quadrature is used unless a
      * different value for this argument is specified. On the other hand, if a
      * value is given for this argument, it overrides the choice of
@@ -349,7 +349,7 @@ namespace hp
      * <code>cell-@>active_fe_index()</code>, i.e. the same index as that of
      * the finite element. As above, if the mapping collection contains only a
      * single element (a frequent case if one wants to use a $Q_1$ mapping for
-     * all finite elements in an hp discretization), then this single mapping
+     * all finite elements in an hp-discretization), then this single mapping
      * is used unless a different value for this argument is specified.
      */
     template <bool lda>
@@ -455,7 +455,7 @@ namespace hp
      * quadrature formula for each finite element in the hp::FECollection. As
      * a special case, if the quadrature collection contains only a single
      * element (a frequent case if one wants to use the same quadrature object
-     * for all finite elements in an hp discretization, even if that may not
+     * for all finite elements in an hp-discretization, even if that may not
      * be the most efficient), then this single quadrature is used unless a
      * different value for this argument is specified. On the other hand, if a
      * value is given for this argument, it overrides the choice of
@@ -468,7 +468,7 @@ namespace hp
      * <code>cell-@>active_fe_index()</code>, i.e. the same index as that of
      * the finite element. As above, if the mapping collection contains only a
      * single element (a frequent case if one wants to use a $Q_1$ mapping for
-     * all finite elements in an hp discretization), then this single mapping
+     * all finite elements in an hp-discretization), then this single mapping
      * is used unless a different value for this argument is specified.
      */
     template <bool lda>
@@ -576,7 +576,7 @@ namespace hp
      * quadrature formula for each finite element in the hp::FECollection. As
      * a special case, if the quadrature collection contains only a single
      * element (a frequent case if one wants to use the same quadrature object
-     * for all finite elements in an hp discretization, even if that may not
+     * for all finite elements in an hp-discretization, even if that may not
      * be the most efficient), then this single quadrature is used unless a
      * different value for this argument is specified. On the other hand, if a
      * value is given for this argument, it overrides the choice of
@@ -589,7 +589,7 @@ namespace hp
      * <code>cell-@>active_fe_index()</code>, i.e. the same index as that of
      * the finite element. As above, if the mapping collection contains only a
      * single element (a frequent case if one wants to use a $Q_1$ mapping for
-     * all finite elements in an hp discretization), then this single mapping
+     * all finite elements in an hp-discretization), then this single mapping
      * is used unless a different value for this argument is specified.
      */
     template <bool lda>
index 12b01f6ac7e5c930aa5504c1279c79bf3ae4deed..a8ae7ebdecf1b8cde1cb1a39d5d1f0a7a6bbf508 100644 (file)
@@ -620,7 +620,7 @@ namespace hp
      *
      * @note The function Triangulation::prepare_coarsening_and_refinement()
      *   will clean up all h-coarsening flags if they are not shared among
-     *   all siblings. In the hp case, we need to bring forward this decision:
+     *   all siblings. In the hp-case, we need to bring forward this decision:
      *   If the cell will not be coarsened, but qualifies for p-adaptivity,
      *   we have to set all flags accordingly. So this function anticipates
      *   the decision that Triangulation::prepare_coarsening_and_refinement()
index 6e4b0ed96542be04d545d05c2c421a780ca00c0d..61b04ad70c60c0745f6b590dfe8a2ffdd9bbcf77 100644 (file)
@@ -443,7 +443,7 @@ class AffineConstraints;
  *
  * The algorithms used in the implementation of this class are described in
  * some detail in the
- * @ref hp_paper "hp paper".
+ * @ref hp_paper "hp-paper".
  * There is also a significant amount of documentation on how to use this
  * class in the
  * @ref constraints
@@ -1442,7 +1442,7 @@ public:
    * sparsity pattern entries.
    *
    * As explained in the
-   * @ref hp_paper "hp paper"
+   * @ref hp_paper "hp-paper"
    * and in step-27, first allocating a sparsity pattern and later coming back
    * and allocating additional entries for those matrix entries that will be
    * written to due to the elimination of constrained degrees of freedom
index e1b1c5f271340af42b497a00d5bb90820311304d..f1a2dc13ae1757fd66c343946510db9d721874d2 100644 (file)
@@ -129,9 +129,9 @@ namespace internal
       clear();
 
       /**
-       * Return the FE index for a given finite element degree. If not in hp
+       * Return the FE index for a given finite element degree. If not in hp-
        * mode, this function always returns index 0. If an index is not found
-       * in hp mode, it returns numbers::invalid_unsigned_int.
+       * in hp-mode, it returns numbers::invalid_unsigned_int.
        */
       unsigned int
       fe_index_from_degree(const unsigned int first_selected_component,
@@ -634,7 +634,7 @@ namespace internal
        * account. This information is encoded in the row_starts variables
        * directly.
        *
-       * The outer vector goes through the various fe indices in the hp case,
+       * The outer vector goes through the various fe indices in the hp-case,
        * similarly to the @p dofs_per_cell variable.
        */
       std::vector<std::vector<unsigned int>> component_dof_indices_offset;
@@ -655,20 +655,20 @@ namespace internal
       bool store_plain_indices;
 
       /**
-       * Stores the index of the active finite element in the hp case.
+       * Stores the index of the active finite element in the hp-case.
        */
       std::vector<unsigned int> cell_active_fe_index;
 
       /**
-       * Stores the maximum degree of different finite elements for the hp
+       * Stores the maximum degree of different finite elements for the hp-
        * case.
        */
       unsigned int max_fe_index;
 
       /**
-       * To each of the slots in an hp adaptive case, the inner vector stores
+       * To each of the slots in an hp-adaptive case, the inner vector stores
        * the corresponding element degree. This is used by the constructor of
-       * FEEvaluationBase to identify the correct data slot in the hp case.
+       * FEEvaluationBase to identify the correct data slot in the hp-case.
        */
       std::vector<std::vector<unsigned int>> fe_index_conversion;
 
index 0f424797949eb05d24d0c8a676eb97e38bde2a7e..3662a970c46cae28fa46f57f4d84210aa818c99a 100644 (file)
@@ -257,7 +257,7 @@ public:
   get_current_cell_index() const;
 
   /**
-   * Return the active fe index for this class for efficient indexing in the hp
+   * Return the active fe index for this class for efficient indexing in the hp-
    * case.
    */
   unsigned int
@@ -265,7 +265,7 @@ public:
 
   /**
    * Return the active quadrature index for this class for efficient indexing in
-   * the hp case.
+   * the hp-case.
    */
   unsigned int
   get_active_quadrature_index() const;
@@ -360,13 +360,13 @@ protected:
     VectorizedArrayType> *mapping_data;
 
   /**
-   * The active fe index for this class for efficient indexing in the hp case.
+   * The active fe index for this class for efficient indexing in the hp-case.
    */
   const unsigned int active_fe_index;
 
   /**
    * The active quadrature index for this class for efficient indexing in the
-   * hp case.
+   * hp-case.
    */
   const unsigned int active_quad_index;
 
index dc63926076e7b8c136188270aad631bfcade4488..8c0d0c77d46e7badb001ecbca42b1b036788f719 100644 (file)
@@ -104,7 +104,7 @@ namespace internal
      * The third component is a descriptor of data from the unit cells, called
      * QuadratureDescriptor, which contains the quadrature weights and
      * permutations of how to go through quadrature points in case of face
-     * data. The latter comes in a vector for the support of hp adaptivity,
+     * data. The latter comes in a vector for the support of hp-adaptivity,
      * with several data fields for the individual quadrature formulas.
      *
      * @ingroup matrixfree
@@ -188,7 +188,7 @@ namespace internal
       /**
        * A class describing the layout of the sections in the @p data_storage
        * field and also includes some data that depends on the number of
-       * quadrature points in the hp context such as the inner quadrature
+       * quadrature points in the hp-context such as the inner quadrature
        * formula and re-indexing for faces that are not in the standard
        * orientation.
        */
@@ -289,7 +289,7 @@ namespace internal
 
       /**
        * Returns the quadrature index for a given number of quadrature
-       * points. If not in hp mode or if the index is not found, this
+       * points. If not in hp-mode or if the index is not found, this
        * function always returns index 0. Hence, this function does not
        * check whether the given degree is actually present.
        */
@@ -456,7 +456,7 @@ namespace internal
 
       /**
        * Internal function to compute the geometry for the case the mapping is
-       * a MappingQ and a single quadrature formula per slot (non-hp case) is
+       * a MappingQ and a single quadrature formula per slot (non-hp-case) is
        * used. This method computes all data from the underlying cell
        * quadrature points using the fast operator evaluation techniques from
        * the matrix-free framework itself, i.e., it uses a polynomial
index c2d822fff7e31285184bd8929ab0033bde5fae12..d6cddd792b615c12b5602b6d055a8540472443b9 100644 (file)
@@ -460,7 +460,7 @@ namespace internal
             }
         }
 
-      // In case we have no hp adaptivity (active_fe_index is empty), we have
+      // In case we have no hp-adaptivity (active_fe_index is empty), we have
       // cells, and the mapping is MappingQGeneric or a derived class, we can
       // use the fast method.
       if (active_fe_index.empty() && !cells.empty() && mapping->size() == 1 &&
@@ -904,7 +904,7 @@ namespace internal
         GeometryType cell_t_prev = general;
 
         // fe_values object that is used to compute the mapping data. for
-        // the hp case there might be more than one finite element. since we
+        // the hp-case there might be more than one finite element. since we
         // manually select the active FE index and not via a
         // DoFHandler<dim>::active_cell_iterator, we need to manually
         // select the correct finite element, so just hold a vector of
@@ -1840,7 +1840,7 @@ namespace internal
                ++my_q)
             {
 #ifndef DEAL_II_WITH_SIMPLEX_SUPPORT
-              // currently only non-hp case...
+              // currently only non-hp-case...
               AssertDimension(mapping_in.size(), 1);
               AssertDimension(mapping_info.face_data[my_q].descriptor.size(),
                               1);
index e04a41b761316de6a43510550ee17f1449678e6c..1f82ed4fd7f7c5a7a496a2014781243181ddf40e 100644 (file)
@@ -163,7 +163,7 @@ public:
    * The two parameters `cell_vectorization_categories` and
    * `cell_vectorization_categories_strict` control the formation of batches
    * for vectorization over several cells. It is used implicitly when working
-   * with hp adaptivity but can also be useful in other contexts, such as in
+   * with hp-adaptivity but can also be useful in other contexts, such as in
    * local time stepping where one would like to control which elements
    * together form a batch of cells. The array `cell_vectorization_categories`
    * is accessed by the number given by cell->active_cell_index() when working
@@ -511,7 +511,7 @@ public:
     /**
      * This data structure allows to assign a fraction of cells to different
      * categories when building the information for vectorization. It is used
-     * implicitly when working with hp adaptivity but can also be useful in
+     * implicitly when working with hp-adaptivity but can also be useful in
      * other contexts, such as in local time stepping where one would like to
      * control which elements together form a batch of cells.
      *
@@ -1458,7 +1458,7 @@ public:
       DataAccessOnFaces::unspecified) const;
 
   /**
-   * In the hp adaptive case, a subrange of cells as computed during the cell
+   * In the hp-adaptive case, a subrange of cells as computed during the cell
    * loop might contain elements of different degrees. Use this function to
    * compute what the subrange for an individual finite element degree is. The
    * finite element degree is associated to the vector component given in the
@@ -1470,9 +1470,9 @@ public:
                           const unsigned int dof_handler_index = 0) const;
 
   /**
-   * In the hp adaptive case, a subrange of cells as computed during the cell
+   * In the hp-adaptive case, a subrange of cells as computed during the cell
    * loop might contain elements of different degrees. Use this function to
-   * compute what the subrange for a given index the hp finite element, as
+   * compute what the subrange for a given index the hp-finite element, as
    * opposed to the finite element degree in the other function.
    */
   std::pair<unsigned int, unsigned int>
@@ -1482,7 +1482,7 @@ public:
     const unsigned int                           dof_handler_index = 0) const;
 
   /**
-   * In the hp adaptive case, a subrange of internal faces as computed during
+   * In the hp-adaptive case, a subrange of internal faces as computed during
    * loop() might contain internal faces with elements of different active
    * fe indices. Use this function to compute what the subrange for a given pair
    * of active fe indices is.
@@ -1495,7 +1495,7 @@ public:
     const unsigned int                           dof_handler_index = 0) const;
 
   /**
-   * In the hp adaptive case, a subrange of boundary faces as computed during
+   * In the hp-adaptive case, a subrange of boundary faces as computed during
    * loop() might contain boundary faces with elements of different active
    * fe indices. Use this function to compute what the subrange for a given
    * active fe indices is.
@@ -1507,20 +1507,20 @@ public:
     const unsigned int                           dof_handler_index = 0) const;
 
   /**
-   * In the hp adaptive case, return number of active_fe_indices.
+   * In the hp-adaptive case, return number of active_fe_indices.
    */
   unsigned int
   n_active_fe_indices() const;
 
   /**
-   * In the hp adaptive case, return the active_fe_index of a cell range.
+   * In the hp-adaptive case, return the active_fe_index of a cell range.
    */
   unsigned int
   get_cell_active_fe_index(
     const std::pair<unsigned int, unsigned int> range) const;
 
   /**
-   * In the hp adaptive case, return the active_fe_index of a face range.
+   * In the hp-adaptive case, return the active_fe_index of a face range.
    */
   unsigned int
   get_face_active_fe_index(const std::pair<unsigned int, unsigned int> range,
@@ -1862,14 +1862,14 @@ public:
   n_active_entries_per_face_batch(const unsigned int face_batch_index) const;
 
   /**
-   * Return the number of degrees of freedom per cell for a given hp index.
+   * Return the number of degrees of freedom per cell for a given hp-index.
    */
   unsigned int
   get_dofs_per_cell(const unsigned int dof_handler_index  = 0,
                     const unsigned int hp_active_fe_index = 0) const;
 
   /**
-   * Return the number of quadrature points per cell for a given hp index.
+   * Return the number of quadrature points per cell for a given hp-index.
    */
   unsigned int
   get_n_q_points(const unsigned int quad_index         = 0,
@@ -1877,7 +1877,7 @@ public:
 
   /**
    * Return the number of degrees of freedom on each face of the cell for
-   * given hp index.
+   * given hp-index.
    */
   unsigned int
   get_dofs_per_face(const unsigned int dof_handler_index  = 0,
@@ -1885,21 +1885,21 @@ public:
 
   /**
    * Return the number of quadrature points on each face of the cell for
-   * given hp index.
+   * given hp-index.
    */
   unsigned int
   get_n_q_points_face(const unsigned int quad_index         = 0,
                       const unsigned int hp_active_fe_index = 0) const;
 
   /**
-   * Return the quadrature rule for given hp index.
+   * Return the quadrature rule for given hp-index.
    */
   const Quadrature<dim> &
   get_quadrature(const unsigned int quad_index         = 0,
                  const unsigned int hp_active_fe_index = 0) const;
 
   /**
-   * Return the quadrature rule for given hp index.
+   * Return the quadrature rule for given hp-index.
    */
   const Quadrature<dim - 1> &
   get_face_quadrature(const unsigned int quad_index         = 0,
@@ -1908,7 +1908,7 @@ public:
   /**
    * Return the category the current batch of cells was assigned to. Categories
    * run between the given values in the field
-   * AdditionalData::cell_vectorization_category for non-hp DoFHandler types
+   * AdditionalData::cell_vectorization_category for non-hp-DoFHandler types
    * and return the active FE index in the hp-adaptive case.
    */
   unsigned int
@@ -2012,7 +2012,7 @@ public:
   constraint_pool_end(const unsigned int pool_index) const;
 
   /**
-   * Return the unit cell information for given hp index.
+   * Return the unit cell information for given hp-index.
    */
   const internal::MatrixFreeFunctions::ShapeInfo<VectorizedArrayType> &
   get_shape_info(const unsigned int dof_handler_index_component = 0,
index cba9b410ae5e0c3f92be43eb488b447351687e00..b2f3fab8937b10afaa5f5ada2caf5b31765eb38d 100644 (file)
@@ -106,7 +106,7 @@ MatrixFree<dim, Number, VectorizedArrayType>::create_cell_subrange_hp_by_index(
         Assert(
           fe_indices[i] >= fe_indices[i - 1],
           ExcMessage(
-            "Cell range must be over sorted range of fe indices in hp case!"));
+            "Cell range must be over sorted range of fe indices in hp-case!"));
       AssertIndexRange(range.first, fe_indices.size() + 1);
       AssertIndexRange(range.second, fe_indices.size() + 1);
 #endif
@@ -579,7 +579,7 @@ MatrixFree<dim, Number, VectorizedArrayType>::internal_reinit(
     {
       if (dof_handler.size() > 1)
         {
-          // check if all DoHandlers are in the same hp mode; and if hp
+          // check if all DoHandlers are in the same hp-mode; and if hp-
           // capabilities are enabled: check if active_fe_indices of all
           // DoFHandler are the same.
           for (unsigned int i = 1; i < dof_handler.size(); ++i)
index 322b863ddbe26e5fad94cc419a88c60361781fe3..d985c3a570a187971685edb502f80be494c695cf 100644 (file)
@@ -151,7 +151,7 @@ namespace internal
        * interleaving cell and face integrals.
        *
        * @param categories_are_hp Defines whether
-       * `cell_vectorization_categories` is originating from a hp adaptive
+       * `cell_vectorization_categories` is originating from a hp-adaptive
        * computation with variable polynomial degree or a user-defined
        * variant.
        *
@@ -246,7 +246,7 @@ namespace internal
        * some SIMD lanes in VectorizedArray would not be filled for a given
        * cell batch index.
        *
-       * @param hp_bool Defines whether we are in hp mode or not
+       * @param hp_bool Defines whether we are in hp-mode or not
        */
       void
       make_thread_graph_partition_color(
@@ -285,7 +285,7 @@ namespace internal
        * some SIMD lanes in VectorizedArray would not be filled for a given
        * cell batch index.
        *
-       * @param hp_bool Defines whether we are in hp mode or not
+       * @param hp_bool Defines whether we are in hp-mode or not
        */
       void
       make_thread_graph_partition_partition(
@@ -316,7 +316,7 @@ namespace internal
        * some SIMD lanes in VectorizedArray would not be filled for a given
        * cell batch index.
        *
-       * @param hp_bool Defines whether we are in hp mode or not
+       * @param hp_bool Defines whether we are in hp-mode or not
        */
       void
       make_thread_graph(const std::vector<unsigned int> &cell_active_fe_index,
index b1fd856f59eb22599b5c9ba542cdbcdefd885c9b..dc88c7e8fafc39a55bb0ae8066899d07944788ba 100644 (file)
@@ -38,7 +38,7 @@ namespace internal
 
 
 /**
- * Class for transfer between two multigrid levels for p or global coarsening.
+ * Class for transfer between two multigrid levels for p- or global coarsening.
  */
 template <int dim, typename VectorType>
 class MGTwoLevelTransfer
@@ -60,7 +60,7 @@ public:
 
 
 /**
- * Class for transfer between two multigrid levels for p or global coarsening.
+ * Class for transfer between two multigrid levels for p- or global coarsening.
  * Specialization for LinearAlgebra::distributed::Vector.
  */
 template <int dim, typename Number>
index 220b3fc69238f28e76f90cbd23bc88bbf43ed15f..e7e4bf220878a69a53db0506cebec307335bdacc 100644 (file)
@@ -429,7 +429,7 @@ public:
 
   /**
    * Equivalent to the set of functions above, except that this one takes a
-   * quadrature collection for hp finite element dof handlers.
+   * quadrature collection for hp-finite element dof handlers.
    */
   template <typename InputVector>
   static void
@@ -452,7 +452,7 @@ public:
 
   /**
    * Equivalent to the set of functions above, except that this one takes a
-   * quadrature collection for hp finite element dof handlers.
+   * quadrature collection for hp-finite element dof handlers.
    */
   template <typename InputVector>
   static void
@@ -474,7 +474,7 @@ public:
 
   /**
    * Equivalent to the set of functions above, except that this one takes a
-   * quadrature collection for hp finite element dof handlers.
+   * quadrature collection for hp-finite element dof handlers.
    */
   template <typename InputVector>
   static void
@@ -497,7 +497,7 @@ public:
 
   /**
    * Equivalent to the set of functions above, except that this one takes a
-   * quadrature collection for hp finite element dof handlers.
+   * quadrature collection for hp-finite element dof handlers.
    */
   template <typename InputVector>
   static void
@@ -715,7 +715,7 @@ public:
 
   /**
    * Equivalent to the set of functions above, except that this one takes a
-   * quadrature collection for hp finite element dof handlers.
+   * quadrature collection for hp-finite element dof handlers.
    */
   template <typename InputVector>
   static void
@@ -738,7 +738,7 @@ public:
 
   /**
    * Equivalent to the set of functions above, except that this one takes a
-   * quadrature collection for hp finite element dof handlers.
+   * quadrature collection for hp-finite element dof handlers.
    */
   template <typename InputVector>
   static void
@@ -760,7 +760,7 @@ public:
 
   /**
    * Equivalent to the set of functions above, except that this one takes a
-   * quadrature collection for hp finite element dof handlers.
+   * quadrature collection for hp-finite element dof handlers.
    */
   template <typename InputVector>
   static void
@@ -783,7 +783,7 @@ public:
 
   /**
    * Equivalent to the set of functions above, except that this one takes a
-   * quadrature collection for hp finite element dof handlers.
+   * quadrature collection for hp-finite element dof handlers.
    */
   template <typename InputVector>
   static void
index beb539b0aadedc0a7f83b9e7c580ad035800fc2c..5b72586f20fcfe5bce950cd911611643e73e4015 100644 (file)
@@ -84,7 +84,7 @@ namespace internal
    * needs not allocate memory itself, or synchronize with other threads.
    *
    * The sizes of the arrays are initialized with the maximal number of
-   * entries necessary for the hp case. Within the loop over individual
+   * entries necessary for the hp-case. Within the loop over individual
    * cells, we then resize the arrays as necessary. Since for std::vector
    * resizing to a smaller size doesn't imply memory allocation, this is
    * fast.
@@ -195,7 +195,7 @@ namespace internal
 
     /**
      * Resize the arrays so that they fit the number of quadrature points
-     * associated with the given finite element index into the hp
+     * associated with the given finite element index into the hp-
      * collections.
      */
     void
@@ -700,7 +700,7 @@ namespace internal
                ExcInternalError());
 
         // get restriction of finite element function of @p{neighbor} to the
-        // common face. in the hp case, use the quadrature formula that
+        // common face. in the hp-case, use the quadrature formula that
         // matches the one we would use for the present cell
         fe_face_values_neighbor.reinit(neighbor,
                                        neighbor_neighbor,
index c0052ff6170b924f77ed2cb63acec9ddffad8ac8..52169804de37766557ce54309516fd2537fb1438 100644 (file)
@@ -318,7 +318,7 @@ namespace MatrixCreator
     const AffineConstraints<number> &constraints = AffineConstraints<number>());
 
   /**
-   * Same function as above, but for hp objects.
+   * Same function as above, but for hp-objects.
    */
   template <int dim, int spacedim, typename number>
   void
@@ -331,7 +331,7 @@ namespace MatrixCreator
     const AffineConstraints<number> &constraints = AffineConstraints<number>());
 
   /**
-   * Same function as above, but for hp objects.
+   * Same function as above, but for hp-objects.
    */
   template <int dim, int spacedim, typename number>
   void
@@ -343,7 +343,7 @@ namespace MatrixCreator
     const AffineConstraints<number> &constraints = AffineConstraints<number>());
 
   /**
-   * Same function as above, but for hp objects.
+   * Same function as above, but for hp-objects.
    */
   template <int dim, int spacedim, typename number>
   void
@@ -358,7 +358,7 @@ namespace MatrixCreator
     const AffineConstraints<number> &constraints = AffineConstraints<number>());
 
   /**
-   * Same function as above, but for hp objects.
+   * Same function as above, but for hp-objects.
    */
   template <int dim, int spacedim, typename number>
   void
@@ -430,7 +430,7 @@ namespace MatrixCreator
     std::vector<unsigned int>               component_mapping = {});
 
   /**
-   * Same function as above, but for hp objects.
+   * Same function as above, but for hp-objects.
    */
   template <int dim, int spacedim, typename number>
   void
@@ -447,7 +447,7 @@ namespace MatrixCreator
     std::vector<unsigned int>               component_mapping = {});
 
   /**
-   * Same function as above, but for hp objects.
+   * Same function as above, but for hp-objects.
    */
   template <int dim, int spacedim, typename number>
   void
@@ -550,8 +550,7 @@ namespace MatrixCreator
     const AffineConstraints<double> &constraints = AffineConstraints<double>());
 
   /**
-   * Like the functions above, but for hp dof handlers, mappings, and
-   * quadrature collections.
+   * Like the functions above, but for hp-objects.
    */
   template <int dim, int spacedim>
   void
@@ -564,8 +563,7 @@ namespace MatrixCreator
     const AffineConstraints<double> &constraints = AffineConstraints<double>());
 
   /**
-   * Like the functions above, but for hp dof handlers, mappings, and
-   * quadrature collections.
+   * Like the functions above, but for hp-objects.
    */
   template <int dim, int spacedim>
   void
@@ -577,8 +575,7 @@ namespace MatrixCreator
     const AffineConstraints<double> &constraints = AffineConstraints<double>());
 
   /**
-   * Like the functions above, but for hp dof handlers, mappings, and
-   * quadrature collections.
+   * Like the functions above, but for hp-objects.
    */
   template <int dim, int spacedim>
   void
@@ -593,8 +590,7 @@ namespace MatrixCreator
     const AffineConstraints<double> &constraints = AffineConstraints<double>());
 
   /**
-   * Like the functions above, but for hp dof handlers, mappings, and
-   * quadrature collections.
+   * Like the functions above, but for hp-objects.
    */
   template <int dim, int spacedim>
   void
index ddaa04566e16f6c88637b5d904e7ba891b29deb8..2da1e585e9921f218ad7a7b2f3df0cdcfb9b694f 100644 (file)
@@ -291,7 +291,7 @@ DEAL_II_NAMESPACE_OPEN
  * necessary to call AffineConstraints::distribute().
  *
  *
- * <h3>Implementation in the context of hp finite elements</h3>
+ * <h3>Implementation in the context of hp-finite elements</h3>
  *
  * In the case of DoFHandlers with hp-capabilities, nothing defines which of the
  * finite elements that are part of the hp::FECollection associated with the
@@ -323,7 +323,7 @@ DEAL_II_NAMESPACE_OPEN
  *   active_fe_index for a different space post-refinement and before calling
  *   DoFHandler::distribute_dofs()).
  *
- * @note In the context of hp refinement, if cells are coarsened or the
+ * @note In the context of hp-refinement, if cells are coarsened or the
  * polynomial degree is lowered on some cells, then the old finite element
  * space is not a subspace of the new space and you may run into the same
  * situation as discussed above with hanging nodes. You may want to consider
index 6593be957bd2c94509873e62dd2e436e9b86c361..69e7818119178a50e85b70d41cc9c77ca1c57823 100644 (file)
@@ -625,7 +625,7 @@ namespace VectorTools
    * a problem when using the previous function in conjunction with non-
    * rectangular geometries (i.e. elements with non-rectangular faces). The
    * L2-projection method used has been taken from the paper "Electromagnetic
-   * scattering simulation using an H (curl) conforming hp finite element
+   * scattering simulation using an H (curl) conforming hp-finite element
    * method in three dimensions" by PD Ledger, K Morgan and O Hassan ( Int. J.
    * Num. Meth. Fluids, Volume 53, Issue 8, pages 1267-1296).
    *
index 30168150f37e41efbf3aaf0f06ea9403b2cb4e53..350ab9c5dc1f621de6188fe959b5b6fa3afef3de 100644 (file)
@@ -2928,13 +2928,13 @@ namespace VectorTools
       // compute_face_projection_curl_conforming_l2
       //
       // For details see (for example) section 4.2:
-      // Electromagnetic scattering simulation using an H (curl) conforming hp
+      // Electromagnetic scattering simulation using an H (curl) conforming hp-
       // finite element method in three dimensions, PD Ledger, K Morgan, O
       // Hassan, Int. J.  Num. Meth. Fluids, Volume 53, Issue 8, pages
       // 1267-1296, 20 March 2007:
       // http://onlinelibrary.wiley.com/doi/10.1002/fld.1223/abstract
 
-      // Create hp FEcollection, dof_handler can be either hp or standard type.
+      // Create hp-FEcollection, dof_handler can be either hp- or standard type.
       // From here on we can treat it like a hp-namespace object.
       const hp::FECollection<dim> &fe_collection(
         dof_handler.get_fe_collection());
@@ -3216,7 +3216,7 @@ namespace VectorTools
     AffineConstraints<number> &  constraints,
     const Mapping<dim> &         mapping)
   {
-    // non-hp version - calls the internal
+    // non-hp-version - calls the internal
     // compute_project_boundary_values_curl_conforming_l2() function
     // above after recasting the mapping.
 
@@ -3240,7 +3240,7 @@ namespace VectorTools
     AffineConstraints<number> &            constraints,
     const hp::MappingCollection<dim, dim> &mapping_collection)
   {
-    // hp version - calls the internal
+    // hp-version - calls the internal
     // compute_project_boundary_values_curl_conforming_l2() function above.
     internals::compute_project_boundary_values_curl_conforming_l2(
       dof_handler,
index ee36053253f0ebcc61089b5ca29775805ca7b54b..b13b173a5024a9e07a3794afb72981cc4d4290c9 100644 (file)
@@ -73,7 +73,7 @@ namespace VectorTools
     const ComponentMask &component_mask = ComponentMask());
 
   /**
-   * Same as above but in an hp context.
+   * Same as above but in an hp-context.
    */
   template <int dim, int spacedim, typename VectorType>
   void
index 34878b0ba3c1ff4632e50aec625aefd3434f8b59..d5894d315ddb1c15ea375b94df0c26adb9f20222 100644 (file)
@@ -82,7 +82,7 @@ namespace VectorTools
       AffineConstraints<typename VectorType::value_type>());
 
   /**
-   * Like the previous set of functions, but for hp objects.
+   * Like the previous set of functions, but for hp-objects.
    */
   template <int dim, int spacedim, typename VectorType>
   void
@@ -96,7 +96,7 @@ namespace VectorTools
       AffineConstraints<typename VectorType::value_type>());
 
   /**
-   * Like the previous set of functions, but for hp objects.
+   * Like the previous set of functions, but for hp-objects.
    */
   template <int dim, int spacedim, typename VectorType>
   void
@@ -146,7 +146,7 @@ namespace VectorTools
       std::set<types::boundary_id>());
 
   /**
-   * Same as the set of functions above, but for hp objects.
+   * Same as the set of functions above, but for hp-objects.
    *
    * @see
    * @ref GlossBoundaryIndicator "Glossary entry on boundary indicators"
index 3baf6506d432950eac8b0409a71ef2270fcd7f73..b920452d47134c79440e3e2d2a07691230302d84 100644 (file)
@@ -97,7 +97,7 @@ DoFCellAccessor<dim, spacedim, lda>::get_interpolated_dof_values(
     // children recursively.
     {
       // we are on a non-active cell. these do not have any finite
-      // element associated with them in the hp context (in the non-hp
+      // element associated with them in the hp-context (in the non-hp-
       // context, we can simply assume that the FE space to which we
       // want to interpolate is the same as for all elements in the
       // mesh). consequently, we cannot interpolate from children's FE
index 427918db8438118a80df0ca25b8a677c714b8d28..47ee62b991b12764ba0028daba34c62013b3c848 100644 (file)
@@ -2445,7 +2445,7 @@ DoFHandler<dim, spacedim>::set_fe(const hp::FECollection<dim, spacedim> &ff)
       AssertThrow(
         hp_capability_enabled || !contains_multiple_fes,
         ExcMessage(
-          "You cannot re-enable hp capabilities after you registered a single "
+          "You cannot re-enable hp-capabilities after you registered a single "
           "finite element. Please create a new DoFHandler object instead."));
     }
 
@@ -2524,7 +2524,7 @@ DoFHandler<dim, spacedim>::distribute_dofs(
       AssertThrow(
         hp_capability_enabled || !contains_multiple_fes,
         ExcMessage(
-          "You cannot re-enable hp capabilities after you registered a single "
+          "You cannot re-enable hp-capabilities after you registered a single "
           "finite element. Please call reinit() or create a new DoFHandler "
           "object instead."));
     }
index c1c2ba7aaaf803645e2a255311a41920ddee2c9d..62f5531d9ff805af3d20e8f8bade7e9da7426dba 100644 (file)
@@ -402,7 +402,7 @@ namespace internal
             dof_handler.get_triangulation())
             .clear_user_flags_line();
 
-          // An implementation of the algorithm described in the hp paper,
+          // An implementation of the algorithm described in the hp-paper,
           // including the modification mentioned later in the "complications in
           // 3-d" subsections
           //
@@ -446,7 +446,7 @@ namespace internal
                                            fe_index_2 =
                                              line->nth_active_fe_index(g);
 
-                        // as described in the hp paper, we only unify on lines
+                        // as described in the hp-paper, we only unify on lines
                         // when there are at most two different FE objects
                         // assigned on it.
                         // however, more than two 'active_fe_indices' can be
@@ -777,7 +777,7 @@ namespace internal
             dof_handler.get_triangulation())
             .clear_user_flags_quad();
 
-          // An implementation of the algorithm described in the hp
+          // An implementation of the algorithm described in the hp-
           // paper, including the modification mentioned later in the
           // "complications in 3-d" subsections
           //
@@ -1020,7 +1020,7 @@ namespace internal
         /**
          * Once degrees of freedom have been distributed on all cells, see if
          * we can identify DoFs on neighboring cells. This function does
-         * nothing unless the DoFHandler has hp capabilities.
+         * nothing unless the DoFHandler has hp-capabilities.
          *
          * Return the final number of degrees of freedom, which is the old one
          * minus however many were identified.
@@ -1252,7 +1252,7 @@ namespace internal
               for (const auto l : cell->line_indices())
                 cell->line(l)->set_user_flag();
 
-          // An implementation of the algorithm described in the hp paper,
+          // An implementation of the algorithm described in the hp-paper,
           // including the modification mentioned later in the "complications in
           // 3-d" subsections
           //
@@ -1533,7 +1533,7 @@ namespace internal
               for (const auto q : cell->face_indices())
                 cell->quad(q)->set_user_flag();
 
-          // An implementation of the algorithm described in the hp
+          // An implementation of the algorithm described in the hp-
           // paper, including the modification mentioned later in the
           // "complications in 3-d" subsections
           //
@@ -1649,7 +1649,7 @@ namespace internal
          * know the indices of all dominating DoFs, and we have to assign those
          * invalid entries to their corresponding global value.
          *
-         * This function does nothing unless the DoFHandler has hp
+         * This function does nothing unless the DoFHandler has hp-
          * capabilities.
          */
         template <int dim, int spacedim>
@@ -1958,7 +1958,7 @@ namespace internal
                           // non-locally owned DoF for which we don't know the
                           // new number yet and so set it to an invalid index.
                           // This will later be fixed up after the first ghost
-                          // exchange phase when we unify hp DoFs on neighboring
+                          // exchange phase when we unify hp-DoFs on neighboring
                           // cells.
                           if (indices_we_care_about.size() == 0)
                             dealii::internal::DoFAccessorImplementation::
@@ -2052,7 +2052,7 @@ namespace internal
                         // DoF for which we don't know the new number yet and so
                         // set it to an invalid index. This will later be fixed
                         // up after the first ghost exchange phase when we unify
-                        // hp DoFs on neighboring cells.
+                        // hp-DoFs on neighboring cells.
                         if (indices_we_care_about.size() == 0)
                           cell->set_dof_index(d,
                                               new_numbers[old_dof_index],
@@ -2163,7 +2163,7 @@ namespace internal
                                   // for which we don't know the new number yet
                                   // and so set it to an invalid index. This
                                   // will later be fixed up after the first
-                                  // ghost exchange phase when we unify hp DoFs
+                                  // ghost exchange phase when we unify hp-DoFs
                                   // on neighboring cells.
                                   if (indices_we_care_about.size() == 0)
                                     line->set_dof_index(
@@ -2272,7 +2272,7 @@ namespace internal
                                   // for which we don't know the new number yet
                                   // and so set it to an invalid index. This
                                   // will later be fixed up after the first
-                                  // ghost exchange phase when we unify hp DoFs
+                                  // ghost exchange phase when we unify hp-DoFs
                                   // on neighboring cells.
                                   if (indices_we_care_about.size() == 0)
                                     line->set_dof_index(
@@ -2350,7 +2350,7 @@ namespace internal
                                   // for which we don't know the new number yet
                                   // and so set it to an invalid index. This
                                   // will later be fixed up after the first
-                                  // ghost exchange phase when we unify hp DoFs
+                                  // ghost exchange phase when we unify hp-DoFs
                                   // on neighboring cells.
                                   if (indices_we_care_about.size() == 0)
                                     quad->set_dof_index(
@@ -2845,7 +2845,7 @@ namespace internal
         // return a sequential, complete index set. take into account that the
         // number of DoF indices may in fact be smaller than there were before
         // if some previously separately numbered dofs have been identified.
-        // this is, for example, what we do when the DoFHandler has hp
+        // this is, for example, what we do when the DoFHandler has hp-
         // capabilities enabled: it first enumerates all DoFs on cells
         // independently, and then unifies some located at vertices or faces;
         // this leaves us with fewer DoFs than there were before, so use the
@@ -3819,7 +3819,7 @@ namespace internal
         // --------- Phase 2: eliminate dof duplicates on all cells:
         //                    - un-numerate dofs on interfaces to ghost cells
         //                      that we don't own
-        //                    - in case of hp support, unify dofs
+        //                    - in case of hp-support, unify dofs
         std::vector<dealii::types::global_dof_index> renumbering(
           n_initial_local_dofs, enumeration_dof_index);
 
@@ -3830,7 +3830,7 @@ namespace internal
           invalidate_dof_indices_on_weaker_ghost_cells_for_renumbering(
             renumbering, subdomain_id, *dof_handler);
 
-        // then, we identify DoF duplicates if the DoFHandler has hp
+        // then, we identify DoF duplicates if the DoFHandler has hp-
         // capabilities
         std::vector<std::map<types::global_dof_index, types::global_dof_index>>
           all_constrained_indices(dim);
@@ -3917,7 +3917,7 @@ namespace internal
           // done twice
           communicate_dof_indices_on_marked_cells(*dof_handler);
 
-          // If the DoFHandler has hp capabilities enabled, then we may have
+          // If the DoFHandler has hp-capabilities enabled, then we may have
           // received valid indices of degrees of freedom that are dominated
           // by a fe object adjacent to a ghost interface.  thus, we overwrite
           // the remaining invalid indices with the valid ones in this step.
@@ -4410,7 +4410,7 @@ namespace internal
             //
             // This is the same as phase 5+6 in the distribute_dofs() algorithm,
             // taking into account that we have to unify a few DoFs in between
-            // then communication phases if we do hp numbering
+            // then communication phases if we do hp-numbering
             {
               std::vector<bool> user_flags;
               triangulation->save_user_flags(user_flags);
@@ -4430,7 +4430,7 @@ namespace internal
               // done twice
               communicate_dof_indices_on_marked_cells(*dof_handler);
 
-              // if the DoFHandler has hp capabilities then we may have
+              // if the DoFHandler has hp-capabilities then we may have
               // received valid indices of degrees of freedom that are
               // dominated by a fe object adjacent to a ghost interface.
               // thus, we overwrite the remaining invalid indices with the
index 5d55b546e687b483be0bc410ab7cd940b8595a67..e7e593cca3075306978924c9d8d39f91bfeccf56 100644 (file)
@@ -50,7 +50,7 @@ namespace internal
       Assert(
         (fe_index == dealii::DoFHandler<dh_dim, spacedim>::default_fe_index),
         ExcMessage(
-          "Only the default FE index is allowed for non-hp DoFHandler objects"));
+          "Only the default FE index is allowed for non-hp-DoFHandler objects"));
       Assert(
         local_index < dof_handler.get_fe().template n_dofs_per_object<dim>(),
         ExcIndexRange(local_index,
index 624e4a33b9aa7a6e70d9f1711a97d18879434710..79a1678658b5d7528f664db643968ebb5a10ed49 100644 (file)
@@ -21,7 +21,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS)
     \{
       namespace boost
       \{
-        // TODO[WB]: also implement the following boost for hp DoFHandlers etc.
+        // TODO[WB]: also implement the following boost for hp-DoFHandlers etc.
       \}
 
 
@@ -78,7 +78,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS)
     \{
       namespace boost
       \{
-        // TODO[WB]: also implement the following boost for hp DoFHandlers etc.
+        // TODO[WB]: also implement the following boost for hp-DoFHandlers etc.
         template void
         Cuthill_McKee(DoFHandler<deal_II_dimension> &, bool, bool);
 
index 4f50b8db7c0844086bc6c7f96e53fbc7fc33744f..d1998c278f25da21d4cd7653fd598f9ab90339b4 100644 (file)
@@ -149,7 +149,7 @@ namespace DoFTools
       /**
        * When restricting, on a face, the degrees of freedom of fe1 to the space
        * described by fe2 (for example for the complex case described
-       * in the @ref hp_paper "hp paper"), we have to select fe2.dofs_per_face
+       * in the @ref hp_paper "hp-paper"), we have to select fe2.dofs_per_face
        * out of the fe1.dofs_per_face face DoFs as the
        * primary dofs, and the rest become dependent dofs. This function selects
        * which ones will be primary, and which ones will be dependents.
@@ -395,7 +395,7 @@ namespace DoFTools
       /**
        * Given the face interpolation matrix between two elements, split it into
        * its primary and dependent parts and invert the primary part as
-       * explained in the @ref hp_paper "hp paper".
+       * explained in the @ref hp_paper "hp-paper".
        */
       void
       ensure_existence_of_split_face_matrix(
@@ -457,7 +457,7 @@ namespace DoFTools
 
       /**
        * A function that returns how many different finite elements a dof
-       * handler uses. This is one for non-hp DoFHandlers and
+       * handler uses. This is one for non-hp-DoFHandlers and
        * dof_handler.get_fe().size() for the hp-versions.
        */
       template <int dim, int spacedim>
@@ -476,7 +476,7 @@ namespace DoFTools
        * Copy constraints into an AffineConstraints object.
        *
        * This function removes zero constraints and those, which constrain a DoF
-       * which was already eliminated in one of the previous steps of the hp
+       * which was already eliminated in one of the previous steps of the hp-
        * hanging node procedure.
        *
        * It also suppresses very small entries in the AffineConstraints object
@@ -1016,7 +1016,7 @@ namespace DoFTools
       AffineConstraints<number> &      constraints)
     {
       // note: this function is going to be hard to understand if you haven't
-      // read the hp paper. however, we try to follow the notation laid out
+      // read the hp-paper. however, we try to follow the notation laid out
       // there, so go read the paper before you try to understand what is going
       // on here
 
@@ -1046,7 +1046,7 @@ namespace DoFTools
       // primary and dependent parts, and for which the primary part is
       // inverted. these two matrices are derived from the face interpolation
       // matrix
-      // as described in the @ref hp_paper "hp paper"
+      // as described in the @ref hp_paper "hp-paper"
       Table<2,
             std::unique_ptr<std::pair<FullMatrix<double>, FullMatrix<double>>>>
         split_face_interpolation_matrices(n_finite_elements(dof_handler),
@@ -1104,7 +1104,7 @@ namespace DoFTools
                            ExcInternalError());
 
                 // first find out whether we can constrain each of the subfaces
-                // to the mother face. in the lingo of the hp paper, this would
+                // to the mother face. in the lingo of the hp-paper, this would
                 // be the simple case. note that we can short-circuit this
                 // decision if the dof_handler doesn't support hp at all
                 //
@@ -1142,7 +1142,7 @@ namespace DoFTools
                     case FiniteElementDomination::either_element_can_dominate:
                       {
                         // Case 1 (the simple case and the only case that can
-                        // happen for non-hp DoFHandlers): The coarse element
+                        // happen for non-hp-DoFHandlers): The coarse element
                         // dominates the elements on the subfaces (or they are
                         // all the same)
                         //
@@ -1255,10 +1255,10 @@ namespace DoFTools
                       {
                         // Case 2 (the "complex" case): at least one (the
                         // neither_... case) of the finer elements or all of
-                        // them (the other_... case) is dominating. See the hp
+                        // them (the other_... case) is dominating. See the hp-
                         // paper for a way how to deal with this situation
                         //
-                        // since this is something that can only happen for hp
+                        // since this is something that can only happen for hp-
                         // dof handlers, add a check here...
                         Assert(dof_handler.has_hp_capabilities() == true,
                                ExcInternalError());
@@ -1389,7 +1389,7 @@ namespace DoFTools
 
 
                         // next we have to deal with the subfaces. do as
-                        // discussed in the hp paper
+                        // discussed in the hp-paper
                         for (unsigned int sf = 0;
                              sf < cell->face(face)->n_children();
                              ++sf)
@@ -1581,7 +1581,7 @@ namespace DoFTools
                             // our best bet is to find the common space among
                             // other FEs in FECollection and then constrain both
                             // FEs to that one. More precisely, we follow the
-                            // strategy outlined on page 17 of the hp paper:
+                            // strategy outlined on page 17 of the hp-paper:
                             // First we find the dominant FE space S. Then we
                             // divide our dofs in primary and dependent such
                             // that I^{face,primary}_{S^{face}->S} is
@@ -3156,7 +3156,7 @@ namespace DoFTools
     Assert(coarse_grid.get_fe_collection().size() == 1 &&
              fine_grid.get_fe_collection().size() == 1,
            ExcMessage("This function is not yet implemented for DoFHandlers "
-                      "using hp capabilities."));
+                      "using hp-capabilities."));
     // store the weights with which a dof on the parameter grid contributes to a
     // dof on the fine grid. see the long doc below for more info
     //
@@ -3340,7 +3340,7 @@ namespace DoFTools
     Assert(coarse_grid.get_fe_collection().size() == 1 &&
              fine_grid.get_fe_collection().size() == 1,
            ExcMessage("This function is not yet implemented for DoFHandlers "
-                      "using hp capabilities."));
+                      "using hp-capabilities."));
     // store the weights with which a dof on the parameter grid contributes to a
     // dof on the fine grid. see the long doc below for more info
     //
index 82b91388c54870d2528b59511ed373b7d80218bc..241e1e6746b3c46916c9de240bfb6871c7f70149 100644 (file)
@@ -765,7 +765,7 @@ namespace DoFTools
     namespace
     {
       // implementation of the same function in namespace DoFTools for
-      // non-hp DoFHandlers
+      // non-hp-DoFHandlers
       template <int dim,
                 int spacedim,
                 typename SparsityPatternType,
@@ -1103,7 +1103,7 @@ namespace DoFTools
           {
             // while the implementation above is quite optimized and caches a
             // lot of data (see e.g. the int/flux_dof_mask tables), this is no
-            // longer practical for the hp version since we would have to have
+            // longer practical for the hp-version since we would have to have
             // it for all combinations of elements in the hp::FECollection.
             // consequently, the implementation here is simpler and probably
             // less efficient but at least readable...
@@ -1189,7 +1189,7 @@ namespace DoFTools
                           if (!face_has_flux_coupling(cell, face))
                             continue;
 
-                          // Like the non-hp case: If the cells are on the same
+                          // Like the non-hp-case: If the cells are on the same
                           // level (and both are active, locally-owned cells)
                           // then only add to the sparsity pattern if the
                           // current cell is 'greater' in the total ordering.
@@ -1198,7 +1198,7 @@ namespace DoFTools
                               neighbor->is_active() &&
                               neighbor->is_locally_owned())
                             continue;
-                          // Again, like the non-hp case: If we are more refined
+                          // Again, like the non-hp-case: If we are more refined
                           // then the neighbor, then we will automatically find
                           // the active neighbor cell when we call 'neighbor
                           // (face)' above. The opposite is not true; if the
index 07e2aa9db99565f20202604d16da1a95444939b3..ee1c0f1a69d903cfba08a57cb5ea65ab1818856c 100644 (file)
@@ -131,7 +131,7 @@ FE_Bernstein<dim, spacedim>::get_subface_interpolation_matrix(
       // Make sure that the element for which the DoFs should be constrained
       // is the one with the higher polynomial degree.  Actually the procedure
       // will work also if this assertion is not satisfied. But the matrices
-      // produced in that case might lead to problems in the hp procedures,
+      // produced in that case might lead to problems in the hp-procedures,
       // which use this method.
       Assert(
         this->n_dofs_per_face(face_no) <= source_fe->n_dofs_per_face(face_no),
index d673916566d91fbf5d78708a623b871f88f9317b..0e78e47ddc80c8c8b4bcb99a5d0a6438ed41e99f 100644 (file)
@@ -181,7 +181,7 @@ FE_FaceQ<dim, spacedim>::get_subface_interpolation_matrix(
       // Make sure that the element for which the DoFs should be constrained
       // is the one with the higher polynomial degree.  Actually the procedure
       // will work also if this assertion is not satisfied. But the matrices
-      // produced in that case might lead to problems in the hp procedures,
+      // produced in that case might lead to problems in the hp-procedures,
       // which use this method.
       Assert(
         this->n_dofs_per_face(face_no) <= source_fe->n_dofs_per_face(face_no),
@@ -910,7 +910,7 @@ FE_FaceP<dim, spacedim>::get_subface_interpolation_matrix(
       // Make sure that the element for which the DoFs should be constrained
       // is the one with the higher polynomial degree.  Actually the procedure
       // will work also if this assertion is not satisfied. But the matrices
-      // produced in that case might lead to problems in the hp procedures,
+      // produced in that case might lead to problems in the hp-procedures,
       // which use this method.
       Assert(
         this->n_dofs_per_face(face_no) <= source_fe->n_dofs_per_face(face_no),
index caa4f1f39d94962f471eeda07a59c4ac800f40ab..56974a0d9bc51b8fe4c6b3ce1415eb1d013efca0 100644 (file)
@@ -2500,7 +2500,7 @@ FE_Nedelec<dim>::get_face_interpolation_matrix(
   // satisfied. But the matrices
   // produced in that case might
   // lead to problems in the
-  // hp procedures, which use this
+  // hp-procedures, which use this
   // method.
   Assert(this->n_dofs_per_face(face_no) <= source_fe.n_dofs_per_face(face_no),
          (typename FiniteElement<dim>::ExcInterpolationNotImplemented()));
@@ -2607,7 +2607,7 @@ FE_Nedelec<dim>::get_subface_interpolation_matrix(
   // satisfied. But the matrices
   // produced in that case might
   // lead to problems in the
-  // hp procedures, which use this
+  // hp-procedures, which use this
   // method.
   Assert(this->n_dofs_per_face(face_no) <= source_fe.n_dofs_per_face(face_no),
          (typename FiniteElement<dim>::ExcInterpolationNotImplemented()));
index 3d6cf65dd47e934db13ee4f154f96f593c83995d..9f444f7aa0fb994de62cc775d55b0dadafe8ccd4 100644 (file)
@@ -644,7 +644,7 @@ FE_Q_Base<PolynomialType, dim, spacedim>::get_subface_interpolation_matrix(
       // Make sure that the element for which the DoFs should be constrained
       // is the one with the higher polynomial degree.  Actually the procedure
       // will work also if this assertion is not satisfied. But the matrices
-      // produced in that case might lead to problems in the hp procedures,
+      // produced in that case might lead to problems in the hp-procedures,
       // which use this method.
       Assert(
         this->n_dofs_per_face(face_no) <= source_fe->n_dofs_per_face(face_no),
index 670ec26d5edb15f0da5697857235b58f6428ab38..71296683df974c59d730693d31a5521ea91a4fc8 100644 (file)
@@ -965,7 +965,7 @@ FE_Q_Hierarchical<dim>::get_face_interpolation_matrix(
   // satisfied. But the matrices
   // produced in that case might
   // lead to problems in the
-  // hp procedures, which use this
+  // hp-procedures, which use this
   // method.
   Assert(this->n_dofs_per_face(face_no) <= source_fe.n_dofs_per_face(face_no),
          (typename FiniteElement<dim>::ExcInterpolationNotImplemented()));
@@ -1053,7 +1053,7 @@ FE_Q_Hierarchical<dim>::get_subface_interpolation_matrix(
   // satisfied. But the matrices
   // produced in that case might
   // lead to problems in the
-  // hp procedures, which use this
+  // hp-procedures, which use this
   // method.
   Assert(this->n_dofs_per_face(face_no) <= source_fe.n_dofs_per_face(face_no),
          (typename FiniteElement<dim>::ExcInterpolationNotImplemented()));
index 4ca716558be13548e56fc82a151d5f5423c0abba..e43c7c0bd0e888b9c8ebd7be897eefe40c2961a7 100644 (file)
@@ -378,7 +378,7 @@ FE_RaviartThomasNodal<dim>::
 // TODO: There are tests that check that the following few functions don't
 // produce assertion failures, but none that actually check whether they do the
 // right thing. one example for such a test would be to project a function onto
-// an hp space and make sure that the convergence order is correct with regard
+// an hp-space and make sure that the convergence order is correct with regard
 // to the lowest used polynomial degree
 
 template <int dim>
@@ -625,7 +625,7 @@ FE_RaviartThomasNodal<dim>::get_face_interpolation_matrix(
   // satisfied. But the matrices
   // produced in that case might
   // lead to problems in the
-  // hp procedures, which use this
+  // hp-procedures, which use this
   // method.
   Assert(this->n_dofs_per_face(face_no) <= source_fe.n_dofs_per_face(face_no),
          typename FiniteElement<dim>::ExcInterpolationNotImplemented());
@@ -733,7 +733,7 @@ FE_RaviartThomasNodal<dim>::get_subface_interpolation_matrix(
   // satisfied. But the matrices
   // produced in that case might
   // lead to problems in the
-  // hp procedures, which use this
+  // hp-procedures, which use this
   // method.
   Assert(this->n_dofs_per_face(face_no) <= source_fe.n_dofs_per_face(face_no),
          typename FiniteElement<dim>::ExcInterpolationNotImplemented());
index dbe8ae548538316b12c6dda856453f45d082ab15..3a2c80e6e0fcbe2af51befd5ef62ecefa3067799 100644 (file)
@@ -37,7 +37,7 @@ namespace hp
   namespace Refinement
   {
     /**
-     * Setting p adaptivity flags
+     * Setting p-adaptivity flags
      */
     template <int dim, int spacedim>
     void
@@ -631,7 +631,7 @@ namespace hp
 
 
     /**
-     * Decide between h and p adaptivity
+     * Decide between h- and p-adaptivity
      */
     template <int dim, int spacedim>
     void
@@ -695,9 +695,9 @@ namespace hp
             cell->clear_refine_flag();
 
             // A cell will only be coarsened into its parent if all of its
-            // siblings are flagged for h coarsening as well. We must take this
-            // into account for our decision whether we would like to impose h
-            // or p adaptivity.
+            // siblings are flagged for h-coarsening as well. We must take this
+            // into account for our decision whether we would like to impose h-
+            // or p-adaptivity.
             if (cell->coarsen_flag_set())
               {
                 const auto &       parent     = cell->parent();
@@ -737,8 +737,8 @@ namespace hp
                 if (h_flagged_children == n_children &&
                     p_flagged_children != n_children)
                   {
-                    // Perform pure h coarsening and
-                    // drop all p adaptation flags.
+                    // Perform pure h-coarsening and
+                    // drop all p-adaptation flags.
                     for (const auto &child : parent->child_iterators())
                       {
                         // h_flagged_children == n_children implies
@@ -750,8 +750,8 @@ namespace hp
                   }
                 else
                   {
-                    // Perform p adaptation on all children and
-                    // drop all h coarsening flags.
+                    // Perform p-adaptation on all children and
+                    // drop all h-coarsening flags.
                     for (const auto &child : parent->child_iterators())
                       {
                         if (child->is_active() && child->is_locally_owned())
index dcf1c1949739cce8440e02b9bbf11c95c56d1386..9ab41f175b775b3c958d10a15aea0cda8586a6a3 100644 (file)
@@ -798,7 +798,7 @@ namespace internal
       // a. Only cells belonging to the same category (or next higher if the
       // cell_vectorization_categories_strict is false) can be grouped into
       // the same SIMD batch
-      // b. hp adaptive computations must form contiguous ranges for the same
+      // b. hp-adaptive computations must form contiguous ranges for the same
       // degree (category) in cell_partition_data
       // c. We want to group the cells with the same parent in the same SIMD
       // lane if possible
@@ -954,7 +954,7 @@ namespace internal
 
       // Step 5: Sort the batches of cells by their last cell index to get
       // good locality, assuming that the initial cell order is of good
-      // locality. In case we have hp calculations with categories, we need to
+      // locality. In case we have hp-calculations with categories, we need to
       // sort also by the category.
       std::vector<std::array<unsigned int, 3>> batch_order;
       std::vector<std::array<unsigned int, 3>> batch_order_comm;
index c2daf74cac8bdcd8c54a1175e510c75e726fff59..b809d99a2c4d3fc4c90bc74b8cfb82583b87d158 100644 (file)
@@ -287,7 +287,7 @@ DataOutStack<dim, spacedim, void>::build_patches(
   // create collection objects from
   // single quadratures,
   // and finite elements. if we have
-  // an hp DoFHandler,
+  // an hp-DoFHandler,
   // dof_handler.get_fe() returns a
   // collection of which we do a
   // shallow copy instead
index 38ad27d01b98ddee235c4f334398acf50fcc16a3..32822082ef9e7d52379a7ff97c3fcae637a1f7b1 100644 (file)
@@ -752,7 +752,7 @@ namespace DerivativeApproximation
       // create collection objects from
       // single quadratures, mappings,
       // and finite elements. if we have
-      // an hp DoFHandler,
+      // an hp-DoFHandler,
       // dof_handler.get_fe() returns a
       // collection of which we do a
       // shallow copy instead
index 38d737ea6d11a6bdf24de238a2be76c0d821539f..3d8d8a978effa81d84503da20d3d793ff73f5d7e 100644 (file)
@@ -21,7 +21,7 @@ for (scalar : REAL_SCALARS; deal_II_dimension : DIMENSIONS;
      deal_II_space_dimension : SPACE_DIMENSIONS)
   {
 #if deal_II_dimension <= deal_II_space_dimension
-    // non-hp version of create_mass_matrix
+    // non-hp-version of create_mass_matrix
     template void MatrixCreator::
       create_mass_matrix<deal_II_dimension, deal_II_space_dimension, scalar>(
         const Mapping<deal_II_dimension, deal_II_space_dimension> &   mapping,
@@ -38,7 +38,7 @@ for (scalar : REAL_SCALARS; deal_II_dimension : DIMENSIONS;
         const Function<deal_II_space_dimension, scalar> *const coefficient,
         const AffineConstraints<scalar> &                      constraints);
 
-    // hp versions of functions
+    // hp-versions of functions
     template void MatrixCreator::
       create_mass_matrix<deal_II_dimension, deal_II_space_dimension, scalar>(
         const hp::MappingCollection<deal_II_dimension, deal_II_space_dimension>
@@ -66,7 +66,7 @@ for (scalar : REAL_AND_COMPLEX_SCALARS; deal_II_dimension : DIMENSIONS;
      deal_II_space_dimension : SPACE_DIMENSIONS)
   {
 #if deal_II_dimension <= deal_II_space_dimension
-    // non-hp version of create_mass_matrix
+    // non-hp-version of create_mass_matrix
     template void MatrixCreator::
       create_mass_matrix<deal_II_dimension, deal_II_space_dimension, scalar>(
         const Mapping<deal_II_dimension, deal_II_space_dimension> &   mapping,
@@ -87,7 +87,7 @@ for (scalar : REAL_AND_COMPLEX_SCALARS; deal_II_dimension : DIMENSIONS;
         const Function<deal_II_space_dimension, scalar> *const coefficient,
         const AffineConstraints<scalar> &                      constraints);
 
-    // hp version
+    // hp-version
     template void MatrixCreator::
       create_mass_matrix<deal_II_dimension, deal_II_space_dimension, scalar>(
         const hp::MappingCollection<deal_II_dimension, deal_II_space_dimension>
@@ -183,7 +183,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS)
   {
 #if deal_II_dimension == deal_II_space_dimension
 
-    // non-hp versions of create_laplace_matrix
+    // non-hp-versions of create_laplace_matrix
     template void MatrixCreator::create_laplace_matrix<deal_II_dimension>(
       const DoFHandler<deal_II_dimension> &    dof,
       const Quadrature<deal_II_dimension> &    q,
@@ -215,7 +215,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS)
       const Function<deal_II_dimension> *const coefficient,
       const AffineConstraints<double> &        constraints);
 
-    // hp versions of create_laplace_matrix
+    // hp-versions of create_laplace_matrix
     template void MatrixCreator::create_laplace_matrix<deal_II_dimension>(
       const DoFHandler<deal_II_dimension> &     dof,
       const hp::QCollection<deal_II_dimension> &q,
@@ -253,7 +253,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS)
 for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS)
   {
 #if deal_II_dimension < deal_II_space_dimension
-    // non-hp version of create_laplace_matrix
+    // non-hp-version of create_laplace_matrix
     template void MatrixCreator::create_laplace_matrix<deal_II_dimension,
                                                        deal_II_space_dimension>(
       const Mapping<deal_II_dimension, deal_II_space_dimension> &   mapping,
index 150af1711ab6a6c0204701305d92a7726ca835b6..1d6b1d147f1630e351769bd9aded8d810bb202fd 100644 (file)
@@ -351,9 +351,9 @@ SolutionTransfer<dim, VectorType, DoFHandlerType>::
       else if (cell->has_children() && cell->child(0)->coarsen_flag_set())
         {
           // we will need to interpolate from the children of this cell
-          // to the current one. in the hp context, this also means
+          // to the current one. in the hp-context, this also means
           // we need to figure out which finite element space to interpolate
-          // to since that is not implied by the global FE as in the non-hp
+          // to since that is not implied by the global FE as in the non-hp-
           // case. we choose the 'least dominant fe' on all children from
           // the associated FECollection.
           std::set<unsigned int> fe_indices_children;
@@ -505,7 +505,7 @@ SolutionTransfer<dim, VectorType, DoFHandlerType>::interpolate(
                 {
                   // make sure that the size of the stored indices is the same
                   // as dofs_per_cell. this is kind of a test if we use the same
-                  // fe in the hp case. to really do that test we would have to
+                  // fe in the hp-case. to really do that test we would have to
                   // store the fe_index of all cells
                   const Vector<typename VectorType::value_type> *data = nullptr;
                   const unsigned int active_fe_index = cell->active_fe_index();
index f6c20b21069712322c7c0a7fa707d673bc7b3925..d75217d6b0b9baf6285a158faef6e2f28691d0f8 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// check that computation of hp constraints works for DGP elements correctly
+// check that computation of hp-constraints works for DGP elements correctly
 
 char logname[] = "output";
 
index dc53e291b56156a9de45d80e9d20a198ee2b6ba6..84d884aaf63968fd24556d14ced047676d43a1a3 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// check that computation of hp constraints works for DGP_Monomial elements
+// check that computation of hp-constraints works for DGP_Monomial elements
 // correctly
 
 char logname[] = "output";
index 308b24f863278aae1074cbc93bbfc08c59a91d7e..acad818e98d87f449d4e08a71c3120d33753c3d6 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// check that computation of hp constraints works for DGPNonparametric elements
+// check that computation of hp-constraints works for DGPNonparametric elements
 // correctly on a uniformly refined mesh for functions of degree q
 
 char logname[] = "output";
index f55d9546938ff4522d2a6572be7e8e1bb3c8b9a8..f27a596e7eddb616979c1782e90f65c74ba3814f 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// check that computation of hp constraints works for DGQ elements correctly
+// check that computation of hp-constraints works for DGQ elements correctly
 
 char logname[] = "output";
 
index 4eab486a8f2fac28799bfa0f83e9f64b4378b6e8..65d5fbb3de4a10073090270f7cc0f459c63056af 100644 (file)
@@ -28,7 +28,7 @@
 // check
 //   DoFTools::
 //   count_dofs_per_component (...);
-// for the hp case
+// for the hp-case
 
 
 using namespace std;
index c133fc79005935f4da48cba0d53f92c76462ded1..8cf3ac5280d61685701f075cc4dcb3ea19fd5951 100644 (file)
@@ -32,7 +32,7 @@
 // check
 //   DoFTools::
 //   count_dofs_per_component (...);
-// for the hp case
+// for the hp-case
 //
 // in contrast to the _01 test also check that this works if the element
 // collection has more than one element
index fafdcbd0c22946a868ddfc878c49223e49df8b65..08e7b32286d695e91a3c1850a62ffe71aa52a0c4 100644 (file)
@@ -73,7 +73,7 @@ check()
 
       // then build hanging node
       // constraints. this should trip the
-      // new code using the hp constraints,
+      // new code using the hp-constraints,
       // added in late July 2006
       AffineConstraints<double> constraints;
       DoFTools::make_hanging_node_constraints(dof, constraints);
index e18ef5f36437edddf393302279c9ba16aac5ac3d..df66b6a37f7e7e7f413a07b037e71dae95bc9a53 100644 (file)
@@ -31,7 +31,7 @@
 // check
 //   DoFTools::
 //   map_dofs_to_support_points(...);
-// for the hp case
+// for the hp-case
 
 
 using namespace std;
index 220a73b39f9a8fd9cf0b08fbe64c1b0d984a2e74..fde7dd63d6faa1f77f0be9658da8e2eb2b9319b4 100644 (file)
@@ -32,7 +32,7 @@
 // check
 //   DoFTools::
 //   map_dofs_to_support_points(...);
-// for the hp case with different finite elements
+// for the hp-case with different finite elements
 // on different cells.
 
 
index e1b6431de55fbec6be4b76fcd6f5990e92ae8dcf..65950a26bc69dee711ddbad18fe963c3abf33e88 100644 (file)
@@ -14,7 +14,7 @@
 // ---------------------------------------------------------------------
 
 
-// check VectorTools::point_gradient for a hp dofhandler.
+// check VectorTools::point_gradient for a hp-dofhandler.
 
 
 
index 43705d07129566c5898c9889d271c840e121add8..042296f8e58a0c2175c1172e0a41ddb3fd187451 100644 (file)
@@ -14,7 +14,7 @@
 // ---------------------------------------------------------------------
 
 
-// check VectorTools::point_value for a hp dofhandler.
+// check VectorTools::point_value for a hp-dofhandler.
 
 
 
index 8793d7f52b855a0b294060b495ad453d6da081fe..7d59e01c22cd13e313aafffaac6a524f8092213e 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// check that computation of hp constraints works for Q elements correctly
+// check that computation of hp-constraints works for Q elements correctly
 
 char logname[] = "output";
 
index 25485a1d193357ea65205fc929d72c4f3da7a6ad..999e70812c9e1e003acc0dbc8891acacdd1d7210 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// check that computation of hp constraints works for FESystem(FE_Q) elements
+// check that computation of hp-constraints works for FESystem(FE_Q) elements
 // correctly on a uniformly refined mesh for functions of degree q
 
 char logname[] = "output";
index f6f0882c57e04f947ea812a0af00c1577832f87e..5d6ae317b8655daa86d24b23c6e6d01c73bf89fe 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// check that computation of hp constraints works for FESystem(FE_Q) elements
+// check that computation of hp-constraints works for FESystem(FE_Q) elements
 // correctly on a uniformly refined mesh for functions of degree q
 
 // these tests check that we can deal with FESystem(FE_Q(p),FE_DGQ(q)) for
index 7459fcfbe7b69071c14c91d1f4e05da8ac2a73bb..d002b8e535e2508d43bc6ea42c6e4cf2fa48805f 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// check that computation of hp constraints works for RT elements correctly
+// check that computation of hp-constraints works for RT elements correctly
 
 char logname[] = "output";
 
index 2d939b5961e4d5b3626fa103917eb7e656402177..75659e8ac3ef3a705734476691433d838b97fe36 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// check that computation of hp constraints works for RT elements correctly
+// check that computation of hp-constraints works for RT elements correctly
 
 char logname[] = "output";
 
index 53aada348f143372340d648f548ea7c4407f4017..0a784e881a248df14671a9fa303ed95f11cbf7b1 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// check that computation of hp constraints works for RT elements correctly
+// check that computation of hp-constraints works for RT elements correctly
 
 char logname[] = "output";
 
index da81338735bcd373da015a9f220ad6ade2fc00ea..be480a3bf5ee46c9dc3e8f5364e0603155e1417a 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// check that computation of hp constraints works for RT elements correctly
+// check that computation of hp-constraints works for RT elements correctly
 
 char logname[] = "output";
 
index 1a5b076587573af6734777fef93a1297f639206e..d4f1da74aaed839b22b03a98a1476ad6ca5e0650 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// check that computation of hp constraints works for RT elements correctly
+// check that computation of hp-constraints works for RT elements correctly
 
 char logname[] = "output";
 
index 1c2e6c06299d63951e7e8c2b46601f8c43e7d775..23f9bb83ca2998e4f4191129f54b9337e29959b1 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// check that computation of hp constraints works for RT elements correctly
+// check that computation of hp-constraints works for RT elements correctly
 
 char logname[] = "output";
 
index f1397b0012c9824c1e5c5671b21b4956f8e14a07..508302c2561530aba11cc1c3faa00b6040020314 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// like deal.II/vectors_boundary_rhs_02, but for hp objects. here, each hp
+// like deal.II/vectors_boundary_rhs_02, but for hp-objects. here, each hp-
 // object has only a single component, so we expect exactly the same output as
 // for the old test. vectors_boundary_rhs_hp_02_hp tests for different finite
 // elements
index 620df0fa1bc27ae610913d99a5a6d484a2a79ba2..77f8c327fa7b694478f75c892a30666239c6ce9b 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// like deal.II/vectors_rhs_hp_02, but for hp objects. here, each hp object has
+// like deal.II/vectors_rhs_hp_02, but for hp-objects. here, each hp-object has
 // only a single component, so we expect exactly the same output as for the old
 // test. vectors_rhs_hp_02_hp tests for different finite elements
 
index 1081be2273f2496057892404d6e1042d931e571e..278d262b9439eaf56109eb4bb1980d37299e2118 100644 (file)
@@ -96,7 +96,7 @@ test6(const bool         do_href,
   fe_collection.push_back(FE_Enriched<dim>(FE_Q<dim>(p_feq)));
   fe_collection.push_back(
     FE_Enriched<dim>(FE_Q<dim>(p_feen), FE_Q<dim>(1), &function));
-  // push back to be able to resolve hp constrains:
+  // push back to be able to resolve hp-constrains:
   fe_collection.push_back(FE_Enriched<dim>(FE_Q<dim>(p_feen)));
 
   GridGenerator::hyper_cube(triangulation);
index fd0e56bbdff13b8654d922442a4a1da45fcdb9b5..2f0d81466ec9b0dbaacf2b064337d39231eeb076 100644 (file)
@@ -14,7 +14,7 @@
 // ---------------------------------------------------------------------
 
 
-// check constraints on hp dofhandler with 2 neighboring cells where one
+// check constraints on hp-dofhandler with 2 neighboring cells where one
 // cell is enriched and nother is not.
 
 #include <deal.II/base/function.h>
@@ -110,7 +110,7 @@ test2cells(const unsigned int p_feq = 2, const unsigned int p_feen = 1)
   fe_collection.push_back(FE_Enriched<dim>(FE_Q<dim>(p_feq)));
   fe_collection.push_back(
     FE_Enriched<dim>(FE_Q<dim>(p_feen), FE_Q<dim>(1), &function));
-  // push back to be able to resolve hp constrains:
+  // push back to be able to resolve hp-constrains:
   fe_collection.push_back(FE_Enriched<dim>(FE_Q<dim>(p_feen)));
 
   dof_handler.begin_active()->set_active_fe_index(1); // POU
index 0d4ce7c5eecd7115668b50fac39ed8854086a8dd..39d00e2da442d695477cb8f12c627d48f7e5fba1 100644 (file)
@@ -77,7 +77,7 @@ test2cellsFESystem(const unsigned int p_feq = 2, const unsigned int p_feen = 1)
     FESystem<dim>(FE_Q<dim>(p_feq), 1, FE_Nothing<dim>(), 1));
   fe_collection.push_back(FESystem<dim>(FE_Q<dim>(p_feen), 1, FE_Q<dim>(1), 1));
 
-  // push back to be able to resolve hp constrains:
+  // push back to be able to resolve hp-constrains:
   fe_collection.push_back(
     FESystem<dim>(FE_Q<dim>(p_feen), 1, FE_Nothing<dim>(), 1));
 
index d1c8b295dd6671cf2b605c5cffb1f0ee1f97b9f7..76c2b6bd5910c09a1952e8c97e64285cad8be82a 100644 (file)
@@ -16,7 +16,7 @@
 
 
 // adapted from hp/crash_06, which itself is from
-// make_hanging_node_constraints for hp elements. used to crash. triggers the
+// make_hanging_node_constraints for hp-elements. used to crash. triggers the
 // crash that at the time of writing the test afflicts all
 // hp/hp_constraints_*_03 tests
 
index d6422abe6fa09e0bc4401140e688c54251b2591a..aec3695e29c07b19908f13069f26760e628e6362 100644 (file)
@@ -16,7 +16,7 @@
 
 // verify that we can do things like cell->face() in 1d as well. here:
 // test cell->face(0)->get_dof_indices()
-// compared to _06, we now test for an hp DoFHandler
+// compared to _06, we now test for an hp-DoFHandler
 
 #include <deal.II/dofs/dof_accessor.h>
 #include <deal.II/dofs/dof_handler.h>
index 7a131963db52308d69b7a31525f8e5825e8f0cfd..c8e08f858378d041917bd434f761172af5e7bfbf 100644 (file)
@@ -16,7 +16,7 @@
 
 
 // Like hp/matrices, but only the boundary mass matrices for vector-valued
-// (non-primitive) hp objects are being tested.
+// (non-primitive) hp-objects are being tested.
 
 
 #include <deal.II/base/function_lib.h>
index 8aa54ca331ab6e0618f74f781cf122f9b39dc524..0a0d37437d77ce4e9b5814f1a08eda17a2f2b1cd 100644 (file)
@@ -16,7 +16,7 @@
 
 
 // Same as hp/boundary_matrices, but with different FE objects. Tests
-// the boundary mass matrces for vector-valued (non-primiteve) hp
+// the boundary mass matrces for vector-valued (non-primiteve) hp-
 // FE objects.
 
 
index 730f0e29cfa012b3b9932e53662638395756e68b..d9edda2d7621de6cad60a0147943a0bf46a39a63 100644 (file)
@@ -16,7 +16,7 @@
 
 
 // a test adapted from little programs by Markus Buerg that makes sure
-// we compute the same solution for hp and non-hp cases
+// we compute the same solution for hp- and non-hp-cases
 
 
 #include <deal.II/base/function.h>
index 776b5de65926c120da37053fc597afd1b31e874a..d3241cdc4f66d348fc08e3b1b9ffccbcf51279de 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// the crash_08 testcase discussed in the hp paper. this produces a cyclic
+// the crash_08 testcase discussed in the hp-paper. this produces a cyclic
 // constraint between degrees of freedom 3->14->17->6->3 with the algorithm
 // that is presently in make_hanging_node_constraints
 
index 6563bb6c6eaf54525dae5d7181f5199f7759049f..e114c77ec5048c00617810e49696094d0776f0bc 100644 (file)
@@ -16,7 +16,7 @@
 
 
 // a test where a degree of freedom was constrained multiple times,
-// but with different weights. see the hp paper for more on this
+// but with different weights. see the hp-paper for more on this
 
 char logname[] = "output";
 
index 2def2b0634a072562c0c1b2476e61f7120ed2886..afc1f7f643b86bcef97ea18d17f093e85c34cacc 100644 (file)
@@ -16,7 +16,7 @@
 
 
 // a test where a degree of freedom was constrained multiple times,
-// but with different weights. see the hp paper for more on this
+// but with different weights. see the hp-paper for more on this
 
 #include <deal.II/base/function.h>
 #include <deal.II/base/quadrature_lib.h>
index 82b0b794ead2fcaf2ea41dc1fb28e9910ccf0dc6..5d2ce3fd68696e74353fcccd1b55878ced2ed9dd 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// check the complex case described in the hp paper by playing through all
+// check the complex case described in the hp-paper by playing through all
 // sorts of arrangements of finite elements on one coarse and one refined cell
 //
 // this code in particular tests some compensating code in
index 42e57750220403518f61b4427f002e5f18467237..8c9443bd0cf3cc0edcd39900de67b846bbac3187 100644 (file)
@@ -22,7 +22,7 @@
 // apparently, what is happening is that we don't unify more than 2 finite
 // elements on an edge in 3d, according to a comment at the top of
 // hp::DoFHandler::compute_line_dof_identities at the time of this writing
-// (and referring to a comment in the hp paper). there is now code that deals
+// (and referring to a comment in the hp-paper). there is now code that deals
 // with the more narrow special case we have here
 
 #include <deal.II/dofs/dof_accessor.h>
index 0949de23bb2c00fb14ec66053e59158986da539a..4d2421a8e88bf7bca881ac00fd4eaadc6905e2bb 100644 (file)
@@ -17,7 +17,7 @@
 
 // a problem uncovered by Baerbel Janssen in that
 // DoFTools::make_flux_sparsity_pattern aborted in 1d with adaptively refined
-// meshes and hp DoFHandlers. this actually uncovered all sorts of other
+// meshes and hp-DoFHandlers. this actually uncovered all sorts of other
 // problems that led to a long sequence of assertions triggered every time one
 // of them was fixed. this test cumulatively makes sure everything is ok
 
index cf3951f06b388a1ebc0d8f9912d3889b7c65b27b..254381e25ed29d30a7295d5aec684c88e5a7ab1d 100644 (file)
@@ -16,7 +16,7 @@
 
 
 // Check the consistency of the number cache of DoFHandler for a sequential
-// object. Like deal.II/dof_handler_number_cache but for an hp object
+// object. Like deal.II/dof_handler_number_cache but for an hp-object
 
 
 #include <deal.II/base/tensor.h>
index 8b1f60d683b64b714af99648d50f2791e74d691a..e3a8a50c0bf7914cf5d7ff1bdf9d2ea678c1bd7b 100644 (file)
@@ -16,7 +16,7 @@
 
 
 // validate combination of error prediction and cell data transfer algorithms
-// for hp adaptive methods
+// for hp-adaptive methods
 
 
 #include <deal.II/dofs/dof_handler.h>
index aed473a60c583a825e1305f4fa7d230e9b62e20c..22d1af8a3eb96f92581f0a55ae76e9ace35831a2 100644 (file)
@@ -16,7 +16,7 @@
 
 
 // test that FE_Nothing can be called with interpolate_boundary_values
-// with vector elements in the hp context with each element active
+// with vector elements in the hp-context with each element active
 // only in a subdomain
 
 
index 61d5307a4fd3f6a047ed22e4f7c65008e2378dbb..f52f901e6dd5444aa33aed714b6ce30325ba7784 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// interpolate() can not deal with FE_Nothing in an hp setting
+// interpolate() can not deal with FE_Nothing in an hp-setting
 
 
 #include <deal.II/base/function.h>
index a93bd3ca304727dec34c58d800efec65f9c03858..a100d69a993b0ae6cc3775dc4eeb43a56a14c659 100644 (file)
@@ -14,7 +14,7 @@
 // ---------------------------------------------------------------------
 
 // A test that checks make_flux_sparsity_pattern
-// with vector-valued hp objects and coupling masks
+// with vector-valued hp-objects and coupling masks
 
 #include <deal.II/dofs/dof_accessor.h>
 #include <deal.II/dofs/dof_handler.h>
index 34b72209d870ef0097086f116ebb93b49bf18b58..fb2e313d2f664658b05a475ad46a2f9fd98cda35 100644 (file)
@@ -14,7 +14,7 @@
 // ---------------------------------------------------------------------
 
 // A second test that checks make_flux_sparsity_pattern
-// with scalar valued hp objects.
+// with scalar valued hp-objects.
 
 #include <deal.II/dofs/dof_accessor.h>
 #include <deal.II/dofs/dof_handler.h>
index 731787e643ab71ca4594dab6699d082292ef1ff4..fb5d7b9881793842edfab68e9064d0983802dbfd 100644 (file)
@@ -14,7 +14,7 @@
 // ---------------------------------------------------------------------
 
 
-// cell->get_interpolated_dof_values can not work properly in the hp
+// cell->get_interpolated_dof_values can not work properly in the hp-
 // context when called on non-active cells because these do not have a
 // finite element associated with them
 
index 917b290935bf99c5235c02c3f4de996c34643589..b641b2520a83f225f4f7ce7393086f37c60fd713 100644 (file)
@@ -14,7 +14,7 @@
 // ---------------------------------------------------------------------
 
 
-// cell->get_interpolated_dof_values can not work properly in the hp
+// cell->get_interpolated_dof_values can not work properly in the hp-
 // context when called on non-active cells because these do not have a
 // finite element associated with them
 //
index 302d645ba15f56bcc31aa10a72cc988f3d8fbcb1..ffd75e276a9bfbfed8859859d854b1da8cdc3ede 100644 (file)
@@ -14,7 +14,7 @@
 // ---------------------------------------------------------------------
 
 
-// cell->get_interpolated_dof_values can not work properly in the hp
+// cell->get_interpolated_dof_values can not work properly in the hp-
 // context when called on non-active cells because these do not have a
 // finite element associated with them
 //
index ebe169ec89402a988cc920c98d33ba7dc1cf60dc..3b8d8c4ae359059af5412b8a09614452be357b69 100644 (file)
@@ -15,8 +15,8 @@
 
 
 
-// validate hp decision algorithms on grid coarsening
-// that depend on the composition of h and p adaptivity flags
+// validate hp-decision algorithms on grid coarsening
+// that depend on the composition of h- and p-adaptivity flags
 
 
 #include <deal.II/dofs/dof_handler.h>
@@ -53,7 +53,7 @@ setup(Triangulation<dim> &tria, const DoFHandler<dim> &dh)
   GridGenerator::hyper_cube(tria);
   tria.refine_global(1);
 
-  // Set h and p flags on all cells.
+  // Set h- and p-flags on all cells.
   for (const auto &cell : dh.active_cell_iterators())
     {
       cell->set_coarsen_flag();
index 14040cf22f56e3db4489dd6fb77d4e9eb11755ee..1776ab79908dcb93897cf5635ebc05b1e6d73053 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// check that computation of hp constraints works for Bernstein elements
+// check that computation of hp-constraints works for Bernstein elements
 // correctly
 
 char logname[] = "output";
index 502ff6fcdc4062f2679546fc1e303f26acbfc6e1..10918f767c7ea07031fae9692ea815abded00a2a 100644 (file)
@@ -14,7 +14,7 @@
 // ---------------------------------------------------------------------
 
 
-// common framework to check hp constraints
+// common framework to check hp-constraints
 
 #include <deal.II/base/function.h>
 #include <deal.II/base/function_lib.h>
index cc6f3ef2d33f0336e0ae8308a966996580eb6b9e..d94968f37785ff911abaa2b686bcd5d0136ed193 100644 (file)
@@ -14,7 +14,7 @@
 // ---------------------------------------------------------------------
 
 
-// common framework to check hp constraints for fe without support points
+// common framework to check hp-constraints for fe without support points
 
 #include <deal.II/base/function.h>
 #include <deal.II/base/function_lib.h>
index f6be75c3fb13074b474bd9284695ded651a71c5b..6b39e71500b83f9868e148b934ec402c42095442 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// check that computation of hp constraints works for DGP elements correctly
+// check that computation of hp-constraints works for DGP elements correctly
 
 char logname[] = "output";
 
index f03673ca2e90a27b66b5052e0368c20c25b54300..d554ae332cd44e6e6f4d4b2a33fbbf1fdc72c05a 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// check that computation of hp constraints works for DGP_Monomial elements
+// check that computation of hp-constraints works for DGP_Monomial elements
 // correctly
 
 char logname[] = "output";
index c239f7c5264d5a594c125c6bcb6c43b241873b52..f954070768c0b0eb6326c3aeca9ed171de5bf503 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// check that computation of hp constraints works for DGPNonparametric elements
+// check that computation of hp-constraints works for DGPNonparametric elements
 // correctly on a uniformly refined mesh for functions of degree q
 
 char logname[] = "output";
index cb26ef5617c6a1a5201a93bd2a8541aca83c950e..c4fee1efbc55d056332e5f536afedcc37cf44ca1 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// check that computation of hp constraints works for DGQ elements correctly
+// check that computation of hp-constraints works for DGQ elements correctly
 
 char logname[] = "output";
 
index 337ffe42c59afbe541746a8651dba86fd9f538ce..64a24ab06b3f41e5d1fce1a40b01b4d2d21d74f1 100644 (file)
@@ -95,7 +95,7 @@ test2cells(const unsigned int p1 = 2, const unsigned int p2 = 1)
   fe_collection.push_back(
     FESystem<dim>(FE_Q<dim>(p1), 1, FE_Nothing<dim>(1, true), 1));
   fe_collection.push_back(FESystem<dim>(FE_Q<dim>(p2), 1, FE_Q<dim>(1), 1));
-  // push back to be able to resolve hp constrains no matter what:
+  // push back to be able to resolve hp-constrains no matter what:
   fe_collection.push_back(
     FESystem<dim>(FE_Q<dim>(p2), 1, FE_Nothing<dim>(1, true), 1));
 
index 487485c5669552cefb77d181c6cf1dd53966b300..c5845bf5b474546b17ece186148425dd6bf6629e 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// check that computation of hp constraints works for Q elements correctly
+// check that computation of hp-constraints works for Q elements correctly
 
 char logname[] = "output";
 
index 00b3f54256589e5e8de36932cc468b1501bace14..e47940009757d336103b36d3cd7ad1ba12125902 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// check that computation of hp constraints works for DGP_Monomial elements
+// check that computation of hp-constraints works for DGP_Monomial elements
 // correctly
 
 char logname[] = "output";
index 99ac7dd621f22fd041e0a431dd0180ddeab3377e..1818514291e0ac38c8966c56d224cb32b0578234 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// check that computation of hp constraints works for FESystem(FE_Q) elements
+// check that computation of hp-constraints works for FESystem(FE_Q) elements
 // correctly on a uniformly refined mesh for functions of degree q
 
 char logname[] = "output";
index 3050bad5599c0597ed4a73363031781be988f0a8..5865bdc571447c7bcb3a324bbd41c851028ca548 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// check that computation of hp constraints works for FESystem(FE_Q) elements
+// check that computation of hp-constraints works for FESystem(FE_Q) elements
 // correctly on a uniformly refined mesh for functions of degree q
 
 // these tests check that we can deal with FESystem(FE_Q(p),FE_DGQ(q)) for
index 2c9d55eacf174da9710ec038a3ea0f4544a30c1f..069684cac00be35439cb9768b64c4185cca4833c 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// check that computation of hp constraints works for RT elements correctly
+// check that computation of hp-constraints works for RT elements correctly
 
 char logname[] = "output";
 
index 893b1deb61d624359f11895f7708a087b18c547e..dad119befa7d59af6d487cc0d63fe215028749c6 100644 (file)
@@ -48,7 +48,7 @@
 #include "../tests.h"
 
 
-// This a test for the hp capable version of the make_hanging_node_constraints
+// This a test for the hp-capable version of the make_hanging_node_constraints
 // method. It uses a triangulation with one refined element beside an
 // unrefined element to create the constraints for this configuration.
 
index b28991d1162b3cb8f8694332006695e8f6435915..cf81f70a3cfe9a41ec207951d5ed3902fa284061 100644 (file)
@@ -427,7 +427,7 @@ Laplace<dim>::refine_grid(const unsigned int cycle)
   // 3.2. Mark cells for h-refinement
   mark_h_cells();
 
-  // 3.3. Substitute h for p refinement
+  // 3.3. Substitute h- for p-refinement
   substitute_h_for_p();
 
   // prepare refinement and store number of flagged cells
@@ -457,7 +457,7 @@ Laplace<dim>::refine_grid(const unsigned int cycle)
   // 3.5. h-refinement and p-refinement
   triangulation.execute_coarsening_and_refinement();
 
-  // FIXME: some hp strategies might need:
+  // FIXME: some hp-strategies might need:
   // post_execute_coarsening_and_refinement();
 
   // 3.6. Setup
index d627af1b8fc028f198e374a97c70f5cda13c24ef..948dba71650ff336e21e2765d0d8856d7bc5e853 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// like deal.II/matrices, but for hp objects. here, each hp object has only a
+// like deal.II/matrices, but for hp-objects. here, each hp-object has only a
 // single component, so we expect exactly the same output as for the old test.
 // matrices_hp tests for different finite elements
 
index 78b3b81a407fccafdf4b087a2f608228bf84be1a..ae111748005770db047c44ca808c1a05470c8b90 100644 (file)
@@ -16,7 +16,7 @@
 
 
 // Check the consistency of the number cache of DoFHandler for a sequential
-// object. Like deal.II/n_boundary_dofs but for an hp object
+// object. Like deal.II/n_boundary_dofs but for an hp-object
 
 
 #include <deal.II/base/tensor.h>
index e654b03d1efa26c0224ea217c63980bd405e5c7a..667cf574ea6b0f572f22ac0300852ec8496d6506 100644 (file)
@@ -99,8 +99,8 @@ test()
 
 
   // We flag the first half of all cells to be refined and the last half of all
-  // cells to be coarsened for p adapativity. Ultimately, the first quarter of
-  // all cells will be flagged for p refinement, and the last quarter for p
+  // cells to be coarsened for p-adapativity. Ultimately, the first quarter of
+  // all cells will be flagged for p-refinement, and the last quarter for p-
   // coarsening.
 
   const unsigned int n_active = tria.n_active_cells();
index 6bc7fd0b472d763c2043f3df02923455d04792d9..f015a4b738961d31d93719a56116f9e3d145169d 100644 (file)
@@ -99,8 +99,8 @@ test()
 
 
   // We flag the first half of all cells to be refined and the last half of all
-  // cells to be coarsened for p adapativity. Ultimately, the first quarter of
-  // all cells will be flagged for p refinement, and the last quarter for p
+  // cells to be coarsened for p-adapativity. Ultimately, the first quarter of
+  // all cells will be flagged for p-refinement, and the last quarter for p-
   // coarsening.
 
   const unsigned int n_active = tria.n_active_cells();
index 1744d0aa0ded5dd9c7d6c8faf40a02aefcaf34c5..f8e66eb71ea280eaa9484daea33a162bcd84d42b 100644 (file)
@@ -99,8 +99,8 @@ test()
 
 
   // We flag the first half of all cells to be refined and the last half of all
-  // cells to be coarsened for p adapativity. Ultimately, the first quarter of
-  // all cells will be flagged for p refinement, and the last quarter for p
+  // cells to be coarsened for p-adapativity. Ultimately, the first quarter of
+  // all cells will be flagged for p-refinement, and the last quarter for p-
   // coarsening.
 
   const unsigned int n_active = tria.n_active_cells();
index 7d9564fdcdc4af9daf29838ac650856b432ec56d..e9dcdc5e18678daaecf71a7860145d0c84a6b7f4 100644 (file)
@@ -99,8 +99,8 @@ test()
 
 
   // We flag the first half of all cells to be refined and the last half of all
-  // cells to be coarsened for p adapativity. Ultimately, the first quarter of
-  // all cells will be flagged for p refinement, and the last quarter for p
+  // cells to be coarsened for p-adapativity. Ultimately, the first quarter of
+  // all cells will be flagged for p-refinement, and the last quarter for p-
   // coarsening.
 
   const unsigned int n_active = tria.n_active_cells();
index e882b2528583a441c7e17a32b51627434a922c2c..8bf7e1de3a4e04a741c8f739083f13fbe244e469 100644 (file)
@@ -99,8 +99,8 @@ test()
 
 
   // We flag the first half of all cells to be refined and the last half of all
-  // cells to be coarsened for p adapativity. Ultimately, the first quarter of
-  // all cells will be flagged for p refinement, and the last quarter for p
+  // cells to be coarsened for p-adapativity. Ultimately, the first quarter of
+  // all cells will be flagged for p-refinement, and the last quarter for p-
   // coarsening.
 
   const unsigned int n_active = tria.n_active_cells();
index 2a265b35bfa18400a5e8212ab7c7ea5376720591..53aab49f803df1cca99a2e4126290c26997e381a 100644 (file)
@@ -99,8 +99,8 @@ test()
 
 
   // We flag the first half of all cells to be refined and the last half of all
-  // cells to be coarsened for p adapativity. Ultimately, the first quarter of
-  // all cells will be flagged for p refinement, and the last quarter for p
+  // cells to be coarsened for p-adapativity. Ultimately, the first quarter of
+  // all cells will be flagged for p-refinement, and the last quarter for p-
   // coarsening.
 
   const unsigned int n_active = tria.n_active_cells();
index 18f7811c40748d1977dc7a7cc6f89c59ee93113a..ef1fe4ba117fc8291c9d58cda4d244fe9463d6e5 100644 (file)
@@ -14,7 +14,7 @@
 // ---------------------------------------------------------------------
 
 
-// cell->set_dof_values_by_interpolation can not work properly in the hp
+// cell->set_dof_values_by_interpolation can not work properly in the hp-
 // context when called on non-active cells because these do not have a
 // finite element associated with them
 
index ef147071a0d83ad5d1d44e2c1e8f60c6b68e75b6..5e43b4ed55fe6308ec590f20fcec2e6045fb579e 100644 (file)
@@ -14,7 +14,7 @@
 // ---------------------------------------------------------------------
 
 
-// cell->set_dof_values_by_interpolation can not work properly in the hp
+// cell->set_dof_values_by_interpolation can not work properly in the hp-
 // context when called on non-active cells because these do not have a
 // finite element associated with them
 //
index 91ee0ec9545c851c88c161f7851be784d701139a..a56584595b9616ca373d82b6dd080c145979fd32 100644 (file)
@@ -14,7 +14,7 @@
 // ---------------------------------------------------------------------
 
 
-// cell->set_dof_values_by_interpolation can not work properly in the hp
+// cell->set_dof_values_by_interpolation can not work properly in the hp-
 // context when called on non-active cells because these do not have a
 // finite element associated with them
 //
index 766910f102176d7fe2426b886160b69966b4f21a..9f9e9318730f44fb17266ee93c356b64c19d546c 100644 (file)
@@ -208,7 +208,7 @@ transfer(std::ostream &out)
               std::fabs(func.value(fe_val.quadrature_point(q), 0) - vals[q]);
           }
       }
-    deallog << "Error in interpolating hp FE_Q: " << error << std::endl;
+    deallog << "Error in interpolating hp-FE_Q: " << error << std::endl;
   }
   {
     double                                         error = 0;
@@ -231,7 +231,7 @@ transfer(std::ostream &out)
               std::fabs(func.value(fe_val.quadrature_point(q), 0) - vals[q]);
           }
       }
-    deallog << "Error in interpolating hp FE_DGQ: " << error << std::endl;
+    deallog << "Error in interpolating hp-FE_DGQ: " << error << std::endl;
   }
 }
 
index 7af228e047351028fe002122d0ad1a4c0adf7ce7..95080fd65a27205e1f9d5be5e51bfa07f7d7cba7 100644 (file)
@@ -1,10 +1,10 @@
 
 DEAL::   1D solution transfer
-DEAL::Error in interpolating hp FE_Q: 0
-DEAL::Error in interpolating hp FE_DGQ: 0
+DEAL::Error in interpolating hp-FE_Q: 0
+DEAL::Error in interpolating hp-FE_DGQ: 0
 DEAL::   2D solution transfer
-DEAL::Error in interpolating hp FE_Q: 0
-DEAL::Error in interpolating hp FE_DGQ: 0
+DEAL::Error in interpolating hp-FE_Q: 0
+DEAL::Error in interpolating hp-FE_DGQ: 0
 DEAL::   3D solution transfer
-DEAL::Error in interpolating hp FE_Q: 0
-DEAL::Error in interpolating hp FE_DGQ: 0
+DEAL::Error in interpolating hp-FE_Q: 0
+DEAL::Error in interpolating hp-FE_DGQ: 0
index 8c3495b20f0c9843ae09b511872000e318407b8c..7d7e6220174525070aff36414cf8e62f1165e24f 100644 (file)
@@ -16,7 +16,7 @@
 
 
 // SolutionTransfer wanted to compute interpolation matrices between
-// all pairs of elements used on a mesh in the hp case. unfortunately,
+// all pairs of elements used on a mesh in the hp-case. unfortunately,
 // not all pairs are actually supported, e.g. between FE_Nothing and
 // FE_Q, but that shouldn't matter as long as these combinations are
 // never exercised on actual cells
index bbf643554b30389ccb254a78dbf9000db59749f0..8d8fc0b926d64631cfe22944140430c428d47f06 100644 (file)
@@ -222,7 +222,7 @@ transfer(std::ostream &out)
               std::fabs(func.value(fe_val.quadrature_point(q), 0) - vals[q]);
           }
       }
-    deallog << "Error in interpolating hp FE_Q_Hierarchical: " << error
+    deallog << "Error in interpolating hp-FE_Q_Hierarchical: " << error
             << std::endl;
   }
 }
index adc30e4418ffdda44e884597370837e4a826d2d4..b32d35acbfba23d98cbae53b44a077497848bcb0 100644 (file)
@@ -1,7 +1,7 @@
 
 DEAL::   1D solution transfer
-DEAL::Error in interpolating hp FE_Q_Hierarchical: 0
+DEAL::Error in interpolating hp-FE_Q_Hierarchical: 0
 DEAL::   2D solution transfer
-DEAL::Error in interpolating hp FE_Q_Hierarchical: 0
+DEAL::Error in interpolating hp-FE_Q_Hierarchical: 0
 DEAL::   3D solution transfer
-DEAL::Error in interpolating hp FE_Q_Hierarchical: 0
+DEAL::Error in interpolating hp-FE_Q_Hierarchical: 0
index b3c3932d2aa2fedebe2a96eb28f3e6a9499244ca..fd17c0bebd0d1cdba73244151c60e43e84251769 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// like deal.II/vectors_boundary_rhs, but for hp objects. here, each hp object
+// like deal.II/vectors_boundary_rhs, but for hp-objects. here, each hp-object
 // has only a single component, so we expect exactly the same output as for the
 // old test. vectors_boundary_rhs_hp tests for different finite elements
 
index 768ed0451ea687880451acba123444242aeb2ffe..68475e5b67074ed2890ad1305302ee82195bca94 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// like deal.II/vectors_boundary_rhs_02_02, but for hp objects. here, each hp
+// like deal.II/vectors_boundary_rhs_02_02, but for hp-objects. here, each hp-
 // object has only a single component, so we expect exactly the same output as
 // for the old test. vectors_boundary_rhs_02_hp tests for different finite
 // elements
index a4bf3358ea93d36cc0458fa7030f359e9b934c25..4a54b04c5a337063dbd9d236535a2031f6f3f705 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// like deal.II/vectors_boundary_rhs_03, but for hp objects. here, each hp
+// like deal.II/vectors_boundary_rhs_03, but for hp-objects. here, each hp-
 // object has only a single component, so we expect exactly the same output as
 // for the old test. vectors_boundary_rhs_03_hp tests for different finite
 // elements
index 369c82eb099671938094106c0b2b3d07ceb5c102..10a743423d7aa3290d5b1d5b9443b9ca564dfcdd 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// like deal.II/vectors_boundary_rhs, but for hp objects. here, each hp object
+// like deal.II/vectors_boundary_rhs, but for hp-objects. here, each hp-object
 // has only a single component, so we expect exactly the same output as for the
 // old test. vectors_boundary_rhs_hp_hp tests for different finite elements
 
index 0f10120e060c46ad7d15bff16df548abc5e545c8..29a5a584b76a40b1b474f98f63da3dad029eb560 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// like deal.II/vectors_boundary_rhs_03, but for hp objects. here, each hp
+// like deal.II/vectors_boundary_rhs_03, but for hp-objects. here, each hp-
 // object has only a single component, so we expect exactly the same output as
 // for the old test. vectors_boundary_rhs_hp_03_hp tests for different finite
 // elements
index 7cc3a8ed0a8df741563c97c6bca9b4a46ac54cc1..eadd54d729667dcb155e19777ba8ad4f69ccbf68 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// like deal.II/vectors_point_source, but for hp objects. here, each hp object
+// like deal.II/vectors_point_source, but for hp-objects. here, each hp-object
 // has only a single component, so we expect exactly the same output as for the
 // old test. vectors_point_source_hp tests for different finite elements
 
index 32da8432725b2045754268cc475b7e2f0ef68c7c..da496b81faded54809502379897516242f8eb73d 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// like deal.II/vectors_point_source_hp, but for hp objects. here, each hp
+// like deal.II/vectors_point_source_hp, but for hp-objects. here, each hp-
 // object has only a single component, so we expect exactly the same output as
 // for the old test. vectors_point_source_hp_hp tests for different finite
 // elements
index 85adeb730cc7644da9a7f4a9b30c6802c8d92ad7..4d46c557846a0030c6ae5e1539200108ae3215d5 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// like deal.II/vectors_rhs, but for hp objects. here, each hp object has only a
+// like deal.II/vectors_rhs, but for hp-objects. here, each hp-object has only a
 // single component, so we expect exactly the same output as for the old test.
 // vectors_rhs_hp tests for different finite elements
 
index 4c1f4c1718b997217479ac135dc537cdfa911a95..100f27064c49ade4f9b0febf58ccc00443f853e8 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// like deal.II/vectors_rhs_02_02, but for hp objects. here, each hp object has
+// like deal.II/vectors_rhs_02_02, but for hp-objects. here, each hp-object has
 // only a single component, so we expect exactly the same output as for the old
 // test. vectors_rhs_02_hp tests for different finite elements
 
index e0e0e5d8cc111738d06a715971debc1035fb8483..e9ee27570f3db047ac87916c78fb1ccf7e8f2b4a 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// like deal.II/vectors_rhs_03, but for hp objects. here, each hp object has
+// like deal.II/vectors_rhs_03, but for hp-objects. here, each hp-object has
 // only a single component, so we expect exactly the same output as for the old
 // test. vectors_rhs_03_hp tests for different finite elements
 
index 3e528a1db3bfe4528ff747bb687a1bd1f0b9e676..f8e5b6c6e2d73bac7c5bf605289325b046bfaf75 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// like deal.II/vectors_rhs_hp, but for hp objects. here, each hp object has
+// like deal.II/vectors_rhs_hp, but for hp-objects. here, each hp-object has
 // only a single component, so we expect exactly the same output as for the old
 // test. vectors_rhs_hp_hp tests for different finite elements
 
index fad37043476db92dc19270a82dd093545decaaff..f461976bf2280162cdf97f3ccbd287d582564132 100644 (file)
@@ -15,7 +15,7 @@
 
 
 
-// like deal.II/vectors_rhs_hp_03, but for hp objects. here, each hp object has
+// like deal.II/vectors_rhs_hp_03, but for hp-objects. here, each hp-object has
 // only a single component, so we expect exactly the same output as for the old
 // test. vectors_rhs_hp_03_hp tests for different finite elements
 
index 3aca0df3a6eb2b228512754e2b345e9633e32ab0..088dcc6c48c8d6c6517622ed9f1632505a332561 100644 (file)
@@ -17,7 +17,7 @@
 
 // this function tests the correctness of the implementation of
 // inhomogeneous constraints. The program is a modification of the step-27
-// tutorial program with hp elements and the constraints arising in that
+// tutorial program with hp-elements and the constraints arising in that
 // situation. the idea of the test is to set up a matrix with standard tools
 // (i.e., constraints and the boundary value list), and compare that with
 // the new function.
index 00acbf8678dc6c18426cbefffa328ce907a1a288..dbf4028d092dd84b6d9ec3298139c4197921b0fd 100644 (file)
@@ -17,7 +17,7 @@
 
 // this function tests the correctness of the implementation of matrix free
 // matrix-vector products by comparing with the result of deal.II sparse
-// matrix for hp DoFHandler on a hyperball mesh with hanging nodes and finite
+// matrix for hp-DoFHandler on a hyperball mesh with hanging nodes and finite
 // elements orders distributed randomly.
 
 #include <deal.II/base/function.h>
index 4fad45acc6e211bdb4f77f1191957b27845e67c4..660349b3d1b70e7651d1a1496da2fd328e2dd6d1 100644 (file)
@@ -17,7 +17,7 @@
 
 // this function tests the correctness of the implementation of matrix free
 // matrix-vector products by comparing with the result of deal.II sparse
-// matrix for hp DoFHandler on a hyperball mesh with hanging nodes and finite
+// matrix for hp-DoFHandler on a hyperball mesh with hanging nodes and finite
 // elements orders distributed randomly.
 
 #include <deal.II/base/function.h>
index a03d86c2c0e88e4fb122fdb08d5154a743979ac7..852563232bfcef261aa9d538fca6fbc8e306975d 100644 (file)
@@ -16,7 +16,7 @@
 
 
 // this function tests the correctness of the implementation of parallel
-// matrix free matrix-vector products for hp elements by comparing to the
+// matrix free matrix-vector products for hp-elements by comparing to the
 // serial version
 
 #include <deal.II/base/function.h>
index 4422ee967da5df6905b9b70b3448f7b664abf2d2..dd5c51cb176d122d4921ee7cf2d8689e901e3889 100644 (file)
@@ -197,7 +197,7 @@ namespace Step4
     DoFTools::make_zero_boundary_constraints(dof_handler, constraints);
 
 #ifdef DEBUG
-    // We did not think about hp constraints on ghost cells yet.
+    // We did not think about hp-constraints on ghost cells yet.
     // Thus, we are content with verifying their consistency for now.
     IndexSet locally_active_dofs;
     DoFTools::extract_locally_active_dofs(dof_handler, locally_active_dofs);
index 5bf5c77211f434eb97037748771645d4c9526218..735624ac4027398195525ae91878a1ca701bf596 100644 (file)
@@ -15,9 +15,9 @@
 
 
 
-// have a 2x1 coarse mesh (or 2x1x1) and verify DoF indices in the hp
+// have a 2x1 coarse mesh (or 2x1x1) and verify DoF indices in the hp-
 // case with an FECollection that contains multiple copies of the same
-// FE_Q(2) element. the hp code will unify DoF indices on boundaries
+// FE_Q(2) element. the hp-code will unify DoF indices on boundaries
 // between all subdomains.
 
 
index 93488af1e3710c8bb330355af1da63c6574c6f3b..7c94888f82a465ac12105a9c9c31a5e172b40bba 100644 (file)
@@ -15,9 +15,9 @@
 
 
 
-// have a 2x2 coarse mesh (or 2x2x1) and verify DoF indices in the hp
+// have a 2x2 coarse mesh (or 2x2x1) and verify DoF indices in the hp-
 // case with an FECollection that contains multiple copies of the same
-// FE_Q(2) element. the hp code will unify DoF indices on boundaries
+// FE_Q(2) element. the hp-code will unify DoF indices on boundaries
 // between all subdomains.
 //
 // in this testcase, three FE objects are distributed on four cells,
index fbf343677507162234474dc411a35aa012f9856e..94b756561dadfc24a70f6563387e764c8591354e 100644 (file)
@@ -15,9 +15,9 @@
 
 
 
-// have a 2x2 coarse mesh (or 2x2x1) and verify DoF indices in the hp
+// have a 2x2 coarse mesh (or 2x2x1) and verify DoF indices in the hp-
 // case with an FECollection that contains a FE_Q(4) and a FE_Q(2) element.
-// the hp code will unify DoF indices on boundaries between all subdomains.
+// the hp-code will unify DoF indices on boundaries between all subdomains.
 //
 // in this testcase, each cell has a face neighbor with a different
 // active_fe_index, which is either locally owned or a ghost cell.
index 92c8ac3f34de002043af6e40d4c56de1cd0ee9d0..8dc5a0756d2d009b9eb02770ea5d44fc87963724 100644 (file)
@@ -15,9 +15,9 @@
 
 
 
-// have a 2x2 coarse mesh (or 2x2x1) and verify DoF indices in the hp
+// have a 2x2 coarse mesh (or 2x2x1) and verify DoF indices in the hp-
 // case with an FECollection that contains a FE_Q(4) and a FE_Q(2) element.
-// the hp code will unify DoF indices on boundaries between all subdomains.
+// the hp-code will unify DoF indices on boundaries between all subdomains.
 //
 // in this testcase, each cell has a face neighbor which is
 //  - locally owned with the same active_fe_index
index 78b09c0d74ffa5c528d0a6d2772dc8b27444cdb6..9c60903471d1690696c881206c9924938bded677 100644 (file)
@@ -15,9 +15,9 @@
 
 
 
-// have a 2x2 coarse mesh (or 2x2x1) and verify DoF indices in the hp
+// have a 2x2 coarse mesh (or 2x2x1) and verify DoF indices in the hp-
 // case with an FECollection that contains a FE_Q(4) and a FE_Q(2) element.
-// the hp code will unify DoF indices on boundaries between all subdomains.
+// the hp-code will unify DoF indices on boundaries between all subdomains.
 //
 // in this testcase, each cell has a face neighbor which is
 //  - locally owned with a different active_fe_index
index 29684409c3840f76bedd527637ea75a65e8ddab1..04b1658a735425487d3548fe592f6d353905c138 100644 (file)
@@ -15,9 +15,9 @@
 
 
 
-// have a 2x2 coarse mesh (or 2x2x1) and verify DoF indices in the hp
+// have a 2x2 coarse mesh (or 2x2x1) and verify DoF indices in the hp-
 // case with an FECollection that contains multiple copies of the same
-// FE_Q(2) element. the hp code will unify DoF indices on boundaries
+// FE_Q(2) element. the hp-code will unify DoF indices on boundaries
 // between all subdomains.
 //
 // in this testcase, the dominating FE object is located on a cell
index fecbb810b6f49d9e9a026d59a161f85dc85c2ce7..03d69157929efc002744221c98873ff56f1aab97 100644 (file)
 
 
 
-// have a 2x1 coarse mesh (or 2x1x1) and verify DoF indices in the hp
+// have a 2x1 coarse mesh (or 2x1x1) and verify DoF indices in the hp-
 // case with an FECollection that contains multiple copies of the same
-// FE_Q(2) element. in the sequential case, the hp code will unify DoF
+// FE_Q(2) element. in the sequential case, the hp-code will unify DoF
 // indices on boundaries between locally owned subdomains; in early
-// versions of the parallel hp support, we don't do that, but the
+// versions of the parallel hp-support, we don't do that, but the
 // final version now does
 //
 // this test gives a different perspective on this issue. in the _01
index bd22443032560b9137cde5cafc090cd5ebdd9a8e..3fd6d127b4ccdfe671697deeb172eab6f0c5522c 100644 (file)
 
 
 
-// Read in a large grid from a file and distribute hp DoFs on it using
+// Read in a large grid from a file and distribute hp-DoFs on it using
 // FE_Q elements of different orders on different cells. The
 // active_fe_index on each cell is determined in a mostly random way,
 // but so that it is the same regardless of the number of processors.
 //
-// We used to treat hp DoF unification on vertices and faces
+// We used to treat hp-DoF unification on vertices and faces
 // differently depending on whether we are in the interior of a
 // subdomain or at a processor boundary. But later versions of the
 // code did away with this distinction, and now the total number of
index be0c4c43e7c3d36b9a1fe33017e5f80f0e82e960..3bc3c23bb38c6276d4b16d52042f1a93a6b7f7c8 100644 (file)
@@ -15,9 +15,9 @@
 
 
 
-// have a 2x2 coarse mesh (or 2x2x1) and verify DoF indices in the hp
+// have a 2x2 coarse mesh (or 2x2x1) and verify DoF indices in the hp-
 // case with an FECollection that contains multiple copies of the same
-// FESystem object, consisting of two FE_Q(2) elements. the hp code will
+// FESystem object, consisting of two FE_Q(2) elements. the hp-code will
 // unify DoF indices on boundaries between all subdomains.
 //
 // in this testcase, three FESystem objects are distributed on four
index 3775fcb1f943f1ac5025e4ca24f0a27ef20c364b..091a5e76c57f7ab29c5017ac22deac4dbc82f00d 100644 (file)
 
 
 
-// have a 2x1 coarse mesh (or 2x1x1) and verify DoF indices in the hp
+// have a 2x1 coarse mesh (or 2x1x1) and verify DoF indices in the hp-
 // case with a FECollection that contains two finite elements that do
 // not dominate each other. Here, a (FE_Q(1) x FE_Q(2)) and a
 // (FE_Q(2) x FE_Q(1)) element on two separate subdomains face each
-// other. the hp code will unify DoF indices on boundaries between all
+// other. the hp-code will unify DoF indices on boundaries between all
 // subdomains.
 
 
index 28e746eff692bf3d0281256423ca36382810b12b..fe8a8eff9ece0a6c12db5d3faf3e49154598da63 100644 (file)
@@ -104,8 +104,8 @@ test()
 
 
   // We flag the first half of all cells to be refined and the last half of all
-  // cells to be coarsened for p adapativity. Ultimately, the first quarter of
-  // all cells will be flagged for p refinement, and the last quarter for p
+  // cells to be coarsened for p-adapativity. Ultimately, the first quarter of
+  // all cells will be flagged for p-refinement, and the last quarter for p-
   // coarsening.
 
   Vector<double> indicators(tria.n_active_cells());
index 20f2a35ef47e506a97774d83465154a43537449c..1aaa77c55a93d88a9ea6af51fef96119f50bc458 100644 (file)
@@ -226,7 +226,7 @@ namespace Step27
                                              Functions::ZeroFunction<dim>(),
                                              constraints);
 #ifdef DEBUG
-    // We did not think about hp constraints on ghost cells yet.
+    // We did not think about hp-constraints on ghost cells yet.
     // Thus, we are content with verifying their consistency for now.
     IndexSet locally_active_dofs;
     DoFTools::extract_locally_active_dofs(dof_handler, locally_active_dofs);
index cd1aeb27c97366d045eba233da67ce7eef53f365..061e2b7b073f8b9b7f749e3472a97ec252e680c0 100644 (file)
@@ -16,7 +16,7 @@
 
 
 // check interpolation of boundary values for complex-valued
-// objects and the hp case
+// objects and the hp-case
 
 
 #include <deal.II/base/function_lib.h>

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.