From 6b9b043a2e052011c343a3c16532a4e0dc557924 Mon Sep 17 00:00:00 2001 From: Maien Hamed Date: Tue, 8 Sep 2015 09:38:16 +0200 Subject: [PATCH] removed the no longer necessary FiniteElement::differences and ::fd_step_length --- include/deal.II/fe/fe.h | 16 ---------------- source/fe/fe.cc | 16 +--------------- 2 files changed, 1 insertion(+), 31 deletions(-) diff --git a/include/deal.II/fe/fe.h b/include/deal.II/fe/fe.h index ca8ee1035a..c5a990ff67 100644 --- a/include/deal.II/fe/fe.h +++ b/include/deal.II/fe/fe.h @@ -565,15 +565,6 @@ public: */ virtual std::size_t memory_consumption () const; - /** - * Storage for FEValues objects needed to approximate second derivatives. - * - * The ordering is p+hx, p+hy, p+hz, p-hx, - * p-hy, p-hz, where unused entries in lower dimensions are - * missing. - */ - std::vector*> differences; - private: /** * Initially set to true, but reset to false when clear_first_cell() @@ -2184,13 +2175,6 @@ protected: */ const std::vector 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 diff --git a/source/fe/fe.cc b/source/fe/fe.cc index 291eabc240..4bf0d9cc12 100644 --- a/source/fe/fe.cc +++ b/source/fe/fe.cc @@ -34,10 +34,6 @@ DEAL_II_NAMESPACE_OPEN /*------------------------------- FiniteElement ----------------------*/ -template -const double FiniteElement::fd_step_length = 1.0e-6; - - template FiniteElement::InternalDataBase::InternalDataBase (): update_flags(update_default), @@ -50,17 +46,7 @@ FiniteElement::InternalDataBase::InternalDataBase (): template FiniteElement::InternalDataBase::~InternalDataBase () -{ - for (unsigned int i=0; i