]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Rename Vector::val to Vector::values. 5282/head
authorWolfgang Bangerth <bangerth@colostate.edu>
Fri, 20 Oct 2017 19:51:15 +0000 (13:51 -0600)
committerWolfgang Bangerth <bangerth@colostate.edu>
Fri, 20 Oct 2017 19:51:15 +0000 (13:51 -0600)
include/deal.II/lac/vector.h
include/deal.II/lac/vector.templates.h
include/deal.II/lac/vector_view.h
source/lac/lapack_full_matrix.cc
tests/lac/gmres_reorthogonalize_04.cc
tests/lac/gmres_reorthogonalize_05.cc

index 89ad440328e5044b182243f33430e5397cb091c2..767e9dff8cfe240c5d1121187513da51d3cd923f 100644 (file)
@@ -922,7 +922,7 @@ protected:
   /**
    * Pointer to the array of elements of this vector.
    */
-  Number *val;
+  Number *values;
 
   /**
    * For parallel loops with TBB, this member variable stores the affinity
@@ -948,13 +948,13 @@ protected:
 private:
 
   /**
-   * Allocate and align @p val along 64-byte boundaries. The size of the
+   * Allocate and align @p values along 64-byte boundaries. The size of the
    * allocated memory is determined by @p max_vec_size .
    */
   void allocate();
 
   /**
-   * Deallocate @p val.
+   * Deallocate @p values.
    */
   void deallocate();
 };
@@ -980,7 +980,7 @@ Vector<Number>::Vector ()
   :
   vec_size(0),
   max_vec_size(0),
-  val(nullptr)
+  values(nullptr)
 {
   reinit(0);
 }
@@ -993,7 +993,7 @@ Vector<Number>::Vector (const InputIterator first, const InputIterator last)
   :
   vec_size (0),
   max_vec_size (0),
-  val (nullptr)
+  values (nullptr)
 {
   // allocate memory. do not initialize it, as we will copy over to it in a
   // second
@@ -1009,7 +1009,7 @@ Vector<Number>::Vector (const size_type n)
   :
   vec_size(0),
   max_vec_size(0),
-  val(nullptr)
+  values(nullptr)
 {
   reinit (n, false);
 }
@@ -1020,10 +1020,10 @@ template <typename Number>
 inline
 Vector<Number>::~Vector ()
 {
-  if (val)
+  if (values)
     {
       deallocate();
-      val=nullptr;
+      values = nullptr;
     }
 }
 
@@ -1052,7 +1052,7 @@ inline
 typename Vector<Number>::iterator
 Vector<Number>::begin ()
 {
-  return val;
+  return values;
 }
 
 
@@ -1062,7 +1062,7 @@ inline
 typename Vector<Number>::const_iterator
 Vector<Number>::begin () const
 {
-  return val;
+  return values;
 }
 
 
@@ -1072,7 +1072,7 @@ inline
 typename Vector<Number>::iterator
 Vector<Number>::end ()
 {
-  return val + vec_size;
+  return values + vec_size;
 }
 
 
@@ -1082,7 +1082,7 @@ inline
 typename Vector<Number>::const_iterator
 Vector<Number>::end () const
 {
-  return val + vec_size;
+  return values + vec_size;
 }
 
 
@@ -1092,7 +1092,7 @@ inline
 Number Vector<Number>::operator() (const size_type i) const
 {
   Assert (i<vec_size, ExcIndexRange(i,0,vec_size));
-  return val[i];
+  return values[i];
 }
 
 
@@ -1102,7 +1102,7 @@ inline
 Number &Vector<Number>::operator() (const size_type i)
 {
   Assert (i<vec_size, ExcIndexRangeType<size_type>(i,0,vec_size));
-  return val[i];
+  return values[i];
 }
 
 
@@ -1191,7 +1191,7 @@ Vector<Number>::add (const std::vector<size_type> &indices,
 {
   Assert (indices.size() == values.size(),
           ExcDimensionMismatch(indices.size(), values.size()));
-  add (indices.size(), indices.data(), values.val);
+  add (indices.size(), indices.data(), values.values);
 }
 
 
@@ -1210,7 +1210,7 @@ Vector<Number>::add (const size_type  n_indices,
       Assert (numbers::is_finite(values[i]),
               ExcMessage("The given value is not finite but either infinite or Not A Number (NaN)"));
 
-      val[indices[i]] += values[i];
+      this->values[indices[i]] += values[i];
     }
 }
 
@@ -1253,7 +1253,7 @@ Vector<Number>::swap (Vector<Number> &v)
 {
   std::swap (vec_size,     v.vec_size);
   std::swap (max_vec_size, v.max_vec_size);
-  std::swap (val,          v.val);
+  std::swap (values,       v.values);
 }
 
 
@@ -1268,7 +1268,7 @@ Vector<Number>::save (Archive &ar, const unsigned int) const
   ar &static_cast<const Subscriptor &>(*this);
 
   ar &vec_size &max_vec_size ;
-  ar &boost::serialization::make_array(val, max_vec_size);
+  ar &boost::serialization::make_array(values, max_vec_size);
 }
 
 
