]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
The new parser in gcc CVS has a lot to say, so fix the respective places. They belong...
authordeal <deal@0785d39b-7218-0410-832d-ea1e28bc413d>
Fri, 3 Jan 2003 22:21:47 +0000 (22:21 +0000)
committerdeal <deal@0785d39b-7218-0410-832d-ea1e28bc413d>
Fri, 3 Jan 2003 22:21:47 +0000 (22:21 +0000)
git-svn-id: https://svn.dealii.org/trunk@6862 0785d39b-7218-0410-832d-ea1e28bc413d

153 files changed:
deal.II/base/include/base/config.h.in
deal.II/base/include/base/data_out_base.h
deal.II/base/include/base/exceptions.h
deal.II/base/include/base/function_time.h
deal.II/base/include/base/logstream.h
deal.II/base/include/base/memory_consumption.h
deal.II/base/include/base/parameter_handler.h
deal.II/base/include/base/point.h
deal.II/base/include/base/smartpointer.h
deal.II/base/include/base/table.h
deal.II/base/include/base/tensor.h
deal.II/base/include/base/tensor_base.h
deal.II/base/include/base/thread_management.h
deal.II/base/source/data_out_base.cc
deal.II/base/source/exceptions.cc
deal.II/base/source/function.cc
deal.II/base/source/function_derivative.cc
deal.II/base/source/function_lib.cc
deal.II/base/source/function_time.cc
deal.II/base/source/log.cc
deal.II/base/source/memory_consumption.cc
deal.II/base/source/multithread_info.cc
deal.II/base/source/parameter_handler.cc
deal.II/base/source/polynomial.cc
deal.II/base/source/polynomial_space.cc
deal.II/base/source/quadrature.cc
deal.II/base/source/quadrature_lib.cc
deal.II/base/source/subscriptor.cc
deal.II/base/source/tensor_function.cc
deal.II/base/source/thread_management.cc
deal.II/configure.in
deal.II/deal.II/include/dofs/dof_accessor.templates.h
deal.II/deal.II/include/dofs/dof_constraints.templates.h
deal.II/deal.II/include/dofs/dof_handler.h
deal.II/deal.II/include/dofs/dof_tools.h
deal.II/deal.II/include/fe/fe_base.h
deal.II/deal.II/include/fe/fe_values.h
deal.II/deal.II/include/fe/mapping.h
deal.II/deal.II/include/grid/geometry_info.h
deal.II/deal.II/include/grid/grid_out.h
deal.II/deal.II/include/grid/grid_tools.h
deal.II/deal.II/include/grid/tria_accessor.templates.h
deal.II/deal.II/include/grid/tria_hex.h
deal.II/deal.II/include/grid/tria_iterator.h
deal.II/deal.II/include/grid/tria_iterator.templates.h
deal.II/deal.II/include/grid/tria_iterator_base.h
deal.II/deal.II/include/grid/tria_line.h
deal.II/deal.II/include/grid/tria_quad.h
deal.II/deal.II/include/multigrid/mg_base.h
deal.II/deal.II/include/multigrid/mg_dof_accessor.h
deal.II/deal.II/include/multigrid/mg_dof_handler.h
deal.II/deal.II/include/multigrid/mg_smoother.h
deal.II/deal.II/include/multigrid/mg_smoother.templates.h
deal.II/deal.II/include/numerics/time_dependent.h
deal.II/deal.II/source/dofs/dof_accessor.cc
deal.II/deal.II/source/dofs/dof_constraints.cc
deal.II/deal.II/source/dofs/dof_handler.cc
deal.II/deal.II/source/dofs/dof_levels.cc
deal.II/deal.II/source/dofs/dof_renumbering.cc
deal.II/deal.II/source/dofs/dof_tools.cc
deal.II/deal.II/source/fe/fe.cc
deal.II/deal.II/source/fe/fe_data.cc
deal.II/deal.II/source/fe/fe_dgp.cc
deal.II/deal.II/source/fe/fe_dgp_1d.cc
deal.II/deal.II/source/fe/fe_dgp_2d.cc
deal.II/deal.II/source/fe/fe_dgp_3d.cc
deal.II/deal.II/source/fe/fe_dgp_nonparametric.cc
deal.II/deal.II/source/fe/fe_dgq.cc
deal.II/deal.II/source/fe/fe_dgq_1d.cc
deal.II/deal.II/source/fe/fe_dgq_2d.cc
deal.II/deal.II/source/fe/fe_dgq_3d.cc
deal.II/deal.II/source/fe/fe_nedelec.cc
deal.II/deal.II/source/fe/fe_nedelec_1d.cc
deal.II/deal.II/source/fe/fe_nedelec_2d.cc
deal.II/deal.II/source/fe/fe_nedelec_3d.cc
deal.II/deal.II/source/fe/fe_q.cc
deal.II/deal.II/source/fe/fe_q_1d.cc
deal.II/deal.II/source/fe/fe_q_2d.cc
deal.II/deal.II/source/fe/fe_q_3d.cc
deal.II/deal.II/source/fe/fe_q_hierarchical.cc
deal.II/deal.II/source/fe/fe_system.cc
deal.II/deal.II/source/fe/fe_tools.cc
deal.II/deal.II/source/fe/fe_values.cc
deal.II/deal.II/source/fe/mapping_c1.cc
deal.II/deal.II/source/fe/mapping_cartesian.cc
deal.II/deal.II/source/fe/mapping_q.cc
deal.II/deal.II/source/fe/mapping_q1.cc
deal.II/deal.II/source/grid/geometry_info.cc
deal.II/deal.II/source/grid/grid_generator.cc
deal.II/deal.II/source/grid/grid_in.cc
deal.II/deal.II/source/grid/grid_out.all_dimensions.cc
deal.II/deal.II/source/grid/grid_out.cc
deal.II/deal.II/source/grid/grid_refinement.cc
deal.II/deal.II/source/grid/grid_reordering.cc
deal.II/deal.II/source/grid/grid_tools.cc
deal.II/deal.II/source/grid/intergrid_map.cc
deal.II/deal.II/source/grid/persistent_tria.cc
deal.II/deal.II/source/grid/tria.all_dimensions.cc
deal.II/deal.II/source/grid/tria.cc
deal.II/deal.II/source/grid/tria_accessor.cc
deal.II/deal.II/source/grid/tria_boundary.cc
deal.II/deal.II/source/grid/tria_boundary_lib.cc
deal.II/deal.II/source/multigrid/mg_base.cc
deal.II/deal.II/source/multigrid/mg_dof_accessor.cc
deal.II/deal.II/source/multigrid/mg_dof_handler.cc
deal.II/deal.II/source/multigrid/mg_smoother.cc
deal.II/deal.II/source/multigrid/multigrid.all_dimensions.cc
deal.II/deal.II/source/multigrid/multigrid.cc
deal.II/deal.II/source/numerics/data_out.cc
deal.II/deal.II/source/numerics/data_out_faces.cc
deal.II/deal.II/source/numerics/derivative_approximation.cc
deal.II/deal.II/source/numerics/error_estimator.cc
deal.II/deal.II/source/numerics/histogram.cc
deal.II/deal.II/source/numerics/matrices.all_dimensions.cc
deal.II/deal.II/source/numerics/matrices.cc
deal.II/deal.II/source/numerics/solution_transfer.cc
deal.II/deal.II/source/numerics/time_dependent.cc
deal.II/deal.II/source/numerics/vectors.all_dimensions.cc
deal.II/deal.II/source/numerics/vectors.cc
deal.II/lac/include/lac/block_indices.h
deal.II/lac/include/lac/block_sparse_matrix.h
deal.II/lac/include/lac/block_sparse_matrix.templates.h
deal.II/lac/include/lac/block_sparsity_pattern.h
deal.II/lac/include/lac/block_vector.h
deal.II/lac/include/lac/block_vector.templates.h
deal.II/lac/include/lac/compressed_sparsity_pattern.h
deal.II/lac/include/lac/filtered_matrix.h
deal.II/lac/include/lac/filtered_matrix.templates.h
deal.II/lac/include/lac/full_matrix.h
deal.II/lac/include/lac/full_matrix.templates.h
deal.II/lac/include/lac/matrix_out.h
deal.II/lac/include/lac/precondition_block.templates.h
deal.II/lac/include/lac/solver.h
deal.II/lac/include/lac/solver_cg.h
deal.II/lac/include/lac/sparse_decomposition.h
deal.II/lac/include/lac/sparse_ilu.h
deal.II/lac/include/lac/sparse_ilu.templates.h
deal.II/lac/include/lac/sparse_matrix.h
deal.II/lac/include/lac/sparse_matrix.templates.h
deal.II/lac/include/lac/sparse_mic.templates.h
deal.II/lac/include/lac/sparse_vanka.templates.h
deal.II/lac/include/lac/sparsity_pattern.h
deal.II/lac/include/lac/swappable_vector.templates.h
deal.II/lac/include/lac/vector.h
deal.II/lac/include/lac/vector.templates.h
deal.II/lac/source/block_sparsity_pattern.cc
deal.II/lac/source/block_vector.cc
deal.II/lac/source/compressed_sparsity_pattern.cc
deal.II/lac/source/filtered_matrix.cc
deal.II/lac/source/matrix_out.cc
deal.II/lac/source/solver_control.cc
deal.II/lac/source/sparse_direct.cc
deal.II/lac/source/sparsity_pattern.cc

index 42bdc72147fd54465743ed47c4556de9dd0bb015..e9bf8556f5b296dae5b42c188610a162b232df02 100644 (file)
@@ -5,7 +5,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2001, 2002 by the deal.II authors
+//    Copyright (C) 2001, 2002, 2003 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -268,6 +268,6 @@ namespace deal_II_numbers {
                                               * 1/sqrt(2)
                                               */
   static const double  SQRT1_2 = 0.70710678118654752440;
-};
+}
 #endif
 
index aab724c0ec47e05710c91483bb1327debdd30392..9c03f445e55c1e62cd382a6a29e405d7f3e52037 100644 (file)
@@ -2062,7 +2062,7 @@ bool
 DataOutBase::EpsFlags::RgbValues::is_grey () const 
 {
   return (red == green) && (red == blue);
-};
+}
 
 
 
index 34924656e6ac5a300d9d87ccfc0b5bd9203fc5ea..7ad7fd9ba6d82d27b33231538e84431ada0cb9c3 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1998, 1999, 2000, 2001, 2002 by the deal.II authors
+//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -531,7 +531,7 @@ namespace deal_II_exceptions
 
   }
   
-};
+}
 
 
 
@@ -934,7 +934,7 @@ namespace StandardExceptions
                  << arg1 << " switch. You should either use an\n"
                  << "alternative function, or configure again without\n"
                  << "this switch and recompile the library.");
-};
+}
 
 
 using namespace StandardExceptions;
index f90894386ccb55757ccc8fb72a6c112d38881eaa..a747284bb916f1391314ff4c33f5b4aef088f3f5 100644 (file)
@@ -105,7 +105,7 @@ inline double
 FunctionTime::get_time () const
 {
   return time;
-};
+}
 
 
 #endif
index ee1b9c7c14cbf031a03cff8e3458c71602134720..a392404c82a99ab0d2caef9e66f9a14a5512859d 100644 (file)
@@ -306,7 +306,7 @@ LogStream::operator<< (const T& t)
                                   // the two operator<< functions
   print (t);
   return *this;
-};
+}
 
 
 
@@ -326,7 +326,7 @@ LogStream::operator<< (std::ostream& (*p) (std::ostream&))
     was_endl = true;
 
   return *this;
-};
+}
 
 
 
index aae8b8a1d17037e33a7ce7dc06ee1800d819cb20..017f5c583fd70f027159ab30a7d2c5b5e2ea1c74 100644 (file)
@@ -393,7 +393,7 @@ namespace MemoryConsumption
   unsigned int memory_consumption (const bool) 
   {
     return sizeof(bool);
-  };
+  }
   
   
   
@@ -401,7 +401,7 @@ namespace MemoryConsumption
   unsigned int memory_consumption (const char)
   {
     return sizeof(char);
-  };
+  }
   
 
 
@@ -409,7 +409,7 @@ namespace MemoryConsumption
   unsigned int memory_consumption (const short int) 
   {
     return sizeof(short int);
-  };
+  }
   
 
 
@@ -417,7 +417,7 @@ namespace MemoryConsumption
   unsigned int memory_consumption (const short unsigned int) 
   {
     return sizeof(short unsigned int);
-  };
+  }
 
 
 
@@ -425,7 +425,7 @@ namespace MemoryConsumption
   unsigned int memory_consumption (const int) 
   {
     return sizeof(int);
-  };
+  }
   
 
 
@@ -433,7 +433,7 @@ namespace MemoryConsumption
   unsigned int memory_consumption (const unsigned int) 
   {
     return sizeof(unsigned int);
-  };
+  }
 
 
 
@@ -441,7 +441,7 @@ namespace MemoryConsumption
   unsigned int memory_consumption (const float)
   {
     return sizeof(float);
-  };
+  }
 
 
 
@@ -449,7 +449,7 @@ namespace MemoryConsumption
   unsigned int memory_consumption (const double)
   {
     return sizeof(double);
-  };
+  }
 
 
   
@@ -457,7 +457,7 @@ namespace MemoryConsumption
   unsigned int memory_consumption (const std::string &s)
   {
     return sizeof(s) + s.length();
-  };  
+  }
 
 
 // if necessary try to work around a bug in the IBM xlC compiler
index 5a25b13ae884a40030e88d8cbc72db7eb576c03a..a9798122fda329a70f61ab56032135401ca164d9 100644 (file)
@@ -738,7 +738,7 @@ namespace Patterns
                                        */
       virtual PatternBase * clone () const;
   };
-};
+}
 
 
 /**
index 71e53792edb97b2290dc3f943badaa701682b244..4c224d9983ec4c2a6fe1bc057532e5940e0c12d6 100644 (file)
@@ -176,7 +176,7 @@ class Point : public Tensor<1,dim>
 template <int dim>
 inline
 Point<dim>::Point ()
-{};
+{}
 
 
 
@@ -184,7 +184,7 @@ template <int dim>
 inline
 Point<dim>::Point (const bool initialize) :
                Tensor<1,dim>(initialize) 
-{};
+{}
 
 
 
@@ -192,7 +192,7 @@ template <int dim>
 inline
 Point<dim>::Point (const Tensor<1,dim> &t) :
                Tensor<1,dim>(t) 
-{};
+{}
 
 
 
@@ -202,7 +202,7 @@ Point<dim>::Point (const double x)
 {
   Assert (dim==1, ExcInvalidConstructorCalled());
   this->values[0] = x;
-};
+}
 
 
 
@@ -213,7 +213,7 @@ Point<dim>::Point (const double x, const double y)
   Assert (dim==2, ExcInvalidConstructorCalled());
   this->values[0] = x;
   this->values[1] = y;
-};
+}
 
 
 
@@ -225,7 +225,7 @@ Point<dim>::Point (const double x, const double y, const double z)
   this->values[0] = x;
   this->values[1] = y;
   this->values[2] = z;
-};
+}
 
 
 
@@ -235,7 +235,7 @@ double Point<dim>::operator () (const unsigned int index) const
 {
   Assert (index<dim, ExcIndexRange (index, 0, dim));
   return this->values[index];
-};
+}
 
 
 
@@ -245,7 +245,7 @@ double & Point<dim>::operator () (const unsigned int index)
 {
   Assert (index<dim, ExcIndexRange (index, 0, dim));
   return this->values[index];
-};
+}
 
 
 
@@ -254,7 +254,7 @@ inline
 Point<dim> Point<dim>::operator + (const Tensor<1,dim> &p) const 
 {
   return (Point<dim>(*this) += p);
-};
+}
 
 
 
@@ -263,7 +263,7 @@ inline
 Point<dim> Point<dim>::operator - (const Tensor<1,dim> &p) const 
 {
   return (Point<dim>(*this) -= p);
-};
+}
 
 
 
@@ -275,7 +275,7 @@ Point<dim> Point<dim>::operator - () const
   for (unsigned int i=0; i<dim; ++i)
     result.values[i] = -this->values[i];
   return result;
-};
+}
 
 
 
@@ -284,7 +284,7 @@ inline
 Point<dim> Point<dim>::operator * (const double factor) const 
 {
   return (Point<dim>(*this) *= factor);
-};
+}
 
 
 
@@ -294,7 +294,7 @@ double Point<dim>::operator * (const Tensor<1,dim> &p) const
 {
                                   // simply pass down
   return Tensor<1,dim>::operator * (p);
-};
+}
 
 
 template <int dim>
@@ -305,7 +305,7 @@ double Point<dim>::square () const
   for (unsigned int i=0; i<dim; ++i)
     q += this->values[i] * this->values[i];
   return q;
-};
+}
 
 
 template <int dim>
@@ -328,7 +328,7 @@ inline
 Point<dim> Point<dim>::operator / (const double factor) const 
 {
   return (Point<dim>(*this) /= factor);
-};
+}
 
 
 
@@ -343,7 +343,7 @@ inline
 Point<dim> operator * (const double factor, const Point<dim> &p) 
 {
   return p*factor;
-};
+}
 
 
 /**
@@ -359,7 +359,7 @@ std::ostream & operator << (std::ostream &out, const Point<dim> &p)
   out << p[dim-1];
 
   return out;
-};
+}
 
 
 
@@ -374,6 +374,6 @@ std::ostream & operator << (std::ostream &out, const Point<1> &p)
   out << p[0];
 
   return out;
-};
+}
 
 #endif
index 8d2a5d6d83619f2b77d59e9a7c00f48d922f3042..ef32d229f39edf00a7fd4fc7c35c759797ecd6df 100644 (file)
@@ -185,7 +185,7 @@ class SmartPointer
 template <typename T>
 SmartPointer<T>::SmartPointer () :
                t (0)
-{};
+{}
 
 
 
@@ -195,7 +195,7 @@ SmartPointer<T>::SmartPointer (T *t) :
 {
   if (t != 0)
     t->subscribe();
-};
+}
 
 
 
@@ -205,7 +205,7 @@ SmartPointer<T>::SmartPointer (const SmartPointer<T> &tt) :
 {
   if (t != 0)
     t->subscribe();
-};
+}
 
 
 
@@ -214,7 +214,7 @@ SmartPointer<T>::~SmartPointer ()
 {
   if (t != 0)
     t->unsubscribe();
-};
+}
 
 
 
@@ -232,7 +232,7 @@ SmartPointer<T> & SmartPointer<T>::operator = (T *tt)
   if (tt != 0)
     tt->subscribe();
   return *this;
-};
+}
 
 
 
@@ -251,7 +251,7 @@ SmartPointer<T> & SmartPointer<T>::operator = (const SmartPointer<T>& tt)
   if (tt != 0)
     tt->subscribe();
   return *this;
-};
+}
 
 
 
@@ -260,7 +260,7 @@ inline
 SmartPointer<T>::operator T* () const
 {
   return t;
-};
+}
 
 
 
@@ -269,7 +269,7 @@ inline
 T & SmartPointer<T>::operator * () const
 {
   return *t;
-};
+}
 
 
 
@@ -278,7 +278,7 @@ inline
 T * SmartPointer<T>::operator -> () const
 {
   return t;
-};
+}
 
 
 
@@ -287,7 +287,7 @@ inline
 void SmartPointer<T>::swap (SmartPointer<T> &tt)
 {
   swap (t, tt.t);
-};
+}
 
 
 
@@ -302,7 +302,7 @@ void SmartPointer<T>::swap (T *&tt)
 
   if (t != 0)
     t->subscribe ();
-};
+}
 
 
 
@@ -311,7 +311,7 @@ inline
 unsigned int SmartPointer<T>::memory_consumption () const
 {
   return sizeof(SmartPointer<T>);
-};
+}
 
 
 
@@ -326,7 +326,7 @@ inline
 void swap (SmartPointer<T> &t1, SmartPointer<T> &t2)
 {
   t1.swap (t2);
-};
+}
 
 
 
@@ -342,7 +342,7 @@ inline
 void swap (SmartPointer<T> &t1, T *&t2)
 {
   t1.swap (t2);
-};
+}
 
 
 
@@ -358,7 +358,7 @@ inline
 void swap (T *&t1, SmartPointer<T> &t2)
 {
   t2.swap (t1);
-};
+}
 
 
 #endif
index 5de5813aa91d0e4149b391af407b941a172b2cff..098f69999fa350eab6ffada5e4ace9263c7e05d9 100644 (file)
@@ -615,7 +615,7 @@ namespace TableBaseAccessors
       friend class Accessor<N,T,C,2>;
 #endif
   };
-};
+}
   
 
 
@@ -1552,7 +1552,7 @@ TableIndicesBase<N>::operator [] (const unsigned int i) const
 {
   Assert (i < N, ExcIndexRange (i, 0, N));
   return indices[i];
-};
+}
 
 
 
@@ -1560,7 +1560,7 @@ inline
 TableIndices<1>::TableIndices () 
 {
   this->indices[0] = 0;
-};
+}
 
 
 
@@ -1568,7 +1568,7 @@ inline
 TableIndices<1>::TableIndices (const unsigned int index1) 
 {
   this->indices[0] = index1;
-};
+}
 
 
 
@@ -1576,7 +1576,7 @@ inline
 TableIndices<2>::TableIndices () 
 {
   this->indices[0] = this->indices[1] = 0;
-};
+}
 
 
 
@@ -1586,7 +1586,7 @@ TableIndices<2>::TableIndices (const unsigned int index1,
 {
   this->indices[0] = index1;
   this->indices[1] = index2;
-};
+}
 
 
 
@@ -1594,7 +1594,7 @@ inline
 TableIndices<3>::TableIndices () 
 {
   this->indices[0] = this->indices[1] = this->indices[2] = 0;
-};
+}
 
 
 
@@ -1606,14 +1606,14 @@ TableIndices<3>::TableIndices (const unsigned int index1,
   this->indices[0] = index1;
   this->indices[1] = index2;
   this->indices[2] = index3;
-};
+}
 
 
 inline
 TableIndices<4>::TableIndices () 
 {
   this->indices[0] = this->indices[1] = this->indices[2] = this->indices[3] = 0;
-};
+}
 
 
 
@@ -1627,7 +1627,7 @@ TableIndices<4>::TableIndices (const unsigned int index1,
   this->indices[1] = index2;
   this->indices[2] = index3;
   this->indices[3] = index4;
-};
+}
 
 
 
@@ -1635,7 +1635,7 @@ inline
 TableIndices<5>::TableIndices () 
 {
   this->indices[0] = this->indices[1] = this->indices[2] = this->indices[3] = this->indices[4] = 0;
-};
+}
 
 
 
@@ -1651,7 +1651,7 @@ TableIndices<5>::TableIndices (const unsigned int index1,
   this->indices[2] = index3;
   this->indices[3] = index4;
   this->indices[4] = index5;
-};
+}
 
 
 
@@ -1660,7 +1660,7 @@ TableIndices<6>::TableIndices ()
 {
   this->indices[0] = this->indices[1] = this->indices[2]
                   = this->indices[3] = this->indices[4] = 0;
-};
+}
 
 
 
@@ -1678,7 +1678,7 @@ TableIndices<6>::TableIndices (const unsigned int index1,
   this->indices[3] = index4;
   this->indices[4] = index5;
   this->indices[5] = index6;
-};
+}
 
 
 
@@ -1687,7 +1687,7 @@ TableBase<N,T>::TableBase ()
                 :
                 val (0),
                 val_size (0)
-{};
+{}
 
 
 
@@ -1698,7 +1698,7 @@ TableBase<N,T>::TableBase (const TableIndices<N> &sizes)
                 val_size (0)
 {
   reinit (sizes);
-};
+}
 
 
 
@@ -1712,7 +1712,7 @@ TableBase<N,T>::TableBase (const TableBase<N,T> &src)
   reinit (src.table_size);
   if (src.n_elements() != 0)
     fill (src.data());
-};
+}
 
 
 
@@ -1726,7 +1726,7 @@ TableBase<N,T>::TableBase (const TableBase<N,T2> &src)
   reinit (src.table_size);
   if (src.n_elements() != 0)
     fill (src.data());
-};
+}
 
 
 
@@ -1739,7 +1739,7 @@ namespace TableBaseAccessors
                   :
                   table (table),
                   data (data)
-  {};
+  {}
 
 
 
@@ -1754,7 +1754,7 @@ namespace TableBaseAccessors
                                      // temporary objects, so should
                                      // not need to be copied around
     Assert (false, ExcInternalError());
-  };
+  }
   
 
   
@@ -1769,7 +1769,7 @@ namespace TableBaseAccessors
                                      // temporary objects, so should
                                      // not need to be copied around
     Assert (false, ExcInternalError());
-  };
+  }
   
 
   
@@ -1797,7 +1797,7 @@ namespace TableBaseAccessors
         const pointer new_data = data + i*subobject_size;
         return Accessor<N,T,C,P-1> (table, new_data);
       };
-  };
+  }
 
 
 
@@ -1808,7 +1808,7 @@ namespace TableBaseAccessors
                   :
                   table (table),
                   data (data)
-  {};
+  {}
 
 
 
@@ -1823,7 +1823,7 @@ namespace TableBaseAccessors
                                      // temporary objects, so should
                                      // not need to be copied around
     Assert (false, ExcInternalError());
-  };
+  }
   
 
 
@@ -1838,7 +1838,7 @@ namespace TableBaseAccessors
                                      // temporary objects, so should
                                      // not need to be copied around
     Assert (false, ExcInternalError());
-  };  
+  }
 
 
   
@@ -1850,7 +1850,7 @@ namespace TableBaseAccessors
     Assert (i < table.size()[N-1],
             ExcIndexRange (i, 0, table.size()[N-1]));
     return data[i];
-  };
+  }
 
 
   
@@ -1860,7 +1860,7 @@ namespace TableBaseAccessors
   Accessor<N,T,C,1>::size () const
   {
     return table.size()[N-1];
-  };
+  }
 
 
 
@@ -1870,7 +1870,7 @@ namespace TableBaseAccessors
   Accessor<N,T,C,1>::begin () const
   {
     return data;
-  };
+  }
 
 
 
@@ -1880,8 +1880,8 @@ namespace TableBaseAccessors
   Accessor<N,T,C,1>::end () const
   {
     return data+table.size()[N-1];
-  };
-};
+  }
+}
 
 
 
@@ -1891,7 +1891,7 @@ TableBase<N,T>::~TableBase ()
 {
   if (val != 0)
     delete[] val;
-};
+}
 
 
 
@@ -1929,7 +1929,7 @@ TableBase<N,T>::clear ()
 {
   if (n_elements() != 0)
     std::fill_n (val, n_elements(), T());
-};
+}
 
 
 
@@ -1975,7 +1975,7 @@ TableBase<N,T>::reinit (const TableIndices<N> &new_sizes)
                                    // reinitialize contents of old or
                                    // new memory.
   clear ();
-};
+}
 
 
 
@@ -1984,7 +1984,7 @@ const TableIndices<N> &
 TableBase<N,T>::size () const
 {
   return table_size;
-};
+}
 
 
 
@@ -1996,7 +1996,7 @@ TableBase<N,T>::n_elements () const
   for (unsigned int n=0; n<N; ++n)
     s *= table_size[n];
   return s;
-};
+}
 
 
 
@@ -2005,7 +2005,7 @@ bool
 TableBase<N,T>::empty () const
 {
   return (n_elements() == 0);
-};
+}
 
 
 
@@ -2058,7 +2058,7 @@ TableBase<N,T>::position (const TableIndices<N> &indices) const
         return s;
       };
     };
-};
+}
 
 
 
@@ -2071,7 +2071,7 @@ TableBase<N,T>::operator() (const TableIndices<N> &indices) const
     Assert (indices[n] < table_size[n],
             ExcIndexRange (indices[n], 0, table_size[n]));
   return el(indices);
-};
+}
 
 
 
@@ -2083,7 +2083,7 @@ TableBase<N,T>::operator() (const TableIndices<N> &indices)
     Assert (indices[n] < table_size[n],
             ExcIndexRange (indices[n], 0, table_size[n]));
   return el(indices);
-};
+}
 
 
 
@@ -2092,7 +2092,7 @@ inline const T &
 TableBase<N,T>::el (const TableIndices<N> &indices) const
 {  
   return val[position(indices)];
-};
+}
 
 
 
@@ -2101,7 +2101,7 @@ inline T &
 TableBase<N,T>::el (const TableIndices<N> &indices)
 {
   return val[position(indices)];
-};
+}
 
 
 
@@ -2118,7 +2118,7 @@ TableBase<N,T>::data () const
 
 template <typename T>
 Table<1,T>::Table () 
-{};
+{}
 
 
 
@@ -2126,7 +2126,7 @@ template <typename T>
 Table<1,T>::Table (const unsigned int size)
                 :
                 TableBase<1,T> (TableIndices<1> (size))
-{};
+{}
 
 
 
@@ -2137,7 +2137,7 @@ Table<1,T>::operator [] (const unsigned int i) const
   Assert (i < this->table_size[0],
           ExcIndexRange (i, 0, this->table_size[0]));
   return this->val[i];
-};
+}
 
 
 
@@ -2148,7 +2148,7 @@ Table<1,T>::operator [] (const unsigned int i)
   Assert (i < this->table_size[0],
           ExcIndexRange (i, 0, this->table_size[0]));
   return this->val[i];
-};
+}
 
 
 
@@ -2160,7 +2160,7 @@ Table<1,T>::operator () (const unsigned int i) const
   Assert (i < this->table_size[0],
           ExcIndexRange (i, 0, this->table_size[0]));
   return this->val[i];
-};
+}
 
 
 
@@ -2172,14 +2172,14 @@ Table<1,T>::operator () (const unsigned int i)
   Assert (i < this->table_size[0],
           ExcIndexRange (i, 0, this->table_size[0]));
   return this->val[i];
-};
+}
 
 
 
 
 template <typename T>
 Table<2,T>::Table ()
-{};
+{}
 
 
 
@@ -2188,7 +2188,7 @@ Table<2,T>::Table (const unsigned int size1,
                    const unsigned int size2)
                 :
                 TableBase<2,T> (TableIndices<2> (size1, size2))
-{};
+{}
 
 
 
@@ -2198,7 +2198,7 @@ Table<2,T>::reinit (const unsigned int size1,
                     const unsigned int size2)
 {
   this->TableBase<2,T>::reinit (TableIndices<2> (size1, size2));
-};
+}
 
 
 
@@ -2211,7 +2211,7 @@ Table<2,T>::operator [] (const unsigned int i) const
           ExcIndexRange (i, 0, this->table_size[0]));
   return TableBaseAccessors::Accessor<2,T,true,1>(*this,
                                                   this->val+i*n_cols());
-};
+}
 
 
 
@@ -2224,7 +2224,7 @@ Table<2,T>::operator [] (const unsigned int i)
           ExcIndexRange (i, 0, this->table_size[0]));
   return TableBaseAccessors::Accessor<2,T,false,1>(*this,
                                                    this->val+i*n_cols());
-};
+}
 
 
 
@@ -2239,7 +2239,7 @@ Table<2,T>::operator () (const unsigned int i,
   Assert (j < this->table_size[1],
           ExcIndexRange (j, 0, this->table_size[1]));
   return this->val[i*this->table_size[1]+j];
-};
+}
 
 
 
@@ -2254,7 +2254,7 @@ Table<2,T>::operator () (const unsigned int i,
   Assert (j < this->table_size[1],
           ExcIndexRange (j, 0, this->table_size[1]));
   return this->val[i*this->table_size[1]+j];
-};
+}
 
 
 
@@ -2265,7 +2265,7 @@ Table<2,T>::el (const unsigned int i,
                 const unsigned int j) const
 {
   return this->val[i*this->table_size[1]+j];
-};
+}
 
 
 
@@ -2276,7 +2276,7 @@ Table<2,T>::el (const unsigned int i,
                 const unsigned int j)
 {
   return this->val[i*this->table_size[1]+j];
-};
+}
 
 
 
@@ -2286,7 +2286,7 @@ unsigned int
 Table<2,T>::n_rows () const
 {
   return this->table_size[0];
-};
+}
 
 
 
@@ -2296,7 +2296,7 @@ unsigned int
 Table<2,T>::n_cols () const
 {
   return this->table_size[1];
-};
+}
 
 
 
@@ -2304,7 +2304,7 @@ Table<2,T>::n_cols () const
 
 template <typename T>
 Table<3,T>::Table () 
-{};
+{}
 
 
 
@@ -2314,7 +2314,7 @@ Table<3,T>::Table (const unsigned int size1,
                    const unsigned int size3)
                 :
                 TableBase<3,T> (TableIndices<3> (size1, size2, size3))
-{};
+{}
 
 
 
@@ -2330,7 +2330,7 @@ Table<3,T>::operator [] (const unsigned int i) const
   return (TableBaseAccessors::Accessor<3,T,true,2>
           (*this,
            this->val+i*subobject_size));
-};
+}
 
 
 
@@ -2346,7 +2346,7 @@ Table<3,T>::operator [] (const unsigned int i)
   return (TableBaseAccessors::Accessor<3,T,false,2>
           (*this,
            this->val+i*subobject_size));
-};
+}
 
 
 
@@ -2365,7 +2365,7 @@ Table<3,T>::operator () (const unsigned int i,
           ExcIndexRange (k, 0, this->table_size[2]));
   return this->val[(i*this->table_size[1]+j)
                  *this->table_size[2] + k];
-};
+}
 
 
 
@@ -2384,13 +2384,13 @@ Table<3,T>::operator () (const unsigned int i,
           ExcIndexRange (k, 0, this->table_size[2]));
   return this->val[(i*this->table_size[1]+j)
                  *this->table_size[2] + k];
-};
+}
 
 
 
 template <typename T>
 Table<4,T>::Table () 
-{};
+{}
 
 
 
@@ -2401,7 +2401,7 @@ Table<4,T>::Table (const unsigned int size1,
                   const unsigned int size4)
                 :
                 TableBase<4,T> (TableIndices<4> (size1, size2, size3, size4))
-{};
+{}
 
 
 
@@ -2418,7 +2418,7 @@ Table<4,T>::operator [] (const unsigned int i) const
   return (TableBaseAccessors::Accessor<4,T,true,3>
           (*this,
            this->val+i*subobject_size));
-};
+}
 
 
 
@@ -2435,7 +2435,7 @@ Table<4,T>::operator [] (const unsigned int i)
   return (TableBaseAccessors::Accessor<4,T,false,3>
           (*this,
            this->val+i*subobject_size));
-};
+}
 
 
 
@@ -2458,7 +2458,7 @@ Table<4,T>::operator () (const unsigned int i,
   return this->val[((i*this->table_size[1]+j)
                    *this->table_size[2] + k)
                  *this->table_size[3] + l];
-};
+}
 
 
 
@@ -2481,14 +2481,14 @@ Table<4,T>::operator () (const unsigned int i,
   return this->val[((i*this->table_size[1]+j)
                    *this->table_size[2] + k)
                  *this->table_size[3] + l];
-};
+}
 
 
 
 
 template <typename T>
 Table<5,T>::Table () 
-{};
+{}
 
 
 
@@ -2500,7 +2500,7 @@ Table<5,T>::Table (const unsigned int size1,
                   const unsigned int size5)
                 :
                 TableBase<5,T> (TableIndices<5> (size1, size2, size3, size4, size5))
-{};
+{}
 
 
 
@@ -2518,7 +2518,7 @@ Table<5,T>::operator [] (const unsigned int i) const
   return (TableBaseAccessors::Accessor<5,T,true,4>
           (*this,
            this->val+i*subobject_size));
-};
+}
 
 
 
@@ -2536,7 +2536,7 @@ Table<5,T>::operator [] (const unsigned int i)
   return (TableBaseAccessors::Accessor<5,T,false,4>
           (*this,
            this->val+i*subobject_size));
-};
+}
 
 
 
@@ -2563,7 +2563,7 @@ Table<5,T>::operator () (const unsigned int i,
                     *this->table_size[2] + k)
                    *this->table_size[3] + l)
                  *this->table_size[4] + m];
-};
+}
 
 
 
@@ -2590,13 +2590,13 @@ Table<5,T>::operator () (const unsigned int i,
                     *this->table_size[2] + k)
                    *this->table_size[3] + l)
                  *this->table_size[4] + m];
-};
+}
 
 
 
 template <typename T>
 Table<6,T>::Table () 
-{};
+{}
 
 
 
@@ -2609,7 +2609,7 @@ Table<6,T>::Table (const unsigned int size1,
                   const unsigned int size6)
                 :
                 TableBase<6,T> (TableIndices<6> (size1, size2, size3, size4, size5, size6))
-{};
+{}
 
 
 
@@ -2628,7 +2628,7 @@ Table<6,T>::operator [] (const unsigned int i) const
   return (TableBaseAccessors::Accessor<6,T,true,5>
           (*this,
            this->val+i*subobject_size));
-};
+}
 
 
 
@@ -2647,7 +2647,7 @@ Table<6,T>::operator [] (const unsigned int i)
   return (TableBaseAccessors::Accessor<6,T,false,5>
           (*this,
            this->val+i*subobject_size));
-};
+}
 
 
 
@@ -2678,7 +2678,7 @@ Table<6,T>::operator () (const unsigned int i,
                     *this->table_size[3] + l)
                    *this->table_size[4] + m)
                  *this->table_size[5] + n];
-};
+}
 
 
 
@@ -2709,7 +2709,7 @@ Table<6,T>::operator () (const unsigned int i,
                     *this->table_size[3] + l)
                    *this->table_size[4] + m)
                  *this->table_size[5] + n];
-};
+}
 
 
 
index 2cd00e9ec366b17a69900d42f8eb70782381b5b1..8bafe9c136ea66222ec53c6ececc1f7faaa0bedd 100644 (file)
@@ -224,7 +224,7 @@ Tensor<rank_,dim>::Tensor ()
 // default constructor. not specifying an initializer list calls
 // the default constructor of the subobjects, which initialize them
 // selves. therefore, the tensor is set to zero this way
-};
+}
 
 
 template <int rank_, int dim>
@@ -233,7 +233,7 @@ Tensor<rank_,dim>::Tensor (const array_type &initializer)
 {
   for (unsigned int i=0; i<dim; ++i)
     subtensor[i] =  Tensor<rank_-1,dim>(initializer[i]);
-};
+}
 
 
 template <int rank_, int dim>
@@ -244,7 +244,7 @@ Tensor<rank_,dim>::operator[] (const unsigned int i)
   Assert (i<dim, ExcIndexRange(i, 0, dim));
   
   return subtensor[i];
-};
+}
 
 
 template <int rank_, int dim>
@@ -255,7 +255,7 @@ Tensor<rank_,dim>::operator[] (const unsigned int i) const
   Assert (i<dim, ExcIndexRange(i, 0, dim));
   
   return subtensor[i];
-};
+}
 
 
 template <int rank_, int dim>
@@ -266,7 +266,7 @@ Tensor<rank_,dim>::operator = (const Tensor<rank_,dim> &t)
   for (unsigned int i=0; i<dim; ++i)
     subtensor[i] = t.subtensor[i];
   return *this;
-};
+}
 
 
 template <int rank_, int dim>
@@ -277,7 +277,7 @@ Tensor<rank_,dim>::operator == (const Tensor<rank_,dim> &p) const
   for (unsigned int i=0; i<dim; ++i)
     if (subtensor[i] != p.subtensor[i]) return false;
   return true;
-};
+}
 
 
 template <int rank_, int dim>
@@ -286,7 +286,7 @@ bool
 Tensor<rank_,dim>::operator != (const Tensor<rank_,dim> &p) const
 {
   return !((*this) == p);
-};
+}
 
 
 template <int rank_, int dim>
@@ -297,7 +297,7 @@ Tensor<rank_,dim>::operator += (const Tensor<rank_,dim> &p)
   for (unsigned int i=0; i<dim; ++i)
     subtensor[i] += p.subtensor[i];
   return *this;
-};
+}
 
 
 template <int rank_, int dim>
@@ -308,7 +308,7 @@ Tensor<rank_,dim>::operator -= (const Tensor<rank_,dim> &p)
   for (unsigned int i=0; i<dim; ++i)
     subtensor[i] -= p.subtensor[i];
   return *this;
-};
+}
 
 
 template <int rank_, int dim>
@@ -319,7 +319,7 @@ Tensor<rank_,dim>::operator *= (const double &s)
   for (unsigned int i=0; i<dim; ++i)
     subtensor[i] *= s;
   return *this;
-};
+}
 
 
 template <int rank_, int dim>
@@ -330,7 +330,7 @@ Tensor<rank_,dim>::operator /= (const double &s)
   for (unsigned int i=0; i<dim; ++i)
     subtensor[i] /= s;
   return *this;
-};
+}
 
 
 template <int rank_, int dim>
@@ -344,7 +344,7 @@ Tensor<rank_,dim>::operator + (const Tensor<rank_,dim> &t) const
     tmp.subtensor[i] += t.subtensor[i];
 
   return tmp;
-};
+}
 
 
 template <int rank_, int dim>
@@ -358,7 +358,7 @@ Tensor<rank_,dim>::operator - (const Tensor<rank_,dim> &t) const
     tmp.subtensor[i] -= t.subtensor[i];
 
   return tmp;
-};
+}
 
 
 template <int rank_, int dim>
@@ -372,7 +372,7 @@ Tensor<rank_,dim>::operator - () const
     tmp.subtensor[i] = -subtensor[i];
 
   return tmp;
-};
+}
 
 
 template <int rank_, int dim>
@@ -381,7 +381,7 @@ void Tensor<rank_,dim>::clear ()
 {
   for (unsigned int i=0; i<dim; ++i)
     subtensor[i].clear();
-};
+}
 
 
 
@@ -391,7 +391,7 @@ unsigned int
 Tensor<rank_,dim>::memory_consumption ()
 {
   return sizeof(Tensor<rank_,dim>);
-};
+}
 
 
 /* ----------------- Non-member functions operating on tensors. ------------ */
@@ -412,7 +412,7 @@ std::ostream & operator << (std::ostream &out, const Tensor<rank_,dim> &p)
   out << p[dim-1];
 
   return out;
-};
+}
 
 
 /**
@@ -425,7 +425,7 @@ std::ostream & operator << (std::ostream &out, const Tensor<rank_,1> &p)
   out << p[0];
 
   return out;
-};
+}
 
 
 
@@ -464,7 +464,7 @@ void contract (Tensor<1,dim>       &dest,
   for (unsigned int i=0; i<dim; ++i)
     for (unsigned int j=0; j<dim; ++j)
       dest[i] += src1[i][j] * src2[j];
-};
+}
 
 
 
@@ -484,7 +484,7 @@ void contract (Tensor<1,dim>       &dest,
   for (unsigned int i=0; i<dim; ++i)
     for (unsigned int j=0; j<dim; ++j)
       dest[i] += src1[j] * src2[j][i];
-};
+}
 
 
 
@@ -505,7 +505,7 @@ void contract (Tensor<2,dim>       &dest,
     for (unsigned int j=0; j<dim; ++j)
       for (unsigned int k=0; k<dim; ++k)
        dest[i][j] += src1[i][k] * src2[k][j];
-};
+}
 
 
 
@@ -578,7 +578,7 @@ void contract (Tensor<2,dim>       &dest,
       default:
            Assert (false, (typename Tensor<2,dim>::ExcInvalidTensorIndex (index1)));
     };
-};
+}
 
 
 
@@ -627,7 +627,7 @@ void contract (Tensor<2,dim>       &dest,
            Assert (false,
                     (typename Tensor<2,dim>::ExcInvalidTensorIndex (index1)));
     };
-};
+}
 
 
 
@@ -649,7 +649,7 @@ void contract (Tensor<3,dim>       &dest,
       for (unsigned int k=0; k<dim; ++k)
        for (unsigned int l=0; l<dim; ++l)
          dest[i][j][k] += src1[i][j][l] * src2[l][k];
-};
+}
 
 
 
@@ -671,7 +671,7 @@ void contract (Tensor<3,dim>       &dest,
       for (unsigned int k=0; k<dim; ++k)
        for (unsigned int l=0; l<dim; ++l)
          dest[i][j][k] += src1[i][l] * src2[l][j][k];
-};
+}
 
 
 /**
@@ -693,7 +693,7 @@ void contract (Tensor<4,dim>       &dest,
        for (unsigned int l=0; l<dim; ++l)
          for (unsigned int m=0; m<dim; ++m)
            dest[i][j][k][l] += src1[i][j][m] * src2[m][k][l];
-};
+}
 
 
 
@@ -711,7 +711,7 @@ void outer_product (Tensor<2,dim>       &dst,
   for (unsigned int i=0; i<dim; ++i)
     for (unsigned int j=0; j<dim; ++j)
       dst[i][j] = src1[i] * src2[j];
-};
+}
 
 
 
@@ -730,7 +730,7 @@ void outer_product (Tensor<3,dim>       &dst,
     for (unsigned int j=0; j<dim; ++j)
       for (unsigned int k=0; k<dim; ++k)
        dst[i][j][k] = src1[i] * src2[j][k];
-};
+}
 
 
 
@@ -749,7 +749,7 @@ void outer_product (Tensor<3,dim>       &dst,
     for (unsigned int j=0; j<dim; ++j)
       for (unsigned int k=0; k<dim; ++k)
        dst[i][j][k] = src1[i][j] * src2[k];
-};
+}
 
 
 
@@ -770,7 +770,7 @@ void outer_product (Tensor<1,dim>       &dst,
 {
   for (unsigned int i=0; i<dim; ++i)
     dst[i] = src1 * src2[i];
-};
+}
 
 
 
@@ -791,7 +791,7 @@ void outer_product (Tensor<1,dim>       &dst,
 {
   for (unsigned int i=0; i<dim; ++i)
     dst[i] = src1[i] * src2;
-};
+}
 
 
 
@@ -866,7 +866,7 @@ double determinant (const Tensor<rank,1> &t)
                                   // computable in the general
                                   // template
   return determinant(t[0]);
-};
+}
 
 
 
@@ -881,7 +881,7 @@ inline
 double determinant (const Tensor<1,1> &t)
 {
   return t[0];
-};
+}
 
 
 
@@ -895,7 +895,7 @@ double determinant (const Tensor<2,2> &t)
 {
   return ((t[0][0] * t[1][1]) -
          (t[1][0] * t[0][1]));
-};
+}
 
 
 
@@ -920,7 +920,7 @@ double determinant (const Tensor<2,3> &t)
           +t[1][0]*t[0][2]*t[2][1]
           +t[2][0]*t[0][1]*t[1][2]
           -t[2][0]*t[0][2]*t[1][1] );
-};
+}
 
 
 
@@ -937,7 +937,7 @@ double trace (const Tensor<2,dim> &d)
   for (unsigned int i=0; i<dim; ++i)
     t += d[i][i];
   return t;
-};
+}
 
 
 
@@ -1002,7 +1002,7 @@ invert (const Tensor<2,dim> &t)
            AssertThrow (false, ExcNotImplemented());
     };    
   return return_tensor;
-};
+}
 
 
 
@@ -1029,7 +1029,7 @@ transpose (const Tensor<2,dim> &t)
         tt[j][i] = x;
       };
   return tt;
-};
+}
 
 
 
@@ -1044,7 +1044,7 @@ Tensor<2,1>
 transpose (const Tensor<2,1> &t) 
 {
   return t;
-};
+}
 
 
 
@@ -1061,7 +1061,7 @@ transpose (const Tensor<2,2> &t)
 {
   const double x[2][2] = {{t[0][0], t[1][0]}, {t[0][1], t[1][1]}};
   return Tensor<2,2>(x);
-};
+}
 
 
 
@@ -1080,7 +1080,7 @@ transpose (const Tensor<2,3> &t)
                           {t[0][1], t[1][1], t[2][1]},
                           {t[0][2], t[1][2], t[2][2]}};
   return Tensor<2,3>(x);
-};
+}
 
 
 
@@ -1098,7 +1098,7 @@ operator * (const Tensor<rank,dim> &t,
   Tensor<rank,dim> tt = t;
   tt *= factor;
   return tt;
-};
+}
 
 
 
@@ -1115,7 +1115,7 @@ operator * (const double            factor,
   Tensor<rank,dim> tt = t;
   tt *= factor;
   return tt;
-};
+}
 
 
 
@@ -1131,7 +1131,7 @@ operator / (const Tensor<rank,dim> &t,
   Tensor<rank,dim> tt = t;
   tt /= factor;
   return tt;
-};
+}
 
 
 #endif
index af2f6b0ca7d55767bb234f762eb5d30b7eac8cef..7030178acc58682bbda2dcd9945fb9fdd0f8e883 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1998, 1999, 2000, 2001, 2002 by the deal authors
+//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003 by the deal authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -312,7 +312,7 @@ Tensor<1,dim>::Tensor (const bool initialize)
   if (initialize)
     for (unsigned int i=0; i!=dim; ++i)
       values[i] = 0;
-};
+}
 
 
 
@@ -322,7 +322,7 @@ Tensor<1,dim>::Tensor (const array_type &initializer)
 {
   for (unsigned int i=0; i<dim; ++i)
     values[i] = initializer[i];
-};
+}
 
 
 
@@ -332,7 +332,7 @@ Tensor<1,dim>::Tensor (const Tensor<1,dim> &p)
 {
   for (unsigned int i=0; i<dim; ++i)
     values[i] = p.values[i];
-};
+}
 
 
 
@@ -350,7 +350,7 @@ Tensor<1,0>::Tensor (const Tensor<1,0> &)
                                   // function that the loop end check
                                   // always fails, we implement this
                                   // function here
-};
+}
 
 
 
@@ -360,7 +360,7 @@ double Tensor<1,dim>::operator [] (const unsigned int index) const
 {
   Assert (index<dim, ExcIndexRange (index, 0, dim));
   return values[index];
-};
+}
 
 
 
@@ -370,7 +370,7 @@ double & Tensor<1,dim>::operator [] (const unsigned int index)
 {
   Assert (index<dim, ExcIndexRange (index, 0, dim));
   return values[index];
-};
+}
 
 
 
@@ -381,7 +381,7 @@ Tensor<1,dim> & Tensor<1,dim>::operator = (const Tensor<1,dim> &p)
   for (unsigned int i=0; i<dim; ++i)
     values[i] = p.values[i];
   return *this;
-};
+}
 
 
 
@@ -400,7 +400,7 @@ Tensor<1,0> & Tensor<1,0>::operator = (const Tensor<1,0> &)
                                   // always fails, we implement this
                                   // function here
   return *this;
-};
+}
 
 
 
@@ -411,7 +411,7 @@ bool Tensor<1,dim>::operator == (const Tensor<1,dim> &p) const
   for (unsigned int i=0; i<dim; ++i)
     if (values[i] != p.values[i]) return false;
   return true;
-};
+}
 
 
 
@@ -420,7 +420,7 @@ inline
 bool Tensor<1,dim>::operator != (const Tensor<1,dim> &p) const
 {
   return !((*this) == p);
-};
+}
 
 
 
@@ -431,7 +431,7 @@ Tensor<1,dim> & Tensor<1,dim>::operator += (const Tensor<1,dim> &p)
   for (unsigned int i=0; i<dim; ++i)
     values[i] += p.values[i];
   return *this;
-};
+}
 
 
 
@@ -442,7 +442,7 @@ Tensor<1,dim> & Tensor<1,dim>::operator -= (const Tensor<1,dim> &p)
   for (unsigned int i=0; i<dim; ++i)
     values[i] -= p.values[i];
   return *this;
-};
+}
 
 
 
@@ -453,7 +453,7 @@ Tensor<1,dim> & Tensor<1,dim>::operator *= (const double &s)
   for (unsigned int i=0; i<dim; ++i)
     values[i] *= s;
   return *this;
-};
+}
 
 
 
@@ -464,7 +464,7 @@ Tensor<1,dim> & Tensor<1,dim>::operator /= (const double &s)
   for (unsigned int i=0; i<dim; ++i)
     values[i] /= s;
   return *this;
-};
+}
 
 
 
@@ -476,7 +476,7 @@ double Tensor<1,dim>::operator * (const Tensor<1,dim> &p) const
   for (unsigned int i=0; i<dim; ++i)
     q += values[i] * p.values[i];
   return q;
-};
+}
 
 
 
@@ -485,7 +485,7 @@ inline
 Tensor<1,dim> Tensor<1,dim>::operator + (const Tensor<1,dim> &p) const
 {
   return (Tensor<1,dim>(*this) += p);
-};
+}
 
 
 
@@ -494,7 +494,7 @@ inline
 Tensor<1,dim> Tensor<1,dim>::operator - (const Tensor<1,dim> &p) const
 {
   return (Tensor<1,dim>(*this) -= p);
-};
+}
 
 
 
@@ -506,7 +506,7 @@ Tensor<1,dim> Tensor<1,dim>::operator - () const
   for (unsigned int i=0; i<dim; ++i)
     result.values[i] = -values[i];
   return result;
-};
+}
 
 
 
@@ -516,7 +516,7 @@ void Tensor<1,dim>::clear ()
 {
   for (unsigned int i=0; i<dim; ++i)
     values[i] = 0;
-};
+}
 
 
 
@@ -526,7 +526,7 @@ unsigned int
 Tensor<1,dim>::memory_consumption ()
 {
   return sizeof(Tensor<1,dim>);
-};
+}
 
 
 
@@ -543,7 +543,7 @@ std::ostream & operator << (std::ostream &out, const Tensor<1,dim> &p)
   out << p[dim-1];
 
   return out;
-};
+}
 
 
 
@@ -558,7 +558,7 @@ std::ostream & operator << (std::ostream &out, const Tensor<1,1> &p)
   out << p[0];
 
   return out;
-};
+}
 
 
 
@@ -575,7 +575,7 @@ operator * (const Tensor<1,dim> &t,
   for (unsigned int d=0; d<dim; ++d)
     tt[d] = t[d] * factor;
   return tt;
-};
+}
 
 
 
@@ -592,7 +592,7 @@ operator * (const double         factor,
   for (unsigned int d=0; d<dim; ++d)
     tt[d] = t[d] * factor;
   return tt;
-};
+}
 
 
 
@@ -609,7 +609,7 @@ operator / (const Tensor<1,dim> &t,
   for (unsigned int d=0; d<dim; ++d)
     tt[d] = t[d] / factor;
   return tt;
-};
+}
 
 
 
index 022bcc35c92012b2cde591777ab797d5022e2053..d091a3910598661c194e655b80918cb16124b614 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2000, 2001, 2002 by the deal.II authors
+//    Copyright (C) 2000, 2001, 2002, 2003 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -4773,7 +4773,7 @@ namespace Threads
                                     */
   void handle_unknown_exception ();
   
-};   // end declarations of namespace Threads
+}   // end declarations of namespace Threads
 
 
 
@@ -4827,7 +4827,7 @@ namespace Threads
       = dynamic_cast<const ThisClass*> (fun_encapsulation->fun_data_base);
 
                                     // copy the parameters
-    ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
+    typename ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
 
 
                                     // copying of parameters is done,
@@ -4927,7 +4927,7 @@ namespace Threads
       = dynamic_cast<const ThisClass*> (fun_encapsulation->fun_data_base);
 
                                     // copy the parameters
-    ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
+    typename ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
     Arg1              arg1    = fun_data->arg1;
 
 
@@ -5031,7 +5031,7 @@ namespace Threads
       = dynamic_cast<const ThisClass*> (fun_encapsulation->fun_data_base);
 
                                     // copy the parameters
-    ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
+    typename ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
     Arg1              arg1    = fun_data->arg1;
     Arg2              arg2    = fun_data->arg2;
 
@@ -5141,7 +5141,7 @@ namespace Threads
       = dynamic_cast<const ThisClass*> (fun_encapsulation->fun_data_base);
 
                                     // copy the parameters
-    ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
+    typename ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
     Arg1              arg1    = fun_data->arg1;
     Arg2              arg2    = fun_data->arg2;
     Arg3              arg3    = fun_data->arg3;
@@ -5256,7 +5256,7 @@ namespace Threads
       = dynamic_cast<const ThisClass*> (fun_encapsulation->fun_data_base);
 
                                     // copy the parameters
-    ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
+    typename ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
     Arg1              arg1    = fun_data->arg1;
     Arg2              arg2    = fun_data->arg2;
     Arg3              arg3    = fun_data->arg3;
@@ -5376,7 +5376,7 @@ namespace Threads
       = dynamic_cast<const ThisClass*> (fun_encapsulation->fun_data_base);
 
                                     // copy the parameters
-    ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
+    typename ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
     Arg1              arg1    = fun_data->arg1;
     Arg2              arg2    = fun_data->arg2;
     Arg3              arg3    = fun_data->arg3;
@@ -5502,7 +5502,7 @@ namespace Threads
       = dynamic_cast<const ThisClass*> (fun_encapsulation->fun_data_base);
 
                                     // copy the parameters
-    ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
+    typename ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
     Arg1              arg1    = fun_data->arg1;
     Arg2              arg2    = fun_data->arg2;
     Arg3              arg3    = fun_data->arg3;
@@ -5634,7 +5634,7 @@ namespace Threads
       = dynamic_cast<const ThisClass*> (fun_encapsulation->fun_data_base);
 
                                     // copy the parameters
-    ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
+    typename ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
     Arg1              arg1    = fun_data->arg1;
     Arg2              arg2    = fun_data->arg2;
     Arg3              arg3    = fun_data->arg3;
@@ -5773,7 +5773,7 @@ namespace Threads
       = dynamic_cast<const ThisClass*> (fun_encapsulation->fun_data_base);
 
                                     // copy the parameters
-    ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
+    typename ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
     Arg1              arg1    = fun_data->arg1;
     Arg2              arg2    = fun_data->arg2;
     Arg3              arg3    = fun_data->arg3;
@@ -5916,7 +5916,7 @@ namespace Threads
       = dynamic_cast<const ThisClass*> (fun_encapsulation->fun_data_base);
 
                                     // copy the parameters
-    ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
+    typename ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
     Arg1              arg1    = fun_data->arg1;
     Arg2              arg2    = fun_data->arg2;
     Arg3              arg3    = fun_data->arg3;
@@ -6067,7 +6067,7 @@ namespace Threads
       = dynamic_cast<const ThisClass*> (fun_encapsulation->fun_data_base);
 
                                     // copy the parameters
-    ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
+    typename ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
     Arg1              arg1    = fun_data->arg1;
     Arg2              arg2    = fun_data->arg2;
     Arg3              arg3    = fun_data->arg3;
@@ -6193,7 +6193,7 @@ namespace Threads
       = dynamic_cast<const ThisClass*> (fun_encapsulation->fun_data_base);
 
                                     // copy the parameters
-    ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
+    typename ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
     Class            *object  = fun_data->object;
 
                                     // copying of parameters is done,
@@ -6306,7 +6306,7 @@ namespace Threads
       = dynamic_cast<const ThisClass*> (fun_encapsulation->fun_data_base);
 
                                     // copy the parameters
-    ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
+    typename ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
     Class            *object  = fun_data->object;
     Arg1              arg1    = fun_data->arg1;
 
@@ -6424,7 +6424,7 @@ namespace Threads
       = dynamic_cast<const ThisClass*> (fun_encapsulation->fun_data_base);
 
                                     // copy the parameters
-    ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
+    typename ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
     Class            *object  = fun_data->object;
     Arg1              arg1    = fun_data->arg1;
     Arg2              arg2    = fun_data->arg2;
@@ -6550,7 +6550,7 @@ namespace Threads
       = dynamic_cast<const ThisClass*> (fun_encapsulation->fun_data_base);
 
                                     // copy the parameters
-    ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
+    typename ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
     Class            *object  = fun_data->object;
     Arg1              arg1    = fun_data->arg1;
     Arg2              arg2    = fun_data->arg2;
@@ -6683,7 +6683,7 @@ namespace Threads
       = dynamic_cast<const ThisClass*> (fun_encapsulation->fun_data_base);
 
                                     // copy the parameters
-    ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
+    typename ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
     Class            *object  = fun_data->object;
     Arg1              arg1    = fun_data->arg1;
     Arg2              arg2    = fun_data->arg2;
@@ -6821,7 +6821,7 @@ namespace Threads
       = dynamic_cast<const ThisClass*> (fun_encapsulation->fun_data_base);
 
                                     // copy the parameters
-    ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
+    typename ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
     Class            *object  = fun_data->object;
     Arg1              arg1    = fun_data->arg1;
     Arg2              arg2    = fun_data->arg2;
@@ -6966,7 +6966,7 @@ namespace Threads
       = dynamic_cast<const ThisClass*> (fun_encapsulation->fun_data_base);
 
                                     // copy the parameters
-    ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
+    typename ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
     Class            *object  = fun_data->object;
     Arg1              arg1    = fun_data->arg1;
     Arg2              arg2    = fun_data->arg2;
@@ -7119,7 +7119,7 @@ namespace Threads
       = dynamic_cast<const ThisClass*> (fun_encapsulation->fun_data_base);
 
                                     // copy the parameters
-    ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
+    typename ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
     Class            *object  = fun_data->object;
     Arg1              arg1    = fun_data->arg1;
     Arg2              arg2    = fun_data->arg2;
@@ -7275,7 +7275,7 @@ namespace Threads
       = dynamic_cast<const ThisClass*> (fun_encapsulation->fun_data_base);
 
                                     // copy the parameters
-    ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
+    typename ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
     Class            *object  = fun_data->object;
     Arg1              arg1    = fun_data->arg1;
     Arg2              arg2    = fun_data->arg2;
@@ -7437,7 +7437,7 @@ namespace Threads
       = dynamic_cast<const ThisClass*> (fun_encapsulation->fun_data_base);
 
                                     // copy the parameters
-    ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
+    typename ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
     Class            *object  = fun_data->object;
     Arg1              arg1    = fun_data->arg1;
     Arg2              arg2    = fun_data->arg2;
@@ -7606,7 +7606,7 @@ namespace Threads
       = dynamic_cast<const ThisClass*> (fun_encapsulation->fun_data_base);
 
                                     // copy the parameters
-    ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
+    typename ThisClass::FunPtr fun_ptr = fun_data->fun_ptr;
     Class            *object  = fun_data->object;
     Arg1              arg1    = fun_data->arg1;
     Arg2              arg2    = fun_data->arg2;
@@ -8064,7 +8064,7 @@ namespace Threads
 
 
            
-};   // end of implementation of namespace Threads
+}   // end of implementation of namespace Threads
 
 
 
index 4605c1079c4c92d3b90923e2af8c1bc1888a133b..1ee7da19748b553ee50d06f32a16e1a56ca77500 100644 (file)
@@ -49,7 +49,7 @@ DataOutBase::Patch<dim,spacedim>::Patch () :
   
   Assert (dim<=spacedim, ExcInvalidCombinationOfDimensions(dim,spacedim));
   Assert (spacedim<=3, ExcNotImplemented());
-};
+}
 
 
 
@@ -63,13 +63,13 @@ DataOutBase::Patch<dim,spacedim>::memory_consumption () const
          MemoryConsumption::memory_consumption(n_subdivisions)
          +
          MemoryConsumption::memory_consumption(data));
-};
+}
 
 
 
 DataOutBase::UcdFlags::UcdFlags (const bool write_preamble) :
                write_preamble (write_preamble)
-{};
+{}
 
 
 
@@ -79,7 +79,7 @@ DataOutBase::PovrayFlags::PovrayFlags (const bool smooth,
                smooth (smooth),
                bicubic_patch(bicubic_patch),
                external_data(external_data)
-{};
+{}
 
 
 DataOutBase::DXFlags::DXFlags (const bool write_multigrid,
@@ -93,7 +93,7 @@ void DataOutBase::DXFlags::declare_parameters (ParameterHandler &prm)
 {
   prm.declare_entry ("Write multigrid", "true", Patterns::Bool());
   prm.declare_entry ("Write neighbors", "true", Patterns::Bool());
-};
+}
 
 
 
@@ -101,7 +101,7 @@ void DataOutBase::DXFlags::parse_parameters (ParameterHandler &prm)
 {
   write_multigrid = prm.get_bool ("Write multigrid");
   write_neighbors = prm.get_bool ("Write neighbors");
-};
+}
 
 
 
@@ -111,7 +111,7 @@ DataOutBase::DXFlags::memory_consumption () const
                                   // only simple data elements, so
                                   // use sizeof operator
   return sizeof (*this);
-};
+}
 
 
 
@@ -119,14 +119,14 @@ DataOutBase::DXFlags::memory_consumption () const
 void DataOutBase::UcdFlags::declare_parameters (ParameterHandler &prm)
 {
   prm.declare_entry ("Write preamble", "true", Patterns::Bool());
-};
+}
 
 
 
 void DataOutBase::UcdFlags::parse_parameters (ParameterHandler &prm)
 {
   write_preamble = prm.get_bool ("Write preamble");
-};
+}
 
 
 unsigned int
@@ -135,17 +135,17 @@ DataOutBase::UcdFlags::memory_consumption () const
                                   // only simple data elements, so
                                   // use sizeof operator
   return sizeof (*this);
-};
+}
 
 
 
 void DataOutBase::GnuplotFlags::declare_parameters (ParameterHandler &/*prm*/)
-{};
+{}
 
 
 
 void DataOutBase::GnuplotFlags::parse_parameters (ParameterHandler &/*prm*/)
-{};
+{}
 
 
 
@@ -155,7 +155,7 @@ DataOutBase::GnuplotFlags::memory_consumption () const
                                   // only simple data elements, so
                                   // use sizeof operator
   return sizeof (*this);
-};
+}
 
 
 
@@ -168,7 +168,7 @@ void DataOutBase::PovrayFlags::declare_parameters (ParameterHandler &prm)
                     Patterns::Bool());
   prm.declare_entry ("Include external file", "true",
                     Patterns::Bool ());
-};
+}
 
 
 
@@ -177,7 +177,7 @@ void DataOutBase::PovrayFlags::parse_parameters (ParameterHandler &prm)
   smooth        = prm.get_bool ("Use smooth triangles");
   bicubic_patch = prm.get_bool ("Use bicubic patches");
   external_data = prm.get_bool ("Include external file");
-};
+}
 
 
 
@@ -187,7 +187,7 @@ DataOutBase::PovrayFlags::memory_consumption () const
                                   // only simple data elements, so
                                   // use sizeof operator
   return sizeof (*this);
-};
+}
 
 
 
@@ -215,7 +215,7 @@ DataOutBase::EpsFlags::EpsFlags (const unsigned int  height_vector,
                draw_cells(draw_cells),
                shade_cells(shade_cells),
                color_function(color_function)
-{};
+{}
 
 
 
@@ -302,7 +302,7 @@ DataOutBase::EpsFlags::default_color_function (const double x,
     rgb_values.red = rgb_values.green = rgb_values.blue = 1;
 
   return rgb_values;
-};
+}
 
 
 
@@ -315,7 +315,7 @@ DataOutBase::EpsFlags::grey_scale_color_function (const double x,
   rgb_values.red = rgb_values.blue = rgb_values.green
                 = (x-xmin)/(xmax-xmin);
   return rgb_values;
-};
+}
 
 
 
@@ -328,7 +328,7 @@ DataOutBase::EpsFlags::reverse_grey_scale_color_function (const double x,
   rgb_values.red = rgb_values.blue = rgb_values.green
                 = 1-(x-xmin)/(xmax-xmin);
   return rgb_values;
-};
+}
 
 
 
@@ -337,7 +337,7 @@ bool DataOutBase::EpsCell2d::operator < (const EpsCell2d &e) const
                                   // note the "wrong" order in
                                   // which we sort the elements
   return depth > e.depth;
-};
+}
 
 
 
@@ -367,7 +367,7 @@ void DataOutBase::EpsFlags::declare_parameters (ParameterHandler &prm)
                     Patterns::Bool());
   prm.declare_entry ("Color function", "default",
                     Patterns::Selection ("default|grey scale|reverse grey scale"));
-};
+}
 
 
 
@@ -399,7 +399,7 @@ void DataOutBase::EpsFlags::parse_parameters (ParameterHandler &prm)
                                     // already have checked that the
                                     // given value is valid
     Assert (false, ExcInternalError());
-};
+}
 
 
 
@@ -409,17 +409,17 @@ DataOutBase::EpsFlags::memory_consumption () const
                                   // only simple data elements, so
                                   // use sizeof operator
   return sizeof (*this);
-};
+}
 
 
 
 void DataOutBase::GmvFlags::declare_parameters (ParameterHandler &/*prm*/)
-{};
+{}
 
 
 
 void DataOutBase::GmvFlags::parse_parameters (ParameterHandler &/*prm*/)
-{};
+{}
 
 
 unsigned int
@@ -428,24 +428,24 @@ DataOutBase::GmvFlags::memory_consumption () const
                                   // only simple data elements, so
                                   // use sizeof operator
   return sizeof (*this);
-};
+}
 
 
 
 DataOutBase::TecplotFlags::TecplotFlags (const char* tecplot_binary_file_name) :
   tecplot_binary_file_name(tecplot_binary_file_name)
 {
-};
+}
 
 
 
 void DataOutBase::TecplotFlags::declare_parameters (ParameterHandler &/*prm*/)
-{};
+{}
 
 
 
 void DataOutBase::TecplotFlags::parse_parameters (ParameterHandler &/*prm*/)
-{};
+{}
 
 
 unsigned int
@@ -454,17 +454,17 @@ DataOutBase::TecplotFlags::memory_consumption () const
                                   // only simple data elements, so
                                   // use sizeof operator
   return sizeof (*this);
-};
+}
 
 
 
 void DataOutBase::VtkFlags::declare_parameters (ParameterHandler &/*prm*/)
-{};
+{}
 
 
 
 void DataOutBase::VtkFlags::parse_parameters (ParameterHandler &/*prm*/)
-{};
+{}
 
 
 unsigned int
@@ -473,14 +473,14 @@ DataOutBase::VtkFlags::memory_consumption () const
                                   // only simple data elements, so
                                   // use sizeof operator
   return sizeof (*this);
-};
+}
 
 
 
 unsigned int DataOutBase::memory_consumption ()
 {
   return 0;
-};
+}
 
 
 
@@ -890,7 +890,7 @@ void DataOutBase::write_ucd (const std::vector<Patch<dim,spacedim> > &patches,
 
                                   // assert the stream is still ok
   AssertThrow (out, ExcIO());
-};
+}
 
 
 
@@ -1388,7 +1388,7 @@ void DataOutBase::write_dx (const std::vector<Patch<dim,spacedim> > &patches,
   out << "end" << std::endl;
                                   // assert the stream is still ok
   AssertThrow (out, ExcIO());
-};
+}
 
 
 
@@ -1676,7 +1676,7 @@ void DataOutBase::write_gnuplot (const std::vector<Patch<dim,spacedim> > &patche
     };
 
   AssertThrow (out, ExcIO());
-};
+}
 
 
 
@@ -2038,7 +2038,7 @@ void DataOutBase::write_povray (const std::vector<Patch<dim,spacedim> > &patches
     }
   
   AssertThrow (out, ExcIO());
-};
+}
 
 
 
@@ -2422,7 +2422,7 @@ void DataOutBase::write_eps (const std::vector<Patch<dim,spacedim> > &patches,
       default:
            Assert (false, ExcNotImplemented());
     };
-};
+}
 
 
 
@@ -2736,7 +2736,7 @@ void DataOutBase::write_gmv (const std::vector<Patch<dim,spacedim> > &patches,
   
                                   // assert the stream is still ok
   AssertThrow (out, ExcIO());
-};
+}
 
 
 
@@ -3082,7 +3082,7 @@ void DataOutBase::write_tecplot (const std::vector<Patch<dim,spacedim> > &patche
   
                                    // assert the stream is still ok
   AssertThrow (out, ExcIO());
-};
+}
 
 
 
@@ -3534,7 +3534,7 @@ void DataOutBase::write_tecplot_binary (const std::vector<Patch<dim,spacedim> >
    delete [] tecVarNames;
          
 #endif
-};
+}
 
 
 
@@ -3863,7 +3863,7 @@ void DataOutBase::write_vtk (const std::vector<Patch<dim,spacedim> > &patches,
   
                                   // assert the stream is still ok
   AssertThrow (out, ExcIO());
-};
+}
 
 
 
@@ -3952,7 +3952,7 @@ DataOutBase::write_gmv_reorder_data_vectors (const std::vector<Patch<dim,spacedi
   for (unsigned int data_set=0; data_set<n_data_sets; ++data_set)
     Assert (data_vectors[data_set].size() == next_value,
            ExcInternalError());
-};
+}
 
 
 
@@ -3964,7 +3964,7 @@ void DataOutInterface<dim,spacedim>::write_dx (std::ostream &out) const
 {
   DataOutBase::write_dx (get_patches(), get_dataset_names(),
                         dx_flags, out);
-};
+}
 
 
 
@@ -3973,7 +3973,7 @@ void DataOutInterface<dim,spacedim>::write_ucd (std::ostream &out) const
 {
   DataOutBase::write_ucd (get_patches(), get_dataset_names(),
                          ucd_flags, out);
-};
+}
 
 
 
@@ -3982,7 +3982,7 @@ void DataOutInterface<dim,spacedim>::write_gnuplot (std::ostream &out) const
 {
   DataOutBase::write_gnuplot (get_patches(), get_dataset_names(),
                              gnuplot_flags, out);
-};
+}
 
 
 
@@ -3991,7 +3991,7 @@ void DataOutInterface<dim,spacedim>::write_povray (std::ostream &out) const
 {
   DataOutBase::write_povray (get_patches(), get_dataset_names(),
                             povray_flags, out);
-};
+}
 
 
 
@@ -4000,7 +4000,7 @@ void DataOutInterface<dim,spacedim>::write_eps (std::ostream &out) const
 {
   DataOutBase::write_eps (get_patches(), get_dataset_names(),
                          eps_flags, out);
-};
+}
 
 
 
@@ -4009,7 +4009,7 @@ void DataOutInterface<dim,spacedim>::write_gmv (std::ostream &out) const
 {
   DataOutBase::write_gmv (get_patches(), get_dataset_names(),
                          gmv_flags, out);
-};
+}
 
 
 
@@ -4018,7 +4018,7 @@ void DataOutInterface<dim,spacedim>::write_tecplot (std::ostream &out) const
 {
   DataOutBase::write_tecplot (get_patches(), get_dataset_names(),
                              tecplot_flags, out);
-};
+}
 
 
 
@@ -4027,7 +4027,7 @@ void DataOutInterface<dim,spacedim>::write_tecplot_binary (std::ostream &out) co
 {
   DataOutBase::write_tecplot_binary (get_patches(), get_dataset_names(),
                                     tecplot_flags, out);
-};
+}
 
 
 
@@ -4036,7 +4036,7 @@ void DataOutInterface<dim,spacedim>::write_vtk (std::ostream &out) const
 {
   DataOutBase::write_vtk (get_patches(), get_dataset_names(),
                          vtk_flags, out);
-};
+}
 
 
 
@@ -4090,7 +4090,7 @@ DataOutInterface<dim,spacedim>::write (std::ostream &out,
       default:
            Assert (false, ExcNotImplemented());
     };
-};
+}
 
 
 
@@ -4107,7 +4107,7 @@ template <int dim, int spacedim>
 void DataOutInterface<dim,spacedim>::set_flags (const DXFlags &flags) 
 {
   dx_flags = flags;
-};
+}
 
 
 
@@ -4115,7 +4115,7 @@ template <int dim, int spacedim>
 void DataOutInterface<dim,spacedim>::set_flags (const UcdFlags &flags) 
 {
   ucd_flags = flags;
-};
+}
 
 
 
@@ -4123,7 +4123,7 @@ template <int dim, int spacedim>
 void DataOutInterface<dim,spacedim>::set_flags (const GnuplotFlags &flags) 
 {
   gnuplot_flags = flags;
-};
+}
 
 
 
@@ -4131,7 +4131,7 @@ template <int dim, int spacedim>
 void DataOutInterface<dim,spacedim>::set_flags (const PovrayFlags &flags) 
 {
   povray_flags = flags;
-};
+}
 
 
 
@@ -4139,7 +4139,7 @@ template <int dim, int spacedim>
 void DataOutInterface<dim,spacedim>::set_flags (const EpsFlags &flags) 
 {
   eps_flags = flags;
-};
+}
 
 
 
@@ -4147,7 +4147,7 @@ template <int dim, int spacedim>
 void DataOutInterface<dim,spacedim>::set_flags (const GmvFlags &flags) 
 {
   gmv_flags = flags;
-};
+}
 
 
 
@@ -4155,7 +4155,7 @@ template <int dim, int spacedim>
 void DataOutInterface<dim,spacedim>::set_flags (const TecplotFlags &flags) 
 {
   tecplot_flags = flags;
-};
+}
 
 
 
@@ -4163,7 +4163,7 @@ template <int dim, int spacedim>
 void DataOutInterface<dim,spacedim>::set_flags (const VtkFlags &flags) 
 {
   vtk_flags = flags;
-};
+}
 
 
 
@@ -4208,7 +4208,7 @@ DataOutInterface<dim,spacedim>::default_suffix (const OutputFormat output_format
            Assert (false, ExcNotImplemented()); 
            return "";
     };
-};
+}
 
 
 
@@ -4247,7 +4247,7 @@ DataOutInterface<dim,spacedim>::parse_output_format (const std::string &format_n
 
                                   // return something invalid
   return OutputFormat(-1);
-};
+}
 
 
 
@@ -4353,7 +4353,7 @@ DataOutInterface<dim,spacedim>::memory_consumption () const
          MemoryConsumption::memory_consumption (gmv_flags) +
          MemoryConsumption::memory_consumption (tecplot_flags) +
          MemoryConsumption::memory_consumption (vtk_flags));
-};
+}
 
 
 
index 6862557be81eec9c87349c8197cc4c3bea1493fa..c49ed829538d56e0d7dd258141a2255e0c4a3ddd 100644 (file)
 
 ExceptionBase::ExceptionBase () :
                file(""), line(0), function(""), cond(""), exc("")
-{};
+{}
 
 
 
 ExceptionBase::ExceptionBase (const char* f, const int l, const char *func,
                              const char* c, const char *e) :
                file(f), line(l), function(func), cond(c), exc(e)
-{};
+{}
 
 
 
 ExceptionBase::~ExceptionBase () throw ()
-{};
+{}
 
 
 
@@ -54,7 +54,7 @@ void ExceptionBase::SetFields (const char* f,
   function = func;
   cond = c;
   exc  = e;
-};
+}
 
 
 
@@ -69,14 +69,14 @@ void ExceptionBase::PrintExcData (std::ostream &out) const
       << "The name and call sequence of the exception was:" << std::endl
       << "    " << exc  << std::endl
       << "Additional Information: " << std::endl;
-};
+}
 
 
 
 void ExceptionBase::PrintInfo (std::ostream &out) const
 {
   out << "(none)" << std::endl;
-};
+}
 
 
 
@@ -146,7 +146,7 @@ const char * ExceptionBase::what () const throw ()
       std::abort ();
       return 0;
     }
-};
+}
 
 
 
@@ -158,7 +158,7 @@ namespace deal_II_exceptions
   void set_additional_assert_output (const char * const p)
   {
     additional_assert_output = p;
-  };
+  }
 
   
   
@@ -245,18 +245,18 @@ namespace deal_II_exceptions
        }
       else
        std::abort ();
-    };
+    }
 
 
 
     void abort ()
     {
       std::abort ();
-    };
+    }
     
   }
   
-};
+}
 
 
 // from the aclocal file:
index 3949e15669cbf62bba205d573b58e442ad808dc2..1330fb51fdc23269fcbd149de26fcc384096ed5d 100644 (file)
@@ -23,12 +23,12 @@ Function<dim>::Function (const unsigned int n_components,
                         const double       initial_time) :
                FunctionTime(initial_time),
                n_components(n_components)
-{};
+{}
 
 
 template <int dim>
 Function<dim>::~Function ()
-{};
+{}
 
 
 template <int dim>
@@ -37,7 +37,7 @@ double Function<dim>::value (const Point<dim> &,
 {
   Assert (false, ExcPureFunctionCalled());
   return 0;
-};
+}
 
 
 template <int dim>
@@ -45,7 +45,7 @@ void Function<dim>::vector_value (const Point<dim> &,
                                  Vector<double>   &) const
 {
   Assert (false, ExcPureFunctionCalled());
-};
+}
 
 
 // if necessary try to work around a bug in the IBM xlC compiler
@@ -66,7 +66,7 @@ void Function<dim>::value_list (const std::vector<Point<dim> > &points,
 
   for (unsigned int i=0; i<points.size(); ++i)
     values[i]  = this->value (points[i], component);
-};
+}
 
 
 template <int dim>
@@ -81,7 +81,7 @@ void Function<dim>::vector_value_list (const std::vector<Point<dim> > &points,
 
   for (unsigned int i=0; i<points.size(); ++i)
     this->vector_value (points[i], values[i]);
-};
+}
 
 
 template <int dim>
@@ -90,7 +90,7 @@ Tensor<1,dim> Function<dim>::gradient (const Point<dim> &,
 {
   Assert (false, ExcPureFunctionCalled());
   return Point<dim>();
-};
+}
 
 
 template <int dim>
@@ -98,7 +98,7 @@ void Function<dim>::vector_gradient (const Point<dim>       &,
                                     std::vector<Tensor<1,dim> > &) const
 {
   Assert (false, ExcPureFunctionCalled());
-};
+}
 
 
 template <int dim>
@@ -111,7 +111,7 @@ void Function<dim>::gradient_list (const std::vector<Point<dim> > &points,
 
   for (unsigned int i=0; i<points.size(); ++i)
     gradients[i] = gradient(points[i], component);
-};
+}
 
 
 template <int dim>
@@ -189,7 +189,7 @@ Function<dim>::memory_consumption () const
                                   // only simple data elements, so
                                   // use sizeof operator
   return sizeof (*this);
-};
+}
 
 
 //------------------------------------------------------------//
@@ -210,7 +210,7 @@ double ZeroFunction<dim>::value (const Point<dim> &,
                                 const unsigned int) const
 {
   return 0.;
-};
+}
 
 
 template <int dim>
@@ -221,7 +221,7 @@ void ZeroFunction<dim>::vector_value (const Point<dim> &,
          ExcDimensionMismatch (return_value.size(), this->n_components));
 
   std::fill (return_value.begin(), return_value.end(), 0.0);
-};
+}
 
 
 template <int dim>
@@ -232,7 +232,7 @@ void ZeroFunction<dim>::value_list (const std::vector<Point<dim> > &points,
          ExcDimensionMismatch(values.size(), points.size()));
 
   std::fill (values.begin(), values.end(), 0.);
-};
+}
 
 
 template <int dim>
@@ -248,7 +248,7 @@ void ZeroFunction<dim>::vector_value_list (const std::vector<Point<dim> > &point
              ExcDimensionMismatch(values[i].size(), this->n_components));
       std::fill (values[i].begin(), values[i].end(), 0.);
     };
-};
+}
 
 
 template <int dim>
@@ -256,7 +256,7 @@ Tensor<1,dim> ZeroFunction<dim>::gradient (const Point<dim> &,
                                           const unsigned int) const
 {
   return Tensor<1,dim>();
-};
+}
 
 
 template <int dim>
@@ -268,7 +268,7 @@ void ZeroFunction<dim>::vector_gradient (const Point<dim>       &,
 
   for (unsigned int c=0; c<this->n_components; ++c)
     gradients[c].clear ();
-};
+}
 
 
 template <int dim>
@@ -281,7 +281,7 @@ void ZeroFunction<dim>::gradient_list (const std::vector<Point<dim> > &points,
 
   for (unsigned int i=0; i<points.size(); ++i)
     gradients[i].clear ();
-};
+}
 
 
 template <int dim>
@@ -297,7 +297,7 @@ void ZeroFunction<dim>::vector_gradient_list (const std::vector<Point<dim> >
       for (unsigned int c=0; c<this->n_components; ++c)
        gradients[i][c].clear ();
     };
-};
+}
 
 //------------------------------------------------------------//
 
@@ -307,11 +307,11 @@ ConstantFunction<dim>::ConstantFunction (const double value,
                                         const unsigned int n_components) :
                ZeroFunction<dim> (n_components),
   function_value    (value)
-{};
+{}
 
 
 template <int dim>
-ConstantFunction<dim>::~ConstantFunction () {};
+ConstantFunction<dim>::~ConstantFunction () {}
 
 
 template <int dim>
@@ -319,7 +319,7 @@ double ConstantFunction<dim>::value (const Point<dim> &,
                                     const unsigned int) const
 {
   return function_value;
-};
+}
 
 
 template <int dim>
@@ -330,7 +330,7 @@ void ConstantFunction<dim>::vector_value (const Point<dim> &,
          ExcDimensionMismatch (return_value.size(), this->n_components));
 
   std::fill (return_value.begin(), return_value.end(), function_value);
-};
+}
 
 
 template <int dim>
@@ -342,7 +342,7 @@ void ConstantFunction<dim>::value_list (const std::vector<Point<dim> > &points,
          ExcDimensionMismatch(values.size(), points.size()));
 
   std::fill (values.begin(), values.end(), function_value);
-};
+}
 
 
 template <int dim>
@@ -358,7 +358,7 @@ void ConstantFunction<dim>::vector_value_list (const std::vector<Point<dim> > &p
              ExcDimensionMismatch(values[i].size(), this->n_components));
       std::fill (values[i].begin(), values[i].end(), function_value);
     };
-};
+}
 
 
 
@@ -369,7 +369,7 @@ ConstantFunction<dim>::memory_consumption () const
                                   // only simple data elements, so
                                   // use sizeof operator
   return sizeof (*this);
-};
+}
 
 //------------------------------------------------------------//
 
@@ -421,7 +421,7 @@ ComponentSelectFunction<dim>::memory_consumption () const
                                   // only simple data elements, so
                                   // use sizeof operator
   return sizeof (*this);
-};
+}
 
 
 // explicit instantiations
index 633f1944411bf4146405288d7dbf6f00a2ff6446..81c2dae0168733d0b84f844175607913b5af9fc7 100644 (file)
@@ -205,7 +205,7 @@ FunctionDerivative<dim>::memory_consumption () const
                                   // only simple data elements, so
                                   // use sizeof operator
   return sizeof (*this);
-};
+}
 
 
 
index fcdba001258fbadac2c218ea7ab618648fda9cbd..8df7500e3406b133bb87c5d50c004e6f0c598350 100644 (file)
@@ -1488,4 +1488,4 @@ namespace Functions
   template class FourierSineSum<1>;
   template class FourierSineSum<2>;
   template class FourierSineSum<3>;
-};
+}
index 13c9ba7d892228d155001a86fce8f07e78eb9dc5..365acfae911710e60639d06ea134750ffeb8cc8d 100644 (file)
@@ -27,10 +27,10 @@ void
 FunctionTime::set_time (const double new_time)
 {
   time = new_time;
-};
+}
 
 void
 FunctionTime::advance_time (const double delta_t)
 {
   set_time (time+delta_t);
-};
+}
index fefd825cfc19aa0495eb80a1388bd83a9cf2d82c..f88be35b5597bb74fa0b5a5228f401021637f772 100644 (file)
@@ -69,7 +69,7 @@ LogStream::attach(std::ostream& o)
 void LogStream::detach ()
 {
   file = 0;
-};
+}
 
 
 std::ostream&
@@ -101,28 +101,28 @@ LogStream::push (const std::string& text)
   pre += text;
   pre += std::string(":");
   prefixes.push(pre);
-};
+}
 
 
 void LogStream::pop ()
 {
   if (prefixes.size() > 1)
     prefixes.pop();
-};
+}
 
 
 void
 LogStream::depth_console(unsigned n)
 {
   std_depth = n;
-};
+}
 
 
 void
 LogStream::depth_file(unsigned n)
 {
   file_depth = n;
-};
+}
 
 
 void
@@ -242,4 +242,4 @@ LogStream::memory_consumption () const
     };
   
   return mem;
-};
+}
index 33e5bbbb3beda05c1ac4131cc7c4b8efeaf3ba48..329b0c22884a3437a0cb339ff6f68dad095e284e 100644 (file)
@@ -23,7 +23,7 @@ namespace MemoryConsumption
     for (unsigned int i=0; i<v.size(); ++i)
       mem += memory_consumption(v[i]);
     return mem;
-  };
+  }
   
 
-};
+}
index bfbd6162c25f9af5fd256918a920f02fa0cefa06..9161a0914ace27ef0f1f187bca9c05888a7b1173 100644 (file)
@@ -108,7 +108,7 @@ unsigned int MultithreadInfo::get_n_cpus()
 MultithreadInfo::MultithreadInfo () :
                 n_cpus (get_n_cpus()),
                 n_default_threads (n_cpus)
-{};
+{}
 
 
 
@@ -118,7 +118,7 @@ MultithreadInfo::memory_consumption ()
                                   // only simple data elements, so
                                   // use sizeof operator
   return sizeof (MultithreadInfo);
-};
+}
 
 
 
index d1213aed5210ca2c1b7d97e6e3dba50aed92ae63..b0ceb45c2b8524ce6290d89184b5fe7b6b8e7af3 100644 (file)
@@ -36,7 +36,7 @@ namespace Patterns
 {  
 
   PatternBase::~PatternBase ()
-  {};
+  {}
 
 
   unsigned int
@@ -52,7 +52,7 @@ namespace Patterns
       return sizeof(Anything);
     else
       return sizeof(*this) + 32;
-  };
+  }
   
 
 
@@ -75,7 +75,7 @@ namespace Patterns
                    const int upper_bound) :
                  lower_bound (lower_bound),
                  upper_bound (upper_bound)
-  {};
+  {}
 
 
 
@@ -101,7 +101,7 @@ namespace Patterns
       };
   
     return false;
-  };
+  }
 
 
 
@@ -130,7 +130,7 @@ namespace Patterns
                                       // if no bounds were given, then
                                       // return generic string
       return "[Integer]";
-  };
+  }
 
 
 
@@ -138,7 +138,7 @@ namespace Patterns
   Integer::clone () const
   {
     return new Integer(lower_bound, upper_bound);
-  };
+  }
 
 
 
@@ -160,7 +160,7 @@ namespace Patterns
                  const double upper_bound) :
                  lower_bound (lower_bound),
                  upper_bound (upper_bound)
-  {};
+  {}
 
 
 
@@ -185,7 +185,7 @@ namespace Patterns
          return true;
       };
     return false;
-  };
+  }
 
 
 
@@ -214,14 +214,14 @@ namespace Patterns
                                       // if no bounds were given, then
                                       // return generic string
       return "[Double]";
-  };
+  }
 
 
   PatternBase *
   Double::clone () const
   {
     return new Double(lower_bound, upper_bound);
-  };
+  }
 
 
 
@@ -233,7 +233,7 @@ namespace Patterns
       sequence.replace (sequence.find(" |"), 2, "|");
     while (sequence.find("| ") != std::string::npos)
       sequence.replace (sequence.find("| "), 2, "|");
-  };
+  }
 
 
 
@@ -255,14 +255,14 @@ namespace Patterns
 
                                     // not found
     return false;
-  };
+  }
 
 
 
   std::string Selection::description () const
   {
     return sequence;
-  };
+  }
 
 
 
@@ -270,7 +270,7 @@ namespace Patterns
   Selection::clone () const
   {
     return new Selection(sequence);
-  };
+  }
 
 
   unsigned int
@@ -278,7 +278,7 @@ namespace Patterns
   {
     return (sizeof(PatternBase) +
            MemoryConsumption::memory_consumption(sequence));
-  };
+  }
   
 
 
@@ -300,7 +300,7 @@ namespace Patterns
   {
     Assert (min_elements <= max_elements,
             ExcInvalidRange (min_elements, max_elements));
-  };
+  }
 
 
 
@@ -308,7 +308,7 @@ namespace Patterns
   {
     delete pattern;
     pattern = 0;
-  };
+  }
 
 
 
@@ -353,7 +353,7 @@ namespace Patterns
         return false;
 
     return true;
-  };
+  }
 
 
 
@@ -374,7 +374,7 @@ namespace Patterns
 #endif
 
     return description.str();
-  };
+  }
 
 
 
@@ -382,7 +382,7 @@ namespace Patterns
   List::clone () const
   {
     return new List(*pattern, min_elements, max_elements);
-  };
+  }
 
 
   unsigned int
@@ -390,7 +390,7 @@ namespace Patterns
   {
     return (sizeof(PatternBase) +
            MemoryConsumption::memory_consumption(*pattern));
-  };
+  }
 
   
   
@@ -403,7 +403,7 @@ namespace Patterns
       sequence.replace (sequence.find(" |"), 2, "|");
     while (sequence.find("| ") != std::string::npos)
       sequence.replace (sequence.find("| "), 2, "|");
-  };
+  }
 
 
 
@@ -467,14 +467,14 @@ namespace Patterns
       };
 
     return true;
-  };
+  }
 
 
 
   std::string MultipleSelection::description () const
   {
     return sequence;
-  };
+  }
 
 
 
@@ -482,7 +482,7 @@ namespace Patterns
   MultipleSelection::clone () const
   {
     return new MultipleSelection(sequence);
-  };
+  }
 
 
   unsigned int
@@ -490,13 +490,13 @@ namespace Patterns
   {
     return (sizeof(PatternBase) +
            MemoryConsumption::memory_consumption(sequence));
-  };
+  }
 
 
 
   Bool::Bool () :
                  Selection ("true|false")
-  {};
+  {}
 
 
 
@@ -504,26 +504,26 @@ namespace Patterns
   Bool::clone () const
   {
     return new Bool();
-  };
+  }
 
 
 
   Anything::Anything ()
-  {};
+  {}
 
 
 
   bool Anything::match (const std::string &) const
   {
     return true;
-  };
+  }
 
 
 
   std::string Anything::description () const
   {
     return "[Anything]";
-  };
+  }
 
 
 
@@ -531,19 +531,19 @@ namespace Patterns
   Anything::clone () const
   {
     return new Anything();
-  };
+  }
  
 }   // end namespace Patterns
 
 
 
 ParameterHandler::ParameterHandler () :
-               status(true) {};
+               status(true) {}
 
 
 
 ParameterHandler::~ParameterHandler ()
-{};
+{}
 
 
 
@@ -562,7 +562,7 @@ bool ParameterHandler::read_input (std::istream &input)
     };
 
   return status;
-};
+}
 
 
 
@@ -619,7 +619,7 @@ bool ParameterHandler::read_input_from_string (const char *s)
     };
 
   return status;
-};
+}
 
 
 
@@ -644,7 +644,7 @@ void ParameterHandler::clear ()
 
   defaults.subsections.clear ();
   changed_entries.subsections.clear ();
-};
+}
 
 
 
@@ -675,7 +675,7 @@ bool ParameterHandler::declare_entry (const std::string           &entry,
     return false;
 
   return true;
-};
+}
 
 
 
@@ -697,7 +697,7 @@ void ParameterHandler::enter_subsection (const std::string &subsection)
 
                                   // finally enter subsection
   subsection_path.push_back (subsection);
-};
+}
 
 
 
@@ -716,7 +716,7 @@ bool ParameterHandler::leave_subsection ()
 
   subsection_path.pop_back ();
   return true;
-};
+}
 
 
 
@@ -747,7 +747,7 @@ const std::string & ParameterHandler::get (const std::string &entry_string) cons
                                   // not changed
   ptr = pd->entries.find (entry_string);
   return ptr->second.first;
-};
+}
 
 
 
@@ -761,7 +761,7 @@ long int ParameterHandler::get_integer (const std::string &entry_string) const
               ExcConversionError(s));
 
   return i;
-};
+}
 
 
 
@@ -775,7 +775,7 @@ double ParameterHandler::get_double (const std::string &entry_string) const
               ExcConversionError(s));
 
   return d;
-};
+}
 
 
 
@@ -788,7 +788,7 @@ bool ParameterHandler::get_bool (const std::string &entry_string) const
     return true;
   else
     return false;
-};
+}
 
 
 
@@ -832,7 +832,7 @@ std::ostream & ParameterHandler::print_parameters (std::ostream &out,
     };
   
   return out;
-};
+}
 
 
 void
@@ -843,7 +843,7 @@ ParameterHandler::log_parameters (LogStream &out)
   log_parameters_section (out);
 
   out.pop();
-};
+}
 
 
 
@@ -970,7 +970,7 @@ void ParameterHandler::print_parameters_section (std::ostream      &out,
                Assert (false, ExcNotImplemented());
        };
     };
-};
+}
 
 
 
@@ -1008,7 +1008,7 @@ void ParameterHandler::log_parameters_section (LogStream &out)
       leave_subsection ();
       out.pop();
     };
-};
+}
 
 
 
@@ -1141,7 +1141,7 @@ bool ParameterHandler::scan_line (std::string        line,
   std::cerr << "Line " << lineno << ": This line matched nothing known:" << std::endl
            << "    " << line << std::endl;
   return false;
-};
+}
 
 
 
@@ -1157,7 +1157,7 @@ ParameterHandler::Section* ParameterHandler::get_present_defaults_subsection ()
     };
 
   return sec;
-};
+}
 
 
 
@@ -1174,7 +1174,7 @@ const ParameterHandler::Section* ParameterHandler::get_present_defaults_subsecti
     };
 
   return sec;
-};
+}
 
 
 
@@ -1190,7 +1190,7 @@ ParameterHandler::Section* ParameterHandler::get_present_changed_subsection ()
     };
 
   return sec;
-};
+}
 
 
 
@@ -1206,7 +1206,7 @@ const ParameterHandler::Section* ParameterHandler::get_present_changed_subsectio
     };
 
   return sec;
-};
+}
 
 
 
@@ -1217,7 +1217,7 @@ ParameterHandler::memory_consumption () const
          MemoryConsumption::memory_consumption (subsection_path) +
          MemoryConsumption::memory_consumption (defaults) +
          MemoryConsumption::memory_consumption (changed_entries));
-};
+}
 
 
 
@@ -1239,7 +1239,7 @@ ParameterHandler::Section::~Section ()
     delete p->second;
 
   subsections.clear ();
-};
+}
 
 
 
@@ -1255,19 +1255,19 @@ ParameterHandler::Section::memory_consumption () const
     mem += (MemoryConsumption::memory_consumption (i->first) +
            MemoryConsumption::memory_consumption (*(i->second)));
   return mem;
-};
+}
 
 
 
 
 MultipleParameterLoop::MultipleParameterLoop() :
                n_branches(0)
-{};
+{}
 
 
 
 MultipleParameterLoop::~MultipleParameterLoop ()
-{};
+{}
 
 
 
@@ -1279,7 +1279,7 @@ bool MultipleParameterLoop::read_input (std::istream &input)
   if (x)
     init_branches ();
   return x;
-};
+}
 
 
 
@@ -1290,7 +1290,7 @@ bool MultipleParameterLoop::read_input (const std::string &filename)
                                   // function calls
                                   // MultipleParameterLoop::Readinput(std::istream &, std::ostream &)
                                   // which itself calls init_branches.
-};
+}
 
 
 
@@ -1299,7 +1299,7 @@ bool MultipleParameterLoop::read_input_from_string (const char *s)
   bool x = ParameterHandler::read_input (s);
   init_branches ();
   return x;
-};
+}
 
 
 
@@ -1312,7 +1312,7 @@ void MultipleParameterLoop::loop (MultipleParameterLoop::UserClass &uc)
       fill_entry_values (run_no);
       uc.run (*this);
     };
-};
+}
 
 
 
@@ -1369,7 +1369,7 @@ void MultipleParameterLoop::init_branches ()
                                   // other output)
   for (unsigned int i=0; i<n_branches; ++i) 
     fill_entry_values (i);
-};
+}
 
 
 
@@ -1393,7 +1393,7 @@ void MultipleParameterLoop::init_branches_section (const ParameterHandler::Secti
       init_branches_section (*s->second);
       leave_subsection ();
     };
-};
+}
 
 
 
@@ -1464,7 +1464,7 @@ void MultipleParameterLoop::fill_entry_values (const unsigned int run_no)
        possibilities *= choice->different_values.size();
     };
   
-};
+}
 
 
 
@@ -1477,7 +1477,7 @@ MultipleParameterLoop::memory_consumption () const
     mem += multiple_choices[i].memory_consumption ();
   
   return mem;
-};
+}
 
 
 
@@ -1485,7 +1485,7 @@ MultipleParameterLoop::Entry::Entry (const std::vector<std::string> &ssp,
                                     const std::string              &Name,
                                     const std::string              &Value) :
                subsection_path (ssp), entry_name(Name), entry_value(Value)
-{};
+{}
 
 
 
@@ -1533,7 +1533,7 @@ void MultipleParameterLoop::Entry::split_different_values ()
     type = Entry::array;
   else
     type = Entry::variant;
-};
+}
 
 
 unsigned int 
@@ -1544,4 +1544,4 @@ MultipleParameterLoop::Entry::memory_consumption () const
          MemoryConsumption::memory_consumption (entry_value) +
          MemoryConsumption::memory_consumption (different_values) +
          sizeof (type));
-};
+}
index 2423e4438f3592598df15d24dbeb948d20827d77..99e5d8659b5911f80f314f9544e3177505aca101 100644 (file)
@@ -30,7 +30,7 @@
 namespace 
 {
   Threads::ThreadMutex coefficients_lock;
-};
+}
 
 
 namespace Polynomials
@@ -494,7 +494,7 @@ namespace Polynomials
           v.push_back(LagrangeEquidistant(degree,i));
         return v;
       };
-  };
+  }
 
 
 
@@ -682,7 +682,7 @@ namespace Polynomials
     for (unsigned int i=0; i<=degree; ++i)
       v.push_back (Legendre<double>(i));
     return v;
-  };
+  }
 
 
 
@@ -800,7 +800,7 @@ namespace Polynomials
                                   // now, everything is done, so
                                   // release the lock again
     coefficients_lock.release ();
-  };
+  }
 
 
 
@@ -821,7 +821,7 @@ namespace Polynomials
                                   // change any more once computed,
                                   // this is MT safe
     return *p;
-  };
+  }
 
 
 
@@ -842,7 +842,7 @@ namespace Polynomials
     for (unsigned int i=0; i<=degree; ++i)
       v.push_back (Hierarchical<double>(i));
     return v;
-  };
+  }
 }
 
 
index fbda5c562daec007fe1659cafdbbb4609db7bb2c..c596213fc9cca99852a859845783bddcf2e3e674 100644 (file)
@@ -28,7 +28,7 @@ PolynomialSpace<dim>::compute_n_pols (const unsigned int n)
       n_pols /= (i+1);
     }
   return n_pols;
-};
+}
 
 
 template <int dim>
index 47dfec07049766dbebfea69af45a6a36602568be..54f1ee70d16b4953e5f22367de7274aeef12f012 100644 (file)
 template <>
 Quadrature<0>::Quadrature (const unsigned int)
               : n_quadrature_points(0)
-{};
+{}
 
 
 
 template <>
 Quadrature<0>::~Quadrature ()
-{};
+{}
 
 
 
@@ -87,7 +87,7 @@ Quadrature<0>::Quadrature (const Quadrature<-1> &,
                : n_quadrature_points (0)
 {
   Assert (false, ExcInternalError());
-};
+}
 
 
 
@@ -97,7 +97,7 @@ Quadrature<1>::Quadrature (const Quadrature<0> &,
                 n_quadrature_points (0)
 {
   Assert (false, ExcInternalError());
-};
+}
 
 
 
@@ -137,13 +137,13 @@ Quadrature<dim>::Quadrature (const SubQuadrature &q1,
                                   // near that. 
   Assert ((sum>0.999999) && (sum<1.000001), ExcInternalError());
 #endif
-};
+}
 
 
 
 template <int dim>
 Quadrature<dim>::~Quadrature ()
-{};
+{}
 
 
 
@@ -153,7 +153,7 @@ const Point<0> & Quadrature<0>::point (const unsigned int) const
   Assert (false, ExcInternalError());
   static const Point<0> dummy;
   return dummy;
-};
+}
 
 
 
@@ -162,7 +162,7 @@ const Point<dim> & Quadrature<dim>::point (const unsigned int i) const
 {
   Assert (i<n_quadrature_points, ExcIndexRange(i, 0, n_quadrature_points));
   return quadrature_points[i];
-};
+}
 
 
 
@@ -171,7 +171,7 @@ const std::vector<Point<0> > & Quadrature<0>::get_points () const
 {
   Assert (false, ExcInternalError());
   return quadrature_points;
-};
+}
 
 
 
@@ -179,7 +179,7 @@ template <int dim>
 const std::vector<Point<dim> > & Quadrature<dim>::get_points () const
 {
   return quadrature_points;
-};
+}
 
 
 
@@ -188,7 +188,7 @@ double Quadrature<0>::weight (const unsigned int) const
 {
   Assert (false, ExcInternalError());
   return 0;
-};
+}
 
 
 
@@ -197,7 +197,7 @@ double Quadrature<dim>::weight (const unsigned int i) const
 {
   Assert (i<n_quadrature_points, ExcIndexRange(i, 0, n_quadrature_points));
   return weights[i];
-};
+}
 
 
 
@@ -205,7 +205,7 @@ template <int dim>
 const std::vector<double> & Quadrature<dim>::get_weights () const
 {
   return weights;
-};
+}
 
 
 
@@ -214,7 +214,7 @@ const std::vector<double> & Quadrature<0>::get_weights () const
 {
   Assert (false, ExcInternalError());
   return weights;
-};
+}
 
 
 
@@ -224,7 +224,7 @@ Quadrature<dim>::memory_consumption () const
 {
   return (MemoryConsumption::memory_consumption (quadrature_points) +
          MemoryConsumption::memory_consumption (weights));
-};
+}
 
 
 //----------------------------------------------------------------------//
@@ -268,7 +268,7 @@ void QProjector<2>::project_to_face (const Quadrature<1>      &quadrature,
        default:
              Assert (false, ExcInternalError());
       };
-};
+}
 
 
 
@@ -319,7 +319,7 @@ void QProjector<3>::project_to_face (const Quadrature<2>    &quadrature,
        default:
              Assert (false, ExcInternalError());
       };
-};
+}
 
 
 
@@ -406,7 +406,7 @@ void QProjector<2>::project_to_subface (const Quadrature<1>    &quadrature,
        default:
              Assert (false, ExcInternalError());
       };
-};
+}
 
 
 
@@ -566,7 +566,7 @@ void QProjector<3>::project_to_subface (const Quadrature<2>    &quadrature,
        default:
              Assert (false, ExcInternalError());
       };
-};
+}
 
 
 
@@ -576,7 +576,7 @@ QProjector<1>::project_to_all_faces (const Quadrature<0> &)
 {
   Assert (false, ExcImpossibleInDim(1));
   return Quadrature<1>(0);
-};
+}
 
 
 
@@ -617,7 +617,7 @@ QProjector<1>::project_to_all_subfaces (const Quadrature<0> &)
 {
   Assert (false, ExcImpossibleInDim(1));
   return Quadrature<1>(0);
-};
+}
 
 
 
@@ -706,7 +706,7 @@ QProjector<dim>::project_to_child (const Quadrature<dim>    &quadrature,
     weights[i] *= (1./GeometryInfo<dim>::children_per_cell);
 
   return Quadrature<dim> (q_points, weights);
-};
+}
 
 
 
@@ -728,7 +728,7 @@ QIterated<1>::uses_both_endpoints (const Quadrature<1> &base_quadrature)
     };
 
   return (at_left && at_right);
-};
+}
 
 
 
@@ -829,7 +829,7 @@ QIterated<1>::QIterated (const Quadrature<1> &base_quadrature,
   Assert (std::fabs(sum_of_weights-1) < 1e-15,
          ExcSumOfWeightsNotOne());
 #endif
-};
+}
 
 
 
@@ -840,7 +840,7 @@ QIterated<dim>::QIterated (const Quadrature<1> &base_quadrature,
                           const unsigned int   N) :
                Quadrature<dim> (QIterated<dim-1>(base_quadrature, N),
                                 QIterated<1>(base_quadrature, N))
-{};
+{}
 
 
 
index 93827e2ec865cc13caf0b6e4aa6f22c3ba839272..edc0d64e646281caeb2cb2fa1bd774902c2317f5 100644 (file)
@@ -90,7 +90,7 @@ QGauss2<1>::QGauss2 () :
       this->quadrature_points[i] = Point<1>(xpts[i]);
       this->weights[i] = wts[i];
     };
-};
+}
 
 
 template <>
@@ -119,7 +119,7 @@ QGauss3<1>::QGauss3 () :
       this->quadrature_points[i] = Point<1>(xpts[i]);
       this->weights[i] = wts[i];
     };
-};
+}
 
 
 template <>
@@ -152,7 +152,7 @@ QGauss4<1>::QGauss4 () :
       this->quadrature_points[i] = Point<1>(xpts[i]);
       this->weights[i] = wts[i];
     };
-};
+}
 
 
 template <>
@@ -189,7 +189,7 @@ QGauss5<1>::QGauss5 () :
       this->quadrature_points[i] = Point<1>(xpts[i]);
       this->weights[i] = wts[i];
     };
-};
+}
 
 
 template <>
@@ -230,7 +230,7 @@ QGauss6<1>::QGauss6 () :
       this->quadrature_points[i] = Point<1>(xpts[i]);
       this->weights[i] = wts[i];
     };
-};
+}
 
 
 template <>
@@ -275,7 +275,7 @@ QGauss7<1>::QGauss7 () :
       this->quadrature_points[i] = Point<1>(xpts[i]);
       this->weights[i] = wts[i];
     };
-};
+}
 
 
 
@@ -285,7 +285,7 @@ QMidpoint<1>::QMidpoint () :
 {
   this->quadrature_points[0] = Point<1>(0.5);
   this->weights[0] = 1.0;
-};
+}
 
 
 template <>
@@ -300,7 +300,7 @@ QTrapez<1>::QTrapez () :
       this->quadrature_points[i] = Point<1>(xpts[i]);
       this->weights[i] = wts[i];
     };
-};
+}
 
 
 template <>
@@ -315,7 +315,7 @@ QSimpson<1>::QSimpson () :
       this->quadrature_points[i] = Point<1>(xpts[i]);
       this->weights[i] = wts[i];
     };
-};
+}
 
 
 template <>
@@ -330,7 +330,7 @@ QMilne<1>::QMilne () :
       this->quadrature_points[i] = Point<1>(xpts[i]);
       this->weights[i] = wts[i];
     };
-};
+}
 
 
 template <>
@@ -347,7 +347,7 @@ QWeddle<1>::QWeddle () :
       this->quadrature_points[i] = Point<1>(xpts[i]);
       this->weights[i] = wts[i];
     };
-};
+}
 
 
 
@@ -357,53 +357,53 @@ QWeddle<1>::QWeddle () :
 template <int dim>
 QGauss<dim>::QGauss (const unsigned int n)
   :  Quadrature<dim> (QGauss<dim-1>(n), QGauss<1>(n))
-{};
+{}
 
 
 
 template <int dim>
-QGauss2<dim>::QGauss2 () :  Quadrature<dim> (QGauss2<dim-1>(), QGauss2<1>())  {};
+QGauss2<dim>::QGauss2 () :  Quadrature<dim> (QGauss2<dim-1>(), QGauss2<1>())  {}
 
 template <int dim>
 QGauss3<dim>::QGauss3 () :
-               Quadrature<dim> (QGauss3<dim-1>(), QGauss3<1>()){};
+               Quadrature<dim> (QGauss3<dim-1>(), QGauss3<1>()){}
 
 template <int dim>
 QGauss4<dim>::QGauss4 () :
-               Quadrature<dim> (QGauss4<dim-1>(), QGauss4<1>()){};
+               Quadrature<dim> (QGauss4<dim-1>(), QGauss4<1>()){}
 
 template <int dim>
 QGauss5<dim>::QGauss5 () :
-               Quadrature<dim> (QGauss5<dim-1>(), QGauss5<1>()){};
+               Quadrature<dim> (QGauss5<dim-1>(), QGauss5<1>()){}
 
 template <int dim>
 QGauss6<dim>::QGauss6 () :
-               Quadrature<dim> (QGauss6<dim-1>(), QGauss6<1>()){};
+               Quadrature<dim> (QGauss6<dim-1>(), QGauss6<1>()){}
 
 template <int dim>
 QGauss7<dim>::QGauss7 () :
-               Quadrature<dim> (QGauss7<dim-1>(), QGauss7<1>()){};
+               Quadrature<dim> (QGauss7<dim-1>(), QGauss7<1>()){}
 
 
 template <int dim>
 QMidpoint<dim>::QMidpoint () :
-               Quadrature<dim> (QMidpoint<dim-1>(), QMidpoint<1>()){};
+               Quadrature<dim> (QMidpoint<dim-1>(), QMidpoint<1>()){}
 
 template <int dim>
 QTrapez<dim>::QTrapez () :
-               Quadrature<dim> (QTrapez<dim-1>(), QTrapez<1>()){};
+               Quadrature<dim> (QTrapez<dim-1>(), QTrapez<1>()){}
 
 template <int dim>
 QSimpson<dim>::QSimpson () :
-               Quadrature<dim> (QSimpson<dim-1>(), QSimpson<1>()){};
+               Quadrature<dim> (QSimpson<dim-1>(), QSimpson<1>()){}
 
 template <int dim>
 QMilne<dim>::QMilne () :
-               Quadrature<dim> (QMilne<dim-1>(), QMilne<1>()){};
+               Quadrature<dim> (QMilne<dim-1>(), QMilne<1>()){}
 
 template <int dim>
 QWeddle<dim>::QWeddle () :
-               Quadrature<dim> (QWeddle<dim-1>(), QWeddle<1>()){};
+               Quadrature<dim> (QWeddle<dim-1>(), QWeddle<1>()){}
 
 
 // explicit specialization
index 73f0ab8d55256b8bc72dfdcefd618408a624ebc5..c63b85d565184b06b85f6ac53dd8fc2c085fbc1d 100644 (file)
@@ -28,7 +28,7 @@ namespace
 // include the huge <thread_management.h> file into the
 // <subscriptor.h> file).
   Threads::ThreadMutex subscription_lock;
-};
+}
 
 
 
@@ -87,13 +87,13 @@ ActiveObjectMonitor::deregister_object (const Subscriptor *p)
 Subscriptor::Subscriptor () :
                counter (0),
                object_info (0)
-{};
+{}
 
 
 Subscriptor::Subscriptor (const Subscriptor &) :
                counter (0),
                object_info (0)
-{};
+{}
 
 
 Subscriptor::~Subscriptor ()
@@ -118,7 +118,7 @@ Subscriptor & Subscriptor::operator = (const Subscriptor &s)
 {
   object_info = s.object_info;
   return *this;
-};
+}
 
 
 
@@ -132,7 +132,7 @@ void Subscriptor::subscribe () const
   subscription_lock.acquire();
   ++counter;
   subscription_lock.release();
-};
+}
 
 
 void Subscriptor::unsubscribe () const {
@@ -140,10 +140,10 @@ void Subscriptor::unsubscribe () const {
   subscription_lock.acquire();
   --counter;
   subscription_lock.release();
-};
+}
 
 
 unsigned int Subscriptor::n_subscriptions () const 
 {
   return counter;
-};
+}
index a90138d94d539b201025b29b6cd6500352c71540..79e345c3e339d5a413d62a857fd3125d50385984 100644 (file)
@@ -27,12 +27,12 @@ template <int rank, int dim>
 TensorFunction<rank, dim>::TensorFunction (const double initial_time)
                :
                FunctionTime (initial_time)
-{};
+{}
 
 
 template <int rank, int dim>
 TensorFunction<rank, dim>::~TensorFunction ()
-{};
+{}
 
 
 template <int rank, int dim>
@@ -41,7 +41,7 @@ TensorFunction<rank, dim>::value (const Point<dim> &) const
 {
   Assert (false, ExcPureFunctionCalled());
   return Tensor<rank,dim>();
-};
+}
 
 
 // if necessary try to work around a bug in the IBM xlC compiler
@@ -60,7 +60,7 @@ TensorFunction<rank, dim>::value_list (const std::vector<Point<dim> > &points,
 
   for (unsigned int i=0; i<points.size(); ++i)
     values[i]  = this->value (points[i]);
-};
+}
 
 
 template <int rank, int dim>
@@ -69,7 +69,7 @@ TensorFunction<rank, dim>::gradient (const Point<dim> &) const
 {
   Assert (false, ExcPureFunctionCalled());
   return Tensor<rank+1,dim>();
-};
+}
 
 
 template <int rank, int dim>
@@ -82,7 +82,7 @@ TensorFunction<rank, dim>::gradient_list (const std::vector<Point<dim> >   &poin
 
   for (unsigned int i=0; i<points.size(); ++i)
     gradients[i] = gradient(points[i]);
-};
+}
 
 
 template class TensorFunction<1,1>;
index febde0806805b6e4b3c2ba4b628bb3421c71289b..18548a6b41d0cf9aab1563df52203dbd9369aeb0 100644 (file)
@@ -40,7 +40,7 @@ namespace Threads
     n_existing_threads_mutex.acquire ();
     ++n_existing_threads_counter;
     n_existing_threads_mutex.release ();
-  };
+  }
 
 
   
@@ -51,7 +51,7 @@ namespace Threads
     Assert (n_existing_threads_counter >= 1,
             ExcInternalError());
     n_existing_threads_mutex.release ();
-  };
+  }
 
 
 
@@ -73,7 +73,7 @@ namespace Threads
               << "---------------------------------------------------------"
               << std::endl;
     std::abort ();
-  };
+  }
 
 
 
@@ -94,7 +94,7 @@ namespace Threads
               << "---------------------------------------------------------"
               << std::endl;
     std::abort ();
-  };
+  }
   
 
   
@@ -104,7 +104,7 @@ namespace Threads
     const unsigned int n = n_existing_threads_counter;
     n_existing_threads_mutex.release ();
     return n;
-  };
+  }
   
   
 #if DEAL_II_USE_MT != 1
@@ -113,7 +113,7 @@ namespace Threads
                                  int          /*flags*/) const
   {
     (*fun_ptr) (fun_data);
-  };
+  }
   
 
   
@@ -122,7 +122,7 @@ namespace Threads
                              void               *)
   {
     Assert (count == 1, ExcBarrierSizeNotUseful(count));
-  };
+  }
 
 
 #else
@@ -267,7 +267,7 @@ namespace Threads
   FunDataCounter::FunDataCounter () :
                  n_fun_encapsulation_objects (0),
                  n_fun_data_base_objects (0)
-  {};
+  {}
   
 
   
@@ -277,7 +277,7 @@ namespace Threads
                 ExcObjectsExist("FunEncapsulation", n_fun_encapsulation_objects));
     AssertThrow (n_fun_data_base_objects == 0,
                 ExcObjectsExist("FunDataBase", n_fun_data_base_objects));
-  };
+  }
       
 
 
@@ -295,7 +295,7 @@ namespace Threads
                                     // keep some statistics on the
                                     // number of variables around
     ++fun_data_counter.n_fun_encapsulation_objects;
-  };
+  }
 
 
 
@@ -305,7 +305,7 @@ namespace Threads
                                     // keep some statistics on the
                                     // number of variables around
     ++fun_data_counter.n_fun_encapsulation_objects;
-  };
+  }
 
 
 
@@ -315,7 +315,7 @@ namespace Threads
                                     // keep some statistics on the
                                     // number of variables around
     ++fun_data_counter.n_fun_encapsulation_objects;
-  };
+  }
 
 
   FunEncapsulation::~FunEncapsulation ()
@@ -332,7 +332,7 @@ namespace Threads
                                   // keep some statistics on the
                                   // number of variables around
     --fun_data_counter.n_fun_encapsulation_objects;
-  };
+  }
     
 
   const FunEncapsulation &
@@ -344,7 +344,7 @@ namespace Threads
     Assert (false, ExcNotImplemented());
     const FunEncapsulation * const p = 0;
     return *p;
-  };
+  }
 
 
 
@@ -354,7 +354,7 @@ namespace Threads
                                     // keep some statistics on the
                                     // number of variables around
     ++fun_data_counter.n_fun_data_base_objects;
-  };
+  }
 
 
 
@@ -364,7 +364,7 @@ namespace Threads
                                     // keep some statistics on the
                                     // number of variables around
     ++fun_data_counter.n_fun_data_base_objects;
-  };
+  }
 
 
 
@@ -379,7 +379,7 @@ namespace Threads
                                     // keep some statistics on the
                                     // number of variables around
     --fun_data_counter.n_fun_data_base_objects;
-  };
+  }
 
 
     
@@ -414,7 +414,7 @@ namespace Threads
                          (void*)&fun_data,
                          0);
 #endif
-  };
+  }
 
 
   
@@ -424,7 +424,7 @@ namespace Threads
   {
     for (unsigned int i=0; i<n_threads; ++i)
       spawn (thread_manager, fun_data);
-  };
+  }
   
 
 
@@ -461,8 +461,8 @@ namespace Threads
          return_values[i].second = end;
       };
     return return_values;
-  };  
+  };
   
   
  
-};   // end namespace Threads
+};   // end namespace Thread
index 64339e3c8c7ba610ce757fe9e09fada6e0eeb670..48aad53480901586a34fe2dd2141eb5116b51407 100644 (file)
@@ -470,7 +470,7 @@ namespace deal_II_numbers {
                                               * 1/sqrt(2)
                                               */
   static const double  SQRT1_2 = 0.70710678118654752440;
-};
+}
 #endif
 ])
 
index ef766005dc27a8c24bcb4e332b8a2cbc4e3a681f..1facfcf5746f8d695a3ca5f6b6b36cca9b5b7b5d 100644 (file)
@@ -32,7 +32,7 @@ DoFAccessor<dim>::DoFAccessor () :
                dof_handler(0)
 {
   Assert (false, ExcInvalidObject());
-};
+}
 
 
 
@@ -40,7 +40,7 @@ template <int dim>
 inline
 DoFAccessor<dim>::DoFAccessor (const DoFHandler<dim> *dof_handler) :
                dof_handler(const_cast<DoFHandler<dim>*>(dof_handler))
-{};
+{}
 
 
 
@@ -50,7 +50,7 @@ DoFAccessor<dim>::set_dof_handler (DoFHandler<dim> *dh)
 {
   Assert (dh != 0, ExcInvalidObject());
   dof_handler = dh;
-};
+}
 
 
 
@@ -59,7 +59,7 @@ const DoFHandler<dim> &
 DoFAccessor<dim>::get_dof_handler () const
 {
   return *dof_handler;
-};
+}
 
 
 
@@ -70,7 +70,7 @@ DoFAccessor<dim>::operator = (const DoFAccessor<dim> &da)
 {
   this->set_dof_handler (da.dof_handler);
   return *this;
-};
+}
 
 
 
@@ -102,7 +102,7 @@ DoFObjectAccessor<1,dim>::dof_index (const unsigned int i) const
 
   return this->dof_handler->levels[this->present_level]
     ->line_dofs[this->present_index*this->dof_handler->selected_fe->dofs_per_line+i];
-};
+}
 
 
 template <int dim>
@@ -132,7 +132,7 @@ DoFObjectAccessor<1,dim>::vertex_dof_index (const unsigned int vertex,
                                   this->dof_handler->selected_fe->dofs_per_vertex +
                                   i);
   return this->dof_handler->vertex_dofs[dof_number];
-};
+}
 
 
 template <int dim>
@@ -178,7 +178,7 @@ DoFObjectAccessor<1,dim>::get_dof_indices (std::vector<unsigned int> &dof_indice
       *next++ = vertex_dof_index(vertex,d);
   for (unsigned int d=0; d<dofs_per_line; ++d)
     *next++ = dof_index(d);
-};
+}
 
 
 template <int dim>
@@ -196,7 +196,7 @@ DoFObjectAccessor<1,dim>::child (const unsigned int i) const
     Assert (q->used(), typename TriaAccessor<dim>::ExcUnusedCellAsChild());
 #endif
   return q;
-};
+}
 
 
 template <int dim>
@@ -206,7 +206,7 @@ DoFObjectAccessor<1,dim>::copy_from (const DoFObjectAccessor<1,dim> &a)
 {
   BaseClass::copy_from (a);
   this->set_dof_handler (a.dof_handler);
-};
+}
 
 
 /*------------------------- Functions: DoFObjectAccessor<2,dim> -----------------------*/
@@ -226,7 +226,7 @@ unsigned int DoFObjectAccessor<2,dim>::dof_index (const unsigned int i) const
 
   return this->dof_handler->levels[this->present_level]
     ->quad_dofs[this->present_index*this->dof_handler->selected_fe->dofs_per_quad+i];
-};
+}
 
 
 template <int dim>
@@ -247,7 +247,7 @@ DoFObjectAccessor<2,dim>::vertex_dof_index (const unsigned int vertex,
                                   this->dof_handler->selected_fe->dofs_per_vertex +
                                   i);
   return this->dof_handler->vertex_dofs[dof_number];
-};
+}
 
 
 // if necessary try to work around a bug in the IBM xlC compiler
@@ -296,7 +296,7 @@ DoFObjectAccessor<2,dim>::get_dof_indices (std::vector<unsigned int> &dof_indice
       *next++ = this->line(line)->dof_index(d);
   for (unsigned int d=0; d<dofs_per_quad; ++d)
     *next++ = dof_index(d);
-};
+}
 
 
 template <int dim>
@@ -313,7 +313,7 @@ DoFObjectAccessor<2,dim>::line (const unsigned int i) const
       this->line_index (i),
       this->dof_handler
     );
-};
+}
 
 
 template <int dim>
@@ -331,7 +331,7 @@ DoFObjectAccessor<2,dim>::child (const unsigned int i) const
     Assert (q->used(), typename TriaAccessor<dim>::ExcUnusedCellAsChild());
 #endif
   return q;
-};
+}
 
 
 template <int dim>
@@ -341,7 +341,7 @@ DoFObjectAccessor<2,dim>::copy_from (const DoFObjectAccessor<2,dim> &a)
 {
   BaseClass::copy_from (a);
   this->set_dof_handler (a.dof_handler);
-};
+}
 
 
 /*------------------------- Functions: DoFObjectAccessor<3,dim> -----------------------*/
@@ -363,7 +363,7 @@ DoFObjectAccessor<3,dim>::dof_index (const unsigned int i) const
 
   return this->dof_handler->levels[this->present_level]
     ->hex_dofs[this->present_index*this->dof_handler->selected_fe->dofs_per_hex+i];
-};
+}
 
 
 template <int dim>
@@ -384,7 +384,7 @@ DoFObjectAccessor<3,dim>::vertex_dof_index (const unsigned int vertex,
                                   this->dof_handler->selected_fe->dofs_per_vertex +
                                   i);
   return this->dof_handler->vertex_dofs[dof_number];
-};
+}
 
 
 template <int dim>
@@ -431,7 +431,7 @@ DoFObjectAccessor<3,dim>::get_dof_indices (std::vector<unsigned int> &dof_indice
       *next++ = this->quad(quad)->dof_index(d);
   for (unsigned int d=0; d<dofs_per_hex; ++d)
     *next++ = dof_index(d);
-};
+}
 
 
 
@@ -448,7 +448,7 @@ DoFObjectAccessor<3,dim>::line (const unsigned int i) const
       l->index(),
       this->dof_handler
     );
-};
+}
 
 
 template <int dim>
@@ -465,7 +465,7 @@ DoFObjectAccessor<3,dim>::quad (const unsigned int i) const
       this->quad_index (i),
       this->dof_handler
     );
-};
+}
 
 
 template <int dim>
@@ -483,7 +483,7 @@ DoFObjectAccessor<3,dim>::child (const unsigned int i) const
     Assert (q->used(), typename TriaAccessor<dim>::ExcUnusedCellAsChild());
 #endif
   return q;
-};
+}
 
 
 template <int dim>
@@ -491,7 +491,7 @@ void DoFObjectAccessor<3,dim>::copy_from (const DoFObjectAccessor<3,dim> &a)
 {
   BaseClass::copy_from (a);
   this->set_dof_handler (a.dof_handler);
-};
+}
 
 
 /*------------------------- Functions: DoFCellAccessor -----------------------*/
@@ -512,7 +512,7 @@ DoFCellAccessor<dim>::neighbor (const unsigned int i) const
     Assert (q->used(), typename TriaAccessor<dim>::ExcUnusedCellAsNeighbor());
 #endif
   return q;
-};
+}
 
 
 template <int dim>
@@ -530,7 +530,7 @@ DoFCellAccessor<dim>::child (const unsigned int i) const
     Assert (q->used(), typename TriaAccessor<dim>::ExcUnusedCellAsChild());
 #endif
   return q;
-};
+}
 
 
 #endif
index f04bea11acca7bb06df58fe6d6a08f7466612399..26b9a86794849ab99f0e07a10e15f1b7c20e52c0 100644 (file)
@@ -145,7 +145,7 @@ ConstraintMatrix::condense (const SparseMatrix<number> &uncondensed,
        
        ++next_constraint;
       };
-};
+}
 
 
 
@@ -258,7 +258,7 @@ ConstraintMatrix::condense (SparseMatrix<number> &uncondensed) const
              };
          };
     };
-};
+}
 
 
 
@@ -440,7 +440,7 @@ ConstraintMatrix::condense (BlockSparseMatrix<number> &uncondensed) const
            };
        };
     };
-};
+}
 
 
 
@@ -514,7 +514,7 @@ ConstraintMatrix::condense (const VectorType &uncondensed,
 
        ++next_constraint;
       };
-};
+}
 
 
 
@@ -545,7 +545,7 @@ ConstraintMatrix::condense (VectorType &vec) const
                                           // nothing more to do
          break;
       };
-};
+}
 
 
 
@@ -571,7 +571,7 @@ ConstraintMatrix::set_zero (VectorType &vec) const
                                           // nothing more to do
          break;
       };
-};
+}
 
 
 
@@ -644,7 +644,7 @@ ConstraintMatrix::distribute (const VectorType &condensed,
                                next_constraint->entries[i].second);
        ++next_constraint;
       };
-};
+}
 
 
 
@@ -665,7 +665,7 @@ ConstraintMatrix::distribute (VectorType &vec) const
        vec(next_constraint->line) += (vec(next_constraint->entries[i].first) *
                                       next_constraint->entries[i].second);
     };
-};
+}
 
 
 #endif
index c744388bd96a37e37f5363ed4b190eeb973f849b..03ab817b8c25012e6d0e387131896ce1108c9607 100644 (file)
@@ -1285,7 +1285,7 @@ inline
 unsigned int DoFHandler<dim>::n_dofs () const
 {
   return used_dofs;
-};
+}
 
 
 
@@ -1295,7 +1295,7 @@ const FiniteElement<dim> & DoFHandler<dim>::get_fe () const
 {
   Assert(selected_fe!=0, ExcNoFESelected());
   return *selected_fe;
-};
+}
 
 
 /*----------------------------   dof.h     ---------------------------*/
index 336899f67a4d2ea83323a1e8e6bbe11d592867e6..e82bcc8b60c58802487c8bb4b1930e78b28d0133 100644 (file)
@@ -1268,7 +1268,7 @@ map_support_points_to_dofs (const Mapping<dim>       &mapping,
   point_to_index_map.clear ();
   for (unsigned int i=0; i<dof_handler.n_dofs(); ++i)
     point_to_index_map[support_points[i]] = i;
-};
+}
 
 
 
index 9e75f5d666592225296407f43ed92157a77b2ba3..c13b0dcbd10ae9dddcc82308e640a7638801fb75 100644 (file)
@@ -1569,7 +1569,7 @@ unsigned int
 FiniteElementData<dim>::n_dofs_per_vertex () const
 {
   return dofs_per_vertex;
-};
+}
 
 
 template <int dim>
@@ -1578,7 +1578,7 @@ unsigned int
 FiniteElementData<dim>::n_dofs_per_line () const
 {
   return dofs_per_line;
-};
+}
 
 
 template <int dim>
@@ -1587,7 +1587,7 @@ unsigned int
 FiniteElementData<dim>::n_dofs_per_quad () const
 {
   return dofs_per_quad;
-};
+}
 
 
 template <int dim>
@@ -1596,7 +1596,7 @@ unsigned int
 FiniteElementData<dim>::n_dofs_per_hex () const
 {
   return dofs_per_hex;
-};
+}
 
 
 template <int dim>
@@ -1605,7 +1605,7 @@ unsigned int
 FiniteElementData<dim>::n_dofs_per_face () const
 {
   return dofs_per_face;
-};
+}
 
 
 template <int dim>
@@ -1614,7 +1614,7 @@ unsigned int
 FiniteElementData<dim>::n_dofs_per_cell () const
 {
   return dofs_per_cell;
-};
+}
 
 
 template <int dim>
@@ -1623,7 +1623,7 @@ unsigned int
 FiniteElementData<dim>::n_components () const
 {
   return components;
-};
+}
 
 
 
@@ -1712,7 +1712,7 @@ FiniteElementBase<dim>::face_system_to_component_index (const unsigned int index
           typename FiniteElementBase<dim>::ExcShapeFunctionNotPrimitive(index));
 
   return face_system_to_component_table[index];
-};
+}
 
 
 
@@ -1737,7 +1737,7 @@ FiniteElementBase<dim>::face_system_to_base_index (const unsigned int index) con
   Assert(index < face_system_to_base_table.size(),
         ExcIndexRange(index, 0, face_system_to_base_table.size()));
   return face_system_to_base_table[index];
-};
+}
 
 
 
@@ -1771,7 +1771,7 @@ FiniteElementBase<dim>::get_nonzero_components (const unsigned int i) const
 {
   Assert (i < this->dofs_per_cell, ExcIndexRange (i, 0, this->dofs_per_cell));
   return nonzero_components[i];
-};
+}
 
 
 
@@ -1782,7 +1782,7 @@ FiniteElementBase<dim>::n_nonzero_components (const unsigned int i) const
 {
   Assert (i < this->dofs_per_cell, ExcIndexRange (i, 0, this->dofs_per_cell));
   return n_nonzero_components_table[i];
-};
+}
 
 
 
@@ -1803,7 +1803,7 @@ FiniteElementBase<dim>::is_primitive (const unsigned int i) const
                                   // probably more expensive than
                                   // just comparing against 1
   return (n_nonzero_components_table[i] == 1);
-};
+}
 
 
 template <int dim>
@@ -1812,7 +1812,7 @@ bool
 FiniteElementBase<dim>::is_primitive () const
 {
   return cached_primitivity;
-};
+}
 
 
 
index dd482eeab4b2c8939cee38fbaadcc1c0ef135a7a..69bac18a0052d8e761aaeaaa9e91cb769e9aa270 100644 (file)
@@ -1291,7 +1291,7 @@ FEValuesBase<dim>::shape_grad (const unsigned int i,
                                     // component the call of this
                                     // function refers
     return this->shape_gradients[this->shape_function_to_row_table[i]][j];
-};
+}
 
 
 
@@ -1489,7 +1489,7 @@ const Quadrature<dim> &
 FEValues<dim>::get_quadrature () const 
 {
   return quadrature;
-};
+}
 
 
 /*------------------------ Inline functions: FEFaceValuesBase --------------------*/
@@ -1501,10 +1501,10 @@ FEFaceValuesBase<dim>::normal_vector (const unsigned int i) const
 {
   Assert (i<this->normal_vectors.size(), ExcIndexRange(i, 0, this->normal_vectors.size()));
   Assert (this->update_flags & update_normal_vectors,
-         FEValuesBase<dim>::ExcAccessToUninitializedField());
+         typename FEValuesBase<dim>::ExcAccessToUninitializedField());
   
   return this->normal_vectors[i];
-};
+}
 
 
 template <int dim>
@@ -1513,7 +1513,7 @@ typename DoFHandler<dim>::face_iterator
 FEFaceValuesBase<dim>::get_face() const 
 {
   return present_face;
-};
+}
 
 
 
@@ -1523,7 +1523,7 @@ const Quadrature<dim-1> &
 FEFaceValuesBase<dim>::get_quadrature () const 
 {
   return quadrature;
-};
+}
 
 
 
index b1a02a77506678ec42e0c8d2a100838490c029cb..c8edba439c503171a03d3c1bf4fbe447a2e55f9e 100644 (file)
@@ -550,7 +550,7 @@ Mapping<dim>::InternalDataBase::current_update_flags () const
     }
   else
     return update_each;
-};
+}
 
 
 
@@ -560,7 +560,7 @@ bool
 Mapping<dim>::InternalDataBase::is_first_cell () const
 {
   return first_cell;
-};
+}
 
 
 
@@ -570,7 +570,7 @@ void
 Mapping<dim>::InternalDataBase::clear_first_cell ()
 {
   first_cell = false;
-};
+}
 
 
 #endif
index 3237421dbb2afacc1360d86108379aedf79fc556..ffcd162a3c98c1d53fb231ab678522b58276e757 100644 (file)
@@ -821,7 +821,7 @@ GeometryInfo<1>::unit_cell_vertex (const unsigned int vertex)
   const Point<dim> vertices[vertices_per_cell] =
     { Point<dim>(0.), Point<dim>(1.) };
   return vertices[vertex];
-};
+}
 
 
 
@@ -836,7 +836,7 @@ GeometryInfo<2>::unit_cell_vertex (const unsigned int vertex)
     { Point<dim>(0., 0.), Point<dim>(1., 0.),
       Point<dim>(1.,1.), Point<dim>(0.,1.) };
   return vertices[vertex];
-};
+}
 
 
 
@@ -853,7 +853,7 @@ GeometryInfo<3>::unit_cell_vertex (const unsigned int vertex)
       Point<dim>(0., 1., 0.), Point<dim>(1., 1., 0.),
       Point<dim>(1., 1., 1.), Point<dim>(0., 1., 1.) };
   return vertices[vertex];
-};
+}
 
 
 
@@ -868,7 +868,7 @@ GeometryInfo<1>::vertices_adjacent_to_line (const unsigned int line,
          ExcIndexRange (vertex, 0, 2));
 
   return vertex;
-};
+}
 
 
 
@@ -886,7 +886,7 @@ GeometryInfo<2>::vertices_adjacent_to_line (const unsigned int line,
     { {0, 1}, {1, 2}, {3, 2}, {0, 3} };
 
   return vertex_indices[line][vertex];
-};
+}
 
 
 
@@ -906,7 +906,7 @@ GeometryInfo<3>::vertices_adjacent_to_line (const unsigned int line,
       {0, 4}, {1, 5}, {2, 6}, {3, 7}  };
 
   return vertex_indices[line][vertex];
-};
+}
 
 
 
index c47609fa1d3bc1a9d1ac4b506ecf370d84743fed..7e6d3a9dd25a343cc38e503e384af9933490ed64 100644 (file)
@@ -376,7 +376,7 @@ namespace GridOutFlags
           const double       azimut_angle    = 60,
           const double       turn_angle      = 30);
   };
-};
+}
 
 
 
index d0655de4be4c3cd6149257336fadba11bee35b0c..ec5323391d3fbd7f5794c3dffb5ce135fa7d955e 100644 (file)
@@ -188,7 +188,7 @@ void GridTools::transform (const Predicate    &predicate,
                                           // and mark it as treated
          treated_vertices[cell->vertex_index(v)] = true;
        };
-};
+}
 
 
 
index 6afe09b6214dd263fbe9cf1fc751b559bd9b4966..1cf38c6d6bbf7ed05653610d1aede9c8154a51fb 100644 (file)
@@ -36,7 +36,7 @@ TriaAccessor<dim>::copy_from (const TriaAccessor<dim> &a)
   present_level = a.present_level;
   present_index = a.present_index;
   tria = a.tria;
-};
+}
 
 
 
@@ -48,7 +48,7 @@ TriaAccessor<dim>::operator == (const TriaAccessor<dim> &a) const
   Assert (tria == a.tria, ExcCantCompareIterators());
   return ((present_index == a.present_index) &&
          (present_level == a.present_level));
-};
+}
 
 
 
@@ -60,7 +60,7 @@ TriaAccessor<dim>::operator != (const TriaAccessor<dim> &a) const
   Assert (tria == a.tria, ExcCantCompareIterators());
   return ((present_index != a.present_index) ||
          (present_level != a.present_level));
-};
+}
 
 
 
@@ -70,7 +70,7 @@ int
 TriaAccessor<dim>::level () const
 {
   return present_level;
-};
+}
 
 
 
@@ -80,7 +80,7 @@ int
 TriaAccessor<dim>::index () const
 {
   return present_index;
-};
+}
 
 
 
@@ -96,7 +96,7 @@ TriaAccessor<dim>::state () const
       return IteratorState::past_the_end;
     else
       return IteratorState::invalid;
-};
+}
 
 
 
@@ -106,7 +106,7 @@ const Triangulation<dim> &
 TriaAccessor<dim>::get_triangulation () const
 {
   return *tria;
-};
+}
 
 
 /*------------------------ Functions: LineAccessor ---------------------------*/
@@ -120,7 +120,7 @@ TriaObjectAccessor<1,dim>::used () const
   Assert (this->state() == IteratorState::valid,
          typename TriaAccessor<dim>::ExcDereferenceInvalidObject());
   return this->tria->levels[this->present_level]->lines.used[this->present_index];
-};
+}
 
 
 
@@ -131,7 +131,7 @@ TriaObjectAccessor<1,dim>::user_flag_set () const
 {
   Assert (this->used(), typename TriaAccessor<dim>::ExcCellNotUsed());
   return this->tria->levels[this->present_level]->lines.user_flags[this->present_index];
-};
+}
 
 
 
@@ -142,7 +142,7 @@ TriaObjectAccessor<1,dim>::set_user_flag () const
 {
   Assert (this->used(), typename TriaAccessor<dim>::ExcCellNotUsed());
   this->tria->levels[this->present_level]->lines.user_flags[this->present_index] = true;
-};
+}
 
 
 
@@ -153,7 +153,7 @@ TriaObjectAccessor<1,dim>::clear_user_flag () const
 {
   Assert (this->used(), typename TriaAccessor<dim>::ExcCellNotUsed());
   this->tria->levels[this->present_level]->lines.user_flags[this->present_index] = false;
-};
+}
 
 
 
@@ -171,7 +171,7 @@ TriaObjectAccessor<1,dim>::child (const unsigned int i) const
          typename TriaAccessor<dim>::ExcUnusedCellAsChild());
 
   return q;
-};
+}
 
 
 
@@ -182,7 +182,7 @@ TriaObjectAccessor<1,dim>::child_index (unsigned const int i) const
 {
   Assert (i<2, ExcIndexRange(i,0,2));
   return this->tria->levels[this->present_level]->lines.children[this->present_index]+i;
-};
+}
 
 
 
@@ -209,7 +209,7 @@ TriaObjectAccessor<1,dim>::max_refinement_depth () const
   const unsigned int depths[2] = { child(0)->max_refinement_depth() + 1,
                                   child(1)->max_refinement_depth() + 1  };
   return std::max (depths[0], depths[1]);
-};
+}
 
 
 
@@ -237,7 +237,7 @@ TriaObjectAccessor<1,dim>::operator ++ ()
          return;
        };
     };
-};
+}
 
 
 
@@ -263,7 +263,7 @@ TriaObjectAccessor<1,dim>::operator -- ()
                                       // else
       this->present_index = this->tria->levels[this->present_level]->lines.lines.size()-1;
     };
-};
+}
 
 
 /*------------------------ Functions: QuadAccessor ---------------------------*/
@@ -277,7 +277,7 @@ TriaObjectAccessor<2,dim>::used () const
   Assert (this->state() == IteratorState::valid,
          typename TriaAccessor<dim>::ExcDereferenceInvalidObject());
   return this->tria->levels[this->present_level]->quads.used[this->present_index];
-};
+}
 
 
 
@@ -288,7 +288,7 @@ TriaObjectAccessor<2,dim>::user_flag_set () const
 {
   Assert (this->used(), typename TriaAccessor<dim>::ExcCellNotUsed());
   return this->tria->levels[this->present_level]->quads.user_flags[this->present_index];
-};
+}
 
 
 
@@ -299,7 +299,7 @@ TriaObjectAccessor<2,dim>::set_user_flag () const
 {
   Assert (this->used(), typename TriaAccessor<dim>::ExcCellNotUsed());
   this->tria->levels[this->present_level]->quads.user_flags[this->present_index] = true;
-};
+}
 
 
 
@@ -310,7 +310,7 @@ TriaObjectAccessor<2,dim>::clear_user_flag () const
 {
   Assert (this->used(), typename TriaAccessor<dim>::ExcCellNotUsed());
   this->tria->levels[this->present_level]->quads.user_flags[this->present_index] = false;
-};
+}
 
 
 
@@ -326,7 +326,7 @@ TriaObjectAccessor<2,dim>::line (const unsigned int i) const
       this->present_level,
       line_index (i)
     );
-};
+}
 
 
 
@@ -338,7 +338,7 @@ TriaObjectAccessor<2,dim>::line_index (const unsigned int i) const
   Assert (i<4, ExcIndexRange(i,0,4));
 
   return this->tria->levels[this->present_level]->quads.quads[this->present_index].line(i);
-};
+}
 
 
 
@@ -356,7 +356,7 @@ TriaObjectAccessor<2,dim>::child (const unsigned int i) const
          typename TriaAccessor<dim>::ExcUnusedCellAsChild());
 
   return q;
-};
+}
 
 
 
@@ -366,7 +366,7 @@ int TriaObjectAccessor<2,dim>::child_index (const unsigned int i) const
 {
   Assert (i<4, ExcIndexRange(i,0,4));
   return this->tria->levels[this->present_level]->quads.children[this->present_index]+i;
-};
+}
 
 
 
@@ -378,7 +378,7 @@ TriaObjectAccessor<2,dim>::has_children () const
   Assert (this->state() == IteratorState::valid,
          typename TriaAccessor<dim>::ExcDereferenceInvalidObject());
   return (this->tria->levels[this->present_level]->quads.children[this->present_index] != -1);
-};
+}
 
 
 
@@ -396,7 +396,7 @@ TriaObjectAccessor<2,dim>::max_refinement_depth () const
                                   child(3)->max_refinement_depth() + 1 };
   return std::max (std::max (depths[0], depths[1]),
                   std::max (depths[2], depths[3]));
-};
+}
 
 
 
@@ -423,7 +423,7 @@ TriaObjectAccessor<2,dim>::operator ++ ()
          return;
        };
     };
-};
+}
 
 
 
@@ -449,7 +449,7 @@ TriaObjectAccessor<2,dim>::operator -- ()
                                       // else
       this->present_index = this->tria->levels[this->present_level]->quads.quads.size()-1;
     };
-};
+}
 
 
 /*------------------------ Functions: HexAccessor ---------------------------*/
@@ -463,7 +463,7 @@ TriaObjectAccessor<3,dim>::used () const
   Assert (this->state() == IteratorState::valid,
          typename TriaAccessor<dim>::ExcDereferenceInvalidObject());
   return this->tria->levels[this->present_level]->hexes.used[this->present_index];
-};
+}
 
 
 
@@ -474,7 +474,7 @@ TriaObjectAccessor<3,dim>::user_flag_set () const
 {
   Assert (this->used(), typename TriaAccessor<dim>::ExcCellNotUsed());
   return this->tria->levels[this->present_level]->hexes.user_flags[this->present_index];
-};
+}
 
 
 
@@ -485,7 +485,7 @@ TriaObjectAccessor<3,dim>::set_user_flag () const
 {
   Assert (this->used(), typename TriaAccessor<dim>::ExcCellNotUsed());
   this->tria->levels[this->present_level]->hexes.user_flags[this->present_index] = true;
-};
+}
 
 
 
@@ -495,7 +495,7 @@ void TriaObjectAccessor<3,dim>::clear_user_flag () const
 {
   Assert (this->used(), typename TriaAccessor<dim>::ExcCellNotUsed());
   this->tria->levels[this->present_level]->hexes.user_flags[this->present_index] = false;
-};
+}
 
 
 
@@ -534,7 +534,7 @@ TriaObjectAccessor<3,dim>::line (const unsigned int i) const
        };
   Assert (false, ExcIndexRange(i,0,12));
   return TriaIterator<dim,TriaObjectAccessor<1,dim> >(this->tria, -1, -1, 0);
-};
+}
 
 
 
@@ -551,7 +551,7 @@ TriaObjectAccessor<3,dim>::quad (const unsigned int i) const
       this->present_level,
       quad_index (i)
     );
-};
+}
 
 
 
@@ -581,7 +581,7 @@ TriaObjectAccessor<3,dim>::line_index (const unsigned int i) const
        };
   Assert (false, ExcIndexRange(i,0,12));
   return 0;
-};
+}
 
 
 
@@ -593,7 +593,7 @@ TriaObjectAccessor<3,dim>::quad_index (const unsigned int i) const
   Assert (i<6, ExcIndexRange(i,0,6));
 
   return this->tria->levels[this->present_level]->hexes.hexes[this->present_index].quad(i);
-};
+}
 
 
 
@@ -610,7 +610,7 @@ TriaObjectAccessor<3,dim>::child (const unsigned int i) const
          typename TriaAccessor<dim>::ExcUnusedCellAsChild());
 
   return q;
-};
+}
 
 
 
@@ -620,7 +620,7 @@ int TriaObjectAccessor<3,dim>::child_index (const unsigned int i) const
 {
   Assert (i<8, ExcIndexRange(i,0,8));
   return this->tria->levels[this->present_level]->hexes.children[this->present_index]+i;
-};
+}
 
 
 
@@ -630,7 +630,7 @@ bool TriaObjectAccessor<3,dim>::has_children () const
   Assert (this->state() == IteratorState::valid,
          typename TriaAccessor<dim>::ExcDereferenceInvalidObject());
   return (this->tria->levels[this->present_level]->hexes.children[this->present_index] != -1);
-};
+}
 
 
 
@@ -654,7 +654,7 @@ TriaObjectAccessor<3,dim>::max_refinement_depth () const
                             std::max (depths[2], depths[3])),
                   std::max (std::max (depths[4], depths[5]),
                             std::max (depths[6], depths[7])));
-};
+}
 
 
 
@@ -681,7 +681,7 @@ TriaObjectAccessor<3,dim>::operator ++ ()
          return;
        };
     };
-};
+}
 
 
 
@@ -707,7 +707,7 @@ TriaObjectAccessor<3,dim>::operator -- ()
                                       // else
       this->present_index = this->tria->levels[this->present_level]->hexes.hexes.size()-1;
     };
-};
+}
 
 
 /*------------------------ Functions: TriaObjectAccessor ---------------------------*/
@@ -721,7 +721,7 @@ TriaObjectAccessor<celldim,dim>::used () const
   Assert (this->state() == IteratorState::valid,
          typename TriaAccessor<dim>::ExcDereferenceInvalidObject());
   return this->tria->levels[this->present_level]->hexes.used[this->present_index];
-};
+}
 
 
 
@@ -732,7 +732,7 @@ TriaObjectAccessor<celldim,dim>::user_flag_set () const
 {
   Assert (this->used(), typename TriaAccessor<dim>::ExcCellNotUsed());
   return this->tria->levels[this->present_level]->hexes.user_flags[this->present_index];
-};
+}
 
 
 
@@ -743,7 +743,7 @@ TriaObjectAccessor<celldim,dim>::set_user_flag () const
 {
   Assert (this->used(), typename TriaAccessor<dim>::ExcCellNotUsed());
   this->tria->levels[this->present_level]->hexes.user_flags[this->present_index] = true;
-};
+}
 
 
 
@@ -753,7 +753,7 @@ void TriaObjectAccessor<celldim,dim>::clear_user_flag () const
 {
   Assert (this->used(), typename TriaAccessor<dim>::ExcCellNotUsed());
   this->tria->levels[this->present_level]->hexes.user_flags[this->present_index] = false;
-};
+}
 
 
 
@@ -800,7 +800,7 @@ TriaObjectAccessor<celldim,dim>::line (const unsigned int i) const
     }
   
   return TriaIterator<dim,TriaObjectAccessor<1,dim> >(this->tria, -1, -1, 0);
-};
+}
 
 
 
@@ -819,7 +819,7 @@ TriaObjectAccessor<celldim,dim>::quad (const unsigned int i) const
       this->present_level,
       quad_index (i)
     );
-};
+}
 
 
 
@@ -859,7 +859,7 @@ TriaObjectAccessor<celldim,dim>::line_index (const unsigned int i) const
            Assert(false, ExcNotImplemented());
     }    
   return 0;
-};
+}
 
 
 
@@ -872,7 +872,7 @@ TriaObjectAccessor<celldim,dim>::quad_index (const unsigned int i) const
          ExcIndexRange(i,0,GeometryInfo<celldim>::quads_per_cell));
 
   return this->tria->levels[this->present_level]->hexes.hexes[this->present_index].quad(i);
-};
+}
 
 
 
@@ -891,7 +891,7 @@ TriaObjectAccessor<celldim,dim>::child (const unsigned int i) const
          typename TriaAccessor<dim>::ExcUnusedCellAsChild());
 
   return q;
-};
+}
 
 
 
@@ -902,7 +902,7 @@ int TriaObjectAccessor<celldim,dim>::child_index (const unsigned int i) const
   Assert (i < GeometryInfo<celldim>::children_per_cell,
          ExcIndexRange(i,0,GeometryInfo<celldim>::children_per_cell));
   return this->tria->levels[this->present_level]->hexes.children[this->present_index]+i;
-};
+}
 
 
 
@@ -912,7 +912,7 @@ bool TriaObjectAccessor<celldim,dim>::has_children () const
   Assert (this->state() == IteratorState::valid,
          typename TriaAccessor<dim>::ExcDereferenceInvalidObject());
   return (this->tria->levels[this->present_level]->hexes.children[this->present_index] != -1);
-};
+}
 
 
 
@@ -936,7 +936,7 @@ TriaObjectAccessor<celldim,dim>::max_refinement_depth () const
                             std::max (depths[2], depths[3])),
                   std::max (std::max (depths[4], depths[5]),
                             std::max (depths[6], depths[7])));
-};
+}
 
 
 
@@ -963,7 +963,7 @@ TriaObjectAccessor<celldim,dim>::operator ++ ()
          return;
        };
     };
-};
+}
 
 
 
@@ -989,7 +989,7 @@ TriaObjectAccessor<celldim,dim>::operator -- ()
                                       // else
       this->present_index = this->tria->levels[this->present_level]->hexes.hexes.size()-1;
     };
-};
+}
 
 
 /*------------------------ Functions: CellAccessor<dim> -----------------------*/
@@ -1002,7 +1002,7 @@ CellAccessor<1>::face (const unsigned int) const
 {
   Assert (false, TriaAccessor<1>::ExcNotUsefulForThisDimension());
   return TriaIterator<1,TriaObjectAccessor<0, 1> >();
-};
+}
 
 
 
@@ -1012,7 +1012,7 @@ Triangulation<2>::face_iterator
 CellAccessor<2>::face (const unsigned int i) const 
 {
   return this->line(i);
-};
+}
 
 
 
@@ -1022,7 +1022,7 @@ Triangulation<3>::face_iterator
 CellAccessor<3>::face (const unsigned int i) const 
 {
   return this->quad(i);
-};
+}
 
 
 
@@ -1035,7 +1035,7 @@ CellAccessor<dim>::neighbor_index (const unsigned int i) const
          typename TriaAccessor<dim>::ExcInvalidNeighbor(i));
   return this->tria->levels[this->present_level]->
     neighbors[this->present_index*GeometryInfo<dim>::faces_per_cell+i].second;
-};
+}
 
 
 
@@ -1048,7 +1048,7 @@ CellAccessor<dim>::neighbor_level (const unsigned int i) const
          typename TriaAccessor<dim>::ExcInvalidNeighbor(i));
   return this->tria->levels[this->present_level]->
     neighbors[this->present_index*GeometryInfo<dim>::faces_per_cell+i].first;
-};
+}
 
 
 
@@ -1066,7 +1066,7 @@ CellAccessor<dim>::refine_flag_set () const
   Assert (this->active() ||  !this->tria->levels[this->present_level]->refine_flags[this->present_index],
          ExcRefineCellNotActive());
   return this->tria->levels[this->present_level]->refine_flags[this->present_index];
-};
+}
 
 
 
@@ -1080,7 +1080,7 @@ CellAccessor<dim>::set_refine_flag () const
          ExcCellFlaggedForCoarsening());
   
   this->tria->levels[this->present_level]->refine_flags[this->present_index] = true;
-};
+}
 
 
 
@@ -1091,7 +1091,7 @@ CellAccessor<dim>::clear_refine_flag () const
 {
   Assert (this->used() && this->active(), ExcRefineCellNotActive());
   this->tria->levels[this->present_level]->refine_flags[this->present_index] = false;
-};
+}
 
 
 
@@ -1109,7 +1109,7 @@ CellAccessor<dim>::coarsen_flag_set () const
   Assert (this->active() ||  !this->tria->levels[this->present_level]->coarsen_flags[this->present_index],
          ExcRefineCellNotActive());
   return this->tria->levels[this->present_level]->coarsen_flags[this->present_index];
-};
+}
 
 
 
@@ -1122,7 +1122,7 @@ CellAccessor<dim>::set_coarsen_flag () const
   Assert (!refine_flag_set(), ExcCellFlaggedForRefinement());
   
   this->tria->levels[this->present_level]->coarsen_flags[this->present_index] = true;
-};
+}
 
 
 
@@ -1133,7 +1133,7 @@ CellAccessor<dim>::clear_coarsen_flag () const
 {
   Assert (this->used() && this->active(), ExcRefineCellNotActive());
   this->tria->levels[this->present_level]->coarsen_flags[this->present_index] = false;
-};
+}
 
 
 
@@ -1149,7 +1149,7 @@ CellAccessor<dim>::neighbor (const unsigned int i) const
          typename TriaAccessor<dim>::ExcUnusedCellAsNeighbor());
 
   return q;
-};
+}
 
 
 
@@ -1165,7 +1165,7 @@ CellAccessor<dim>::child (const unsigned int i) const
          typename TriaAccessor<dim>::ExcUnusedCellAsChild());
 
   return q;
-};
+}
 
 
 
@@ -1175,7 +1175,7 @@ bool
 CellAccessor<dim>::active () const
 {
   return !this->has_children();
-};
+}
 
 
 #endif
index 6558a742bb84719571b02103567b8a47d3deee8f..67f093479ec3e33b1e8decf40784ce2c7542a14c 100644 (file)
@@ -98,7 +98,7 @@ Hexahedron::Hexahedron (const int i0, const int i1,
   quads[3] = i3;
   quads[4] = i4;
   quads[5] = i5;
-};
+}
 
 
 
@@ -108,7 +108,7 @@ int Hexahedron::quad (const int i) const
   Assert ((i>=0) && (i<6),
          ExcRange(i));
   return quads[i];
-};
+}
 
 
 
@@ -118,7 +118,7 @@ void Hexahedron::set_quad (const int i, const int index)
   Assert ((i>=0) && (i<6),
          ExcRange(i));
   quads[i] = index;
-};
+}
 
 
 
@@ -127,6 +127,6 @@ unsigned int
 Hexahedron::memory_consumption ()
 {
   return sizeof(Hexahedron);
-};
+}
 
 #endif
index 2f906ef8c2f404170f097fdafdd6d2ac9252f508..835b92035f931b7476b1b581c018c31e85d9402d 100644 (file)
@@ -871,7 +871,7 @@ template <int dim, typename Accessor>
 inline
 TriaRawIterator<dim,Accessor>::TriaRawIterator (const Accessor &a) :
                accessor (a)
-{};
+{}
 
 
 
@@ -880,7 +880,7 @@ template <typename OtherAccessor>
 inline
 TriaRawIterator<dim,Accessor>::TriaRawIterator (const TriaRawIterator<dim,OtherAccessor> &i)
                : accessor (i.accessor)
-{};
+{}
 
 
 
@@ -892,7 +892,7 @@ TriaRawIterator<dim,Accessor>::operator * () const
   Assert (state() == IteratorState::valid,
          ExcDereferenceInvalidObject(accessor));
   return accessor;
-};
+}
 
 
 
@@ -904,7 +904,7 @@ TriaRawIterator<dim,Accessor>::operator * ()
   Assert (state() == IteratorState::valid,
          ExcDereferenceInvalidObject(accessor));
   return accessor;
-};
+}
 
 
 
@@ -914,7 +914,7 @@ const Accessor *
 TriaRawIterator<dim,Accessor>::operator -> () const
 {
   return &(this->operator* ());
-};
+}
 
 
 
@@ -924,7 +924,7 @@ Accessor *
 TriaRawIterator<dim,Accessor>::operator -> ()
 {
   return &(this->operator* ());
-};
+}
 
 
 
@@ -934,7 +934,7 @@ IteratorState::IteratorStates
 TriaRawIterator<dim,Accessor>::state () const
 {
   return accessor.state ();
-};
+}
 
 
 
@@ -957,7 +957,7 @@ TriaRawIterator<dim,Accessor>::operator < (const TriaRawIterator &i) const
           (i.state()==IteratorState::valid)                 ) ||
          ((state()==IteratorState::valid) &&
           (i.state()==IteratorState::past_the_end)));
-};
+}
 
 
 template <int dim, typename Accessor>
@@ -969,7 +969,7 @@ TriaRawIterator<dim,Accessor>::operator ++ ()
 
   ++accessor;
   return *this;
-};
+}
 
 
 
@@ -982,7 +982,7 @@ TriaRawIterator<dim,Accessor>::operator -- ()
 
   --accessor;
   return *this;
-};
+}
 
 
 
@@ -992,7 +992,7 @@ void
 TriaRawIterator<dim,Accessor>::print (std::ostream &out) const
 {
   out << accessor.level() << "." << accessor.index();
-};
+}
 
 
 
@@ -1002,7 +1002,7 @@ unsigned int
 TriaRawIterator<dim,Accessor>::memory_consumption () const
 {
   return sizeof(TriaRawIterator<dim,Accessor>);
-};
+}
 
 
 
@@ -1011,7 +1011,7 @@ template <typename OtherAccessor>
 inline
 TriaIterator<dim,Accessor>::TriaIterator (const TriaIterator<dim,OtherAccessor> &i)
                : TriaRawIterator<dim,Accessor> (static_cast<TriaIterator<dim,OtherAccessor> >(i))
-{};
+{}
 
 
 
@@ -1032,7 +1032,7 @@ TriaIterator<dim,Accessor>::TriaIterator (const TriaRawIterator<dim,OtherAccesso
     Assert (this->accessor.used(),
            ExcAssignmentOfUnusedObject());
 #endif
-};
+}
 
 
 
@@ -1041,7 +1041,7 @@ template <typename OtherAccessor>
 inline
 TriaActiveIterator<dim,Accessor>::TriaActiveIterator (const TriaActiveIterator<dim,OtherAccessor> &i)
                : TriaIterator<dim,Accessor> (static_cast<TriaIterator<dim,OtherAccessor> >(i))
-{};
+{}
 
 
 
@@ -1062,7 +1062,7 @@ TriaActiveIterator<dim,Accessor>::TriaActiveIterator (const TriaRawIterator<dim,
     Assert (this->accessor.has_children()==false,
            ExcAssignmentOfInactiveObject());
 #endif
-};
+}
 
 
 
@@ -1081,7 +1081,7 @@ std::ostream & operator << (std::ostream                        &out,
 {
   i.print(out);
   return out;
-};
+}
 
 
 
@@ -1100,7 +1100,7 @@ std::ostream & operator << (std::ostream                     &out,
 {
   i.print(out);
   return out;
-};
+}
 
 
 
@@ -1119,7 +1119,7 @@ std::ostream & operator << (std::ostream                           &out,
 {
   i.print(out);
   return out;
-};
+}
 
 
 
index c8b4b63a815793039d804a5778b28b087706f107..04f3d3fc1e5d041c8e13910a7f3167204c349b5f 100644 (file)
 template <int dim, typename Accessor>
 inline
 TriaRawIterator<dim,Accessor>::TriaRawIterator () :
-               accessor (0, -2, -2, 0) {};
+               accessor (0, -2, -2, 0) {}
 
 
 template <int dim, typename Accessor>
 inline
 TriaRawIterator<dim,Accessor>::TriaRawIterator (const TriaRawIterator<dim,Accessor> &i) :
-               accessor (i.accessor) {};
+               accessor (i.accessor) {}
 
 
 template <int dim, typename Accessor>
@@ -46,7 +46,7 @@ TriaRawIterator<dim,Accessor>::TriaRawIterator (const Triangulation<dim> *parent
                                                const int                 level,
                                                const int                 index,
                                                const typename Accessor::AccessorData *local_data) :
-               accessor (parent, level, index, local_data) {};
+               accessor (parent, level, index, local_data) {}
 
 
 template <int dim, typename Accessor>
@@ -56,7 +56,7 @@ TriaRawIterator<dim,Accessor>::operator = (const TriaRawIterator<dim,Accessor> &
   accessor.copy_from (i.accessor);
   
   return *this;
-};
+}
 
 
 template <int dim, typename Accessor>
@@ -64,7 +64,7 @@ inline
 bool
 TriaRawIterator<dim,Accessor>::operator == (const TriaRawIterator<dim,Accessor> &i) const {
   return accessor == i.accessor;
-};
+}
 
 
 template <int dim, typename Accessor>
@@ -83,7 +83,7 @@ TriaRawIterator<dim,Accessor>::operator != (const TriaRawIterator<dim,Accessor>
                                   //
                                   // Work around the problem this way:
   return accessor.operator != (i.accessor);
-};
+}
 
 
 template <int dim, typename Accessor>
@@ -94,7 +94,7 @@ TriaRawIterator<dim,Accessor>::operator ++ (int) {
   operator++ ();
   
   return tmp;
-};
+}
 
 
 template <int dim, typename Accessor>
@@ -105,7 +105,7 @@ TriaRawIterator<dim,Accessor>::operator -- (int) {
   operator-- ();
   
   return tmp;
-};
+}
 
 
 /*-----------------------  functions: TriaIterator ---------------*/
@@ -114,13 +114,13 @@ TriaRawIterator<dim,Accessor>::operator -- (int) {
 template <int dim, typename Accessor>
 inline
 TriaIterator<dim,Accessor>::TriaIterator () :
-               TriaRawIterator<dim,Accessor> () {};
+               TriaRawIterator<dim,Accessor> () {}
 
 
 template <int dim, typename Accessor>
 inline
 TriaIterator<dim,Accessor>::TriaIterator (const TriaIterator<dim,Accessor> &i) :
-               TriaRawIterator<dim,Accessor> (static_cast<TriaRawIterator<dim,Accessor> >(i)) {};
+               TriaRawIterator<dim,Accessor> (static_cast<TriaRawIterator<dim,Accessor> >(i)) {}
 
 
 template <int dim, typename Accessor>
@@ -139,7 +139,7 @@ TriaIterator<dim,Accessor>::TriaIterator (const TriaRawIterator<dim,Accessor> &i
     Assert (this->accessor.used(),
            ExcAssignmentOfUnusedObject());
 #endif  
-};
+}
 
 
 template <int dim, typename Accessor>
@@ -161,7 +161,7 @@ TriaIterator<dim,Accessor>::TriaIterator (const Triangulation<dim> *parent,
     Assert (this->accessor.used(),
            ExcAssignmentOfUnusedObject());
 #endif  
-};
+}
 
 
 template <int dim, typename Accessor>
@@ -170,7 +170,7 @@ TriaIterator<dim,Accessor> &
 TriaIterator<dim,Accessor>::operator = (const TriaIterator<dim,Accessor> &i) {
   this->accessor.copy_from (i.accessor);
   return *this;
-};
+}
 
 
 template <int dim, typename Accessor>
@@ -190,7 +190,7 @@ TriaIterator<dim,Accessor>::operator = (const TriaRawIterator<dim,Accessor> &i)
            ExcAssignmentOfUnusedObject());
 #endif  
   return *this;
-};
+}
 
 
 template <int dim, typename Accessor>
@@ -201,7 +201,7 @@ TriaIterator<dim,Accessor> & TriaIterator<dim,Accessor>::operator ++ () {
     if (this->accessor.used() == true)
       return *this;
   return *this;
-};
+}
 
 
 template <int dim, typename Accessor>
@@ -211,7 +211,7 @@ TriaIterator<dim,Accessor>  TriaIterator<dim,Accessor>::operator ++ (int) {
   operator++ ();
   
   return tmp;
-};
+}
 
 
 template <int dim, typename Accessor>
@@ -223,7 +223,7 @@ TriaIterator<dim,Accessor>::operator -- () {
     if (this->accessor.used() == true)
       return *this;
   return *this;
-};
+}
 
 
 template <int dim, typename Accessor>
@@ -234,7 +234,7 @@ TriaIterator<dim,Accessor>::operator -- (int) {
   operator-- ();
   
   return tmp;
-};
+}
 
 
 /*-----------------------  functions: TriaActiveIterator ---------------*/
@@ -243,13 +243,13 @@ TriaIterator<dim,Accessor>::operator -- (int) {
 template <int dim, typename Accessor>
 inline
 TriaActiveIterator<dim,Accessor>::TriaActiveIterator () :
-               TriaIterator<dim,Accessor> () {};
+               TriaIterator<dim,Accessor> () {}
 
 
 template <int dim, typename Accessor>
 inline
 TriaActiveIterator<dim,Accessor>::TriaActiveIterator (const TriaActiveIterator<dim,Accessor> &i) :
-               TriaIterator<dim,Accessor> (static_cast<TriaIterator<dim,Accessor> >(i)) {};
+               TriaIterator<dim,Accessor> (static_cast<TriaIterator<dim,Accessor> >(i)) {}
 
 
 template <int dim, typename Accessor>
@@ -268,7 +268,7 @@ TriaActiveIterator<dim,Accessor>::TriaActiveIterator (const TriaRawIterator<dim,
     Assert (this->accessor.has_children()==false,
            ExcAssignmentOfInactiveObject());
 #endif  
-};
+}
 
 
 template <int dim, typename Accessor>
@@ -287,7 +287,7 @@ TriaActiveIterator<dim,Accessor>::TriaActiveIterator (const TriaIterator<dim,Acc
     Assert (this->accessor.has_children()==false,
            ExcAssignmentOfInactiveObject());
 #endif  
-};
+}
 
 
 template <int dim, typename Accessor>
@@ -309,7 +309,7 @@ TriaActiveIterator<dim,Accessor>::TriaActiveIterator (const Triangulation<dim> *
     Assert (this->accessor.has_children()==false,
            ExcAssignmentOfInactiveObject());
 #endif  
-};
+}
 
 
 template <int dim, typename Accessor>
@@ -318,7 +318,7 @@ TriaActiveIterator<dim,Accessor> &
 TriaActiveIterator<dim,Accessor>::operator = (const TriaActiveIterator<dim,Accessor> &i) {
   this->accessor.copy_from (i.accessor);
   return *this;
-};
+}
 
 
 template <int dim, typename Accessor>
@@ -338,7 +338,7 @@ TriaActiveIterator<dim,Accessor>::operator = (const TriaRawIterator<dim,Accessor
            ExcAssignmentOfInactiveObject());
 #endif  
   return *this;
-};
+}
 
 
 template <int dim, typename Accessor>
@@ -358,7 +358,7 @@ TriaActiveIterator<dim,Accessor>::operator = (const TriaIterator<dim,Accessor> &
            ExcAssignmentOfInactiveObject());
 #endif  
   return *this;
-};
+}
 
 
 template <int dim, typename Accessor>
@@ -370,7 +370,7 @@ TriaActiveIterator<dim,Accessor>::operator ++ () {
     if (this->accessor.has_children() == false)
       return *this;
   return *this;
-};
+}
 
 
 template <int dim, typename Accessor>
@@ -381,7 +381,7 @@ TriaActiveIterator<dim,Accessor>::operator ++ (int) {
   operator++ ();
   
   return tmp;
-};
+}
 
 
 template <int dim, typename Accessor>
@@ -393,7 +393,7 @@ TriaActiveIterator<dim,Accessor>::operator -- () {
     if (this->accessor.has_children() == false)
       return *this;
   return *this;
-};
+}
 
 
 template <int dim, typename Accessor>
@@ -403,7 +403,7 @@ TriaActiveIterator<dim,Accessor> TriaActiveIterator<dim,Accessor>::operator -- (
   operator-- ();
   
   return tmp;
-};
+}
 
 
 #endif
index 7da1415a3dee57c1d3bac3772db69593a087d8b8..c1a2af4b4b5b98479390ab111e1984e6925d0064 100644 (file)
@@ -34,7 +34,7 @@ namespace IteratorState
        past_the_end,
        invalid
   };
-};
+}
 
 
 
index 8ce1d9e38649b22e40696c4d535b3d1071be3a51..669157bdeadb2b3d01ee14cd80c70fef2c373abd 100644 (file)
@@ -84,7 +84,7 @@ Line::Line (const int i0, const int i1)
 {
   end_points[0] = i0;
   end_points[1] = i1;
-};
+}
 
 
 
@@ -94,7 +94,7 @@ int Line::vertex (const int i) const
   Assert ((i==0) || (i==1),
          ExcRange(i));
   return end_points[i];
-};
+}
 
 
 
@@ -104,7 +104,7 @@ void Line::set_vertex (const int i, const int index)
   Assert ((i==0) || (i==1),
          ExcRange(i));
   end_points[i] = index;
-};
+}
 
 
 
@@ -113,7 +113,7 @@ unsigned int
 Line::memory_consumption ()
 {
   return sizeof(Line);
-};
+}
 
 
 #endif
index baad4fae3113e68be16518722ddf554e38ed9a95..4111e46a7c8e7ecc895f481f79e11c2c4d3e9b3d 100644 (file)
@@ -90,7 +90,7 @@ Quad::Quad (const int i0, const int i1, const int i2, const int i3)
   lines[1] = i1;
   lines[2] = i2;
   lines[3] = i3;
-};
+}
 
 
 
@@ -100,7 +100,7 @@ int Quad::line (const int i) const
   Assert ((i>=0) && (i<4),
          ExcRange(i));
   return lines[i];
-};
+}
 
 
 
@@ -110,7 +110,7 @@ void Quad::set_line (const int i, const int index)
   Assert ((i>=0) && (i<4),
          ExcRange(i));
   lines[i] = index;
-};
+}
 
 
 
@@ -119,6 +119,6 @@ unsigned int
 Quad::memory_consumption ()
 {
   return sizeof(Quad);
-};
+}
 
 #endif
index 968e55b58548b04c1c1c32feb8d42bb66c1f4b2b..1cfb583fd1d4d5077ecf2cae25334652937f6529 100644 (file)
@@ -336,7 +336,7 @@ MGLevelObject<Object>::MGLevelObject(const unsigned int min,
                minlevel(0)
 {
   resize (min, max);
-};
+}
 
 
 template<class Object>
@@ -369,7 +369,7 @@ MGLevelObject<Object>::resize (const unsigned int new_minlevel,
 
   minlevel = new_minlevel;
   objects.resize (new_maxlevel - new_minlevel + 1);
-};
+}
 
 
 template<class Object>
@@ -379,7 +379,7 @@ MGLevelObject<Object>::clear ()
   typename std::vector<Object>::iterator v;
   for (v = objects.begin(); v != objects.end(); ++v)
     v->clear();  
-};
+}
 
 
 template<class Object>
@@ -387,7 +387,7 @@ unsigned int
 MGLevelObject<Object>::get_minlevel () const
 {
   return minlevel;
-};
+}
 
 
 template<class Object>
@@ -395,7 +395,7 @@ unsigned int
 MGLevelObject<Object>::get_maxlevel () const
 {
   return minlevel + objects.size() - 1;
-};
+}
 
 /*----------------------------------------------------------------------*/
 
index 46d1e77326908bc60a61bb879ce47155744970ad..17842817a88eca30bab07973f8e6d212b462d9a7 100644 (file)
@@ -78,7 +78,7 @@ class MGDoFAccessor {
                                      * Reset the DoF handler pointer.
                                      */
     void set_mg_dof_handler (MGDoFHandler<dim> *dh) {
-      Assert (dh != 0, DoFAccessor<dim>::ExcInvalidObject());
+      Assert (dh != 0, typename DoFAccessor<dim>::ExcInvalidObject());
       mg_dof_handler = dh;
     };
 
index 9e98adaf68914b2a3f8d59ac9c22b4b82559a3f3..33e220e3b3998ec39f74fdb16516023859f12df5 100644 (file)
@@ -1126,7 +1126,7 @@ void MGDoFHandler<dim>::MGVertexDoFs::set_index  (const unsigned int level,
          ExcIndexRange(dof_number, 0, dofs_per_vertex));
   
   indices[(level-coarsest_level)*dofs_per_vertex + dof_number] = index;
-};
+}
 
 
 template <int dim>
@@ -1141,7 +1141,7 @@ MGDoFHandler<dim>::MGVertexDoFs::get_index  (const unsigned int level,
          ExcIndexRange (dof_number, 0, dofs_per_vertex));
   
   return indices[(level-coarsest_level)*dofs_per_vertex + dof_number];
-};
+}
 
 
 template <>
index 207900d974d0046152548992efbb28e48f4d6316..cb1b87311f698889778173a834847ee3cf7c8325 100644 (file)
@@ -253,7 +253,7 @@ inline void
 MGSmootherIdentity<VECTOR>::smooth (
   const unsigned int, VECTOR&,
   const VECTOR&) const
-{};
+{}
 
 /*----------------------------------------------------------------------*/
 
index 81ebfd1a505b3e5178b528c282ba2c2cc18de990..fb56334d440888e1ccaef31da7e0f3bccd36394e 100644 (file)
@@ -30,7 +30,7 @@ MGSmootherRelaxation<MATRIX, VECTOR>
                matrix(&matrix),
                relaxation(relaxation),
                omega(omega)
-{};
+{}
 
 
 template<class MATRIX, class VECTOR>
index 4930e1cc42ce7b1a20ce3ec4806d7db6556a9f9e..1476f7a4de6c2341cf0c171d3248eba117e6b615 100644 (file)
@@ -1545,7 +1545,7 @@ namespace TimeStepBase_Tria_Flags
                      double,
                      << "The following value does not fulfill the requirements: " << arg1);
   };
-};
+}
 
 
 
@@ -1975,7 +1975,7 @@ void TimeDependent::do_loop (InitFunctionObject      init_function,
                  timesteps[n_timesteps-(step-look_back)-1]->sleep(look_back);
                break;
        };
-};
+}
 
 
 /*----------------------------   time-dependent.h     ---------------------------*/
index ed61c5aaba111cd1d1077f53556bcf1cb695a573..6067fa0624724e7da4b71a71da13a0f43d456859 100644 (file)
@@ -34,16 +34,18 @@ template <int dim>
 void DoFObjectAccessor<1, dim>::set_dof_index (const unsigned int i,
                                               const unsigned int index) const
 {
-  Assert (this->dof_handler != 0, DoFAccessor<dim>::ExcInvalidObject());
+  Assert (this->dof_handler != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
                                   // make sure a FE has been selected
                                   // and enough room was reserved
-  Assert (this->dof_handler->selected_fe != 0, DoFAccessor<dim>::ExcInvalidObject());
+  Assert (this->dof_handler->selected_fe != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
   Assert (i<this->dof_handler->selected_fe->dofs_per_line,
          ExcIndexRange (i, 0, this->dof_handler->selected_fe->dofs_per_line));
 
   this->dof_handler->levels[this->present_level]
     ->line_dofs[this->present_index*this->dof_handler->selected_fe->dofs_per_line+i] = index;
-};
+}
 
 
 
@@ -76,7 +78,7 @@ void DoFObjectAccessor<1, dim>::set_vertex_dof_index (const unsigned int vertex,
                                   this->dof_handler->selected_fe->dofs_per_vertex +
                                   i);
   this->dof_handler->vertex_dofs[dof_number] = index;
-};
+}
 
 
 
@@ -115,7 +117,7 @@ distribute_local_to_global (const Vector<double> &local_source,
                                   // distribute cell vector
   for (unsigned int j=0; j<n_dofs; ++j)
     global_destination(dofs[j]) += local_source(j);
-};
+}
 
 
 
@@ -159,7 +161,7 @@ distribute_local_to_global (const FullMatrix<double> &local_source,
   for (unsigned int i=0; i<n_dofs; ++i)
     for (unsigned int j=0; j<n_dofs; ++j)
       global_destination.add(dofs[i], dofs[j], local_source(i,j));
-};
+}
 
 
 
@@ -190,7 +192,7 @@ DoFObjectAccessor<1,dim>::get_dof_values (const InputVector &values,
 
   Assert (next_local_value == local_values.end(),
          ExcInternalError());
-};
+}
 
 
 
@@ -221,7 +223,7 @@ DoFObjectAccessor<1,dim>::set_dof_values (const Vector<number> &local_values,
 
   Assert (next_local_value == local_values.end(),
          ExcInternalError());
-};
+}
 
 
 /*------------------------- Functions: DoFObjectAccessor<2,dim> -----------------------*/
@@ -242,7 +244,7 @@ void DoFObjectAccessor<2, dim>::set_dof_index (const unsigned int i,
 
   this->dof_handler->levels[this->present_level]
     ->quad_dofs[this->present_index*this->dof_handler->selected_fe->dofs_per_quad+i] = index;
-};
+}
 
 
 
@@ -264,7 +266,7 @@ DoFObjectAccessor<2, dim>::set_vertex_dof_index (const unsigned int vertex,
                                   this->dof_handler->selected_fe->dofs_per_vertex +
                                   i);
   this->dof_handler->vertex_dofs[dof_number] = index;
-};
+}
 
 
 
@@ -292,7 +294,7 @@ distribute_local_to_global (const Vector<double> &local_source,
                                   // distribute cell vector
   for (unsigned int j=0; j<n_dofs; ++j)
     global_destination(dofs[j]) += local_source(j);
-};
+}
 
 
 
@@ -325,7 +327,7 @@ distribute_local_to_global (const FullMatrix<double> &local_source,
   for (unsigned int i=0; i<n_dofs; ++i)
     for (unsigned int j=0; j<n_dofs; ++j)
       global_destination.add(dofs[i], dofs[j], local_source(i,j));
-};
+}
 
 
 
@@ -363,7 +365,7 @@ DoFObjectAccessor<2,dim>::get_dof_values (const InputVector &values,
 
   Assert (next_local_value == local_values.end(),
          ExcInternalError());
-};
+}
 
 
 
@@ -401,7 +403,7 @@ DoFObjectAccessor<2,dim>::set_dof_values (const Vector<number> &local_values,
 
   Assert (next_local_value == local_values.end(),
          ExcInternalError());
-};
+}
 
 
 /*------------------------- Functions: DoFObjectAccessor<3,dim> -----------------------*/
@@ -422,7 +424,7 @@ void DoFObjectAccessor<3, dim>::set_dof_index (const unsigned int i,
 
   this->dof_handler->levels[this->present_level]
     ->hex_dofs[this->present_index*this->dof_handler->selected_fe->dofs_per_hex+i] = index;
-};
+}
 
 
 
@@ -444,7 +446,7 @@ void DoFObjectAccessor<3, dim>::set_vertex_dof_index (const unsigned int vertex,
                                   this->dof_handler->selected_fe->dofs_per_vertex +
                                   i);
   this->dof_handler->vertex_dofs[dof_number] = index;
-};
+}
 
 
 
@@ -474,7 +476,7 @@ distribute_local_to_global (const Vector<double> &local_source,
                                   // distribute cell vector
   for (unsigned int j=0; j<n_dofs; ++j)
     global_destination(dofs[j]) += local_source(j);
-};
+}
 
 
 
@@ -509,7 +511,7 @@ distribute_local_to_global (const FullMatrix<double> &local_source,
   for (unsigned int i=0; i<n_dofs; ++i)
     for (unsigned int j=0; j<n_dofs; ++j)
       global_destination.add(dofs[i], dofs[j], local_source(i,j));
-};
+}
 
 
 
@@ -549,7 +551,7 @@ DoFObjectAccessor<3,dim>::get_dof_values (const InputVector &values,
 
   Assert (next_local_value == local_values.end(),
          ExcInternalError());
-};
+}
 
 
 
@@ -591,7 +593,7 @@ DoFObjectAccessor<3,dim>::set_dof_values (const Vector<number> &local_values,
 
   Assert (next_local_value == local_values.end(),
          ExcInternalError());
-};
+}
 
 
 
@@ -606,7 +608,7 @@ DoFCellAccessor<1>::face (const unsigned int) const
 {
   Assert (false, ExcNotUsefulForThisDimension());
   return TriaIterator<1, DoFObjectAccessor<0,1> >();
-};
+}
 
 #endif
 
@@ -618,7 +620,7 @@ TriaIterator<2, DoFObjectAccessor<1,2> >
 DoFCellAccessor<2>::face (const unsigned int i) const
 {
   return this->line(i);
-};
+}
 
 #endif
 
@@ -630,7 +632,7 @@ TriaIterator<3, DoFObjectAccessor<2, 3> >
 DoFCellAccessor<3>::face (const unsigned int i) const
 {
   return this->quad(i);
-};
+}
 
 #endif
 
@@ -645,12 +647,14 @@ DoFCellAccessor<dim>::get_interpolated_dof_values (const InputVector &values,
   const unsigned int        dofs_per_cell = fe.dofs_per_cell;
   
   
-  Assert (this->dof_handler != 0, DoFAccessor<dim>::ExcInvalidObject());
-  Assert (&fe != 0, DoFAccessor<dim>::ExcInvalidObject());
+  Assert (this->dof_handler != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
+  Assert (&fe != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
   Assert (interpolated_values.size() == dofs_per_cell,
-         DoFAccessor<dim>::ExcVectorDoesNotMatch());
+         typename DoFAccessor<dim>::ExcVectorDoesNotMatch());
   Assert (values.size() == this->dof_handler->n_dofs(),
-         DoFAccessor<dim>::ExcVectorDoesNotMatch());
+         typename DoFAccessor<dim>::ExcVectorDoesNotMatch());
 
   if (!this->has_children())
                                     // if this cell has no children: simply
@@ -737,7 +741,7 @@ DoFCellAccessor<dim>::get_interpolated_dof_values (const InputVector &values,
                 interpolated_values(i) = tmp2(i);
        };
     };
-};
+}
 
 
 
@@ -749,12 +753,14 @@ DoFCellAccessor<dim>::set_dof_values_by_interpolation (const Vector<number> &loc
 {
   const unsigned int dofs_per_cell = this->dof_handler->get_fe().dofs_per_cell;
   
-  Assert (this->dof_handler != 0, DoFAccessor<dim>::ExcInvalidObject());
-  Assert (&this->dof_handler->get_fe() != 0, DoFAccessor<dim>::ExcInvalidObject());
+  Assert (this->dof_handler != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
+  Assert (&this->dof_handler->get_fe() != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
   Assert (local_values.size() == dofs_per_cell,
-         DoFAccessor<dim>::ExcVectorDoesNotMatch());
+         typename DoFAccessor<dim>::ExcVectorDoesNotMatch());
   Assert (values.size() == this->dof_handler->n_dofs(),
-         DoFAccessor<dim>::ExcVectorDoesNotMatch());
+         typename DoFAccessor<dim>::ExcVectorDoesNotMatch());
 
   if (!this->has_children())
                                      // if this cell has no children: simply
@@ -774,7 +780,7 @@ DoFCellAccessor<dim>::set_dof_values_by_interpolation (const Vector<number> &loc
          this->child(child)->set_dof_values_by_interpolation (tmp, values);
        };
     };
-};
+}
 
 
 
index 96c3f44b669f8cd4fd6ad6e98968c9a3e89ccdd8..24d817fda4831ad9fea54a6f578d3a16924a43ae 100644 (file)
@@ -41,7 +41,7 @@ bool
 ConstraintMatrix::check_zero_weight (const std::pair<unsigned int, double> &p)
 {
   return (p.second == 0);
-};
+}
 
 
 
@@ -50,7 +50,7 @@ bool
 ConstraintMatrix::ConstraintLine::operator < (const ConstraintLine &a) const
 {
   return line < a.line;
-};
+}
 
 
 
@@ -59,7 +59,7 @@ bool
 ConstraintMatrix::ConstraintLine::operator == (const ConstraintLine &a) const
 {
   return line == a.line;
-};
+}
 
 
 
@@ -68,14 +68,14 @@ ConstraintMatrix::ConstraintLine::memory_consumption () const
 {
   return (MemoryConsumption::memory_consumption (line) +
          MemoryConsumption::memory_consumption (entries));
-};
+}
 
 
 
 ConstraintMatrix::ConstraintMatrix () :
                lines(),
                sorted(false)
-{};
+{}
 
 
 void ConstraintMatrix::add_line (const unsigned int line)
@@ -92,7 +92,7 @@ void ConstraintMatrix::add_line (const unsigned int line)
                                   // list
   lines.push_back (ConstraintLine());
   lines.back().line = line;
-};
+}
 
 
 
@@ -135,7 +135,7 @@ void ConstraintMatrix::add_entry (const unsigned int line,
       };
   
   line_ptr->entries.push_back (std::make_pair(column,value));
-};
+}
 
 
 
@@ -185,7 +185,7 @@ void ConstraintMatrix::add_entries (const unsigned int                        li
       
       line_ptr->entries.push_back (*col_val_pair);
     };
-};
+}
 
 
 
@@ -246,7 +246,7 @@ void ConstraintMatrix::close ()
 #endif
   
   sorted = true;
-};
+}
 
 
 
@@ -446,7 +446,7 @@ void ConstraintMatrix::merge (const ConstraintMatrix &other_constraints)
                                   // state
   if (object_was_sorted == true)
     close ();
-};
+}
 
 
 
@@ -455,7 +455,7 @@ void ConstraintMatrix::clear ()
   std::vector<ConstraintLine> tmp;
   lines.swap (tmp);
   sorted = false;
-};
+}
 
 
 
@@ -565,7 +565,7 @@ void ConstraintMatrix::condense (const SparsityPattern &uncondensed,
       };
 
   condensed.compress();
-};
+}
 
 
 
@@ -679,7 +679,7 @@ void ConstraintMatrix::condense (SparsityPattern &sparsity) const
     };
   
   sparsity.compress();
-};
+}
 
 
 
@@ -812,7 +812,7 @@ void ConstraintMatrix::condense (CompressedSparsityPattern &sparsity) const
                                .entries[q].first);
          };
     };
-};
+}
 
 
 
@@ -955,7 +955,7 @@ void ConstraintMatrix::condense (BlockSparsityPattern &sparsity) const
     };
   
   sparsity.compress();
-};
+}
 
 
 
@@ -1087,14 +1087,14 @@ void ConstraintMatrix::condense (CompressedBlockSparsityPattern &sparsity) const
            };
        };
     };
-};
+}
 
 
 
 unsigned int ConstraintMatrix::n_constraints () const
 {
   return lines.size();
-};
+}
 
 
 
@@ -1118,7 +1118,7 @@ bool ConstraintMatrix::is_constrained (const unsigned int index) const
 
       return false;
     };
-};
+}
 
 
 
@@ -1147,7 +1147,7 @@ bool ConstraintMatrix::is_identity_constrained (const unsigned int index) const
 
       return false;
     };
-};
+}
 
 
 
@@ -1163,7 +1163,7 @@ unsigned int ConstraintMatrix::max_constraint_indirections () const
                            static_cast<unsigned int>(i->entries.size()));
 
   return return_value;
-};
+}
 
     
 
@@ -1176,7 +1176,7 @@ void ConstraintMatrix::print (std::ostream &out) const
          << ":  " << lines[i].entries[j].second << std::endl;
 
   AssertThrow (out, ExcIO());
-};
+}
 
 
 
@@ -1185,7 +1185,7 @@ ConstraintMatrix::memory_consumption () const
 {
   return (MemoryConsumption::memory_consumption (lines) +
          MemoryConsumption::memory_consumption (sorted));
-};
+}
 
 
 
@@ -1216,19 +1216,19 @@ ConstraintMatrix::memory_consumption () const
 
 
 #define VectorType Vector<float>
-vector_functions;
+vector_functions
 #undef VectorType
 
 #define VectorType Vector<double>
-vector_functions;
+vector_functions
 #undef VectorType
 
 #define VectorType BlockVector<double>
-vector_functions;
+vector_functions
 #undef VectorType
 
 #define VectorType BlockVector<float>
-vector_functions;
+vector_functions
 #undef VectorType
 
 
index 92579f38f2f237fcf2d77c5847859cf360bcf88a..4626b33176838d9aecdff55453ca045301867b4c 100644 (file)
@@ -44,7 +44,7 @@ template <int dim>
 DoFHandler<dim>::DoFHandler (const Triangulation<dim> &tria) :
                tria(&tria),
                used_dofs (0)
-{};
+{}
 
 
 template <int dim>
@@ -52,7 +52,7 @@ DoFHandler<dim>::~DoFHandler ()
 {
                                   // release allocated memory
   clear ();
-};
+}
 
 
 #if deal_II_dimension == 1
@@ -61,70 +61,70 @@ template <>
 DoFHandler<1>::raw_cell_iterator
 DoFHandler<1>::begin_raw (const unsigned int level) const {
   return begin_raw_line (level);
-};
+}
 
 
 template <>
 DoFHandler<1>::cell_iterator
 DoFHandler<1>::begin (const unsigned int level) const {
   return begin_line (level);
-};
+}
 
 
 template <>
 DoFHandler<1>::active_cell_iterator
 DoFHandler<1>::begin_active (const unsigned int level) const {
   return begin_active_line (level);
-};
+}
 
 
 template <>
 DoFHandler<1>::raw_cell_iterator
 DoFHandler<1>::end () const {
   return end_line ();
-};
+}
 
 
 template <>
 DoFHandler<1>::raw_cell_iterator
 DoFHandler<1>::last_raw () const {
   return last_raw_line ();
-};
+}
 
 
 template <>
 DoFHandler<1>::raw_cell_iterator
 DoFHandler<1>::last_raw (const unsigned int level) const {
   return last_raw_line (level);
-};
+}
 
 
 template <>
 DoFHandler<1>::cell_iterator
 DoFHandler<1>::last () const {
   return last_line ();
-};
+}
 
 
 template <>
 DoFHandler<1>::cell_iterator
 DoFHandler<1>::last (const unsigned int level) const {
   return last_line (level);
-};
+}
 
 
 template <>
 DoFHandler<1>::active_cell_iterator
 DoFHandler<1>::last_active () const {
   return last_active_line ();
-};
+}
 
 
 template <>
 DoFHandler<1>::active_cell_iterator
 DoFHandler<1>::last_active (const unsigned int level) const {
   return last_active_line (level);
-};
+}
 
 
 template <>
@@ -132,7 +132,7 @@ DoFDimensionInfo<1>::raw_face_iterator
 DoFHandler<1>::begin_raw_face (const unsigned int) const {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 template <>
@@ -140,7 +140,7 @@ DoFDimensionInfo<1>::face_iterator
 DoFHandler<1>::begin_face (const unsigned int) const {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 template <>
@@ -148,7 +148,7 @@ DoFDimensionInfo<1>::active_face_iterator
 DoFHandler<1>::begin_active_face (const unsigned int) const {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 template <>
@@ -156,7 +156,7 @@ DoFDimensionInfo<1>::raw_face_iterator
 DoFHandler<1>::end_face () const {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 template <>
@@ -164,7 +164,7 @@ DoFDimensionInfo<1>::raw_face_iterator
 DoFHandler<1>::last_raw_face () const {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 template <>
@@ -172,7 +172,7 @@ DoFDimensionInfo<1>::raw_face_iterator
 DoFHandler<1>::last_raw_face (const unsigned int) const {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 template <>
@@ -180,7 +180,7 @@ DoFDimensionInfo<1>::face_iterator
 DoFHandler<1>::last_face () const {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 template <>
@@ -188,7 +188,7 @@ DoFDimensionInfo<1>::face_iterator
 DoFHandler<1>::last_face (const unsigned int) const {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 template <>
@@ -196,7 +196,7 @@ DoFDimensionInfo<1>::active_face_iterator
 DoFHandler<1>::last_active_face () const {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 template <>
@@ -204,7 +204,7 @@ DoFDimensionInfo<1>::active_face_iterator
 DoFHandler<1>::last_active_face (const unsigned int) const {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 template <>
@@ -212,7 +212,7 @@ DoFHandler<1>::raw_quad_iterator
 DoFHandler<1>::begin_raw_quad (const unsigned int) const {
   Assert (false, ExcNotImplemented());
   return 0;
-};
+}
 
 
 template <>
@@ -220,7 +220,7 @@ DoFHandler<1>::quad_iterator
 DoFHandler<1>::begin_quad (const unsigned int) const {
   Assert (false, ExcNotImplemented());
   return 0;
-};
+}
 
 
 template <>
@@ -228,7 +228,7 @@ DoFHandler<1>::active_quad_iterator
 DoFHandler<1>::begin_active_quad (const unsigned int) const {
   Assert (false, ExcNotImplemented());
   return 0;
-};
+}
 
 
 template <>
@@ -236,7 +236,7 @@ DoFHandler<1>::raw_quad_iterator
 DoFHandler<1>::end_quad () const {
   Assert (false, ExcNotImplemented());
   return 0;
-};
+}
 
 
 template <>
@@ -244,7 +244,7 @@ DoFHandler<1>::raw_quad_iterator
 DoFHandler<1>::last_raw_quad (const unsigned int) const {
   Assert (false, ExcNotImplemented());
   return 0;
-};
+}
 
 
 template <>
@@ -252,7 +252,7 @@ DoFHandler<1>::quad_iterator
 DoFHandler<1>::last_quad (const unsigned int) const {
   Assert (false, ExcNotImplemented());
   return 0;
-};
+}
 
 
 template <>
@@ -260,7 +260,7 @@ DoFHandler<1>::active_quad_iterator
 DoFHandler<1>::last_active_quad (const unsigned int) const {
   Assert (false, ExcNotImplemented());
   return 0;
-};
+}
 
 
 template <>
@@ -268,7 +268,7 @@ DoFHandler<1>::raw_quad_iterator
 DoFHandler<1>::last_raw_quad () const {
   Assert (false, ExcNotImplemented());
   return 0;
-};
+}
 
 
 template <>
@@ -276,7 +276,7 @@ DoFHandler<1>::quad_iterator
 DoFHandler<1>::last_quad () const {
   Assert (false, ExcNotImplemented());
   return 0;
-};
+}
 
 
 template <>
@@ -284,7 +284,7 @@ DoFHandler<1>::active_quad_iterator
 DoFHandler<1>::last_active_quad () const {
   Assert (false, ExcNotImplemented());
   return 0;
-};
+}
 
 
 template <>
@@ -292,7 +292,7 @@ DoFHandler<1>::raw_hex_iterator
 DoFHandler<1>::begin_raw_hex (const unsigned int) const {
   Assert (false, ExcNotImplemented());
   return 0;
-};
+}
 
 
 template <>
@@ -300,7 +300,7 @@ DoFHandler<1>::hex_iterator
 DoFHandler<1>::begin_hex (const unsigned int) const {
   Assert (false, ExcNotImplemented());
   return 0;
-};
+}
 
 
 template <>
@@ -308,7 +308,7 @@ DoFHandler<1>::active_hex_iterator
 DoFHandler<1>::begin_active_hex (const unsigned int) const {
   Assert (false, ExcNotImplemented());
   return 0;
-};
+}
 
 
 template <>
@@ -316,7 +316,7 @@ DoFHandler<1>::raw_hex_iterator
 DoFHandler<1>::end_hex () const {
   Assert (false, ExcNotImplemented());
   return 0;
-};
+}
 
 
 template <>
@@ -324,7 +324,7 @@ DoFHandler<1>::raw_hex_iterator
 DoFHandler<1>::last_raw_hex (const unsigned int) const {
   Assert (false, ExcNotImplemented());
   return 0;
-};
+}
 
 
 template <>
@@ -332,7 +332,7 @@ DoFHandler<1>::raw_hex_iterator
 DoFHandler<1>::last_raw_hex () const {
   Assert (false, ExcNotImplemented());
   return 0;
-};
+}
 
 
 template <>
@@ -340,7 +340,7 @@ DoFHandler<1>::hex_iterator
 DoFHandler<1>::last_hex (const unsigned int) const {
   Assert (false, ExcNotImplemented());
   return 0;
-};
+}
 
 
 template <>
@@ -348,7 +348,7 @@ DoFHandler<1>::hex_iterator
 DoFHandler<1>::last_hex () const {
   Assert (false, ExcNotImplemented());
   return 0;
-};
+}
 
 
 template <>
@@ -356,7 +356,7 @@ DoFHandler<1>::active_hex_iterator
 DoFHandler<1>::last_active_hex (const unsigned int) const {
   Assert (false, ExcNotImplemented());
   return 0;
-};
+}
 
 
 template <>
@@ -364,7 +364,7 @@ DoFHandler<1>::active_hex_iterator
 DoFHandler<1>::last_active_hex () const {
   Assert (false, ExcNotImplemented());
   return 0;
-};
+}
 
 #endif
 
@@ -375,140 +375,140 @@ template <>
 DoFHandler<2>::raw_cell_iterator
 DoFHandler<2>::begin_raw (const unsigned int level) const {
   return begin_raw_quad (level);
-};
+}
 
 
 template <>
 DoFHandler<2>::cell_iterator
 DoFHandler<2>::begin (const unsigned int level) const {
   return begin_quad (level);
-};
+}
 
 
 template <>
 DoFHandler<2>::active_cell_iterator
 DoFHandler<2>::begin_active (const unsigned int level) const {
   return begin_active_quad (level);
-};
+}
 
 
 template <>
 DoFHandler<2>::raw_cell_iterator
 DoFHandler<2>::end () const {
   return end_quad ();
-};
+}
 
 
 template <>
 DoFHandler<2>::raw_cell_iterator
 DoFHandler<2>::last_raw () const {
   return last_raw_quad ();
-};
+}
 
 
 template <>
 DoFHandler<2>::raw_cell_iterator
 DoFHandler<2>::last_raw (const unsigned int level) const {
   return last_raw_quad (level);
-};
+}
 
 
 template <>
 DoFHandler<2>::cell_iterator
 DoFHandler<2>::last () const {
   return last_quad ();
-};
+}
 
 
 template <>
 DoFHandler<2>::cell_iterator
 DoFHandler<2>::last (const unsigned int level) const {
   return last_quad (level);
-};
+}
 
 
 template <>
 DoFHandler<2>::active_cell_iterator
 DoFHandler<2>::last_active () const {
   return last_active_quad ();
-};
+}
 
 
 template <>
 DoFHandler<2>::active_cell_iterator
 DoFHandler<2>::last_active (const unsigned int level) const {
   return last_active_quad (level);
-};
+}
 
 
 template <>
 DoFDimensionInfo<2>::raw_face_iterator
 DoFHandler<2>::begin_raw_face (const unsigned int level) const {
   return begin_raw_line (level);
-};
+}
 
 
 template <>
 DoFDimensionInfo<2>::face_iterator
 DoFHandler<2>::begin_face (const unsigned int level) const {
   return begin_line (level);
-};
+}
 
 
 template <>
 DoFDimensionInfo<2>::active_face_iterator
 DoFHandler<2>::begin_active_face (const unsigned int level) const {
   return begin_active_line (level);
-};
+}
 
 
 template <>
 DoFDimensionInfo<2>::raw_face_iterator
 DoFHandler<2>::end_face () const {
   return end_line ();
-};
+}
 
 
 template <>
 DoFDimensionInfo<2>::raw_face_iterator
 DoFHandler<2>::last_raw_face () const {
   return last_raw_line ();
-};
+}
 
 
 template <>
 DoFDimensionInfo<2>::raw_face_iterator
 DoFHandler<2>::last_raw_face (const unsigned int level) const {
   return last_raw_line (level);
-};
+}
 
 
 template <>
 DoFDimensionInfo<2>::face_iterator
 DoFHandler<2>::last_face () const {
   return last_line ();
-};
+}
 
 
 template <>
 DoFDimensionInfo<2>::face_iterator
 DoFHandler<2>::last_face (const unsigned int level) const {
   return last_line (level);
-};
+}
 
 
 template <>
 DoFDimensionInfo<2>::active_face_iterator
 DoFHandler<2>::last_active_face () const {
   return last_active_line ();
-};
+}
 
 
 template <>
 DoFDimensionInfo<2>::active_face_iterator
 DoFHandler<2>::last_active_face (const unsigned int level) const {
   return last_active_line (level);
-};
+}
 
 
 template <>
@@ -516,7 +516,7 @@ DoFHandler<2>::raw_hex_iterator
 DoFHandler<2>::begin_raw_hex (const unsigned int) const {
   Assert (false, ExcNotImplemented());
   return 0;
-};
+}
 
 
 template <>
@@ -524,7 +524,7 @@ DoFHandler<2>::hex_iterator
 DoFHandler<2>::begin_hex (const unsigned int) const {
   Assert (false, ExcNotImplemented());
   return 0;
-};
+}
 
 
 template <>
@@ -532,7 +532,7 @@ DoFHandler<2>::active_hex_iterator
 DoFHandler<2>::begin_active_hex (const unsigned int) const {
   Assert (false, ExcNotImplemented());
   return 0;
-};
+}
 
 
 template <>
@@ -540,7 +540,7 @@ DoFHandler<2>::raw_hex_iterator
 DoFHandler<2>::end_hex () const {
   Assert (false, ExcNotImplemented());
   return 0;
-};
+}
 
 
 template <>
@@ -548,7 +548,7 @@ DoFHandler<2>::raw_hex_iterator
 DoFHandler<2>::last_raw_hex (const unsigned int) const {
   Assert (false, ExcNotImplemented());
   return 0;
-};
+}
 
 
 template <>
@@ -556,7 +556,7 @@ DoFHandler<2>::raw_hex_iterator
 DoFHandler<2>::last_raw_hex () const {
   Assert (false, ExcNotImplemented());
   return 0;
-};
+}
 
 
 template <>
@@ -564,7 +564,7 @@ DoFHandler<2>::hex_iterator
 DoFHandler<2>::last_hex (const unsigned int) const {
   Assert (false, ExcNotImplemented());
   return 0;
-};
+}
 
 
 template <>
@@ -572,7 +572,7 @@ DoFHandler<2>::hex_iterator
 DoFHandler<2>::last_hex () const {
   Assert (false, ExcNotImplemented());
   return 0;
-};
+}
 
 
 template <>
@@ -580,7 +580,7 @@ DoFHandler<2>::active_hex_iterator
 DoFHandler<2>::last_active_hex (const unsigned int) const {
   Assert (false, ExcNotImplemented());
   return 0;
-};
+}
 
 
 template <>
@@ -588,7 +588,7 @@ DoFHandler<2>::active_hex_iterator
 DoFHandler<2>::last_active_hex () const {
   Assert (false, ExcNotImplemented());
   return 0;
-};
+}
 
 
 #endif
@@ -600,140 +600,140 @@ template <>
 DoFHandler<3>::raw_cell_iterator
 DoFHandler<3>::begin_raw (const unsigned int level) const {
   return begin_raw_hex (level);
-};
+}
 
 
 template <>
 DoFHandler<3>::cell_iterator
 DoFHandler<3>::begin (const unsigned int level) const {
   return begin_hex (level);
-};
+}
 
 
 template <>
 DoFHandler<3>::active_cell_iterator
 DoFHandler<3>::begin_active (const unsigned int level) const {
   return begin_active_hex (level);
-};
+}
 
 
 template <>
 DoFHandler<3>::raw_cell_iterator
 DoFHandler<3>::end () const {
   return end_hex ();
-};
+}
 
 
 template <>
 DoFHandler<3>::raw_cell_iterator
 DoFHandler<3>::last_raw () const {
   return last_raw_hex ();
-};
+}
 
 
 template <>
 DoFHandler<3>::raw_cell_iterator
 DoFHandler<3>::last_raw (const unsigned int level) const {
   return last_raw_hex (level);
-};
+}
 
 
 template <>
 DoFHandler<3>::cell_iterator
 DoFHandler<3>::last () const {
   return last_hex ();
-};
+}
 
 
 template <>
 DoFHandler<3>::cell_iterator
 DoFHandler<3>::last (const unsigned int level) const {
   return last_hex (level);
-};
+}
 
 
 template <>
 DoFHandler<3>::active_cell_iterator
 DoFHandler<3>::last_active () const {
   return last_active_hex ();
-};
+}
 
 
 template <>
 DoFHandler<3>::active_cell_iterator
 DoFHandler<3>::last_active (const unsigned int level) const {
   return last_active_hex (level);
-};
+}
 
 
 template <>
 DoFHandler<3>::raw_face_iterator
 DoFHandler<3>::begin_raw_face (const unsigned int level) const {
   return begin_raw_quad (level);
-};
+}
 
 
 template <>
 DoFHandler<3>::face_iterator
 DoFHandler<3>::begin_face (const unsigned int level) const {
   return begin_quad (level);
-};
+}
 
 
 template <>
 DoFHandler<3>::active_face_iterator
 DoFHandler<3>::begin_active_face (const unsigned int level) const {
   return begin_active_quad (level);
-};
+}
 
 
 template <>
 DoFHandler<3>::raw_face_iterator
 DoFHandler<3>::end_face () const {
   return end_quad ();
-};
+}
 
 
 template <>
 DoFHandler<3>::raw_face_iterator
 DoFHandler<3>::last_raw_face () const {
   return last_raw_quad ();
-};
+}
 
 
 template <>
 DoFHandler<3>::raw_face_iterator
 DoFHandler<3>::last_raw_face (const unsigned int level) const {
   return last_raw_quad (level);
-};
+}
 
 
 template <>
 DoFHandler<3>::face_iterator
 DoFHandler<3>::last_face () const {
   return last_quad ();
-};
+}
 
 
 template <>
 DoFHandler<3>::face_iterator
 DoFHandler<3>::last_face (const unsigned int level) const {
   return last_quad (level);
-};
+}
 
 
 template <>
 DoFHandler<3>::active_face_iterator
 DoFHandler<3>::last_active_face () const {
   return last_active_quad ();
-};
+}
 
 
 template <>
 DoFHandler<3>::active_face_iterator
 DoFHandler<3>::last_active_face (const unsigned int level) const {
   return last_active_quad (level);
-};
+}
 
 
 #endif
@@ -746,7 +746,7 @@ DoFHandler<dim>::begin_raw_line (const unsigned int level) const {
                            tria->begin_raw_line(level)->level(),
                            tria->begin_raw_line(level)->index(),
                            this);
-};
+}
 
 
 template <int dim>
@@ -756,7 +756,7 @@ DoFHandler<dim>::begin_line (const unsigned int level) const {
                        tria->begin_line(level)->level(),
                        tria->begin_line(level)->index(),
                        this);
-};
+}
 
 
 template <int dim>
@@ -766,7 +766,7 @@ DoFHandler<dim>::begin_active_line (const unsigned int level) const {
                               tria->begin_active_line(level)->level(),
                               tria->begin_active_line(level)->index(),
                               this);
-};
+}
 
 
 template <int dim>
@@ -776,7 +776,7 @@ DoFHandler<dim>::begin_raw_quad (const unsigned int level) const {
                            tria->begin_raw_quad(level)->level(),
                            tria->begin_raw_quad(level)->index(),
                            this);
-};
+}
 
 
 template <int dim>
@@ -786,7 +786,7 @@ DoFHandler<dim>::begin_quad (const unsigned int level) const {
                        tria->begin_quad(level)->level(),
                        tria->begin_quad(level)->index(),
                        this);
-};
+}
 
 
 template <int dim>
@@ -796,7 +796,7 @@ DoFHandler<dim>::begin_active_quad (const unsigned int level) const {
                               tria->begin_active_quad(level)->level(),
                               tria->begin_active_quad(level)->index(),
                               this);
-};
+}
 
 
 template <int dim>
@@ -806,7 +806,7 @@ DoFHandler<dim>::begin_raw_hex (const unsigned int level) const {
                           tria->begin_raw_hex(level)->level(),
                           tria->begin_raw_hex(level)->index(),
                           this);
-};
+}
 
 
 template <int dim>
@@ -816,7 +816,7 @@ DoFHandler<dim>::begin_hex (const unsigned int level) const {
                       tria->begin_hex(level)->level(),
                       tria->begin_hex(level)->index(),
                       this);
-};
+}
 
 
 template <int dim>
@@ -826,28 +826,28 @@ DoFHandler<dim>::begin_active_hex (const unsigned int level) const {
                              tria->begin_active_hex(level)->level(),
                              tria->begin_active_hex(level)->index(),
                              this);
-};
+}
 
 
 template <int dim>
 typename DoFHandler<dim>::raw_line_iterator
 DoFHandler<dim>::end_line () const {
   return raw_line_iterator (tria, -1, -1, this);
-};
+}
 
 
 template <int dim>
 typename DoFHandler<dim>::raw_quad_iterator
 DoFHandler<dim>::end_quad () const {
   return raw_quad_iterator (tria, -1, -1, this);
-};
+}
 
 
 template <int dim>
 typename DoFHandler<dim>::raw_hex_iterator
 DoFHandler<dim>::end_hex () const {
   return raw_hex_iterator (tria, -1, -1, this);
-};
+}
 
 
 template <int dim>
@@ -856,7 +856,7 @@ DoFHandler<dim>::end_raw (const unsigned int level) const {
   return (level == levels.size()-1 ?
          end() :
          begin_raw (level+1));
-};
+}
 
 
 template <int dim>
@@ -865,7 +865,7 @@ DoFHandler<dim>::end (const unsigned int level) const {
   return (level == levels.size()-1 ?
          cell_iterator(end()) :
          begin (level+1));
-};
+}
 
 
 template <int dim>
@@ -874,7 +874,7 @@ DoFHandler<dim>::end_active (const unsigned int level) const {
   return (level == levels.size()-1 ?
          active_cell_iterator(end()) :
          begin_active (level+1));
-};
+}
 
 
 template <int dim>
@@ -883,7 +883,7 @@ DoFHandler<dim>::end_raw_face (const unsigned int level) const {
   return (level == levels.size()-1 ?
          end_face() :
          begin_raw_face (level+1));
-};
+}
 
 
 template <int dim>
@@ -892,7 +892,7 @@ DoFHandler<dim>::end_face (const unsigned int level) const {
   return (level == levels.size()-1 ?
          face_iterator(end_face()) :
          begin_face (level+1));
-};
+}
 
 
 template <int dim>
@@ -901,7 +901,7 @@ DoFHandler<dim>::end_active_face (const unsigned int level) const {
   return (level == levels.size()-1 ?
          active_face_iterator(end_face()) :
          begin_active_face (level+1));
-};
+}
 
 
 template <int dim>
@@ -910,7 +910,7 @@ DoFHandler<dim>::end_raw_line (const unsigned int level) const {
   return (level == levels.size()-1 ?
          end_line() :
          begin_raw_line (level+1));
-};
+}
 
 
 template <int dim>
@@ -919,7 +919,7 @@ DoFHandler<dim>::end_line (const unsigned int level) const {
   return (level == levels.size()-1 ?
          line_iterator(end_line()) :
          begin_line (level+1));
-};
+}
 
 
 template <int dim>
@@ -928,7 +928,7 @@ DoFHandler<dim>::end_active_line (const unsigned int level) const {
   return (level == levels.size()-1 ?
          active_line_iterator(end_line()) :
          begin_active_line (level+1));
-};
+}
 
 
 template <int dim>
@@ -937,7 +937,7 @@ DoFHandler<dim>::end_raw_quad (const unsigned int level) const {
   return (level == levels.size()-1 ?
          end_quad() :
          begin_raw_quad (level+1));
-};
+}
 
 
 template <int dim>
@@ -946,7 +946,7 @@ DoFHandler<dim>::end_quad (const unsigned int level) const {
   return (level == levels.size()-1 ?
          quad_iterator(end_quad()) :
          begin_quad (level+1));
-};
+}
 
 
 template <int dim>
@@ -955,7 +955,7 @@ DoFHandler<dim>::end_active_quad (const unsigned int level) const {
   return (level == levels.size()-1 ?
          active_quad_iterator(end_quad()) :
          begin_active_quad (level+1));
-};
+}
 
 
 template <int dim>
@@ -964,7 +964,7 @@ DoFHandler<dim>::end_raw_hex (const unsigned int level) const {
   return (level == levels.size()-1 ?
          end_hex() :
          begin_raw_hex (level+1));
-};
+}
 
 
 template <int dim>
@@ -973,7 +973,7 @@ DoFHandler<dim>::end_hex (const unsigned int level) const {
   return (level == levels.size()-1 ?
          hex_iterator(end_hex()) :
          begin_hex (level+1));
-};
+}
 
 
 template <int dim>
@@ -982,7 +982,7 @@ DoFHandler<dim>::end_active_hex (const unsigned int level) const {
   return (level == levels.size()-1 ?
          active_hex_iterator(end_hex()) :
          begin_active_hex (level+1));
-};
+}
 
 
 template <int dim>
@@ -992,7 +992,7 @@ DoFHandler<dim>::last_raw_line (const unsigned int level) const {
                            tria->last_raw_line(level)->level(),
                            tria->last_raw_line(level)->index(),
                            this);
-};
+}
 
 
 template <int dim>
@@ -1002,7 +1002,7 @@ DoFHandler<dim>::last_line (const unsigned int level) const {
                        tria->last_line(level)->level(),
                        tria->last_line(level)->index(),
                        this);
-};
+}
 
 
 template <int dim>
@@ -1012,7 +1012,7 @@ DoFHandler<dim>::last_active_line (const unsigned int level) const {
                               tria->last_active_line(level)->level(),
                               tria->last_active_line(level)->index(),
                               this);
-};
+}
 
 
 template <int dim>
@@ -1022,7 +1022,7 @@ DoFHandler<dim>::last_raw_quad (const unsigned int level) const {
                            tria->last_raw_quad(level)->level(),
                            tria->last_raw_quad(level)->index(),
                            this);
-};
+}
 
 
 template <int dim>
@@ -1032,7 +1032,7 @@ DoFHandler<dim>::last_quad (const unsigned int level) const {
                        tria->last_quad(level)->level(),
                        tria->last_quad(level)->index(),
                        this);
-};
+}
 
 
 template <int dim>
@@ -1042,7 +1042,7 @@ DoFHandler<dim>::last_active_quad (const unsigned int level) const {
                               tria->last_active_quad(level)->level(),
                               tria->last_active_quad(level)->index(),
                               this);
-};
+}
 
 
 template <int dim>
@@ -1052,7 +1052,7 @@ DoFHandler<dim>::last_raw_hex (const unsigned int level) const {
                           tria->last_raw_hex(level)->level(),
                           tria->last_raw_hex(level)->index(),
                           this);
-};
+}
 
 
 template <int dim>
@@ -1062,7 +1062,7 @@ DoFHandler<dim>::last_hex (const unsigned int level) const {
                       tria->last_hex(level)->level(),
                       tria->last_hex(level)->index(),
                       this);
-};
+}
 
 
 template <int dim>
@@ -1072,70 +1072,70 @@ DoFHandler<dim>::last_active_hex (const unsigned int level) const {
                              tria->last_active_hex(level)->level(),
                              tria->last_active_hex(level)->index(),
                              this);
-};
+}
 
 
 template <int dim>
 typename DoFHandler<dim>::raw_line_iterator
 DoFHandler<dim>::last_raw_line () const {
   return last_raw_line (levels.size()-1);
-};
+}
 
 
 template <int dim>
 typename DoFHandler<dim>::raw_quad_iterator
 DoFHandler<dim>::last_raw_quad () const {
   return last_raw_quad (levels.size()-1);
-};
+}
 
 
 template <int dim>
 typename DoFHandler<dim>::raw_hex_iterator
 DoFHandler<dim>::last_raw_hex () const {
   return last_raw_hex (levels.size()-1);
-};
+}
 
 
 template <int dim>
 typename DoFHandler<dim>::line_iterator
 DoFHandler<dim>::last_line () const {
   return last_line (levels.size()-1);
-};
+}
 
 
 template <int dim>
 typename DoFHandler<dim>::quad_iterator
 DoFHandler<dim>::last_quad () const {
   return last_quad (levels.size()-1);
-};
+}
 
 
 template <int dim>
 typename DoFHandler<dim>::hex_iterator
 DoFHandler<dim>::last_hex () const {
   return last_hex (levels.size()-1);
-};
+}
 
 
 template <int dim>
 typename DoFHandler<dim>::active_line_iterator
 DoFHandler<dim>::last_active_line () const {
   return last_active_line (levels.size()-1);
-};
+}
 
 
 template <int dim>
 typename DoFHandler<dim>::active_quad_iterator
 DoFHandler<dim>::last_active_quad () const {
   return last_active_quad (levels.size()-1);
-};
+}
 
 
 template <int dim>
 typename DoFHandler<dim>::active_hex_iterator
 DoFHandler<dim>::last_active_hex () const {
   return last_active_hex (levels.size()-1);
-};
+}
 
 
 //------------------------------------------------------------------
@@ -1148,7 +1148,7 @@ unsigned int DoFHandler<1>::n_boundary_dofs () const
 {
   Assert (selected_fe != 0, ExcNoFESelected());
   return 2*selected_fe->dofs_per_vertex;
-};
+}
 
 
 
@@ -1166,7 +1166,7 @@ unsigned int DoFHandler<1>::n_boundary_dofs (const FunctionMap &boundary_indicat
            ExcInvalidBoundaryIndicator());
 
   return boundary_indicators.size()*selected_fe->dofs_per_vertex;
-};
+}
 
 
 
@@ -1184,7 +1184,7 @@ unsigned int DoFHandler<1>::n_boundary_dofs (const std::set<unsigned char> &boun
            ExcInvalidBoundaryIndicator());
 
   return boundary_indicators.size()*selected_fe->dofs_per_vertex;
-};
+}
 
 #endif
 
@@ -1219,7 +1219,7 @@ unsigned int DoFHandler<dim>::n_boundary_dofs () const
          boundary_dofs.insert(dofs_on_face[i]);
       };
   return boundary_dofs.size();
-};    
+}
 
 
 
@@ -1246,7 +1246,7 @@ DoFHandler<dim>::n_boundary_dofs (const FunctionMap &boundary_indicators) const
          boundary_dofs.insert(dofs_on_face[i]);
       };
   return boundary_dofs.size();
-};    
+}
 
 
 
@@ -1275,7 +1275,7 @@ DoFHandler<dim>::n_boundary_dofs (const std::set<unsigned char> &boundary_indica
          boundary_dofs.insert(dofs_on_face[i]);
       };
   return boundary_dofs.size();
-};    
+}
 
 
 
@@ -1283,7 +1283,7 @@ template <int dim>
 const Triangulation<dim> & DoFHandler<dim>::get_tria () const
 {
   return *tria;
-};
+}
 
 
 
@@ -1301,7 +1301,7 @@ DoFHandler<dim>::memory_consumption () const
     mem += MemoryConsumption::memory_consumption (*levels[i]);
   
   return mem;
-};
+}
 
 
 
@@ -1338,7 +1338,7 @@ void DoFHandler<dim>::distribute_dofs (const FiniteElement<dim> &ff,
 
                                   // finally restore the user flags
   const_cast<Triangulation<dim> &>(*tria).load_user_flags(user_flags);
-};
+}
 
 
 template <int dim>
@@ -1348,7 +1348,7 @@ void DoFHandler<dim>::clear () {
 
                                   // release memory
   clear_space ();
-};
+}
 
 
 #if deal_II_dimension == 1
@@ -1400,7 +1400,7 @@ unsigned int DoFHandler<1>::distribute_dofs_on_cell (active_cell_iterator &cell,
   cell->set_user_flag ();
   
   return next_free_dof;
-};
+}
 
 #endif
 
@@ -1446,7 +1446,7 @@ unsigned int DoFHandler<2>::distribute_dofs_on_cell (active_cell_iterator &cell,
   cell->set_user_flag ();
   
   return next_free_dof;
-};
+}
 
 #endif
 
@@ -1507,7 +1507,7 @@ unsigned int DoFHandler<3>::distribute_dofs_on_cell (active_cell_iterator &cell,
   cell->set_user_flag ();
   
   return next_free_dof;
-};
+}
 
 #endif
 
@@ -1555,7 +1555,7 @@ void DoFHandler<1>::renumber_dofs (const std::vector<unsigned int> &new_numbers)
         i!=levels[level]->line_dofs.end(); ++i)
       if (*i != invalid_dof_index)
        *i = new_numbers[*i];
-};
+}
 
 #endif
 
@@ -1609,7 +1609,7 @@ void DoFHandler<2>::renumber_dofs (const std::vector<unsigned int> &new_numbers)
        if (*i != invalid_dof_index)
          *i = new_numbers[*i];
     };
-};
+}
 
 #endif
 
@@ -1667,7 +1667,7 @@ void DoFHandler<3>::renumber_dofs (const std::vector<unsigned int> &new_numbers)
        if (*i != invalid_dof_index)
          *i = new_numbers[*i];
     };
-};
+}
 
 #endif
 
@@ -1680,7 +1680,7 @@ unsigned int DoFHandler<1>::max_couplings_between_dofs () const
   Assert (selected_fe != 0, ExcNoFESelected());
   return std::min(3*selected_fe->dofs_per_vertex +
                  2*selected_fe->dofs_per_line, n_dofs());
-};
+}
 
 
 
@@ -1689,7 +1689,7 @@ unsigned int DoFHandler<1>::max_couplings_between_boundary_dofs () const
 {
   Assert (selected_fe != 0, ExcNoFESelected());
   return selected_fe->dofs_per_vertex;
-};
+}
 
 #endif
 
@@ -1755,7 +1755,7 @@ unsigned int DoFHandler<2>::max_couplings_between_dofs () const
            max_couplings=0;
     };
   return std::min(max_couplings,n_dofs());
-};
+}
 
 
 
@@ -1764,7 +1764,7 @@ unsigned int DoFHandler<2>::max_couplings_between_boundary_dofs () const
 {
   Assert (selected_fe != 0, ExcNoFESelected());
   return 3*selected_fe->dofs_per_vertex + 2*selected_fe->dofs_per_line;
-};
+}
 
 #endif
 
@@ -1801,7 +1801,7 @@ unsigned int DoFHandler<3>::max_couplings_between_dofs () const
     }
   
   return std::min(max_couplings,n_dofs());
-};
+}
 
 
 template <>
@@ -1823,7 +1823,7 @@ unsigned int DoFHandler<3>::max_couplings_between_boundary_dofs () const {
   return (19*selected_fe->dofs_per_vertex +
          28*selected_fe->dofs_per_line +
          8*selected_fe->dofs_per_quad);
-};
+}
 
 
 #endif
@@ -1854,7 +1854,7 @@ void DoFHandler<1>::reserve_space () {
                                                           selected_fe->dofs_per_line,
                                                           invalid_dof_index);
     };
-};
+}
 
 
 #endif
@@ -1887,7 +1887,7 @@ void DoFHandler<2>::reserve_space () {
                                                            selected_fe->dofs_per_quad,
                                                            invalid_dof_index);
     };
-};
+}
 
 #endif
 
@@ -1922,7 +1922,7 @@ void DoFHandler<3>::reserve_space () {
                                                           selected_fe->dofs_per_hex,
                                                           invalid_dof_index);
     };
-};
+}
 
 #endif
 
@@ -1935,7 +1935,7 @@ void DoFHandler<dim>::clear_space () {
 
   std::vector<unsigned int> tmp;
   std::swap (vertex_dofs, tmp);
-};
+}
 
 
 /*-------------- Explicit Instantiations -------------------------------*/
index dd863d99efdc5916681cfff5af87a4e8ee9df7d4..24075c861e3a34257d5a5efae15216f582fe89aa 100644 (file)
@@ -20,7 +20,7 @@ unsigned int
 DoFLevel<1>::memory_consumption () const
 {
   return MemoryConsumption::memory_consumption (line_dofs);
-};
+}
 
 
 
@@ -29,7 +29,7 @@ DoFLevel<2>::memory_consumption () const
 {
   return (DoFLevel<1>::memory_consumption () +
          MemoryConsumption::memory_consumption (quad_dofs));
-};
+}
 
 
 
@@ -38,4 +38,4 @@ DoFLevel<3>::memory_consumption () const
 {
   return (DoFLevel<2>::memory_consumption () +
          MemoryConsumption::memory_consumption (hex_dofs));
-};
+}
index 33b179ac3f00a4ca3752dcccc3feed7a465c9b5d..64c0b6894dfcddf833450f6a123c35dbbe63302a 100644 (file)
@@ -263,7 +263,7 @@ void DoFRenumbering::Cuthill_McKee (DoFHandler<dim>                 &dof_handler
                                   // this is dimension specific and
                                   // thus needs an own function
   dof_handler.renumber_dofs (new_number);
-};
+}
 
 
 #ifdef ENABLE_MULTIGRID
@@ -430,7 +430,7 @@ void DoFRenumbering::Cuthill_McKee (MGDoFHandler<dim>               &dof_handler
                                   // this is dimension specific and
                                   // thus needs an own function
   dof_handler.renumber_dofs (level, new_number);
-};
+}
 #endif
 
 
@@ -582,7 +582,7 @@ DoFRenumbering::component_wise (DoFHandler<dim>                 &dof_handler,
          ExcInternalError());
 
   dof_handler.renumber_dofs (new_indices);
-};
+}
 
 
 
@@ -733,7 +733,7 @@ void DoFRenumbering::component_wise (MGDoFHandler<dim>& dof_handler,
           ExcInternalError());
 
   dof_handler.renumber_dofs (level, new_indices);
-};
+}
 
 
 
@@ -771,7 +771,7 @@ DoFRenumbering::sort_selected_dofs_back (DoFHandler<dim>         &dof_handler,
 
                                   // now perform the renumbering
   dof_handler.renumber_dofs (new_dof_indices);
-};
+}
 
 
 template <int dim>
@@ -965,7 +965,7 @@ DoFRenumbering::random (DoFHandler<dim> &dof_handler)
   
   std::random_shuffle (new_indices.begin(), new_indices.end());
   dof_handler.renumber_dofs(new_indices);  
-};
+}
 
 
 
index 5218840a62d814d16a29cd384eb46747a5abdc44..c1acf625831c88c19b9020ad1dc282a35c7eaf6a 100644 (file)
@@ -163,7 +163,7 @@ DoFTools::make_boundary_sparsity_pattern (const DoFHandler<1>             &dof_h
          sparsity.add (boundary_dof_boundary_indices[i],
                        boundary_dof_boundary_indices[j]);
     };
-};
+}
 
 
 
@@ -181,7 +181,7 @@ void DoFTools::make_boundary_sparsity_pattern (const DoFHandler<1> &dof_handler,
   boundary_indicators[1] = 0;
   make_boundary_sparsity_pattern (dof_handler, boundary_indicators,
                                  dof_to_boundary_mapping, sparsity);
-};
+}
 
 
 #endif
@@ -240,7 +240,7 @@ DoFTools::make_boundary_sparsity_pattern (const DoFHandler<dim>& dof,
            sparsity.add (dof_to_boundary_mapping[dofs_on_this_face[i]],
                          dof_to_boundary_mapping[dofs_on_this_face[j]]);
       };
-};
+}
 
 
 
@@ -254,7 +254,7 @@ void DoFTools::make_boundary_sparsity_pattern (const DoFHandler<dim>& dof,
 
   Assert (dof_to_boundary_mapping.size() == n_dofs, ExcInternalError());
   Assert (boundary_indicators.find(255) == boundary_indicators.end(),
-         DoFHandler<dim>::ExcInvalidBoundaryIndicator());
+         typename DoFHandler<dim>::ExcInvalidBoundaryIndicator());
   Assert (sparsity.n_rows() == dof.n_boundary_dofs(boundary_indicators),
          ExcDimensionMismatch (sparsity.n_rows(), dof.n_boundary_dofs(boundary_indicators)));
   Assert (sparsity.n_cols() == dof.n_boundary_dofs(boundary_indicators),
@@ -289,7 +289,7 @@ void DoFTools::make_boundary_sparsity_pattern (const DoFHandler<dim>& dof,
            sparsity.add (dof_to_boundary_mapping[dofs_on_this_face[i]],
                          dof_to_boundary_mapping[dofs_on_this_face[j]]);
       };
-};
+}
 
 
 
@@ -443,7 +443,7 @@ DoFTools::make_flux_sparsity_pattern (const DoFHandler<1> &dof,
                sparsity.add (local_dof_indices[i], neighbor_dof_indices[j]);
          };
     };
-};
+}
 
 
 #endif
@@ -734,7 +734,7 @@ void DoFTools::make_hanging_node_constraints (const DoFHandler<1> &,
                                              ConstraintMatrix &)
 {
                                   // nothing to be done here
-};
+}
 
 #endif
 
@@ -821,7 +821,7 @@ void DoFTools::make_hanging_node_constraints (const DoFHandler<2> &dof_handler,
                                       fe.constraints()(row,i));
            };
        };
-};
+}
 
 #endif
 
@@ -962,7 +962,7 @@ void DoFTools::make_hanging_node_constraints (const DoFHandler<3> &dof_handler,
                                       fe.constraints()(row,i));
            };
        };
-};
+}
 
 #endif
 
@@ -1036,7 +1036,7 @@ void DoFTools::distribute_cell_to_dof_vector (const DoFHandler<dim> &dof_handler
       if (touch_count[i] != 0)
        dof_data(i) /=  touch_count[i];
     };
-};
+}
 
 
 template<int dim>
@@ -1301,7 +1301,7 @@ DoFTools::extract_boundary_dofs (const DoFHandler<dim>         &dof_handler,
                    == true))
                selected_dofs[face_dof_indices[i]] = true;
          };
-};
+}
 
 
 #else
@@ -1366,7 +1366,7 @@ DoFTools::extract_boundary_dofs (const DoFHandler<1>      &dof_handler,
                                   face_system_to_component_index(i).first] == true))
              selected_dofs[cell->vertex_dof_index(1,i)] = true;
     };
-};
+}
 
 
 #endif
@@ -1385,7 +1385,7 @@ DoFTools::extract_hanging_node_dofs (const DoFHandler<1> &dof_handler,
   std::fill_n (selected_dofs.begin(), dof_handler.n_dofs(), false);
 
                                   // there are no hanging nodes in 1d
-};
+}
 
 #endif
 
@@ -1423,7 +1423,7 @@ DoFTools::extract_hanging_node_dofs (const DoFHandler<2> &dof_handler,
            for (unsigned int dof=0; dof!=fe.dofs_per_line; ++dof)
              selected_dofs[line->child(child)->dof_index(dof)] = true;
        };
-};
+}
 
 #endif
 
@@ -1490,7 +1490,7 @@ DoFTools::extract_hanging_node_dofs (const DoFHandler<3> &dof_handler,
            for (unsigned int dof=0; dof!=fe.dofs_per_quad; ++dof)
              selected_dofs[face->child(child)->dof_index(dof)] = true;
        };
-};
+}
 
 #endif
 
@@ -1524,7 +1524,7 @@ DoFTools::extract_subdomain_dofs (const DoFHandler<dim> &dof_handler,
        for (unsigned int i=0; i<dofs_per_cell; ++i)
          selected_dofs[local_dof_indices[i]] = true;
       };
-};
+}
 
 
 
@@ -1588,7 +1588,7 @@ count_dofs_per_component (const DoFHandler<dim>     &dof_handler,
            == dof_handler.n_dofs()),
          ExcInternalError());
          
-};
+}
 
 
 
@@ -1806,7 +1806,7 @@ DoFTools::compute_intergrid_constraints (const DoFHandler<dim>              &coa
        
        constraints.add_entries (global_dof, constraint_line);
       };
-};
+}
 
 
 
@@ -1916,7 +1916,7 @@ compute_intergrid_transfer_representation (const DoFHandler<dim>              &c
          transfer_representation[p][i] = j->second;
        };
     };
-};
+}
 
 
 
@@ -2151,7 +2151,7 @@ DoFTools::compute_intergrid_weights_1 (const DoFHandler<dim>              &coars
 
   
   return n_parameters_on_fine_grid;
-};
+}
 
 
 
@@ -2194,7 +2194,7 @@ DoFTools::compute_intergrid_weights_2 (const DoFHandler<dim>              &coars
 
                                   // wait for the threads to finish
   thread_manager.wait ();
-};
+}
 
 
 
@@ -2380,7 +2380,7 @@ DoFTools::compute_intergrid_weights_3 (const DoFHandler<dim>              &coars
            mutex.release ();
          };
     };
-};
+}
 
 
 
@@ -2424,7 +2424,7 @@ void DoFTools::map_dof_to_boundary_indices (const DoFHandler<1> &dof_handler,
       for (unsigned int i=0; i<dof_handler.get_fe().dofs_per_vertex; ++i)
        mapping[cell->vertex_dof_index(direction,i)] = next_free_index++;
     };
-};
+}
 
 
 
@@ -2441,7 +2441,7 @@ void DoFTools::map_dof_to_boundary_indices (const DoFHandler<1> &dof_handler,
   boundary_indicators.insert (0U);
   boundary_indicators.insert (1U);
   map_dof_to_boundary_indices (dof_handler, boundary_indicators, mapping);
-};
+}
 
 #else
 
@@ -2486,7 +2486,7 @@ void DoFTools::map_dof_to_boundary_indices (const DoFHandler<dim>     &dof_handl
 
   Assert (next_boundary_index == dof_handler.n_boundary_dofs(),
          ExcInternalError());
-};
+}
 
 
 
@@ -2525,7 +2525,7 @@ void DoFTools::map_dof_to_boundary_indices (const DoFHandler<dim>         &dof_h
 
   Assert (next_boundary_index == dof_handler.n_boundary_dofs(boundary_indicators),
          ExcInternalError());
-};
+}
 
 #endif
 
@@ -2575,7 +2575,7 @@ DoFTools::map_dofs_to_support_points (const Mapping<dim>       &mapping,
       for (unsigned int i=0; i<dofs_per_cell; ++i)
        support_points[local_dof_indices[i]] = points[i];
     };
-};
+}
 
 
 
index 366f43d06daa505f7fa1c68765e5172e7b4018c2..3c4bf2c7b54d22debe54e92f8d3c2c90957f8343 100644 (file)
@@ -169,7 +169,7 @@ FiniteElementBase (const FiniteElementData<dim> &fe_data,
       face_system_to_component_table[j] = std::pair<unsigned,unsigned>(0,j);
       face_system_to_base_table[j] = std::make_pair(std::make_pair(0U,0U),j);      
     }
-};
+}
 
 
 template <int dim>
@@ -248,7 +248,7 @@ FiniteElementBase<dim>::restrict (const unsigned int child) const
          ExcIndexRange(child, 0, GeometryInfo<dim>::children_per_cell));
   Assert (restriction[child].n() != 0, ExcProjectionVoid());
   return restriction[child];
-};
+}
 
 
 
@@ -260,7 +260,7 @@ FiniteElementBase<dim>::prolongate (const unsigned int child) const
          ExcIndexRange(child, 0, GeometryInfo<dim>::children_per_cell));
   Assert (prolongation[child].n() != 0, ExcEmbeddingVoid());
   return prolongation[child];
-};
+}
 
 
 
@@ -277,7 +277,7 @@ FiniteElementBase<dim>::constraints () const
                                        interface_constraints.n()));
   
   return interface_constraints;
-};
+}
 
 
 
@@ -303,7 +303,7 @@ FiniteElementBase<dim>::interface_constraints_size () const
     };
   return TableIndices<2> (static_cast<unsigned int>(-1),
                           static_cast<unsigned int>(-1));
-};
+}
 
                                    
 
@@ -314,7 +314,7 @@ bool FiniteElementBase<dim>::operator == (const FiniteElementBase<dim> &f) const
   return ((static_cast<const FiniteElementData<dim>&>(*this) ==
           static_cast<const FiniteElementData<dim>&>(f)) &&
          (interface_constraints == f.interface_constraints));
-};
+}
 
 
 
@@ -330,7 +330,7 @@ FiniteElementBase<dim>::get_unit_support_points () const
          (unit_support_points.size() == this->dofs_per_cell),
          ExcInternalError());
   return unit_support_points;
-};
+}
 
 
 
@@ -339,7 +339,7 @@ bool
 FiniteElementBase<dim>::has_support_points () const
 {
   return (unit_support_points.size() != 0);
-};
+}
 
 
 
@@ -352,7 +352,7 @@ FiniteElementBase<dim>::unit_support_point (const unsigned index) const
   Assert (unit_support_points.size() == this->dofs_per_cell,
           ExcFEHasNoSupportPoints ());
   return unit_support_points[index];
-};
+}
 
 
 
@@ -368,7 +368,7 @@ FiniteElementBase<dim>::get_unit_face_support_points () const
          (unit_face_support_points.size() == this->dofs_per_face),
          ExcInternalError());
   return unit_face_support_points;
-};
+}
 
 
 
@@ -377,7 +377,7 @@ bool
 FiniteElementBase<dim>::has_face_support_points () const
 {
   return (unit_face_support_points.size() != 0);
-};
+}
 
 
 
@@ -390,7 +390,7 @@ FiniteElementBase<dim>::unit_face_support_point (const unsigned index) const
   Assert (unit_face_support_points.size() == this->dofs_per_face,
           ExcFEHasNoSupportPoints ());
   return unit_face_support_points[index];
-};
+}
 
 
 
@@ -414,7 +414,7 @@ FiniteElementBase<dim>::memory_consumption () const
          MemoryConsumption::memory_consumption (restriction_is_additive_flags) +
          MemoryConsumption::memory_consumption (nonzero_components) +
          MemoryConsumption::memory_consumption (n_nonzero_components_table));
-};
+}
 
 
 
@@ -552,7 +552,7 @@ compute_n_nonzero_components (const std::vector<std::vector<bool> > &nonzero_com
                            nonzero_components[i].end(),
                            true);
   return retval;
-};
+}
 
 
 
index 3c6151ee7603b54429be4d9f6d340dac72efe8b7..d8e065e7c99287ca0c0bf21fc83dd90ffd36d08a 100644 (file)
@@ -48,7 +48,7 @@ FiniteElementData<dim>::FiniteElementData (const std::vector<unsigned int> &dofs
                components(n_components)
 {
   Assert(dofs_per_object.size()==dim+1, ExcDimensionMismatch(dofs_per_object.size()-1,dim));
-};
+}
 
 
 
@@ -60,7 +60,7 @@ bool FiniteElementData<dim>::operator== (const FiniteElementData<dim> &f) const
          (dofs_per_quad == f.dofs_per_quad) &&
          (dofs_per_hex == f.dofs_per_hex) &&
          (components == f.components));
-};
+}
 
 
 template class FiniteElementData<1>;
index aec8650d6c7ea2348e0a040a153cfaf7d0574fcd..29f7936c158a84aadfa712842256f4ea0372f041 100644 (file)
@@ -69,7 +69,7 @@ FE_DGP<dim>::FE_DGP (const unsigned int degree)
                                    // elements have neither support
                                    // nor face-support points, so
                                    // leave these fields empty
-};
+}
 
 
 
@@ -424,7 +424,7 @@ unsigned int
 FE_DGP<dim>::n_base_elements () const
 {
   return 1;
-};
+}
 
 
 
@@ -434,7 +434,7 @@ FE_DGP<dim>::base_element (const unsigned int index) const
 {
   Assert (index==0, ExcIndexRange(index, 0, 1));
   return *this;
-};
+}
 
 
 
@@ -444,7 +444,7 @@ FE_DGP<dim>::element_multiplicity (const unsigned int index) const
 {
   Assert (index==0, ExcIndexRange(index, 0, 1));
   return 1;
-};
+}
 
 
 
@@ -473,7 +473,7 @@ unsigned int
 FE_DGP<dim>::get_degree () const
 {
   return degree;
-};
+}
 
 
 
index 1a9b149e42fb740618fc1559e350b73974efdb07..65aaee510271d4c0d852ae326f57e88c5d534747 100644 (file)
@@ -134,7 +134,7 @@ namespace FE_DGP_1d
        0, 0, 0, 0, 0, 1./32., 5.044891251/27.,
        0, 0, 0, 0, 0., 0., 1./64.,
   };
-};
+}
 
 
 template <>
@@ -172,5 +172,5 @@ const unsigned int FE_DGP<1>::Matrices::n_projection_matrices
 #else // #if deal_II_dimension
 // On gcc2.95 on Alpha OSF1, the native assembler does not like empty
 // files, so provide some dummy code
-namespace { void dummy () {}; };
+namespace { void dummy () {} }
 #endif // #if deal_II_dimension
index ce457e86c13a99e860b48dd3815725f31e73f308..1c1cc46f00fbd52c420e7b9556a2a3a035f1b805 100644 (file)
@@ -470,7 +470,7 @@ namespace FE_DGP_2d
        0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 1./64., 0,
        0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0., 0., 0, 0., 0., 1./64.,
   };
-};
+}
 
 
 template <>
@@ -529,5 +529,5 @@ const unsigned int FE_DGP<2>::Matrices::n_projection_matrices
 #else // #if deal_II_dimension
 // On gcc2.95 on Alpha OSF1, the native assembler does not like empty
 // files, so provide some dummy code
-namespace { void dummy () {}; };
+namespace { void dummy () {} }
 #endif // #if deal_II_dimension == 2
index 80535d21d0f0a36cbbb84223decf3de83286f735..c15f1a22cd685fdb9edf26af9b4b32b2131ec49d 100644 (file)
@@ -742,7 +742,7 @@ namespace FE_DGP_3d
        0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 1./16., 0,
        0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 1./16.,
   };
-};
+}
 
 
 template <>
@@ -814,5 +814,5 @@ const unsigned int FE_DGP<3>::Matrices::n_projection_matrices
 #else // #if deal_II_dimension
 // On gcc2.95 on Alpha OSF1, the native assembler does not like empty
 // files, so provide some dummy code
-namespace { void dummy () {}; };
+namespace { void dummy () {} }
 #endif // #if deal_II_dimension
index debf89db4017b5602c3072fe388f4c4c4c19ad22..480b8f777d5a06168ff5ba94f1663cc9be6eecaa 100644 (file)
@@ -72,7 +72,7 @@ FE_DGPNonparametric<dim>::FE_DGPNonparametric (const unsigned int degree)
                                    // elements have neither support
                                    // nor face-support points, so
                                    // leave these fields empty
-};
+}
 
 
 
@@ -378,7 +378,7 @@ unsigned int
 FE_DGPNonparametric<dim>::n_base_elements () const
 {
   return 1;
-};
+}
 
 
 
@@ -388,7 +388,7 @@ FE_DGPNonparametric<dim>::base_element (const unsigned int index) const
 {
   Assert (index==0, ExcIndexRange(index, 0, 1));
   return *this;
-};
+}
 
 
 
@@ -398,7 +398,7 @@ FE_DGPNonparametric<dim>::element_multiplicity (const unsigned int index) const
 {
   Assert (index==0, ExcIndexRange(index, 0, 1));
   return 1;
-};
+}
 
 
 
@@ -427,7 +427,7 @@ unsigned int
 FE_DGPNonparametric<dim>::get_degree () const
 {
   return degree;
-};
+}
 
 
 
index 485604393d4c6c48cf249d49af712e5359bcb7ad..38b01d2d2355ee18aedec2bcec90cff95485c32b 100644 (file)
@@ -205,7 +205,7 @@ FE_DGQ<dim>::FE_DGQ (const unsigned int degree)
 
                                   // note: no face support points for
                                   // DG elements
-};
+}
 
 
 
@@ -639,7 +639,7 @@ unsigned int
 FE_DGQ<dim>::n_base_elements () const
 {
   return 1;
-};
+}
 
 
 
@@ -649,7 +649,7 @@ FE_DGQ<dim>::base_element (const unsigned int index) const
 {
   Assert (index==0, ExcIndexRange(index, 0, 1));
   return *this;
-};
+}
 
 
 
@@ -659,7 +659,7 @@ FE_DGQ<dim>::element_multiplicity (const unsigned int index) const
 {
   Assert (index==0, ExcIndexRange(index, 0, 1));
   return 1;
-};
+}
 
 
 
@@ -751,7 +751,7 @@ unsigned int
 FE_DGQ<dim>::get_degree () const
 {
   return degree;
-};
+}
 
 
 
index e457b9e9ac536207ac7826d26065168feed44c5e..37ecf94bc24045523623defeb1945781c3b577b9 100644 (file)
@@ -126,7 +126,7 @@ namespace FE_DGQ_1d
        -0.012439378, 0.040990099, -0.017439155, -0.050376157, 0.0042995099, 0.054999345, 0.038394855, -0.001831157,
        -0.050934606, 0.18647931, -0.15057292, -0.1043873, -0.016304977, 0.28934245, 0.015028935, -0.031932147,
   };
-};
+}
 
 
 
@@ -174,5 +174,5 @@ const unsigned int FE_DGQ<1>::Matrices::n_projection_matrices
 #else // #if deal_II_dimension
 // On gcc2.95 on Alpha OSF1, the native assembler does not like empty
 // files, so provide some dummy code
-namespace { void dummy () {}; };
+namespace { void dummy () {} }
 #endif // #if deal_II_dimension == 1
index 8d7c7b119bb46354042e60135f31d3cbb613ca4f..dae73d1c54e712e483d8ce3e7e96139f77708799 100644 (file)
@@ -427,7 +427,7 @@ namespace FE_DGQ_2d
        0.00063359485, -0.0020878146, 0.00088825647, 0.0025658897, -0.00021899385, -0.00280137, -0.0019556268, 9.3269261e-05, -0.0023196867, 0.0076438055, -0.0032520415, -0.0093941111, 0.00080176965, 0.01025624, 0.0071598461, -0.00034147289, 0.0018730335, -0.0061719988, 0.0026258644, 0.0075852849, -0.00064738975, -0.0082814118, -0.0057812253, 0.00027572265, 0.0012985131, -0.0042788457, 0.0018204262, 0.0052586309, -0.00044881422, -0.005741233, -0.0040079352, 0.00019114953, 0.00020282378, -0.00066834262, 0.00028434501, 0.00082138208, -7.010341e-05, -0.00089676305, -0.00062602722, 2.9856972e-05, -0.0035992402, 0.011860176, -0.0050458877, -0.014575961, 0.0012440307, 0.015913645, 0.011109261, -0.00052983145, -0.00018695061, 0.00061603754, -0.00026209192, -0.0007571, 6.4617056e-05, 0.00082658159, 0.00057703379, -2.752034e-05, 0.00039721606, -0.0013089019, 0.00055686965, 0.0016086189, -0.00013729258, -0.0017562472, -0.0012260302, 5.8472774e-05,
        0.0025943341, -0.0094982503, 0.0076693723, 0.0053169259, 0.00083048758, -0.014737544, -0.0007654929, 0.0016264513, -0.0094982503, 0.034774534, -0.028078734, -0.019466071, -0.0030405409, 0.05395638, 0.0028025855, -0.0059546848, 0.0076693723, -0.028078734, 0.022672203, 0.0157179, 0.0024550879, -0.043567136, -0.0022629506, 0.0048081165, 0.0053169259, -0.019466071, 0.0157179, 0.010896708, 0.0017020325, -0.030203676, -0.0015688299, 0.0033333105, 0.00083048758, -0.0030405409, 0.0024550879, 0.0017020325, 0.00026585227, -0.0047177219, -0.00024504644, 0.00052065292, -0.014737544, 0.05395638, -0.043567136, -0.030203676, -0.0047177219, 0.083719052, 0.0043485089, -0.0092393256, -0.0007654929, 0.0028025855, -0.0022629506, -0.0015688299, -0.00024504644, 0.0043485089, 0.00022586889, -0.00047990617, 0.0016264513, -0.0059546848, 0.0048081165, 0.0033333105, 0.00052065292, -0.0092393256, -0.00047990617, 0.001019662,
   };
-};
+}
 
 
 template <>
@@ -471,5 +471,5 @@ const unsigned int FE_DGQ<2>::Matrices::n_projection_matrices
 #else // #if deal_II_dimension
 // On gcc2.95 on Alpha OSF1, the native assembler does not like empty
 // files, so provide some dummy code
-namespace { void dummy () {}; };
+namespace { void dummy () {} }
 #endif // #if deal_II_dimension == 2
index 8a9bbfa20128401ed384e3b36a71a5915cf78598..cf54f2bca346108c48ae9ebc24edccbf51466817 100644 (file)
@@ -385,7 +385,7 @@ static const double dgq4_refined_onto_dgq4[] =
  -5.6211513e-05, 0.00027635624, -0.00023302227, -0.00049874943, 1.1242303e-05, 8.9938421e-05, -0.00044216998, 0.00037283564, 0.00079799909, -1.7987684e-05, 0.00013490763, -0.00066325498, 0.00055925346, 0.0011969986, -2.6981526e-05, -0.0002338399, 0.001149642, -0.00096937266, -0.0020747976, 4.6767979e-05, -5.6211513e-05, 0.00027635624, -0.00023302227, -0.00049874943, 1.1242303e-05, 8.9938421e-05, -0.00044216998, 0.00037283564, 0.00079799909, -1.7987684e-05, -0.00014390147, 0.00070747198, -0.00059653702, -0.0012767985, 2.8780295e-05, -0.00021585221, 0.001061208, -0.00089480553, -0.0019151978, 4.3170442e-05, 0.00037414383, -0.0018394271, 0.0015509963, 0.0033196762, -7.4828767e-05, 8.9938421e-05, -0.00044216998, 0.00037283564, 0.00079799909, -1.7987684e-05, 0.00013490763, -0.00066325498, 0.00055925346, 0.0011969986, -2.6981526e-05, -0.00021585221, 0.001061208, -0.00089480553, -0.0019151978, 4.3170442e-05, -0.00032377832, 0.0015918119, -0.0013422083, -0.0028727967, 6.4755663e-05, 0.00056121575, -0.0027591407, 0.0023264944, 0.0049795143, -0.00011224315, 0.00013490763, -0.00066325498, 0.00055925346, 0.0011969986, -2.6981526e-05, -0.0002338399, 0.001149642, -0.00096937266, -0.0020747976, 4.6767979e-05, 0.00037414383, -0.0018394271, 0.0015509963, 0.0033196762, -7.4828767e-05, 0.00056121575, -0.0027591407, 0.0023264944, 0.0049795143, -0.00011224315, -0.00097277397, 0.0047825106, -0.0040325903, -0.0086311581, 0.00019455479, -0.0002338399, 0.001149642, -0.00096937266, -0.0020747976, 4.6767979e-05, -5.6211513e-05, 0.00027635624, -0.00023302227, -0.00049874943, 1.1242303e-05, 8.9938421e-05, -0.00044216998, 0.00037283564, 0.00079799909, -1.7987684e-05, 0.00013490763, -0.00066325498, 0.00055925346, 0.0011969986, -2.6981526e-05, -0.0002338399, 0.001149642, -0.00096937266, -0.0020747976, 4.6767979e-05, -5.6211513e-05, 0.00027635624, -0.00023302227, -0.00049874943, 1.1242303e-05,
  0.00065409761, -0.0010465562, -0.0015698343, 0.0027210461, 0.00065409761, -0.0010465562, 0.0016744899, 0.0025117348, -0.0043536737, -0.0010465562, -0.0015698343, 0.0025117348, 0.0037676022, -0.0065305105, -0.0015698343, 0.0027210461, -0.0043536737, -0.0065305105, 0.011319552, 0.0027210461, 0.00065409761, -0.0010465562, -0.0015698343, 0.0027210461, 0.00065409761, -0.0010465562, 0.0016744899, 0.0025117348, -0.0043536737, -0.0010465562, 0.0016744899, -0.0026791838, -0.0040187757, 0.0069658779, 0.0016744899, 0.0025117348, -0.0040187757, -0.0060281636, 0.010448817, 0.0025117348, -0.0043536737, 0.0069658779, 0.010448817, -0.018111283, -0.0043536737, -0.0010465562, 0.0016744899, 0.0025117348, -0.0043536737, -0.0010465562, -0.0015698343, 0.0025117348, 0.0037676022, -0.0065305105, -0.0015698343, 0.0025117348, -0.0040187757, -0.0060281636, 0.010448817, 0.0025117348, 0.0037676022, -0.0060281636, -0.0090422454, 0.015673225, 0.0037676022, -0.0065305105, 0.010448817, 0.015673225, -0.027166924, -0.0065305105, -0.0015698343, 0.0025117348, 0.0037676022, -0.0065305105, -0.0015698343, 0.0027210461, -0.0043536737, -0.0065305105, 0.011319552, 0.0027210461, -0.0043536737, 0.0069658779, 0.010448817, -0.018111283, -0.0043536737, -0.0065305105, 0.010448817, 0.015673225, -0.027166924, -0.0065305105, 0.011319552, -0.018111283, -0.027166924, 0.047089335, 0.011319552, 0.0027210461, -0.0043536737, -0.0065305105, 0.011319552, 0.0027210461, 0.00065409761, -0.0010465562, -0.0015698343, 0.0027210461, 0.00065409761, -0.0010465562, 0.0016744899, 0.0025117348, -0.0043536737, -0.0010465562, -0.0015698343, 0.0025117348, 0.0037676022, -0.0065305105, -0.0015698343, 0.0027210461, -0.0043536737, -0.0065305105, 0.011319552, 0.0027210461, 0.00065409761, -0.0010465562, -0.0015698343, 0.0027210461, 0.00065409761,
 };
-};
+}
 
 
 template <>
@@ -427,5 +427,5 @@ const unsigned int FE_DGQ<3>::Matrices::n_projection_matrices
 #else // #if deal_II_dimension
 // On gcc2.95 on Alpha OSF1, the native assembler does not like empty
 // files, so provide some dummy code
-namespace { void dummy () {}; };
+namespace { void dummy () {} }
 #endif // #if deal_II_dimension == 3
index 14e7257f2cb8e7c76c08c4eb4bbdb4afa4fb75db..b36881c98c3e86a39689d14d5d36029b432c9991 100644 (file)
@@ -260,7 +260,7 @@ FE_Nedelec<dim>::FE_Nedelec (const unsigned int degree)
   std::vector<std::pair<unsigned,unsigned> > tmp1, tmp2;
   this->system_to_component_table.swap (tmp1);
   this->face_system_to_component_table.swap (tmp2);
-};
+}
 
 
 
@@ -643,7 +643,7 @@ void FE_Nedelec<dim>::initialize_unit_support_points ()
                                             // right now
            Assert (false, ExcNotImplemented());
     };
-};
+}
 
 
 #if deal_II_dimension == 1
@@ -652,7 +652,7 @@ template <>
 void FE_Nedelec<1>::initialize_unit_face_support_points ()
 {
                                   // no faces in 1d, so nothing to do
-};
+}
 
 #endif
 
@@ -691,7 +691,7 @@ void FE_Nedelec<dim>::initialize_unit_face_support_points ()
                                             // right now
            Assert (false, ExcNotImplemented());
     };     
-};
+}
 
 
 
@@ -938,7 +938,7 @@ FE_Nedelec<dim>::fill_fe_values (const Mapping<dim>                   &mapping,
 
   if (flags & update_second_derivatives)
     this->compute_2nd (mapping, cell, 0, mapping_data, fe_data, data);
-};
+}
 
 
 
@@ -1222,7 +1222,7 @@ FE_Nedelec<dim>::fill_fe_subface_values (const Mapping<dim>                   &m
 
   if (flags & update_second_derivatives)
     this->compute_2nd (mapping, cell, offset, mapping_data, fe_data, data);
-};
+}
 
 
 
@@ -1231,7 +1231,7 @@ unsigned int
 FE_Nedelec<dim>::n_base_elements () const
 {
   return 1;
-};
+}
 
 
 
@@ -1241,7 +1241,7 @@ FE_Nedelec<dim>::base_element (const unsigned int index) const
 {
   Assert (index==0, ExcIndexRange(index, 0, 1));
   return *this;
-};
+}
 
 
 
@@ -1251,7 +1251,7 @@ FE_Nedelec<dim>::element_multiplicity (const unsigned int index) const
 {
   Assert (index==0, ExcIndexRange(index, 0, 1));
   return 1;
-};
+}
 
 
 
@@ -1332,7 +1332,7 @@ unsigned int
 FE_Nedelec<dim>::get_degree () const
 {
   return degree;
-};
+}
 
 
 
index 1babaddbd8c097161d25cc88e1c9803173cf701e..983c3e4954163aa1cbb4289834cd69c89baf0075 100644 (file)
@@ -48,6 +48,6 @@ FE_Nedelec<1>::Matrices::constraint_matrices[] = {};
 #else // #if deal_II_dimension
 // On gcc2.95 on Alpha OSF1, the native assembler does not like empty
 // files, so provide some dummy code
-namespace { void dummy () {}; };
+namespace { void dummy () {} }
 #endif // #if deal_II_dimension == 1
 
index d55ffd5905c814b7310d87a5da5d06b57804bafa..1a4e9b7715c09b86778dcb4057c71638b6958d98 100644 (file)
@@ -64,7 +64,7 @@ namespace FE_Nedelec_2d
        0.,   0.,   .5,   0.,
        0.,   0.,   0.,   .5,
   };
-};  // namespace FE_Nedelec_2d
+}  // namespace FE_Nedelec_2d
 
 
 // embedding matrices
@@ -111,7 +111,7 @@ namespace FE_Nedelec_2d
        1./2., 1./2.
   };
 
-};
+}
 
 
 template <>
@@ -133,5 +133,5 @@ sizeof(FE_Nedelec<2>::Matrices::constraint_matrices[0]);
 #else // #if deal_II_dimension
 // On gcc2.95 on Alpha OSF1, the native assembler does not like empty
 // files, so provide some dummy code
-namespace { void dummy () {}; };
+namespace { void dummy () {} }
 #endif // #if deal_II_dimension == 2
index 6afa6fbe65168f5eadd56678d23a718f5cea0aed..0ca2a616b94c107391d3211f9c35dbed1d1aa27d 100644 (file)
@@ -165,7 +165,7 @@ namespace FE_Nedelec_3d
        0., 0., 0., 0., 0., 0., 0., 0., 0., 0., 0., 0.5,
   };
 
-};  // namespace FE_Nedelec_3d
+}  // namespace FE_Nedelec_3d
 
 
 // embedding matrices
@@ -214,7 +214,7 @@ namespace FE_Nedelec_3d
        0, 0, 0, .5,
        0, 0, 0, .5
   };
-};
+}
 
 
 
@@ -238,5 +238,5 @@ sizeof(FE_Nedelec<3>::Matrices::constraint_matrices[0]);
 #else // #if deal_II_dimension
 // On gcc2.95 on Alpha OSF1, the native assembler does not like empty
 // files, so provide some dummy code
-namespace { void dummy () {}; };
+namespace { void dummy () {} }
 #endif // #if deal_II_dimension == 3
index 8a057dc7a943e7ca586ee03d9b7784a3d66f6c9c..97817298fef633eaec5c78109f829c7ad922bd9e 100644 (file)
@@ -627,7 +627,7 @@ FE_Q<dim>::FE_Q (const unsigned int degree)
                                   // on cell and face
   initialize_unit_support_points ();
   initialize_unit_face_support_points ();
-};
+}
 
 
 
@@ -742,7 +742,7 @@ void FE_Q<dim>::initialize_unit_support_points ()
          
          this->unit_support_points[renumber[k++]] = p;
        };
-};
+}
 
 
 #if deal_II_dimension == 1
@@ -751,7 +751,7 @@ template <>
 void FE_Q<1>::initialize_unit_face_support_points ()
 {
                                   // no faces in 1d, so nothing to do
-};
+}
 
 #endif
 
@@ -784,7 +784,7 @@ void FE_Q<dim>::initialize_unit_face_support_points ()
          
          this->unit_face_support_points[face_renumber[k++]] = p;
        };
-};
+}
 
 
 
@@ -1304,7 +1304,7 @@ unsigned int
 FE_Q<dim>::n_base_elements () const
 {
   return 1;
-};
+}
 
 
 
@@ -1314,7 +1314,7 @@ FE_Q<dim>::base_element (const unsigned int index) const
 {
   Assert (index==0, ExcIndexRange(index, 0, 1));
   return *this;
-};
+}
 
 
 
@@ -1324,7 +1324,7 @@ FE_Q<dim>::element_multiplicity (const unsigned int index) const
 {
   Assert (index==0, ExcIndexRange(index, 0, 1));
   return 1;
-};
+}
 
 
 
@@ -1468,7 +1468,7 @@ FE_Q<dim>::has_support_on_face (const unsigned int shape_index,
                                    // we should not have gotten here
   Assert (false, ExcInternalError());
   return false;
-};
+}
 
 
 
@@ -1487,7 +1487,7 @@ unsigned int
 FE_Q<dim>::get_degree () const
 {
   return degree;
-};
+}
 
 
 
index a5275ad93b536b6344fd6763f121be559caba2e1..5fe450b3074ccf31819dfb2f98f09a9048eefd3a 100644 (file)
@@ -83,7 +83,7 @@ namespace FE_Q_1d
        -1.0546875/27., 7.3828125/27., 5.90625/27., -14.765625/27., 29.53125/27.,
   };
  
-};   // namespace FE_Q_1d
+}   // namespace FE_Q_1d
 
 
 
@@ -124,5 +124,5 @@ FE_Q<1>::Matrices::constraint_matrices[] = { 0 };
 #else // #if deal_II_dimension
 // On gcc2.95 on Alpha OSF1, the native assembler does not like empty
 // files, so provide some dummy code
-namespace { void dummy () {}; };
+namespace { void dummy () {} }
 #endif // #if deal_II_dimension == 1
index 1cf85b7aba95b84a2de34aa9abd55422bf5b3189..bf7f4f2c1eee3aec6f097cf71e7ad820adaa369f 100644 (file)
@@ -185,7 +185,7 @@ namespace FE_Q_2d
        0., 0., 0., 0., 1.6875/27., 0., 0., 0., 8.4375/27., 0., 0., 0., -8.4375/27., 0., 25.3125/27., 0.,
   };
  
-};  // namespace FE_Q_2d
+}  // namespace FE_Q_2d
 
 
 // embedding matrices
@@ -244,7 +244,7 @@ namespace FE_Q_2d
        0., 0., 0., 0., 1.,
        -0.0390625, 0.2734375, 0.21875, -0.546875, 1.09375
   };
-};
+}
 
 
 template <>
@@ -269,5 +269,5 @@ FE_Q<2>::Matrices::n_constraint_matrices
 #else // #if deal_II_dimension
 // On gcc2.95 on Alpha OSF1, the native assembler does not like empty
 // files, so provide some dummy code
-namespace { void dummy () {}; };
+namespace { void dummy () {} }
 #endif // #if deal_II_dimension == 2
index 2e78beb61e8231d866c8e5fe92fb160b8e7b61fa..b21e833a50ed3c2f46014cf07cd44530b18dc136 100644 (file)
@@ -364,7 +364,7 @@ namespace FE_Q_3d
        0.421875/27., 0., 0., -1.265625/27., -1.265625/27., 0., 0., 3.796875/27., 0., 0., 0., -2.53125/27., 0., 0., 0., 7.59375/27., -2.53125/27., 0., 0., 7.59375/27., 0., 0., 0., 0., 0., 15.1875/27., 0.,
        0.158203125/27., -0.052734375/27., 0.158203125/27., -0.474609375/27., -0.474609375/27., 0.158203125/27., -0.474609375/27., 1.423828125/27., 0.31640625/27., 0.31640625/27., -0.94921875/27., -0.94921875/27., -0.94921875/27., -0.94921875/27., 2.84765625/27., 2.84765625/27., -0.94921875/27., 0.31640625/27., -0.94921875/27., 2.84765625/27., -1.8984375/27., 5.6953125/27., -1.8984375/27., -1.8984375/27., 5.6953125/27., 5.6953125/27., 11.390625/27.,
   };
-};  // namespace FE_Q_3d
+}  // namespace FE_Q_3d
 
 
 // embedding matrices
@@ -429,7 +429,7 @@ namespace FE_Q_3d
        .015625,-.046875,.140625,-.046875,-.09375,.28125,.28125,-.09375,.5625,
        -.046875,.015625,-.046875,.140625,-.09375,-.09375,.28125,.28125,.5625
   };
-};
+}
 
 
 
@@ -454,5 +454,5 @@ FE_Q<3>::Matrices::n_constraint_matrices
 #else // #if deal_II_dimension
 // On gcc2.95 on Alpha OSF1, the native assembler does not like empty
 // files, so provide some dummy code
-namespace { void dummy () {}; };
+namespace { void dummy () {} }
 #endif // #if deal_II_dimension == 3
index 7b2457adccfb902ef353459ecae5ec8315ee48e8..448ec5eb87557a8b01e0e68f9c15351bfdd49766 100644 (file)
@@ -315,7 +315,7 @@ FE_Q_Hierarchical<dim>::FE_Q_Hierarchical (const unsigned int degree)
                                   // on cell and face
   initialize_unit_support_points ();
   initialize_unit_face_support_points ();
-};
+}
 
 
 
@@ -452,7 +452,7 @@ void FE_Q_Hierarchical<dim>::initialize_unit_support_points ()
        }
        this->unit_support_points[renumber[k++]] = p;
       };
-};
+}
 
 
 #if deal_II_dimension == 1
@@ -461,7 +461,7 @@ template <>
 void FE_Q_Hierarchical<1>::initialize_unit_face_support_points ()
 {
                                   // no faces in 1d, so nothing to do
-};
+}
 
 #endif
 
@@ -511,7 +511,7 @@ void FE_Q_Hierarchical<dim>::initialize_unit_face_support_points ()
        }
        this->unit_face_support_points[face_renumber[k++]] = p;
       };
-};
+}
 
 
                                            // we use same dpo_vector as FE_Q
@@ -1044,7 +1044,7 @@ unsigned int
 FE_Q_Hierarchical<dim>::n_base_elements () const
 {
   return 1;
-};
+}
 
 
 
@@ -1054,7 +1054,7 @@ FE_Q_Hierarchical<dim>::base_element (const unsigned int index) const
 {
   Assert (index==0, ExcIndexRange(index, 0, 1));
   return *this;
-};
+}
 
 
 
@@ -1064,7 +1064,7 @@ FE_Q_Hierarchical<dim>::element_multiplicity (const unsigned int index) const
 {
   Assert (index==0, ExcIndexRange(index, 0, 1));
   return 1;
-};
+}
 
 
 
@@ -1336,7 +1336,7 @@ unsigned int
 FE_Q_Hierarchical<dim>::get_degree () const
 {
   return degree;
-};
+}
 
 
 
index 739b6769f3ad16d7cc932bab10fd4f8e5c1e1c67..d9852e0d9748c6442894d988e353e18c268b7bbf 100644 (file)
@@ -58,7 +58,7 @@ FESystem<dim>::InternalData::~InternalData()
        delete base_fe_values_datas[i];
        base_fe_values_datas[i] = 0;
       };
-};
+}
 
 
 
@@ -70,7 +70,7 @@ InternalData::get_fe_data (const unsigned int base_no) const
   Assert(base_no<base_fe_datas.size(),
         ExcIndexRange(base_no,0,base_fe_datas.size()));
   return *base_fe_datas[base_no];
-};
+}
 
 
 
@@ -83,7 +83,7 @@ InternalData::set_fe_data (const unsigned int base_no,
   Assert(base_no<base_fe_datas.size(),
         ExcIndexRange(base_no,0,base_fe_datas.size()));
   base_fe_datas[base_no]=ptr;
-};
+}
 
 
 
@@ -96,7 +96,7 @@ InternalData::get_fe_values_data (const unsigned int base_no) const
         ExcIndexRange(base_no,0,base_fe_values_datas.size()));
   Assert(base_fe_values_datas[base_no]!=0, ExcInternalError());
   return *base_fe_values_datas[base_no];
-};
+}
 
 
 
@@ -109,7 +109,7 @@ InternalData::set_fe_values_data (const unsigned int base_no,
   Assert(base_no<base_fe_values_datas.size(),
         ExcIndexRange(base_no,0,base_fe_values_datas.size()));
   base_fe_values_datas[base_no]=ptr;
-};
+}
 
 
 
@@ -138,7 +138,7 @@ FESystem<dim>::InternalData::clear_first_cell ()
                                    // sub-objects
   for (unsigned int i=0; i<base_fe_datas.size(); ++i)
     base_fe_datas[i]->clear_first_cell ();
-};
+}
 
 
 /* ---------------------------------- FESystem ------------------- */
@@ -159,7 +159,7 @@ FESystem<dim>::FESystem (const FiniteElement<dim> &fe,
   base_elements[0] = ElementPair(fe.clone(), n_elements);
   base_elements[0].first->subscribe ();
   initialize ();
-};
+}
 
 
 
@@ -180,7 +180,7 @@ FESystem<dim>::FESystem (const FiniteElement<dim> &fe1,
   base_elements[1] = ElementPair(fe2.clone(), n2);
   base_elements[1].first->subscribe ();
   initialize ();
-};
+}
 
 
 
@@ -209,7 +209,7 @@ FESystem<dim>::FESystem (const FiniteElement<dim> &fe1,
   base_elements[2] = ElementPair(fe3.clone(), n3);
   base_elements[2].first->subscribe ();
   initialize ();
-};
+}
 
 
 
@@ -224,7 +224,7 @@ FESystem<dim>::~FESystem ()
       delete base_elements[i].first;
       base_elements[i].first = 0;
     }
-};
+}
 
 
 
@@ -553,7 +553,7 @@ fill_fe_values (const Mapping<dim>                   &mapping,
 {
   compute_fill(mapping, cell, invalid_face_number, invalid_face_number,
               quadrature, mapping_data, fe_data, data);
-};
+}
 
 
 
@@ -570,7 +570,7 @@ fill_fe_face_values (const Mapping<dim>                   &mapping,
 {
   compute_fill (mapping, cell, face_no, invalid_face_number,
                 quadrature, mapping_data, fe_data, data);
-};
+}
 
 
 
@@ -1041,7 +1041,7 @@ FESystem<dim>::build_cell_tables()
                  this->system_to_component_table[total_index] = non_primitive_index;
              }
       }
-};
+}
 
 
 
@@ -1223,7 +1223,7 @@ FESystem<dim>::build_face_tables()
          ExcInternalError());
   Assert (total_index == this->face_system_to_base_table.size(),
          ExcInternalError());
-};
+}
 
 
 
@@ -1477,7 +1477,7 @@ void FESystem<dim>::build_interface_constraints ()
            = (base_element(n_index.first.first).constraints()(m_index.second,
                                                               n_index.second));
       };
-};
+}
 
 
 
@@ -1580,7 +1580,7 @@ void FESystem<dim>::initialize ()
                                   // on cell and face
   initialize_unit_support_points ();
   initialize_unit_face_support_points ();
-};
+}
 
 
 
@@ -1596,7 +1596,7 @@ FESystem<dim>::multiply_dof_numbers (const FiniteElementData<dim> &fe_data,
   if (dim>2) dpo.push_back(fe_data.dofs_per_hex * N);
   
   return FiniteElementData<dim> (dpo, fe_data.n_components() * N);
-};
+}
 
 
 
@@ -1647,7 +1647,7 @@ FESystem<1>::
 initialize_unit_face_support_points ()
 {
                                   // no faces no work
-};
+}
 
 #endif
 
@@ -1710,7 +1710,7 @@ FESystem<dim>::multiply_dof_numbers (const FiniteElementData<dim> &fe1,
   return FiniteElementData<dim> (dpo,
                                 fe1.n_components() * N1 +
                                 fe2.n_components() * N2);
-};
+}
 
 
 
@@ -1741,7 +1741,7 @@ FESystem<dim>::multiply_dof_numbers (const FiniteElementData<dim> &fe1,
                                 fe1.n_components() * N1 +
                                 fe2.n_components() * N2 +
                                 fe3.n_components() * N3);
-};
+}
 
 
 
@@ -1757,7 +1757,7 @@ FESystem<dim>::compute_restriction_is_additive_flags (const FiniteElement<dim> &
   multiplicities.push_back (n_elements);
   
   return compute_restriction_is_additive_flags (fe_list, multiplicities);
-};
+}
 
 
 
@@ -1778,7 +1778,7 @@ FESystem<dim>::compute_restriction_is_additive_flags (const FiniteElement<dim> &
   multiplicities.push_back (N2);
   
   return compute_restriction_is_additive_flags (fe_list, multiplicities);
-};
+}
 
 
 
@@ -1804,7 +1804,7 @@ FESystem<dim>::compute_restriction_is_additive_flags (const FiniteElement<dim> &
   multiplicities.push_back (N3);
   
   return compute_restriction_is_additive_flags (fe_list, multiplicities);
-};
+}
 
 
 
@@ -1936,7 +1936,7 @@ compute_restriction_is_additive_flags (const std::vector<const FiniteElement<dim
   Assert (total_index == n_shape_functions, ExcInternalError());
   
   return retval;
-};
+}
 
 
 
@@ -1952,7 +1952,7 @@ FESystem<dim>::compute_nonzero_components (const FiniteElement<dim> &fe1,
   multiplicities.push_back (N1);
   
   return compute_nonzero_components (fe_list, multiplicities);
-};
+}
 
 
 
@@ -1973,7 +1973,7 @@ FESystem<dim>::compute_nonzero_components (const FiniteElement<dim> &fe1,
   multiplicities.push_back (N2);
   
   return compute_nonzero_components (fe_list, multiplicities);
-};
+}
 
 
 
@@ -1999,7 +1999,7 @@ FESystem<dim>::compute_nonzero_components (const FiniteElement<dim> &fe1,
   multiplicities.push_back (N3);
   
   return compute_nonzero_components (fe_list, multiplicities);
-};
+}
 
 
 
@@ -2181,7 +2181,7 @@ compute_nonzero_components (const std::vector<const FiniteElement<dim>*> &fes,
   Assert (total_index == n_shape_functions, ExcInternalError());
   
   return retval;
-};
+}
 
 
 
@@ -2193,7 +2193,7 @@ FESystem<dim>::base_element (const unsigned int index) const
   Assert (index < base_elements.size(), 
          ExcIndexRange(index, 0, base_elements.size()));
   return *base_elements[index].first;
-};
+}
 
 
 
@@ -2202,7 +2202,7 @@ unsigned int
 FESystem<dim>::n_base_elements () const
 {
   return base_elements.size();
-};
+}
 
 
 
@@ -2213,7 +2213,7 @@ FESystem<dim>::element_multiplicity (const unsigned int index) const
   Assert (index < base_elements.size(), 
          ExcIndexRange(index, 0, base_elements.size()));
   return base_elements[index].second;
-};
+}
 
 
 
@@ -2249,7 +2249,7 @@ FESystem<dim>::unit_support_point (const unsigned index) const
                                      // provide this information
     return (base_element(this->system_to_base_index(index).first.first)
             .unit_support_point(this->system_to_base_index(index).second));
-};
+}
 
 
 
@@ -2273,7 +2273,7 @@ FESystem<dim>::unit_face_support_point (const unsigned index) const
                                      // provide this information
     return (base_element(this->face_system_to_base_index(index).first.first)
             .unit_face_support_point(this->face_system_to_base_index(index).second));
-};
+}
 
 
 
@@ -2293,7 +2293,7 @@ FESystem<dim>::memory_consumption () const
   for (unsigned int i=0; i<base_elements.size(); ++i)
     mem += MemoryConsumption::memory_consumption (*base_elements[i].first);
   return mem;
-};
+}
 
 
 
index e69fe21598ad790f819ba0d0b72c5cbb80a5de1b..fceb71e5c31fb2ccc1e949897516bb478ff097f2 100644 (file)
@@ -602,7 +602,7 @@ FETools::hierarchic_to_lexicographic_numbering (const FE_Q<dim>           &fe,
       default:
            Assert (false, ExcNotImplemented());
     };
-};
+}
 
 
 
@@ -849,7 +849,7 @@ FETools::lexicographic_to_hierarchic_numbering (const FE_Q<dim>           &fe,
                  }  
          } 
     }
-};
+}
 
 
 
index 3575a51e284a8854b82b6e41417e911c8de60e7b..7de3aca4fd02ab540a78ca2c62c460a29ff46b0b 100644 (file)
@@ -171,7 +171,7 @@ void FEValuesBase<dim>::get_function_values (const InputVector            &fe_fu
     for (unsigned int shape_func=0; shape_func<dofs_per_cell; ++shape_func)
       values[point] += (dof_values(shape_func) *
                        this->shape_value(shape_func, point));
-};
+}
 
 
 
@@ -218,7 +218,7 @@ void FEValuesBase<dim>::get_function_values (const InputVector
        for (unsigned int c=0; c<n_components; ++c)
          values[point](c) += (dof_values(shape_func) *
                               shape_value_component(shape_func, point, c));
-};
+}
 
 
 
@@ -228,7 +228,7 @@ FEValuesBase<dim>::get_quadrature_points () const
 {
   Assert (this->update_flags & update_q_points, ExcAccessToUninitializedField());
   return this->quadrature_points;
-};
+}
 
 
 
@@ -282,7 +282,7 @@ get_function_grads (const InputVector                    &fe_function,
        tmp *= dof_values(shape_func);
        gradients[point] += tmp;
       };
-};
+}
 
 
 
@@ -338,7 +338,7 @@ get_function_grads (const InputVector                         &fe_function,
            tmp *= dof_values(shape_func);
            gradients[point][c] += tmp;
          };
-};
+}
 
 
 
@@ -381,7 +381,7 @@ get_function_2nd_derivatives (const InputVector                    &fe_function,
        tmp *= dof_values(shape_func);
        second_derivatives[point] += tmp;
       };
-};
+}
 
 
 
@@ -433,7 +433,7 @@ get_function_2nd_derivatives (const InputVector                         &fe_func
            tmp *= dof_values(shape_func);
            second_derivs[point][c] += tmp;
          };
-};
+}
 
 
 
@@ -445,7 +445,7 @@ FEValuesBase<dim>::quadrature_point (const unsigned int i) const
   Assert (i<this->quadrature_points.size(), ExcIndexRange(i, 0, this->quadrature_points.size()));
   
   return this->quadrature_points[i];
-};
+}
 
 
 
@@ -457,7 +457,7 @@ double FEValuesBase<dim>::JxW (const unsigned int i) const
   Assert (i<this->JxW_values.size(), ExcIndexRange(i, 0, this->JxW_values.size()));
   
   return this->JxW_values[i];
-};
+}
 
 
 
@@ -483,7 +483,7 @@ FEValuesBase<dim>::memory_consumption () const
          MemoryConsumption::memory_consumption (fe_data) +
          MemoryConsumption::memory_consumption (*fe_data) +
          MemoryConsumption::memory_consumption (this->shape_function_to_row_table));
-};
+}
 
 
 
@@ -505,7 +505,7 @@ FEValuesBase<dim>::compute_update_flags (const UpdateFlags update_flags) const
           | mapping->update_each (flags);
 
   return flags;
-};
+}
 
 
 
@@ -536,7 +536,7 @@ FEValues<dim>::FEValues (const Mapping<dim>       &mapping,
   quadrature (q)
 {
   initialize (update_flags);
-};
+}
 
 
 
@@ -554,7 +554,7 @@ FEValues<dim>::FEValues (const FiniteElement<dim> &fe,
 {
   Assert (DEAL_II_COMPAT_MAPPING, ExcCompatibility("mapping"));
   initialize (update_flags);
-};
+}
 
 
 
@@ -578,7 +578,7 @@ FEValues<dim>::initialize (const UpdateFlags update_flags)
 
                                   // set up objects within this class
   FEValuesData<dim>::initialize (this->n_quadrature_points, *this->fe, flags);
-};
+}
 
 
 
@@ -620,7 +620,7 @@ FEValues<dim>::memory_consumption () const
 {
   return (FEValuesBase<dim>::memory_consumption () +
          MemoryConsumption::memory_consumption (quadrature));
-};
+}
 
 
 /*------------------------------- FEFaceValuesBase --------------------------*/
@@ -640,7 +640,7 @@ FEFaceValuesBase<dim>::FEFaceValuesBase (const unsigned int n_q_points,
                                   mapping,
                                   fe),
   quadrature(quadrature)
-{};
+{}
 
 
 
@@ -651,7 +651,7 @@ FEFaceValuesBase<dim>::get_normal_vectors () const
   Assert (this->update_flags & update_normal_vectors,
          typename FEValuesBase<dim>::ExcAccessToUninitializedField());
   return this->normal_vectors;
-};
+}
 
 
 
@@ -660,9 +660,9 @@ const std::vector<Tensor<1,dim> > &
 FEFaceValuesBase<dim>::get_boundary_forms () const
 {
   Assert (this->update_flags & update_boundary_forms,
-         FEValuesBase<dim>::ExcAccessToUninitializedField());
+         typename FEValuesBase<dim>::ExcAccessToUninitializedField());
   return this->boundary_forms;
-};
+}
 
 
 
@@ -673,7 +673,7 @@ FEFaceValuesBase<dim>::memory_consumption () const
   return (FEValuesBase<dim>::memory_consumption () +
          MemoryConsumption::memory_consumption (quadrature) +
          MemoryConsumption::memory_consumption (present_face));
-};
+}
 
 
 /*------------------------------- FEFaceValues -------------------------------*/
@@ -692,7 +692,7 @@ FEFaceValues<dim>::FEFaceValues (const Mapping<dim>       &mapping,
                                       fe, quadrature)
 {
   initialize (update_flags);
-};
+}
 
 
 
@@ -709,7 +709,7 @@ FEFaceValues<dim>::FEFaceValues (const FiniteElement<dim> &fe,
 {
   Assert (DEAL_II_COMPAT_MAPPING, ExcCompatibility("mapping"));
   initialize (update_flags);
-};
+}
 
 
 
@@ -728,7 +728,7 @@ FEFaceValues<dim>::initialize (const UpdateFlags update_flags)
 
                                   // set up objects within this class
   FEValuesData<dim>::initialize(this->n_quadrature_points, *this->fe, flags);
-};
+}
 
 
 
@@ -764,7 +764,7 @@ void FEFaceValues<dim>::reinit (const typename DoFHandler<dim>::cell_iterator &c
 
   this->fe_data->clear_first_cell ();
   this->mapping_data->clear_first_cell ();
-};
+}
 
 
 /*------------------------------- FESubFaceValues -------------------------------*/
@@ -800,7 +800,7 @@ FESubfaceValues<dim>::FESubfaceValues (const FiniteElement<dim> &fe,
 {
   Assert (DEAL_II_COMPAT_MAPPING, ExcCompatibility("mapping"));
   initialize (update_flags);
-};
+}
 
 
 
@@ -821,7 +821,7 @@ FESubfaceValues<dim>::initialize (const UpdateFlags update_flags)
 
                                   // set up objects within this class
   FEValuesData<dim>::initialize(this->n_quadrature_points, *this->fe, flags);
-};
+}
 
 
 
@@ -862,7 +862,7 @@ void FESubfaceValues<dim>::reinit (const typename DoFHandler<dim>::cell_iterator
 
   this->fe_data->clear_first_cell ();
   this->mapping_data->clear_first_cell ();
-};
+}
 
 
 /*------------------------------- Explicit Instantiations -------------*/
index 559ba4ec359d6e80c6b5f59a9225714ebe2a2542..cbad47d0f0b7e4e5da166d3b6feb38e42795f007 100644 (file)
@@ -27,7 +27,7 @@ MappingC1<dim>::MappingC1 ()
                MappingQ<dim> (3)
 {
   Assert (dim > 1, ExcImpossibleInDim(dim));
-};
+}
 
 
 #if deal_II_dimension == 1
@@ -39,7 +39,7 @@ MappingC1<1>::add_line_support_points (const Triangulation<1>::cell_iterator &,
 {
   const unsigned int dim = 1;
   Assert (dim > 1, ExcImpossibleInDim(dim));
-};
+}
 
 #endif
 
@@ -183,7 +183,7 @@ MappingC1<2>::add_line_support_points (const Triangulation<2>::cell_iterator &ce
          a.insert (a.end(), line_points.begin(), line_points.end());
        };
     };
-};
+}
 
 #endif
 
@@ -195,7 +195,7 @@ MappingC1<dim>::add_line_support_points (const typename Triangulation<dim>::cell
                                         std::vector<Point<dim> > &) const
 {
   Assert (false, ExcNotImplemented());
-};
+}
 
 
 
@@ -209,7 +209,7 @@ MappingC1<1>::add_quad_support_points (const Triangulation<1>::cell_iterator &,
 {
   const unsigned int dim = 1;
   Assert (dim > 2, ExcImpossibleInDim(dim));
-};
+}
 
 #endif
 
@@ -224,7 +224,7 @@ MappingC1<2>::add_quad_support_points (const Triangulation<2>::cell_iterator &,
 {
   const unsigned int dim = 2;
   Assert (dim > 2, ExcImpossibleInDim(dim));
-};
+}
 
 #endif
 
@@ -237,7 +237,7 @@ MappingC1<dim>::add_quad_support_points (const typename Triangulation<dim>::cell
                                         std::vector<Point<dim> > &) const
 {
   Assert (false, ExcNotImplemented());
-};
+}
 
 
 
index af9c98727612335a4f078a26a4dffa60adf7029e..92d817a963d84c96216eced27effbdcaff34ada1 100644 (file)
@@ -49,7 +49,7 @@ MappingCartesian<dim>::InternalData::memory_consumption () const
          MemoryConsumption::memory_consumption (quadrature_points) +
          MemoryConsumption::memory_consumption (unit_tangentials) +
          MemoryConsumption::memory_consumption (aux));
-};
+}
 
 
 
index 1318982481318574e0fc4db53ffc17f1284f16d1..f35144e7e7a079b16042d5f00b281a91c5b6e0ef 100644 (file)
@@ -52,7 +52,7 @@ MappingQ<dim>::InternalData::memory_consumption () const
          MemoryConsumption::memory_consumption (unit_normals) +
          MemoryConsumption::memory_consumption (use_mapping_q1_on_current_cell) +
          MemoryConsumption::memory_consumption (mapping_q1_data));
-};
+}
 
 
 
@@ -864,7 +864,7 @@ MappingQ<dim>::add_line_support_points (const typename Triangulation<dim>::cell_
          a.insert (a.end(), line_points.begin(), line_points.end());
        }
     }
-};
+}
 
 
 
@@ -1255,7 +1255,7 @@ unsigned int
 MappingQ<dim>::get_degree() const
 {
   return degree;
-};
+}
 
   
 // explicit instantiation
index eb5b90d0fe3b8e27454f6eb7b58ce36446a657d7..d25cab652fa73b201af848af62e1d0c63b6d66fa 100644 (file)
@@ -56,13 +56,13 @@ MappingQ1<dim>::InternalData::memory_consumption () const
          MemoryConsumption::memory_consumption (cell_of_current_support_points) +
          MemoryConsumption::memory_consumption (is_mapping_q1_data) +
          MemoryConsumption::memory_consumption (n_shape_functions));
-};
+}
 
 
 
 template <int dim>
 MappingQ1<dim>::MappingQ1 ()
-{};
+{}
 
 
 
index 812106d8d72778d029e88aadd3167bfe98babc13..1a9ef5a3b653efd50441afdf26afad1e9967adfb 100644 (file)
@@ -93,7 +93,7 @@ GeometryInfo<2>::child_cell_on_face (const unsigned int face,
                                                                {3,2},
                                                                {0,3}};
   return subcells[face][subface];
-};
+}
 
 
 
@@ -112,4 +112,4 @@ GeometryInfo<3>::child_cell_on_face (const unsigned int face,
                                                                {3, 2, 6, 7},
                                                                {0, 4, 7, 3}};
   return subcells[face][subface];
-};
+}
index 204b400ef788f7f88f5e5f0798c43be06199daf3..4ec9c7fda5385fc56047bb329807f5db19e5bf71 100644 (file)
@@ -106,7 +106,7 @@ void
 GridGenerator::colorize_hyper_rectangle (Triangulation<1> &)
 {
                                   // nothing to do in 1d
-};
+}
 
 
 #else
@@ -137,7 +137,7 @@ GridGenerator::colorize_hyper_rectangle (Triangulation<dim> &tria)
       default:
            Assert(false, ExcNotImplemented());
     };
-};
+}
 
 #endif
 
@@ -166,7 +166,7 @@ void GridGenerator::hyper_cube_slit (Triangulation<1> &,
                                     const bool)
 {
   Assert (false, ExcNotImplemented());
-};
+}
 
 
 
@@ -175,7 +175,7 @@ void GridGenerator::hyper_L (Triangulation<1> &,
                             const double)
 {
   Assert (false, ExcNotImplemented());
-};
+}
 
 
 
@@ -184,7 +184,7 @@ void GridGenerator::hyper_ball (Triangulation<1> &,
                                const double)
 {
   Assert (false, ExcNotImplemented());
-};
+}
 
 
 
@@ -193,7 +193,7 @@ void GridGenerator::cylinder (Triangulation<1> &,
                              const double)
 {
   Assert (false, ExcNotImplemented());
-};
+}
 
 
 
@@ -204,7 +204,7 @@ void GridGenerator::hyper_shell (Triangulation<1> &,
                                 const unsigned int)
 {
   Assert (false, ExcNotImplemented());
-};
+}
 
 #endif
 
@@ -294,7 +294,7 @@ GridGenerator::hyper_cube_slit (Triangulation<2> &tria,
       ++cell;
       cell->face(3)->set_boundary_indicator(2);
     }
-};
+}
 
 
 
@@ -328,7 +328,7 @@ GridGenerator::hyper_L (Triangulation<2> &tria,
   tria.create_triangulation (std::vector<Point<dim> >(&vertices[0], &vertices[8]),
                             cells,
                             SubCellData());       // no boundary information
-};
+}
 
 
 
@@ -368,7 +368,7 @@ GridGenerator::hyper_ball (Triangulation<2> &tria,
   tria.create_triangulation (std::vector<Point<2> >(&vertices[0], &vertices[8]),
                             cells,
                             SubCellData());       // no boundary information
-};
+}
 
 
 
@@ -428,7 +428,7 @@ void GridGenerator::hyper_shell (Triangulation<2>   &tria,
     };
   
   tria.create_triangulation (vertices, cells, SubCellData());
-};
+}
 
 
 
@@ -499,7 +499,7 @@ GridGenerator::half_hyper_ball (Triangulation<2> &tria,
   tria.create_triangulation (std::vector<Point<2> >(&vertices[0], &vertices[8]),
                             cells,
                             SubCellData());       // no boundary information
-};
+}
 
 
 
@@ -568,7 +568,7 @@ GridGenerator::half_hyper_shell (Triangulation<2>   &tria,
     };
   
   tria.create_triangulation (vertices, cells, SubCellData());
-};
+}
 
 
 
@@ -584,7 +584,7 @@ void GridGenerator::hyper_cube_slit (Triangulation<3> &,
                                     const bool)
 {
   Assert (false, ExcNotImplemented());
-};
+}
 
 
 
@@ -705,7 +705,7 @@ GridGenerator::hyper_L (Triangulation<3> &tria,
   tria.create_triangulation (std::vector<Point<dim> >(&vertices[0], &vertices[26]),
                             cells,
                             SubCellData());       // no boundary information
-};
+}
 
 
 
@@ -786,7 +786,7 @@ GridGenerator::hyper_ball (Triangulation<3> &/*tria*/,
                             cells,
                             SubCellData());       // no boundary information
 */                          
-};
+}
 
 
 
@@ -868,7 +868,7 @@ GridGenerator::cylinder (Triangulation<3> &tria,
        cell->face(1)->set_boundary_indicator(2);
       ++cell;
     }
-};
+}
 
 
 
@@ -879,7 +879,7 @@ void GridGenerator::hyper_shell (Triangulation<3>   &,
                                 const unsigned int  )
 {
   Assert (false, ExcNotImplemented());
-};
+}
 
 
 #endif
index 15dbabae5251bcb71734316ebfd5630b10bf1613..cfa1d92c0c6214ea2e1fcca355ad971e3b36672a 100644 (file)
@@ -31,14 +31,14 @@ using namespace std;
 
 template <int dim>
 GridIn<dim>::GridIn () :
-               tria(0) {};
+               tria(0) {}
 
 
 template <int dim>
 void GridIn<dim>::attach_triangulation (Triangulation<dim> &t)
 {
   tria = &t;
-};
+}
 
 
 template <int dim>
@@ -202,7 +202,7 @@ void GridIn<dim>::read_ucd (std::istream &in)
                                   // ... and cells
   GridReordering<dim>::reorder_cells (cells);
   tria->create_triangulation (vertices, cells, subcelldata);
-};
+}
 
 
 
@@ -366,7 +366,7 @@ void GridIn<dim>::read_dbmesh (std::istream &in)
                                   // ...and cells
   GridReordering<dim>::reorder_cells (cells);
   tria->create_triangulation (vertices, cells, subcelldata);
-};
+}
 
 
 
@@ -394,7 +394,7 @@ void GridIn<dim>::skip_empty_lines (std::istream &in)
 
                                       // else: go on with next line
     };
-};
+}
 
 
 
@@ -413,7 +413,7 @@ void GridIn<dim>::skip_comment_lines (std::istream &in,
                                   // put back first character of
                                   // first non-comment line
   in.putback (c);
-};
+}
 
 
 
@@ -469,7 +469,7 @@ GridIn<dim>::delete_unused_vertices (std::vector<Point<dim> >    &vertices,
     if (vertex_used[v] == true)
       tmp.push_back (vertices[v]);
   swap (vertices, tmp);
-};
+}
 
 
 
@@ -479,7 +479,7 @@ void GridIn<dim>::debug_output_grid (const std::vector<CellData<dim> > &/*cells*
                                     std::ostream                      &/*out*/)
 {
   Assert (false, ExcNotImplemented());
-};
+}
 
 
 #if deal_II_dimension == 2
@@ -550,7 +550,7 @@ GridIn<2>::debug_output_grid (const std::vector<CellData<2> > &cells,
       << min_y << ':' << max_y <<  "] "
       << min_y << std::endl
       << "pause -1" << std::endl;
-};
+}
 
 #endif
 
@@ -626,7 +626,7 @@ GridIn<3>::debug_output_grid (const std::vector<CellData<3> > &cells,
          << vertices[cells[cell].vertices[7]]
          << std::endl << std::endl << std::endl;
     };
-};
+}
 
 #endif
 
index 3127081cce52d2d2de3b064603d04e732b7641f7..cccb80b99b3bb83160e1709774db747a89f76a52 100644 (file)
@@ -27,7 +27,7 @@ namespace GridOutFlags
     write_diameter (write_diameter),
     write_measure (write_measure),
     write_all_faces (write_all_faces)
-  {};
+  {}
 
   
   
@@ -35,7 +35,7 @@ namespace GridOutFlags
            const bool write_faces) :
                  write_preamble (write_preamble),
                  write_faces (write_faces)
-  {};
+  {}
 
   
   
@@ -43,7 +43,7 @@ namespace GridOutFlags
                    const unsigned int n_boundary_face_points) :
                  write_cell_numbers (write_cell_numbers),
                  n_boundary_face_points(n_boundary_face_points)
-  {};
+  {}
 
   
   
@@ -57,7 +57,7 @@ namespace GridOutFlags
                  line_width (line_width),
                  color_lines_on_user_flag(color_lines_on_user_flag),
                  n_boundary_face_points(n_boundary_face_points)
-  {};
+  {}
   
 
   
@@ -70,7 +70,7 @@ namespace GridOutFlags
                  EpsFlagsBase(size_type, size, line_width,
                               color_lines_on_user_flag,
                               n_boundary_face_points)
-  {};
+  {}
 
   
   
@@ -89,7 +89,7 @@ namespace GridOutFlags
                  write_cell_numbers (write_cell_numbers),
                  write_cell_number_level (write_cell_number_level),
                  write_vertex_numbers (write_vertex_numbers)
-  {};
+  {}
 
 
   
@@ -106,50 +106,50 @@ namespace GridOutFlags
                               n_boundary_face_points),
                  azimut_angle (azimut_angle),
                  turn_angle (turn_angle)
-  {};
-};  // end namespace GridOutFlags
+  {}
+}  // end namespace GridOutFlags
 
 
 
 void GridOut::set_flags (const GridOutFlags::DX &flags) 
 {
   dx_flags = flags;
-};
+}
 
 
 
 void GridOut::set_flags (const GridOutFlags::Ucd &flags) 
 {
   ucd_flags = flags;
-};
+}
 
 
 
 void GridOut::set_flags (const GridOutFlags::Gnuplot &flags) 
 {
   gnuplot_flags = flags;
-};
+}
 
 
 
 void GridOut::set_flags (const GridOutFlags::Eps<1> &flags) 
 {
   eps_flags_1 = flags;
-};
+}
 
 
 
 void GridOut::set_flags (const GridOutFlags::Eps<2> &flags) 
 {
   eps_flags_2 = flags;
-};
+}
 
 
 
 void GridOut::set_flags (const GridOutFlags::Eps<3> &flags) 
 {
   eps_flags_3 = flags;
-};
+}
 
 
 
@@ -173,7 +173,7 @@ GridOut::default_suffix (const OutputFormat output_format)
            Assert (false, ExcNotImplemented()); 
            return "";
     };
-};
+}
 
 
 
@@ -195,14 +195,14 @@ GridOut::parse_output_format (const std::string &format_name)
   AssertThrow (false, ExcInvalidState ());
                                   // return something weird
   return OutputFormat(-1);
-};
+}
 
 
 
 std::string GridOut::get_output_format_names () 
 {
   return "dx|gnuplot|eps|ucd";
-};
+}
 
 
 
@@ -214,4 +214,4 @@ GridOut::memory_consumption () const
          sizeof(eps_flags_1) +
          sizeof(eps_flags_2) +
          sizeof(eps_flags_3));
-};
+}
index 68014e6a0eb098c5f7623278c7b40303630a92e5..9955ff6f247a41341300a4381d7c961a282cc661 100644 (file)
@@ -364,7 +364,7 @@ void GridOut::write_ucd (const Triangulation<dim> &tria,
     write_ucd_faces (tria, cell_index, out);
     
   AssertThrow (out, ExcIO());
-};
+}
 
 
 
@@ -373,7 +373,7 @@ void GridOut::write_ucd (const Triangulation<dim> &tria,
 unsigned int GridOut::n_boundary_faces (const Triangulation<1> &) const
 {
   return 0;
-};
+}
 
 #endif
 
@@ -392,7 +392,7 @@ unsigned int GridOut::n_boundary_faces (const Triangulation<dim> &tria) const
       n_faces++;
 
   return n_faces;
-};
+}
 
 
 
@@ -403,7 +403,7 @@ void GridOut::write_ucd_faces (const Triangulation<1> &,
                               std::ostream &) const
 {
   return;
-};
+}
 
 #endif
 
@@ -439,7 +439,7 @@ void GridOut::write_ucd_faces (const Triangulation<dim> &tria,
 
        ++index;
       };         
-};
+}
 
 #if deal_II_dimension==1
 
@@ -688,7 +688,7 @@ void GridOut::write_gnuplot (const Triangulation<dim> &tria,
   
   
   AssertThrow (out, ExcIO());
-};
+}
 
 #endif
 
@@ -1111,7 +1111,7 @@ void GridOut::write_eps (const Triangulation<dim> &tria,
   out << "showpage" << std::endl;
   
   AssertThrow (out, ExcIO());
-};
+}
 
 #endif
 
@@ -1142,7 +1142,7 @@ void GridOut::write (const Triangulation<dim> &tria,
     };
 
   Assert (false, ExcInternalError());
-};
+}
 
 
 
index 030a0f2b691488e3082f6a416b81cce33229a8d4..f965a9a715583016be3be62e76afd92816be7941 100644 (file)
@@ -106,7 +106,7 @@ void GridRefinement::refine (Triangulation<dim>   &tria,
   for (unsigned int index=0; index<n_cells; ++cell, ++index)
     if (std::fabs(criteria(index)) >= new_threshold)
       cell->set_refine_flag();
-};
+}
 
 
 
@@ -127,7 +127,7 @@ void GridRefinement::coarsen (Triangulation<dim>   &tria,
     if (std::fabs(criteria(index)) <= threshold)
       if (!cell->refine_flag_set())
         cell->set_coarsen_flag();
-};
+}
 
 
 
@@ -168,7 +168,7 @@ GridRefinement::refine_and_coarsen_fixed_number (Triangulation<dim>   &tria,
          coarsen (tria, criteria, *(tmp.begin() + tmp.size() - coarsen_cells));
        };
     };
-};
+}
 
 
 
@@ -256,7 +256,7 @@ GridRefinement::refine_and_coarsen_fixed_fraction (Triangulation<dim>   &tria,
   
   if (bottom_threshold > *std::min_element(criteria.begin(), criteria.end()))
     coarsen (tria, criteria, bottom_threshold);
-};
+}
 
 
 
@@ -316,7 +316,7 @@ GridRefinement::refine_and_coarsen_optimize (Triangulation<dim>   &tria,
        }
     }
   refine(tria,criteria,criteria(tmp[minArg]));
-};
+}
 
 // explicit instantiations
 template void GridRefinement
index 4eefed489bbbb2c4e42dd83134a0c6e5364ce39f..5ea677f2a0d0197e1e4b525587a4b40593de5a29 100644 (file)
@@ -51,7 +51,7 @@ GridReordering<dim>::Cell::Cell () :
 {
   for (unsigned int i=0; i<GeometryInfo<dim>::faces_per_cell; ++i)
     neighbors[i] = invalid_neighbor;
-};
+}
 
 
 
@@ -62,7 +62,7 @@ GridReordering<dim>::Cell::Cell (const CellData<dim> &cd,
 {
   for (unsigned int i=0; i<GeometryInfo<dim>::faces_per_cell; ++i)
     neighbors[i] = invalid_neighbor;
-};
+}
 
 
 template <int dim>
@@ -89,7 +89,7 @@ unsigned int GridReordering<dim>::Cell::count_neighbors () const
     if (neighbors[i] != invalid_neighbor)
       ++n;
   return n;
-};
+}
 
 
 
@@ -98,7 +98,7 @@ void
 GridReordering<dim>::Cell::insert_faces (std::map<Face,FaceData> &/*global_faces*/)
 {
   Assert (false, ExcNotImplemented());
-};
+}
 
 
 #if deal_II_dimension == 2
@@ -212,7 +212,7 @@ GridReordering<2>::Cell::insert_faces (std::map<Face,FaceData> &global_faces)
          faces[2][face]->second.adjacent_cells[1] = cell_no;
        };
     };
-};
+}
 
 #endif
 
@@ -555,7 +555,7 @@ GridReordering<3>::Cell::insert_faces (std::map<Face,FaceData> &global_faces)
       faces[rot][face] = new_faces_ptr
                         [cell_orientation_faces[rot][face].second]
                         [cell_orientation_faces[rot][face].first];
-};
+}
 
 #endif
 
@@ -580,7 +580,7 @@ void GridReordering<dim>::Cell::fix_cell_neighbors ()
       else
        neighbors[face] = faces[0][face]->second.adjacent_cells[0];
     };
-};
+}
 
 
 
@@ -627,7 +627,7 @@ void GridReordering<dim>::Cell::find_backtracking_point ()
   else
     if (track_back_to_cell == FaceData::invalid_adjacent_cell)
       track_back_to_cell = cell_no-1;
-};
+}
 
 
 
@@ -655,7 +655,7 @@ bool GridReordering<dim>::Cell::check_consistency (const unsigned int rot) const
 
                                   // no conflicts found
   return true;
-};
+}
 
 
 
@@ -669,7 +669,7 @@ void GridReordering<dim>::Cell::mark_faces_used (const unsigned int rot)
              ExcInternalError());
       ++faces[rot][face]->second.use_count;
     };
-};
+}
 
 
 
@@ -683,7 +683,7 @@ void GridReordering<dim>::Cell::mark_faces_unused (const unsigned int rot)
              ExcInternalError());
       --faces[rot][face]->second.use_count;
     };
-};
+}
 
 
 
@@ -707,7 +707,7 @@ bool GridReordering<dim>::Face::operator < (const Face &face) const
 
                                   // if all indices are equal:
   return false;
-};
+}
 
 
 
@@ -718,7 +718,7 @@ bool GridReordering<dim>::Face::operator == (const Face &face) const
     if (vertices[v] != face.vertices[v])
       return false;
   return true;
-};
+}
 
 
 
@@ -727,7 +727,7 @@ GridReordering<dim>::FaceData::FaceData () :
                use_count (0)
 {
   adjacent_cells[0] = adjacent_cells[1] = invalid_adjacent_cell;
-};
+}
 
 
 
@@ -807,7 +807,7 @@ void GridReordering<dim>::track_back (std::vector<Cell> &cells,
                                       // as a goto.
       goto top_of_function;
     };
-};
+}
 
 
 
@@ -923,7 +923,7 @@ bool GridReordering<dim>::try_rotate_single_neighbors (std::vector<Cell> &cells,
                                   // backtracking
 //  cout << "Unsuccessfully tried to rotate neighbors of cell " << cell_no << endl;
   return false;
-};
+}
 
 
 
@@ -1110,7 +1110,7 @@ void GridReordering<dim>::find_reordering (std::vector<Cell>           &cells,
     };
 
 //  cout << "Done!" << endl;
-};
+}
 
 
 
@@ -1265,7 +1265,7 @@ GridReordering<dim>::presort_cells (std::vector<Cell>       &cells,
        i->second.adjacent_cells[k] = new_cell_numbers[i->second.adjacent_cells[k]];
 
   return new_cell_numbers;
-};
+}
 
                      
 
@@ -1330,7 +1330,7 @@ void GridReordering<dim>::reorder_cells (std::vector<CellData<dim> > &original_c
                                   // of
   for (typename std::map<Face,FaceData>::iterator i=faces.begin(); i!=faces.end(); ++i)
     Assert (i->second.use_count == 0, ExcInternalError());
-};
+}
 
 
 
@@ -1341,7 +1341,7 @@ void GridReordering<1>::reorder_cells (std::vector<CellData<1> > &)
 {
                                   // there should not be much to do
                                   // in 1d...
-};
+}
 
 #endif
 
index d7109293f00eab8fbbcc3f4b8929a098d7a653fe..1d0bd53fe1b1261912932c9d5f906817b30bf991 100644 (file)
@@ -70,7 +70,7 @@ GridTools::diameter (const Triangulation<dim> &tria)
     };
 
   return std::sqrt(max_distance_sqr);
-};
+}
 
 
 #else
@@ -88,7 +88,7 @@ GridTools::diameter (const Triangulation<1> &tria)
   while (!rightmost->at_boundary(1)) rightmost = rightmost->neighbor(1);
 
   return std::sqrt((leftmost->vertex(0) - rightmost->vertex(1)).square());
-};
+}
 
 #endif
 
@@ -151,7 +151,7 @@ namespace
     private:
       const double factor;
   };
-};
+}
 
 
 template <int dim>
@@ -160,7 +160,7 @@ GridTools::shift (const Point<dim>   &shift_vector,
                  Triangulation<dim> &triangulation)
 {
   transform (ShiftPoint<dim>(shift_vector), triangulation);
-};
+}
 
 
 #if deal_II_dimension == 2
@@ -170,7 +170,7 @@ GridTools::rotate (const double      angle,
                   Triangulation<2> &triangulation)
 {
   transform (Rotate2d(angle), triangulation);
-};
+}
 
 #endif
 
@@ -182,7 +182,7 @@ GridTools::scale (const double        scaling_factor,
 {
   Assert (scaling_factor>0, ExcScalingFactorNotPositive (scaling_factor));
   transform (ScalePoint<dim>(scaling_factor), triangulation);
-};
+}
 
 
 
index 2b37c41eed1949acc0a232ed1a4228a55fc9d1b5..9b64c079acf88a4d28b37a112e344ebb994358bf 100644 (file)
@@ -40,7 +40,7 @@ get_n_levels (const GridClass &grid)
                                   // of this object, there is a
                                   // specialization of this function
   return grid.get_tria().n_levels();
-};
+}
 
 
 // specialization for grid==tria
@@ -51,7 +51,7 @@ get_n_levels (const Triangulation<dim> &grid)
                                   // if GridClass==Triangulation, then
                                   // we can ask directly.
   return grid.n_levels();
-};
+}
 
 
 template <template <int> class GridClass, int dim>
@@ -107,7 +107,7 @@ void InterGridMap<GridClass,dim>::make_mapping (const GridClass<dim> &source_gri
                                   // are indeed related:
   Assert (dst_cell == destination_grid.end(0),
          ExcIncompatibleGrids ());
-};
+}
 
 
 
@@ -138,7 +138,7 @@ InterGridMap<GridClass,dim>::set_mapping (const cell_iterator &src_cell,
                                   // else (no cell is refined or
                                   // dst_cell is refined): no pointers
                                   // to be set
-};
+}
 
 
 
@@ -156,7 +156,7 @@ InterGridMap<GridClass,dim>::set_entries_to_cell (const cell_iterator &src_cell,
     for (unsigned int c=0; c<GeometryInfo<dim>::children_per_cell; ++c)
       set_entries_to_cell (src_cell->child(c),
                           dst_cell);
-};
+}
 
 
 template <template <int> class GridClass, int dim>
@@ -171,7 +171,7 @@ InterGridMap<GridClass,dim>::operator [] (const cell_iterator &source_cell) cons
          ExcInvalidKey (source_cell));
 
   return mapping[source_cell->level()][source_cell->index()];
-};
+}
 
 
 
@@ -181,7 +181,7 @@ void InterGridMap<GridClass,dim>::clear ()
   mapping.clear ();
   source_grid      = 0;
   destination_grid = 0;
-};
+}
 
 
 
@@ -190,7 +190,7 @@ const GridClass<dim> &
 InterGridMap<GridClass,dim>::get_source_grid () const
 {
   return *source_grid;
-};
+}
 
 
 
@@ -199,7 +199,7 @@ const GridClass<dim> &
 InterGridMap<GridClass,dim>::get_destination_grid () const
 {
   return *destination_grid;
-};
+}
 
 
 
@@ -210,7 +210,7 @@ InterGridMap<GridClass,dim>::memory_consumption () const
   return (MemoryConsumption::memory_consumption (mapping) +
          MemoryConsumption::memory_consumption (source_grid) +
          MemoryConsumption::memory_consumption (destination_grid));
-};
+}
 
 
   
index 6f58c1f41fa5628c0786f3fa83bde406d1ce3049..97d8948e7c5902ac5baa11ed3b6baefd2861f3b1 100644 (file)
@@ -29,7 +29,7 @@ template <int dim>
 PersistentTriangulation<dim>::
 PersistentTriangulation (const Triangulation<dim> &coarse_grid) :
                coarse_grid (&coarse_grid) 
-{};
+{}
 
 
 template <int dim>
@@ -44,12 +44,12 @@ PersistentTriangulation (const PersistentTriangulation<dim> &old_tria) :
   coarsen_flags (old_tria.coarsen_flags)
 {
   Assert (old_tria.n_levels() == 0, ExcTriaNotEmpty ());
-};
+}
 
 
 template <int dim>
 PersistentTriangulation<dim>::~PersistentTriangulation () 
-{};
+{}
 
 
 template <int dim>
@@ -64,7 +64,7 @@ PersistentTriangulation<dim>::execute_coarsening_and_refinement ()
 
                                   // then refine triangulation
   Triangulation<dim>::execute_coarsening_and_refinement ();
-};
+}
 
 
 template <int dim>
@@ -75,7 +75,7 @@ PersistentTriangulation<dim>::restore ()
                                   // refinement sweeps
   for (unsigned int i=0; i<refine_flags.size()+1; ++i) 
     restore(i);
-};
+}
 
 
 template <int dim>
@@ -100,7 +100,7 @@ PersistentTriangulation<dim>::restore (const unsigned int step) {
 
       Triangulation<dim>::execute_coarsening_and_refinement ();
     };
-};
+}
 
 
 
@@ -120,7 +120,7 @@ PersistentTriangulation<dim>::copy_triangulation (const Triangulation<dim> &old_
   coarse_grid  = &old_grid;
   refine_flags.clear ();
   coarsen_flags.clear ();
-};
+}
 
 
 template <int dim>
@@ -130,7 +130,7 @@ PersistentTriangulation<dim>::create_triangulation (const std::vector<Point<dim>
                                                    const SubCellData                 &)
 {
   Assert (false, ExcFunctionNotUseful());
-};
+}
 
 
 template <int dim>
@@ -207,7 +207,7 @@ PersistentTriangulation<dim>::memory_consumption () const
          MemoryConsumption::memory_consumption (coarse_grid) +
          MemoryConsumption::memory_consumption (refine_flags) +
          MemoryConsumption::memory_consumption (coarsen_flags));
-};
+}
 
 
 // explicit instantiations
index 308de12a7c65a8d5d935a214c26589b0e844b2a1..c7aaa74b305f1e03d6a7bce34fc33b7509d6b7ee 100644 (file)
@@ -39,7 +39,7 @@ void
 CellData<1>::rotate (const unsigned int)
 {
   Assert (false, ExcNotPossible());
-};
+}
 
 
 
@@ -57,7 +57,7 @@ CellData<2>::rotate (const unsigned int times)
       vertices[2] = vertices[3];
       vertices[3] = x;
     };
-};
+}
 
 
 
@@ -111,7 +111,7 @@ CellData<3>::rotate (const unsigned int times)
                                   // order
   for (unsigned int i=0; i<GeometryInfo<3>::vertices_per_cell; ++i)
     vertices[i] = old_vertices[rotations[times][i]];
-};
+}
 
 
 
@@ -127,7 +127,7 @@ SubCellData::check_consistency (const unsigned int dim) const
            return (boundary_quads.size() == 0);
     };
   return true;
-};
+}
 
 
 
@@ -164,7 +164,7 @@ TriangulationLevel<0>::reserve_space (const unsigned int total_cells,
                        total_cells*(2*dimension) - neighbors.size(),
                        std::make_pair(-1,-1));
     };
-};
+}
 
 
 
@@ -198,7 +198,7 @@ TriangulationLevel<0>::monitor_memory (const unsigned int true_dimension) const
          ExcMemoryInexact (refine_flags.size(), neighbors.size()));
   Assert (2*true_dimension*coarsen_flags.size() == neighbors.size(),
          ExcMemoryInexact (coarsen_flags.size(), neighbors.size()));
-};
+}
 
 
 
@@ -208,7 +208,7 @@ TriangulationLevel<0>::memory_consumption () const
   return (MemoryConsumption::memory_consumption (refine_flags) +
          MemoryConsumption::memory_consumption (coarsen_flags) +
          MemoryConsumption::memory_consumption (neighbors));
-};
+}
 
 
 
@@ -247,7 +247,7 @@ TriangulationLevel<1>::reserve_space (const unsigned int new_lines)
       lines.user_pointers.insert (lines.user_pointers.end(),
                                  new_size-lines.user_pointers.size(), 0);
     };
-};
+}
 
 
 
@@ -289,7 +289,7 @@ TriangulationLevel<1>::monitor_memory (const unsigned int true_dimension) const
          ExcMemoryInexact (lines.lines.size(), lines.user_pointers.size()));
 
   TriangulationLevel<0>::monitor_memory (true_dimension);
-};
+}
 
 
 
@@ -303,7 +303,7 @@ TriangulationLevel<1>::memory_consumption () const
          MemoryConsumption::memory_consumption (lines.user_flags) +
          MemoryConsumption::memory_consumption (lines.material_id) +
          MemoryConsumption::memory_consumption (lines.user_pointers));
-};
+}
   
 
 
@@ -341,7 +341,7 @@ TriangulationLevel<2>::reserve_space (const unsigned int new_quads)
       quads.user_pointers.insert (quads.user_pointers.end(),
                                  new_size-quads.user_pointers.size(), 0);
     };
-};
+}
 
 
 
@@ -383,7 +383,7 @@ TriangulationLevel<2>::monitor_memory (const unsigned int true_dimension) const
          ExcMemoryInexact (quads.quads.size(), quads.user_pointers.size()));
 
   TriangulationLevel<1>::monitor_memory (true_dimension);
-};
+}
 
 
 
@@ -397,7 +397,7 @@ TriangulationLevel<2>::memory_consumption () const
          MemoryConsumption::memory_consumption (quads.user_flags) +
          MemoryConsumption::memory_consumption (quads.material_id) +
          MemoryConsumption::memory_consumption (quads.user_pointers));
-};
+}
 
 
 
@@ -435,7 +435,7 @@ TriangulationLevel<3>::reserve_space (const unsigned int new_hexes)
       hexes.user_pointers.insert (hexes.user_pointers.end(),
                                  new_size-hexes.user_pointers.size(), 0);
     };
-};
+}
 
 
 
@@ -477,7 +477,7 @@ TriangulationLevel<3>::monitor_memory (const unsigned int true_dimension) const
          ExcMemoryInexact (hexes.hexes.size(), hexes.user_pointers.size()));
 
   TriangulationLevel<2>::monitor_memory (true_dimension);
-};
+}
 
 
 
@@ -491,7 +491,7 @@ TriangulationLevel<3>::memory_consumption () const
          MemoryConsumption::memory_consumption (hexes.user_flags) +
          MemoryConsumption::memory_consumption (hexes.material_id) +
          MemoryConsumption::memory_consumption (hexes.user_pointers));
-};
+}
 
 
 
@@ -500,7 +500,7 @@ TriaNumberCache<1>::TriaNumberCache () :
                n_active_lines (0) 
                                   // all other fields are
                                   // default constructed
-{};
+{}
 
 
 
@@ -511,7 +511,7 @@ TriaNumberCache<1>::memory_consumption () const
          MemoryConsumption::memory_consumption (n_lines_level) +
          MemoryConsumption::memory_consumption (n_active_lines) +
          MemoryConsumption::memory_consumption (n_active_lines_level));
-};
+}
 
 
 TriaNumberCache<2>::TriaNumberCache () :
@@ -519,7 +519,7 @@ TriaNumberCache<2>::TriaNumberCache () :
                n_active_quads (0) 
                                   // all other fields are
                                   // default constructed
-{};
+{}
 
 
 
@@ -531,7 +531,7 @@ TriaNumberCache<2>::memory_consumption () const
          MemoryConsumption::memory_consumption (n_quads_level) +
          MemoryConsumption::memory_consumption (n_active_quads) +
          MemoryConsumption::memory_consumption (n_active_quads_level));
-};
+}
 
 
 
@@ -540,7 +540,7 @@ TriaNumberCache<3>::TriaNumberCache () :
                n_active_hexes (0) 
                                   // all other fields are
                                   // default constructed
-{};
+{}
 
 
 
@@ -552,4 +552,4 @@ TriaNumberCache<3>::memory_consumption () const
          MemoryConsumption::memory_consumption (n_hexes_level) +
          MemoryConsumption::memory_consumption (n_active_hexes) +
          MemoryConsumption::memory_consumption (n_active_hexes_level));
-};
+}
index f451a59391b099bc91667d56072ef7b5c380ca26..f30a89d81bd02ccf641957ee0f4e6396dc448b83 100644 (file)
@@ -35,7 +35,7 @@
 namespace 
 {
   const StraightBoundary<deal_II_dimension> dummy_straight_boundary;
-};
+}
 
 
 template <int dim>
@@ -56,7 +56,7 @@ Triangulation<dim>::Triangulation (const MeshSmoothing smooth_grid) :
       boundary[i] = straight_boundary;
       boundary[i]->subscribe();
     }
-};
+}
 
 
 template <int dim>
@@ -68,7 +68,7 @@ Triangulation<dim>::Triangulation (const Triangulation<dim> &)
                                   // is an error!
 {
   Assert (false, ExcInternalError());
-};
+}
 
 
 template <int dim>
@@ -80,7 +80,7 @@ Triangulation<dim>::~Triangulation ()
 
   for (unsigned int i=0;i<255;++i)
     boundary[i]->unsubscribe ();
-};
+}
 
 
 template <int dim>
@@ -106,7 +106,7 @@ void Triangulation<dim>::clear ()
     };
 
   number_cache = TriaNumberCache<dim>();
-};
+}
 
 
 template <int dim>
@@ -119,7 +119,7 @@ Triangulation<dim>::set_boundary (const unsigned int number,
   boundary[number]->unsubscribe ();
   boundary[number] = &boundary_object;
   boundary_object.subscribe();
-};
+}
 
 
 template <int dim>
@@ -129,7 +129,7 @@ Triangulation<dim>::get_boundary (const unsigned int number) const
   Assert(number<255, ExcIndexRange(number,0,255));
   
   return *(boundary[number]);
-};
+}
 
 
 /*--------- Put the next functions a bit out-or-order to avoid use before
@@ -140,14 +140,14 @@ template <>
 TriaDimensionInfo<1>::cell_iterator
 Triangulation<1>::begin (const unsigned int level) const {
   return begin_line (level);
-};
+}
 
 
 template <>
 TriaDimensionInfo<1>::raw_cell_iterator
 Triangulation<1>::end () const {
   return end_line ();
-};
+}
 
 #endif
 
@@ -158,14 +158,14 @@ template <>
 TriaDimensionInfo<2>::cell_iterator
 Triangulation<2>::begin (const unsigned int level) const {
   return begin_quad (level);
-};
+}
 
 
 template <>
 TriaDimensionInfo<2>::raw_cell_iterator
 Triangulation<2>::end () const {
   return end_quad ();
-};
+}
 
 #endif
 
@@ -176,14 +176,14 @@ template <>
 TriaDimensionInfo<3>::cell_iterator
 Triangulation<3>::begin (const unsigned int level) const {
   return begin_hex (level);
-};
+}
 
 
 template <>
 TriaDimensionInfo<3>::raw_cell_iterator
 Triangulation<3>::end () const {
   return end_hex ();
-};
+}
 
 #endif
 
@@ -220,7 +220,7 @@ void Triangulation<dim>::copy_triangulation (const Triangulation<dim> &old_tria)
   
                                   // note that we need not copy the
                                   // subscriptor!
-};
+}
 
 
 #if deal_II_dimension == 1
@@ -384,7 +384,7 @@ void Triangulation<1>::create_triangulation (const std::vector<Point<1> >    &v,
 
                                   // re-compute numbers of lines, etc
   update_number_cache ();  
-};
+}
 
 #endif
 
@@ -849,7 +849,7 @@ void Triangulation<2>::create_triangulation (const std::vector<Point<2> >    &v,
 
                                   // re-compute numbers of lines, etc
   update_number_cache ();  
-};
+}
 
 #endif
 
@@ -1646,7 +1646,7 @@ void Triangulation<3>::create_triangulation (const std::vector<Point<3> >    &v,
 
                                   // re-compute numbers of lines, etc
   update_number_cache ();  
-};
+}
 
 #endif
 
@@ -1729,7 +1729,7 @@ void Triangulation<1>::distort_random (const double factor,
                                       // finally move the vertex
       vertices[vertex] += shift_vector;
     };
-};
+}
 
 #endif
 
@@ -1844,7 +1844,7 @@ void Triangulation<dim>::distort_random (const double factor,
            = (cell->face(face)->vertex(0) +
               cell->face(face)->vertex(1)) / 2;
        }
-};
+}
 
 
 
@@ -1859,7 +1859,7 @@ void Triangulation<dim>::set_all_refine_flags ()
       cell->clear_coarsen_flag();
       cell->set_refine_flag ();
     };
-};
+}
 
 
 
@@ -1871,7 +1871,7 @@ void Triangulation<dim>::refine_global (const unsigned int times)
       set_all_refine_flags();
       execute_coarsening_and_refinement ();
     };
-};
+}
 
 
 
@@ -1890,7 +1890,7 @@ void Triangulation<dim>::save_refine_flags (std::vector<bool> &v) const
                       endc = end();
   for (; cell!=endc; ++cell, ++i)
     *i = cell->refine_flag_set();
-};
+}
 
 
 
@@ -1901,7 +1901,7 @@ void Triangulation<dim>::save_refine_flags (std::ostream &out) const
   save_refine_flags (v);
   write_bool_vector (mn_tria_refine_flags_begin, v, mn_tria_refine_flags_end,
                     out);
-};
+}
 
 
 
@@ -1912,7 +1912,7 @@ void Triangulation<dim>::load_refine_flags (std::istream &in)
   read_bool_vector (mn_tria_refine_flags_begin, v, mn_tria_refine_flags_end,
                    in);
   load_refine_flags (v);
-};
+}
 
 
 
@@ -1929,7 +1929,7 @@ void Triangulation<dim>::load_refine_flags (const std::vector<bool> &v)
       cell->set_refine_flag();
     else
       cell->clear_refine_flag();
-};
+}
 
 
 
@@ -1942,7 +1942,7 @@ void Triangulation<dim>::save_coarsen_flags (std::vector<bool> &v) const
                       endc = end();
   for (; cell!=endc; ++cell, ++i)
     *i = cell->coarsen_flag_set();
-};
+}
 
 
 
@@ -1953,7 +1953,7 @@ void Triangulation<dim>::save_coarsen_flags (std::ostream &out) const
   save_coarsen_flags (v);
   write_bool_vector (mn_tria_coarsen_flags_begin, v, mn_tria_coarsen_flags_end,
                     out);
-};
+}
 
 
 
@@ -1964,7 +1964,7 @@ void Triangulation<dim>::load_coarsen_flags (std::istream &in)
   read_bool_vector (mn_tria_coarsen_flags_begin, v, mn_tria_coarsen_flags_end,
                    in);
   load_coarsen_flags (v);
-};
+}
 
 
 
@@ -1981,7 +1981,7 @@ void Triangulation<dim>::load_coarsen_flags (const std::vector<bool> &v)
       cell->set_coarsen_flag();
     else
       cell->clear_coarsen_flag();
-};
+}
 
 
 #if deal_II_dimension == 1
@@ -1993,7 +1993,7 @@ void Triangulation<1>::clear_user_pointers ()
                endc = end();
   for (; cell!=endc; ++cell)
     cell->clear_user_pointer ();
-};
+}
 
 
 
@@ -2004,7 +2004,7 @@ void Triangulation<1>::clear_user_flags ()
                endc = end();
   for (; cell!=endc; ++cell)
     cell->clear_user_flag ();
-};
+}
 
 #endif
 
@@ -2023,7 +2023,7 @@ void Triangulation<2>::clear_user_pointers ()
                endc = end();
   for (; cell!=endc; ++cell)
     cell->clear_user_pointer ();
-};
+}
 
 
 
@@ -2039,7 +2039,7 @@ void Triangulation<2>::clear_user_flags ()
                endc = end();
   for (; cell!=endc; ++cell)
     cell->clear_user_flag ();
-};
+}
 
 
 #endif
@@ -2064,7 +2064,7 @@ void Triangulation<3>::clear_user_pointers ()
                endc = end();
   for (; cell!=endc; ++cell)
     cell->clear_user_pointer ();
-};
+}
 
 
 
@@ -2085,7 +2085,7 @@ void Triangulation<3>::clear_user_flags ()
                endc = end();
   for (; cell!=endc; ++cell)
     cell->clear_user_flag ();
-};
+}
 
 
 #endif
@@ -2104,7 +2104,7 @@ void Triangulation<dim>::save_user_flags (std::ostream &out) const
 
   if (dim >= 4)
     Assert (false, ExcNotImplemented());
-};
+}
 
 
 
@@ -2134,7 +2134,7 @@ void Triangulation<dim>::save_user_flags (std::vector<bool> &v) const
 
   if (dim >= 4)
     Assert (false, ExcNotImplemented());
-};
+}
 
 
 
@@ -2151,7 +2151,7 @@ void Triangulation<dim>::load_user_flags (std::istream &in)
 
   if (dim >= 4)
     Assert (false, ExcNotImplemented());
-};
+}
 
 
 
@@ -2186,7 +2186,7 @@ void Triangulation<dim>::load_user_flags (const std::vector<bool> &v)
 
   if (dim >= 4)
     Assert (false, ExcNotImplemented());
-};
+}
 
 
 
@@ -2199,7 +2199,7 @@ void Triangulation<dim>::save_user_flags_line (std::vector<bool> &v) const
                endl = end_line();
   for (; line!=endl; ++line, ++i)
     *i = line->user_flag_set();
-};
+}
 
 
 
@@ -2210,7 +2210,7 @@ void Triangulation<dim>::save_user_flags_line (std::ostream &out) const
   save_user_flags_line (v);
   write_bool_vector (mn_tria_line_user_flags_begin, v, mn_tria_line_user_flags_end,
                     out);
-};
+}
 
 
 
@@ -2221,7 +2221,7 @@ void Triangulation<dim>::load_user_flags_line (std::istream &in)
   read_bool_vector (mn_tria_line_user_flags_begin, v, mn_tria_line_user_flags_end,
                    in);
   load_user_flags_line (v);
-};
+}
 
 
 
@@ -2238,7 +2238,7 @@ void Triangulation<dim>::load_user_flags_line (const std::vector<bool> &v)
       line->set_user_flag();
     else
       line->clear_user_flag();
-};
+}
 
 
 #if deal_II_dimension == 1
@@ -2247,7 +2247,7 @@ template <>
 void Triangulation<1>::save_user_flags_quad (std::ostream &) const
 {
   Assert (false, ExcFunctionNotUseful());
-};
+}
 
 
 
@@ -2255,7 +2255,7 @@ template <>
 void Triangulation<1>::save_user_flags_quad (std::vector<bool> &) const
 {
   Assert (false, ExcFunctionNotUseful());
-};
+}
 
 
 
@@ -2263,7 +2263,7 @@ template <>
 void Triangulation<1>::load_user_flags_quad (std::istream &)
 {
   Assert (false, ExcFunctionNotUseful());
-};
+}
 
 
 
@@ -2271,7 +2271,7 @@ template <>
 void Triangulation<1>::load_user_flags_quad (const std::vector<bool> &)
 {
   Assert (false, ExcFunctionNotUseful());
-};
+}
 
 
 
@@ -2279,7 +2279,7 @@ template <>
 void Triangulation<1>::save_user_flags_hex (std::ostream &) const
 {
   Assert (false, ExcFunctionNotUseful());
-};
+}
 
 
 
@@ -2287,7 +2287,7 @@ template <>
 void Triangulation<1>::save_user_flags_hex (std::vector<bool> &) const
 {
   Assert (false, ExcFunctionNotUseful());
-};
+}
 
 
 
@@ -2295,7 +2295,7 @@ template <>
 void Triangulation<1>::load_user_flags_hex (std::istream &)
 {
   Assert (false, ExcFunctionNotUseful());
-};
+}
 
 
 
@@ -2303,7 +2303,7 @@ template <>
 void Triangulation<1>::load_user_flags_hex (const std::vector<bool> &)
 {
   Assert (false, ExcFunctionNotUseful());
-};
+}
 
 #endif
 
@@ -2317,7 +2317,7 @@ void Triangulation<dim>::save_user_flags_quad (std::vector<bool> &v) const
                endq = end_quad();
   for (; quad!=endq; ++quad, ++i)
     *i = quad->user_flag_set();
-};
+}
 
 
 
@@ -2328,7 +2328,7 @@ void Triangulation<dim>::save_user_flags_quad (std::ostream &out) const
   save_user_flags_quad (v);
   write_bool_vector (mn_tria_quad_user_flags_begin, v, mn_tria_quad_user_flags_end,
                     out);
-};
+}
 
 
 
@@ -2339,7 +2339,7 @@ void Triangulation<dim>::load_user_flags_quad (std::istream &in)
   read_bool_vector (mn_tria_quad_user_flags_begin, v, mn_tria_quad_user_flags_end,
                    in);
   load_user_flags_quad (v);
-};
+}
 
 
 
@@ -2356,7 +2356,7 @@ void Triangulation<dim>::load_user_flags_quad (const std::vector<bool> &v)
       quad->set_user_flag();
     else
       quad->clear_user_flag();
-};
+}
 
 
 #if deal_II_dimension == 2
@@ -2365,7 +2365,7 @@ template <>
 void Triangulation<2>::save_user_flags_hex (std::ostream &) const
 {
   Assert (false, ExcFunctionNotUseful());
-};
+}
 
 
 
@@ -2373,7 +2373,7 @@ template <>
 void Triangulation<2>::save_user_flags_hex (std::vector<bool> &) const
 {
   Assert (false, ExcFunctionNotUseful());
-};
+}
 
 
 
@@ -2381,7 +2381,7 @@ template <>
 void Triangulation<2>::load_user_flags_hex (std::istream &)
 {
   Assert (false, ExcFunctionNotUseful());
-};
+}
 
 
 
@@ -2389,7 +2389,7 @@ template <>
 void Triangulation<2>::load_user_flags_hex (const std::vector<bool> &)
 {
   Assert (false, ExcFunctionNotUseful());
-};
+}
 
 
 #endif
@@ -2404,7 +2404,7 @@ void Triangulation<dim>::save_user_flags_hex (std::vector<bool> &v) const
              endh = end_hex();
   for (; hex!=endh; ++hex, ++i)
     *i = hex->user_flag_set();
-};
+}
 
 
 
@@ -2415,7 +2415,7 @@ void Triangulation<dim>::save_user_flags_hex (std::ostream &out) const
   save_user_flags_hex (v);
   write_bool_vector (mn_tria_hex_user_flags_begin, v, mn_tria_hex_user_flags_end,
                     out);
-};
+}
 
 
 
@@ -2426,7 +2426,7 @@ void Triangulation<dim>::load_user_flags_hex (std::istream &in)
   read_bool_vector (mn_tria_hex_user_flags_begin, v, mn_tria_hex_user_flags_end,
                    in);
   load_user_flags_hex (v);
-};
+}
 
 
 
@@ -2443,7 +2443,7 @@ void Triangulation<dim>::load_user_flags_hex (const std::vector<bool> &v)
       hex->set_user_flag();
     else
       hex->clear_user_flag();
-};
+}
 
 
 
@@ -2473,7 +2473,7 @@ void Triangulation<dim>::save_user_pointers (std::vector<void *> &v) const
 
   if (dim >= 4)
     Assert (false, ExcNotImplemented());
-};
+}
 
 
 
@@ -2508,7 +2508,7 @@ void Triangulation<dim>::load_user_pointers (const std::vector<void *> &v)
 
   if (dim >= 4)
     Assert (false, ExcNotImplemented());
-};
+}
 
 
 
@@ -2521,7 +2521,7 @@ void Triangulation<dim>::save_user_pointers_line (std::vector<void *> &v) const
                endl = end_line();
   for (; line!=endl; ++line, ++i)
     *i = line->user_pointer();
-};
+}
 
 
 
@@ -2535,7 +2535,7 @@ void Triangulation<dim>::load_user_pointers_line (const std::vector<void *> &v)
   std::vector<void *>::const_iterator i = v.begin();
   for (; line!=endl; ++line, ++i)
     line->set_user_pointer(*i);
-};
+}
 
 
 #if deal_II_dimension == 1
@@ -2545,7 +2545,7 @@ template <>
 void Triangulation<1>::save_user_pointers_quad (std::vector<void *> &) const
 {
   Assert (false, ExcFunctionNotUseful());
-};
+}
 
 
 
@@ -2553,7 +2553,7 @@ template <>
 void Triangulation<1>::load_user_pointers_quad (const std::vector<void *> &)
 {
   Assert (false, ExcFunctionNotUseful());
-};
+}
 
 
 
@@ -2561,7 +2561,7 @@ template <>
 void Triangulation<1>::save_user_pointers_hex (std::vector<void *> &) const
 {
   Assert (false, ExcFunctionNotUseful());
-};
+}
 
 
 
@@ -2569,7 +2569,7 @@ template <>
 void Triangulation<1>::load_user_pointers_hex (const std::vector<void *> &)
 {
   Assert (false, ExcFunctionNotUseful());
-};
+}
 
 #endif
 
@@ -2583,7 +2583,7 @@ void Triangulation<dim>::save_user_pointers_quad (std::vector<void *> &v) const
                endq = end_quad();
   for (; quad!=endq; ++quad, ++i)
     *i = quad->user_pointer();
-};
+}
 
 
 
@@ -2597,7 +2597,7 @@ void Triangulation<dim>::load_user_pointers_quad (const std::vector<void *> &v)
   std::vector<void *>::const_iterator i = v.begin();
   for (; quad!=endq; ++quad, ++i)
     quad->set_user_pointer(*i);
-};
+}
 
 
 #if deal_II_dimension == 2
@@ -2608,7 +2608,7 @@ template <>
 void Triangulation<2>::save_user_pointers_hex (std::vector<void *> &) const
 {
   Assert (false, ExcFunctionNotUseful());
-};
+}
 
 
 
@@ -2616,7 +2616,7 @@ template <>
 void Triangulation<2>::load_user_pointers_hex (const std::vector<void *> &)
 {
   Assert (false, ExcFunctionNotUseful());
-};
+}
 
 
 #endif
@@ -2631,7 +2631,7 @@ void Triangulation<dim>::save_user_pointers_hex (std::vector<void *> &v) const
              endh = end_hex();
   for (; hex!=endh; ++hex, ++i)
     *i = hex->user_pointer();
-};
+}
 
 
 
@@ -2645,7 +2645,7 @@ void Triangulation<dim>::load_user_pointers_hex (const std::vector<void *> &v)
   std::vector<void *>::const_iterator i = v.begin();
   for (; hex!=endh; ++hex, ++i)
     hex->set_user_pointer(*i);
-};
+}
 
 
 
@@ -2659,7 +2659,7 @@ TriaDimensionInfo<1>::raw_cell_iterator
 Triangulation<1>::begin_raw (const unsigned int level) const
 {
   return begin_raw_line (level);
-};
+}
 
 
 
@@ -2668,7 +2668,7 @@ TriaDimensionInfo<1>::active_cell_iterator
 Triangulation<1>::begin_active (const unsigned int level) const
 {
   return begin_active_line (level);
-};
+}
 
 
 
@@ -2677,7 +2677,7 @@ TriaDimensionInfo<1>::raw_cell_iterator
 Triangulation<1>::last_raw () const
 {
   return last_raw_line ();
-};
+}
 
 
 
@@ -2686,7 +2686,7 @@ TriaDimensionInfo<1>::raw_cell_iterator
 Triangulation<1>::last_raw (const unsigned int level) const
 {
   return last_raw_line (level);
-};
+}
 
 
 
@@ -2695,7 +2695,7 @@ TriaDimensionInfo<1>::cell_iterator
 Triangulation<1>::last () const
 {
   return last_line ();
-};
+}
 
 
 
@@ -2704,7 +2704,7 @@ TriaDimensionInfo<1>::cell_iterator
 Triangulation<1>::last (const unsigned int level) const
 {
   return last_line (level);
-};
+}
 
 
 
@@ -2713,7 +2713,7 @@ TriaDimensionInfo<1>::active_cell_iterator
 Triangulation<1>::last_active () const
 {
   return last_active_line ();
-};
+}
 
 
 
@@ -2722,7 +2722,7 @@ TriaDimensionInfo<1>::active_cell_iterator
 Triangulation<1>::last_active (const unsigned int level) const
 {
   return last_active_line (level);
-};
+}
 
 
 
@@ -2732,7 +2732,7 @@ Triangulation<1>::begin_raw_face (const unsigned int) const
 {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 
@@ -2742,7 +2742,7 @@ Triangulation<1>::begin_face (const unsigned int) const
 {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 
@@ -2752,7 +2752,7 @@ Triangulation<1>::begin_active_face (const unsigned int) const
 {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 
@@ -2762,7 +2762,7 @@ Triangulation<1>::end_face () const
 {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 
@@ -2772,7 +2772,7 @@ Triangulation<1>::last_raw_face () const
 {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 
@@ -2782,7 +2782,7 @@ Triangulation<1>::last_raw_face (const unsigned int) const
 {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 
@@ -2792,7 +2792,7 @@ Triangulation<1>::last_face () const
 {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 
@@ -2802,7 +2802,7 @@ Triangulation<1>::last_face (const unsigned int) const
 {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 
@@ -2812,7 +2812,7 @@ Triangulation<1>::last_active_face () const
 {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 
@@ -2822,7 +2822,7 @@ Triangulation<1>::last_active_face (const unsigned int) const
 {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 
@@ -2832,7 +2832,7 @@ Triangulation<1>::begin_raw_quad (const unsigned int) const
 {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 
@@ -2842,7 +2842,7 @@ Triangulation<1>::begin_quad (const unsigned int) const
 {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 
@@ -2852,7 +2852,7 @@ Triangulation<1>::begin_active_quad (const unsigned int) const
 {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 
@@ -2862,7 +2862,7 @@ Triangulation<1>::end_quad () const
 {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 
@@ -2872,7 +2872,7 @@ Triangulation<1>::last_raw_quad (const unsigned int) const
 {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 
@@ -2882,7 +2882,7 @@ Triangulation<1>::last_raw_quad () const
 {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 
@@ -2892,7 +2892,7 @@ Triangulation<1>::last_quad (const unsigned int) const
 {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 
@@ -2902,7 +2902,7 @@ Triangulation<1>::last_quad () const
 {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 
@@ -2912,7 +2912,7 @@ Triangulation<1>::last_active_quad (const unsigned int) const
 {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 
@@ -2922,7 +2922,7 @@ Triangulation<1>::last_active_quad () const
 {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 
@@ -2932,7 +2932,7 @@ Triangulation<1>::begin_raw_hex (const unsigned int) const
 {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 
@@ -2942,7 +2942,7 @@ Triangulation<1>::begin_hex (const unsigned int) const
 {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 
@@ -2952,7 +2952,7 @@ Triangulation<1>::begin_active_hex (const unsigned int) const
 {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 
@@ -2962,7 +2962,7 @@ Triangulation<1>::end_hex () const
 {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 
@@ -2972,7 +2972,7 @@ Triangulation<1>::last_raw_hex (const unsigned int) const
 {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 
@@ -2982,7 +2982,7 @@ Triangulation<1>::last_raw_hex () const
 {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 
@@ -2992,7 +2992,7 @@ Triangulation<1>::last_hex (const unsigned int) const
 {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 
@@ -3002,7 +3002,7 @@ Triangulation<1>::last_hex () const
 {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 
@@ -3012,7 +3012,7 @@ Triangulation<1>::last_active_hex (const unsigned int) const
 {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 
@@ -3022,7 +3022,7 @@ Triangulation<1>::last_active_hex () const
 {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 #endif
 
@@ -3034,7 +3034,7 @@ TriaDimensionInfo<2>::raw_cell_iterator
 Triangulation<2>::begin_raw (const unsigned int level) const
 {
   return begin_raw_quad (level);
-};
+}
 
 
 
@@ -3043,7 +3043,7 @@ TriaDimensionInfo<2>::active_cell_iterator
 Triangulation<2>::begin_active (const unsigned int level) const
 {
   return begin_active_quad (level);
-};
+}
 
 
 
@@ -3052,7 +3052,7 @@ TriaDimensionInfo<2>::raw_cell_iterator
 Triangulation<2>::last_raw () const
 {
   return last_raw_quad ();
-};
+}
 
 
 
@@ -3061,7 +3061,7 @@ TriaDimensionInfo<2>::raw_cell_iterator
 Triangulation<2>::last_raw (const unsigned int level) const
 {
   return last_raw_quad (level);
-};
+}
 
 
 
@@ -3070,7 +3070,7 @@ TriaDimensionInfo<2>::cell_iterator
 Triangulation<2>::last () const
 {
   return last_quad ();
-};
+}
 
 
 
@@ -3079,7 +3079,7 @@ TriaDimensionInfo<2>::cell_iterator
 Triangulation<2>::last (const unsigned int level) const
 {
   return last_quad (level);
-};
+}
 
 
 
@@ -3088,7 +3088,7 @@ TriaDimensionInfo<2>::active_cell_iterator
 Triangulation<2>::last_active () const
 {
   return last_active_quad ();
-};
+}
 
 
 
@@ -3097,7 +3097,7 @@ TriaDimensionInfo<2>::active_cell_iterator
 Triangulation<2>::last_active (const unsigned int level) const
 {
   return last_active_quad (level);
-};
+}
 
 
 
@@ -3106,7 +3106,7 @@ TriaDimensionInfo<2>::raw_face_iterator
 Triangulation<2>::begin_raw_face (const unsigned int level) const
 {
   return begin_raw_line (level);
-};
+}
 
 
 
@@ -3115,7 +3115,7 @@ TriaDimensionInfo<2>::face_iterator
 Triangulation<2>::begin_face (const unsigned int level) const
 {
   return begin_line (level);
-};
+}
 
 
 
@@ -3124,7 +3124,7 @@ TriaDimensionInfo<2>::active_face_iterator
 Triangulation<2>::begin_active_face (const unsigned int level) const
 {
   return begin_active_line (level);
-};
+}
 
 
 
@@ -3133,7 +3133,7 @@ TriaDimensionInfo<2>::raw_face_iterator
 Triangulation<2>::end_face () const
 {
   return end_line ();
-};
+}
 
 
 
@@ -3142,7 +3142,7 @@ TriaDimensionInfo<2>::raw_face_iterator
 Triangulation<2>::last_raw_face () const
 {
   return last_raw_line ();
-};
+}
 
 
 
@@ -3151,7 +3151,7 @@ TriaDimensionInfo<2>::raw_face_iterator
 Triangulation<2>::last_raw_face (const unsigned int level) const
 {
   return last_raw_line (level);
-};
+}
 
 
 
@@ -3160,7 +3160,7 @@ TriaDimensionInfo<2>::face_iterator
 Triangulation<2>::last_face () const
 {
   return last_line ();
-};
+}
 
 
 
@@ -3169,7 +3169,7 @@ TriaDimensionInfo<2>::face_iterator
 Triangulation<2>::last_face (const unsigned int level) const
 {
   return last_line (level);
-};
+}
 
 
 
@@ -3178,7 +3178,7 @@ TriaDimensionInfo<2>::active_face_iterator
 Triangulation<2>::last_active_face () const
 {
   return last_active_line ();
-};
+}
 
 
 
@@ -3187,7 +3187,7 @@ TriaDimensionInfo<2>::active_face_iterator
 Triangulation<2>::last_active_face (const unsigned int level) const
 {
   return last_active_line (level);
-};
+}
 
 
 
@@ -3197,7 +3197,7 @@ Triangulation<2>::begin_raw_hex (const unsigned int) const
 {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 
@@ -3207,7 +3207,7 @@ Triangulation<2>::begin_hex (const unsigned int) const
 {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 
@@ -3217,7 +3217,7 @@ Triangulation<2>::begin_active_hex (const unsigned int) const
 {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 
@@ -3227,7 +3227,7 @@ Triangulation<2>::end_hex () const
 {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 
@@ -3237,7 +3237,7 @@ Triangulation<2>::last_raw_hex (const unsigned int) const
 {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 
@@ -3247,7 +3247,7 @@ Triangulation<2>::last_raw_hex () const
 {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 
@@ -3257,7 +3257,7 @@ Triangulation<2>::last_hex (const unsigned int) const
 {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 
@@ -3267,7 +3267,7 @@ Triangulation<2>::last_hex () const
 {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 
@@ -3277,7 +3277,7 @@ Triangulation<2>::last_active_hex (const unsigned int) const
 {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 
 
@@ -3287,7 +3287,7 @@ Triangulation<2>::last_active_hex () const
 {
   Assert (false, ExcFunctionNotUseful());
   return 0;
-};
+}
 
 #endif
 
@@ -3299,7 +3299,7 @@ TriaDimensionInfo<3>::raw_cell_iterator
 Triangulation<3>::begin_raw (const unsigned int level) const
 {
   return begin_raw_hex (level);
-};
+}
 
 
 
@@ -3308,7 +3308,7 @@ TriaDimensionInfo<3>::active_cell_iterator
 Triangulation<3>::begin_active (const unsigned int level) const
 {
   return begin_active_hex (level);
-};
+}
 
 
 
@@ -3317,7 +3317,7 @@ TriaDimensionInfo<3>::raw_cell_iterator
 Triangulation<3>::last_raw () const
 {
   return last_raw_hex ();
-};
+}
 
 
 
@@ -3326,7 +3326,7 @@ TriaDimensionInfo<3>::raw_cell_iterator
 Triangulation<3>::last_raw (const unsigned int level) const
 {
   return last_raw_hex (level);
-};
+}
 
 
 
@@ -3335,7 +3335,7 @@ TriaDimensionInfo<3>::cell_iterator
 Triangulation<3>::last () const
 {
   return last_hex ();
-};
+}
 
 
 
@@ -3344,7 +3344,7 @@ TriaDimensionInfo<3>::cell_iterator
 Triangulation<3>::last (const unsigned int level) const
 {
   return last_hex (level);
-};
+}
 
 
 
@@ -3353,7 +3353,7 @@ TriaDimensionInfo<3>::active_cell_iterator
 Triangulation<3>::last_active () const
 {
   return last_active_hex ();
-};
+}
 
 
 
@@ -3362,7 +3362,7 @@ TriaDimensionInfo<3>::active_cell_iterator
 Triangulation<3>::last_active (const unsigned int level) const
 {
   return last_active_hex (level);
-};
+}
 
 
 
@@ -3371,7 +3371,7 @@ TriaDimensionInfo<3>::raw_face_iterator
 Triangulation<3>::begin_raw_face (const unsigned int level) const
 {
   return begin_raw_quad (level);
-};
+}
 
 
 
@@ -3380,7 +3380,7 @@ TriaDimensionInfo<3>::face_iterator
 Triangulation<3>::begin_face (const unsigned int level) const
 {
   return begin_quad (level);
-};
+}
 
 
 
@@ -3389,7 +3389,7 @@ TriaDimensionInfo<3>::active_face_iterator
 Triangulation<3>::begin_active_face (const unsigned int level) const
 {
   return begin_active_quad (level);
-};
+}
 
 
 
@@ -3398,7 +3398,7 @@ TriaDimensionInfo<3>::raw_face_iterator
 Triangulation<3>::end_face () const
 {
   return end_quad ();
-};
+}
 
 
 
@@ -3407,7 +3407,7 @@ TriaDimensionInfo<3>::raw_face_iterator
 Triangulation<3>::last_raw_face () const
 {
   return last_raw_quad ();
-};
+}
 
 
 
@@ -3416,7 +3416,7 @@ TriaDimensionInfo<3>::raw_face_iterator
 Triangulation<3>::last_raw_face (const unsigned int level) const
 {
   return last_raw_quad (level);
-};
+}
 
 
 
@@ -3425,7 +3425,7 @@ TriaDimensionInfo<3>::face_iterator
 Triangulation<3>::last_face () const
 {
   return last_quad ();
-};
+}
 
 
 
@@ -3434,7 +3434,7 @@ TriaDimensionInfo<3>::face_iterator
 Triangulation<3>::last_face (const unsigned int level) const
 {
   return last_quad (level);
-};
+}
 
 
 
@@ -3443,7 +3443,7 @@ TriaDimensionInfo<3>::active_face_iterator
 Triangulation<3>::last_active_face () const
 {
   return last_active_quad ();
-};
+}
 
 
 
@@ -3452,7 +3452,7 @@ TriaDimensionInfo<3>::active_face_iterator
 Triangulation<3>::last_active_face (const unsigned int level) const
 {
   return last_active_quad (level);
-};
+}
 
 
 #endif
@@ -3470,7 +3470,7 @@ Triangulation<dim>::begin_raw_line (const unsigned int level) const
   return raw_line_iterator (const_cast<Triangulation<dim>*>(this),
                            level,
                            0);
-};
+}
 
 
 
@@ -3486,7 +3486,7 @@ Triangulation<dim>::begin_raw_quad (const unsigned int level) const
   return raw_quad_iterator (const_cast<Triangulation<dim>*>(this),
                            level,
                            0);
-};
+}
 
 
 
@@ -3502,7 +3502,7 @@ Triangulation<dim>::begin_raw_hex (const unsigned int level) const
   return raw_hex_iterator (const_cast<Triangulation<dim>*>(this),
                           level,
                           0);
-};
+}
 
 
 
@@ -3518,7 +3518,7 @@ Triangulation<dim>::begin_line (const unsigned int level) const
     if ((++ri).state() != IteratorState::valid)
       return ri;
   return ri;
-};
+}
 
 
 
@@ -3534,7 +3534,7 @@ Triangulation<dim>::begin_quad (const unsigned int level) const
     if ((++ri).state() != IteratorState::valid)
       return ri;
   return ri;
-};
+}
 
 
 
@@ -3550,7 +3550,7 @@ Triangulation<dim>::begin_hex (const unsigned int level) const
     if ((++ri).state() != IteratorState::valid)
       return ri;
   return ri;
-};
+}
 
 
 
@@ -3566,7 +3566,7 @@ Triangulation<dim>::begin_active_line (const unsigned int level) const
     if ((++i).state() != IteratorState::valid)
       return i;
   return i;
-};
+}
 
 
 
@@ -3582,7 +3582,7 @@ Triangulation<dim>::begin_active_quad (const unsigned int level) const
     if ((++i).state() != IteratorState::valid)
       return i;
   return i;
-};
+}
 
 
 
@@ -3598,7 +3598,7 @@ Triangulation<dim>::begin_active_hex (const unsigned int level) const
     if ((++i).state() != IteratorState::valid)
       return i;
   return i;
-};
+}
 
 
 
@@ -3609,7 +3609,7 @@ Triangulation<dim>::end_line () const
   return raw_line_iterator (const_cast<Triangulation<dim>*>(this),
                            -1,
                            -1);
-};
+}
 
 
 
@@ -3620,7 +3620,7 @@ Triangulation<dim>::end_quad () const
   return raw_quad_iterator (const_cast<Triangulation<dim>*>(this),
                            -1,
                            -1);
-};
+}
 
 
 
@@ -3631,7 +3631,7 @@ Triangulation<dim>::end_hex () const
   return raw_hex_iterator (const_cast<Triangulation<dim>*>(this),
                           -1,
                           -1);
-};
+}
 
 
 
@@ -3646,7 +3646,7 @@ Triangulation<dim>::last_raw_line (const unsigned int level) const
   return raw_line_iterator (const_cast<Triangulation<dim>*>(this),
                            level,
                            levels[level]->lines.lines.size()-1);
-};
+}
 
 
 template <int dim>
@@ -3660,7 +3660,7 @@ Triangulation<dim>::last_raw_quad (const unsigned int level) const {
   return raw_quad_iterator (const_cast<Triangulation<dim>*>(this),
                            level,
                            levels[level]->quads.quads.size()-1);
-};
+}
 
 
 template <int dim>
@@ -3674,28 +3674,28 @@ Triangulation<dim>::last_raw_hex (const unsigned int level) const {
   return raw_hex_iterator (const_cast<Triangulation<dim>*>(this),
                           level,
                           levels[level]->hexes.hexes.size()-1);
-};
+}
 
 
 template <int dim>
 typename TriaDimensionInfo<dim>::raw_line_iterator
 Triangulation<dim>::last_raw_line () const {
   return last_raw_line (levels.size()-1);
-};
+}
 
 
 template <int dim>
 typename TriaDimensionInfo<dim>::raw_quad_iterator
 Triangulation<dim>::last_raw_quad () const {
   return last_raw_quad (levels.size()-1);
-};
+}
 
 
 template <int dim>
 typename TriaDimensionInfo<dim>::raw_hex_iterator
 Triangulation<dim>::last_raw_hex () const {
   return last_raw_hex (levels.size()-1);
-};
+}
 
 
 template <int dim>
@@ -3709,7 +3709,7 @@ Triangulation<dim>::last_line (const unsigned int level) const {
     if (ri->used()==true)
       return ri;
   return ri;
-};
+}
 
 
 template <int dim>
@@ -3723,7 +3723,7 @@ Triangulation<dim>::last_quad (const unsigned int level) const {
     if (ri->used()==true)
       return ri;
   return ri;
-};
+}
 
 
 template <int dim>
@@ -3737,28 +3737,28 @@ Triangulation<dim>::last_hex (const unsigned int level) const {
     if (ri->used()==true)
       return ri;
   return ri;
-};
+}
 
 
 template <int dim>
 typename TriaDimensionInfo<dim>::line_iterator
 Triangulation<dim>::last_line () const {
   return last_line (levels.size()-1);
-};
+}
 
 
 template <int dim>
 typename TriaDimensionInfo<dim>::quad_iterator
 Triangulation<dim>::last_quad () const {
   return last_quad (levels.size()-1);
-};
+}
 
 
 template <int dim>
 typename TriaDimensionInfo<dim>::hex_iterator
 Triangulation<dim>::last_hex () const {
   return last_hex (levels.size()-1);
-};
+}
 
 
 template <int dim>
@@ -3772,7 +3772,7 @@ Triangulation<dim>::last_active_line (const unsigned int level) const {
     if (i->has_children()==false)
       return i;
   return i;
-};
+}
 
 
 template <int dim>
@@ -3786,7 +3786,7 @@ Triangulation<dim>::last_active_quad (const unsigned int level) const {
     if (i->has_children()==false)
       return i;
   return i;
-};
+}
 
 
 template <int dim>
@@ -3800,28 +3800,28 @@ Triangulation<dim>::last_active_hex (const unsigned int level) const {
     if (i->has_children()==false)
       return i;
   return i;
-};
+}
 
 
 template <int dim>
 typename TriaDimensionInfo<dim>::active_line_iterator
 Triangulation<dim>::last_active_line () const {
   return last_active_line (levels.size()-1);
-};
+}
 
 
 template <int dim>
 typename TriaDimensionInfo<dim>::active_quad_iterator
 Triangulation<dim>::last_active_quad () const {
   return last_active_quad (levels.size()-1);
-};
+}
 
 
 template <int dim>
 typename TriaDimensionInfo<dim>::active_hex_iterator
 Triangulation<dim>::last_active_hex () const {
   return last_active_hex (levels.size()-1);
-};
+}
 
 
 template <int dim>
@@ -3830,7 +3830,7 @@ Triangulation<dim>::end_raw (const unsigned int level) const {
   return (level == levels.size()-1 ?
          end() :
          begin_raw (level+1));
-};
+}
 
 
 template <int dim>
@@ -3839,7 +3839,7 @@ Triangulation<dim>::end (const unsigned int level) const {
   return (level == levels.size()-1 ?
          cell_iterator(end()) :
          begin (level+1));
-};
+}
 
 
 template <int dim>
@@ -3848,7 +3848,7 @@ Triangulation<dim>::end_active (const unsigned int level) const {
   return (level == levels.size()-1 ?
          active_cell_iterator(end()) :
          begin_active (level+1));
-};
+}
 
 
 template <int dim>
@@ -3857,7 +3857,7 @@ Triangulation<dim>::end_raw_face (const unsigned int level) const {
   return (level == levels.size()-1 ?
          end_face() :
          begin_raw_face (level+1));
-};
+}
 
 
 template <int dim>
@@ -3866,7 +3866,7 @@ Triangulation<dim>::end_face (const unsigned int level) const {
   return (level == levels.size()-1 ?
          face_iterator(end_face()) :
          begin_face (level+1));
-};
+}
 
 
 template <int dim>
@@ -3875,7 +3875,7 @@ Triangulation<dim>::end_active_face (const unsigned int level) const {
   return (level == levels.size()-1 ?
          active_face_iterator(end_face()) :
          begin_active_face (level+1));
-};
+}
 
 
 template <int dim>
@@ -3884,7 +3884,7 @@ Triangulation<dim>::end_raw_line (const unsigned int level) const {
   return (level == levels.size()-1 ?
          end_line() :
          begin_raw_line (level+1));
-};
+}
 
 
 template <int dim>
@@ -3893,7 +3893,7 @@ Triangulation<dim>::end_line (const unsigned int level) const {
   return (level == levels.size()-1 ?
          line_iterator(end_line()) :
          begin_line (level+1));
-};
+}
 
 
 template <int dim>
@@ -3902,7 +3902,7 @@ Triangulation<dim>::end_active_line (const unsigned int level) const {
   return (level == levels.size()-1 ?
          active_line_iterator(end_line()) :
          begin_active_line (level+1));
-};
+}
 
 
 template <int dim>
@@ -3911,7 +3911,7 @@ Triangulation<dim>::end_raw_quad (const unsigned int level) const {
   return (level == levels.size()-1 ?
          end_quad() :
          begin_raw_quad (level+1));
-};
+}
 
 
 template <int dim>
@@ -3920,7 +3920,7 @@ Triangulation<dim>::end_quad (const unsigned int level) const {
   return (level == levels.size()-1 ?
          quad_iterator(end_quad()) :
          begin_quad (level+1));
-};
+}
 
 
 template <int dim>
@@ -3929,7 +3929,7 @@ Triangulation<dim>::end_active_quad (const unsigned int level) const {
   return (level == levels.size()-1 ?
          active_quad_iterator(end_quad()) :
          begin_active_quad (level+1));
-};
+}
 
 
 template <int dim>
@@ -3938,7 +3938,7 @@ Triangulation<dim>::end_raw_hex (const unsigned int level) const {
   return (level == levels.size()-1 ?
          end_hex() :
          begin_raw_hex (level+1));
-};
+}
 
 
 template <int dim>
@@ -3947,7 +3947,7 @@ Triangulation<dim>::end_hex (const unsigned int level) const {
   return (level == levels.size()-1 ?
          hex_iterator(end_hex()) :
          begin_hex (level+1));
-};
+}
 
 
 template <int dim>
@@ -3956,7 +3956,7 @@ Triangulation<dim>::end_active_hex (const unsigned int level) const {
   return (level == levels.size()-1 ?
          active_hex_iterator(end_hex()) :
          begin_active_hex (level+1));
-};
+}
 
 
 template <int dim>
@@ -3965,7 +3965,7 @@ unsigned int Triangulation<dim>::n_cells () const {
   for (unsigned int l=0; l<levels.size(); ++l)
     n += n_cells (l);
   return n;
-};
+}
 
 
 template <int dim>
@@ -3974,7 +3974,7 @@ unsigned int Triangulation<dim>::n_active_cells () const {
   for (unsigned int l=0; l<levels.size(); ++l)
     n += n_active_cells (l);
   return n;
-};
+}
 
 
 #if deal_II_dimension == 1
@@ -3982,13 +3982,13 @@ unsigned int Triangulation<dim>::n_active_cells () const {
 template <>
 unsigned int Triangulation<1>::n_active_cells (const unsigned int level) const {
   return n_active_lines (level);
-};
+}
 
 
 template <>
 unsigned int Triangulation<1>::n_cells (const unsigned int level) const {
   return n_lines (level);
-};
+}
 
 #endif
 
@@ -3998,13 +3998,13 @@ unsigned int Triangulation<1>::n_cells (const unsigned int level) const {
 template <>
 unsigned int Triangulation<2>::n_cells (const unsigned int level) const {
   return n_quads (level);
-};
+}
 
 
 template <>
 unsigned int Triangulation<2>::n_active_cells (const unsigned int level) const {
   return n_active_quads (level);
-};
+}
 
 #endif
 
@@ -4014,13 +4014,13 @@ unsigned int Triangulation<2>::n_active_cells (const unsigned int level) const {
 template <>
 unsigned int Triangulation<3>::n_cells (const unsigned int level) const {
   return n_hexs (level);
-};
+}
 
 
 template <>
 unsigned int Triangulation<3>::n_active_cells (const unsigned int level) const {
   return n_active_hexs (level);
-};
+}
 
 #endif
 
@@ -4028,7 +4028,7 @@ unsigned int Triangulation<3>::n_active_cells (const unsigned int level) const {
 template <int dim>
 unsigned int Triangulation<dim>::n_lines () const {
   return number_cache.n_lines;
-};
+}
 
 
 template <int dim>
@@ -4037,13 +4037,13 @@ unsigned int Triangulation<dim>::n_lines (const unsigned int level) const {
          ExcIndexRange (level, 0, number_cache.n_lines_level.size()));
   
   return number_cache.n_lines_level[level];
-};
+}
 
 
 template <int dim>
 unsigned int Triangulation<dim>::n_active_lines () const {
   return number_cache.n_active_lines;
-};
+}
 
 
 template <int dim>
@@ -4052,7 +4052,7 @@ unsigned int Triangulation<dim>::n_active_lines (const unsigned int level) const
          ExcIndexRange (level, 0, number_cache.n_lines_level.size()));
   
   return number_cache.n_active_lines_level[level];
-};
+}
 
 
 #if deal_II_dimension == 1
@@ -4061,28 +4061,28 @@ template <>
 unsigned int Triangulation<1>::n_quads () const
 {
   return 0;
-};
+}
 
 
 template <>
 unsigned int Triangulation<1>::n_quads (const unsigned int) const
 {
   return 0;
-};
+}
 
 
 template <>
 unsigned int Triangulation<1>::n_active_quads (const unsigned int) const
 {
   return 0;
-};
+}
 
 
 template <>
 unsigned int Triangulation<1>::n_active_quads () const
 {
   return 0;
-};
+}
 
 
 #endif
@@ -4091,7 +4091,7 @@ unsigned int Triangulation<1>::n_active_quads () const
 template <int dim>
 unsigned int Triangulation<dim>::n_quads () const {
   return number_cache.n_quads;
-};
+}
 
 
 template <int dim>
@@ -4100,13 +4100,13 @@ unsigned int Triangulation<dim>::n_quads (const unsigned int level) const {
          ExcIndexRange (level, 0, number_cache.n_quads_level.size()));
   
   return number_cache.n_quads_level[level];
-};
+}
 
 
 template <int dim>
 unsigned int Triangulation<dim>::n_active_quads () const {
   return number_cache.n_active_quads;
-};
+}
 
 
 template <int dim>
@@ -4115,7 +4115,7 @@ unsigned int Triangulation<dim>::n_active_quads (const unsigned int level) const
          ExcIndexRange (level, 0, number_cache.n_quads_level.size()));
   
   return number_cache.n_active_quads_level[level];
-};
+}
 
 
 #if deal_II_dimension < 3
@@ -4124,7 +4124,7 @@ template <int dim>
 unsigned int Triangulation<dim>::n_hexs () const
 {
   return 0;
-};
+}
 
 
 
@@ -4132,7 +4132,7 @@ template <int dim>
 unsigned int Triangulation<dim>::n_hexs (const unsigned int) const
 {
   return 0;
-};
+}
 
 
 
@@ -4140,7 +4140,7 @@ template <int dim>
 unsigned int Triangulation<dim>::n_active_hexs () const
 {
   return 0;
-};
+}
 
 
 
@@ -4148,7 +4148,7 @@ template <int dim>
 unsigned int Triangulation<dim>::n_active_hexs (const unsigned int) const
 {
   return 0;
-};
+}
 
 
 #else
@@ -4158,7 +4158,7 @@ template <int dim>
 unsigned int Triangulation<dim>::n_hexs () const
 {
   return number_cache.n_hexes;
-};
+}
 
 
 
@@ -4169,7 +4169,7 @@ unsigned int Triangulation<dim>::n_hexs (const unsigned int level) const
          ExcIndexRange (level, 0, number_cache.n_hexes_level.size()));
   
   return number_cache.n_hexes_level[level];
-};
+}
 
 
 
@@ -4177,7 +4177,7 @@ template <int dim>
 unsigned int Triangulation<dim>::n_active_hexs () const
 {
   return number_cache.n_active_hexes;
-};
+}
 
 
 
@@ -4188,7 +4188,7 @@ unsigned int Triangulation<dim>::n_active_hexs (const unsigned int level) const
          ExcIndexRange (level, 0, number_cache.n_hexes_level.size()));
   
   return number_cache.n_active_hexes_level[level];
-};
+}
 
 
 #endif
@@ -4216,7 +4216,7 @@ unsigned int Triangulation<dim>::n_levels () const
   Assert (false, ExcInternalError());
                                   // just to make the compiler happy:
   return 0;
-};
+}
 
 
 
@@ -4225,7 +4225,7 @@ unsigned int
 Triangulation<dim>::n_vertices () const 
 {
   return vertices.size();
-};
+}
 
 
 
@@ -4234,7 +4234,7 @@ const std::vector<Point<dim> > &
 Triangulation<dim>::get_vertices () const 
 {
   return vertices;
-};
+}
 
 
 
@@ -4244,7 +4244,7 @@ Triangulation<dim>::n_used_vertices () const
 {
   return std::count_if (vertices_used.begin(), vertices_used.end(),
                        std::bind2nd (std::equal_to<bool>(), true));
-};
+}
 
 
 
@@ -4253,7 +4253,7 @@ const std::vector<bool> &
 Triangulation<dim>::get_used_vertices () const 
 {
   return vertices_used;
-};
+}
 
 
 #if deal_II_dimension == 1
@@ -4262,7 +4262,7 @@ template <>
 unsigned int Triangulation<1>::max_adjacent_cells () const
 {
   return 2;
-};
+}
 
 #endif
 
@@ -4294,7 +4294,7 @@ unsigned int Triangulation<dim>::max_adjacent_cells () const {
   return std::max (GeometryInfo<dim>::vertices_per_cell,
                   static_cast<unsigned int>(*std::max_element (usage_count.begin(),
                                                                usage_count.end())));
-};
+}
 
 
 
@@ -4304,7 +4304,7 @@ void Triangulation<dim>::execute_coarsening_and_refinement () {
 
   execute_coarsening();
   execute_refinement();
-};
+}
 
 
 #if deal_II_dimension == 1
@@ -4557,7 +4557,7 @@ void Triangulation<1>::execute_refinement () {
   while (cell != endc)
     Assert (!(cell++)->refine_flag_set(), ExcInternalError ());  
 #endif
-};
+}
 
 #endif
 
@@ -5240,7 +5240,7 @@ void Triangulation<2>::execute_refinement () {
   while (cell != endc)
     Assert (!(cell++)->refine_flag_set(), ExcInternalError ());
 #endif
-};
+}
 
 #endif
 
@@ -6636,7 +6636,7 @@ void Triangulation<3>::execute_refinement ()
   while (cell != endc)
     Assert (!(cell++)->refine_flag_set(), ExcInternalError ());
 #endif
-};
+}
 
 
 #endif
@@ -6714,12 +6714,12 @@ void Triangulation<dim>::execute_coarsening ()
   for (cell=begin(); cell!=endc; ++cell)
     Assert (cell->user_flag_set() == false, ExcInternalError());
 #endif
-};
+}
 
 
 template <int dim>
 void Triangulation<dim>::prepare_refinement_dim_dependent () 
-{};
+{}
 
 
 #if deal_II_dimension == 3
@@ -6863,7 +6863,7 @@ void Triangulation<3>::prepare_refinement_dim_dependent ()
          };
     }
   while (mesh_changed == true);
-};
+}
 
 #endif
 
@@ -6988,7 +6988,7 @@ void Triangulation<dim>::fix_coarsen_flags () {
              cell->child(c)->set_coarsen_flag();
            };
       };
-};
+}
 
 
 template <int dim>
@@ -7767,7 +7767,7 @@ bool Triangulation<dim>::prepare_coarsening_and_refinement () {
                                   // the present state
   return ((flags_before[0] != flags_before_loop[0]) ||
          (flags_before[1] != flags_before_loop[1]));
-};
+}
 
 
 #if deal_II_dimension == 1
@@ -7864,7 +7864,7 @@ void Triangulation<1>::delete_children (cell_iterator &cell) {
                                   // delete pointer to children
   cell->set_children (-1);
   cell->clear_user_flag();
-};
+}
 
 #endif
 
@@ -7997,7 +7997,7 @@ void Triangulation<2>::delete_children (cell_iterator &cell) {
                                   // delete pointer to children
   cell->set_children (-1);
   cell->clear_user_flag();
-};
+}
 
 #endif
 
@@ -8344,7 +8344,7 @@ void Triangulation<3>::delete_children (cell_iterator &cell) {
 
        line->clear_children();
       };
-};
+}
 
 #endif
 
@@ -8377,7 +8377,7 @@ void Triangulation<dim>::write_bool_vector (const unsigned int  magic_number1,
   delete[] flags;
 
   AssertThrow (out, ExcIO());
-};
+}
 
 
 template <int dim>
@@ -8412,7 +8412,7 @@ void Triangulation<dim>::read_bool_vector (const unsigned int  magic_number1,
   delete[] flags;
 
   AssertThrow (in, ExcIO());
-};
+}
 
 
 
@@ -8431,7 +8431,7 @@ Triangulation<dim>::memory_consumption () const
   mem += MemoryConsumption::memory_consumption (number_cache);
 
   return mem;
-};
+}
 
   
 
@@ -8482,7 +8482,7 @@ void Triangulation<dim>::update_number_cache_lines ()
                                       // update total number of lines
       number_cache.n_active_lines += number_cache.n_active_lines_level[level];
     };
-};
+}
 
 
 #if deal_II_dimension == 1
@@ -8491,7 +8491,7 @@ template <>
 void Triangulation<1>::update_number_cache_quads () 
 {
   Assert (false, ExcInternalError());
-};
+}
 
 #endif
 
@@ -8543,7 +8543,7 @@ void Triangulation<dim>::update_number_cache_quads ()
                                       // update total number of quads
       number_cache.n_active_quads += number_cache.n_active_quads_level[level];
     };
-};
+}
 
 #endif
 
@@ -8554,7 +8554,7 @@ template <>
 void Triangulation<1>::update_number_cache_hexes () 
 {
   Assert (false, ExcInternalError());
-};
+}
 
 #endif
 
@@ -8565,7 +8565,7 @@ template <>
 void Triangulation<2>::update_number_cache_hexes () 
 {
   Assert (false, ExcInternalError());
-};
+}
 
 #endif
 
@@ -8617,7 +8617,7 @@ void Triangulation<dim>::update_number_cache_hexes ()
                                       // update total number of hexes
       number_cache.n_active_hexes += number_cache.n_active_hexes_level[level];
     };
-};
+}
 
 #endif
 
@@ -8640,7 +8640,7 @@ void Triangulation<dim>::update_number_cache ()
       default:
            Assert (false, ExcInternalError());
     };
-};
+}
 
 
 // explicit instantiations
index 8fea61e02130ebce5239d86f3e0f0ecbd706f901..9073e9ad248cd265543ae921b07e4817b8f6add9 100644 (file)
@@ -29,7 +29,7 @@ template <int dim>
 void TriaObjectAccessor<1, dim>::set (const Line &line) const
 {
   this->tria->levels[this->present_level]->lines.lines[this->present_index] = line;
-};
+}
 
 
 
@@ -38,7 +38,7 @@ int TriaObjectAccessor<1, dim>::vertex_index (const unsigned int i) const
 {
   Assert (i<2, ExcIndexRange(i,0,2));
   return this->tria->levels[this->present_level]->lines.lines[this->present_index].vertex (i);
-};
+}
 
 
 
@@ -47,7 +47,7 @@ Point<dim> &
 TriaObjectAccessor<1, dim>::vertex (const unsigned int i) const
 {
   return const_cast<Point<dim> &> (this->tria->vertices[vertex_index(i)]);
-};
+}
 
 
 
@@ -57,7 +57,7 @@ void TriaObjectAccessor<1, dim>::set_used_flag () const
   Assert (this->state() == IteratorState::valid,
          typename TriaAccessor<dim>::ExcDereferenceInvalidObject());
   this->tria->levels[this->present_level]->lines.used[this->present_index] = true;
-};
+}
 
 
 
@@ -67,7 +67,7 @@ void TriaObjectAccessor<1, dim>::clear_used_flag () const
   Assert (this->state() == IteratorState::valid,
          typename TriaAccessor<dim>::ExcDereferenceInvalidObject());
   this->tria->levels[this->present_level]->lines.used[this->present_index] = false;
-};
+}
 
 
 
@@ -79,7 +79,7 @@ void TriaObjectAccessor<1, dim>::recursively_set_user_flag () const
   if (has_children())
     for (unsigned int c=0; c<2; ++c)
       child(c)->recursively_set_user_flag ();
-};
+}
 
 
 
@@ -91,7 +91,7 @@ void TriaObjectAccessor<1, dim>::recursively_clear_user_flag () const
   if (has_children())
     for (unsigned int c=0; c<2; ++c)
       child(c)->recursively_clear_user_flag ();
-};
+}
 
 
 
@@ -100,7 +100,7 @@ void TriaObjectAccessor<1, dim>::set_user_pointer (void *p) const
 {
   Assert (used(), typename TriaAccessor<dim>::ExcCellNotUsed());
   this->tria->levels[this->present_level]->lines.user_pointers[this->present_index] = p;
-};
+}
 
 
 
@@ -109,7 +109,7 @@ void TriaObjectAccessor<1, dim>::clear_user_pointer () const
 {
   Assert (used(), typename TriaAccessor<dim>::ExcCellNotUsed());
   this->tria->levels[this->present_level]->lines.user_pointers[this->present_index] = 0;
-};
+}
 
 
 
@@ -118,7 +118,7 @@ void * TriaObjectAccessor<1, dim>::user_pointer () const
 {
   Assert (used(), typename TriaAccessor<dim>::ExcCellNotUsed());
   return this->tria->levels[this->present_level]->lines.user_pointers[this->present_index];
-};
+}
 
 
 
@@ -131,7 +131,7 @@ void TriaObjectAccessor<1, dim>::set_children (const int index) const
          typename TriaAccessor<dim>::ExcCantSetChildren(index));
   
   this->tria->levels[this->present_level]->lines.children[this->present_index] = index;
-};
+}
 
 
 
@@ -139,7 +139,7 @@ template <int dim>
 void TriaObjectAccessor<1, dim>::clear_children () const
 {
   set_children (-1);
-};
+}
 
 
 
@@ -150,7 +150,7 @@ unsigned char TriaObjectAccessor<1, dim>::boundary_indicator () const
   Assert (used(), typename TriaAccessor<dim>::ExcCellNotUsed());
 
   return this->tria->levels[this->present_level]->lines.material_id[this->present_index];
-};
+}
 
 
 
@@ -161,7 +161,7 @@ void TriaObjectAccessor<1, dim>::set_boundary_indicator (unsigned char boundary_
   Assert (used(), typename TriaAccessor<dim>::ExcCellNotUsed());
 
   this->tria->levels[this->present_level]->lines.material_id[this->present_index] = boundary_ind;
-};
+}
 
 
 
@@ -171,7 +171,7 @@ bool TriaObjectAccessor<1, dim>::at_boundary () const
                                   // error checking is done
                                   // in boundary_indicator()
   return (boundary_indicator() != 255);
-};
+}
 
 
 
@@ -179,7 +179,7 @@ template <int dim>
 double TriaObjectAccessor<1, dim>::diameter () const
 {
   return std::sqrt((vertex(1)-vertex(0)).square());
-};
+}
 
 
 
@@ -187,7 +187,7 @@ template <int dim>
 Point<dim> TriaObjectAccessor<1, dim>::center () const
 {
   return (vertex(1)+vertex(0))/2.;
-};
+}
 
 
 
@@ -195,7 +195,7 @@ template <int dim>
 Point<dim> TriaObjectAccessor<1, dim>::barycenter () const
 {
   return (vertex(1)+vertex(0))/2.;
-};
+}
 
 
 
@@ -203,7 +203,7 @@ template <int dim>
 double TriaObjectAccessor<1, dim>::measure () const
 {
   return std::sqrt((vertex(1)-vertex(0)).square());
-};
+}
 
 
 
@@ -219,7 +219,7 @@ unsigned int TriaObjectAccessor<1, dim>::number_of_children () const
        sum += child(c)->number_of_children();
       return sum;
     };
-};
+}
 
 
 /*------------------------ Functions: QuadAccessor ---------------------------*/
@@ -228,7 +228,7 @@ template <int dim>
 void TriaObjectAccessor<2, dim>::set (const Quad &quad) const
 {
   this->tria->levels[this->present_level]->quads.quads[this->present_index] = quad;
-};
+}
 
 
 
@@ -239,7 +239,7 @@ int TriaObjectAccessor<2, dim>::vertex_index (const unsigned int corner) const
 
   const int corner_convention[4] = { 0,0,1,1 };
   return line(corner)->vertex_index(corner_convention[corner]);
-};
+}
 
 
 
@@ -248,7 +248,7 @@ Point<dim> &
 TriaObjectAccessor<2, dim>::vertex (const unsigned int i) const
 {
   return const_cast<Point<dim> &> (this->tria->vertices[vertex_index(i)]);
-};
+}
 
 
 
@@ -259,7 +259,7 @@ TriaObjectAccessor<2, dim>::set_used_flag () const
   Assert (this->state() == IteratorState::valid,
          typename TriaAccessor<dim>::ExcDereferenceInvalidObject());
   this->tria->levels[this->present_level]->quads.used[this->present_index] = true;
-};
+}
 
 
 
@@ -269,7 +269,7 @@ void TriaObjectAccessor<2, dim>::clear_used_flag () const
   Assert (this->state() == IteratorState::valid,
          typename TriaAccessor<dim>::ExcDereferenceInvalidObject());
   this->tria->levels[this->present_level]->quads.used[this->present_index] = false;
-};
+}
 
 
 
@@ -281,7 +281,7 @@ void TriaObjectAccessor<2, dim>::recursively_set_user_flag () const
   if (has_children())
     for (unsigned int c=0; c<4; ++c)
       child(c)->recursively_set_user_flag ();
-};
+}
 
 
 
@@ -293,7 +293,7 @@ void TriaObjectAccessor<2, dim>::recursively_clear_user_flag () const
   if (has_children())
     for (unsigned int c=0; c<4; ++c)
       child(c)->recursively_clear_user_flag ();
-};
+}
 
 
 
@@ -302,7 +302,7 @@ void TriaObjectAccessor<2, dim>::set_user_pointer (void *p) const
 {
   Assert (used(), typename TriaAccessor<dim>::ExcCellNotUsed());
   this->tria->levels[this->present_level]->quads.user_pointers[this->present_index] = p;
-};
+}
 
 
 
@@ -311,7 +311,7 @@ void TriaObjectAccessor<2, dim>::clear_user_pointer () const
 {
   Assert (used(), typename TriaAccessor<dim>::ExcCellNotUsed());
   this->tria->levels[this->present_level]->quads.user_pointers[this->present_index] = 0;
-};
+}
 
 
 
@@ -320,7 +320,7 @@ void * TriaObjectAccessor<2, dim>::user_pointer () const
 {
   Assert (used(), typename TriaAccessor<dim>::ExcCellNotUsed());
   return this->tria->levels[this->present_level]->quads.user_pointers[this->present_index];
-};
+}
 
 
 
@@ -334,7 +334,7 @@ void TriaObjectAccessor<2, dim>::set_children (const int index) const
          typename TriaAccessor<dim>::ExcCantSetChildren(index));
 
   this->tria->levels[this->present_level]->quads.children[this->present_index] = index;
-};
+}
 
 
 
@@ -342,7 +342,7 @@ template <int dim>
 void TriaObjectAccessor<2, dim>::clear_children () const
 {
   set_children (-1);
-};
+}
 
 
 
@@ -353,7 +353,7 @@ unsigned char TriaObjectAccessor<2, dim>::boundary_indicator () const
   Assert (used(), typename TriaAccessor<dim>::ExcCellNotUsed());
 
   return this->tria->levels[this->present_level]->quads.material_id[this->present_index];
-};
+}
 
 
 
@@ -364,7 +364,7 @@ void TriaObjectAccessor<2, dim>::set_boundary_indicator (unsigned char boundary_
   Assert (used(), typename TriaAccessor<dim>::ExcCellNotUsed());
 
   this->tria->levels[this->present_level]->quads.material_id[this->present_index] = boundary_ind;
-};
+}
 
 
 
@@ -374,7 +374,7 @@ bool TriaObjectAccessor<2, dim>::at_boundary () const
                                   // error checking is done
                                   // in boundary_indicator()
   return (boundary_indicator() != 255);
-};
+}
 
 
 
@@ -383,7 +383,7 @@ double TriaObjectAccessor<2, dim>::diameter () const
 {
   return std::sqrt(std::max((vertex(2)-vertex(0)).square(),
                            (vertex(3)-vertex(1)).square()));
-};
+}
 
 
 
@@ -391,7 +391,7 @@ template <int dim>
 Point<dim> TriaObjectAccessor<2, dim>::center () const
 {
   return (vertex(0)+vertex(1)+vertex(2)+vertex(3))/4.;
-};
+}
 
 
 #if deal_II_dimension == 2
@@ -469,7 +469,7 @@ Point<2> TriaObjectAccessor<2, 2>::barycenter () const
                     +t42*y[2]-t44*y[1]+t38*y[0]-x[1]*t50+x[0]*t52
                     -x[3]*t54+x[2]*t56+x[3]*t50-x[2]*t52+x[1]*t54-x[0]*t56;
   return Point<2> (t25*t35/3.0, t62*t35/3.0);
-};
+}
 
 
 
@@ -518,7 +518,7 @@ double TriaObjectAccessor<2, 2>::measure () const
 
   return (-x[0]*y[3]/2.0-x[1]*y[0]/2.0+x[2]*y[3]/2.0+x[3]*y[0]/2.0+
          x[0]*y[1]/2.0-x[3]*y[2]/2.0+x[1]*y[2]/2.0-x[2]*y[1]/2.0);
-};
+}
 
 #endif
 
@@ -577,7 +577,7 @@ Point<3> TriaObjectAccessor<2, 3>::barycenter () const
   Assert (false, ExcNotImplemented());
   
   return Point<3> ();
-};
+}
 
 
 
@@ -593,7 +593,7 @@ double TriaObjectAccessor<2, 3>::measure () const
                                   // function above.
   Assert (false, ExcNotImplemented());
   return 0;
-};
+}
 
 #endif
 
@@ -610,7 +610,7 @@ unsigned int TriaObjectAccessor<2, dim>::number_of_children () const
        sum += child(c)->number_of_children();
       return sum;
     };
-};
+}
 
 
 /*------------------------ Functions: TriaObjectAccessor ---------------------------*/
@@ -619,7 +619,7 @@ template <int dim>
 void TriaObjectAccessor<3, dim>::set (const Hexahedron &hex) const
 {
   this->tria->levels[this->present_level]->hexes.hexes[this->present_index] = hex;
-};
+}
 
 
 
@@ -635,7 +635,7 @@ int TriaObjectAccessor<3, dim>::vertex_index (const unsigned int corner) const
     return quad(0)->vertex_index(corner);
   else
     return quad(1)->vertex_index(corner-4);
-};
+}
 
 
 
@@ -644,7 +644,7 @@ Point<dim> &
 TriaObjectAccessor<3, dim>::vertex (const unsigned int i) const
 {
   return const_cast<Point<dim> &> (this->tria->vertices[vertex_index(i)]);
-};
+}
 
 
 
@@ -654,7 +654,7 @@ void TriaObjectAccessor<3, dim>::set_used_flag () const
   Assert (this->state() == IteratorState::valid,
          typename TriaAccessor<dim>::ExcDereferenceInvalidObject());
   this->tria->levels[this->present_level]->hexes.used[this->present_index] = true;
-};
+}
 
 
 
@@ -664,7 +664,7 @@ void TriaObjectAccessor<3, dim>::clear_used_flag () const
   Assert (this->state() == IteratorState::valid,
          typename TriaAccessor<dim>::ExcDereferenceInvalidObject());
   this->tria->levels[this->present_level]->hexes.used[this->present_index] = false;
-};
+}
 
 
 
@@ -676,7 +676,7 @@ void TriaObjectAccessor<3, dim>::recursively_set_user_flag () const
   if (has_children())
     for (unsigned int c=0; c<8; ++c)
       child(c)->recursively_set_user_flag ();
-};
+}
 
 
 
@@ -688,7 +688,7 @@ void TriaObjectAccessor<3, dim>::recursively_clear_user_flag () const
   if (has_children())
     for (unsigned int c=0; c<8; ++c)
       child(c)->recursively_clear_user_flag ();
-};
+}
 
 
 
@@ -697,7 +697,7 @@ void TriaObjectAccessor<3, dim>::set_user_pointer (void *p) const
 {
   Assert (used(), typename TriaAccessor<dim>::ExcCellNotUsed());
   this->tria->levels[this->present_level]->hexes.user_pointers[this->present_index] = p;
-};
+}
 
 
 
@@ -706,7 +706,7 @@ void TriaObjectAccessor<3, dim>::clear_user_pointer () const
 {
   Assert (used(), typename TriaAccessor<dim>::ExcCellNotUsed());
   this->tria->levels[this->present_level]->hexes.user_pointers[this->present_index] = 0;
-};
+}
 
 
 
@@ -715,7 +715,7 @@ void * TriaObjectAccessor<3, dim>::user_pointer () const
 {
   Assert (used(), typename TriaAccessor<dim>::ExcCellNotUsed());
   return this->tria->levels[this->present_level]->hexes.user_pointers[this->present_index];
-};
+}
 
 
 
@@ -728,7 +728,7 @@ void TriaObjectAccessor<3, dim>::set_children (const int index) const
          typename TriaAccessor<dim>::ExcCantSetChildren(index));
 
   this->tria->levels[this->present_level]->hexes.children[this->present_index] = index;
-};
+}
 
 
 
@@ -736,7 +736,7 @@ template <int dim>
 void TriaObjectAccessor<3, dim>::clear_children () const
 {
   set_children (-1);
-};
+}
 
 
 
@@ -747,7 +747,7 @@ unsigned char TriaObjectAccessor<3, dim>::boundary_indicator () const
   Assert (used(), typename TriaAccessor<dim>::ExcCellNotUsed());
 
   return this->tria->levels[this->present_level]->hexes.material_id[this->present_index];
-};
+}
 
 
 
@@ -758,7 +758,7 @@ void TriaObjectAccessor<3, dim>::set_boundary_indicator (unsigned char boundary_
   Assert (used(), typename TriaAccessor<dim>::ExcCellNotUsed());
 
   this->tria->levels[this->present_level]->hexes.material_id[this->present_index] = boundary_ind;
-};
+}
 
 
 
@@ -768,7 +768,7 @@ bool TriaObjectAccessor<3, dim>::at_boundary () const
                                   // error checking is done
                                   // in boundary_indicator()
   return (boundary_indicator() != 255);
-};
+}
 
 
 
@@ -779,7 +779,7 @@ double TriaObjectAccessor<3, dim>::diameter () const
                                      (vertex(7)-vertex(1)).square()),
                             std::max((vertex(4)-vertex(2)).square(),
                                      (vertex(5)-vertex(3)).square()) ));
-};
+}
 
 
 
@@ -788,7 +788,7 @@ Point<dim> TriaObjectAccessor<3, dim>::center () const
 {
   return (vertex(0)+vertex(1)+vertex(2)+vertex(3)+
          vertex(4)+vertex(5)+vertex(6)+vertex(7))/8.;
-};
+}
 
 
 #if deal_II_dimension == 3
@@ -1439,7 +1439,7 @@ Point<3> TriaObjectAccessor<3, 3>::barycenter () const
   const double unknown2 = s1*s2;
 
   return Point<3> (unknown0, unknown1, unknown2);
-};
+}
 
 
 
@@ -1526,7 +1526,7 @@ double TriaObjectAccessor<3, 3>::measure () const
     *x[4]*y[1]/12.0-z[5]*x[4]*y[6]/12.0-x[6]*y[7]*z[3]/12.0-x[4]*y[3]*z[7]/12.0+x
     [4]*y[7]*z[3]/12.0-x[1]*y[5]*z[6]/12.0-y[6]*x[7]*z[4]/12.0-y[1]*x[2]*z[6]/12.0-
     y[2]*x[3]*z[6]/12.0+s2+s1+x[2]*y[0]*z[3]/12.0);
-};
+}
 
 #endif
 
@@ -1544,7 +1544,7 @@ unsigned int TriaObjectAccessor<3, dim>::number_of_children () const
        sum += child(c)->number_of_children();
       return sum;
     };
-};
+}
 
 
 /*------------------------ Functions: CellAccessor<1> -----------------------*/
@@ -1556,7 +1556,7 @@ template <>
 bool CellAccessor<1>::at_boundary () const
 {
   return at_boundary(0) || at_boundary(1);
-};
+}
 
 
 
@@ -1566,7 +1566,7 @@ unsigned char CellAccessor<1>::material_id () const
   Assert (this->used(), TriaAccessor<1>::ExcCellNotUsed());
   return this->tria->levels[this->present_level]
     ->lines.material_id[this->present_index];
-};
+}
 
 
 
@@ -1576,7 +1576,7 @@ void CellAccessor<1>::set_material_id (const unsigned char mat_id) const
   Assert (this->used(), TriaAccessor<1>::ExcCellNotUsed());
   this->tria->levels[this->present_level]->lines.material_id[this->present_index]
     = mat_id;
-};
+}
 
 
 template <>
@@ -1608,7 +1608,7 @@ template <>
 bool CellAccessor<2>::at_boundary () const
 {
   return at_boundary(0) || at_boundary(1) || at_boundary(2) || at_boundary(3);
-};
+}
 
 
 
@@ -1617,7 +1617,7 @@ unsigned char CellAccessor<2>::material_id () const
 {
   Assert (this->used(), TriaAccessor<2>::ExcCellNotUsed());
   return this->tria->levels[this->present_level]->quads.material_id[this->present_index];
-};
+}
 
 
 
@@ -1627,7 +1627,7 @@ void CellAccessor<2>::set_material_id (const unsigned char mat_id) const
   Assert (this->used(), TriaAccessor<2>::ExcCellNotUsed());
   this->tria->levels[this->present_level]->quads.material_id[this->present_index]
     = mat_id;                                           
-};
+}
 
 
 
@@ -1693,7 +1693,7 @@ bool CellAccessor<3>::at_boundary () const
   return (at_boundary(0) || at_boundary(1) ||
          at_boundary(2) || at_boundary(3) ||
          at_boundary(4) || at_boundary(5));
-};
+}
 
 
 
@@ -1702,7 +1702,7 @@ unsigned char CellAccessor<3>::material_id () const
 {
   Assert (this->used(), TriaAccessor<3>::ExcCellNotUsed());
   return this->tria->levels[this->present_level]->hexes.material_id[this->present_index];
-};
+}
 
 
 
@@ -1712,7 +1712,7 @@ void CellAccessor<3>::set_material_id (const unsigned char mat_id) const
   Assert (this->used(), TriaAccessor<3>::ExcCellNotUsed());
   this->tria->levels[this->present_level]->hexes.material_id[this->present_index]
     = mat_id;                                           
-};
+}
 
 
 template <>
@@ -1734,7 +1734,7 @@ unsigned int CellAccessor<dim>::subdomain_id () const
 {
   Assert (this->used(), typename TriaAccessor<dim>::ExcCellNotUsed());
   return this->tria->levels[this->present_level]->subdomain_ids[this->present_index];
-};
+}
 
 
 
@@ -1745,7 +1745,7 @@ CellAccessor<dim>::set_subdomain_id (const unsigned int new_subdomain_id) const
   Assert (this->used(), typename TriaAccessor<dim>::ExcCellNotUsed());
   this->tria->levels[this->present_level]->subdomain_ids[this->present_index]
     = new_subdomain_id;
-};
+}
 
 
 
@@ -1774,7 +1774,7 @@ void CellAccessor<dim>::set_neighbor (const unsigned int i,
        neighbors[this->present_index*GeometryInfo<dim>::faces_per_cell+i].second
        = -1;
     };
-};
+}
 
 
 
@@ -1826,7 +1826,7 @@ unsigned int CellAccessor<dim>::neighbor_of_neighbor (const unsigned int neighbo
       Assert (false, ExcInternalError());
       return static_cast<unsigned int>(-1);
     };
-};
+}
 
 
 
@@ -1891,7 +1891,7 @@ CellAccessor<dim>::neighbor_of_coarser_neighbor (const unsigned int neighbor) co
   Assert (false, ExcInternalError());
   return std::make_pair (static_cast<unsigned int>(-1),
                         static_cast<unsigned int>(-1));
-};
+}
 
 
 
@@ -1903,7 +1903,7 @@ bool CellAccessor<dim>::at_boundary (const unsigned int i) const
          ExcIndexRange (i,0,GeometryInfo<dim>::faces_per_cell));
   
   return (neighbor_index(i) == -1);
-};
+}
 
 
 
@@ -1913,7 +1913,7 @@ template <>
 bool CellAccessor<1>::has_boundary_lines () const
 {
   return at_boundary();
-};
+}
 
 #else
 
@@ -1925,7 +1925,7 @@ bool CellAccessor<dim>::has_boundary_lines () const
       return true;
   
   return false;
-};
+}
 
 #endif
 
index f5b666add7aa1e1ac6479059df49bc36e13ef3f6..68c354c4c2619f5a92c4d12f03cb3f4f23248009 100644 (file)
@@ -26,7 +26,7 @@
 
 template <int dim>
 Boundary<dim>::~Boundary ()
-{};
+{}
 
 
 
@@ -36,7 +36,7 @@ Boundary<dim>::get_new_point_on_quad (const typename Triangulation<dim>::quad_it
 {
   Assert (false, ExcPureVirtualFunctionCalled());
   return Point<dim>();
-};
+}
 
 
 
@@ -47,7 +47,7 @@ get_intermediate_points_on_line (const typename Triangulation<dim>::line_iterato
                                 std::vector<Point<dim> > &) const
 {
   Assert (false, ExcPureVirtualFunctionCalled());
-};
+}
 
 
 
@@ -58,7 +58,7 @@ get_intermediate_points_on_quad (const typename Triangulation<dim>::quad_iterato
                                 std::vector<Point<dim> > &) const
 {
   Assert (false, ExcPureVirtualFunctionCalled());
-};
+}
 
 
 
@@ -69,7 +69,7 @@ get_normals_at_vertices (const typename Triangulation<dim>::face_iterator &,
                         FaceVertexNormals                                &) const
 {
   Assert (false, ExcPureVirtualFunctionCalled());
-};
+}
 
 
 
@@ -78,7 +78,7 @@ get_normals_at_vertices (const typename Triangulation<dim>::face_iterator &,
 
 template <int dim>
 StraightBoundary<dim>::StraightBoundary ()
-{};
+{}
 
 
 
@@ -87,7 +87,7 @@ Point<dim>
 StraightBoundary<dim>::get_new_point_on_line (const typename Triangulation<dim>::line_iterator &line) const 
 {
   return (line->vertex(0) + line->vertex(1)) / 2;
-};
+}
 
 
 #if deal_II_dimension < 3
@@ -98,7 +98,7 @@ StraightBoundary<dim>::get_new_point_on_quad (const typename Triangulation<dim>:
 {
   Assert (false, typename Boundary<dim>::ExcFunctionNotUseful(dim));
   return Point<dim>();
-};
+}
 
 
 #else
@@ -115,7 +115,7 @@ get_new_point_on_quad (const typename Triangulation<dim>::quad_iterator &quad) c
          quad->line(1)->child(0)->vertex(1) +
          quad->line(2)->child(0)->vertex(1) +
          quad->line(3)->child(0)->vertex(1)) / 8;
-};
+}
 
 #endif
 
@@ -152,7 +152,7 @@ get_intermediate_points_on_line (const typename Triangulation<dim>::line_iterato
   
   for (unsigned int i=0; i<n; ++i, x+=dx)
     points[i] = (1-x)*vertices[0] + x*vertices[1];
-};
+}
 
 #endif
 
@@ -214,7 +214,7 @@ get_normals_at_vertices (const Triangulation<1>::face_iterator &,
                         Boundary<1>::FaceVertexNormals &) const
 {
   Assert (false, Boundary<1>::ExcFunctionNotUseful(1));
-};
+}
 
 #endif
 
@@ -233,7 +233,7 @@ get_normals_at_vertices (const Triangulation<2>::face_iterator &face,
                                     // compute normals from tangent
     face_vertex_normals[vertex] = Point<dim>(tangent[1],
                                             -tangent[0]);
-};
+}
 
 #endif
 
@@ -270,7 +270,7 @@ get_normals_at_vertices (const Triangulation<3>::face_iterator &face,
       cross_product (face_vertex_normals[vertex],
                     tangents[0], tangents[1]);
     };
-};
+}
 
 #endif
 
index ca8b11af904678ff2147c0904f0adb9315126569..5128827b0f65887c74686eaad37af0df2be01b5f 100644 (file)
@@ -23,7 +23,7 @@
 template <int dim>
 CylinderBoundary<dim>::CylinderBoundary (const double radius) :
                radius(radius)
-{};
+{}
 
 
 
@@ -42,7 +42,7 @@ CylinderBoundary<dim>::get_new_point_on_line (const typename Triangulation<dim>:
        middle(i) *= f;
     }
   return middle;
-};
+}
 
 
 #if deal_II_dimension >=3
@@ -66,7 +66,7 @@ get_new_point_on_quad (const Triangulation<3>::quad_iterator &quad) const
        middle(i) *= f;
     }
   return middle;
-};
+}
 
 #endif
 
@@ -76,7 +76,7 @@ Point<dim>
 CylinderBoundary<dim>::
 get_new_point_on_quad (const typename Triangulation<dim>::quad_iterator &) const
 {
-  Assert(false, Boundary<dim>::ExcFunctionNotUseful(dim));
+  Assert (false, typename Boundary<dim>::ExcFunctionNotUseful(dim));
   return Point<dim>();
 }
 
@@ -168,7 +168,7 @@ CylinderBoundary<dim>::get_intermediate_points_on_quad (
   const typename Triangulation<dim>::quad_iterator &,
   std::vector<Point<dim> > &) const
 {
-  Assert(false, Boundary<dim>::ExcFunctionNotUseful(dim));
+  Assert (false, typename Boundary<dim>::ExcFunctionNotUseful(dim));
 }
 
 
@@ -182,7 +182,7 @@ get_normals_at_vertices (const Triangulation<1>::face_iterator &,
                         Boundary<1>::FaceVertexNormals &) const
 {
   Assert (false, Boundary<1>::ExcFunctionNotUseful(1));
-};
+}
 
 #endif
 
@@ -198,7 +198,7 @@ get_normals_at_vertices (const typename Triangulation<dim>::face_iterator &face,
       face_vertex_normals[vertex] = face->vertex(vertex);
       face_vertex_normals[vertex][0] = 0.;
     }
-};
+}
 
 
 
@@ -207,7 +207,7 @@ double
 CylinderBoundary<dim>::get_radius () const 
 {
   return radius;
-};
+}
 
 
 //======================================================================//
@@ -216,7 +216,7 @@ template <int dim>
 HyperBallBoundary<dim>::HyperBallBoundary (const Point<dim> p,
                                           const double     radius) :
                center(p), radius(radius), compute_radius_automatically(false)
-{};
+{}
 
 
 
@@ -241,7 +241,7 @@ HyperBallBoundary<dim>::get_new_point_on_line (const typename Triangulation<dim>
   
   middle += center;
   return middle;
-};
+}
 
 
 
@@ -254,7 +254,7 @@ get_new_point_on_quad (const Triangulation<1>::quad_iterator &) const
 {
   Assert (false, ExcInternalError());
   return Point<1>();
-};
+}
 
 #endif
 
@@ -282,7 +282,7 @@ get_new_point_on_quad (const typename Triangulation<dim>::quad_iterator &quad) c
   
   middle += center;
   return middle;
-};
+}
 
 
 #if deal_II_dimension == 1
@@ -430,7 +430,7 @@ HyperBallBoundary<dim>::get_intermediate_points_on_quad (
   const typename Triangulation<dim>::quad_iterator &,
   std::vector<Point<dim> > &) const
 {
-  Assert(false, Boundary<dim>::ExcFunctionNotUseful(dim));
+  Assert(false, typename Boundary<dim>::ExcFunctionNotUseful(dim));
 }
 
 
@@ -444,7 +444,7 @@ get_normals_at_vertices (const Triangulation<1>::face_iterator &,
                         Boundary<1>::FaceVertexNormals &) const
 {
   Assert (false, Boundary<1>::ExcFunctionNotUseful(1));
-};
+}
 
 #endif
 
@@ -457,7 +457,7 @@ get_normals_at_vertices (const typename Triangulation<dim>::face_iterator &face,
 {
   for (unsigned int vertex=0; vertex<GeometryInfo<dim>::vertices_per_face; ++vertex)
     face_vertex_normals[vertex] = face->vertex(vertex)-center;
-};
+}
 
 
 
@@ -466,7 +466,7 @@ Point<dim>
 HyperBallBoundary<dim>::get_center () const 
 {
   return center;
-};
+}
 
 
 
@@ -476,7 +476,7 @@ HyperBallBoundary<dim>::get_radius () const
 {
   Assert(!compute_radius_automatically, ExcRadiusNotSet());
   return radius;
-};
+}
 
 
 /* ---------------------------------------------------------------------- */
@@ -486,7 +486,7 @@ template <int dim>
 HalfHyperBallBoundary<dim>::HalfHyperBallBoundary (const Point<dim> center,
                                                   const double     radius) :
                HyperBallBoundary<dim> (center, radius)
-{};
+{}
 
 
 
@@ -504,7 +504,7 @@ get_new_point_on_line (const typename Triangulation<dim>::line_iterator &line) c
     return line_center;
   else
     return HyperBallBoundary<dim>::get_new_point_on_line (line);
-};
+}
 
 
 
@@ -517,7 +517,7 @@ get_new_point_on_quad (const Triangulation<1>::quad_iterator &) const
 {
   Assert (false, ExcInternalError());
   return Point<1>();
-};
+}
 
 #endif
 
@@ -533,7 +533,7 @@ get_new_point_on_quad (const typename Triangulation<dim>::quad_iterator &quad) c
     return quad_center;
   else
     return HyperBallBoundary<dim>::get_new_point_on_quad (quad);
-};
+}
 
 
 
@@ -552,7 +552,7 @@ get_intermediate_points_on_line (const typename Triangulation<dim>::line_iterato
     return StraightBoundary<dim>::get_intermediate_points_on_line (line, points);
   else
     return HyperBallBoundary<dim>::get_intermediate_points_on_line (line, points);
-};
+}
 
 
 
@@ -571,7 +571,7 @@ get_intermediate_points_on_quad (const typename Triangulation<dim>::quad_iterato
     StraightBoundary<dim>::get_intermediate_points_on_quad (quad, points);
   else
     HyperBallBoundary<dim>::get_intermediate_points_on_quad (quad, points);
-};
+}
 
 
 
@@ -584,7 +584,7 @@ get_intermediate_points_on_quad (const Triangulation<1>::quad_iterator &,
                                 std::vector<Point<1> > &) const
 {
   Assert (false, ExcInternalError());
-};
+}
 
 #endif
 
@@ -598,7 +598,7 @@ get_normals_at_vertices (const Triangulation<1>::face_iterator &,
                         Boundary<1>::FaceVertexNormals &) const
 {
   Assert (false, Boundary<1>::ExcFunctionNotUseful(1));
-};
+}
 
 #endif
 
@@ -618,7 +618,7 @@ get_normals_at_vertices (const typename Triangulation<dim>::face_iterator &face,
     StraightBoundary<dim>::get_normals_at_vertices (face, face_vertex_normals);
   else
     HyperBallBoundary<dim>::get_normals_at_vertices (face, face_vertex_normals);
-};
+}
 
 
 /* ---------------------------------------------------------------------- */
@@ -630,7 +630,7 @@ HyperShellBoundary<dim>::HyperShellBoundary (const Point<dim> &center) :
                HyperBallBoundary<dim>(center, 0.)
 {
   this->compute_radius_automatically=true;
-};
+}
 
 
 /* ---------------------------------------------------------------------- */
@@ -641,7 +641,7 @@ HyperShellBoundary<dim>::HyperShellBoundary (const Point<dim> &center) :
 template <int dim>
 HalfHyperShellBoundary<dim>::HalfHyperShellBoundary (const Point<dim> &center) :
                HyperShellBoundary<dim> (center) 
-{};
+{}
 
 
 
@@ -663,7 +663,7 @@ get_new_point_on_line (const typename Triangulation<dim>::line_iterator &line) c
                                   // inner part of the shell. proceed
                                   // as in the base class
   return HyperShellBoundary<dim>::get_new_point_on_line (line);
-};
+}
 
 
 
@@ -676,7 +676,7 @@ get_new_point_on_quad (const Triangulation<1>::quad_iterator &) const
 {
   Assert (false, ExcInternalError());
   return Point<1>();
-};
+}
 
 #endif
 
@@ -701,7 +701,7 @@ get_new_point_on_quad (const typename Triangulation<dim>::quad_iterator &quad) c
                                   // inner part of the shell. proceed
                                   // as in the base class
   return HyperShellBoundary<dim>::get_new_point_on_quad (quad);
-};
+}
 
 
 
@@ -720,7 +720,7 @@ get_intermediate_points_on_line (const typename Triangulation<dim>::line_iterato
     return StraightBoundary<dim>::get_intermediate_points_on_line (line, points);
   else
     return HyperShellBoundary<dim>::get_intermediate_points_on_line (line, points);
-};
+}
 
 
 
@@ -739,7 +739,7 @@ get_intermediate_points_on_quad (const typename Triangulation<dim>::quad_iterato
     StraightBoundary<dim>::get_intermediate_points_on_quad (quad, points);
   else
     HyperShellBoundary<dim>::get_intermediate_points_on_quad (quad, points);
-};
+}
 
 
 
@@ -752,7 +752,7 @@ get_intermediate_points_on_quad (const Triangulation<1>::quad_iterator &,
                                 std::vector<Point<1> > &) const
 {
   Assert (false, ExcInternalError());
-};
+}
 
 #endif
 
@@ -767,7 +767,7 @@ get_normals_at_vertices (const Triangulation<1>::face_iterator &,
                         Boundary<1>::FaceVertexNormals &) const
 {
   Assert (false, Boundary<1>::ExcFunctionNotUseful(1));
-};
+}
 
 #endif
 
@@ -783,7 +783,7 @@ get_normals_at_vertices (const typename Triangulation<dim>::face_iterator &face,
     StraightBoundary<dim>::get_normals_at_vertices (face, face_vertex_normals);
   else
     HyperShellBoundary<dim>::get_normals_at_vertices (face, face_vertex_normals);
-};
+}
 
 
 
index 2a072db83ae27682c699188d6eeb8619dd81799b..4b12c3807f9daf873a5811993405988bde2182e2 100644 (file)
 
 template <class VECTOR>
 MGTransfer<VECTOR>::~MGTransfer()
-{};
+{}
 
 
 template <class VECTOR>
 MGMatrixBase<VECTOR>::~MGMatrixBase()
-{};
+{}
 
 
 template <class VECTOR>
 MGCoarseGrid<VECTOR>::~MGCoarseGrid()
-{};
+{}
 
 
 // Explicit instantiations
index 7c18a9f7c340caf2cddd22929e4e77a6bfdcf6b2..3ee7698f781044aee1687b05b2d031ce90928585 100644 (file)
@@ -40,56 +40,65 @@ MGDoFObjectAccessor<1, dim>::MGDoFObjectAccessor (const Triangulation<dim> *tria
                                                  const AccessorData       *local_data) :
                MGDoFAccessor<dim> (local_data),
                MGDoFObjectAccessor_Inheritance<1,dim>::BaseClass(tria,level,index,local_data)
-{};
+{}
 
 
 template <int dim>
 unsigned int MGDoFObjectAccessor<1, dim>::mg_dof_index (const unsigned int i) const
 {
-  Assert (this->dof_handler != 0, DoFAccessor<dim>::ExcInvalidObject());
-  Assert (this->mg_dof_handler != 0, DoFAccessor<dim>::ExcInvalidObject());
+  Assert (this->dof_handler != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
+  Assert (this->mg_dof_handler != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
                                   // make sure a FE has been selected
                                   // and enough room was reserved
-  Assert (&this->dof_handler->get_fe() != 0, DoFAccessor<dim>::ExcInvalidObject());
+  Assert (&this->dof_handler->get_fe() != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
   Assert (i<this->dof_handler->get_fe().dofs_per_line,
          ExcIndexRange (i, 0, this->dof_handler->get_fe().dofs_per_line));
 
   return this->mg_dof_handler->mg_levels[this->present_level]
     ->line_dofs[this->present_index*this->dof_handler->get_fe().dofs_per_line+i];
-};
+}
 
 
 template <int dim>
 void MGDoFObjectAccessor<1, dim>::set_mg_dof_index (const unsigned int i,
                                                    const unsigned int index) const
 {
-  Assert (this->dof_handler != 0, DoFAccessor<dim>::ExcInvalidObject());
-  Assert (this->mg_dof_handler != 0, DoFAccessor<dim>::ExcInvalidObject());
+  Assert (this->dof_handler != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
+  Assert (this->mg_dof_handler != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
                                   // make sure a FE has been selected
                                   // and enough room was reserved
-  Assert (&this->dof_handler->get_fe() != 0, DoFAccessor<dim>::ExcInvalidObject());
+  Assert (&this->dof_handler->get_fe() != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
   Assert (i<this->dof_handler->get_fe().dofs_per_line,
          ExcIndexRange (i, 0, this->dof_handler->get_fe().dofs_per_line));
 
   this->mg_dof_handler->mg_levels[this->present_level]
     ->line_dofs[this->present_index*this->dof_handler->get_fe().dofs_per_line+i] = index;
-};
+}
 
 
 template <int dim>
 unsigned int MGDoFObjectAccessor<1, dim>::mg_vertex_dof_index (const unsigned int vertex,
                                                               const unsigned int i) const
 {
-  Assert (this->dof_handler != 0, DoFAccessor<dim>::ExcInvalidObject());
-  Assert (this->mg_dof_handler != 0, DoFAccessor<dim>::ExcInvalidObject());
-  Assert (&this->dof_handler->get_fe() != 0, DoFAccessor<dim>::ExcInvalidObject());
+  Assert (this->dof_handler != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
+  Assert (this->mg_dof_handler != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
+  Assert (&this->dof_handler->get_fe() != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
   Assert (vertex<2, ExcIndexRange (i,0,2));
   Assert (i<this->dof_handler->get_fe().dofs_per_vertex,
          ExcIndexRange (i, 0, this->dof_handler->get_fe().dofs_per_vertex));
 
   return (this->mg_dof_handler->mg_vertex_dofs[this->vertex_index(vertex)]
          .get_index (this->present_level, i, this->dof_handler->get_fe().dofs_per_vertex));
-};
+}
 
 
 template <int dim>
@@ -97,28 +106,34 @@ void MGDoFObjectAccessor<1, dim>::set_mg_vertex_dof_index (const unsigned int ve
                                                           const unsigned int i,
                                                           const unsigned int index) const
 {
-  Assert (this->dof_handler != 0, DoFAccessor<dim>::ExcInvalidObject());
-  Assert (this->mg_dof_handler != 0, DoFAccessor<dim>::ExcInvalidObject());
-  Assert (&this->dof_handler->get_fe() != 0, DoFAccessor<dim>::ExcInvalidObject());
+  Assert (this->dof_handler != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
+  Assert (this->mg_dof_handler != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
+  Assert (&this->dof_handler->get_fe() != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
   Assert (vertex<2, ExcIndexRange (i,0,2));
   Assert (i<this->dof_handler->get_fe().dofs_per_vertex,
          ExcIndexRange (i, 0, this->dof_handler->get_fe().dofs_per_vertex));
 
   this->mg_dof_handler->mg_vertex_dofs[this->vertex_index(vertex)]
     .set_index (this->present_level, i, this->dof_handler->get_fe().dofs_per_vertex, index);
-};
+}
 
 
 template <int dim>
 void
 MGDoFObjectAccessor<1, dim>::get_mg_dof_indices (std::vector<unsigned int> &dof_indices) const
 {
-  Assert (this->dof_handler != 0, DoFAccessor<dim>::ExcInvalidObject());
-  Assert (this->mg_dof_handler != 0, DoFAccessor<dim>::ExcInvalidObject());
-  Assert (&this->dof_handler->get_fe() != 0, DoFAccessor<dim>::ExcInvalidObject());
+  Assert (this->dof_handler != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
+  Assert (this->mg_dof_handler != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
+  Assert (&this->dof_handler->get_fe() != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
   Assert (dof_indices.size() == (2*this->dof_handler->get_fe().dofs_per_vertex +
                                 this->dof_handler->get_fe().dofs_per_line),
-         DoFAccessor<dim>::ExcVectorDoesNotMatch());
+         typename DoFAccessor<dim>::ExcVectorDoesNotMatch());
 
   const unsigned int dofs_per_vertex = this->dof_handler->get_fe().dofs_per_vertex,
                     dofs_per_line   = this->dof_handler->get_fe().dofs_per_line;
@@ -131,7 +146,7 @@ MGDoFObjectAccessor<1, dim>::get_mg_dof_indices (std::vector<unsigned int> &dof_
   
   Assert (next == dof_indices.end(),
          ExcInternalError());
-};
+}
 
 
 template <int dim>
@@ -159,7 +174,7 @@ MGDoFObjectAccessor<1,dim>::get_mg_dof_values (const Vector<number> &values,
   
   Assert (next_dof_value == dof_values.end(),
          ExcInternalError());
-};
+}
 
 
 template <int dim>
@@ -176,7 +191,7 @@ MGDoFObjectAccessor<1, dim>::child (const unsigned int i) const
     Assert (q->used(), typename TriaAccessor<dim>::ExcUnusedCellAsChild());
 #endif
   return q;
-};
+}
 
 
 template <int dim>
@@ -185,7 +200,7 @@ MGDoFObjectAccessor<1, dim>::copy_from (const MGDoFObjectAccessor<1, dim> &a)
 {
   DoFObjectAccessor<1, dim>::copy_from (a);
   this->set_mg_dof_handler (a.mg_dof_handler);
-};
+}
 
 
 /* ------------------------ MGDoFQuadAccessor --------------------------- */
@@ -197,56 +212,65 @@ MGDoFObjectAccessor<2, dim>::MGDoFObjectAccessor (const Triangulation<dim> *tria
                                                  const AccessorData       *local_data) :
                MGDoFAccessor<dim> (local_data),
                MGDoFObjectAccessor_Inheritance<2,dim>::BaseClass(tria,level,index,local_data)
-{};
+{}
 
 
 template <int dim>
 unsigned int MGDoFObjectAccessor<2, dim>::mg_dof_index (const unsigned int i) const
 {
-  Assert (this->dof_handler != 0, DoFAccessor<dim>::ExcInvalidObject());
-  Assert (this->mg_dof_handler != 0, DoFAccessor<dim>::ExcInvalidObject());
+  Assert (this->dof_handler != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
+  Assert (this->mg_dof_handler != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
                                   // make sure a FE has been selected
                                   // and enough room was reserved
-  Assert (&this->dof_handler->get_fe() != 0, DoFAccessor<dim>::ExcInvalidObject());
+  Assert (&this->dof_handler->get_fe() != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
   Assert (i<this->dof_handler->get_fe().dofs_per_quad,
          ExcIndexRange (i, 0, this->dof_handler->get_fe().dofs_per_quad));
 
   return this->mg_dof_handler->mg_levels[this->present_level]
     ->quad_dofs[this->present_index*this->dof_handler->get_fe().dofs_per_quad+i];
-};
+}
 
 
 template <int dim>
 void MGDoFObjectAccessor<2, dim>::set_mg_dof_index (const unsigned int i,
                                                    const unsigned int index) const
 {
-  Assert (this->dof_handler != 0, DoFAccessor<dim>::ExcInvalidObject());
-  Assert (this->mg_dof_handler != 0, DoFAccessor<dim>::ExcInvalidObject());
+  Assert (this->dof_handler != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
+  Assert (this->mg_dof_handler != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
                                   // make sure a FE has been selected
                                   // and enough room was reserved
-  Assert (&this->dof_handler->get_fe() != 0, DoFAccessor<dim>::ExcInvalidObject());
+  Assert (&this->dof_handler->get_fe() != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
   Assert (i<this->dof_handler->get_fe().dofs_per_quad,
          ExcIndexRange (i, 0, this->dof_handler->get_fe().dofs_per_quad));
 
   this->mg_dof_handler->mg_levels[this->present_level]
     ->quad_dofs[this->present_index*this->dof_handler->get_fe().dofs_per_quad+i] = index;
-};
+}
 
 
 template <int dim>
 unsigned int MGDoFObjectAccessor<2, dim>::mg_vertex_dof_index (const unsigned int vertex,
                                                               const unsigned int i) const
 {
-  Assert (this->dof_handler != 0, DoFAccessor<dim>::ExcInvalidObject());
-  Assert (this->mg_dof_handler != 0, DoFAccessor<dim>::ExcInvalidObject());
-  Assert (&this->dof_handler->get_fe() != 0, DoFAccessor<dim>::ExcInvalidObject());
+  Assert (this->dof_handler != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
+  Assert (this->mg_dof_handler != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
+  Assert (&this->dof_handler->get_fe() != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
   Assert (vertex<4, ExcIndexRange (i,0,4));
   Assert (i<this->dof_handler->get_fe().dofs_per_vertex,
          ExcIndexRange (i, 0, this->dof_handler->get_fe().dofs_per_vertex));
   
   return (this->mg_dof_handler->mg_vertex_dofs[this->vertex_index(vertex)]
          .get_index (this->present_level, i, this->dof_handler->get_fe().dofs_per_vertex));
-};
+}
 
 
 template <int dim>
@@ -254,25 +278,31 @@ void MGDoFObjectAccessor<2, dim>::set_mg_vertex_dof_index (const unsigned int ve
                                                           const unsigned int i,
                                                           const unsigned int index) const
 {
-  Assert (this->dof_handler != 0, DoFAccessor<dim>::ExcInvalidObject());
-  Assert (this->mg_dof_handler != 0, DoFAccessor<dim>::ExcInvalidObject());
-  Assert (&this->dof_handler->get_fe() != 0, DoFAccessor<dim>::ExcInvalidObject());
+  Assert (this->dof_handler != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
+  Assert (this->mg_dof_handler != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
+  Assert (&this->dof_handler->get_fe() != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
   Assert (vertex<4, ExcIndexRange (i,0,4));
   Assert (i<this->dof_handler->get_fe().dofs_per_vertex,
          ExcIndexRange (i, 0, this->dof_handler->get_fe().dofs_per_vertex));
 
   this->mg_dof_handler->mg_vertex_dofs[this->vertex_index(vertex)]
     .set_index (this->present_level, i, this->dof_handler->get_fe().dofs_per_vertex, index);
-};
+}
 
 
 template <int dim>
 void
 MGDoFObjectAccessor<2, dim>::get_mg_dof_indices (std::vector<unsigned int> &dof_indices) const
 {
-  Assert (this->dof_handler != 0, DoFAccessor<dim>::ExcInvalidObject());
-  Assert (this->mg_dof_handler != 0, DoFAccessor<dim>::ExcInvalidObject());
-  Assert (&this->dof_handler->get_fe() != 0, DoFAccessor<dim>::ExcInvalidObject());
+  Assert (this->dof_handler != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
+  Assert (this->mg_dof_handler != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
+  Assert (&this->dof_handler->get_fe() != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
   Assert (dof_indices.size() == (4*this->dof_handler->get_fe().dofs_per_vertex +
                                 4*this->dof_handler->get_fe().dofs_per_line +
                                 this->dof_handler->get_fe().dofs_per_quad),
@@ -293,7 +323,7 @@ MGDoFObjectAccessor<2, dim>::get_mg_dof_indices (std::vector<unsigned int> &dof_
   
   Assert (next == dof_indices.end(),
          ExcInternalError());
-};
+}
 
 
 template <int dim>
@@ -325,7 +355,7 @@ MGDoFObjectAccessor<2,dim>::get_mg_dof_values (const Vector<number> &values,
   
   Assert (next_dof_value == dof_values.end(),
          ExcInternalError());
-};
+}
 
 
 template <int dim>
@@ -341,7 +371,7 @@ MGDoFObjectAccessor<2, dim>::line (const unsigned int i) const
       this->line_index (i),
       this->mg_dof_handler
     );
-};
+}
 
 
 template <int dim>
@@ -358,7 +388,7 @@ MGDoFObjectAccessor<2, dim>::child (const unsigned int i) const
     Assert (q->used(), typename TriaAccessor<dim>::ExcUnusedCellAsChild());
 #endif
   return q;
-};
+}
 
 
 template <int dim>
@@ -367,7 +397,7 @@ MGDoFObjectAccessor<2, dim>::copy_from (const MGDoFObjectAccessor<2, dim> &a)
 {
   DoFObjectAccessor<2, dim>::copy_from (a);
   this->set_mg_dof_handler (a.mg_dof_handler);
-};
+}
 
 
 /* ------------------------ MGDoFHexAccessor --------------------------- */
@@ -379,56 +409,65 @@ MGDoFObjectAccessor<3, dim>::MGDoFObjectAccessor (const Triangulation<dim> *tria
                                                  const AccessorData       *local_data) :
                MGDoFAccessor<dim> (local_data),
                MGDoFObjectAccessor_Inheritance<3,dim>::BaseClass(tria,level,index,local_data)
-{};
+{}
 
 
 template <int dim>
 unsigned int MGDoFObjectAccessor<3, dim>::mg_dof_index (const unsigned int i) const
 {
-  Assert (this->dof_handler != 0, DoFAccessor<dim>::ExcInvalidObject());
-  Assert (this->mg_dof_handler != 0, DoFAccessor<dim>::ExcInvalidObject());
+  Assert (this->dof_handler != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
+  Assert (this->mg_dof_handler != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
                                   // make sure a FE has been selected
                                   // and enough room was reserved
-  Assert (&this->dof_handler->get_fe() != 0, DoFAccessor<dim>::ExcInvalidObject());
+  Assert (&this->dof_handler->get_fe() != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
   Assert (i<this->dof_handler->get_fe().dofs_per_hex,
          ExcIndexRange (i, 0, this->dof_handler->get_fe().dofs_per_hex));
 
   return this->mg_dof_handler->mg_levels[this->present_level]
     ->hex_dofs[this->present_index*this->dof_handler->get_fe().dofs_per_hex+i];
-};
+}
 
 
 template <int dim>
 void MGDoFObjectAccessor<3, dim>::set_mg_dof_index (const unsigned int i,
                                                    const unsigned int index) const
 {
-  Assert (this->dof_handler != 0, DoFAccessor<dim>::ExcInvalidObject());
-  Assert (this->mg_dof_handler != 0, DoFAccessor<dim>::ExcInvalidObject());
+  Assert (this->dof_handler != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
+  Assert (this->mg_dof_handler != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
                                   // make sure a FE has been selected
                                   // and enough room was reserved
-  Assert (&this->dof_handler->get_fe() != 0, DoFAccessor<dim>::ExcInvalidObject());
+  Assert (&this->dof_handler->get_fe() != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
   Assert (i<this->dof_handler->get_fe().dofs_per_hex,
          ExcIndexRange (i, 0, this->dof_handler->get_fe().dofs_per_hex));
 
   this->mg_dof_handler->mg_levels[this->present_level]
     ->hex_dofs[this->present_index*this->dof_handler->get_fe().dofs_per_hex+i] = index;
-};
+}
 
 
 template <int dim>
 unsigned int MGDoFObjectAccessor<3, dim>::mg_vertex_dof_index (const unsigned int vertex,
                                                               const unsigned int i) const
 {
-  Assert (this->dof_handler != 0, DoFAccessor<dim>::ExcInvalidObject());
-  Assert (this->mg_dof_handler != 0, DoFAccessor<dim>::ExcInvalidObject());
-  Assert (&this->dof_handler->get_fe() != 0, DoFAccessor<dim>::ExcInvalidObject());
+  Assert (this->dof_handler != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
+  Assert (this->mg_dof_handler != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
+  Assert (&this->dof_handler->get_fe() != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
   Assert (vertex<8, ExcIndexRange (i,0,8));
   Assert (i<this->dof_handler->get_fe().dofs_per_vertex,
          ExcIndexRange (i, 0, this->dof_handler->get_fe().dofs_per_vertex));
   
   return (this->mg_dof_handler->mg_vertex_dofs[this->vertex_index(vertex)]
          .get_index (this->present_level, i, this->dof_handler->get_fe().dofs_per_vertex));
-};
+}
 
 
 template <int dim>
@@ -436,25 +475,31 @@ void MGDoFObjectAccessor<3, dim>::set_mg_vertex_dof_index (const unsigned int ve
                                                           const unsigned int i,
                                                           const unsigned int index) const
 {
-  Assert (this->dof_handler != 0, DoFAccessor<dim>::ExcInvalidObject());
-  Assert (this->mg_dof_handler != 0, DoFAccessor<dim>::ExcInvalidObject());
-  Assert (&this->dof_handler->get_fe() != 0, DoFAccessor<dim>::ExcInvalidObject());
+  Assert (this->dof_handler != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
+  Assert (this->mg_dof_handler != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
+  Assert (&this->dof_handler->get_fe() != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
   Assert (vertex<4, ExcIndexRange (i,0,4));
   Assert (i<this->dof_handler->get_fe().dofs_per_vertex,
          ExcIndexRange (i, 0, this->dof_handler->get_fe().dofs_per_vertex));
 
   this->mg_dof_handler->mg_vertex_dofs[this->vertex_index(vertex)]
     .set_index (this->present_level, i, this->dof_handler->get_fe().dofs_per_vertex, index);
-};
+}
 
 
 template <int dim>
 void
 MGDoFObjectAccessor<3, dim>::get_mg_dof_indices (std::vector<unsigned int> &dof_indices) const
 {
-  Assert (this->dof_handler != 0, DoFAccessor<dim>::ExcInvalidObject());
-  Assert (this->mg_dof_handler != 0, DoFAccessor<dim>::ExcInvalidObject());
-  Assert (&this->dof_handler->get_fe() != 0, DoFAccessor<dim>::ExcInvalidObject());
+  Assert (this->dof_handler != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
+  Assert (this->mg_dof_handler != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
+  Assert (&this->dof_handler->get_fe() != 0,
+         typename DoFAccessor<dim>::ExcInvalidObject());
   Assert (dof_indices.size() == (8*this->dof_handler->get_fe().dofs_per_vertex +
                                 12*this->dof_handler->get_fe().dofs_per_line +
                                 6*this->dof_handler->get_fe().dofs_per_quad +
@@ -480,7 +525,7 @@ MGDoFObjectAccessor<3, dim>::get_mg_dof_indices (std::vector<unsigned int> &dof_
   
   Assert (next == dof_indices.end(),
          ExcInternalError());
-};
+}
 
 
 template <int dim>
@@ -516,7 +561,7 @@ MGDoFObjectAccessor<3,dim>::get_mg_dof_values (const Vector<number> &values,
   
   Assert (next_dof_value == dof_values.end(),
          ExcInternalError());
-};
+}
 
 
 template <int dim>
@@ -531,7 +576,7 @@ MGDoFObjectAccessor<3, dim>::line (const unsigned int i) const {
       this->line_index (i),
       this->mg_dof_handler
     );
-};
+}
 
 
 template <int dim>
@@ -546,7 +591,7 @@ MGDoFObjectAccessor<3, dim>::quad (const unsigned int i) const {
       this->quad_index (i),
       this->mg_dof_handler
     );
-};
+}
 
 
 template <int dim>
@@ -562,7 +607,7 @@ MGDoFObjectAccessor<3, dim>::child (const unsigned int i) const {
     Assert (q->used(), typename TriaAccessor<dim>::ExcUnusedCellAsChild());
 #endif
   return q;
-};
+}
 
 
 template <int dim>
@@ -570,7 +615,7 @@ void
 MGDoFObjectAccessor<3, dim>::copy_from (const MGDoFObjectAccessor<3, dim> &a) {
   DoFObjectAccessor<3, dim>::copy_from (a);
   this->set_mg_dof_handler (a.mg_dof_handler);
-};
+}
 
 
 /*------------------------- Functions: MGDoFCellAccessor -----------------------*/
@@ -588,7 +633,7 @@ MGDoFCellAccessor<dim>::neighbor (const unsigned int i) const {
     Assert (q->used(), typename TriaAccessor<dim>::ExcUnusedCellAsNeighbor());
 #endif
   return q;
-};
+}
 
 
 template <int dim>
@@ -604,7 +649,7 @@ MGDoFCellAccessor<dim>::child (const unsigned int i) const {
     Assert (q->used(), typename TriaAccessor<dim>::ExcUnusedCellAsChild());
 #endif
   return q;
-};
+}
 
 
 #if deal_II_dimension == 1
@@ -615,7 +660,7 @@ MGDoFCellAccessor<1>::face (const unsigned int) const
 {
   Assert (false, ExcNotUsefulForThisDimension());
   return face_iterator();
-};
+}
 
 #endif
 
@@ -627,7 +672,7 @@ MGDoFCellAccessor<2>::face_iterator
 MGDoFCellAccessor<2>::face (const unsigned int i) const
 {
   return this->line(i);
-};
+}
 
 #endif
 
@@ -639,7 +684,7 @@ MGDoFCellAccessor<3>::face_iterator
 MGDoFCellAccessor<3>::face (const unsigned int i) const
 {
   return this->quad(i);
-};
+}
 
 #endif
 
index c0c2b55226ec6f5a612157488e31a5661c36b85b..101e2d872582447992f85a9c42d92befe0b11d10 100644 (file)
@@ -36,7 +36,7 @@ MGDoFHandler<dim>::MGVertexDoFs::MGVertexDoFs () :
                coarsest_level (1<<30),
                finest_level (0),
                indices (0)
-{};
+{}
 
 
 template <int dim>
@@ -55,27 +55,27 @@ void MGDoFHandler<dim>::MGVertexDoFs::init (const unsigned int cl,
 
   for (unsigned int i=0; i<n_levels*dofs_per_vertex; ++i)
     indices[i] = DoFHandler<dim>::invalid_dof_index;
-};
+}
 
 
 template <int dim>
 MGDoFHandler<dim>::MGVertexDoFs::~MGVertexDoFs () {
   delete[] indices;
-};
+}
 
 
 template <int dim>
 inline
 unsigned int MGDoFHandler<dim>::MGVertexDoFs::get_coarsest_level () const {
   return coarsest_level;
-};
+}
 
 
 template <int dim>
 inline
 unsigned int MGDoFHandler<dim>::MGVertexDoFs::get_finest_level () const {
   return finest_level;
-};
+}
 
 
 /* ------------------------ MGDoFHandler ------------------------------------- */
@@ -83,14 +83,14 @@ unsigned int MGDoFHandler<dim>::MGVertexDoFs::get_finest_level () const {
 template <int dim>
 MGDoFHandler<dim>::MGDoFHandler (const Triangulation<dim> &tria) :
                DoFHandler<dim> (tria)
-{};
+{}
 
 
 template <int dim>
 MGDoFHandler<dim>::~MGDoFHandler ()
 {
   clear ();
-};
+}
 
 
 #if deal_II_dimension == 1
@@ -99,70 +99,70 @@ template <>
 MGDoFHandler<1>::raw_cell_iterator
 MGDoFHandler<1>::begin_raw (const unsigned int level) const {
   return begin_raw_line (level);
-};
+}
 
 
 template <>
 MGDoFHandler<1>::cell_iterator
 MGDoFHandler<1>::begin (const unsigned int level) const {
   return begin_line (level);
-};
+}
 
 
 template <>
 MGDoFHandler<1>::active_cell_iterator
 MGDoFHandler<1>::begin_active (const unsigned int level) const {
   return begin_active_line (level);
-};
+}
 
 
 template <>
 MGDoFHandler<1>::raw_cell_iterator
 MGDoFHandler<1>::end () const {
   return end_line ();
-};
+}
 
 
 template <>
 MGDoFHandler<1>::raw_cell_iterator
 MGDoFHandler<1>::last_raw () const {
   return last_raw_line ();
-};
+}
 
 
 template <>
 MGDoFHandler<1>::raw_cell_iterator
 MGDoFHandler<1>::last_raw (const unsigned int level) const {
   return last_raw_line (level);
-};
+}
 
 
 template <>
 MGDoFHandler<1>::cell_iterator
 MGDoFHandler<1>::last () const {
   return last_line ();
-};
+}
 
 
 template <>
 MGDoFHandler<1>::cell_iterator
 MGDoFHandler<1>::last (const unsigned int level) const {
   return last_line (level);
-};
+}
 
 
 template <>
 MGDoFHandler<1>::active_cell_iterator
 MGDoFHandler<1>::last_active () const {
   return last_active_line ();
-};
+}
 
 
 template <>
 MGDoFHandler<1>::active_cell_iterator
 MGDoFHandler<1>::last_active (const unsigned int level) const {
   return last_active_line (level);
-};
+}
 
 
 template <>
@@ -170,7 +170,7 @@ MGDoFDimensionInfo<1>::raw_face_iterator
 MGDoFHandler<1>::begin_raw_face (const unsigned int) const {
   Assert (false, ExcImpossibleInDim(1));
   return 0;
-};
+}
 
 
 template <>
@@ -178,7 +178,7 @@ MGDoFDimensionInfo<1>::face_iterator
 MGDoFHandler<1>::begin_face (const unsigned int) const {
   Assert (false, ExcImpossibleInDim(1));
   return 0;
-};
+}
 
 
 template <>
@@ -186,7 +186,7 @@ MGDoFDimensionInfo<1>::active_face_iterator
 MGDoFHandler<1>::begin_active_face (const unsigned int) const {
   Assert (false, ExcImpossibleInDim(1));
   return 0;
-};
+}
 
 
 template <>
@@ -194,7 +194,7 @@ MGDoFDimensionInfo<1>::raw_face_iterator
 MGDoFHandler<1>::end_face () const {
   Assert (false, ExcImpossibleInDim(1));
   return 0;
-};
+}
 
 
 template <>
@@ -202,7 +202,7 @@ MGDoFDimensionInfo<1>::raw_face_iterator
 MGDoFHandler<1>::last_raw_face () const {
   Assert (false, ExcImpossibleInDim(1));
   return 0;
-};
+}
 
 
 template <>
@@ -210,7 +210,7 @@ MGDoFDimensionInfo<1>::raw_face_iterator
 MGDoFHandler<1>::last_raw_face (const unsigned int) const {
   Assert (false, ExcImpossibleInDim(1));
   return 0;
-};
+}
 
 
 template <>
@@ -218,7 +218,7 @@ MGDoFDimensionInfo<1>::face_iterator
 MGDoFHandler<1>::last_face () const {
   Assert (false, ExcImpossibleInDim(1));
   return 0;
-};
+}
 
 
 template <>
@@ -226,7 +226,7 @@ MGDoFDimensionInfo<1>::face_iterator
 MGDoFHandler<1>::last_face (const unsigned int) const {
   Assert (false, ExcImpossibleInDim(1));
   return 0;
-};
+}
 
 
 template <>
@@ -234,7 +234,7 @@ MGDoFDimensionInfo<1>::active_face_iterator
 MGDoFHandler<1>::last_active_face () const {
   Assert (false, ExcImpossibleInDim(1));
   return 0;
-};
+}
 
 
 template <>
@@ -242,7 +242,7 @@ MGDoFDimensionInfo<1>::active_face_iterator
 MGDoFHandler<1>::last_active_face (const unsigned int) const {
   Assert (false, ExcImpossibleInDim(1));
   return 0;
-};
+}
 
 
 template <>
@@ -250,7 +250,7 @@ MGDoFHandler<1>::raw_quad_iterator
 MGDoFHandler<1>::begin_raw_quad (const unsigned int) const {
   Assert (false, ExcImpossibleInDim(1));
   return 0;
-};
+}
 
 
 template <>
@@ -258,7 +258,7 @@ MGDoFHandler<1>::quad_iterator
 MGDoFHandler<1>::begin_quad (const unsigned int) const {
   Assert (false, ExcImpossibleInDim(1));
   return 0;
-};
+}
 
 
 template <>
@@ -266,7 +266,7 @@ MGDoFHandler<1>::active_quad_iterator
 MGDoFHandler<1>::begin_active_quad (const unsigned int) const {
   Assert (false, ExcImpossibleInDim(1));
   return 0;
-};
+}
 
 
 template <>
@@ -274,7 +274,7 @@ MGDoFHandler<1>::raw_quad_iterator
 MGDoFHandler<1>::end_quad () const {
   Assert (false, ExcImpossibleInDim(1));
   return 0;
-};
+}
 
 
 template <>
@@ -282,7 +282,7 @@ MGDoFHandler<1>::raw_quad_iterator
 MGDoFHandler<1>::last_raw_quad (const unsigned int) const {
   Assert (false, ExcImpossibleInDim(1));
   return 0;
-};
+}
 
 
 template <>
@@ -290,7 +290,7 @@ MGDoFHandler<1>::quad_iterator
 MGDoFHandler<1>::last_quad (const unsigned int) const {
   Assert (false, ExcImpossibleInDim(1));
   return 0;
-};
+}
 
 
 template <>
@@ -298,7 +298,7 @@ MGDoFHandler<1>::active_quad_iterator
 MGDoFHandler<1>::last_active_quad (const unsigned int) const {
   Assert (false, ExcImpossibleInDim(1));
   return 0;
-};
+}
 
 
 template <>
@@ -306,7 +306,7 @@ MGDoFHandler<1>::raw_quad_iterator
 MGDoFHandler<1>::last_raw_quad () const {
   Assert (false, ExcImpossibleInDim(1));
   return 0;
-};
+}
 
 
 template <>
@@ -314,7 +314,7 @@ MGDoFHandler<1>::quad_iterator
 MGDoFHandler<1>::last_quad () const {
   Assert (false, ExcImpossibleInDim(1));
   return 0;
-};
+}
 
 
 template <>
@@ -322,7 +322,7 @@ MGDoFHandler<1>::active_quad_iterator
 MGDoFHandler<1>::last_active_quad () const {
   Assert (false, ExcImpossibleInDim(1));
   return 0;
-};
+}
 
 
 template <>
@@ -330,7 +330,7 @@ MGDoFHandler<1>::raw_hex_iterator
 MGDoFHandler<1>::begin_raw_hex (const unsigned int) const {
   Assert (false, ExcImpossibleInDim(1));
   return 0;
-};
+}
 
 
 template <>
@@ -338,7 +338,7 @@ MGDoFHandler<1>::hex_iterator
 MGDoFHandler<1>::begin_hex (const unsigned int) const {
   Assert (false, ExcImpossibleInDim(1));
   return 0;
-};
+}
 
 
 template <>
@@ -346,7 +346,7 @@ MGDoFHandler<1>::active_hex_iterator
 MGDoFHandler<1>::begin_active_hex (const unsigned int) const {
   Assert (false, ExcImpossibleInDim(1));
   return 0;
-};
+}
 
 
 template <>
@@ -354,7 +354,7 @@ MGDoFHandler<1>::raw_hex_iterator
 MGDoFHandler<1>::end_hex () const {
   Assert (false, ExcImpossibleInDim(1));
   return 0;
-};
+}
 
 
 template <>
@@ -362,7 +362,7 @@ MGDoFHandler<1>::raw_hex_iterator
 MGDoFHandler<1>::last_raw_hex (const unsigned int) const {
   Assert (false, ExcImpossibleInDim(1));
   return 0;
-};
+}
 
 
 template <>
@@ -370,7 +370,7 @@ MGDoFHandler<1>::hex_iterator
 MGDoFHandler<1>::last_hex (const unsigned int) const {
   Assert (false, ExcImpossibleInDim(1));
   return 0;
-};
+}
 
 
 template <>
@@ -378,7 +378,7 @@ MGDoFHandler<1>::active_hex_iterator
 MGDoFHandler<1>::last_active_hex (const unsigned int) const {
   Assert (false, ExcImpossibleInDim(1));
   return 0;
-};
+}
 
 
 template <>
@@ -386,7 +386,7 @@ MGDoFHandler<1>::raw_hex_iterator
 MGDoFHandler<1>::last_raw_hex () const {
   Assert (false, ExcImpossibleInDim(1));
   return 0;
-};
+}
 
 
 template <>
@@ -394,7 +394,7 @@ MGDoFHandler<1>::hex_iterator
 MGDoFHandler<1>::last_hex () const {
   Assert (false, ExcImpossibleInDim(1));
   return 0;
-};
+}
 
 
 template <>
@@ -402,7 +402,7 @@ MGDoFHandler<1>::active_hex_iterator
 MGDoFHandler<1>::last_active_hex () const {
   Assert (false, ExcImpossibleInDim(1));
   return 0;
-};
+}
 
 #endif
 
@@ -413,140 +413,140 @@ template <>
 MGDoFHandler<2>::raw_cell_iterator
 MGDoFHandler<2>::begin_raw (const unsigned int level) const {
   return begin_raw_quad (level);
-};
+}
 
 
 template <>
 MGDoFHandler<2>::cell_iterator
 MGDoFHandler<2>::begin (const unsigned int level) const {
   return begin_quad (level);
-};
+}
 
 
 template <>
 MGDoFHandler<2>::active_cell_iterator
 MGDoFHandler<2>::begin_active (const unsigned int level) const {
   return begin_active_quad (level);
-};
+}
 
 
 template <>
 MGDoFHandler<2>::raw_cell_iterator
 MGDoFHandler<2>::end () const {
   return end_quad ();
-};
+}
 
 
 template <>
 MGDoFHandler<2>::raw_cell_iterator
 MGDoFHandler<2>::last_raw () const {
   return last_raw_quad ();
-};
+}
 
 
 template <>
 MGDoFHandler<2>::raw_cell_iterator
 MGDoFHandler<2>::last_raw (const unsigned int level) const {
   return last_raw_quad (level);
-};
+}
 
 
 template <>
 MGDoFHandler<2>::cell_iterator
 MGDoFHandler<2>::last () const {
   return last_quad ();
-};
+}
 
 
 template <>
 MGDoFHandler<2>::cell_iterator
 MGDoFHandler<2>::last (const unsigned int level) const {
   return last_quad (level);
-};
+}
 
 
 template <>
 MGDoFHandler<2>::active_cell_iterator
 MGDoFHandler<2>::last_active () const {
   return last_active_quad ();
-};
+}
 
 
 template <>
 MGDoFHandler<2>::active_cell_iterator
 MGDoFHandler<2>::last_active (const unsigned int level) const {
   return last_active_quad (level);
-};
+}
 
 
 template <>
 MGDoFDimensionInfo<2>::raw_face_iterator
 MGDoFHandler<2>::begin_raw_face (const unsigned int level) const {
   return begin_raw_line (level);
-};
+}
 
 
 template <>
 MGDoFDimensionInfo<2>::face_iterator
 MGDoFHandler<2>::begin_face (const unsigned int level) const {
   return begin_line (level);
-};
+}
 
 
 template <>
 MGDoFDimensionInfo<2>::active_face_iterator
 MGDoFHandler<2>::begin_active_face (const unsigned int level) const {
   return begin_active_line (level);
-};
+}
 
 
 template <>
 MGDoFDimensionInfo<2>::raw_face_iterator
 MGDoFHandler<2>::end_face () const {
   return end_line ();
-};
+}
 
 
 template <>
 MGDoFDimensionInfo<2>::raw_face_iterator
 MGDoFHandler<2>::last_raw_face () const {
   return last_raw_line ();
-};
+}
 
 
 template <>
 MGDoFDimensionInfo<2>::raw_face_iterator
 MGDoFHandler<2>::last_raw_face (const unsigned int level) const {
   return last_raw_line (level);
-};
+}
 
 
 template <>
 MGDoFDimensionInfo<2>::face_iterator
 MGDoFHandler<2>::last_face () const {
   return last_line ();
-};
+}
 
 
 template <>
 MGDoFDimensionInfo<2>::face_iterator
 MGDoFHandler<2>::last_face (const unsigned int level) const {
   return last_line (level);
-};
+}
 
 
 template <>
 MGDoFDimensionInfo<2>::active_face_iterator
 MGDoFHandler<2>::last_active_face () const {
   return last_active_line ();
-};
+}
 
 
 template <>
 MGDoFDimensionInfo<2>::active_face_iterator
 MGDoFHandler<2>::last_active_face (const unsigned int level) const {
   return last_active_line (level);
-};
+}
 
 
 template <>
@@ -554,7 +554,7 @@ MGDoFHandler<2>::raw_hex_iterator
 MGDoFHandler<2>::begin_raw_hex (const unsigned int) const {
   Assert (false, ExcImpossibleInDim(2));
   return 0;
-};
+}
 
 
 template <>
@@ -562,7 +562,7 @@ MGDoFHandler<2>::hex_iterator
 MGDoFHandler<2>::begin_hex (const unsigned int) const {
   Assert (false, ExcImpossibleInDim(2));
   return 0;
-};
+}
 
 
 template <>
@@ -570,7 +570,7 @@ MGDoFHandler<2>::active_hex_iterator
 MGDoFHandler<2>::begin_active_hex (const unsigned int) const {
   Assert (false, ExcImpossibleInDim(2));
   return 0;
-};
+}
 
 
 template <>
@@ -578,7 +578,7 @@ MGDoFHandler<2>::raw_hex_iterator
 MGDoFHandler<2>::end_hex () const {
   Assert (false, ExcImpossibleInDim(2));
   return 0;
-};
+}
 
 
 template <>
@@ -586,7 +586,7 @@ MGDoFHandler<2>::raw_hex_iterator
 MGDoFHandler<2>::last_raw_hex (const unsigned int) const {
   Assert (false, ExcImpossibleInDim(2));
   return 0;
-};
+}
 
 
 template <>
@@ -594,7 +594,7 @@ MGDoFHandler<2>::hex_iterator
 MGDoFHandler<2>::last_hex (const unsigned int) const {
   Assert (false, ExcImpossibleInDim(2));
   return 0;
-};
+}
 
 
 template <>
@@ -602,7 +602,7 @@ MGDoFHandler<2>::active_hex_iterator
 MGDoFHandler<2>::last_active_hex (const unsigned int) const {
   Assert (false, ExcImpossibleInDim(2));
   return 0;
-};
+}
 
 
 template <>
@@ -610,7 +610,7 @@ MGDoFHandler<2>::raw_hex_iterator
 MGDoFHandler<2>::last_raw_hex () const {
   Assert (false, ExcImpossibleInDim(2));
   return 0;
-};
+}
 
 
 template <>
@@ -618,7 +618,7 @@ MGDoFHandler<2>::hex_iterator
 MGDoFHandler<2>::last_hex () const {
   Assert (false, ExcImpossibleInDim(2));
   return 0;
-};
+}
 
 
 template <>
@@ -626,7 +626,7 @@ MGDoFHandler<2>::active_hex_iterator
 MGDoFHandler<2>::last_active_hex () const {
   Assert (false, ExcImpossibleInDim(2));
   return 0;
-};
+}
 
 
 #endif
@@ -638,140 +638,140 @@ template <>
 MGDoFHandler<3>::raw_cell_iterator
 MGDoFHandler<3>::begin_raw (const unsigned int level) const {
   return begin_raw_hex (level);
-};
+}
 
 
 template <>
 MGDoFHandler<3>::cell_iterator
 MGDoFHandler<3>::begin (const unsigned int level) const {
   return begin_hex (level);
-};
+}
 
 
 template <>
 MGDoFHandler<3>::active_cell_iterator
 MGDoFHandler<3>::begin_active (const unsigned int level) const {
   return begin_active_hex (level);
-};
+}
 
 
 template <>
 MGDoFHandler<3>::raw_cell_iterator
 MGDoFHandler<3>::end () const {
   return end_hex ();
-};
+}
 
 
 template <>
 MGDoFHandler<3>::raw_cell_iterator
 MGDoFHandler<3>::last_raw () const {
   return last_raw_hex ();
-};
+}
 
 
 template <>
 MGDoFHandler<3>::raw_cell_iterator
 MGDoFHandler<3>::last_raw (const unsigned int level) const {
   return last_raw_hex (level);
-};
+}
 
 
 template <>
 MGDoFHandler<3>::cell_iterator
 MGDoFHandler<3>::last () const {
   return last_hex ();
-};
+}
 
 
 template <>
 MGDoFHandler<3>::cell_iterator
 MGDoFHandler<3>::last (const unsigned int level) const {
   return last_hex (level);
-};
+}
 
 
 template <>
 MGDoFHandler<3>::active_cell_iterator
 MGDoFHandler<3>::last_active () const {
   return last_active_hex ();
-};
+}
 
 
 template <>
 MGDoFHandler<3>::active_cell_iterator
 MGDoFHandler<3>::last_active (const unsigned int level) const {
   return last_active_hex (level);
-};
+}
 
 
 template <>
 MGDoFDimensionInfo<3>::raw_face_iterator
 MGDoFHandler<3>::begin_raw_face (const unsigned int level) const {
   return begin_raw_quad (level);
-};
+}
 
 
 template <>
 MGDoFDimensionInfo<3>::face_iterator
 MGDoFHandler<3>::begin_face (const unsigned int level) const {
   return begin_quad (level);
-};
+}
 
 
 template <>
 MGDoFDimensionInfo<3>::active_face_iterator
 MGDoFHandler<3>::begin_active_face (const unsigned int level) const {
   return begin_active_quad (level);
-};
+}
 
 
 template <>
 MGDoFDimensionInfo<3>::raw_face_iterator
 MGDoFHandler<3>::end_face () const {
   return end_quad ();
-};
+}
 
 
 template <>
 MGDoFDimensionInfo<3>::raw_face_iterator
 MGDoFHandler<3>::last_raw_face () const {
   return last_raw_quad ();
-};
+}
 
 
 template <>
 MGDoFDimensionInfo<3>::raw_face_iterator
 MGDoFHandler<3>::last_raw_face (const unsigned int level) const {
   return last_raw_quad (level);
-};
+}
 
 
 template <>
 MGDoFDimensionInfo<3>::face_iterator
 MGDoFHandler<3>::last_face () const {
   return last_quad ();
-};
+}
 
 
 template <>
 MGDoFDimensionInfo<3>::face_iterator
 MGDoFHandler<3>::last_face (const unsigned int level) const {
   return last_quad (level);
-};
+}
 
 
 template <>
 MGDoFDimensionInfo<3>::active_face_iterator
 MGDoFHandler<3>::last_active_face () const {
   return last_active_quad ();
-};
+}
 
 
 template <>
 MGDoFDimensionInfo<3>::active_face_iterator
 MGDoFHandler<3>::last_active_face (const unsigned int level) const {
   return last_active_quad (level);
-};
+}
 
 #endif
 
@@ -783,7 +783,7 @@ MGDoFHandler<dim>::begin_raw_line (const unsigned int level) const {
                            this->tria->begin_raw_line(level)->level(),
                            this->tria->begin_raw_line(level)->index(),
                            this);
-};
+}
 
 
 template <int dim>
@@ -793,7 +793,7 @@ MGDoFHandler<dim>::begin_line (const unsigned int level) const {
                        this->tria->begin_line(level)->level(),
                        this->tria->begin_line(level)->index(),
                        this);
-};
+}
 
 
 template <int dim>
@@ -803,7 +803,7 @@ MGDoFHandler<dim>::begin_active_line (const unsigned int level) const {
                               this->tria->begin_active_line(level)->level(),
                               this->tria->begin_active_line(level)->index(),
                               this);
-};
+}
 
 
 template <int dim>
@@ -813,7 +813,7 @@ MGDoFHandler<dim>::begin_raw_quad (const unsigned int level) const {
                            this->tria->begin_raw_quad(level)->level(),
                            this->tria->begin_raw_quad(level)->index(),
                            this);
-};
+}
 
 
 template <int dim>
@@ -823,7 +823,7 @@ MGDoFHandler<dim>::begin_quad (const unsigned int level) const {
                        this->tria->begin_quad(level)->level(),
                        this->tria->begin_quad(level)->index(),
                        this);
-};
+}
 
 
 template <int dim>
@@ -833,7 +833,7 @@ MGDoFHandler<dim>::begin_active_quad (const unsigned int level) const {
                               this->tria->begin_active_quad(level)->level(),
                               this->tria->begin_active_quad(level)->index(),
                               this);
-};
+}
 
 
 template <int dim>
@@ -843,7 +843,7 @@ MGDoFHandler<dim>::begin_raw_hex (const unsigned int level) const {
                           this->tria->begin_raw_hex(level)->level(),
                           this->tria->begin_raw_hex(level)->index(),
                           this);
-};
+}
 
 
 template <int dim>
@@ -853,7 +853,7 @@ MGDoFHandler<dim>::begin_hex (const unsigned int level) const {
                       this->tria->begin_hex(level)->level(),
                       this->tria->begin_hex(level)->index(),
                       this);
-};
+}
 
 
 template <int dim>
@@ -863,28 +863,28 @@ MGDoFHandler<dim>::begin_active_hex (const unsigned int level) const {
                              this->tria->begin_active_hex(level)->level(),
                              this->tria->begin_active_hex(level)->index(),
                              this);
-};
+}
 
 
 template <int dim>
 typename MGDoFHandler<dim>::raw_line_iterator
 MGDoFHandler<dim>::end_line () const {
   return raw_line_iterator (this->tria, -1, -1, this);
-};
+}
 
 
 template <int dim>
 typename MGDoFHandler<dim>::raw_quad_iterator
 MGDoFHandler<dim>::end_quad () const {
   return raw_quad_iterator (this->tria, -1, -1, this);
-};
+}
 
 
 template <int dim>
 typename MGDoFHandler<dim>::raw_hex_iterator
 MGDoFHandler<dim>::end_hex () const {
   return raw_hex_iterator (this->tria, -1, -1, this);
-};
+}
 
 
 template <int dim>
@@ -893,7 +893,7 @@ MGDoFHandler<dim>::end_raw (const unsigned int level) const {
   return (level == mg_levels.size()-1 ?
          end() :
          begin_raw (level+1));
-};
+}
 
 
 template <int dim>
@@ -902,7 +902,7 @@ MGDoFHandler<dim>::end (const unsigned int level) const {
   return (level == mg_levels.size()-1 ?
          cell_iterator(end()) :
          begin (level+1));
-};
+}
 
 
 template <int dim>
@@ -911,7 +911,7 @@ MGDoFHandler<dim>::end_active (const unsigned int level) const {
   return (level == mg_levels.size()-1 ?
          active_cell_iterator(end()) :
          begin_active (level+1));
-};
+}
 
 
 template <int dim>
@@ -920,7 +920,7 @@ MGDoFHandler<dim>::end_raw_face (const unsigned int level) const {
   return (level == mg_levels.size()-1 ?
          end_face() :
          begin_raw_face (level+1));
-};
+}
 
 
 template <int dim>
@@ -929,7 +929,7 @@ MGDoFHandler<dim>::end_face (const unsigned int level) const {
   return (level == mg_levels.size()-1 ?
          face_iterator(end_face()) :
          begin_face (level+1));
-};
+}
 
 
 template <int dim>
@@ -938,7 +938,7 @@ MGDoFHandler<dim>::end_active_face (const unsigned int level) const {
   return (level == mg_levels.size()-1 ?
          active_face_iterator(end_face()) :
          begin_active_face (level+1));
-};
+}
 
 
 template <int dim>
@@ -947,7 +947,7 @@ MGDoFHandler<dim>::end_raw_line (const unsigned int level) const {
   return (level == mg_levels.size()-1 ?
          end_line() :
          begin_raw_line (level+1));
-};
+}
 
 
 template <int dim>
@@ -956,7 +956,7 @@ MGDoFHandler<dim>::end_line (const unsigned int level) const {
   return (level == mg_levels.size()-1 ?
          line_iterator(end_line()) :
          begin_line (level+1));
-};
+}
 
 
 template <int dim>
@@ -965,7 +965,7 @@ MGDoFHandler<dim>::end_active_line (const unsigned int level) const {
   return (level == mg_levels.size()-1 ?
          active_line_iterator(end_line()) :
          begin_active_line (level+1));
-};
+}
 
 
 template <int dim>
@@ -974,7 +974,7 @@ MGDoFHandler<dim>::end_raw_quad (const unsigned int level) const {
   return (level == mg_levels.size()-1 ?
          end_quad() :
          begin_raw_quad (level+1));
-};
+}
 
 
 template <int dim>
@@ -983,7 +983,7 @@ MGDoFHandler<dim>::end_quad (const unsigned int level) const {
   return (level == mg_levels.size()-1 ?
          quad_iterator(end_quad()) :
          begin_quad (level+1));
-};
+}
 
 
 template <int dim>
@@ -992,7 +992,7 @@ MGDoFHandler<dim>::end_active_quad (const unsigned int level) const {
   return (level == mg_levels.size()-1 ?
          active_quad_iterator(end_quad()) :
          begin_active_quad (level+1));
-};
+}
 
 
 template <int dim>
@@ -1001,7 +1001,7 @@ MGDoFHandler<dim>::end_raw_hex (const unsigned int level) const {
   return (level == mg_levels.size()-1 ?
          end_hex() :
          begin_raw_hex (level+1));
-};
+}
 
 
 template <int dim>
@@ -1010,7 +1010,7 @@ MGDoFHandler<dim>::end_hex (const unsigned int level) const {
   return (level == mg_levels.size()-1 ?
          hex_iterator(end_hex()) :
          begin_hex (level+1));
-};
+}
 
 
 template <int dim>
@@ -1019,7 +1019,7 @@ MGDoFHandler<dim>::end_active_hex (const unsigned int level) const {
   return (level == mg_levels.size()-1 ?
          active_hex_iterator(end_hex()) :
          begin_active_hex (level+1));
-};
+}
 
 
 template <int dim>
@@ -1029,7 +1029,7 @@ MGDoFHandler<dim>::last_raw_line (const unsigned int level) const {
                            this->tria->last_raw_line(level)->level(),
                            this->tria->last_raw_line(level)->index(),
                            this);
-};
+}
 
 
 template <int dim>
@@ -1039,7 +1039,7 @@ MGDoFHandler<dim>::last_line (const unsigned int level) const {
                        this->tria->last_line(level)->level(),
                        this->tria->last_line(level)->index(),
                        this);
-};
+}
 
 
 template <int dim>
@@ -1049,7 +1049,7 @@ MGDoFHandler<dim>::last_active_line (const unsigned int level) const {
                               this->tria->last_active_line(level)->level(),
                               this->tria->last_active_line(level)->index(),
                               this);
-};
+}
 
 
 template <int dim>
@@ -1059,7 +1059,7 @@ MGDoFHandler<dim>::last_raw_quad (const unsigned int level) const {
                            this->tria->last_raw_quad(level)->level(),
                            this->tria->last_raw_quad(level)->index(),
                            this);
-};
+}
 
 
 template <int dim>
@@ -1069,7 +1069,7 @@ MGDoFHandler<dim>::last_quad (const unsigned int level) const {
                        this->tria->last_quad(level)->level(),
                        this->tria->last_quad(level)->index(),
                        this);
-};
+}
 
 
 template <int dim>
@@ -1079,7 +1079,7 @@ MGDoFHandler<dim>::last_active_quad (const unsigned int level) const {
                               this->tria->last_active_quad(level)->level(),
                               this->tria->last_active_quad(level)->index(),
                               this);
-};
+}
 
 
 template <int dim>
@@ -1089,7 +1089,7 @@ MGDoFHandler<dim>::last_raw_hex (const unsigned int level) const {
                           this->tria->last_raw_hex(level)->level(),
                           this->tria->last_raw_hex(level)->index(),
                           this);
-};
+}
 
 
 template <int dim>
@@ -1099,7 +1099,7 @@ MGDoFHandler<dim>::last_hex (const unsigned int level) const {
                       this->tria->last_hex(level)->level(),
                       this->tria->last_hex(level)->index(),
                       this);
-};
+}
 
 
 template <int dim>
@@ -1109,70 +1109,70 @@ MGDoFHandler<dim>::last_active_hex (const unsigned int level) const {
                              this->tria->last_active_hex(level)->level(),
                              this->tria->last_active_hex(level)->index(),
                              this);
-};
+}
 
 
 template <int dim>
 typename MGDoFHandler<dim>::raw_line_iterator
 MGDoFHandler<dim>::last_raw_line () const {
   return last_raw_line (mg_levels.size()-1);
-};
+}
 
 
 template <int dim>
 typename MGDoFHandler<dim>::raw_quad_iterator
 MGDoFHandler<dim>::last_raw_quad () const {
   return last_raw_quad (mg_levels.size()-1);
-};
+}
 
 
 template <int dim>
 typename MGDoFHandler<dim>::raw_hex_iterator
 MGDoFHandler<dim>::last_raw_hex () const {
   return last_raw_hex (mg_levels.size()-1);
-};
+}
 
 
 template <int dim>
 typename MGDoFHandler<dim>::line_iterator
 MGDoFHandler<dim>::last_line () const {
   return last_line (mg_levels.size()-1);
-};
+}
 
 
 template <int dim>
 typename MGDoFHandler<dim>::quad_iterator
 MGDoFHandler<dim>::last_quad () const {
   return last_quad (mg_levels.size()-1);
-};
+}
 
 
 template <int dim>
 typename MGDoFHandler<dim>::hex_iterator
 MGDoFHandler<dim>::last_hex () const {
   return last_hex (mg_levels.size()-1);
-};
+}
 
 
 template <int dim>
 typename MGDoFHandler<dim>::active_line_iterator
 MGDoFHandler<dim>::last_active_line () const {
   return last_active_line (mg_levels.size()-1);
-};
+}
 
 
 template <int dim>
 typename MGDoFHandler<dim>::active_quad_iterator
 MGDoFHandler<dim>::last_active_quad () const {
   return last_active_quad (mg_levels.size()-1);
-};
+}
 
 
 template <int dim>
 typename MGDoFHandler<dim>::active_hex_iterator
 MGDoFHandler<dim>::last_active_hex () const {
   return last_active_hex (mg_levels.size()-1);
-};
+}
 
 
 //------------------------------------------------------------------
@@ -1218,7 +1218,7 @@ void MGDoFHandler<dim>::distribute_dofs (const FiniteElement<dim> &fe,
   
                                   // finally restore the user flags
   const_cast<Triangulation<dim> &>(*(this->tria)).load_user_flags(user_flags);
-};
+}
 
 
 #if deal_II_dimension == 1
@@ -1271,7 +1271,7 @@ MGDoFHandler<1>::distribute_dofs_on_cell (cell_iterator &cell,
   cell->set_user_flag ();
   
   return next_free_dof;
-};
+}
 
 #endif
 
@@ -1318,7 +1318,7 @@ MGDoFHandler<2>::distribute_dofs_on_cell (cell_iterator &cell,
   cell->set_user_flag ();
   
   return next_free_dof;
-};
+}
 
 #endif
 
@@ -1380,7 +1380,7 @@ MGDoFHandler<3>::distribute_dofs_on_cell (cell_iterator &cell,
   cell->set_user_flag ();
   
   return next_free_dof;
-};
+}
 
 #endif
 
@@ -1395,7 +1395,7 @@ MGDoFHandler<dim>::clear ()
                                   // let base class release its mem
                                   // as well
   DoFHandler<dim>::clear ();  
-};
+}
 
 
 template <int dim>
@@ -1403,7 +1403,7 @@ unsigned int MGDoFHandler<dim>::n_dofs (const unsigned int level) const {
   Assert (level < mg_used_dofs.size(), ExcInvalidLevel(level));
   
   return mg_used_dofs[level];
-};
+}
 
 
 #if deal_II_dimension == 1
@@ -1436,7 +1436,7 @@ void MGDoFHandler<1>::renumber_dofs (const unsigned int level,
       Assert (*i != DoFHandler<1>::invalid_dof_index, ExcInternalError());
       *i = new_numbers[*i];
     };
-};
+}
 
 #endif
 
@@ -1473,7 +1473,7 @@ void MGDoFHandler<2>::renumber_dofs (const unsigned int  level,
       Assert (*i != DoFHandler<2>::invalid_dof_index, ExcInternalError());
       *i = new_numbers[*i];
     };
-};
+}
 
 #endif
 
@@ -1517,7 +1517,7 @@ void MGDoFHandler<3>::renumber_dofs (const unsigned int  level,
       Assert (*i != DoFHandler<3>::invalid_dof_index, ExcInternalError());
       *i = new_numbers[*i];
     };
-};
+}
 
 #endif
 
@@ -1590,7 +1590,7 @@ void MGDoFHandler<1>::reserve_space () {
                                   max_level[vertex],
                                   this->selected_fe->dofs_per_vertex);
     };
-};
+}
 
 #endif
 
@@ -1669,7 +1669,7 @@ void MGDoFHandler<2>::reserve_space () {
                                   max_level[vertex],
                                   this->selected_fe->dofs_per_vertex);
     };
-};
+}
 
 #endif
 
@@ -1750,7 +1750,7 @@ void MGDoFHandler<3>::reserve_space () {
                                   max_level[vertex],
                                   this->selected_fe->dofs_per_vertex);
     };
-};
+}
 
 #endif
 
@@ -1770,7 +1770,7 @@ void MGDoFHandler<dim>::clear_space ()
                                   // indices
   std::vector<MGVertexDoFs> tmp;
   std::swap (mg_vertex_dofs, tmp);
-};
+}
 
 
 
index 18e0cef626226fa1398f47c8f46efa7474986099..9ef239b4d120fbc0a5e3136e5bb2d22a0ada5822 100644 (file)
@@ -47,7 +47,7 @@ MGSmootherContinuous<VECTOR>::MGSmootherContinuous (
                steps(steps)
 {
   Assert (false, ExcNotImplemented());
-};
+}
 
 #endif
 
@@ -115,7 +115,7 @@ MGSmootherContinuous<VECTOR>::MGSmootherContinuous (
                                       // for this level its destination
       interior_boundary_dofs[level-1] = boundary_dofs;
     };      
-};
+}
 
 #endif
 
@@ -132,7 +132,7 @@ MGSmootherContinuous<VECTOR>::set_zero_interior_boundary (const unsigned int lev
     for (std::vector<unsigned int>::const_iterator p=interior_boundary_dofs[level-1].begin();
         p!=interior_boundary_dofs[level-1].end(); ++p)
       u(*p) = 0;
-};
+}
 
 //////////////////////////////////////////////////////////////////////
 
index a20703198d4d8f187d5b1ed0ca1de0127d128597..36a8d5f1bd835520b6a1d1f9f80da144404693bd 100644 (file)
@@ -22,7 +22,7 @@
 
 template <typename number>
 MGTransferPrebuilt<number>::~MGTransferPrebuilt () 
-{};
+{}
 
 
 template <typename number>
@@ -35,7 +35,7 @@ void MGTransferPrebuilt<number>::prolongate (
          ExcIndexRange (to_level, 1, prolongation_matrices.size()+1));
 
   prolongation_matrices[to_level-1].vmult (dst, src);
-};
+}
 
 
 template <typename number>
@@ -48,7 +48,7 @@ void MGTransferPrebuilt<number>::restrict_and_add (
          ExcIndexRange (from_level, 1, prolongation_matrices.size()+1));
 
   prolongation_matrices[from_level-1].Tvmult_add (dst, src);
-};
+}
 
 
 
@@ -56,7 +56,7 @@ void MGTransferPrebuilt<number>::restrict_and_add (
 
 template <typename number>
 MGTransferBlock<number>::~MGTransferBlock () 
-{};
+{}
 
 
 template <typename number>
@@ -76,7 +76,7 @@ void MGTransferBlock<number>::prolongate (
       prolongation_matrices[to_level-1].block(k,k).vmult (dst.block(b), src.block(b));
       ++k;
     }
-};
+}
 
 
 template <typename number>
@@ -96,14 +96,14 @@ void MGTransferBlock<number>::restrict_and_add (
       prolongation_matrices[from_level-1].block(k,k).Tvmult_add (dst.block(b), src.block(b));
       ++k;
     }
-};
+}
 
 
 
 
 template <typename number>
 MGTransferSelect<number>::~MGTransferSelect () 
-{};
+{}
 
 
 template <typename number>
@@ -117,7 +117,7 @@ void MGTransferSelect<number>::prolongate (
 
       prolongation_matrices[to_level-1].block(selected, selected)
        .vmult (dst, src);
-};
+}
 
 
 template <typename number>
@@ -131,7 +131,7 @@ void MGTransferSelect<number>::restrict_and_add (
 
   prolongation_matrices[from_level-1].block(selected, selected)
     .Tvmult_add (dst, src);
-};
+}
 
 
 // Explicit instantiations
index 17edfc0d8e36b7b949c69e747be9281f215a7e0e..f8ee76eb98c5aac241ffda15af4c259930f6eedb 100644 (file)
@@ -147,7 +147,7 @@ void MGTransferPrebuilt<number>::build_matrices (
              };
          };
     };
-};
+}
 
 
 /* ----------------------------- MGTransferBlock ------------------------ */
@@ -314,7 +314,7 @@ void MGTransferBlockBase::build_matrices (
       k += t;
     }
   
-};
+}
 
 
 template <typename number>
index 5060371da4e28a46a0dd4df05738710b46b294ab..1a7ee1fbc3bddecb5708f60b8b62bda393f5a1be 100644 (file)
@@ -47,7 +47,7 @@ DataEntry (const Vector<double> *data,
                single_data(data),
                has_block(false),
                names(names)
-{};
+{}
 
 
 
@@ -58,7 +58,7 @@ DataEntry (const BlockVector<double> *data,
                block_data(data),
                has_block(true),
                names(names)
-{};
+{}
 
 
 
@@ -69,7 +69,7 @@ DataEntry::memory_consumption () const
 {
   return (sizeof (single_data) + sizeof (block_data) +
          MemoryConsumption::memory_consumption (names));
-};
+}
 
 
 
@@ -78,7 +78,7 @@ DataEntry::memory_consumption () const
 template <int dof_handler_dim, int patch_dim, int patch_space_dim>
 DataOut_DoFData<dof_handler_dim,patch_dim,patch_space_dim>::DataOut_DoFData () :
                dofs(0)
-{};
+{}
 
 
 
@@ -86,7 +86,7 @@ template <int dof_handler_dim, int patch_dim, int patch_space_dim>
 DataOut_DoFData<dof_handler_dim,patch_dim,patch_space_dim>::~DataOut_DoFData ()
 {
   clear ();
-};
+}
 
 
 
@@ -104,7 +104,7 @@ attach_dof_handler (const DoFHandler<dof_handler_dim> &d)
   dofs = &d;
   if (dofs != 0)
     dofs->subscribe ();
-};
+}
 
 
 
@@ -177,7 +177,7 @@ add_data_vector (const VECTOR                   &vec,
     dof_data.push_back (new_entry);
   else
     cell_data.push_back (new_entry);
-};
+}
 
 
 template <int dof_handler_dim, int patch_dim, int patch_space_dim>
@@ -258,7 +258,7 @@ DataOut_DoFData<dof_handler_dim,patch_dim,patch_space_dim>::clear_input_data_ref
       dofs->unsubscribe ();
       dofs = 0;
     };
-};
+}
 
 
 
@@ -301,7 +301,7 @@ DataOut_DoFData<dof_handler_dim,patch_dim,patch_space_dim>::get_dataset_names ()
     };
 
   return names;
-};
+}
 
 
 
@@ -310,7 +310,7 @@ const std::vector< ::DataOutBase::Patch<patch_dim, patch_space_dim> > &
 DataOut_DoFData<dof_handler_dim,patch_dim,patch_space_dim>::get_patches () const
 {
   return patches;
-};
+}
 
 
 
@@ -323,7 +323,7 @@ DataOut_DoFData<dof_handler_dim,patch_dim,patch_space_dim>::memory_consumption (
          MemoryConsumption::memory_consumption (dof_data) +
          MemoryConsumption::memory_consumption (cell_data) +
          MemoryConsumption::memory_consumption (patches));
-};
+}
 
 
 
index 2e96cf7e59da36ea97ed9afc601998b0d1966c22..cf6b031801c95247a88dad773729559f77f00973 100644 (file)
@@ -128,7 +128,7 @@ void DataOutFaces<dim>::build_some_patches (Data data)
          face=next_face(face);
        }
     };
-};
+}
 
 
 
@@ -211,7 +211,7 @@ void DataOutFaces<dim>::build_patches (const unsigned int n_subdivisions,
   else
                                   // just one thread
     build_some_patches(thread_data[0]);
-};
+}
 
 
 
@@ -232,7 +232,7 @@ DataOutFaces<dim>::first_face ()
   Assert (false, ExcInternalError());
   
   return FaceDescriptor();
-};
+}
 
 
 
@@ -288,7 +288,7 @@ DataOutFaces<dim>::next_face (const FaceDescriptor &old_face)
   face.first  = this->dofs->end();
   face.second = 0;
   return face;
-};
+}
 
 
 // explicit instantiations
index 663bdc90ef7b5569d410e87b7f31720a31ed23ea..dd2b89a15ac450f4c882a57d6a45eb29eb9218a9 100644 (file)
@@ -32,7 +32,7 @@ template <typename T>
 static T sqr (const T t)
 {
   return t*t;
-};
+}
 
 
 
@@ -66,7 +66,7 @@ get_projected_derivative (const FEValues<dim>  &fe_values,
       fe_values.get_function_values (solution, values);
       return values[0](component);
     };
-};
+}
 
 
 
@@ -79,7 +79,7 @@ DerivativeApproximation::Gradient<dim>::derivative_norm (const Derivative &d)
   for (unsigned int i=0; i<dim; ++i)
     s += d[i]*d[i];
   return std::sqrt(s);
-};
+}
 
 
 
@@ -89,7 +89,7 @@ void
 DerivativeApproximation::Gradient<dim>::symmetrize (Derivative &)
 {
                                   // nothing to do here
-};
+}
 
 
 
@@ -114,7 +114,7 @@ get_projected_derivative (const FEValues<dim>  &fe_values,
       fe_values.get_function_grads (solution, values);
       return values[0][component];
     };
-};
+}
 
 
 #if deal_II_dimension == 1
@@ -126,7 +126,7 @@ DerivativeApproximation::SecondDerivative<1>::
 derivative_norm (const Derivative &d)
 {
   return std::fabs (d[0][0]);
-};
+}
 
 #endif
 
@@ -153,7 +153,7 @@ derivative_norm (const Derivative &d)
   
   return std::max (std::fabs (eigenvalues[0]),
                   std::fabs (eigenvalues[1]));
-};
+}
 
 #endif
 
@@ -334,7 +334,7 @@ C DEFINE A TEST MATRIX
   return std::max (std::fabs (EE[0]),
                   std::max (std::fabs (EE[1]),
                             std::fabs (EE[2])));
-};
+}
 
 #endif
 
@@ -360,7 +360,7 @@ derivative_norm (const Derivative &)
                                   // suffice?
   Assert (false, ExcNotImplemented());
   return 0;
-};
+}
 
 
 
@@ -376,7 +376,7 @@ DerivativeApproximation::SecondDerivative<dim>::symmetrize (Derivative &d)
        const double s = (d[i][j] + d[j][i]) / 2;
        d[i][j] = d[j][i] = s;
       };
-};
+}
 
 
 
@@ -395,7 +395,7 @@ approximate_gradient (const Mapping<dim>    &mapping,
                                             solution,
                                             component,
                                             derivative_norm);
-};
+}
 
 
 template <int dim>
@@ -413,7 +413,7 @@ approximate_gradient (const DoFHandler<dim> &dof_handler,
                                             solution,
                                             component,
                                             derivative_norm);
-};
+}
 
 
 template <int dim>
@@ -430,7 +430,7 @@ approximate_second_derivative (const Mapping<dim>    &mapping,
                                                     solution,
                                                     component,
                                                     derivative_norm);
-};
+}
 
 
 template <int dim>
@@ -448,7 +448,7 @@ approximate_second_derivative (const DoFHandler<dim> &dof_handler,
                                                     solution,
                                                     component,
                                                     derivative_norm);
-};
+}
 
 
 template <class DerivativeDescription, int dim>
@@ -483,7 +483,7 @@ approximate_derivative (const Mapping<dim>    &mapping,
                                   index_intervals[i],
                                   derivative_norm));
   thread_manager.wait ();
-};
+}
 
 
 
@@ -702,7 +702,7 @@ DerivativeApproximation::approximate (const Mapping<dim>    &mapping,
       *derivative_norm_on_this_cell
        = DerivativeDescription::derivative_norm (derivative);
     };
-};
+}
 
 
 
index ac90fe36a0987f1caa85a40b725314a815333dac..6b917246765c92bdd7059a61fcbcc3c31e512d4b 100644 (file)
@@ -44,7 +44,7 @@ inline
 double sqr (const double x)
 {
   return x*x;
-};
+}
 
 
 
@@ -105,7 +105,7 @@ void KellyErrorEstimator<dim>::estimate (const Mapping<dim>      &mapping,
   std::vector<Vector<float>*>              errors (1, &error);
   estimate (mapping, dof_handler, quadrature, neumann_bc, solutions, errors,
            component_mask, coefficients, n_threads);
-};
+}
 
 
 template <int dim>
@@ -122,7 +122,7 @@ void KellyErrorEstimator<dim>::estimate (const DoFHandler<dim>   &dof_handler,
   static const MappingQ1<dim> mapping;
   estimate(mapping, dof_handler, quadrature, neumann_bc, solution,
           error, component_mask, coefficients, n_threads);
-};
+}
 
 
 
@@ -358,7 +358,7 @@ estimate (const Mapping<1>                    &mapping,
       for (unsigned int s=0; s<n_solution_vectors; ++s)
        (*errors[s])(cell_index) = std::sqrt((*errors[s])(cell_index));
     };
-};
+}
 
 
 #else // #if deal_II_dimension !=1
@@ -539,7 +539,7 @@ estimate_some (const Mapping<dim>                  &mapping,
           ((t<this_thread.second) && (cell!=dof_handler.end()));
           ++t, ++cell);
     };
-};
+}
 
 
 
@@ -697,7 +697,7 @@ KellyErrorEstimator<dim>::estimate (const Mapping<dim>                  &mapping
       for (unsigned int n=0; n<n_solution_vectors; ++n)
        (*errors[n])(present_cell) = std::sqrt((*errors[n])(present_cell));
     };
-};
+}
 
 #endif
 
@@ -737,7 +737,7 @@ integrate_over_regular_face (const DoFHandler<1>               &,
                              FEFaceValues<1>        &)
 {
   Assert (false, ExcInternalError());
-};
+}
 
 
 template <>
@@ -755,7 +755,7 @@ integrate_over_irregular_face (const DoFHandler<1>               &,
                               FESubfaceValues<1>         &)
 {
   Assert (false, ExcInternalError());
-};
+}
 
 #endif
 
@@ -946,7 +946,7 @@ integrate_over_regular_face (const DoFHandler<dim>               &dof_handler,
   Assert (face_integrals[face][0] < 0, ExcInternalError());
   
   face_integrals[face] = face_integral;
-};
+}
 
 
 
@@ -1131,7 +1131,7 @@ integrate_over_irregular_face (const DoFHandler<dim>               &dof_handler,
     };
 
   face_integrals[face] = sum;
-};
+}
 
 
 // explicit instantiations
index 94b240d4efe525f77d9a9c56ba1f04a1889115d0..53892bf09430a76913423c66c92bdae5e4b837c6 100644 (file)
@@ -27,7 +27,7 @@ bool Histogram::logarithmic_less (const number n1,
   return (((n1<n2) && (n1>0)) ||
          ((n1<n2) && (n2<=0)) ||
          ((n2<n1) && (n1>0) && (n2<=0)));
-};
+}
 
 
 
@@ -36,7 +36,7 @@ Histogram::Interval::Interval (const double left_point,
                left_point (left_point),
                right_point (right_point),
                content (0)
-{};
+{}
 
 
 
@@ -44,7 +44,7 @@ unsigned int
 Histogram::Interval::memory_consumption () const
 {
   return sizeof(*this);
-};
+}
 
 
 
@@ -195,7 +195,7 @@ void Histogram::evaluate (const std::vector<Vector<number> > &values,
              break;
            };
       };
-};
+}
 
 
 
@@ -207,7 +207,7 @@ void Histogram::evaluate (const Vector<number>    &values,
   std::vector<Vector<number> > values_list (1,
                                       values);
   evaluate (values_list, std::vector<double>(1,0.), n_intervals, interval_spacing);
-};
+}
 
 
 
@@ -279,14 +279,14 @@ void Histogram::write_gnuplot (std::ostream &out) const
       };
 
   AssertThrow (out, ExcIO());
-};
+}
 
 
 
 std::string Histogram::get_interval_spacing_names () 
 {
   return "linear|logarithmic";
-};
+}
 
 
 
@@ -304,7 +304,7 @@ Histogram::parse_interval_spacing (const std::string &name)
 
        return linear;
       };
-};
+}
 
 
 
@@ -313,7 +313,7 @@ Histogram::memory_consumption () const
 {
   return (MemoryConsumption::memory_consumption (intervals) +
          MemoryConsumption::memory_consumption (y_values));
-};
+}
 
 
 
index d9dd753f2a880b5467234c117791bb8070101c27..b5154e9f335d820c57c106e3af2de0626ebeec96 100644 (file)
@@ -183,7 +183,7 @@ MatrixTools::apply_boundary_values (const std::map<unsigned int,double> &boundar
                                       // preset solution vector
       solution(dof_number) = dof->second;
     };
-};
+}
 
 
 
@@ -502,7 +502,7 @@ MatrixTools::apply_boundary_values (const std::map<unsigned int,double> &boundar
                                       // preset solution vector
       solution.block(block_index.first)(block_index.second) = dof->second;
     };
-};
+}
 
 
 
index a660d7367377de8714a7683532123512a71efb70..541c6236c4e538d86ce998df15c3ae8fc8ecd7c3 100644 (file)
@@ -50,7 +50,7 @@ IteratorRange (const active_cell_iterator &first,
                :
                first (first),
                second (second)
-{};
+{}
 
 
 
@@ -60,7 +60,7 @@ MatrixCreator::IteratorRange<dim>::IteratorRange (const iterator_pair &ip)
                :
                first (ip.first),
                second (ip.second)
-{};
+{}
 
 
 
@@ -106,7 +106,7 @@ void MatrixCreator::create_mass_matrix (const Mapping<dim>       &mapping,
                    .collect_args (mapping, dof, q, matrix, coefficient,
                                   thread_ranges[thread], mutex));
   thread_manager.wait ();  
-};
+}
 
 
 
@@ -228,7 +228,7 @@ void MatrixCreator::create_mass_matrix_1 (const Mapping<dim>       &mapping,
                        cell_matrix(i,j));
       mutex.release ();
     };
-};
+}
 
 
 template <int dim>
@@ -289,7 +289,7 @@ void MatrixCreator::create_mass_matrix (const Mapping<dim>       &mapping,
                                   rhs_vector, coefficient,
                                   thread_ranges[thread], mutex));
   thread_manager.wait ();  
-};
+}
 
 
 
@@ -426,7 +426,7 @@ MatrixCreator::create_mass_matrix_2 (const Mapping<dim>       &mapping,
        rhs_vector(dof_indices[i]) += local_rhs(i);
       mutex.release ();
     };
-};
+}
 
 
 template <int dim>
@@ -458,7 +458,7 @@ void MatrixCreator::create_boundary_mass_matrix (const Mapping<1>          &,
                                   // identity matrix on the boundary
                                   // dofs?
   Assert (false, ExcNotImplemented());
-};
+}
 
 
 #endif
@@ -511,7 +511,7 @@ MatrixCreator::create_boundary_mass_matrix (const Mapping<dim>        &mapping,
                                   dof_to_boundary_mapping, coefficient,
                                   thread_ranges[thread], mutex));
   thread_manager.wait ();  
-};
+}
 
 
 
@@ -872,7 +872,7 @@ create_boundary_mass_matrix_1 (const Mapping<dim>        &mapping,
              };
          mutex.release ();
        };
-};
+}
 
 
 template <int dim>
@@ -933,7 +933,7 @@ void MatrixCreator::create_laplace_matrix (const Mapping<dim>       &mapping,
                    .collect_args (mapping, dof, q, matrix, coefficient,
                                   thread_ranges[thread], mutex));
   thread_manager.wait ();  
-};
+}
 
 
 
@@ -1119,7 +1119,7 @@ void MatrixCreator::create_laplace_matrix (const Mapping<dim>       &mapping,
                                   rhs_vector, coefficient,
                                   thread_ranges[thread], mutex));
   thread_manager.wait ();  
-};
+}
 
 
 
@@ -1259,7 +1259,7 @@ MatrixCreator::create_laplace_matrix_2 (const Mapping<dim>       &mapping,
        rhs_vector(dof_indices[i]) += local_rhs(i);
       mutex.release ();
     };
-};
+}
 
 
 
index 88691b780fac34fccbfb9843e8bb66b3a465281a..76ac45f3570483c446c6f197dcbc0e15d722fad7 100644 (file)
@@ -398,7 +398,7 @@ SolutionTransfer<dim, number>::memory_consumption () const
          MemoryConsumption::memory_consumption (indices_on_cell) +
          MemoryConsumption::memory_consumption (all_pointerstructs) +
          MemoryConsumption::memory_consumption (dof_values_on_cell));
-};
+}
 
 
 
@@ -407,7 +407,7 @@ unsigned int
 SolutionTransfer<dim, number>::Pointerstruct::memory_consumption () const
 {
   return sizeof(*this);
-};
+}
 
 
 
index 30b64923f088ec173701fa296e3bb0dac3572be5..1fa87abaa0fe83ddd94d450b969c16914f9e7c9f 100644 (file)
@@ -31,7 +31,7 @@ TimeDependent::TimeSteppingData::TimeSteppingData (const unsigned int look_ahead
                :
                look_ahead (look_ahead),
                look_back (look_back)
-{};
+{}
 
 
 TimeDependent::TimeDependent (const TimeSteppingData &data_primal,
@@ -41,14 +41,14 @@ TimeDependent::TimeDependent (const TimeSteppingData &data_primal,
                timestepping_data_primal (data_primal),
                timestepping_data_dual (data_dual),
                timestepping_data_postprocess (data_postprocess)
-{};
+{}
 
 
 TimeDependent::~TimeDependent ()
 {
   while (timesteps.size() != 0)
     delete_timestep (0);
-};
+}
 
 
 void
@@ -108,14 +108,14 @@ TimeDependent::insert_timestep (const TimeStepBase *position,
                     timesteps.end() :
                     std::find(timesteps.begin(), timesteps.end(), position)),
                    new_timestep);
-};
+}
 
 
 void
 TimeDependent::add_timestep (TimeStepBase *new_timestep)
 {
   insert_timestep (0, new_timestep);
-};
+}
 
 
 void TimeDependent::delete_timestep (const unsigned int position)
@@ -143,7 +143,7 @@ void TimeDependent::delete_timestep (const unsigned int position)
     timesteps[position]->set_previous_timestep ((position!=0) ?
                                                timesteps[position-1] :
                                                0);
-};
+}
 
 
 void
@@ -153,7 +153,7 @@ TimeDependent::solve_primal_problem ()
           std::mem_fun(&TimeStepBase::solve_primal_problem),
           timestepping_data_primal,
           forward);
-};
+}
 
 
 void
@@ -163,7 +163,7 @@ TimeDependent::solve_dual_problem ()
           std::mem_fun(&TimeStepBase::solve_dual_problem),
           timestepping_data_dual,
           backward);
-};
+}
 
 
 void
@@ -173,7 +173,7 @@ TimeDependent::postprocess ()
           std::mem_fun(&TimeStepBase::postprocess_timestep),
           timestepping_data_postprocess,
           forward);
-};
+}
 
 
 
@@ -196,7 +196,7 @@ void TimeDependent::start_sweep (const unsigned int s)
 
   for (unsigned int step=0; step<timesteps.size(); ++step)
     timesteps[step]->start_sweep ();
-};
+}
 
 
 
@@ -229,7 +229,7 @@ void TimeDependent::end_sweep (const unsigned int begin,
 {     
   for (unsigned int step=begin; step<end; ++step)
     timesteps[step]->end_sweep ();
-};
+}
 
 
 
@@ -244,7 +244,7 @@ unsigned int TimeDependent::memory_consumption () const
     mem += MemoryConsumption::memory_consumption (*timesteps[i]);
 
   return mem;
-};
+}
 
 
 
@@ -257,36 +257,36 @@ TimeStepBase::TimeStepBase (const double time) :
                sweep_no (static_cast<unsigned int>(-1)),
                timestep_no (static_cast<unsigned int>(-1)),
                time (time)
-{};
+{}
 
 
 
 TimeStepBase::~TimeStepBase () 
-{};
+{}
 
 
 
 void
 TimeStepBase::wake_up (const unsigned )
-{};
+{}
 
 
 
 void
 TimeStepBase::sleep (const unsigned)
-{};
+{}
 
 
 
 void
 TimeStepBase::start_sweep () 
-{};
+{}
 
 
 
 void
 TimeStepBase::end_sweep () 
-{};
+{}
 
 
 
@@ -294,7 +294,7 @@ void
 TimeStepBase::init_for_primal_problem () 
 {
   next_action = primal_problem;
-};
+}
 
 
 
@@ -302,7 +302,7 @@ void
 TimeStepBase::init_for_dual_problem () 
 {
   next_action = dual_problem;
-};
+}
 
 
 
@@ -310,7 +310,7 @@ void
 TimeStepBase::init_for_postprocessing () 
 {
   next_action = postprocess;
-};
+}
 
 
 
@@ -318,7 +318,7 @@ void
 TimeStepBase::solve_dual_problem () 
 {
   Assert (false, ExcPureVirtualFunctionCalled());
-};
+}
 
 
 
@@ -326,7 +326,7 @@ void
 TimeStepBase::postprocess_timestep () 
 {
   Assert (false, ExcPureVirtualFunctionCalled());
-};
+}
 
 
 
@@ -334,7 +334,7 @@ double
 TimeStepBase::get_time () const 
 {
   return time;
-};
+}
 
 
 
@@ -342,7 +342,7 @@ unsigned int
 TimeStepBase::get_timestep_no () const 
 {
   return timestep_no;
-};
+}
 
 
 
@@ -351,7 +351,7 @@ TimeStepBase::get_backward_timestep () const
 {
   Assert (previous_timestep != 0, ExcCantComputeTimestep());
   return time - previous_timestep->time;
-};
+}
 
 
 
@@ -360,7 +360,7 @@ TimeStepBase::get_forward_timestep () const
 {
   Assert (next_timestep != 0, ExcCantComputeTimestep());
   return next_timestep->time - time;
-};
+}
 
 
 
@@ -368,7 +368,7 @@ void
 TimeStepBase::set_previous_timestep (const TimeStepBase *previous)
 {
   previous_timestep = previous;
-};
+}
 
 
 
@@ -376,7 +376,7 @@ void
 TimeStepBase::set_next_timestep (const TimeStepBase *next)
 {
   next_timestep     = next;
-};
+}
 
 
 
@@ -384,7 +384,7 @@ void
 TimeStepBase::set_timestep_no (const unsigned int step_no)
 {
   timestep_no = step_no;
-};
+}
 
 
 
@@ -392,7 +392,7 @@ void
 TimeStepBase::set_sweep_no (const unsigned int sweep)
 {
   sweep_no = sweep;
-};
+}
 
 
 
@@ -401,7 +401,7 @@ TimeStepBase::memory_consumption () const
 {
                                   // only simple data types
   return sizeof(*this);
-};
+}
 
 
 /* ------------------------------------------------------------------------- */
@@ -416,7 +416,7 @@ TimeStepBase_Tria<dim>::TimeStepBase_Tria() :
                refinement_flags(0)
 {
   Assert (false, ExcPureVirtualFunctionCalled());
-};
+}
 
 
 
@@ -430,7 +430,7 @@ TimeStepBase_Tria<dim>::TimeStepBase_Tria (const double              time,
                coarse_grid (&coarse_grid),
                flags (flags),
                refinement_flags (refinement_flags)
-{};
+{}
 
 
 
@@ -446,7 +446,7 @@ TimeStepBase_Tria<dim>::~TimeStepBase_Tria ()
     Assert (tria==0, ExcInternalError());
   
   coarse_grid = 0;
-};
+}
 
 
 
@@ -459,7 +459,7 @@ TimeStepBase_Tria<dim>::wake_up (const unsigned wakeup_level)
   if (wakeup_level == flags.wakeup_level_to_build_grid)
     if (flags.delete_and_rebuild_tria || !tria)
       restore_grid ();
-};
+}
 
 
 
@@ -480,7 +480,7 @@ TimeStepBase_Tria<dim>::sleep (const unsigned sleep_level)
     };
 
   TimeStepBase::sleep (sleep_level);
-};
+}
 
 
 
@@ -493,7 +493,7 @@ void TimeStepBase_Tria<dim>::save_refine_flags ()
   coarsen_flags.push_back (std::vector<bool>());
   tria->save_refine_flags (refine_flags.back());
   tria->save_coarsen_flags (coarsen_flags.back());
-};
+}
 
 
 
@@ -534,7 +534,7 @@ void TimeStepBase_Tria<dim>::restore_grid ()
 
       tria->execute_coarsening_and_refinement ();
     };
-};
+}
 
 
 
@@ -581,7 +581,7 @@ mirror_refinement_flags (const typename Triangulation<dim>::cell_iterator &new_c
   if (old_cell->has_children() && new_cell->has_children()) 
     for (unsigned int c=0; c<GeometryInfo<dim>::children_per_cell; ++c)
       ::mirror_refinement_flags<dim> (new_cell->child(c), old_cell->child(c));
-};
+}
 
 
 
@@ -686,7 +686,7 @@ adapt_grid_cells (const typename Triangulation<dim>::cell_iterator &cell1,
 
   Assert (false, ExcInternalError());
   return false;
-};    
+}
 
 
 
@@ -707,7 +707,7 @@ adapt_grids (Triangulation<dim> &tria1,
     grids_changed |= ::adapt_grid_cells<dim> (cell1, cell2);
 
   return grids_changed;
-};
+}
 
 
 
@@ -1104,7 +1104,7 @@ void TimeStepBase_Tria<dim>::refine_grid (const RefinementData refinement_data)
                                       // than the present one and vica versa.
       ::adapt_grids<dim> (*previous_tria, *tria);
     };
-};
+}
 
 
 
@@ -1112,7 +1112,7 @@ template <int dim>
 void TimeStepBase_Tria<dim>::init_for_refinement () 
 {
   next_action = grid_refinement;
-};
+}
 
 
 
@@ -1126,7 +1126,7 @@ TimeStepBase_Tria<dim>::memory_consumption () const
          sizeof(flags) + sizeof(refinement_flags) +
          MemoryConsumption::memory_consumption (refine_flags) +
          MemoryConsumption::memory_consumption (coarsen_flags));
-};
+}
 
 
 
@@ -1138,7 +1138,7 @@ TimeStepBase_Tria_Flags::Flags<dim>::Flags ()
                sleep_level_to_delete_grid (0)
 {
   Assert (false, ExcInternalError());
-};
+}
 
 
 
@@ -1154,7 +1154,7 @@ TimeStepBase_Tria_Flags::Flags<dim>::Flags (const bool delete_and_rebuild_tria,
 //       ExcInvalidParameter(wakeup_level_to_build_grid));
 //   Assert (!delete_and_rebuild_tria || (sleep_level_to_delete_grid>=1),
 //       ExcInvalidParameter(sleep_level_to_delete_grid));
-};
+}
 
 
 template <int dim>
@@ -1193,7 +1193,7 @@ RefinementFlags (const unsigned int max_refinement_level,
   Assert (cell_number_corridor_top>=0, ExcInvalidValue (cell_number_corridor_top));
   Assert (cell_number_corridor_bottom>=0, ExcInvalidValue (cell_number_corridor_bottom));
   Assert (cell_number_corridor_bottom<=1, ExcInvalidValue (cell_number_corridor_bottom));
-};
+}
 
 
 template <int dim>
@@ -1231,7 +1231,7 @@ RefinementData (const double         _refinement_threshold,
   Assert ((coarsening_threshold < refinement_threshold) ||
          ((coarsening_threshold == 0) && (refinement_threshold == 0)),
          ExcInvalidValue (coarsening_threshold));
-};
+}
 
 
 // explicit instantiations
@@ -1242,4 +1242,4 @@ namespace TimeStepBase_Tria_Flags
   template class Flags<deal_II_dimension>;
   template class RefinementFlags<deal_II_dimension>;
   template class RefinementData<deal_II_dimension>;
-};
+}
index 4e18a557cb18d1d67eaddfe20747e1628621e5aa..d2097426c0ae6be85ebc656986fbc45697f82df4 100644 (file)
@@ -44,4 +44,4 @@ VectorTools::subtract_mean_value(Vector<double>     &v,
   for (unsigned int i=0; i<n; ++i)
     if (p_select[i])
       v(i) -= s;  
-};
+}
index 16acb5cf98a9c3c2f720ca5a4dcfe0cb13052afd..f3959f318ff0913cdc2a2dcffcaa0126ec5f5a31 100644 (file)
@@ -50,7 +50,7 @@ template <int dim>
 inline double sqr_point (const Tensor<1,dim> &p)
 {
   return p * p;
-};
+}
 
 
 
@@ -299,7 +299,7 @@ void VectorTools::project (const Mapping<1>       &,
                                   // zero boundary values into the
                                   // project_boundary_values function?
   Assert (false, ExcNotImplemented());
-};
+}
 
 
 #endif
@@ -418,7 +418,7 @@ void VectorTools::project (const Mapping<dim>       &mapping,
   
                                   // distribute solution
   constraints.distribute (vec);
-};
+}
 
 
 template <int dim>
@@ -523,7 +523,7 @@ void VectorTools::create_right_hand_side (const Mapping<dim>    &mapping,
            rhs_vector(dofs[i]) += cell_vector(i);
        }
     }
-};
+}
 
 
 template <int dim>
@@ -636,7 +636,7 @@ VectorTools::create_boundary_right_hand_side (const Mapping<dim>      &mapping,
                rhs_vector(dofs[i]) += cell_vector(i);
            }
     }
-};
+}
 
 #else
 
@@ -649,7 +649,7 @@ VectorTools::create_boundary_right_hand_side (const Mapping<1>    &,
                                              const std::set<unsigned char> &)
 {
   Assert (false, ExcImpossibleInDim(1));
-};
+}
 
 #endif
 
@@ -741,7 +741,7 @@ VectorTools::interpolate_boundary_values (const Mapping<1>         &,
     if (component_mask[fe.face_system_to_component_index(i).first])
       boundary_values[outermost_cell->vertex_dof_index(direction,i)]
        = function_values(fe.face_system_to_component_index(i).first);
-};
+}
 
 
 
@@ -756,7 +756,7 @@ VectorTools::interpolate_boundary_values (const Mapping<1>              &mapping
        i!=function_map.end(); ++i)
     interpolate_boundary_values (mapping, dof, i->first, *i->second,
                                 boundary_values, component_mask);
-};
+}
 
 
 #endif
@@ -914,7 +914,7 @@ VectorTools::interpolate_boundary_values (const Mapping<dim>            &mapping
   function_map[boundary_component] = &boundary_function;
   interpolate_boundary_values (mapping, dof, function_map, boundary_values,
                               component_mask);
-};
+}
 
 
   
@@ -961,7 +961,7 @@ VectorTools::project_boundary_values (const Mapping<1>       &mapping,
                                   // to interpolation
   interpolate_boundary_values (mapping, dof, boundary_functions,
                               boundary_values, std::vector<bool>());
-};
+}
 
 #endif
 
@@ -1056,7 +1056,7 @@ VectorTools::project_boundary_values (const Mapping<dim>       &mapping,
                                       // is the number on the boundary and
                                       // thus in the solution vector
       boundary_values[i] = boundary_projection(dof_to_boundary_mapping[i]);
-};
+}
 
 
 template <int dim>
@@ -1469,7 +1469,7 @@ VectorTools::compute_mean_value (const Mapping<dim>    &mapping,
     };
   
   return (mean/area);
-};
+}
 
 
 template <int dim, class InVector>
index 6a074b38daf6d9c21f3e7c5c96dc5c20f6638622..e54b11d1e63ee737a158a390e79b7887ada06527 100644 (file)
@@ -162,7 +162,7 @@ BlockIndices::BlockIndices (const unsigned int n_blocks)
 {
   for (unsigned int i=0; i<=n_blocks; ++i)
     start_indices[i] = 0;
-};
+}
 
 
 
@@ -173,7 +173,7 @@ BlockIndices::BlockIndices (const std::vector<unsigned int> &n)
                start_indices(n.size()+1)
 {
   reinit (n);
-};
+}
 
 
 
@@ -184,7 +184,7 @@ BlockIndices::reinit (const unsigned int n_blocks,
 {
   const std::vector<unsigned int> v(n_blocks, n_elements_per_block);
   reinit (v);
-};
+}
 
 
 
@@ -200,7 +200,7 @@ BlockIndices::reinit (const std::vector<unsigned int> &n)
   start_indices[0] = 0;
   for (unsigned int i=1; i<=n_blocks; ++i)
     start_indices[i] = start_indices[i-1] + n[i-1];
-};
+}
 
 
 
@@ -215,7 +215,7 @@ BlockIndices::global_to_local (const unsigned int i) const
     --block;
 
   return std::make_pair<unsigned int>(block, i-start_indices[block]);
-};
+}
 
 
 inline
@@ -228,7 +228,7 @@ BlockIndices::local_to_global (const unsigned int block,
          ExcIndexRange (index, 0, start_indices[block+1]-start_indices[block]));
 
   return start_indices[block]+index;
-};
+}
 
 
 inline
@@ -245,7 +245,7 @@ unsigned int
 BlockIndices::total_size () const
 {
   return start_indices[n_blocks];
-};
+}
 
 
 
@@ -255,7 +255,7 @@ BlockIndices::block_size (const unsigned int block) const
 {
   Assert (block < n_blocks, ExcIndexRange(block, 0, n_blocks));
   return start_indices[block+1]-start_indices[block];
-};
+}
 
 
 
@@ -266,7 +266,7 @@ BlockIndices::operator = (const BlockIndices &b)
   start_indices = b.start_indices;
   n_blocks = b.n_blocks;
   return *this;
-};
+}
 
 
 
@@ -282,7 +282,7 @@ BlockIndices::operator == (const BlockIndices &b) const
       return false;
   
   return true;
-};
+}
 
 
 
@@ -295,7 +295,7 @@ BlockIndices::swap (BlockIndices &b)
 
   for (unsigned int i=0; i<=n_blocks; ++i)
     std::swap (start_indices[i], b.start_indices[i]);
-};
+}
 
 
 
@@ -305,7 +305,7 @@ BlockIndices::memory_consumption () const
 {
   return (sizeof(*this) + 
          start_indices.size() * sizeof(start_indices[0]));
-};
+}
 
 
 
@@ -323,7 +323,7 @@ inline
 void swap (BlockIndices &u, BlockIndices &v)
 {
   u.swap (v);
-};
+}
 
 
 
index 1789d4382f2679a5ecbe9589540283c11b98137c..cea00b9ae4244a160be0d393cfc07f6825a5462c 100644 (file)
@@ -949,7 +949,7 @@ unsigned int
 BlockSparseMatrix<number>::n_block_cols () const
 {
   return columns;
-};
+}
 
 
 
@@ -959,7 +959,7 @@ unsigned int
 BlockSparseMatrix<number>::n_block_rows () const
 {
   return rows;
-};
+}
 
 
 template <typename number>
@@ -972,7 +972,7 @@ BlockSparseMatrix<number>::block (const unsigned int row,
   Assert (column<columns, ExcIndexRange (column, 0, columns));
   
   return *sub_objects[row][column];
-};
+}
 
 
 
@@ -986,7 +986,7 @@ BlockSparseMatrix<number>::block (const unsigned int row,
   Assert (column<columns, ExcIndexRange (column, 0, columns));
   
   return *sub_objects[row][column];
-};
+}
 
 
 
@@ -996,7 +996,7 @@ unsigned int
 BlockSparseMatrix<number>::m () const
 {
   return sparsity_pattern->n_rows();
-};
+}
 
 
 
@@ -1006,7 +1006,7 @@ unsigned int
 BlockSparseMatrix<number>::n () const
 {
   return sparsity_pattern->n_cols();
-};
+}
 
 
 
@@ -1023,7 +1023,7 @@ BlockSparseMatrix<number>::set (const unsigned int i,
   block(row_index.first,col_index.first).set (row_index.second,
                                              col_index.second,
                                              value);
-};
+}
 
 
 
@@ -1040,7 +1040,7 @@ BlockSparseMatrix<number>::add (const unsigned int i,
   block(row_index.first,col_index.first).add (row_index.second,
                                              col_index.second,
                                              value);
-};
+}
 
 
 
@@ -1055,7 +1055,7 @@ BlockSparseMatrix<number>::operator () (const unsigned int i,
     col_index = sparsity_pattern->column_indices.global_to_local (j);
   return block(row_index.first,col_index.first) (row_index.second,
                                                 col_index.second);
-};
+}
 
 
 
@@ -1070,7 +1070,7 @@ BlockSparseMatrix<number>::el (const unsigned int i,
     col_index = sparsity_pattern->column_indices.global_to_local (j);
   return block(row_index.first,col_index.first).el (row_index.second,
                                                    col_index.second);
-};
+}
 
 
 
@@ -1086,7 +1086,7 @@ copy_from (const BlockSparseMatrix<somenumber> &source)
       block(r,c).copy_from (source.block(r,c));
   
   return *this;
-};
+}
 
 
 
@@ -1100,7 +1100,7 @@ add_scaled (const number factor,
   for (unsigned int r=0; r<rows; ++r)
     for (unsigned int c=0; c<columns; ++c)
       block(r,c).add_scaled (factor, matrix.block(r,c));
-};
+}
 
 
 
@@ -1124,7 +1124,7 @@ BlockSparseMatrix<number>::vmult (BlockVector<somenumber>       &dst,
        block(row,col).vmult_add (dst.block(row),
                                  src.block(col));
     };
-};
+}
 
 
 
@@ -1147,7 +1147,7 @@ BlockSparseMatrix<number>::vmult_add (BlockVector<somenumber>       &dst,
        block(row,col).vmult_add (dst.block(row),
                                  src.block(col));
     };
-};
+}
 
 
 
@@ -1171,7 +1171,7 @@ BlockSparseMatrix<number>::Tvmult (BlockVector<somenumber>& dst,
        block(row,col).Tvmult_add (dst.block(col),
                                   src.block(row));
     };
-};
+}
 
 
 
@@ -1192,7 +1192,7 @@ BlockSparseMatrix<number>::Tvmult_add (BlockVector<somenumber>& dst,
        block(row,col).Tvmult_add (dst.block(col),
                                   src.block(row));
     };
-};
+}
 
 
 
@@ -1214,7 +1214,7 @@ BlockSparseMatrix<number>::matrix_norm_square (const BlockVector<somenumber> &v)
        norm_sqr += block(row,col).matrix_scalar_product (v.block(row),
                                                          v.block(col));
   return norm_sqr;
-};
+}
 
 
 
@@ -1236,7 +1236,7 @@ matrix_scalar_product (const BlockVector<somenumber>    &u,
       result += block(row,col).matrix_scalar_product (u.block(row),
                                                      v.block(col));
   return result;
-};
+}
 
 
 
@@ -1289,7 +1289,7 @@ residual (BlockVector<somenumber>          &dst,
   for (unsigned int row=0; row<rows; ++row)
     res += dst.block(row).norm_sqr ();
   return std::sqrt(res);
-};
+}
 
 
 
@@ -1311,7 +1311,7 @@ precondition_Jacobi (BlockVector<somenumber>          &dst,
     block(i,i).precondition_Jacobi (dst.block(i),
                                    src.block(i),
                                    omega);
-};
+}
 
 
 template <typename number>
index 306110ffca4463c7c11e2c9a45bb4174998ddeaa..18afc1681dc5cd16d423f47137cd90a5161ee5ba 100644 (file)
@@ -25,7 +25,7 @@ BlockSparseMatrix<number>::BlockSparseMatrix () :
                rows (0),
                columns (0),
                sparsity_pattern (0)
-{};
+{}
 
 
 
@@ -36,7 +36,7 @@ BlockSparseMatrix (const BlockSparsityPattern &sparsity) :
                columns (0)
 {
   reinit (sparsity);
-};
+}
 
 
 
@@ -52,7 +52,7 @@ BlockSparseMatrix<number>::~BlockSparseMatrix ()
        sub_objects[r][c] = 0;
        delete p;
       };
-};
+}
 
 
 
@@ -71,7 +71,7 @@ operator = (const BlockSparseMatrix<number> &m)
     for (unsigned int c=0; c<columns; ++c)
       block(r,c) = m.block(r,c);
   return *this;
-};
+}
 
  
 
@@ -82,7 +82,7 @@ BlockSparseMatrix<number>::reinit ()
   for (unsigned int r=0; r<rows; ++r)
     for (unsigned int c=0; c<columns; ++c)
       block(r,c).reinit ();
-};
+}
 
 
 
@@ -116,7 +116,7 @@ reinit (const BlockSparsityPattern &sparsity)
        sub_objects[r][c] = new SparseMatrix<number>();
        block(r,c).reinit (sparsity.block(r,c));
       };
-};
+}
 
 
 
@@ -128,7 +128,7 @@ BlockSparseMatrix<number>::clear ()
   for (unsigned int r=0; r<rows; ++r)
     for (unsigned int c=0; c<columns; ++c)
       block(r,c).clear ();
-};
+}
 
 
 
@@ -141,7 +141,7 @@ BlockSparseMatrix<number>::empty () const
       if (block(r,c).empty () == false)
        return false;
   return true;
-};
+}
 
 
 
@@ -151,7 +151,7 @@ unsigned int
 BlockSparseMatrix<number>::n_nonzero_elements () const
 {
   return sparsity_pattern->n_nonzero_elements ();
-};
+}
 
 
 
@@ -164,7 +164,7 @@ BlockSparseMatrix<number>::n_actually_nonzero_elements () const
     for (unsigned int j=0; j<columns; ++j)
       count += sub_objects[i][j]->n_actually_nonzero_elements ();
   return count;
-};
+}
 
 
 
@@ -173,7 +173,7 @@ const BlockSparsityPattern &
 BlockSparseMatrix<number>::get_sparsity_pattern () const
 {
   return *sparsity_pattern;
-};
+}
 
 
 template <typename number>
@@ -186,7 +186,7 @@ BlockSparseMatrix<number>::memory_consumption () const
     for (unsigned int c=0; c<columns; ++c)
       mem += MemoryConsumption::memory_consumption(*sub_objects[r][c]);
   return mem;
-};
+}
 
 
 
index 29c684c7f2ed1874df14c35339654f8a4cefe052..c83bb8d811f0f2dd5ddb92c82ba325eeea6c6763 100644 (file)
@@ -508,7 +508,7 @@ BlockSparsityPatternBase<SparsityPatternBase>::block (const unsigned int row,
   Assert (row<rows, ExcIndexRange(row,0,rows));
   Assert (column<columns, ExcIndexRange(column,0,columns));
   return *sub_objects[row][column];
-};
+}
 
 
 
@@ -521,7 +521,7 @@ BlockSparsityPatternBase<SparsityPatternBase>::block (const unsigned int row,
   Assert (row<rows, ExcIndexRange(row,0,rows));
   Assert (column<columns, ExcIndexRange(column,0,columns));
   return *sub_objects[row][column];
-};
+}
 
 
 
@@ -531,7 +531,7 @@ const BlockIndices &
 BlockSparsityPatternBase<SparsityPatternBase>::get_row_indices () const
 {
   return row_indices;
-};
+}
 
 
 
@@ -541,7 +541,7 @@ const BlockIndices &
 BlockSparsityPatternBase<SparsityPatternBase>::get_column_indices () const
 {
   return column_indices;
-};
+}
 
 
 
@@ -559,7 +559,7 @@ BlockSparsityPatternBase<SparsityPatternBase>::add (const unsigned int i,
     col_index = column_indices.global_to_local (j);
   sub_objects[row_index.first][col_index.first]->add (row_index.second,
                                                      col_index.second);
-};
+}
 
 
 
@@ -577,7 +577,7 @@ BlockSparsityPatternBase<SparsityPatternBase>::exists (const unsigned int i,
     col_index = column_indices.global_to_local (j);
   return sub_objects[row_index.first][col_index.first]->exists (row_index.second,
                                                                col_index.second);
-};
+}
 
 
 
index 49224ee2e1a7a9389bfeeb77ef927fb9c69ed65b..d7355b2b4c364bc3c6c6fe54a14677a294c21e02 100644 (file)
@@ -586,7 +586,7 @@ namespace BlockVectorIterators
       friend class InverseConstnessIterator;
 #endif
   };
-};
+}
 
 
 
@@ -1250,7 +1250,7 @@ BlockVector<Number>::BlockVector (const std::vector<unsigned int> &n,
       start = end;
     };
   Assert (start == end, ExcIteratorRangeDoesNotMatchVectorSize());
-};
+}
 
 
 
@@ -1300,7 +1300,7 @@ BlockVector<Number> & BlockVector<Number>::operator *= (const Number factor)
 {
   scale (factor);
   return *this;
-};
+}
 
 
 
@@ -1795,7 +1795,7 @@ namespace BlockVectorIterators
     return *this;
   }
   
-};
+}
 
 
 /**
@@ -1811,7 +1811,7 @@ void swap (BlockVector<Number> &u,
           BlockVector<Number> &v)
 {
   u.swap (v);
-};
+}
 
 
 
index 48399e0419a95b56bdecdd9328beb12d69b643dd..9a14fabed49414d50bd4db272ecd923f557304ed 100644 (file)
@@ -138,7 +138,7 @@ void BlockVector<Number>::swap (BlockVector<Number> &v)
   for (unsigned int i=0; i<num_blocks; ++i)
     ::swap (components[i], v.components[i]);
   ::swap (block_indices, v.block_indices);
-};
+}
 
 
 
@@ -185,7 +185,7 @@ typename BlockVector<Number>::iterator
 BlockVector<Number>::begin()
 {
   return iterator(*this, 0U);
-};
+}
 
 
 
@@ -194,7 +194,7 @@ typename BlockVector<Number>::const_iterator
 BlockVector<Number>::begin() const
 {
   return const_iterator(*this, 0U);
-};
+}
 
 
 template <typename Number>
@@ -202,7 +202,7 @@ typename BlockVector<Number>::iterator
 BlockVector<Number>::end()
 {
   return iterator(*this, size());
-};
+}
 
 
 
@@ -211,7 +211,7 @@ typename BlockVector<Number>::const_iterator
 BlockVector<Number>::end() const
 {
   return const_iterator(*this, size());
-};
+}
 
 
 
@@ -224,7 +224,7 @@ Number BlockVector<Number>::norm_sqr () const
       sum += components[i].norm_sqr();
     }
   return sum;
-};
+}
 
 
 
@@ -583,7 +583,7 @@ BlockVector<Number>::memory_consumption () const
     mem += MemoryConsumption::memory_consumption (components[i]);
   mem += MemoryConsumption::memory_consumption (block_indices);
   return mem;
-};
+}
 
 
 
@@ -700,7 +700,7 @@ namespace BlockVectorIterators
   
     --global_index;
   }
-};
+}
 
 
 #endif
index dcd3b1f706ab0e75875ff4484e19e7c8f780e88d..00d058dedd0f9d94cfcb80e731db8a2337c6692f 100644 (file)
@@ -360,7 +360,7 @@ unsigned int
 CompressedSparsityPattern::n_rows () const
 {
   return rows;
-};
+}
 
 
 inline
@@ -368,6 +368,6 @@ unsigned int
 CompressedSparsityPattern::n_cols () const
 {
   return cols;
-};
+}
 
 #endif
index cda7e2d6764fefb00a445071b2116f99f1851ae8..fc69ac93b882bbacce005f891910a6682c935456 100644 (file)
@@ -577,7 +577,7 @@ operator () (const IndexValuePair &i1,
             const IndexValuePair &i2) const
 {
   return (i1.first < i2.first);
-};
+}
 
 
 
@@ -599,7 +599,7 @@ add_constraints (const ConstraintList &new_constraints)
                      constraints.begin()+old_size,
                      constraints.end(),
                      PairComparison());
-};
+}
 
 
 
@@ -609,7 +609,7 @@ const Matrix &
 FilteredMatrix<Matrix,Vector>::get_referenced_matrix () const
 {
   return *matrix;
-};
+}
 
 
 
@@ -618,7 +618,7 @@ inline
 unsigned int FilteredMatrix<Matrix,Vector>::m () const
 {
   return matrix->m();
-};
+}
 
 
 
@@ -627,7 +627,7 @@ inline
 unsigned int FilteredMatrix<Matrix,Vector>::n () const
 {
   return matrix->n();
-};
+}
 
 
 
index dd16e916ea347ba4b4c1a02cc1283ae6880e21d6..cce89abe084c0f6964dc050f61024a4f6df4a836 100644 (file)
@@ -26,7 +26,7 @@
 template <class Matrix, class Vector>
 FilteredMatrix<Matrix,Vector>::
 FilteredMatrix () 
-{};
+{}
 
 
 
@@ -38,7 +38,7 @@ FilteredMatrix (const FilteredMatrix &fm)
                constraints (fm.constraints)
 {
   set_referenced_matrix (*fm.matrix);
-};
+}
 
 
 
@@ -47,7 +47,7 @@ FilteredMatrix<Matrix,Vector>::
 FilteredMatrix (const Matrix &m)
 {
   set_referenced_matrix (m);
-};
+}
 
 
 
@@ -58,7 +58,7 @@ FilteredMatrix<Matrix,Vector>::operator = (const FilteredMatrix &fm)
   set_referenced_matrix (*fm.matrix);
   constraints = fm.constraints;
   return *this;
-};
+}
 
 
 
@@ -69,7 +69,7 @@ set_referenced_matrix (const Matrix &m)
 {
   matrix = &m;
   allocate_tmp_vector ();
-};
+}
 
 
 
@@ -80,7 +80,7 @@ FilteredMatrix<Matrix,Vector>::clear_constraints ()
                                   // swap vectors to release memory
   std::vector<IndexValuePair> empty;
   constraints.swap (empty);
-};
+}
 
 
 
@@ -137,7 +137,7 @@ apply_constraints (Vector     &v,
                                       // each other
   for (i=constraints.begin(); i!=e; ++i)
     v(i->first) = i->second;
-};
+}
 
 
 
@@ -151,7 +151,7 @@ FilteredMatrix<Matrix,Vector>::pre_filter (Vector &v) const
   const const_index_value_iterator e = constraints.end();
   for (; i!=e; ++i)
     v(i->first) = 0;
-};
+}
 
 
 
@@ -166,7 +166,7 @@ FilteredMatrix<Matrix,Vector>::post_filter (const Vector &in,
   const const_index_value_iterator e = constraints.end();
   for (; i!=e; ++i)
     out(i->first) = in(i->first);
-};
+}
 
 
 
@@ -186,7 +186,7 @@ FilteredMatrix<Matrix,Vector>::vmult (Vector       &dst,
   tmp_mutex.release ();
                                   // finally do post-filtering
   post_filter (src, dst);
-};
+}
 
 
 
@@ -221,7 +221,7 @@ FilteredMatrix<Matrix,Vector>::residual (Vector       &dst,
   
   Assert (res2>=0, ExcInternalError());
   return std::sqrt (res2);
-};
+}
 
 
 
@@ -241,7 +241,7 @@ FilteredMatrix<Matrix,Vector>::Tvmult (Vector       &dst,
   tmp_mutex.release ();
                                   // finally do post-filtering
   post_filter (src, dst);
-};
+}
 
   
 
@@ -263,7 +263,7 @@ FilteredMatrix<Matrix,Vector>::matrix_norm_square (const Vector &v) const
   const value_type ret = matrix->matrix_norm_square (tmp_vector);
   tmp_mutex.release ();
   return ret;
-};
+}
 
 
 
@@ -288,7 +288,7 @@ precondition_Jacobi (Vector           &dst,
   const const_index_value_iterator e = constraints.end();
   for (; i!=e; ++i)
     dst(i->first) = src(i->first);
-};
+}
 
 
 
@@ -299,7 +299,7 @@ FilteredMatrix<Matrix,Vector>::memory_consumption () const
   return (MemoryConsumption::memory_consumption (matrix) +
          MemoryConsumption::memory_consumption (constraints) +
          MemoryConsumption::memory_consumption (tmp_vector));
-};
+}
 
 
 
index a923107b64be848c914e0f04afcf2d770d06591f..e3ef013dd55d178e2a83a426498dad793e3b30a1 100644 (file)
@@ -736,7 +736,7 @@ inline unsigned int
 FullMatrix<number>::m() const
 {
   return this->n_rows();
-};
+}
 
 
 
@@ -745,7 +745,7 @@ inline unsigned int
 FullMatrix<number>::n() const
 {
   return this->n_cols();
-};
+}
 
 
 template <typename number>
index db087fb5b81464b1aca1ce54cd57f98525f99f3d..060796c98d1e6543ca517c2adee48649a0ed4f95 100644 (file)
@@ -88,7 +88,7 @@ FullMatrix<number>::all_zero () const
       return false;
 
   return true;
-};
+}
 
 
 
@@ -102,7 +102,7 @@ FullMatrix<number>::operator *= (const double factor)
     *p++ *= factor;
 
   return *this;
-};
+}
 
 
 
@@ -271,7 +271,7 @@ FullMatrix<number>::vmult (Vector<number2>& dst,
          };
       };
   };
-};
+}
 
 
 
@@ -605,7 +605,7 @@ number2 FullMatrix<number>::matrix_norm_square (const Vector<number2> &v) const
     };
 
   return sum;
-};
+}
 
 
 template <typename number>
@@ -636,7 +636,7 @@ number2 FullMatrix<number>::matrix_scalar_product (const Vector<number2> &u,
     };
 
   return sum;
-};
+}
 
 
 
@@ -653,7 +653,7 @@ FullMatrix<number>::symmetrize ()
        const number t = (this->el(i,j) + this->el(j,i)) / 2;
        this->el(i,j) = this->el(j,i) = t;
       };
-};
+}
 
 
 template <typename number>
@@ -673,7 +673,7 @@ number FullMatrix<number>::l1_norm () const
        max = sum;
     }
   return max;
-};
+}
 
 
 template <typename number>
@@ -693,7 +693,7 @@ number FullMatrix<number>::linfty_norm () const
        max = sum;
     }
   return max;
-};
+}
 
 
 template <typename number>
@@ -1107,7 +1107,7 @@ FullMatrix<number>::operator == (const FullMatrix<number> &M) const
                         M.data()));
   
   return result;
-};
+}
 
 
 template <typename number>
@@ -1137,7 +1137,7 @@ FullMatrix<number>::determinant () const
       default:
             return 0;
     };
-};
+}
 
 
 template <typename number>
@@ -1335,7 +1335,7 @@ FullMatrix<number>::invert (const FullMatrix<number2> &M)
            *this = M;
            gauss_jordan();
     };    
-};
+}
 
 
 template <typename number>
@@ -1355,7 +1355,7 @@ FullMatrix<number>::precondition_Jacobi (Vector<somenumber>       &dst,
   
   for (unsigned int i=0; i<n; ++i, ++dst_ptr, ++src_ptr)
     *dst_ptr = om * *src_ptr / this->el(i,i);
-};
+}
 
 
 
@@ -1404,7 +1404,7 @@ FullMatrix<number>::print_formatted (std::ostream       &out,
                                   // reset output format
   out.flags (old_flags);
   out.precision(old_precision);
-};
+}
 
 
 
@@ -1567,7 +1567,7 @@ FullMatrix<number>::memory_consumption () const
 {
   return sizeof(*this) - sizeof (Table<2,number>)
     + Table<2,number>::memory_consumption();
-};
+}
 
 
 #endif
index f4b74f019dea12fb28784f229e69208df2054b19..326c2dbccce452a3c226671b2ea5820819349f14 100644 (file)
@@ -315,7 +315,7 @@ MatrixOut::get_element (const SparseMatrix<number> &matrix,
                        const unsigned int          j)
 {
   return matrix.el(i,j);
-};
+}
 
 
 
@@ -328,7 +328,7 @@ MatrixOut::get_element (const BlockSparseMatrix<number> &matrix,
                        const unsigned int               j)
 {
   return matrix.el(i,j);
-};
+}
 
 
 
@@ -341,7 +341,7 @@ MatrixOut::get_element (const Matrix       &matrix,
                        const unsigned int  j)
 {
   return matrix(i,j);
-};
+}
 
 
 
@@ -378,7 +378,7 @@ MatrixOut::get_gridpoint_value (const Matrix       &matrix,
        average += get_element (matrix, row, col);
   average /= n_elements;
   return average;
-};
+}
 
 
 
@@ -468,7 +468,7 @@ MatrixOut::build_patches (const Matrix      &matrix,
 
                                   // finally set the name
   this->name = name;
-};
+}
 
 
 
index a5bab3b292fef829ff3480769554909c27cca96a..bac456a0511e32a59c0eba72ef06a46f4ad2f6b7 100644 (file)
@@ -30,7 +30,7 @@ PreconditionBlock<MATRIX,inverse_type>::PreconditionBlock ():
                A(0),
                store_diagonals(false),
                same_diagonal(false)
-{};
+{}
 
 
 template <class MATRIX, typename inverse_type>
@@ -237,7 +237,7 @@ PreconditionBlock<MATRIX,inverse_type>::memory_consumption () const
   for (unsigned int i=0; i<var_diagonal.size(); ++i)
     mem += MemoryConsumption::memory_consumption(var_diagonal[i]);
   return mem;
-};
+}
 
 
 
index 5bf05dac8cc4d15990495f25f5ef7755b88ac23f..d3cda7836c1e6d168ef5fd814b2ef47bc02ab6db 100644 (file)
@@ -181,7 +181,7 @@ SolverControl &
 Solver<Vector>::control() const
 {
   return cntrl;
-};
+}
 
 
 template<class Vector>
@@ -189,7 +189,7 @@ inline
 Solver<Vector>::Solver(SolverControl &cn, VectorMemory<Vector> &mem)
                : cntrl(cn),
                  memory(mem)
-{};
+{}
 
 
 #endif
index a1aa8ea1ee5154d8ed8a1cd19cdf44d9f16b5f55..920608eff3601744036b01cc274990917c93e7b9 100644 (file)
@@ -301,7 +301,7 @@ SolverCG<VECTOR>::solve (const MATRIX         &A,
     throw SolverControl::NoConvergence (this->control().last_step(),
                                        this->control().last_value());
                                   // otherwise exit as normal
-};
+}
 
 
 #endif
index 9ae2b12816329d5ac221d6ee84b0ba2f82805852..555ce7517fd2bb1eb478f0391f7b31a482bfd0b9 100644 (file)
@@ -314,7 +314,7 @@ get_strengthen_diagonal(const number /*rowsum*/,
                        const unsigned int /*row*/) const
 {
   return strengthen_diagonal;
-};
+}
 
 
 
index e4a37461141c065c3d83bf39f0e54b8875f4f640..9ff2647f9a31d82078f8ac9ab53bb61bb5bdb2ec 100644 (file)
@@ -173,6 +173,6 @@ SparseILU<number>::apply_decomposition (Vector<somenumber>       &dst,
                                         const Vector<somenumber> &src) const
 {
   vmult (dst, src);
-};
+}
 
 #endif // __deal2__sparse_ilu_h
index 8d7a5ab659b8df0709d4177dd4adae3b28133179..90072d8f9361a78d4f5c3db4b6f7003276a3d8a0 100644 (file)
 
 template <typename number>
 SparseILU<number>::SparseILU ()
-{};
+{}
 
 
 
 template <typename number>
 SparseILU<number>::SparseILU (const SparsityPattern &sparsity) :
                SparseLUDecomposition<number> (sparsity)
-{};
+{}
 
 
 
@@ -145,7 +145,7 @@ void SparseILU<number>::decompose (const SparseMatrix<somenumber> &matrix,
                                   // because the for-loop doesn't do
                                   // it...
   this->diag_element(this->m()-1) = 1./this->diag_element(this->m()-1);
-};
+}
 
 
 
@@ -214,7 +214,7 @@ void SparseILU<number>::vmult (Vector<somenumber>       &dst,
                                       // was stored inverted
       dst(row) *= this->diag_element(row);
     };
-};
+}
 
 
 
@@ -223,7 +223,7 @@ unsigned int
 SparseILU<number>::memory_consumption () const
 {
   return SparseLUDecomposition<number>::memory_consumption ();
-};
+}
 
 
 
index 2b0f95c846bcb4fee3c586d0e32ec2ce59614712..80c92d4aab8b674677b9255dad3467636b4dafdc 100644 (file)
@@ -1139,7 +1139,7 @@ unsigned int SparseMatrix<number>::m () const
 {
   Assert (cols != 0, ExcMatrixNotInitialized());
   return cols->rows;
-};
+}
 
 
 template <typename number>
@@ -1148,7 +1148,7 @@ unsigned int SparseMatrix<number>::n () const
 {
   Assert (cols != 0, ExcMatrixNotInitialized());
   return cols->cols;
-};
+}
 
 
 template <typename number>
@@ -1169,7 +1169,7 @@ void SparseMatrix<number>::set (const unsigned int i,
 
   if (index != SparsityPattern::invalid_entry)
     val[index] = value;
-};
+}
 
 
 
@@ -1188,7 +1188,7 @@ void SparseMatrix<number>::add (const unsigned int i,
 
   if (value != 0.)
     val[index] += value;
-};
+}
 
 
 
@@ -1201,7 +1201,7 @@ number SparseMatrix<number>::operator () (const unsigned int i,
   Assert (cols->operator()(i,j) != SparsityPattern::invalid_entry,
          ExcInvalidIndex(i,j));
   return val[cols->operator()(i,j)];
-};
+}
 
 
 
@@ -1217,7 +1217,7 @@ number SparseMatrix<number>::el (const unsigned int i,
     return val[index];
   else
     return 0;
-};
+}
 
 
 
@@ -1233,7 +1233,7 @@ number SparseMatrix<number>::diag_element (const unsigned int i) const
                                   // row of a square matrix is the main
                                   // diagonal
   return val[cols->rowstart[i]];
-};
+}
 
 
 
@@ -1249,7 +1249,7 @@ number & SparseMatrix<number>::diag_element (const unsigned int i)
                                   // row of a square matrix is the main
                                   // diagonal
   return val[cols->rowstart[i]];
-};
+}
 
 
 
@@ -1264,7 +1264,7 @@ SparseMatrix<number>::raw_entry (const unsigned int row,
         ExcIndexRange(index,0,cols->row_length(row)));
 
   return val[cols->rowstart[row]+index];
-};
+}
 
 
 
@@ -1277,7 +1277,7 @@ number SparseMatrix<number>::global_entry (const unsigned int j) const
          ExcIndexRange (j, 0, cols->n_nonzero_elements()));
   
   return val[j];
-};
+}
 
 
 
@@ -1290,7 +1290,7 @@ number & SparseMatrix<number>::global_entry (const unsigned int j)
          ExcIndexRange (j, 0, cols->n_nonzero_elements()));
 
   return val[j];
-};
+}
 
 
 
@@ -1315,7 +1315,7 @@ SparseMatrix<number>::copy_from (const ForwardIterator begin,
                                         // write entries
        set (row, j->first, j->second);
     };
-};
+}
 
 
 //----------------------------------------------------------------------//
index 3f235788aedf51e86259bf77d2617cec4c23a141..eecee090db652519b223e687b841974f06da34df 100644 (file)
@@ -45,7 +45,7 @@ SparseMatrix<number>::SparseMatrix () :
                cols(0),
                val(0),
                max_len(0)
-{};
+{}
 
 
 
@@ -59,7 +59,7 @@ SparseMatrix<number>::SparseMatrix (const SparseMatrix &m) :
   Assert (m.cols==0, ExcInvalidConstructorCall());
   Assert (m.val==0, ExcInvalidConstructorCall());
   Assert (m.max_len==0, ExcInvalidConstructorCall());
-};
+}
 
 
 
@@ -72,7 +72,7 @@ SparseMatrix<number>::operator = (const SparseMatrix<number> &m)
   Assert (m.max_len==0, ExcInvalidConstructorCall());
 
   return *this;
-};
+}
 
 
 
@@ -83,7 +83,7 @@ SparseMatrix<number>::SparseMatrix (const SparsityPattern &c) :
                max_len(0)
 {
   reinit();
-};
+}
 
 
 
@@ -94,7 +94,7 @@ SparseMatrix<number>::~SparseMatrix ()
   
   if (val != 0)
     delete[] val;
-};
+}
 
 
 
@@ -133,7 +133,7 @@ SparseMatrix<number>::reinit (const SparsityPattern &sparsity)
 {
   cols = &sparsity;
   reinit ();
-};
+}
 
 
 
@@ -145,7 +145,7 @@ SparseMatrix<number>::clear ()
   if (val) delete[] val;
   val = 0;
   max_len = 0;
-};
+}
 
 
 
@@ -157,7 +157,7 @@ SparseMatrix<number>::empty () const
     return true;
   else
     return cols->empty();
-};
+}
 
 
 
@@ -167,7 +167,7 @@ SparseMatrix<number>::n_nonzero_elements () const
 {
   Assert (cols != 0, ExcMatrixNotInitialized());
   return cols->n_nonzero_elements ();
-};
+}
 
 
 
@@ -178,7 +178,7 @@ SparseMatrix<number>::n_actually_nonzero_elements () const
   Assert (cols != 0, ExcMatrixNotInitialized());
   return std::count_if(&val[0], &val[n_nonzero_elements ()],
                       std::bind2nd(std::not_equal_to<double>(), 0));
-};
+}
 
 
 
@@ -215,7 +215,7 @@ SparseMatrix<number>::symmetrize ()
          ++colnum_ptr;
        };
     };
-};
+}
 
 
 
@@ -232,7 +232,7 @@ SparseMatrix<number>::copy_from (const SparseMatrix<somenumber> &matrix)
             &val[0]);
   
   return *this;
-};
+}
 
 
 
@@ -249,7 +249,7 @@ SparseMatrix<number>::copy_from (const FullMatrix<somenumber> &matrix)
     for (unsigned int col=0; col<matrix.n(); ++col)
       if (matrix(row,col) != 0)
        set (row, col, matrix(row,col));
-};
+}
 
 
 
@@ -269,7 +269,7 @@ SparseMatrix<number>::add_scaled (const number factor,
 
   while (val_ptr != end_ptr)
     *val_ptr++ += factor * *matrix_ptr++;
-};
+}
 
 
 template <typename number>
@@ -342,7 +342,7 @@ SparseMatrix<number>::vmult (Vector<somenumber>& dst,
          *dst_ptr++ = s;
        };
     };
-};
+}
 
 
 template <typename number>
@@ -368,7 +368,7 @@ SparseMatrix<number>::threaded_vmult (Vector<somenumber>       &dst,
        s += *val_ptr++ * src(*colnum_ptr++);
       *dst_ptr++ = s;
     };
-};
+}
 
 
 template <typename number>
@@ -416,7 +416,7 @@ SparseMatrix<number>::vmult_add (Vector<somenumber>& dst, const Vector<somenumbe
        s += *val_ptr++ * src(*colnum_ptr++);
       *dst_ptr++ += s;
     };
-};
+}
 
 
 template <typename number>
@@ -519,7 +519,7 @@ SparseMatrix<number>::matrix_norm_square (const Vector<somenumber>& v) const
       
       return sum;
     };
-};
+}
 
 
 
@@ -548,7 +548,7 @@ SparseMatrix<number>::threaded_matrix_norm_square (const Vector<somenumber> &v,
       sum += s* v(row);
     };
   *partial_sum = sum;
-};
+}
 
 
 
@@ -633,7 +633,7 @@ SparseMatrix<number>::matrix_scalar_product (const Vector<somenumber>& u,
       
       return sum;
     };
-};
+}
 
 
 
@@ -663,7 +663,7 @@ SparseMatrix<number>::threaded_matrix_scalar_product (const Vector<somenumber> &
       sum += s* u(row);
     };
   *partial_sum = sum;
-};
+}
 
 
 
@@ -682,7 +682,7 @@ number SparseMatrix<number>::l1_norm () const
       column_sums(cols->colnums[j]) += std::fabs(val[j]);
 
   return column_sums.linfty_norm();
-};
+}
 
 
 template <typename number>
@@ -705,7 +705,7 @@ number SparseMatrix<number>::linfty_norm () const
        max = sum;
     }
   return max;
-};
+}
 
 
 template <typename number>
@@ -824,7 +824,7 @@ SparseMatrix<number>::threaded_residual (Vector<somenumber>       &dst,
     };
 
   *partial_norm = norm;
-};
+}
 
 
 
@@ -852,7 +852,7 @@ SparseMatrix<number>::precondition_Jacobi (Vector<somenumber>       &dst,
                                     // in each row, i.e. at index
                                     // rowstart[i]
     *dst_ptr = om * *src_ptr / val[*rowstart_ptr];
-};
+}
 
 
 
@@ -938,7 +938,7 @@ SparseMatrix<number>::precondition_SOR (Vector<somenumber>& dst, const Vector<so
 
   dst = src;
   SOR(dst,om);
-};
+}
 
 
 template <typename number>
@@ -953,7 +953,7 @@ SparseMatrix<number>::precondition_TSOR (Vector<somenumber>& dst, const Vector<s
 
   dst = src;
   TSOR(dst,om);
-};
+}
 
 
 template <typename number>
@@ -1113,7 +1113,7 @@ SparseMatrix<number>::get_sparsity_pattern () const
 {
   Assert (cols != 0, ExcMatrixNotInitialized());
   return *cols;
-};
+}
 
 
 
@@ -1128,7 +1128,7 @@ void SparseMatrix<number>::print (std::ostream &out) const
       out << "(" << i << "," << cols->colnums[j] << ") " << val[j] << std::endl;
 
   AssertThrow (out, ExcIO());
-};
+}
 
 
 template <typename number>
@@ -1173,7 +1173,7 @@ void SparseMatrix<number>::print_formatted (std::ostream &out,
                                   // reset output format
   out.precision(old_precision);
   out.flags (old_flags);
-};
+}
 
 
 
@@ -1193,7 +1193,7 @@ SparseMatrix<number>::block_write (std::ostream &out) const
   out << ']';
   
   AssertThrow (out, ExcIO());
-};
+}
 
 
 
@@ -1225,7 +1225,7 @@ SparseMatrix<number>::block_read (std::istream &in)
            - reinterpret_cast<char*>(&val[0]));
   in >> c;
   AssertThrow (c == ']', ExcIO());
-};
+}
 
 
 
@@ -1234,7 +1234,7 @@ unsigned int
 SparseMatrix<number>::memory_consumption () const
 {
   return sizeof(*this) + max_len*sizeof(number);
-};
+}
 
 
 #endif
index a0d88a0d84d91e50ea6aa6597fb8526421ff4b51..677be56cff73a34650ff9829fea0629657090fb1 100644 (file)
@@ -23,7 +23,7 @@ SparseMIC<number>::SparseMIC ()
                 diag(0),
                 inv_diag(0),
                 inner_sums(0)
-{};
+{}
 
 
 
@@ -34,7 +34,7 @@ SparseMIC<number>::SparseMIC (const SparsityPattern &sparsity)
                 diag(0),
                 inv_diag(0),
                 inner_sums(0)
-{};
+{}
 
 
 
@@ -138,7 +138,7 @@ void SparseMIC<number>::decompose (const SparseMatrix<somenumber> &matrix,
     inv_diag[row] = 1.0/diag[row];
     Assert(diag[row]>0, ExcInternal());
   }
-};
+}
 
 
 
@@ -161,7 +161,7 @@ SparseMIC<number>::get_rowsum (const unsigned int row) const
     rowsum += this->global_entry (col-column_numbers);
 
   return rowsum;       
-};
+}
 
 
 
@@ -215,7 +215,7 @@ SparseMIC<number>::vmult (Vector<somenumber>       &dst,
 
       dst(row) *= inv_diag[row];
     };
-};
+}
 
 
 
@@ -227,7 +227,7 @@ SparseMIC<number>::memory_consumption () const
           MemoryConsumption::memory_consumption(diag) +
           MemoryConsumption::memory_consumption(inv_diag) +
           MemoryConsumption::memory_consumption(inner_sums));
-};
+}
 
 
 
index 67105dd0d0d3a3b4ee9420a83745392e1976bf8e..821de0f7bd95f465433ea1a1c4f8eebc93fc525f 100644 (file)
@@ -129,7 +129,7 @@ SparseVanka<number>::compute_inverses ()
   
       thread_manager.wait ();
     };
-};
+}
 
 
 template <typename number>
@@ -147,7 +147,7 @@ SparseVanka<number>::compute_inverses (const unsigned int begin,
   for (unsigned int row=begin; row<end; ++row)
     if (selected[row] == true)
       compute_inverse (row, local_indices);
-};
+}
 
 
 
@@ -191,7 +191,7 @@ SparseVanka<number>::compute_inverse (const unsigned int         row,
   
                                   // Compute inverse
   inverses[row]->gauss_jordan();
-};
+}
 
 
 template<typename number>
@@ -205,7 +205,7 @@ SparseVanka<number>::vmult (Vector<number2>       &dst,
                                   // then pass on to the function
                                   // that actually does the work
   apply_preconditioner (dst, src);
-};
+}
 
 
 
@@ -366,7 +366,7 @@ SparseVanka<number>::apply_preconditioner (Vector<number2>         &dst,
        if (conserve_mem == true)
          inverses[row] = 0;
       };
-};
+}
 
 
 
@@ -380,7 +380,7 @@ SparseVanka<number>::memory_consumption () const
     mem += MemoryConsumption::memory_consumption (*inverses[i]);
   
   return mem;
-};
+}
 
 
 
@@ -399,7 +399,7 @@ SparseBlockVanka<number>::SparseBlockVanka (const SparseMatrix<number> &M,
                           std::vector<bool>(M.m(), false))
 {
   compute_dof_masks (M, selected, blocking_strategy);
-};
+}
 
 
 template <typename number>
@@ -561,7 +561,7 @@ SparseBlockVanka<number>::compute_dof_masks (const SparseMatrix<number> &M,
       default:
            Assert (false, ExcInternalError());
     };
-};
+}
 
 
 
@@ -625,7 +625,7 @@ SparseBlockVanka<number>::memory_consumption () const
   for (unsigned int i=0; i<dof_masks.size(); ++i)
     mem += MemoryConsumption::memory_consumption (dof_masks[i]);
   return mem;
-};
+}
 
          
 
index a93971c0f4fe4c787f6a5314d21438b9993a75e7..fb310c2e186118fbd677e9e2b97db746cc163638 100644 (file)
@@ -1140,7 +1140,7 @@ unsigned int
 SparsityPattern::n_rows () const
 {
   return rows;
-};
+}
 
 
 inline
@@ -1148,7 +1148,7 @@ unsigned int
 SparsityPattern::n_cols () const
 {
   return cols;
-};
+}
 
 
 inline
@@ -1156,7 +1156,7 @@ bool
 SparsityPattern::is_compressed () const
 {
   return compressed;
-};
+}
 
 
 inline
@@ -1164,7 +1164,7 @@ const unsigned int *
 SparsityPattern::get_rowstart_indices () const
 {
   return rowstart;
-};
+}
 
 
 inline
@@ -1172,7 +1172,7 @@ const unsigned int *
 SparsityPattern::get_column_numbers () const
 {
   return colnums;
-};
+}
 
 
 inline
@@ -1203,7 +1203,7 @@ SparsityPattern::n_nonzero_elements () const
   Assert ((rowstart!=0) && (colnums!=0), ExcEmptyObject());  
   Assert (compressed, ExcNotCompressed());
   return rowstart[rows]-rowstart[0];
-};
+}
 
 
 
@@ -1212,7 +1212,7 @@ unsigned int
 SparsityPattern::get_column_index_from_iterator (const unsigned int i)
 {
   return i;
-};
+}
 
 
 
@@ -1223,7 +1223,7 @@ SparsityPattern::
 get_column_index_from_iterator (const std::pair<unsigned int, value> &i)
 {
   return i.first;
-};
+}
 
 
 
@@ -1233,7 +1233,7 @@ unsigned int
 SparsityPattern::get_column_index_from_iterator (const std::pair<const unsigned int, value> &i)
 {
   return i.first;
-};
+}
 
 
 
@@ -1295,7 +1295,7 @@ SparsityPattern::copy_from (const unsigned int    n_rows,
                                   // everything. this also sorts the
                                   // entries within each row
   compress ();
-};
+}
 
 
 #endif
index 11502d26f18dc59577a6c5eafc8cf2f1d018aea0..14a7aec290b46e26884d7a8d4ba42a63e104563f 100644 (file)
@@ -31,7 +31,7 @@ template <typename number>
 SwappableVector<number>::SwappableVector ()
                :
                data_is_preloaded (false)
-{};
+{}
 
 
 
@@ -42,7 +42,7 @@ SwappableVector<number>::SwappableVector (const SwappableVector<number> &v) :
                 data_is_preloaded (false)
 {
   Assert (v.filename == "", ExcInvalidCopyOperation());
-};
+}
 
 
 
@@ -58,7 +58,7 @@ SwappableVector<number>::~SwappableVector ()
 
   if (filename != "")
     kill_file ();
-};
+}
 
 
 
@@ -81,7 +81,7 @@ SwappableVector<number>::operator= (const SwappableVector<number> &v)
   lock.release ();
   
   return *this;
-};
+}
 
 
 
@@ -117,7 +117,7 @@ void SwappableVector<number>::swap_out (const std::string &name)
   this->reinit (0);
 
   lock.release ();
-};
+}
 
 
 
@@ -149,7 +149,7 @@ void SwappableVector<number>::reload ()
                                       // branch of the if-clause
       lock.release ();
     };
-};
+}
 
 
 
@@ -182,7 +182,7 @@ void SwappableVector<number>::alert ()
                    .collect_args(this, true));
                                   // note that reload_vector also
                                   // releases the lock
-};
+}
 
 
 
@@ -206,7 +206,7 @@ void SwappableVector<number>::reload_vector (const bool set_flag)
         data_is_preloaded = true;
       lock.release ();
     };
-};
+}
 
 
 
@@ -235,7 +235,7 @@ void SwappableVector<number>::kill_file ()
     };
 
   lock.release ();
-};
+}
 
 
 
@@ -244,7 +244,7 @@ const std::string &
 SwappableVector<number>::get_filename () const 
 {
   return filename;
-};
+}
 
 
 
@@ -256,7 +256,7 @@ SwappableVector<number>::memory_consumption () const
          sizeof(lock) +
          MemoryConsumption::memory_consumption (data_is_preloaded) +
          Vector<number>::memory_consumption ());
-};
+}
 
 
 
index 98a813906fe64646e6169c26a8793d89c90425ed..a0f36791ce18adfca54e8f2515982cbc2b3258fe 100644 (file)
@@ -595,7 +595,7 @@ Vector<Number>::Vector (const InputIterator first, const InputIterator last)
                                   // over to it in a second
   reinit (std::distance (first, last), true);
   std::copy (first, last, begin());
-};
+}
 
 
 
@@ -675,7 +675,7 @@ typename Vector<Number>::iterator
 Vector<Number>::begin () 
 {
   return &val[0];
-};
+}
 
 
 
@@ -685,7 +685,7 @@ typename Vector<Number>::const_iterator
 Vector<Number>::begin () const 
 {
   return &val[0];
-};
+}
 
 
 
@@ -695,7 +695,7 @@ typename Vector<Number>::iterator
 Vector<Number>::end () 
 {
   return &val[dim];
-};
+}
 
 
 
@@ -705,7 +705,7 @@ typename Vector<Number>::const_iterator
 Vector<Number>::end () const 
 {
   return &val[dim];
-};
+}
 
 
 
@@ -735,7 +735,7 @@ Vector<Number> & Vector<Number>::operator *= (const Number factor)
 {
   scale (factor);
   return *this;
-};
+}
 
 
 
@@ -763,7 +763,7 @@ inline
 void swap (Vector<Number> &u, Vector<Number> &v)
 {
   u.swap (v);
-};
+}
 
 
 
index 419f4e9e6f6f820c1bfa2231d653b9007da75a05..8f8f2fd1061bbedd7971bd4f23159f6312cc8800 100644 (file)
@@ -34,7 +34,7 @@ template <typename Number>
 static inline Number sqr (const Number x)
 {
   return x*x;
-};
+}
 
 
 
@@ -76,7 +76,7 @@ template <typename Number2>
 void Vector<Number>::reinit (const Vector<Number2>& v, const bool fast)
 {
   reinit (v.size(), fast);
-};
+}
 
 
 
@@ -87,7 +87,7 @@ Vector<Number>::swap (Vector<Number> &v)
   std::swap (dim,    v.dim);
   std::swap (maxdim, v.maxdim);
   std::swap (val,    v.val);
-};
+}
 
 
 
@@ -102,7 +102,7 @@ bool Vector<Number>::all_zero () const
     if (*p++ != 0.0)
       return false;
   return true;
-};
+}
 
 
 template <typename Number>
@@ -169,7 +169,7 @@ Number Vector<Number>::norm_sqr () const
     sum0 += ::sqr(*ptr++);
   
   return sum0+sum1+sum2+sum3;
-};
+}
 
 
 template <typename Number>
@@ -199,7 +199,7 @@ Number Vector<Number>::mean_value () const
     sum0 += *ptr++;
   
   return (sum0+sum1+sum2+sum3)/size();
-};
+}
 
 
 template <typename Number>
@@ -229,14 +229,14 @@ Number Vector<Number>::l1_norm () const
     sum0 += std::fabs(*ptr++);
   
   return sum0+sum1+sum2+sum3;
-};
+}
 
 
 template <typename Number>
 Number Vector<Number>::l2_norm () const
 {
   return std::sqrt(norm_sqr());
-};
+}
 
 
 template <typename Number>
@@ -267,7 +267,7 @@ Number Vector<Number>::lp_norm (const Number p) const
   
   return std::pow(sum0+sum1+sum2+sum3,
                  static_cast<Number>(1./p));
-};
+}
 
 
 template <typename Number>
@@ -292,7 +292,7 @@ Number Vector<Number>::linfty_norm () const {
 
   return std::max (std::max(max0, max1),
                   std::max(max2, max3));
-};
+}
 
 
 template <typename Number>
@@ -516,7 +516,7 @@ void Vector<Number>::ratio (const Vector<Number> &a, const Vector<Number> &b)
                 b_ptr = b.begin();
   while (i_ptr!=i_end)
     *i_ptr++ = *a_ptr++ / *b_ptr++;
-};
+}
 
 
 
@@ -584,7 +584,7 @@ void Vector<Number>::print (std::ostream      &out,
   out << std::endl;
   
   AssertThrow (out, ExcIO());
-};
+}
 
 
 
@@ -615,7 +615,7 @@ void Vector<Number>::block_write (std::ostream &out) const
   out.write (&outro, 1);
   
   AssertThrow (out, ExcIO());
-};
+}
 
 
 
@@ -657,7 +657,7 @@ unsigned int
 Vector<Number>::memory_consumption () const
 {
   return sizeof(*this) + (maxdim * sizeof(Number));
-};
+}
 
 
 #endif
index 404940c31b182acc39cc31272a80d37a2591b99d..d273fd4f4785debf68e856616f1c50871f54ac3d 100644 (file)
@@ -21,7 +21,7 @@ BlockSparsityPatternBase<SparsityPatternBase>::BlockSparsityPatternBase ()
                :
                rows (0),
                columns (0)
-{};
+{}
 
 
 
@@ -34,7 +34,7 @@ BlockSparsityPatternBase (const unsigned int r,
                columns (0)
 {
   reinit (r,c);
-};
+}
 
 
 
@@ -48,7 +48,7 @@ BlockSparsityPatternBase<SparsityPatternBase>::BlockSparsityPatternBase (
 
   rows = 0;
   columns=0;
-};
+}
 
 
 
@@ -57,7 +57,7 @@ BlockSparsityPatternBase<SparsityPatternBase>::~BlockSparsityPatternBase ()
 {
                                   // clear all memory
   reinit (0,0);
-};
+}
 
 
 
@@ -85,7 +85,7 @@ BlockSparsityPatternBase<SparsityPatternBase>::reinit (const unsigned int r,
   for (unsigned int i=0; i<rows; ++i)
     for (unsigned int j=0; j<columns; ++j)
       sub_objects[i][j] = new SparsityPatternBase;
-};
+}
 
 
 
@@ -104,7 +104,7 @@ operator = (const BlockSparsityPatternBase<SparsityPatternBase> &bsp)
   collect_sizes ();
 
   return *this;
-};
+}
   
 
 
@@ -143,7 +143,7 @@ BlockSparsityPatternBase<SparsityPatternBase>::collect_sizes ()
                                   // finally initialize the row
                                   // indices with this array
   column_indices.reinit (col_sizes);
-};
+}
 
 
 
@@ -154,7 +154,7 @@ BlockSparsityPatternBase<SparsityPatternBase>::compress ()
   for (unsigned int i=0; i<rows; ++i)
     for (unsigned int j=0; j<columns; ++j)
       sub_objects[i][j]->compress ();
-};
+}
 
 
 
@@ -167,7 +167,7 @@ BlockSparsityPatternBase<SparsityPatternBase>::empty () const
       if (sub_objects[i][j]->empty () == false)
        return false;
   return true;
-};
+}
 
 
 
@@ -186,7 +186,7 @@ BlockSparsityPatternBase<SparsityPatternBase>::max_entries_per_row () const
        max_entries = this_row;
     };
   return max_entries;
-};
+}
 
 
 
@@ -200,7 +200,7 @@ BlockSparsityPatternBase<SparsityPatternBase>::n_rows () const
   for (unsigned int r=0; r<rows; ++r)
     count += sub_objects[r][0]->n_rows();
   return count;
-};
+}
 
 
 
@@ -214,7 +214,7 @@ BlockSparsityPatternBase<SparsityPatternBase>::n_cols () const
   for (unsigned int c=0; c<columns; ++c)
     count += sub_objects[0][c]->n_cols();
   return count;
-};
+}
 
 
 
@@ -227,12 +227,12 @@ BlockSparsityPatternBase<SparsityPatternBase>::n_nonzero_elements () const
     for (unsigned int j=0; j<columns; ++j)
       count += sub_objects[i][j]->n_nonzero_elements ();
   return count;
-};
+}
 
 
 
 BlockSparsityPattern::BlockSparsityPattern ()
-{};
+{}
 
 
 
@@ -241,7 +241,7 @@ BlockSparsityPattern::BlockSparsityPattern (const unsigned int n_rows,
                :
                BlockSparsityPatternBase<SparsityPattern>(n_rows,
                                                          n_columns)
-{};
+{}
 
 
 
@@ -253,7 +253,7 @@ BlockSparsityPattern::is_compressed () const
       if (sub_objects[i][j]->is_compressed () == false)
        return false;
   return true;
-};
+}
 
 
 
@@ -271,7 +271,7 @@ BlockSparsityPattern::memory_consumption () const
       mem += MemoryConsumption::memory_consumption (*sub_objects[r][c]);
   
   return mem;
-};
+}
 
 
 
@@ -290,12 +290,12 @@ BlockSparsityPattern::copy_from  (const CompressedBlockSparsityPattern &csp)
                                   // and finally enquire their new
                                   // sizes
   collect_sizes();
-};
+}
 
 
 
 CompressedBlockSparsityPattern::CompressedBlockSparsityPattern ()
-{};
+{}
 
 
 
@@ -305,7 +305,7 @@ CompressedBlockSparsityPattern (const unsigned int n_rows,
                :
                BlockSparsityPatternBase<CompressedSparsityPattern>(n_rows,
                                                                    n_columns)
-{};
+{}
 
 
 
index dff8748811e54e34cc30d13daface57fc887aeab..4ba71f08979bd4da210e2c2187b742d8084d6e59 100644 (file)
@@ -49,4 +49,4 @@ namespace BlockVectorIterators
 
   template class Iterator<float,false>;
   template class Iterator<float,true>;
-};
+}
index 9f693e32c4a5cd58b045d7c70f90e8c5f2da12dc..2a62abc0046cb11ac7a06cb0c2a2856c6699cb66 100644 (file)
@@ -24,7 +24,7 @@
 CompressedSparsityPattern::CompressedSparsityPattern () :
                rows(0),
                cols(0)
-{};
+{}
 
 
 
@@ -35,7 +35,7 @@ CompressedSparsityPattern::CompressedSparsityPattern (const CompressedSparsityPa
 {
   Assert (s.rows == 0, ExcInvalidConstructorCall());
   Assert (s.cols == 0, ExcInvalidConstructorCall());
-};
+}
 
 
 
@@ -45,7 +45,7 @@ CompressedSparsityPattern::CompressedSparsityPattern (const unsigned int m,
                  cols(0)
 {
   reinit (m,n);
-};
+}
 
 
 
@@ -54,7 +54,7 @@ CompressedSparsityPattern::CompressedSparsityPattern (const unsigned int n)
                  cols(0)
 {
   reinit (n,n);
-};
+}
 
 
 
@@ -68,7 +68,7 @@ CompressedSparsityPattern::operator = (const CompressedSparsityPattern &s)
   Assert (cols == 0, ExcInvalidConstructorCall());
 
   return *this;
-};
+}
 
 
 
@@ -87,7 +87,7 @@ CompressedSparsityPattern::reinit (const unsigned int m,
 
 void
 CompressedSparsityPattern::compress ()
-{};
+{}
 
 
 
@@ -95,7 +95,7 @@ bool
 CompressedSparsityPattern::empty () const
 {
   return ((rows==0) && (cols==0));
-};
+}
 
 
 
@@ -107,7 +107,7 @@ CompressedSparsityPattern::max_entries_per_row () const
     m = std::max (m, static_cast<unsigned int>(column_indices[i].size()));
 
   return m;
-};
+}
 
 
 
@@ -122,7 +122,7 @@ CompressedSparsityPattern::add (const unsigned int i,
                                   // assures uniqueness and
                                   // sortedness of the column indices
   column_indices[i].insert (j);
-};
+}
 
 
 bool 
@@ -159,7 +159,7 @@ CompressedSparsityPattern::symmetrize ()
                                       // this is not the diagonal
       if (row != *i)
        add (*i, row);
-};
+}
 
 
 
@@ -187,7 +187,7 @@ unsigned int
 CompressedSparsityPattern::row_length (const unsigned int row) const
 {
   return column_indices[row].size();
-};
+}
 
 
 
@@ -200,7 +200,7 @@ CompressedSparsityPattern::column_number (const unsigned int row,
   std::set<unsigned int>::const_iterator p = column_indices[row].begin();
   std::advance (p, index);
   return *p;
-};
+}
 
 
 
@@ -215,7 +215,7 @@ CompressedSparsityPattern::bandwidth () const
        b = std::abs(static_cast<signed int>(row-*i));
 
   return b;
-};
+}
 
 
 
@@ -226,4 +226,4 @@ CompressedSparsityPattern::n_nonzero_elements () const
   for (unsigned int i=0; i<rows; ++i)
     n += column_indices[i].size();
   return n;
-};
+}
index 79a6be85a9cf487a825b79401e36e421a9bd8c57..79be8c6f408e79282f263ae7e03665761d58ba11 100644 (file)
@@ -69,7 +69,7 @@ get_column_entries (const unsigned int           index,
                                                       (*matrix)(row,index)));
          };
     };
-};
+}
 
 
 
@@ -83,7 +83,7 @@ get_column_entries (const unsigned int           /*index*/,
                                   // presently not implemented, but
                                   // should be fairly simple to do
   Assert (false, ExcNotImplemented());
-};
+}
 
 
 
@@ -96,7 +96,7 @@ allocate_tmp_vector ()
   tmp_mutex.acquire ();
   tmp_vector.reinit (matrix->n(), true);
   tmp_mutex.release ();
-};
+}
 
 
 
@@ -108,7 +108,7 @@ allocate_tmp_vector ()
   tmp_mutex.acquire ();
   tmp_vector.reinit (matrix->n(), true);
   tmp_mutex.release ();
-};
+}
 
 
 
@@ -124,7 +124,7 @@ allocate_tmp_vector ()
   tmp_mutex.acquire ();
   tmp_vector.reinit (block_sizes, true);
   tmp_mutex.release ();
-};
+}
 
 
 
@@ -140,7 +140,7 @@ allocate_tmp_vector ()
   tmp_mutex.acquire ();
   tmp_vector.reinit (block_sizes, true);
   tmp_mutex.release ();
-};
+}
 
 
 template class FilteredMatrix<SparseMatrix<double>,Vector<double> >;
index f49391fb2d1f6658bbe7fd52cfa66e26f1e8c9aa..d74faf330615b62bba66f3bbf06356e4147516a0 100644 (file)
@@ -22,12 +22,12 @@ MatrixOut::Options::Options (const bool         show_absolute_values,
                show_absolute_values (show_absolute_values),
                block_size (block_size),
                discontinuous (discontinuous)
-{};
+{}
 
 
 
 MatrixOut::~MatrixOut () 
-{};
+{}
 
 
 
@@ -35,7 +35,7 @@ const std::vector<MatrixOut::Patch> &
 MatrixOut::get_patches () const
 {
   return patches;
-};
+}
 
 
 
@@ -43,4 +43,4 @@ std::vector<std::string>
 MatrixOut::get_dataset_names () const
 {
   return std::vector<std::string>(1,name);
-};
+}
index e2271bfee1269589844c343b9f453bf2b3b6f253..958c3e680977deb73bcafc23de5ba2dea4539e15 100644 (file)
@@ -32,7 +32,7 @@ SolverControl::NoConvergence::NoConvergence (const unsigned int last_step,
                :
                last_step (last_step),
                last_residual (last_residual)
-{};
+{}
 
 
 const char *
@@ -85,12 +85,12 @@ SolverControl::SolverControl (const unsigned int maxiter,
                m_log_history(m_log_history),
                m_log_frequency(1),
                m_log_result(m_log_result)
-{};
+{}
 
 
 
 SolverControl::~SolverControl() 
-{};
+{}
 
 
 
@@ -211,17 +211,17 @@ ReductionControl::ReductionControl(const unsigned int n,
                :
                SolverControl (n, tol, m_log_history, m_log_result),
                reduce(red)
-{};
+{}
 
 
 ReductionControl::~ReductionControl()
-{};
+{}
 
 
 double
 ReductionControl::initial_value() const {
   return initial_val;
-};
+}
 
 
 SolverControl::State
@@ -254,7 +254,7 @@ ReductionControl::check (const unsigned int step,
     }
   else
     return SolverControl::check(step, check_value);
-};
+}
 
 
 
index 13e12ae3c0d75b53419d51bface5deae3972eb1f..ea80b673c5acaa50324a5a3e6580a7653576c05f 100644 (file)
@@ -64,7 +64,7 @@ namespace HSL
       AssertThrow (false, ExcMessage("You can only use the HSL functions after putting "
                                     "the respective files in the right place, "
                                     "re-configuring the library and re-building it!"));
-    };
+    }
 
     
     extern "C"
@@ -85,7 +85,7 @@ namespace HSL
       AssertThrow (false, ExcMessage("You can only use the HSL functions after putting "
                                     "the respective files in the right place, "
                                     "re-configuring the library and re-building it!"));
-    };
+    }
 
 
     extern "C"
@@ -103,7 +103,7 @@ namespace HSL
       AssertThrow (false, ExcMessage("You can only use the HSL functions after putting "
                                     "the respective files in the right place, "
                                     "re-configuring the library and re-building it!"));
-    };
+    }
 
 
     extern "C" void ma27x1_ (unsigned int *)
@@ -111,7 +111,7 @@ namespace HSL
       AssertThrow (false, ExcMessage("You can only use the HSL functions after putting "
                                     "the respective files in the right place, "
                                     "re-configuring the library and re-building it!"));
-    };
+    }
       
 
     extern "C" void ma27x2_ (unsigned int *)
@@ -119,7 +119,7 @@ namespace HSL
       AssertThrow (false, ExcMessage("You can only use the HSL functions after putting "
                                     "the respective files in the right place, "
                                     "re-configuring the library and re-building it!"));
-    };
+    }
       
     
     extern "C" void ma27x3_ (const unsigned int *)
@@ -127,9 +127,9 @@ namespace HSL
       AssertThrow (false, ExcMessage("You can only use the HSL functions after putting "
                                     "the respective files in the right place, "
                                     "re-configuring the library and re-building it!"));
-    };
+    }
   }
-};
+}
 #endif  // ifndef HAVE_HSL_MA27
 
 
@@ -145,7 +145,7 @@ namespace HSL
       AssertThrow (false, ExcMessage("You can only use the HSL functions after putting "
                                     "the respective files in the right place, "
                                     "re-configuring the library and re-building it!"));
-    };
+    }
     
 
     extern "C"
@@ -163,7 +163,7 @@ namespace HSL
       AssertThrow (false, ExcMessage("You can only use the HSL functions after putting "
                                     "the respective files in the right place, "
                                     "re-configuring the library and re-building it!"));
-    };
+    }
 
       
     extern "C"
@@ -184,7 +184,7 @@ namespace HSL
       AssertThrow (false, ExcMessage("You can only use the HSL functions after putting "
                                     "the respective files in the right place, "
                                     "re-configuring the library and re-building it!"));
-    };
+    }
 
     
     extern "C"
@@ -201,9 +201,9 @@ namespace HSL
       AssertThrow (false, ExcMessage("You can only use the HSL functions after putting "
                                     "the respective files in the right place, "
                                     "re-configuring the library and re-building it!"));
-    };    
+    }
   }
-};
+}
 #endif   // ifndef HAVE_HSL_MA47
 
 
@@ -264,7 +264,7 @@ namespace CommunicationsLog
     list_access_lock.acquire ();
     communication_log.push_back (record);
     list_access_lock.release ();
-  };
+  }
 
 
                                    /**
@@ -294,7 +294,7 @@ namespace CommunicationsLog
     std::cerr << "++++++++++++++++++++++++++++++" << std::endl;
 
     list_access_lock.release ();
-  };
+  }
 
 
                                    /**
@@ -314,8 +314,8 @@ namespace CommunicationsLog
       if (i->child_pid == child_pid)
         communication_log.erase (i);
     list_access_lock.release ();
-  };
-};
+  }
+}
 
 
 
@@ -331,7 +331,7 @@ namespace
               << std::endl;
     CommunicationsLog::list_communication (child);
     std::abort ();
-  };
+  }
 
 
 /**
@@ -349,8 +349,8 @@ namespace
               << std::endl;
     CommunicationsLog::list_communication (child);
     std::abort ();
-  };
-};
+  }
+}
 
 
 
@@ -476,7 +476,7 @@ SparseDirectMA27::SparseDirectMA27 (const double LIW_factor_1,
                initialize_called (false),
                factorize_called (false),
                sparsity_pattern (0)
-{};
+{}
 
 
 
@@ -502,7 +502,7 @@ SparseDirectMA27::~SparseDirectMA27()
         delete detached_mode_data;
         detached_mode_data = 0;
       };
-};
+}
 
 
 
@@ -511,7 +511,7 @@ SparseDirectMA27::set_detached_mode ()
 {
   Assert (initialize_called == false, ExcInitializeAlreadyCalled());
   detached_mode = true;
-};
+}
 
 
 
@@ -519,7 +519,7 @@ bool
 SparseDirectMA27::detached_mode_set () const
 {
   return detached_mode;
-};
+}
 
 
 
@@ -703,7 +703,7 @@ SparseDirectMA27::initialize (const SparsityPattern &sp)
                                   // note that we have already been
                                   // in this function
   initialize_called = true;
-};
+}
 
 
 
@@ -848,7 +848,7 @@ SparseDirectMA27::factorize (const SparseMatrix<double> &matrix)
                                   // note that we have been here
                                   // already
   factorize_called = true;
-};
+}
 
 
 
@@ -861,7 +861,7 @@ SparseDirectMA27::solve (Vector<double> &rhs_and_solution) const
   call_ma27cd (&n_rows, &A[0], &LA,
                &IW[0], &LIW, &MAXFRT,
                &rhs_and_solution(0), &IW1[0], &NSTEPS);
-};
+}
 
 
 
@@ -872,7 +872,7 @@ SparseDirectMA27::solve (const SparseMatrix<double> &matrix,
   initialize (matrix.get_sparsity_pattern());
   factorize (matrix);
   solve (rhs_and_solution);
-};
+}
 
 
 
@@ -886,7 +886,7 @@ SparseDirectMA27::memory_consumption () const
          MemoryConsumption::memory_consumption (IW) +
          MemoryConsumption::memory_consumption (IKEEP) +
          MemoryConsumption::memory_consumption (IW1));
-};
+}
 
 
 
@@ -897,7 +897,7 @@ SparseDirectMA27::get_synchronisation_lock () const
     return non_static_synchronisation_lock;
   else
     return static_synchronisation_lock;    
-};
+}
 
 
 
@@ -928,7 +928,7 @@ SparseDirectMA27::fill_A (const SparseMatrix<double> &matrix)
          ++global_index;
        };
   Assert (global_index == n_nonzero_elements, ExcInternalError());  
-};
+}
 
 
 
@@ -975,7 +975,7 @@ void SparseDirectMA27::call_ma27ad (const unsigned int *N,
       
       detached_mode_data->mutex.release ();
     };
-};
+}
 
 
 
@@ -1013,7 +1013,7 @@ void SparseDirectMA27::call_ma27bd (const unsigned int *N,
       
       detached_mode_data->mutex.release ();
     };
-};
+}
 
 
 
@@ -1041,7 +1041,7 @@ void SparseDirectMA27::call_ma27cd (const unsigned int *N,
       detached_mode_data->put (RHS, *N, "RHS");
       detached_mode_data->get (RHS, *N, "RHS");
     };
-};
+}
 
 
 
@@ -1059,7 +1059,7 @@ void SparseDirectMA27::call_ma27x1 (unsigned int *NRLNEC)
       detached_mode_data->get (NRLNEC, 1, "NRLNEC");
       detached_mode_data->mutex.release ();
     };
-};
+}
 
 
 
@@ -1077,7 +1077,7 @@ void SparseDirectMA27::call_ma27x2 (unsigned int *NIRNEC)
       detached_mode_data->get (NIRNEC, 1, "NIRNEC");
       detached_mode_data->mutex.release ();
     };
-};
+}
 
 
 
@@ -1095,7 +1095,7 @@ void SparseDirectMA27::call_ma27x3 (const unsigned int *LP)
       detached_mode_data->put (LP, 1, "LP");
       detached_mode_data->mutex.release ();
     };
-};
+}
 
   
 
@@ -1124,7 +1124,7 @@ SparseDirectMA47::SparseDirectMA47 (const double LIW_factor_1,
                initialize_called (false),
                factorize_called (false),
                matrix (0)
-{};
+{}
 
 
 
@@ -1224,7 +1224,7 @@ SparseDirectMA47::initialize (const SparseMatrix<double> &m)
                                   // note that we have already been
                                   // in this function
   initialize_called = true;
-};
+}
 
 
 
@@ -1357,7 +1357,7 @@ SparseDirectMA47::factorize (const SparseMatrix<double> &m)
                                   // note that we have been here
                                   // already
   factorize_called = true;
-};
+}
 
 
 
@@ -1370,7 +1370,7 @@ SparseDirectMA47::solve (Vector<double> &rhs_and_solution)
   call_ma47cd (&n_rows, &A[0], &LA,
                &IW[0], &LIW,
                &rhs_and_solution(0), &IW1[0], &ICNTL[0]);
-};
+}
 
 
 
@@ -1381,7 +1381,7 @@ SparseDirectMA47::solve (const SparseMatrix<double> &matrix,
   initialize (matrix);
   factorize (matrix);
   solve (rhs_and_solution);
-};
+}
 
 
 
@@ -1395,7 +1395,7 @@ SparseDirectMA47::memory_consumption () const
          MemoryConsumption::memory_consumption (IW) +
          MemoryConsumption::memory_consumption (KEEP) +
          MemoryConsumption::memory_consumption (IW1));
-};
+}
 
 
 
@@ -1403,7 +1403,7 @@ Threads::ThreadMutex &
 SparseDirectMA47::get_synchronisation_lock () const
 {
   return synchronisation_lock;
-};
+}
 
 
 
@@ -1434,7 +1434,7 @@ SparseDirectMA47::fill_A (const SparseMatrix<double> &matrix)
          ++global_index;
        };
   Assert (global_index == n_nonzero_elements, ExcInternalError());  
-};
+}
 
 
 
@@ -1443,7 +1443,7 @@ SparseDirectMA47::call_ma47id (double       *CNTL,   // length 2
                                unsigned int *ICNTL)  // length 7
 {
   HSL::MA47::ma47id_ (CNTL, ICNTL);
-};
+}
 
 
 
@@ -1464,7 +1464,7 @@ call_ma47ad (const unsigned int *n_rows,             //scalar
                      row_numbers, column_numbers,
                      IW, LIW, KEEP,
                      ICNTL, &RINFO[0], INFO);
-};
+}
 
 
 
@@ -1488,7 +1488,7 @@ call_ma47bd (const unsigned int *n_rows,             //scalar
                      A, LA,
                      IW, LIW, KEEP, CNTL, ICNTL,
                      IW1, &RINFO[0], INFO);
-};
+}
 
 
 
@@ -1507,4 +1507,4 @@ call_ma47cd (const unsigned int *n_rows,           //scalar
   HSL::MA47::ma47cd_(n_rows, A, LA,
                     IW, LIW, &W[0],
                     rhs_and_solution, IW1, ICNTL);  
-};
+}
index bb479e40e1cf87d8451ec1fd68289376902158da..eda03c95074b08c2cc680f6c40eb1143110c1ae6 100644 (file)
@@ -35,7 +35,7 @@ SparsityPattern::SparsityPattern () :
                colnums(0)
 {
   reinit (0,0,0);
-};
+}
 
 
 
@@ -52,7 +52,7 @@ SparsityPattern::SparsityPattern (const SparsityPattern &s) :
   Assert (s.cols == 0, ExcInvalidConstructorCall());
   
   reinit (0,0,0);
-};
+}
 
 
 
@@ -65,7 +65,7 @@ SparsityPattern::SparsityPattern (const unsigned int m,
                  colnums(0)
 {
   reinit (m,n,max_per_row);
-};
+}
 
 
 
@@ -78,7 +78,7 @@ SparsityPattern::SparsityPattern (const unsigned int               m,
                  colnums(0)
 {
   reinit (m, n, row_lengths);
-};
+}
 
 
 
@@ -90,7 +90,7 @@ SparsityPattern::SparsityPattern (const unsigned int n,
                  colnums(0)
 {
   reinit (n,n,max_per_row);
-};
+}
 
 
 
@@ -102,7 +102,7 @@ SparsityPattern::SparsityPattern (const unsigned int               m,
                  colnums(0)
 {
   reinit (m, m, row_lengths);
-};
+}
 
 
 
@@ -203,7 +203,7 @@ SparsityPattern::SparsityPattern (const SparsityPattern &original,
       Assert (next_free_slot <= &colnums[rowstart[row+1]],
              ExcNotEnoughSpace (0,rowstart[row+1]-rowstart[row]));
     };
-};
+}
 
 
 
@@ -229,7 +229,7 @@ SparsityPattern::operator = (const SparsityPattern &s)
   Assert (cols == 0, ExcInvalidConstructorCall());
 
   return *this;
-};
+}
 
 
 
@@ -242,7 +242,7 @@ SparsityPattern::reinit (const unsigned int m,
                                   // other @p{reinit} function
   const std::vector<unsigned int> row_lengths (m, max_per_row);
   reinit (m, n, row_lengths);
-};
+}
 
 
 
@@ -483,7 +483,7 @@ SparsityPattern::compress ()
   max_vec_len = nonzero_elements;
   
   compressed = true;
-};
+}
 
 
 
@@ -493,7 +493,7 @@ SparsityPattern::copy_from (const CompressedSparsityPattern &csp)
   copy_from (csp.n_rows(), csp.n_cols(),
             csp.column_indices.begin(),
             csp.column_indices.end());
-};
+}
 
 
 template <typename number>
@@ -516,7 +516,7 @@ void SparsityPattern::copy_from (const FullMatrix<number> &matrix)
 
                                   // finally compress
   compress ();
-};
+}
 
 
 
@@ -543,7 +543,7 @@ SparsityPattern::empty () const
       return true;
     };
   return false;
-};
+}
 
 
 
@@ -565,7 +565,7 @@ SparsityPattern::max_entries_per_row () const
     m = std::max (m, rowstart[i]-rowstart[i-1]);
 
   return m;
-};
+}
 
 
 
@@ -641,7 +641,7 @@ SparsityPattern::add (const unsigned int i,
                                   // wrong: there was not enough space
                                   // in this line
   Assert (false, ExcNotEnoughSpace(i, rowstart[i+1]-rowstart[i]));
-};
+}
 
 
 bool
@@ -689,7 +689,7 @@ SparsityPattern::matrix_position (const unsigned int global_index) const
 
                                   // so return the respective pair
   return std::make_pair (row,col);
-};
+}
 
 
 
@@ -729,7 +729,7 @@ SparsityPattern::symmetrize ()
        if (colnums[k] != row)
          add (colnums[k], row);
       };
-};
+}
 
 
 
@@ -771,7 +771,7 @@ SparsityPattern::bandwidth () const
                                         // the entries of this line
        break;
   return b;
-};
+}
 
 
 
@@ -798,7 +798,7 @@ SparsityPattern::block_write (std::ostream &out) const
   out << ']';
   
   AssertThrow (out, ExcIO());
-};
+}
 
 
 
@@ -839,7 +839,7 @@ SparsityPattern::block_read (std::istream &in)
            - reinterpret_cast<char*>(&colnums[0]));
   in >> c;
   AssertThrow (c == ']', ExcIO());
-};
+}
 
 
 
@@ -849,7 +849,7 @@ SparsityPattern::memory_consumption () const
   return (sizeof(*this) +
          max_dim * sizeof(unsigned int) +
          max_vec_len * sizeof(unsigned int));
-};
+}
 
 
 

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.