]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Deprecate FiniteElement::interpolate and all its implementations.
authorWolfgang Bangerth <bangerth@colostate.edu>
Tue, 31 Jan 2017 23:26:44 +0000 (16:26 -0700)
committerWolfgang Bangerth <bangerth@colostate.edu>
Fri, 3 Mar 2017 22:07:32 +0000 (15:07 -0700)
include/deal.II/fe/fe.h
include/deal.II/fe/fe_abf.h
include/deal.II/fe/fe_bdm.h
include/deal.II/fe/fe_dg_vector.h
include/deal.II/fe/fe_nedelec.h
include/deal.II/fe/fe_q_bubbles.h
include/deal.II/fe/fe_q_dg0.h
include/deal.II/fe/fe_q_hierarchical.h
include/deal.II/fe/fe_rannacher_turek.h
include/deal.II/fe/fe_raviart_thomas.h

index 95fb372ebb44481b55917f4085c3d7edea237cdb..65076657faef2d52d5834a1554f16d7a14cf3580 100644 (file)
@@ -1941,11 +1941,13 @@ public:
    * element has support points. In this case, the resulting coefficients are
    * just the values in the support points. All other elements must
    * reimplement it.
+   *
+   * @deprecated Use convert_support_point_values_to_nodal_values() instead.
    */
   virtual
   void
   interpolate(std::vector<double>       &local_dofs,
-              const std::vector<double> &values) const;
+              const std::vector<double> &values) const DEAL_II_DEPRECATED;
 
   /**
    * Interpolate a set of vector values, computed in the generalized support
@@ -1955,21 +1957,25 @@ public:
    * <tt>offset</tt> is used to determine the first component of the vector to
    * be interpolated. Maybe consider changing your data structures to use the
    * next function.
+   *
+   * @deprecated Use convert_support_point_values_to_nodal_values() instead.
    */
   virtual
   void
   interpolate(std::vector<double>                &local_dofs,
               const std::vector<Vector<double> > &values,
-              const unsigned int                  offset = 0) const;
+              const unsigned int                  offset = 0) const DEAL_II_DEPRECATED;
 
   /**
    * Interpolate a set of vector values, computed in the generalized support
    * points.
+   *
+   * @deprecated Use convert_support_point_values_to_nodal_values() instead.
    */
   virtual
   void
   interpolate(std::vector<double>                                         &local_dofs,
-              const VectorSlice<const std::vector<std::vector<double> > > &values) const;
+              const VectorSlice<const std::vector<std::vector<double> > > &values) const DEAL_II_DEPRECATED;
 
   //@}
 
index e5957f2b947f55b562d6c52a4683f23faf48ab72..24e3f0b8a2cf0425e5c4ef85242d6565e0edcd8b 100644 (file)
@@ -124,13 +124,15 @@ public:
                                     const unsigned int face_index) const;
 
   virtual void interpolate(std::vector<double>                &local_dofs,
-                           const std::vector<double>          &values) const;
+                           const std::vector<double>          &values) const DEAL_II_DEPRECATED;
+
   virtual void interpolate(std::vector<double>                &local_dofs,
                            const std::vector<Vector<double> > &values,
-                           const unsigned int                  offset = 0) const;
-  virtual void interpolate(
-    std::vector<double> &local_dofs,
-    const VectorSlice<const std::vector<std::vector<double> > > &values) const;
+                           const unsigned int                  offset = 0) const DEAL_II_DEPRECATED;
+
+  virtual void interpolate(std::vector<double> &local_dofs,
+                           const VectorSlice<const std::vector<std::vector<double> > > &values) const DEAL_II_DEPRECATED;
+
   virtual std::size_t memory_consumption () const;
   virtual FiniteElement<dim> *clone() const;
 
