]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Add std:: prefices.
authorthird-party <third-party@0785d39b-7218-0410-832d-ea1e28bc413d>
Mon, 22 Jan 2001 10:25:13 +0000 (10:25 +0000)
committerthird-party <third-party@0785d39b-7218-0410-832d-ea1e28bc413d>
Mon, 22 Jan 2001 10:25:13 +0000 (10:25 +0000)
git-svn-id: https://svn.dealii.org/trunk@3750 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/base/include/base/polynomial.h
deal.II/base/include/base/tensor_product_polynomials.h
deal.II/base/source/polynomial.cc
deal.II/base/source/tensor_product_polynomials.cc

index 9401e01006017d5c1d9d64a469aa46fe9d797638..445f31df5cb0f648ba35624277361efd0285c179 100644 (file)
@@ -48,7 +48,7 @@ class Polynomial : public Subscriptor
                                      * the @p{coefficient} array
                                      * minus one.
                                      */
-    Polynomial (const vector<double> &coefficients);
+    Polynomial (const std::vector<double> &coefficients);
 
                                      /**
                                      * Default-Constructor.
@@ -81,8 +81,8 @@ class Polynomial : public Subscriptor
                                      * scheme for numerical stability
                                      * of the evaluation.
                                      */
-    void value (const double    x,
-               vector<double> &values) const;
+    void value (const double         x,
+               std::vector<double> &values) const;
 
                                     /**
                                      * Exception
@@ -104,7 +104,7 @@ class Polynomial : public Subscriptor
                                      * passed down by derived
                                      * classes.
                                      */
-    vector<double> coefficients;
+    std::vector<double> coefficients;
 };
 
 
@@ -162,7 +162,7 @@ class LagrangeEquidistant: public Polynomial
                                      * constructor.
                                      */
     static 
-    vector<double> 
+    std::vector<double> 
     compute_coefficients (const unsigned int n,
                          const unsigned int support_point);
 };
index 0871eafdcbc950e01622c3100e97e0543284297c..8827888568cdbd3cb4cf29a6a05fded714978ceb 100644 (file)
@@ -43,7 +43,7 @@ class TensorProductPolynomials
                                      * and will be copied into the
                                      * member variable @p{polynomials}.
                                      */
-    TensorProductPolynomials(const vector<SmartPointer<Polynomial> > &pols);
+    TensorProductPolynomials(const std::vector<SmartPointer<Polynomial> > &pols);
 
                                     /**
                                      * Calculates the polynomials
@@ -56,10 +56,10 @@ class TensorProductPolynomials
                                      * case, the function will not
                                      * compute these values.
                                      */
-    void compute (const Point<dim> &unit_point,
-                 vector<double> &values,
-                 vector<Tensor<1,dim> > &grads,
-                 vector<Tensor<2,dim> > &grad_grads) const;
+    void compute (const Point<dim>                     &unit_point,
+                 std::vector<double>                  &values,
+                 typename std::vector<Tensor<1,dim> > &grads,
+                 typename std::vector<Tensor<2,dim> > &grad_grads) const;
 
                                     /**
                                      * Returns the number of tensor
@@ -81,7 +81,7 @@ class TensorProductPolynomials
                                      * Pointer to the @p{polynomials}
                                      * given to the constructor.
                                      */
-    vector<SmartPointer<Polynomial> > polynomials;
+    std::vector<SmartPointer<Polynomial> > polynomials;
 
                                     /**
                                      * Number of tensor product
index 419ebe72bef980c23901033eef68726ef0bac5e3..7ea2e58a8f4fdb4d99b67a6e497fc7848febc2b9 100644 (file)
@@ -15,7 +15,7 @@
 #include <base/polynomial.h>
 
 
-Polynomial::Polynomial (const vector<double> &a):
+Polynomial::Polynomial (const std::vector<double> &a):
                coefficients(a)
 {}
 
@@ -43,8 +43,8 @@ double Polynomial::value (const double x) const
 
 
 
-void Polynomial::value (const double    x,
-                       vector<double> &values) const
+void Polynomial::value (const double         x,
+                       std::vector<double> &values) const
 {
   Assert (coefficients.size() > 0, ExcVoidPolynomial());
   Assert (values.size() > 0, ExcEmptyArray());
@@ -68,7 +68,7 @@ void Polynomial::value (const double    x,
                                   // then do it properly by the
                                   // full Horner scheme
   const unsigned int m=coefficients.size();
-  vector<double> a(coefficients);
+  std::vector<double> a(coefficients);
   unsigned int j_faculty=1;
   for (unsigned int j=0; j<values_size; ++j)
     {      
@@ -97,11 +97,11 @@ LagrangeEquidistant::LagrangeEquidistant ()
 
 
 
-vector<double> 
+std::vector<double> 
 LagrangeEquidistant::compute_coefficients (const unsigned int n,
                                           const unsigned int support_point)
 {
-  vector<double> a (n+1);
+  std::vector<double> a (n+1);
   Assert(support_point<n+1, ExcIndexRange(support_point, 0, n+1));
 
   switch (n)
index b47a29b0cbc6103aa75b89f95ac04e2ebdb78a41..80b390f3fa85eb54a8162282c07efc13b82bef50 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2000 by the deal.II authors
+//    Copyright (C) 2000, 2001 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -30,7 +30,7 @@ number power(number x, unsigned int y)
 
 template <int dim>
 TensorProductPolynomials<dim>::TensorProductPolynomials(
-  const vector<SmartPointer<Polynomial> > &pols):
+  const std::vector<SmartPointer<Polynomial> > &pols):
                polynomials(pols),
                n_tensor_pols(power(polynomials.size(), dim))
 {}
@@ -38,13 +38,13 @@ TensorProductPolynomials<dim>::TensorProductPolynomials(
 
 template <int dim>
 void TensorProductPolynomials<dim>::compute(
-  const Point<dim> &p,
-  vector<double> &values,
-  vector<Tensor<1,dim> > &grads,
-  vector<Tensor<2,dim> > &grad_grads) const
+  const Point<dim>                     &p,
+  std::vector<double>                  &values,
+  typename std::vector<Tensor<1,dim> > &grads,
+  typename std::vector<Tensor<2,dim> > &grad_grads) const
 {
   unsigned int n_pols=polynomials.size();
-  vector<unsigned int> n_pols_to(dim+1);
+  std::vector<unsigned int> n_pols_to(dim+1);
   n_pols_to[0]=1;
   for (unsigned int i=0; i<dim; ++i)
     n_pols_to[i+1]=n_pols_to[i]*n_pols;
@@ -75,12 +75,12 @@ void TensorProductPolynomials<dim>::compute(
       v_size=3;
     }
 
-  vector<vector<vector<double> > > v(
-    dim, vector<vector<double> > (n_pols, vector<double> (v_size)));
+  std::vector<std::vector<std::vector<double> > > v(
+    dim, std::vector<std::vector<double> > (n_pols, std::vector<double> (v_size)));
 
   for (unsigned int d=0; d<dim; ++d)
     {
-      vector<vector<double> > &v_d=v[d];
+      std::vector<std::vector<double> > &v_d=v[d];
       Assert(v_d.size()==n_pols, ExcInternalError());
       for (unsigned int i=0; i<n_pols; ++i)
        polynomials[i]->value(p(d), v_d[i]);

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.