]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Fix constness of argument in FE::interpolate() 3834/head
authorTimo Heister <timo.heister@gmail.com>
Mon, 23 Jan 2017 01:38:35 +0000 (20:38 -0500)
committerTimo Heister <timo.heister@gmail.com>
Mon, 23 Jan 2017 01:39:22 +0000 (20:39 -0500)
Reported by MSVC.

17 files changed:
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_dg_vector.templates.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
source/fe/fe_abf.cc
source/fe/fe_nedelec.cc
source/fe/fe_q_bubbles.cc
source/fe/fe_q_dg0.cc
source/fe/fe_rannacher_turek.cc
source/fe/fe_raviart_thomas.cc
source/fe/fe_raviart_thomas_nodal.cc

index 0202f6767db3b2e66db85c39b6c61fdb71908222..c05cedd3fec2c6ab85f099aa10ec37be2ab23798 100644 (file)
@@ -124,10 +124,10 @@ 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;
   virtual void interpolate(std::vector<double>                &local_dofs,
                            const std::vector<Vector<double> > &values,
-                           unsigned int offset = 0) const;
+                           const unsigned int                  offset = 0) const;
   virtual void interpolate(
     std::vector<double> &local_dofs,
     const VectorSlice<const std::vector<std::vector<double> > > &values) const;
index c49e225dc1e1c65c03a49b8b6784e9cb92693c06..b82b1a2cc4260dbad3fa3026f5853cc254d815b8 100644 (file)
@@ -73,10 +73,10 @@ 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;
   virtual void interpolate(std::vector<double>                &local_dofs,
                            const std::vector<Vector<double> > &values,
-                           unsigned int offset = 0) const;
+                           const unsigned int                  offset = 0) const;
   virtual void interpolate(
     std::vector<double> &local_dofs,
     const VectorSlice<const std::vector<std::vector<double> > > &values) const;
index c08df9df40fe6ac3365746558aba1dd9b7e9ce82..162c87d2d99458ada20ce639326f864ae4ea9d78 100644 (file)
@@ -81,10 +81,10 @@ 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;
   virtual void interpolate(std::vector<double>                &local_dofs,
                            const std::vector<Vector<double> > &values,
-                           unsigned int offset = 0) const;
+                           const unsigned int                  offset = 0) const;
   virtual void interpolate(
     std::vector<double> &local_dofs,
     const VectorSlice<const std::vector<std::vector<double> > > &values) const;
index 63052b2593365bc36442df3a2b2a2766e88ccbca..96a69334e69bcdb35c610fbf6af81f54e583cf03 100644 (file)
@@ -105,7 +105,7 @@ void
 FE_DGVector<PolynomialType,dim,spacedim>::interpolate
 (std::vector<double> & /*local_dofs*/,
  const std::vector<Vector<double> > & /*values*/,
- unsigned int /*offset*/) const
const unsigned int /*offset*/) const
 {
   Assert(false, ExcNotImplemented());
 }
index 6e085d44abfbf3b240f45bd5f7fe82af506ff66f..76ca5beecd593fe873701c41da94e6197478acd4 100644 (file)
@@ -260,7 +260,7 @@ public:
 
   virtual void interpolate (std::vector<double> &local_dofs,
                             const std::vector<Vector<double> > &values,
-                            unsigned int offset = 0) const;
+                            const unsigned int offset = 0) const;
   virtual void interpolate (std::vector<double> &local_dofs,
                             const VectorSlice<const std::vector<std::vector<double> > > &values)
   const;
