]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Make variables const and thus Intel C++ compiler more happy.
authorWolfgang Bangerth <bangerth@math.tamu.edu>
Thu, 17 May 2001 12:49:49 +0000 (12:49 +0000)
committerWolfgang Bangerth <bangerth@math.tamu.edu>
Thu, 17 May 2001 12:49:49 +0000 (12:49 +0000)
git-svn-id: https://svn.dealii.org/trunk@4637 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/deal.II/include/numerics/matrices.h
deal.II/lac/include/lac/precondition.h
deal.II/lac/include/lac/vector_memory.h

index ef34ba675932a48260ce33799844fa245f53e6b4..30b1d074c92eb38781a7e8f54ff0277be776ed5f 100644 (file)
@@ -277,7 +277,7 @@ class MatrixCreator
                                      const typename FunctionMap<dim>::type        &boundary_functions,
                                      Vector<double>           &rhs_vector,
                                      std::vector<unsigned int>&dof_to_boundary_mapping,
-                                     const Function<dim>      *a = 0);
+                                     const Function<dim> * const a = 0);
 
                                     /**
                                      * Calls the
@@ -292,7 +292,7 @@ class MatrixCreator
                                      const typename FunctionMap<dim>::type        &boundary_functions,
                                      Vector<double>           &rhs_vector,
                                      std::vector<unsigned int>&dof_to_boundary_mapping,
-                                     const Function<dim>      *a = 0);
+                                     const Function<dim> * const a = 0);
 
                                     /**
                                      * Assemble the Laplace
@@ -311,7 +311,7 @@ class MatrixCreator
                                       const DoFHandler<dim>    &dof,
                                       const Quadrature<dim>    &q,
                                       SparseMatrix<double>     &matrix,
-                                      const Function<dim>      *a = 0);
+                                      const Function<dim> * const a = 0);
     
                                     /**
                                      * Calls the @p{create_laplace_matrix}
@@ -321,7 +321,7 @@ class MatrixCreator
     static void create_laplace_matrix (const DoFHandler<dim>    &dof,
                                       const Quadrature<dim>    &q,
                                       SparseMatrix<double>     &matrix,
-                                      const Function<dim>      *a = 0);
+                                      const Function<dim> * const a = 0);
 
                                     /**
                                      * Generate Laplace matrix for a
@@ -368,7 +368,7 @@ class MatrixCreator
                                       SparseMatrix<double>     &matrix,
                                       const Function<dim>      &rhs,
                                       Vector<double>           &rhs_vector,
-                                      const Function<dim>      *a = 0);
+                                      const Function<dim> * const a = 0);
 
                                     /**
                                      * Exception
index 4c6e271e6a02852bf1764e9c95c90ecc75671dd2..a57c19ac6db35815b1dc8bd4959841a43a787e6b 100644 (file)
@@ -518,7 +518,8 @@ PreconditionIdentity::Tvmult (VECTOR& dst, const VECTOR& src) const
 
 template <class MATRIX>
 inline void
-PreconditionRelaxation<MATRIX>::initialize (const MATRIX& rA, double o)
+PreconditionRelaxation<MATRIX>::initialize (const MATRIX &rA,
+                                           const double  o)
 {
   A = &rA;
   omega = o;
@@ -597,8 +598,8 @@ PreconditionSSOR<MATRIX>::Tvmult (VECTOR& dst, const VECTOR& src) const
 
 
 template<class MATRIX, class VECTOR>
-PreconditionUseMatrix<MATRIX,VECTOR>::PreconditionUseMatrix(const MATRIXM,
-                                                           function_ptr method)
+PreconditionUseMatrix<MATRIX,VECTOR>::PreconditionUseMatrix(const MATRIX       &M,
+                                                           const function_ptr  method)
                :
                matrix(M), precondition(method)
 {}
index a70c7a72906fa64d4e43ce48f179340881a7e885..f425908033440a181d4fbd8ec2e7611198b7f28e 100644 (file)
@@ -55,7 +55,7 @@ class VectorMemory : public Subscriptor
                                      * Return a vector into the pool
                                      * for later use.
                                      */
-    virtual void free(const Vector*) = 0;
+    virtual void free (const Vector * const) = 0;
                                     /**
                                      * No more available vectors.
                                      */

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.