]> https://gitweb.dealii.org/ - dealii.git/commitdiff
More doc updates.
authorWolfgang Bangerth <bangerth@math.tamu.edu>
Thu, 15 Jun 2000 07:54:44 +0000 (07:54 +0000)
committerWolfgang Bangerth <bangerth@math.tamu.edu>
Thu, 15 Jun 2000 07:54:44 +0000 (07:54 +0000)
git-svn-id: https://svn.dealii.org/trunk@3021 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/deal.II/include/fe/fe.h

index d84002b32e36c47d0b2b36080946629c884d8ab3..e1ed7b6bb2b86022a7b7bc9479281bd7fbdb9ee1 100644 (file)
@@ -214,6 +214,8 @@ class FiniteElementData
 };
 
 
+
+
 /**
  * Base class for finite elements in arbitrary dimensions. This class provides
  * several fields which describe a specific finite element and which are filled
@@ -729,12 +731,19 @@ class FiniteElementBase : public Subscriptor,
 };
 
 
+
+
 /**
  * Finite Element in any dimension. This class declares the
  * functionality to fill the fields of the #FiniteElementBase#
  * class. Since this is something that depends on the actual finite
  * element, the functions are declared virtual if it is not possible
- * to provide a reasonable standard implementation.
+ * to provide a reasonable standard implementation. Note that you will
+ * only seldomly use the functionality of this class in application
+ * programs, as you will normally be interested in the values and
+ * derivatives of shape functions on cells in physical space, rather
+ * than on the unit cell. In that case, you will have to use the
+ * #FEValues# class and its siblings.
  *
  *
  * \subsection{Finite elements in one dimension}
@@ -1066,21 +1075,24 @@ class FiniteElement : public FiniteElementBase<dim>
                                           const Point<dim>   &p) const = 0;
 
                                     /**
-                                     * Return the value of the #i#th shape
-                                     * function of the transformation mapping
-                                     * from unit cell to real cell. For
-                                     * isoparametric elements, this function
-                                     * is the same as the trial functions,
-                                     * but for sublinear or other mappings,
+                                     * Return the value of the #i#th
+                                     * shape function of the
+                                     * transformation mapping from
+                                     * unit cell to real cell. For
+                                     * isoparametric elements, this
+                                     * function is the same as the
+                                     * trial functions, but for
+                                     * sublinear or other mappings,
                                      * they differ.
                                      */
     virtual double shape_value_transform (const unsigned int i,
                                          const Point<dim> &p) const = 0;
 
                                     /**
-                                     * Same as above: return gradient of the
-                                     * #i#th shape function for the mapping
-                                     * from unit to real cell.
+                                     * Same as above: return gradient
+                                     * of the #i#th shape function
+                                     * for the mapping from unit to
+                                     * real cell.
                                      */
     virtual Tensor<1,dim> shape_grad_transform (const unsigned int i,
                                                const Point<dim> &p) const = 0;    
@@ -1696,6 +1708,7 @@ FiniteElementData<dim>::n_dofs_per_vertex () const
 };
 
 
+
 template <int dim>
 inline
 unsigned int 
@@ -1705,6 +1718,7 @@ FiniteElementData<dim>::n_dofs_per_line () const
 };
 
 
+
 template <int dim>
 inline
 unsigned int 
@@ -1714,6 +1728,7 @@ FiniteElementData<dim>::n_dofs_per_quad () const
 };
 
 
+
 template <int dim>
 inline
 unsigned int 
@@ -1723,6 +1738,7 @@ FiniteElementData<dim>::n_dofs_per_hex () const
 };
 
 
+
 template <int dim>
 inline
 unsigned int 
@@ -1732,6 +1748,7 @@ FiniteElementData<dim>::n_dofs_per_face () const
 };
 
 
+
 template <int dim>
 inline
 unsigned int 
@@ -1741,6 +1758,7 @@ FiniteElementData<dim>::n_dofs_per_cell () const
 };
 
 
+
 template <int dim>
 inline
 unsigned int 
@@ -1750,6 +1768,7 @@ FiniteElementData<dim>::n_components () const
 };
 
 
+
 template <int dim>
 inline
 unsigned int 
@@ -1759,6 +1778,7 @@ FiniteElementData<dim>::n_transform_functions () const
 };
 
 
+
 template <int dim>
 inline
 unsigned int
@@ -1774,6 +1794,7 @@ FiniteElementBase<dim>::component_to_system_index (unsigned int component,
 }
 
 
+
 template <int dim>  
 inline
 pair<unsigned int,unsigned int>
@@ -1785,6 +1806,7 @@ FiniteElementBase<dim>::system_to_component_index (unsigned int index) const
 }
 
 
+
 template <int dim>
 inline
 unsigned int
@@ -1800,6 +1822,7 @@ FiniteElementBase<dim>::face_component_to_system_index (unsigned int component,
 }
 
 
+
 template <int dim>  
 inline
 pair<unsigned int,unsigned int>
@@ -1811,6 +1834,7 @@ FiniteElementBase<dim>::face_system_to_component_index (unsigned int index) cons
 }
 
 
+
 template <int dim>  
 inline
 unsigned int
@@ -1824,6 +1848,7 @@ FiniteElementBase<dim>::component_to_base (unsigned int index) const
 }
 
 
+
 template <int dim>
 inline
 bool

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.