]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Fix some issues with Intels icc compiler.
authorwolf <wolf@0785d39b-7218-0410-832d-ea1e28bc413d>
Mon, 4 Feb 2002 17:34:56 +0000 (17:34 +0000)
committerwolf <wolf@0785d39b-7218-0410-832d-ea1e28bc413d>
Mon, 4 Feb 2002 17:34:56 +0000 (17:34 +0000)
git-svn-id: https://svn.dealii.org/branches/Branch-3-3@5471 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/base/include/base/function_lib.h
deal.II/base/include/base/quadrature_lib.h
deal.II/base/source/function_lib_cutoff.cc
deal.II/base/source/parameter_handler.cc
deal.II/base/source/quadrature_lib.cc
deal.II/deal.II/include/grid/grid_out.h
deal.II/deal.II/source/fe/fe_dgq.cc
deal.II/lac/source/block_vector.cc
deal.II/lac/source/vector.cc
deal.II/lac/source/vector.long_double.cc

index 30374dbe67a2315c22f6d4eb9c8efc942cbe589a..06345b2564e1ee635d5637bd32aa38126769b328 100644 (file)
@@ -809,7 +809,7 @@ namespace Functions
                                        * only.
                                        */
       CutOffFunctionLinfty (const double radius = 1.,
-                           Point<dim> = Point<dim>(),
+                           const Point<dim> = Point<dim>(),
                            const unsigned int n_components = 1,
                            const unsigned int select = no_component);
     
@@ -880,7 +880,7 @@ namespace Functions
                                        * component only.
                                        */
       CutOffFunctionW1 (const double radius = 1.,
-                       Point<dim> = Point<dim>(),
+                       const Point<dim> = Point<dim>(),
                        const unsigned int n_components = 1,
                        const unsigned int select = no_component);
     
@@ -953,7 +953,7 @@ namespace Functions
                                        * component only.
                                        */
       CutOffFunctionCinfty (const double radius = 1.,
-                           Point<dim> = Point<dim>(),
+                           const Point<dim> = Point<dim>(),
                            const unsigned int n_components = 1,
                            const unsigned int select = no_component);
     
index 7c45b5c64f3c7aafcb5c880914e00efa67d8ac07..21b4382ef9d9e1803e1f46f968c2afb766086122 100644 (file)
@@ -203,7 +203,7 @@ class QWeddle : public Quadrature<dim>
 
 /* -------------- declaration of explicit specializations ------------- */
 
-template <> QGauss<1>::QGauss (unsigned int n);
+template <> QGauss<1>::QGauss (const unsigned int n);
 template <> QGauss2<1>::QGauss2 ();
 template <> QGauss3<1>::QGauss3 ();
 template <> QGauss4<1>::QGauss4 ();
index a872a1c07eac6494a48b5f094fe0cbcd6c7e3882..3270004be88390a56c44de5ede668efd0d0a1e87 100644 (file)
@@ -44,7 +44,7 @@ namespace Functions
   CutOffFunctionLinfty<dim>::CutOffFunctionLinfty (const double r,
                                                   const Point<dim> p,
                                                   const unsigned int n_components,
-                                                  unsigned int select)
+                                                  const unsigned int select)
                  :
                  Function<dim> (n_components),
     center(p),
@@ -111,7 +111,7 @@ namespace Functions
   CutOffFunctionW1<dim>::CutOffFunctionW1 (const double     r,
                                           const Point<dim> p,
                                           const unsigned int n_components,
-                                          unsigned int select)
+                                          const unsigned int select)
                  :
                  Function<dim> (n_components),
                   center(p),
@@ -183,7 +183,7 @@ namespace Functions
   CutOffFunctionCinfty<dim>::CutOffFunctionCinfty (const double     r,
                                                   const Point<dim> p,
                                                   const unsigned int n_components,
-                                                  unsigned int select)
+                                                  const unsigned int select)
                  :
                  Function<dim> (n_components),
                   center(p),
