]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Convert FE::compute_2nd().
authorWolfgang Bangerth <bangerth@math.tamu.edu>
Fri, 31 Jul 2015 21:25:35 +0000 (16:25 -0500)
committerWolfgang Bangerth <bangerth@math.tamu.edu>
Fri, 31 Jul 2015 21:25:35 +0000 (16:25 -0500)
It only uses finite element related data. Let this be the only
argument it gets.

include/deal.II/fe/fe.h
source/fe/fe.cc

index 3242f99b8c7b8a5a334c50246d312873ddc125dc..1491521bd2176b499046bd10286becd8067f805e 100644 (file)
@@ -20,6 +20,7 @@
 #include <deal.II/base/geometry_info.h>
 #include <deal.II/fe/fe_base.h>
 #include <deal.II/fe/fe_values_extractors.h>
+#include <deal.II/fe/fe_update_flags.h>
 #include <deal.II/fe/component_mask.h>
 #include <deal.II/fe/block_mask.h>
 #include <deal.II/fe/mapping.h>
@@ -1969,12 +1970,12 @@ protected:
   /**
    * Compute second derivatives by finite differences of gradients.
    */
-  void compute_2nd (const Mapping<dim,spacedim>                      &mapping,
+  void compute_2nd (const Mapping<dim,spacedim>                                  &mapping,
                     const typename Triangulation<dim,spacedim>::cell_iterator    &cell,
-                    const unsigned int                       offset,
-                    const typename Mapping<dim,spacedim>::InternalDataBase &mapping_internal,
-                    const InternalDataBase                        &fe_internal,
-                    FEValuesData<dim,spacedim>                       &data) const;
+                    const unsigned int                                            offset,
+                    const typename Mapping<dim,spacedim>::InternalDataBase       &mapping_internal,
+                    const InternalDataBase                                       &fe_internal,
+                    internal::FEValues::FiniteElementRelatedData<dim,spacedim>   &data) const;
 
   /**
    * Given the pattern of nonzero components for each shape function, compute
index 9c5234a027092192208c3924225969df28bcc738..df3cf0302b046066039ed583138ca9249b85d5c8 100644 (file)
@@ -1220,7 +1220,7 @@ FiniteElement<1,2>::compute_2nd (
   const unsigned int,
   const Mapping<1,2>::InternalDataBase &,
   const InternalDataBase &,
-  FEValuesData<1,2> &) const
+  internal::FEValues::FiniteElementRelatedData<1,2> &) const
 {
   Assert(false, ExcNotImplemented());
 }
@@ -1234,7 +1234,7 @@ FiniteElement<1,3>::compute_2nd (
   const unsigned int,
   const Mapping<1,3>::InternalDataBase &,
   const InternalDataBase &,
-  FEValuesData<1,3> &) const
+  internal::FEValues::FiniteElementRelatedData<1,3> &) const
 {
   Assert(false, ExcNotImplemented());
 }
@@ -1249,7 +1249,7 @@ FiniteElement<2,3>::compute_2nd (
   const unsigned int,
   const Mapping<2,3>::InternalDataBase &,
   const InternalDataBase &,
-  FEValuesData<2,3> &) const
+  internal::FEValues::FiniteElementRelatedData<2,3> &) const
 {
   Assert(false, ExcNotImplemented());
 }
@@ -1264,7 +1264,7 @@ FiniteElement<dim,spacedim>::compute_2nd (
   const unsigned int offset,
   const typename Mapping<dim,spacedim>::InternalDataBase &mapping_internal,
   const InternalDataBase                     &fe_internal,
-  FEValuesData<dim,spacedim>                    &data) const
+  internal::FEValues::FiniteElementRelatedData<dim,spacedim>                    &data) const
 {
   Assert ((fe_internal.update_each | fe_internal.update_once)
           & update_hessians,

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.