@@ -1287,7 +1287,7 @@ Vector<Number>::load (Archive &ar, const unsigned int)
   ar &vec_size &max_vec_size ;
 
   allocate();
-  ar &boost::serialization::make_array(val, max_vec_size);
+  ar &boost::serialization::make_array(values, max_vec_size);
 }
 
 #endif
index 385d8945bc83ec8c5dc982d30912703472fc0369..a1b19dc83cf3c05269bb97e60dc8d656941d6986 100644 (file)
@@ -48,7 +48,7 @@ Vector<Number>::Vector (const Vector<Number> &v)
   Subscriptor(),
   vec_size(v.size()),
   max_vec_size(v.size()),
-  val(nullptr)
+  values(nullptr)
 {
   if (vec_size != 0)
     {
@@ -65,12 +65,12 @@ Vector<Number>::Vector (Vector<Number> &&v)
   Subscriptor(std::move(v)),
   vec_size(v.vec_size),
   max_vec_size(v.max_vec_size),
-  val(v.val),
+  values(v.values),
   thread_loop_partitioner(std::move(v.thread_loop_partitioner))
 {
   v.vec_size = 0;
   v.max_vec_size = 0;
-  v.val = nullptr;
+  v.values = nullptr;
 }
 
 
@@ -82,7 +82,7 @@ Vector<Number>::Vector (const Vector<OtherNumber> &v)
   Subscriptor(),
   vec_size(v.size()),
   max_vec_size(v.size()),
-  val(nullptr)
+  values(nullptr)
 {
   if (vec_size != 0)
     {
@@ -145,7 +145,7 @@ Vector<Number>::Vector (const PETScWrappers::VectorBase &v)
   Subscriptor(),
   vec_size(0),
   max_vec_size(0),
-  val(nullptr)
+  values(nullptr)
 {
   if (v.size() != 0)
     {
@@ -163,7 +163,7 @@ Vector<Number>::Vector (const TrilinosWrappers::MPI::Vector &v)
   Subscriptor(),
   vec_size(v.size()),
   max_vec_size(v.size()),
-  val(nullptr)
+  values(nullptr)
 {
   if (vec_size != 0)
     {
@@ -207,7 +207,7 @@ Vector<Number>::operator= (const Vector<Number> &v)
 
   if (vec_size>0)
     {
-      dealii::internal::VectorOperations::Vector_copy<Number,Number> copier(v.val, val);
+      dealii::internal::VectorOperations::Vector_copy<Number,Number> copier(v.values, values);
       internal::VectorOperations::parallel_for(copier,0,vec_size,thread_loop_partitioner);
     }
 
@@ -224,16 +224,16 @@ Vector<Number>::operator= (Vector<Number> &&v)
 {
   Subscriptor::operator=(std::move(v));
 
-  if (val) deallocate();
+  if (values) deallocate();
 
   vec_size = v.vec_size;
   max_vec_size = v.max_vec_size;
-  val = v.val;
+  values = v.values;
   thread_loop_partitioner = std::move(v.thread_loop_partitioner);
 
   v.vec_size = 0;
   v.max_vec_size = 0;
-  v.val = nullptr;
+  v.values = nullptr;
 
   return *this;
 }
@@ -251,7 +251,7 @@ Vector<Number>::operator= (const Vector<Number2> &v)
   if (vec_size != v.vec_size)
     reinit (v, true);
 
-  dealii::internal::VectorOperations::Vector_copy<Number,Number2> copier(v.val, val);
+  dealii::internal::VectorOperations::Vector_copy<Number,Number2> copier(v.values, values);
   internal::VectorOperations::parallel_for(copier,0,vec_size,thread_loop_partitioner);
 
   return *this;
@@ -266,8 +266,8 @@ void Vector<Number>::reinit (const size_type n,
 {
   if (n==0)
     {
-      if (val) deallocate();
-      val = nullptr;
+      if (values) deallocate();
+      values = nullptr;
       max_vec_size = vec_size = 0;
       thread_loop_partitioner.reset(new parallel::internal::TBBPartitioner());
       return;
@@ -275,7 +275,7 @@ void Vector<Number>::reinit (const size_type n,
 
   if (n>max_vec_size)
     {
-      if (val) deallocate();
+      if (values) deallocate();
       max_vec_size = n;
       allocate();
     };
@@ -305,15 +305,15 @@ void Vector<Number>::reinit (const Vector<Number2> &v,
 
   if (v.vec_size==0)
     {
-      if (val) deallocate();
-      val = nullptr;
+      if (values) deallocate();
+      values = nullptr;
       max_vec_size = vec_size = 0;
       return;
     };
 
   if (v.vec_size>max_vec_size)
     {
-      if (val) deallocate();
+      if (values) deallocate();
       max_vec_size = v.vec_size;
       allocate();
     };
@@ -331,7 +331,7 @@ Vector<Number>::all_zero () const
   Assert (vec_size!=0, ExcEmptyObject());
 
   for (size_type i=0; i<vec_size; ++i)
-    if (val[i] != Number())
+    if (values[i] != Number())
       return false;
   return true;
 }
@@ -345,7 +345,7 @@ Vector<Number>::is_non_negative () const
   Assert (vec_size!=0, ExcEmptyObject());
 
   for (size_type i=0; i<vec_size; ++i)
-    if ( ! internal::VectorOperations::is_non_negative (val[i]))
+    if ( ! internal::VectorOperations::is_non_negative (values[i]))
       return false;
 
   return true;
@@ -363,7 +363,7 @@ Vector<Number>::operator= (const Number s)
 
   if (vec_size>0)
     {
-      internal::VectorOperations::Vector_set<Number> setter(s, val);
+      internal::VectorOperations::Vector_set<Number> setter(s, values);
       internal::VectorOperations::parallel_for(setter,0,vec_size,thread_loop_partitioner);
     }
 
@@ -379,7 +379,7 @@ Vector<Number> &Vector<Number>::operator *= (const Number factor)
 
   Assert (vec_size!=0, ExcEmptyObject());
 
-  internal::VectorOperations::Vectorization_multiply_factor<Number> vector_multiply(val, factor);
+  internal::VectorOperations::Vectorization_multiply_factor<Number> vector_multiply(values, factor);
 
   internal::VectorOperations::parallel_for(vector_multiply,0,vec_size,thread_loop_partitioner);
 
@@ -398,7 +398,7 @@ Vector<Number>::add (const Number a,
   Assert (vec_size!=0, ExcEmptyObject());
   Assert (vec_size == v.vec_size, ExcDimensionMismatch(vec_size, v.vec_size));
 
-  internal::VectorOperations::Vectorization_add_av<Number> vector_add_av(val, v.val, a);
+  internal::VectorOperations::Vectorization_add_av<Number> vector_add_av(values, v.values, a);
   internal::VectorOperations::parallel_for(vector_add_av,0,vec_size,thread_loop_partitioner);
 }
 
@@ -416,7 +416,7 @@ Vector<Number>::sadd (const Number x,
   Assert (vec_size!=0, ExcEmptyObject());
   Assert (vec_size == v.vec_size, ExcDimensionMismatch(vec_size, v.vec_size));
 
-  internal::VectorOperations::Vectorization_sadd_xav<Number> vector_sadd_xav(val, v.val, a, x);
+  internal::VectorOperations::Vectorization_sadd_xav<Number> vector_sadd_xav(values, v.values, a, x);
   internal::VectorOperations::parallel_for(vector_sadd_xav,0,vec_size,thread_loop_partitioner);
 }
 
@@ -435,7 +435,7 @@ Number Vector<Number>::operator * (const Vector<Number2> &v) const
           ExcDimensionMismatch(vec_size, v.size()));
 
   Number sum;
-  internal::VectorOperations::Dot<Number,Number2> dot(val, v.val);
+  internal::VectorOperations::Dot<Number,Number2> dot(values, v.values);
   internal::VectorOperations::parallel_reduce (dot, 0, vec_size, sum, thread_loop_partitioner);
   AssertIsFinite(sum);
 
@@ -451,7 +451,7 @@ Vector<Number>::norm_sqr () const
   Assert (vec_size!=0, ExcEmptyObject());
 
   real_type sum;
-  internal::VectorOperations::Norm2<Number,real_type> norm2(val);
+  internal::VectorOperations::Norm2<Number,real_type> norm2(values);
   internal::VectorOperations::parallel_reduce (norm2, 0, vec_size, sum, thread_loop_partitioner);
 
   AssertIsFinite(sum);
@@ -467,7 +467,7 @@ Number Vector<Number>::mean_value () const
   Assert (vec_size!=0, ExcEmptyObject());
 
   Number sum;
-  internal::VectorOperations::MeanValue<Number> mean(val);
+  internal::VectorOperations::MeanValue<Number> mean(values);
   internal::VectorOperations::parallel_reduce (mean, 0, vec_size, sum, thread_loop_partitioner);
 
   return sum / real_type(size());
@@ -482,7 +482,7 @@ Vector<Number>::l1_norm () const
   Assert (vec_size!=0, ExcEmptyObject());
 
   real_type sum;
-  internal::VectorOperations::Norm1<Number, real_type> norm1(val);
+  internal::VectorOperations::Norm1<Number, real_type> norm1(values);
   internal::VectorOperations::parallel_reduce (norm1, 0, vec_size, sum, thread_loop_partitioner);
 
   return sum;
@@ -502,7 +502,7 @@ Vector<Number>::l2_norm () const
   Assert (vec_size!=0, ExcEmptyObject());
 
   real_type norm_square;
-  internal::VectorOperations::Norm2<Number, real_type> norm2(val);
+  internal::VectorOperations::Norm2<Number, real_type> norm2(values);
   internal::VectorOperations::parallel_reduce (norm2, 0, vec_size, norm_square,
                                                thread_loop_partitioner);
   if (numbers::is_finite(norm_square) &&
@@ -514,10 +514,10 @@ Vector<Number>::l2_norm () const
       real_type sum = 1.;
       for (size_type i=0; i<vec_size; ++i)
         {
-          if (val[i] != Number())
+          if (values[i] != Number())
             {
               const real_type abs_x =
-                numbers::NumberTraits<Number>::abs(val[i]);
+                numbers::NumberTraits<Number>::abs(values[i]);
               if (scale < abs_x)
                 {
                   sum = 1. + sum * (scale/abs_x) * (scale/abs_x);
@@ -546,7 +546,7 @@ Vector<Number>::lp_norm (const real_type p) const
     return l2_norm();
 
   real_type sum;
-  internal::VectorOperations::NormP<Number, real_type> normp(val, p);
+  internal::VectorOperations::NormP<Number, real_type> normp(values, p);
   internal::VectorOperations::parallel_reduce (normp, 0, vec_size, sum, thread_loop_partitioner);
 
   if (numbers::is_finite(sum) && sum >= std::numeric_limits<real_type>::min())
@@ -557,10 +557,10 @@ Vector<Number>::lp_norm (const real_type p) const
       real_type sum = 1.;
       for (size_type i=0; i<vec_size; ++i)
         {
-          if (val[i] != Number())
+          if (values[i] != Number())
             {
               const real_type abs_x =
-                numbers::NumberTraits<Number>::abs(val[i]);
+                numbers::NumberTraits<Number>::abs(values[i]);
               if (scale < abs_x)
                 {
                   sum = 1. + sum * std::pow(scale/abs_x, p);
@@ -585,7 +585,7 @@ Vector<Number>::linfty_norm () const
   real_type max = 0.;
 
   for (size_type i=0; i<vec_size; ++i)
-    max = std::max (numbers::NumberTraits<Number>::abs(val[i]), max);
+    max = std::max (numbers::NumberTraits<Number>::abs(values[i]), max);
 
   return max;
 }
@@ -603,7 +603,7 @@ Vector<Number>::add_and_dot (const Number          a,
   AssertDimension (vec_size, W.size());
 
   Number sum;
-  internal::VectorOperations::AddAndDot<Number> adder(this->val, V.val, W.val, a);
+  internal::VectorOperations::AddAndDot<Number> adder(this->values, V.values, W.values, a);
   internal::VectorOperations::parallel_reduce (adder, 0, vec_size, sum, thread_loop_partitioner);
   AssertIsFinite(sum);
 
@@ -618,7 +618,7 @@ Vector<Number> &Vector<Number>::operator += (const Vector<Number> &v)
   Assert (vec_size!=0, ExcEmptyObject());
   Assert (vec_size == v.vec_size, ExcDimensionMismatch(vec_size, v.vec_size));
 
-  internal::VectorOperations::Vectorization_add_v<Number> vector_add(val, v.val);
+  internal::VectorOperations::Vectorization_add_v<Number> vector_add(values, v.values);
   internal::VectorOperations::parallel_for(vector_add,0,vec_size,thread_loop_partitioner);
   return *this;
 }
@@ -631,7 +631,7 @@ Vector<Number> &Vector<Number>::operator -= (const Vector<Number> &v)
   Assert (vec_size!=0, ExcEmptyObject());
   Assert (vec_size == v.vec_size, ExcDimensionMismatch(vec_size, v.vec_size));
 
-  internal::VectorOperations::Vectorization_subtract_v<Number> vector_subtract(val, v.val);
+  internal::VectorOperations::Vectorization_subtract_v<Number> vector_subtract(values, v.values);
   internal::VectorOperations::parallel_for(vector_subtract,0,vec_size,thread_loop_partitioner);
 
   return *this;
@@ -644,7 +644,7 @@ void Vector<Number>::add (const Number v)
 {
   Assert (vec_size!=0, ExcEmptyObject());
 
-  internal::VectorOperations::Vectorization_add_factor<Number> vector_add(val, v);
+  internal::VectorOperations::Vectorization_add_factor<Number> vector_add(values, v);
   internal::VectorOperations::parallel_for(vector_add,0,vec_size,thread_loop_partitioner);
 }
 
@@ -661,7 +661,7 @@ void Vector<Number>::add (const Number a, const Vector<Number> &v,
   Assert (vec_size == v.vec_size, ExcDimensionMismatch(vec_size, v.vec_size));
   Assert (vec_size == w.vec_size, ExcDimensionMismatch(vec_size, w.vec_size));
 
-  internal::VectorOperations::Vectorization_add_avpbw<Number> vector_add(val, v.val, w.val, a, b);
+  internal::VectorOperations::Vectorization_add_avpbw<Number> vector_add(values, v.values, w.values, a, b);
   internal::VectorOperations::parallel_for(vector_add,0,vec_size,thread_loop_partitioner);
 }
 
@@ -676,7 +676,7 @@ void Vector<Number>::sadd (const Number x,
   Assert (vec_size!=0, ExcEmptyObject());
   Assert (vec_size == v.vec_size, ExcDimensionMismatch(vec_size, v.vec_size));
 
-  internal::VectorOperations::Vectorization_sadd_xv<Number> vector_sadd(val, v.val, x);
+  internal::VectorOperations::Vectorization_sadd_xv<Number> vector_sadd(values, v.values, x);
   internal::VectorOperations::parallel_for(vector_sadd,0,vec_size,thread_loop_partitioner);
 }
 
@@ -688,7 +688,7 @@ void Vector<Number>::scale (const Vector<Number> &s)
   Assert (vec_size!=0, ExcEmptyObject());
   Assert (vec_size == s.vec_size, ExcDimensionMismatch(vec_size, s.vec_size));
 
-  internal::VectorOperations::Vectorization_scale<Number> vector_scale(val, s.val);
+  internal::VectorOperations::Vectorization_scale<Number> vector_scale(values, s.values);
   internal::VectorOperations::parallel_for(vector_scale,0,vec_size,thread_loop_partitioner);
 }
 
@@ -702,7 +702,7 @@ void Vector<Number>::scale (const Vector<Number2> &s)
   Assert (vec_size == s.vec_size, ExcDimensionMismatch(vec_size, s.vec_size));
 
   for (size_type i=0; i<vec_size; ++i)
-    val[i] *= Number(s.val[i]);
+    values[i] *= Number(s.values[i]);
 }
 
 
@@ -716,7 +716,7 @@ void Vector<Number>::equ (const Number a,
   Assert (vec_size!=0, ExcEmptyObject());
   Assert (vec_size == u.vec_size, ExcDimensionMismatch(vec_size, u.vec_size));
 
-  internal::VectorOperations::Vectorization_equ_au<Number> vector_equ(val, u.val, a);
+  internal::VectorOperations::Vectorization_equ_au<Number> vector_equ(values, u.values, a);
   internal::VectorOperations::parallel_for(vector_equ,0,vec_size,thread_loop_partitioner);
 }
 
@@ -739,7 +739,7 @@ void Vector<Number>::equ (const Number a,
   // operator*(complex<float>,complex<double>)
   // is not defined by default
   for (size_type i=0; i<vec_size; ++i)
-    val[i] = a * Number(u.val[i]);
+    values[i] = a * Number(u.values[i]);
 }
 
 
@@ -756,7 +756,7 @@ void Vector<Number>::ratio (const Vector<Number> &a,
   // we overwrite them anyway
   reinit (a.size(), true);
 
-  internal::VectorOperations::Vectorization_ratio<Number> vector_ratio(val, a.val, b.val);
+  internal::VectorOperations::Vectorization_ratio<Number> vector_ratio(values, a.values, b.values);
   internal::VectorOperations::parallel_for(vector_ratio,0,vec_size,thread_loop_partitioner);
 }
 
@@ -772,7 +772,7 @@ Vector<Number>::operator= (const BlockVector<Number> &v)
   size_type this_index = 0;
   for (size_type b=0; b<v.n_blocks(); ++b)
     for (size_type i=0; i<v.block(b).size(); ++i, ++this_index)
-      val[this_index] = v.block(b)(i);
+      values[this_index] = v.block(b)(i);
 
   return *this;
 }
@@ -837,7 +837,7 @@ Vector<Number>::operator== (const Vector<Number2> &v) const
   // operator==(complex<float>,complex<double>)
   // is not defined by default
   for (size_type i=0; i<vec_size; ++i)
-    if (val[i] != Number(v.val[i]))
+    if (values[i] != Number(v.values[i]))
       return false;
 
   return true;
@@ -851,7 +851,7 @@ void Vector<Number>::print (const char *format) const
   Assert (vec_size!=0, ExcEmptyObject());
 
   for (size_type j=0; j<size(); ++j)
-    internal::VectorOperations::print (val[j], format);
+    internal::VectorOperations::print (values[j], format);
   std::printf ("\n");
 }
 
@@ -877,10 +877,10 @@ void Vector<Number>::print (std::ostream      &out,
 
   if (across)
     for (size_type i=0; i<size(); ++i)
-      out << val[i] << ' ';
+      out << values[i] << ' ';
   else
     for (size_type i=0; i<size(); ++i)
-      out << val[i] << std::endl;
+      out << values[i] << std::endl;
   out << std::endl;
 
   AssertThrow (out, ExcIO());
@@ -899,10 +899,10 @@ Vector<Number>::print (LogStream &out, const unsigned int width, const bool acro
 
   if (across)
     for (size_type i=0; i<size(); ++i)
-      out << std::setw(width) << val[i] << ' ';
+      out << std::setw(width) << values[i] << ' ';
   else
     for (size_type i=0; i<size(); ++i)
-      out << val[i] << std::endl;
+      out << values[i] << std::endl;
   out << std::endl;
 }
 
@@ -998,10 +998,10 @@ void
 Vector<Number>::allocate()
 {
   // make sure that we don't create a memory leak
-  Assert (val == nullptr, ExcInternalError());
+  Assert (values == nullptr, ExcInternalError());
 
   // then allocate memory with the proper alignment requirements of 64 bytes
-  Utilities::System::posix_memalign ((void **)&val, 64, sizeof(Number)*max_vec_size);
+  Utilities::System::posix_memalign ((void **)&values, 64, sizeof(Number)*max_vec_size);
 }
 
 
@@ -1010,8 +1010,8 @@ template <typename Number>
 void
 Vector<Number>::deallocate()
 {
-  free(val);
-  val = nullptr;
+  free(values);
+  values = nullptr;
 }
 
 DEAL_II_NAMESPACE_CLOSE
index 730e4e2cb7a1464ae04738810fe46806349a1c2d..ed22d53ed3a39c8697f73eeedda763a5edc99d4f 100644 (file)
@@ -238,7 +238,7 @@ VectorView<Number>::VectorView(const size_type new_size, Number *ptr)
 {
   this->vec_size      = new_size;
   this->max_vec_size  = new_size;
-  this->val           = ptr;
+  this->values        = ptr;
 }
 
 
@@ -249,7 +249,7 @@ VectorView<Number>::VectorView(const size_type new_size, const Number *ptr)
 {
   this->vec_size      = new_size;
   this->max_vec_size  = new_size;
-  this->val           = const_cast<Number *>(ptr);
+  this->values        = const_cast<Number *>(ptr);
 }
 
 
@@ -262,7 +262,7 @@ VectorView<Number>::~VectorView()
   // memory it doesn't own
   this->vec_size = 0;
   this->max_vec_size = 0;
-  this->val = nullptr;
+  this->values = nullptr;
 }
 
 
@@ -284,7 +284,7 @@ void VectorView<Number>::reinit(const size_type new_size, Number *ptr)
 {
   this->vec_size      = new_size;
   this->max_vec_size  = new_size;
-  this->val           = ptr;
+  this->values        = ptr;
 }
 
 
@@ -294,7 +294,7 @@ void VectorView<Number>::reinit(const size_type new_size, const Number *ptr)
 {
   this->vec_size      = new_size;
   this->max_vec_size  = new_size;
-  this->val           = const_cast<Number *>(ptr);
+  this->values        = const_cast<Number *>(ptr);
 }
 
 
index 6be51ecfa3743364486127aacfeb37047b74664c..570b1a343fd17479c3a089cd0ab99dcc8ad8625c 100644 (file)
@@ -192,7 +192,7 @@ LAPACKFullMatrix<number>::vmult (
       AssertDimension(v.size(), this->n_cols());
       AssertDimension(w.size(), this->n_rows());
 
-      gemv("N", &mm, &nn, &alpha, &this->values[0], &mm, v.val, &one, &beta, w.val, &one);
+      gemv("N", &mm, &nn, &alpha, &this->values[0], &mm, v.values, &one, &beta, w.values, &one);
       break;
     }
     case svd:
@@ -202,12 +202,12 @@ LAPACKFullMatrix<number>::vmult (
       AssertDimension(w.size(), this->n_rows());
       // Compute V^T v
       work.resize(std::max(mm,nn));
-      gemv("N", &nn, &nn, &alpha, &svd_vt->values[0], &nn, v.val, &one, &null, work.data(), &one);
+      gemv("N", &nn, &nn, &alpha, &svd_vt->values[0], &nn, v.values, &one, &null, work.data(), &one);
       // Multiply by singular values
       for (size_type i=0; i<wr.size(); ++i)
         work[i] *= wr[i];
       // Multiply with U
-      gemv("N", &mm, &mm, &alpha, &svd_u->values[0], &mm, work.data(), &one, &beta, w.val, &one);
+      gemv("N", &mm, &mm, &alpha, &svd_u->values[0], &mm, work.data(), &one, &beta, w.values, &one);
       break;
     }
     case inverse_svd:
@@ -217,12 +217,12 @@ LAPACKFullMatrix<number>::vmult (
       AssertDimension(v.size(), this->n_rows());
       // Compute U^T v
       work.resize(std::max(mm,nn));
-      gemv("T", &mm, &mm, &alpha, &svd_u->values[0], &mm, v.val, &one, &null, work.data(), &one);
+      gemv("T", &mm, &mm, &alpha, &svd_u->values[0], &mm, v.values, &one, &null, work.data(), &one);
       // Multiply by singular values
       for (size_type i=0; i<wr.size(); ++i)
         work[i] *= wr[i];
       // Multiply with V
-      gemv("T", &nn, &nn, &alpha, &svd_vt->values[0], &nn, work.data(), &one, &beta, w.val, &one);
+      gemv("T", &nn, &nn, &alpha, &svd_vt->values[0], &nn, work.data(), &one, &beta, w.values, &one);
       break;
     }
     default:
@@ -252,7 +252,7 @@ LAPACKFullMatrix<number>::Tvmult (
       AssertDimension(w.size(), this->n_cols());
       AssertDimension(v.size(), this->n_rows());
 
-      gemv("T", &mm, &nn, &alpha, &this->values[0], &mm, v.val, &one, &beta, w.val, &one);
+      gemv("T", &mm, &nn, &alpha, &this->values[0], &mm, v.values, &one, &beta, w.values, &one);
       break;
     }
     case svd:
@@ -263,12 +263,12 @@ LAPACKFullMatrix<number>::Tvmult (
 
       // Compute U^T v
       work.resize(std::max(mm,nn));
-      gemv("T", &mm, &mm, &alpha, &svd_u->values[0], &mm, v.val, &one, &null, work.data(), &one);
+      gemv("T", &mm, &mm, &alpha, &svd_u->values[0], &mm, v.values, &one, &null, work.data(), &one);
       // Multiply by singular values
       for (size_type i=0; i<wr.size(); ++i)
         work[i] *= wr[i];
       // Multiply with V
-      gemv("T", &nn, &nn, &alpha, &svd_vt->values[0], &nn, work.data(), &one, &beta, w.val, &one);
+      gemv("T", &nn, &nn, &alpha, &svd_vt->values[0], &nn, work.data(), &one, &beta, w.values, &one);
       break;
     }
     case inverse_svd:
@@ -279,12 +279,12 @@ LAPACKFullMatrix<number>::Tvmult (
 
       // Compute V^T v
       work.resize(std::max(mm,nn));
-      gemv("N", &nn, &nn, &alpha, &svd_vt->values[0], &nn, v.val, &one, &null, work.data(), &one);
+      gemv("N", &nn, &nn, &alpha, &svd_vt->values[0], &nn, v.values, &one, &null, work.data(), &one);
       // Multiply by singular values
       for (size_type i=0; i<wr.size(); ++i)
         work[i] *= wr[i];
       // Multiply with U
-      gemv("N", &mm, &mm, &alpha, &svd_u->values[0], &mm, work.data(), &one, &beta, w.val, &one);
+      gemv("N", &mm, &mm, &alpha, &svd_u->values[0], &mm, work.data(), &one, &beta, w.values, &one);
       break;
     }
     default:
index fa8d5f32345a03326eb7c8e187fd8b4110e22b11..3637c9a8ef329445686034f59de2c6abd9098417 100644 (file)
@@ -35,7 +35,7 @@ namespace dealii
   {
     Number sum = 0;
     for (unsigned int i=0; i<size(); ++i)
-      sum += val[i] * v.val[i];
+      sum += values[i] * v.values[i];
     return sum;
   }
   template <typename Number>
@@ -43,7 +43,7 @@ namespace dealii
   {
     real_type sum = 0;
     for (unsigned int i=0; i<size(); ++i)
-      sum += val[i] * val[i];
+      sum += values[i] * values[i];
     return std::sqrt(sum);
   }
 }
index 13241a1518d0178bb832f9395b26326e1e8673d3..cb776b29ecb1222e8c2319d62c285df5001bd143 100644 (file)
@@ -35,7 +35,7 @@ namespace dealii
   {
     Number sum = 0;
     for (unsigned int i=0; i<size(); ++i)
-      sum += val[i] * v.val[i];
+      sum += values[i] * v.values[i];
     return sum;
   }
   template <typename Number>
@@ -43,7 +43,7 @@ namespace dealii
   {
     real_type sum = 0;
     for (unsigned int i=0; i<size(); ++i)
-      sum += val[i] * val[i];
+      sum += values[i] * values[i];
     return std::sqrt(sum);
   }
 }

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.