index f6261669af6d24aded08a644c21566af4a9bc4b2..38a512607377c74d05f4037981eb0fbe3b640f53 100644 (file)
@@ -123,7 +123,7 @@ public:
    */
   virtual void interpolate(std::vector<double>                &local_dofs,
                            const std::vector<Vector<double> > &values,
-                           unsigned int offset = 0) const;
+                           const unsigned int                  offset = 0) const;
 
   /**
    * Interpolate a set of vector values, computed in the generalized support
index 28c24b63478d69704942e0c164b394080ad37d5b..bc98739be518ad5ffff6254efd0664cc5936b8d1 100644 (file)
@@ -276,7 +276,7 @@ public:
    */
   virtual void interpolate(std::vector<double>                &local_dofs,
                            const std::vector<Vector<double> > &values,
-                           unsigned int offset = 0) const;
+                           const unsigned int                  offset = 0) const;
 
   /**
    * Interpolate a set of vector values, computed in the generalized support
index 682f1a75ef7ca410f18be62a4b1b357f55f6a2f8..0beb22d7c65e43abb38524a3040417488fab7a8b 100644 (file)
@@ -701,7 +701,7 @@ public:
   void
   interpolate(std::vector<double>                &local_dofs,
               const std::vector<Vector<double> > &values,
-              unsigned int offset = 0) const;
+              const unsigned int offset = 0) const;
 
   /**
    * This function is not implemented and throws an exception if called.
index 27c6370c251353d0536f2bce8407d42f42b88d77..28dff634fa05a8773431cd8e969b05f7ce4f46ef 100644 (file)
@@ -73,7 +73,7 @@ public:
   virtual void interpolate(
     std::vector<double> &local_dofs,
     const std::vector<Vector<double> > &values,
-    unsigned int offset) const;
+    const unsigned int offset = 0) const;
   virtual void interpolate(
     std::vector<double> &local_dofs,
     const VectorSlice<const std::vector<std::vector<double> > > &values) const;
index 4fd67eaccfd6728a11ed121b5aede4037a1cbcb9..c49d7ddf6ebe57ccda515c21047a856afc7bc7a0 100644 (file)
@@ -129,10 +129,10 @@ 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;
   virtual void interpolate(std::vector<double>                &local_dofs,
                            const std::vector<Vector<double> > &values,
-                           unsigned int offset = 0) const;
+                           const unsigned int                  offset = 0) const;
   virtual void interpolate(
     std::vector<double> &local_dofs,
     const VectorSlice<const std::vector<std::vector<double> > > &values) const;
@@ -263,7 +263,7 @@ public:
                            const std::vector<double> &values) const;
   virtual void interpolate(std::vector<double>                &local_dofs,
                            const std::vector<Vector<double> > &values,
-                           unsigned int offset = 0) const;
+                           const unsigned int                  offset = 0) const;
   virtual void interpolate(
     std::vector<double> &local_dofs,
     const VectorSlice<const std::vector<std::vector<double> > > &values) const;
index 97d04e44e6a0802c467caeeb9983791e0dab1075..eb95d35e72dbe42d5a723e9381cda89d14c02fc3 100644 (file)
@@ -524,7 +524,7 @@ void
 FE_ABF<dim>::interpolate(
   std::vector<double>    &local_dofs,
   const std::vector<Vector<double> > &values,
-  unsigned int offset) const
+  const unsigned int offset) const
 {
   Assert (values.size() == this->generalized_support_points.size(),
           ExcDimensionMismatch(values.size(), this->generalized_support_points.size()));
index 85cbc3a981d267e481787d7dc07d71afaae8482f..f093b71614fdeafcb90b68f447da6bd662f3dfbc 100644 (file)
@@ -3105,7 +3105,7 @@ template <int dim>
 void
 FE_Nedelec<dim>::interpolate (std::vector<double> &local_dofs,
                               const std::vector<Vector<double> > &values,
-                              unsigned int offset) const
+                              const unsigned int offset) const
 {
   const unsigned int deg = this->degree-1;
 
index a7a7e6b86cc544642fae2818ecdbf8f2f40f4aa0..9f73b611a08970a14f49fea36b76d35f19f8c0be 100644 (file)
@@ -355,7 +355,7 @@ template <int dim, int spacedim>
 void
 FE_Q_Bubbles<dim,spacedim>::interpolate(std::vector<double>    &local_dofs,
                                         const std::vector<Vector<double> > &values,
-                                        unsigned int offset) const
+                                        const unsigned int offset) const
 {
   Assert (values.size() == this->unit_support_points.size(),
           ExcDimensionMismatch(values.size(),
index 4e0fe23ab31d456df7898eb60cbec5d4a23cb524..e9344f2c5d32abbd08414eb64a6738cf749df27f 100644 (file)
@@ -199,7 +199,7 @@ template <int dim, int spacedim>
 void
 FE_Q_DG0<dim,spacedim>::interpolate(std::vector<double>    &local_dofs,
                                     const std::vector<Vector<double> > &values,
-                                    unsigned int offset) const
+                                    const unsigned int offset) const
 {
   Assert (values.size() == this->unit_support_points.size(),
           ExcDimensionMismatch(values.size(),
index 9b5dbdaa48e1598aaff19b7a041d57489c3b386c..034d8eeb03758c930a782754235fba2577f23eec 100644 (file)
@@ -133,7 +133,7 @@ template <int dim>
 void FE_RannacherTurek<dim>::interpolate(
   std::vector<double> &local_dofs,
   const std::vector<Vector<double> > &values,
-  unsigned int offset) const
+  const unsigned int offset) const
 {
   AssertDimension(values.size(), this->generalized_support_points.size());
   AssertDimension(local_dofs.size(), this->dofs_per_cell);
index e21f8db1edb140611c06330f42e5555ce41ec4c6..8ecaf65c316f26fc7028612447f49b2b61b9f77b 100644 (file)
@@ -477,7 +477,7 @@ void
 FE_RaviartThomas<dim>::interpolate(
   std::vector<double>    &local_dofs,
   const std::vector<Vector<double> > &values,
-  unsigned int offset) const
+  const unsigned int offset) const
 {
   Assert (values.size() == this->generalized_support_points.size(),
           ExcDimensionMismatch(values.size(), this->generalized_support_points.size()));
index 6b9a1e1bc15b14e3e4d3f388943f05c5433ab4d1..db2bc592fed2b4824fa51699a153d5fb085887e7 100644 (file)
@@ -295,7 +295,7 @@ void
 FE_RaviartThomasNodal<dim>::interpolate(
   std::vector<double>    &local_dofs,
   const std::vector<Vector<double> > &values,
-  unsigned int offset) const
+  const unsigned int offset) const
 {
   Assert (values.size() == this->generalized_support_points.size(),
           ExcDimensionMismatch(values.size(), this->generalized_support_points.size()));

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.