index 41c90d17aadd5fc32c9657a6e39ba9905f4ac844..a6f71755e8492057bca106d24fa56af639e35a0d 100644 (file)
 #  include <strstream>
 #endif
 
+#ifdef HAVE_STD_NUMERIC_LIMITS
+# include <limits>
+#endif
+
 
 namespace Patterns
 {  
index e14aa199955207a11cea27bc1ce47350ead39ffe..9e1950e1fe396a017c9abc3ad82a00541b2e99af 100644 (file)
@@ -358,7 +358,7 @@ QWeddle<1>::QWeddle () :
 // tensor product of lower dimensions
 
 template <int dim>
-QGauss<dim>::QGauss (unsigned int n)
+QGauss<dim>::QGauss (const unsigned int n)
   :  Quadrature<dim> (QGauss<dim-1>(n), QGauss<1>(n))
 {};
 
index 568287bbb197eaec62856d9575d40406890f3d96..3ef69a2a949cc119f0370245b150b23c93e56efc 100644 (file)
@@ -54,8 +54,8 @@ namespace GridOutFlags
                                     /**
                                      * Constructor.
                                      */
-    DX (bool write_faces = false,
-       bool write_all_faces = false);  
+    DX (const bool write_faces = false,
+       const bool write_all_faces = false);  
   };                      
     
                                   /**
index ab1e2c1be24e2f14dbe1ce41bffd16d04fadb335..2d6abc635a9ea805027fdb65121e94c171a156e6 100644 (file)
@@ -585,7 +585,7 @@ FE_DGQ<dim>::base_element (const unsigned int index) const
 
 template <int dim>
 bool
-FE_DGQ<dim>::has_support_on_face (unsigned int shape_index,
+FE_DGQ<dim>::has_support_on_face (const unsigned int shape_index,
                                  const unsigned int face_index) const
 {
 
index 27b9d16c211940f44af6f89ddfb94b719c2d263e..0a5315a49919805341f302a395ca067212419911 100644 (file)
 template class BlockVector<double>;
 template BlockVector<double>& BlockVector<double>::operator=(
   const BlockVector<float>&);
-template void BlockVector<double>::reinit(const BlockVector<double>&, bool);
-template void BlockVector<double>::reinit(const BlockVector<float>&, bool);
-template void BlockVector<double>::equ(double, const BlockVector<double>&);
-template void BlockVector<double>::equ(double, const BlockVector<float>&);
+template void BlockVector<double>::reinit(const BlockVector<double>&, const bool);
+template void BlockVector<double>::reinit(const BlockVector<float>&, const bool);
+template void BlockVector<double>::equ(const double, const BlockVector<double>&);
+template void BlockVector<double>::equ(const double, const BlockVector<float>&);
 
 template class BlockVector<float>;
 template BlockVector<float>& BlockVector<float>::operator=(
   const BlockVector<double>&);
-template void BlockVector<float>::reinit(const BlockVector<double>&, bool);
-template void BlockVector<float>::reinit(const BlockVector<float>&, bool);
-template void BlockVector<float>::equ(float, const BlockVector<double>&);
-template void BlockVector<float>::equ(float, const BlockVector<float>&);
+template void BlockVector<float>::reinit(const BlockVector<double>&, const bool);
+template void BlockVector<float>::reinit(const BlockVector<float>&, const bool);
+template void BlockVector<float>::equ(const float, const BlockVector<double>&);
+template void BlockVector<float>::equ(const float, const BlockVector<float>&);
 
 namespace BlockVectorIterators
 {
index 391ac3c00946dd9329bbe20a31347836eefaede0..8fad192863f3c73fa428b305f426f3518be10d28 100644 (file)
@@ -19,19 +19,19 @@ template class Vector<double>;
 template Vector<double>& Vector<double>::operator=(const Vector<float>&);
 template double Vector<double>::operator*(const Vector<float>&) const;
 template double Vector<double>::operator*(const Vector<double>&) const;
-template void Vector<double>::reinit(const Vector<double>&, bool);
-template void Vector<double>::reinit(const Vector<float>&, bool);
-template void Vector<double>::equ(double, const Vector<double>&);
-template void Vector<double>::equ(double, const Vector<float>&);
+template void Vector<double>::reinit(const Vector<double>&, const bool);
+template void Vector<double>::reinit(const Vector<float>&, const bool);
+template void Vector<double>::equ(const double, const Vector<double>&);
+template void Vector<double>::equ(const double, const Vector<float>&);
 
 template class Vector<float>;
 template Vector<float>& Vector<float>::operator=(const Vector<double>&);
 template float Vector<float>::operator*(const Vector<float>&) const;
 template float Vector<float>::operator*(const Vector<double>&) const;
-template void Vector<float>::reinit(const Vector<double>&, bool);
-template void Vector<float>::reinit(const Vector<float>&, bool);
-template void Vector<float>::equ(float, const Vector<double>&);
-template void Vector<float>::equ(float, const Vector<float>&);
+template void Vector<float>::reinit(const Vector<double>&, const bool);
+template void Vector<float>::reinit(const Vector<float>&, const bool);
+template void Vector<float>::equ(const float, const Vector<double>&);
+template void Vector<float>::equ(const float, const Vector<float>&);
 
 // see the .h file for why these functions are disabled.
 // template Vector<float>::Vector (const Vector<double>& v);
index 1b4285588e8e2715da10f5fd000e77c46b7907d6..3567be18838de4b298a38e4965c1eee5e330c496 100644 (file)
@@ -22,22 +22,22 @@ template Vector<long double>& Vector<long double>::operator=(const Vector<float>
 template long double Vector<long double>::operator * (const Vector<long double> &) const;
 template long double Vector<long double>::operator * (const Vector<double> &) const;
 template long double Vector<long double>::operator * (const Vector<float> &) const;
-template void Vector<long double>::reinit(const Vector<long double>&, bool);
-template void Vector<long double>::reinit(const Vector<double>&, bool);
-template void Vector<long double>::reinit(const Vector<float>&, bool);
-template void Vector<long double>::equ(long double, const Vector<long double>&);
-template void Vector<long double>::equ(long double, const Vector<double>&);
-template void Vector<long double>::equ(long double, const Vector<float>&);
+template void Vector<long double>::reinit(const Vector<long double>&, const bool);
+template void Vector<long double>::reinit(const Vector<double>&, const bool);
+template void Vector<long double>::reinit(const Vector<float>&, const bool);
+template void Vector<long double>::equ(const long double, const Vector<long double>&);
+template void Vector<long double>::equ(const long double, const Vector<double>&);
+template void Vector<long double>::equ(const long double, const Vector<float>&);
 
 template Vector<double>& Vector<double>::operator=(const Vector<long double>&);
 template double Vector<double>::operator * (const Vector<long double> &) const;
-template void Vector<double>::reinit(const Vector<long double>&, bool);
-template void Vector<double>::equ(double, const Vector<long double>&);
+template void Vector<double>::reinit(const Vector<long double>&, const bool);
+template void Vector<double>::equ(const double, const Vector<long double>&);
 
 template Vector<float>& Vector<float>::operator=(const Vector<long double>&);
 template float Vector<float>::operator * (const Vector<long double> &) const;
-template void Vector<float>::reinit(const Vector<long double>&, bool);
-template void Vector<float>::equ(float, const Vector<long double>&);
+template void Vector<float>::reinit(const Vector<long double>&, const bool);
+template void Vector<float>::equ(const float, const Vector<long double>&);
 
 // see the .h file for why these functions are disabled.
 // template Vector<float>::Vector (const Vector<double>& v);

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.