]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Fixed documentation and a few const.
authorLuca Heltai <luca.heltai@sissa.it>
Sat, 25 Jul 2015 16:55:21 +0000 (18:55 +0200)
committerTimo Heister <timo.heister@gmail.com>
Sun, 26 Jul 2015 21:42:21 +0000 (17:42 -0400)
Conflicts:
doc/news/changes.h

doc/news/8.2.1-vs-8.3.0.h
include/deal.II/numerics/vector_tools.h
include/deal.II/numerics/vector_tools.templates.h

index 5334f601f3801be42bb8159a647618573476d25d..bc8898b02806bb23f1dd0df3f86e9ed521506335 100644 (file)
@@ -548,6 +548,14 @@ inconvenience this causes.
 
 
 <ol>
+  <li> New: VectorTools::get_position_vector now works with arbitrary
+  FESystems, provided that the geometrical components are primitive, 
+  and that you provide a component mask to select what components of 
+  the finite element to use for the geometrical interpolation.
+  <br>
+  (Luca Heltai, 2015/07/25)
+  </li>
+
   <li> Fixed: parallel::distributed::refine_and_coarsen_fixed_fraction()
   in rare circumstances decided to not refine any cells at all, even
   if the refinement threshold was nonzero. This is now fixed.
index 142950baaee27b1c92f09c1b7afcb97301448994..7d0608694a7b78b148f7950aa9dcd1ab79db8c0c 100644 (file)
@@ -2345,17 +2345,15 @@ namespace VectorTools
    */
   //@{
   /**
-   * Given a DoFHandler containing at least a spacedim vector field, this
-   * function interpolates the Triangulation at the support points of a FE_Q()
-   * finite element of the same degree as dh->get_fe().degree.
+   * Given a DoFHandler containing at least a spacedim vector field,
+   * this function interpolates the Triangulation at the support
+   * points of a FE_Q() finite element of the same degree as the
+   * degree of the required components.
    *
    * Curved manifold are respected, and the resulting VECTOR will be
-   * geometrically consistent.
-   *
-   * The resulting map is guaranteed to be interpolatory at the support points
-   * of a FE_Q() finite element of the same degree as dh->get_fe().degree.
-   * Notice that this may or may not be meaningful, depending on the
-   * FiniteElement you have distributed in dh.
+   * geometrically consistent. The resulting map is guaranteed to be
+   * interpolatory at the support points of a FE_Q() finite element of
+   * the same degree as the degree of the required components.
    *
    * If the underlying finite element is an FE_Q(1)^spacedim, then the
    * resulting VECTOR is a finite element field representation of the vertices
@@ -2367,6 +2365,9 @@ namespace VectorTools
    * the first spacedim components of the FiniteElement are assumed to
    * represent the geometry of the problem.
    *
+   * This function is only implemented for FiniteElements where the
+   * specified components are primitive.
+   *
    * @author Luca Heltai, 2015
    */
   template<class DH, class VECTOR>
index 714cf9a6e7f27d95d2345b9a7e2f24da649b3875..452424eff12333dec2750e29538139b80e33122a 100644 (file)
@@ -7183,13 +7183,19 @@ namespace VectorTools
         for (unsigned int i=0; i<fe_mask.size(); ++i)
           if (fe_mask[i])
             {
-              unsigned int base_i = fe_system->component_to_base_index(i).first;
+              const unsigned int base_i = fe_system->component_to_base_index(i).first;
               Assert(degree == numbers::invalid_unsigned_int ||
                      degree == fe_system->base_element(base_i).degree,
                      ExcNotImplemented());
+              Assert(fe_system->base_element(base_i).is_primitive(),
+                     ExcNotImplemented());
               degree = fe_system->base_element(base_i).degree;
             }
 
+        // We create an intermediate FE_Q vector space, and then
+        // interpolate from that vector space to this one, by
+        // carefully selecting the right components.
+
         FESystem<dim,spacedim> feq(FE_Q<dim,spacedim>(degree), spacedim);
         DH dhq(dh.get_tria());
         dhq.distribute_dofs(feq);
@@ -7211,11 +7217,17 @@ namespace VectorTools
         // v_j phi_j(q_i) = w_k psi_k(q_i) = w_k delta_ki = w_i
         //
         // where psi_k are the basis functions for fe_q, and phi_i are
-        // the basis functions of the target space.
+        // the basis functions of the target space while q_i are the
+        // support points for the fe_q space. With this choice of
+        // interpolation points, on the matrices is the identity
+        // matrix, and we have to invert only one matrix. The
+        // resulting vector will be interpolatory at the support
+        // points of fe_q, even if the finite element does not have
+        // support points.
         //
         // Morally, we should invert the matrix T_ij = phi_i(q_j),
         // however in general this matrix is not invertible, since
-        // there may by components which do not contribute to the
+        // there may be components which do not contribute to the
         // displacement vector. Since we are not interested in those
         // components, we construct a square matrix with the same
         // number of components of the FE_Q system. The FE_Q system
@@ -7239,7 +7251,7 @@ namespace VectorTools
 
         for (unsigned int j=0; j<fe.dofs_per_cell; ++j)
           {
-            unsigned int comp_j = fe.system_to_component_index(j).first;
+            const unsigned int comp_j = fe.system_to_component_index(j).first;
             if (fe_mask[comp_j])
               for (unsigned int i=0; i<points.size(); ++i)
                 {

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.