]> https://gitweb.dealii.org/ - dealii.git/commitdiff
removed the no longer necessary FiniteElement::differences and ::fd_step_length 1551/head
authorMaien Hamed <tomaien@hotmail.com>
Tue, 8 Sep 2015 07:38:16 +0000 (09:38 +0200)
committerMaien Hamed <tomaien@hotmail.com>
Tue, 8 Sep 2015 08:00:59 +0000 (10:00 +0200)
include/deal.II/fe/fe.h
source/fe/fe.cc

index ca8ee1035a02c78c60e4d1efc7307020bc3e852f..c5a990ff67bb69c6e29d8052b4346826e45a7d31 100644 (file)
@@ -565,15 +565,6 @@ public:
      */
     virtual std::size_t memory_consumption () const;
 
-    /**
-     * Storage for FEValues objects needed to approximate second derivatives.
-     *
-     * The ordering is <i>p+hx</i>, <i>p+hy</i>, <i>p+hz</i>, <i>p-hx</i>,
-     * <i>p-hy</i>, <i>p-hz</i>, where unused entries in lower dimensions are
-     * missing.
-     */
-    std::vector<FEValues<dim,spacedim>*> differences;
-
   private:
     /**
      * Initially set to true, but reset to false when clear_first_cell()
@@ -2184,13 +2175,6 @@ protected:
    */
   const std::vector<unsigned int> n_nonzero_components_table;
 
-  /**
-   * Second derivatives of shapes functions are not computed analytically, but
-   * by finite differences of the gradients. This static variable denotes the
-   * step length to be used for that. It's value is set to 1e-6.
-   */
-  static const double fd_step_length;
-
   /**
    * Return the size of interface constraint matrices. Since this is needed in
    * every derived finite element class when initializing their size, it is
index 291eabc2404c7bbc660aca4f781c21fee3d3ee90..4bf0d9cc123d00e26e2670adcfe76a31223bb594 100644 (file)
@@ -34,10 +34,6 @@ DEAL_II_NAMESPACE_OPEN
 /*------------------------------- FiniteElement ----------------------*/
 
 
-template <int dim, int spacedim>
-const double FiniteElement<dim,spacedim>::fd_step_length = 1.0e-6;
-
-
 template <int dim, int spacedim>
 FiniteElement<dim, spacedim>::InternalDataBase::InternalDataBase ():
   update_flags(update_default),
@@ -50,17 +46,7 @@ FiniteElement<dim, spacedim>::InternalDataBase::InternalDataBase ():
 
 template <int dim, int spacedim>
 FiniteElement<dim,spacedim>::InternalDataBase::~InternalDataBase ()
-{
-  for (unsigned int i=0; i<differences.size (); ++i)
-    if (differences[i] != 0)
-      {
-        // delete pointer and set it
-        // to zero to avoid
-        // inadvertent use
-        delete differences[i];
-        differences[i] = 0;
-      }
-}
+{}
 
 
 

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.