From 7fc26bede3780f8defdc310a889b36c667cc9b5a Mon Sep 17 00:00:00 2001 From: Wolfgang Bangerth Date: Sun, 16 Apr 2017 18:35:25 -0600 Subject: [PATCH] Remove implementation of FE::interpolate() from FE_Q_DGQ0. --- include/deal.II/fe/fe_q_dg0.h | 10 ----- source/fe/fe_q_dg0.cc | 75 ----------------------------------- 2 files changed, 85 deletions(-) diff --git a/include/deal.II/fe/fe_q_dg0.h b/include/deal.II/fe/fe_q_dg0.h index ddb27bdbc8..7bc73548bd 100644 --- a/include/deal.II/fe/fe_q_dg0.h +++ b/include/deal.II/fe/fe_q_dg0.h @@ -264,16 +264,6 @@ public: convert_generalized_support_point_values_to_nodal_values (const std::vector > &support_point_values, std::vector &nodal_values) const; - virtual void interpolate(std::vector &local_dofs, - const std::vector &values) const DEAL_II_DEPRECATED; - - virtual void interpolate(std::vector &local_dofs, - const std::vector > &values, - const unsigned int offset = 0) const DEAL_II_DEPRECATED; - - virtual void interpolate(std::vector &local_dofs, - const VectorSlice > > &values) const DEAL_II_DEPRECATED; - /** * Return the matrix interpolating from the given finite element to the * present one. The size of the matrix is then @p dofs_per_cell times diff --git a/source/fe/fe_q_dg0.cc b/source/fe/fe_q_dg0.cc index f8c61fe8ef..6a6bc3c3e1 100644 --- a/source/fe/fe_q_dg0.cc +++ b/source/fe/fe_q_dg0.cc @@ -201,81 +201,6 @@ convert_generalized_support_point_values_to_nodal_values(const std::vector -void -FE_Q_DG0::interpolate(std::vector &local_dofs, - const std::vector &values) const -{ - Assert (values.size() == this->unit_support_points.size(), - ExcDimensionMismatch(values.size(), - this->unit_support_points.size())); - Assert (local_dofs.size() == this->dofs_per_cell, - ExcDimensionMismatch(local_dofs.size(),this->dofs_per_cell)); - Assert (this->n_components() == 1, - ExcDimensionMismatch(this->n_components(), 1)); - - std::copy(values.begin(), values.end(), local_dofs.begin()); - - // We don't need the discontinuous function for local interpolation - local_dofs[local_dofs.size()-1] = 0.; -} - - - -template -void -FE_Q_DG0::interpolate(std::vector &local_dofs, - const std::vector > &values, - const unsigned int offset) const -{ - Assert (values.size() == this->unit_support_points.size(), - ExcDimensionMismatch(values.size(), - this->unit_support_points.size())); - Assert (local_dofs.size() == this->dofs_per_cell, - ExcDimensionMismatch(local_dofs.size(),this->dofs_per_cell)); - Assert (values[0].size() >= offset+this->n_components(), - ExcDimensionMismatch(values[0].size(),offset+this->n_components())); - - for (unsigned int i=0; idofs_per_cell-1; ++i) - { - const std::pair index - = this->system_to_component_index(i); - local_dofs[i] = values[i](offset+index.first); - } - - // We don't need the discontinuous function for local interpolation - local_dofs[local_dofs.size()-1] = 0.; -} - - - -template -void -FE_Q_DG0::interpolate( - std::vector &local_dofs, - const VectorSlice > > &values) const -{ - Assert (values[0].size() == this->unit_support_points.size(), - ExcDimensionMismatch(values.size(), - this->unit_support_points.size())); - Assert (local_dofs.size() == this->dofs_per_cell, - ExcDimensionMismatch(local_dofs.size(),this->dofs_per_cell)); - Assert (values.size() == this->n_components(), - ExcDimensionMismatch(values.size(), this->n_components())); - - for (unsigned int i=0; idofs_per_cell-1; ++i) - { - const std::pair index - = this->system_to_component_index(i); - local_dofs[i] = values[index.first][i]; - } - - // We don't need the discontinuous function for local interpolation - local_dofs[local_dofs.size()-1] = 0.; -} - - - template void FE_Q_DG0:: -- 2.39.5