index 419b0e5a2a2fc9a810e94b80db582e933a44e61f..e64dd951722bffef51f73bd9ba3007d651dabdee 100644 (file)
@@ -73,13 +73,15 @@ public:
   virtual FiniteElement<dim> *clone () const;
 
   virtual void interpolate(std::vector<double>                &local_dofs,
-                           const std::vector<double>          &values) const;
+                           const std::vector<double>          &values) const DEAL_II_DEPRECATED;
+
   virtual void interpolate(std::vector<double>                &local_dofs,
                            const std::vector<Vector<double> > &values,
-                           const unsigned int                  offset = 0) const;
-  virtual void interpolate(
-    std::vector<double> &local_dofs,
-    const VectorSlice<const std::vector<std::vector<double> > > &values) const;
+                           const unsigned int                  offset = 0) const DEAL_II_DEPRECATED;
+
+  virtual void interpolate(std::vector<double> &local_dofs,
+                           const VectorSlice<const std::vector<std::vector<double> > > &values) const DEAL_II_DEPRECATED;
+
 private:
   /**
    * Only for internal use. Its full name is @p get_dofs_per_object_vector
index 711b9bfcf6649b96b921f0c6d4265f13d526862e..516e14c03c9b29f1b127773bab9e8e70249a2edb 100644 (file)
@@ -81,13 +81,15 @@ public:
                                     const unsigned int face_index) const;
 
   virtual void interpolate(std::vector<double>                &local_dofs,
-                           const std::vector<double>          &values) const;
+                           const std::vector<double>          &values) const DEAL_II_DEPRECATED;
+
   virtual void interpolate(std::vector<double>                &local_dofs,
                            const std::vector<Vector<double> > &values,
-                           const unsigned int                  offset = 0) const;
-  virtual void interpolate(
-    std::vector<double> &local_dofs,
-    const VectorSlice<const std::vector<std::vector<double> > > &values) const;
+                           const unsigned int                  offset = 0) const DEAL_II_DEPRECATED;
+
+  virtual void interpolate(std::vector<double> &local_dofs,
+                           const VectorSlice<const std::vector<std::vector<double> > > &values) const DEAL_II_DEPRECATED;
+
   virtual std::size_t memory_consumption () const;
 
 private:
index c60b94b46916fa4ad5a46dae1642ae437a6c9f67..52a3b0af9d192278d11fee371db9b8dbae093d64 100644 (file)
@@ -256,14 +256,14 @@ public:
                            const RefinementCase<dim> &refinement_case=RefinementCase<dim>::isotropic_refinement) const;
 
   virtual void interpolate (std::vector<double> &local_dofs,
-                            const std::vector<double> &values) const;
+                            const std::vector<double> &values) const DEAL_II_DEPRECATED;
 
   virtual void interpolate (std::vector<double> &local_dofs,
                             const std::vector<Vector<double> > &values,
-                            const unsigned int offset = 0) const;
+                            const unsigned int offset = 0) const DEAL_II_DEPRECATED;
+
   virtual void interpolate (std::vector<double> &local_dofs,
-                            const VectorSlice<const std::vector<std::vector<double> > > &values)
-  const;
+                            const VectorSlice<const std::vector<std::vector<double> > > &values) const DEAL_II_DEPRECATED;
 
   /**
    * Return a list of constant modes of the element.
index 7403b36f2c119878fe8bbaf198c4f523ad1bea57..046d6fd676f75fa94bcec58b1e0b8be7218c775d 100644 (file)
@@ -104,33 +104,15 @@ public:
    */
   virtual std::string get_name () const;
 
-  /**
-   * Interpolate a set of scalar values, computed in the generalized support
-   * points.
-   */
   virtual void interpolate(std::vector<double>       &local_dofs,
-                           const std::vector<double> &values) const;
+                           const std::vector<double> &values) const DEAL_II_DEPRECATED;
 
-  /**
-   * Interpolate a set of vector values, computed in the generalized support
-   * points.
-   *
-   * Since a finite element often only interpolates part of a vector,
-   * <tt>offset</tt> is used to determine the first component of the vector to
-   * be interpolated. Maybe consider changing your data structures to use the
-   * next function.
-   */
   virtual void interpolate(std::vector<double>                &local_dofs,
                            const std::vector<Vector<double> > &values,
-                           const unsigned int                  offset = 0) const;
+                           const unsigned int                  offset = 0) const DEAL_II_DEPRECATED;
 
-  /**
-   * Interpolate a set of vector values, computed in the generalized support
-   * points.
-   */
-  virtual void interpolate(
-    std::vector<double>          &local_dofs,
-    const VectorSlice<const std::vector<std::vector<double> > > &values) const;
+  virtual void interpolate(std::vector<double>          &local_dofs,
+                           const VectorSlice<const std::vector<std::vector<double> > > &values) const DEAL_II_DEPRECATED;
 
   /**
    * Return the matrix interpolating from the given finite element to the
index 5f98ca63b721a851f845f7763abf5ac6b87e3a10..fa3467301fc189bacbdcd64c8446b9c9a72d3f7d 100644 (file)
@@ -258,33 +258,15 @@ public:
    */
   virtual std::string get_name () const;
 
-  /**
-   * Interpolate a set of scalar values, computed in the generalized support
-   * points.
-   */
   virtual void interpolate(std::vector<double>       &local_dofs,
-                           const std::vector<double> &values) const;
+                           const std::vector<double> &values) const DEAL_II_DEPRECATED;
 
-  /**
-   * Interpolate a set of vector values, computed in the generalized support
-   * points.
-   *
-   * Since a finite element often only interpolates part of a vector,
-   * <tt>offset</tt> is used to determine the first component of the vector to
-   * be interpolated. Maybe consider changing your data structures to use the
-   * next function.
-   */
   virtual void interpolate(std::vector<double>                &local_dofs,
                            const std::vector<Vector<double> > &values,
-                           const unsigned int                  offset = 0) const;
+                           const unsigned int                  offset = 0) const DEAL_II_DEPRECATED;
 
