]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Augment documentation
authorMatthias Maier <tamiko@43-1.org>
Fri, 15 Sep 2017 15:35:35 +0000 (10:35 -0500)
committerMatthias Maier <tamiko@43-1.org>
Sun, 17 Sep 2017 20:26:40 +0000 (15:26 -0500)
include/deal.II/fe/fe.h
include/deal.II/fe/fe_tools.h

index b55fdcec1a43bf534dd86cb426ad22a29702f30a..d9deb79c06f800e550645f734f60c3dc0e5cb78f 100644 (file)
@@ -1972,15 +1972,17 @@ public:
    */
   bool has_generalized_support_points () const;
 
-//FIXME
   /**
    * Return the equivalent to get_generalized_support_points(), except
    * for faces.
+   *
+   * @deprecated In general, it is not possible to associate a unique
+   * subset of generalized support points describing degrees of freedom for
+   * a given face. Don't use this function
    */
   const std::vector<Point<dim-1> > &
-  get_generalized_face_support_points () const;
+  get_generalized_face_support_points () const DEAL_II_DEPRECATED;
 
-//FIXME
   /**
    * Return whether a finite element has defined generalized support points on
    * faces. If the result is true, then a call to the
@@ -1988,9 +1990,13 @@ public:
    *
    * For more information, see the documentation for the has_support_points()
    * function.
+   *
+   * @deprecated In general, it is not possible to associate a unique
+   * subset of generalized support points describing degrees of freedom for
+   * a given face. Don't use this function
    */
   bool
-  has_generalized_face_support_points () const;
+  has_generalized_face_support_points () const DEAL_II_DEPRECATED;
 
   /**
    * For a given degree of freedom, return whether it is logically associated
index 1d28e058bcee77ea2fc4c8fa17605f5082f1c11f..e9b7962f3d2146cb771f21564d32e22ed96a8acb 100644 (file)
@@ -572,16 +572,21 @@ namespace FETools
    * FiniteElement::convert_generalized_support_point_values_to_dof_values()
    * that works with arbitrary number types.
    *
-   * If the number type is double this function simply calls the
-   * FiniteElement::convert_generalized_support_point_values_to_dof_values()
-   * directly. Otherwise, temporary (per-thread storage) is used to call to
-   * above function.
+   * @param[in] finite_element The FiniteElement to compute dof values for.
+   * @param[in] support_point_values An array of size @p dofs_per_cell
+   *   (which equals the number of points the get_generalized_support_points()
+   *   function will return) where each element is a vector with as many entries
+   *   as the element has vector components. This array should contain
+   *   the values of a function at the generalized support points of the
+   *   finite element.
+   * @param[out] dof_values An array of size @p dofs_per_cell that contains
+   *   the node functionals of the element applied to the given function.
    */
   template <int dim, int spacedim, typename number>
   void convert_generalized_support_point_values_to_dof_values(
     const FiniteElement<dim, spacedim> &finite_element,
     const std::vector<Vector<number> > &support_point_values,
-    std::vector<number>                &nodal_values);
+    std::vector<number>                &dof_values);
 
 
 

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.