-  /**
-   * Interpolate a set of vector values, computed in the generalized support
-   * points.
-   */
-  virtual void interpolate(
-    std::vector<double>          &local_dofs,
-    const VectorSlice<const std::vector<std::vector<double> > > &values) const;
+  virtual void interpolate(std::vector<double>          &local_dofs,
+                           const VectorSlice<const std::vector<std::vector<double> > > &values) const DEAL_II_DEPRECATED;
 
   /**
    * Return the matrix interpolating from the given finite element to the
index c4ecf65be28c95d6a067cf05d95676beaee16fa8..1d7f5b130af01c08573a474ab9bf92ef77dae9f5 100644 (file)
@@ -692,7 +692,7 @@ public:
    */
   virtual
   void interpolate(std::vector<double>       &local_dofs,
-                   const std::vector<double> &values) const;
+                   const std::vector<double> &values) const DEAL_II_DEPRECATED;
 
   /**
    * This function is not implemented and throws an exception if called.
@@ -701,7 +701,7 @@ public:
   void
   interpolate(std::vector<double>                &local_dofs,
               const std::vector<Vector<double> > &values,
-              const unsigned int offset = 0) const;
+              const unsigned int offset = 0) const DEAL_II_DEPRECATED;
 
   /**
    * This function is not implemented and throws an exception if called.
@@ -709,7 +709,7 @@ public:
   virtual
   void
   interpolate(std::vector<double> &local_dofs,
-              const VectorSlice<const std::vector<std::vector<double> > > &values) const;
+              const VectorSlice<const std::vector<std::vector<double> > > &values) const DEAL_II_DEPRECATED;
 
 
 protected:
index cd97b61a39b11b6424a3c4a3afb10ae65dfac16a..5c138583be46b1fe8c1b7e542f7302a3c790c72e 100644 (file)
@@ -67,16 +67,15 @@ public:
   virtual std::string get_name() const;
   virtual FiniteElement<dim> *clone() const;
 
-  virtual void interpolate(
-    std::vector<double> &local_dofs,
-    const std::vector<double> &values) const;
-  virtual void interpolate(
-    std::vector<double> &local_dofs,
-    const std::vector<Vector<double> > &values,
-    const unsigned int offset = 0) const;
-  virtual void interpolate(
-    std::vector<double> &local_dofs,
-    const VectorSlice<const std::vector<std::vector<double> > > &values) const;
+  virtual void interpolate(std::vector<double> &local_dofs,
+                           const std::vector<double> &values) const DEAL_II_DEPRECATED;
+
+  virtual void interpolate(std::vector<double> &local_dofs,
+                           const std::vector<Vector<double> > &values,
+                           const unsigned int offset = 0) const DEAL_II_DEPRECATED;
+
+  virtual void interpolate(std::vector<double> &local_dofs,
+                           const VectorSlice<const std::vector<std::vector<double> > > &values) const DEAL_II_DEPRECATED;
 private:
   /**
    * Order of this element.
index 2f579118398619036b8daf6bf2f233c03e47df43..1e76c5b4f0d1a0c6a22fc11ed94dbc0595a75bc9 100644 (file)
@@ -129,13 +129,14 @@ public:
                                     const unsigned int face_index) const;
 
   virtual void interpolate(std::vector<double>                &local_dofs,
-                           const std::vector<double>          &values) const;
+                           const std::vector<double>          &values) const DEAL_II_DEPRECATED;
+
   virtual void interpolate(std::vector<double>                &local_dofs,
                            const std::vector<Vector<double> > &values,
-                           const unsigned int                  offset = 0) const;
-  virtual void interpolate(
-    std::vector<double> &local_dofs,
-    const VectorSlice<const std::vector<std::vector<double> > > &values) const;
+                           const unsigned int                  offset = 0) const DEAL_II_DEPRECATED;
+
+  virtual void interpolate(std::vector<double> &local_dofs,
+                           const VectorSlice<const std::vector<std::vector<double> > > &values) const DEAL_II_DEPRECATED;
 
   /**
    * Return a list of constant modes of the element. This method is currently
@@ -260,13 +261,14 @@ public:
   virtual FiniteElement<dim> *clone () const;
 
   virtual void interpolate(std::vector<double>                &local_dofs,
-                           const std::vector<double> &values) const;
+                           const std::vector<double> &values) const DEAL_II_DEPRECATED;
+
   virtual void interpolate(std::vector<double>                &local_dofs,
                            const std::vector<Vector<double> > &values,
-                           const unsigned int                  offset = 0) const;
-  virtual void interpolate(
-    std::vector<double> &local_dofs,
-    const VectorSlice<const std::vector<std::vector<double> > > &values) const;
+                           const unsigned int                  offset = 0) const DEAL_II_DEPRECATED;
+
+  virtual void interpolate(std::vector<double> &local_dofs,
+                           const VectorSlice<const std::vector<std::vector<double> > > &values) const DEAL_II_DEPRECATED;
 
 
   virtual void get_face_interpolation_matrix (const FiniteElement<dim> &source,

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.