]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Purge most warnings from gcc 3.4. wave-test has a lot to do, though.
authorwolf <wolf@0785d39b-7218-0410-832d-ea1e28bc413d>
Wed, 9 Apr 2003 15:49:56 +0000 (15:49 +0000)
committerwolf <wolf@0785d39b-7218-0410-832d-ea1e28bc413d>
Wed, 9 Apr 2003 15:49:56 +0000 (15:49 +0000)
git-svn-id: https://svn.dealii.org/trunk@7383 0785d39b-7218-0410-832d-ea1e28bc413d

56 files changed:
tests/base/auto_derivative_function.cc
tests/base/table.cc
tests/base/tensor.cc
tests/bits/anna_1.cc
tests/bits/anna_2.cc
tests/bits/anna_3.cc
tests/bits/anna_4.cc
tests/bits/anna_5.cc
tests/bits/anna_6.cc
tests/bits/parameter_handler_1.cc
tests/bits/unit_support_points.cc
tests/deal.II/block_matrices.cc
tests/deal.II/boundaries.cc
tests/deal.II/constraints.cc
tests/deal.II/data_out.cc
tests/deal.II/dof_test.cc
tests/deal.II/error_estimator.cc
tests/deal.II/fe_tables.cc
tests/deal.II/filtered_iterator.cc
tests/deal.II/filtered_matrix.cc
tests/deal.II/gradients.cc
tests/deal.II/grid_in.cc
tests/deal.II/grid_out.cc
tests/deal.II/grid_test.cc
tests/deal.II/grid_tools.cc
tests/deal.II/grid_transform.cc
tests/deal.II/intergrid_constraints.cc
tests/deal.II/intergrid_map.cc
tests/deal.II/matrices.cc
tests/deal.II/second_derivatives.cc
tests/deal.II/sparsity_pattern.cc
tests/deal.II/subdomain_ids.cc
tests/deal.II/support_point_map.cc
tests/deal.II/wave-test-3.cc
tests/fe/fe_tools_test.cc
tests/fe/fe_traits.cc
tests/fe/internals.cc
tests/fe/mapping.cc
tests/fe/mapping_c1.cc
tests/fe/nedelec.cc
tests/fe/nedelec_2.cc
tests/fe/nedelec_3.cc
tests/fe/non_primitive_1.cc
tests/fe/non_primitive_2.cc
tests/fe/shapes.cc
tests/fe/transfer.cc
tests/fe/up_and_down.cc
tests/lac/block_matrices.cc
tests/lac/block_vector.cc
tests/lac/block_vector_iterator.cc
tests/lac/matrix_out.cc
tests/lac/solver.cc
tests/lac/sparse_ilu.cc
tests/lac/sparsity_pattern.cc
tests/lac/testmatrix.cc
tests/lac/vector-vector.cc

index 8d19af46d684df01de0a7117a58813c7b787f136..99df0403d400c141c608225ff9a0ebf2c10c19b7 100644 (file)
@@ -66,7 +66,8 @@ template <int dim>
 void AutoSinExp<dim>::vector_value (const Point<dim> &p,
                                    Vector<double>     &values) const
 {
-  Assert(values.size()==n_components, ExcDimensionMismatch(values.size(), n_components));
+  Assert(values.size()==this->n_components,
+         ExcDimensionMismatch(values.size(), this->n_components));
   values(0)=0;
   values(1)=value(p);
 }
@@ -105,7 +106,8 @@ template <int dim>
 void ExactSinExp<dim>::vector_gradient (const Point<dim>       &p,
                                       typename std::vector<Tensor<1,dim> > &gradients) const
 {
-  Assert(gradients.size()==n_components, ExcDimensionMismatch(gradients.size(), n_components));
+  Assert(gradients.size()==this->n_components,
+         ExcDimensionMismatch(gradients.size(), this->n_components));
   
   gradients[0].clear();
   gradients[1]=gradient(p);
index dbde4ab5b276760c0058879886de14e83039beb4..3b79f44c648c99a432b828519c6d02c4d25af294 100644 (file)
@@ -322,7 +322,7 @@ main ()
                        ExcDimensionMismatch(Td[i][j][k][l][m].end() - Td[i][j][k][l][m].begin(),
                                             static_cast<signed int>(N)));
     };
-};
+}
 
 
       
index 6ab322e1a28187e5a221cbe33387e1e1b2f535bc..784aea721580e3246c1ae7d22d743fcd0653e1d2 100644 (file)
@@ -98,4 +98,4 @@ int main ()
       deallog << "Result WRONG!" << std::endl;
     };
 
-};
+}
index 9acfd07507590f117d88269f1ff433770549cf4d..6d64cda0881a2a20c339bea081b7217acbc67d00 100644 (file)
@@ -63,7 +63,7 @@ SystemTest<dim>::SystemTest () :
                 fe (FE_Nedelec<dim>(1), 2,
                     FE_Q<dim>(1), 1),
                dof_handler (triangulation)
-{};
+{}
 
 
 template <int dim>
@@ -81,7 +81,7 @@ void SystemTest<dim>::make_grid_and_dofs ()
   deallog << "Number of degrees of freedom: " << dof_handler.n_dofs()
           << std::endl;
                                  
-};
+}
 
 template <int dim>
 void SystemTest<dim>::shape_to_components () 
@@ -94,15 +94,16 @@ void SystemTest<dim>::shape_to_components ()
   for(unsigned int i = 0; i<fe.dofs_per_cell; i++)
     deallog <<"  shapefunction "<< i << " is Nedelec:  "
             << (fe.is_primitive(i) ? "false" : "true") << std::endl;
-};
+}
 
 
 
 template <int dim>
 void SystemTest<dim>::check_numbering () 
 {
-  DoFHandler<dim>::active_cell_iterator cell = dof_handler.begin_active(),
-                                      endc = dof_handler.end();
+  typename DoFHandler<dim>::active_cell_iterator
+    cell = dof_handler.begin_active(),
+    endc = dof_handler.end();
   std::vector<unsigned int>    local_dof_indices(fe.dofs_per_cell);
        
   for (; cell!=endc; ++cell)
@@ -136,8 +137,7 @@ void SystemTest<dim>::check_numbering ()
                 << std::endl;
       deallog << std::endl;
     };
-       
-};
+}
 
 
 template <int dim>
@@ -146,7 +146,7 @@ void SystemTest<dim>::run ()
   make_grid_and_dofs ();
   shape_to_components ();
   check_numbering();
-};
+}
 
     
 
@@ -159,4 +159,4 @@ int main ()
   SystemTest<2>().run();
   SystemTest<3>().run();  
   return 0;
-};
+}
index 071401b1bbf87aa5c7c531c6a61c098fe2118c0b..96f55918e3a2168aa4b4276e75c5bd73d73e264d 100644 (file)
@@ -57,9 +57,7 @@ class SystemTest
                                    
     Triangulation<dim>     triangulation;
     FESystem<dim>          fe;
-    DoFHandler<dim>        dof_handler;
-
-                                  
+    DoFHandler<dim>        dof_handler;                   
 };
 
 template <int dim>
@@ -67,7 +65,7 @@ SystemTest<dim>::SystemTest () :
                 fe (FE_Nedelec<dim>(1), 2,
                     FE_Q<dim>(1), 1),
                dof_handler (triangulation)
-{};
+{}
 
 
 template <int dim>
@@ -83,9 +81,8 @@ void SystemTest<dim>::make_grid_and_dofs ()
                                  
   dof_handler.distribute_dofs (fe);
   deallog << "Number of degrees of freedom: " << dof_handler.n_dofs()
-          << std::endl;
-                                 
-};
+          << std::endl;                          
+}
 
 template <int dim>
 void SystemTest<dim>::shape_to_components () 
@@ -98,15 +95,16 @@ void SystemTest<dim>::shape_to_components ()
   for(unsigned int i = 0; i<fe.dofs_per_cell; i++)
     deallog <<"  shapefunction "<< i << " is Nedelec:  "
             << (fe.is_primitive(i) ? "false" : "true") << std::endl;
-};
+}
 
 
 
 template <int dim>
 void SystemTest<dim>::check_numbering () 
 {
-  DoFHandler<dim>::active_cell_iterator cell = dof_handler.begin_active(),
-                                      endc = dof_handler.end();
+  typename DoFHandler<dim>::active_cell_iterator
+    cell = dof_handler.begin_active(),
+    endc = dof_handler.end();
   std::vector<unsigned int>    local_dof_indices(fe.dofs_per_cell);
        
   for (; cell!=endc; ++cell)
@@ -143,8 +141,7 @@ void SystemTest<dim>::check_numbering ()
                 << std::endl;
       deallog << std::endl;
     };
-       
-};
+}
 
 
 template <int dim>
@@ -153,7 +150,7 @@ void SystemTest<dim>::run ()
   make_grid_and_dofs ();
   shape_to_components ();
   check_numbering();
-};
+}
 
     
 
@@ -166,4 +163,4 @@ int main ()
   SystemTest<2>().run();
   SystemTest<3>().run();  
   return 0;
-};
+}
index f7890b10273cf3870cf33f50bdf55ea9c5710658..59b688b0bff0ae7d2d7228acd4142a7e7d651d25 100644 (file)
@@ -61,13 +61,12 @@ SystemTest<dim>::SystemTest () :
                 fe (FE_Nedelec<dim>(1), 2,
                     FE_Q<dim>(1), 1),
                dof_handler (triangulation)
-{};
+{}
 
 
 template <int dim>
 void SystemTest<dim>::make_grid_and_dofs ()
-{
-                                 
+{                        
   GridGenerator::hyper_cube (triangulation, -1, 1);
   triangulation.refine_global (0);
   deallog << "Number of active cells: " << triangulation.n_active_cells()
@@ -79,7 +78,7 @@ void SystemTest<dim>::make_grid_and_dofs ()
   deallog << "Number of degrees of freedom: " << dof_handler.n_dofs()
           << std::endl;
                                  
-};
+}
 
 
 template <int dim>
@@ -104,7 +103,7 @@ void SystemTest<dim>::check ()
   for (unsigned int i=0; i<fe.n_components(); ++i)
     deallog << dofs_per_component[i] << ' ';
   deallog << std::endl;
-};
+}
 
 
 template <int dim>
@@ -119,7 +118,7 @@ void SystemTest<dim>::run ()
   deallog << std::endl << "*** Renumbering ***" << std::endl;
   DoFRenumbering::component_wise (dof_handler);
   check ();
-};
+}
 
     
 
@@ -132,4 +131,4 @@ int main ()
   SystemTest<2>().run();
   SystemTest<3>().run();  
   return 0;
-};
+}
index 653e478817fdd27dfc199724d15a78d0de2bc0a8..6e58f05277d03e8aa04ca5a05f099470367fb9f7 100644 (file)
@@ -69,7 +69,7 @@ void VectorBoundaryValues<dim>::vector_value (const Point<dim> &p,
 
   for (unsigned int i=0; i<2; ++i)
     values(i) = p(i)*p(i);
-};
+}
 
 
 
@@ -87,7 +87,7 @@ class FindBug
     FESystem<dim>              fe;
     DoFHandler<dim>        dof_handler;
     Vector<double>          solution;
-};
+}
 
 
                                  // Construct FESystem with
@@ -98,7 +98,7 @@ FindBug<dim>::FindBug () :
                 fe (FE_Q<dim>(1), 1,
                     FE_DGP<dim>(0), 1),
                 dof_handler (triangulation)
-{};
+{}
 
 
 template <int dim>
@@ -125,8 +125,7 @@ void FindBug<dim>::make_grid_and_dofs ()
           << std::endl;
 
   solution.reinit(dof_handler.n_dofs());
-
-};
+}
 
 
 template <int dim>
@@ -227,7 +226,7 @@ void FindBug<dim>::dirichlet_conditions ()
   for (unsigned int i=0; i<dof_handler.n_dofs(); ++i)
     if (fixed_dofs[i] == true)
       deallog << i << " " << dirichlet_dofs[i] << std::endl;
-};
+}
 
 
 
@@ -236,7 +235,7 @@ void FindBug<dim>::run ()
 {
   make_grid_and_dofs ();
   dirichlet_conditions ();
-};
+}
 
 
 
@@ -250,5 +249,5 @@ int main ()
   FindBug<3>().run ();
   
   return 0;
-};
+}
 
index 9674075b97ec21af746360b2f0460874dc79dbe2..1e79d42cff8d0639a188907a6dc1f1643e694adc 100644 (file)
@@ -21,4 +21,4 @@ int main ()
 {
   std::ofstream o("anna_5.output");
   BlockSparsityPattern      sparsity_pattern;
-};
+}
index 07b2aaaa1b68e0c2a13039d99cfe1cebe18d2174..15d6641ccabb05aac6277f2f5b7379136773e072 100644 (file)
@@ -112,13 +112,13 @@ class BoundaryFunction : public Function<dim>
 
 template <int dim>
 BoundaryFunction<dim>::BoundaryFunction () : 
-                Function<dim> (dim+1) {};
+                Function<dim> (dim+1) {}
 
 
 
 template <int dim>
 inline
-void BoundaryFunction<dim>::vector_value (const Point<dim>   &p,
+void BoundaryFunction<dim>::vector_value (const Point<dim>   &,
                                           Vector<double> &values) const
 {
        
@@ -127,7 +127,7 @@ void BoundaryFunction<dim>::vector_value (const Point<dim>   &p,
                                  
   values.clear ();
   values(dim) = 1.;
-};
+}
 
 
 
@@ -138,10 +138,8 @@ void BoundaryFunction<dim>::vector_value (const Point<dim>   &p,
 template <int dim>
 ImposeBC<dim>::ImposeBC() :
                 fe (FE_Nedelec<dim>(1), 1, FE_Q<dim>(1), 1),
-                dof_handler (triangulation)
-                       
-                                
-{};
+                dof_handler (triangulation)                     
+{}
 
 
 
@@ -149,7 +147,7 @@ template <int dim>
 ImposeBC<dim>::~ImposeBC() 
 {
   dof_handler.clear ();
-};
+}
 
 
 template <int dim>
@@ -195,9 +193,7 @@ void ImposeBC<dim>::test_extract_boundary_DoFs ()
   for (unsigned int i=0; i<dof_handler.n_dofs(); ++i)
     if (ned_boundary_dofs[i] == true)
       boundary_values[i] = 0.;
-         
-
-};
+}
 
 
                                
@@ -250,7 +246,7 @@ void ImposeBC<dim>::test_interpolate_BC ()
       deallog << boundary_values[i] << ' ';
     }
   deallog << std::endl;
-};
+}
 
 
 
@@ -280,9 +276,8 @@ void ImposeBC<dim>::run ()
           << std::endl;
 
   test_extract_boundary_DoFs ();
-  test_interpolate_BC ();
-         
-};
+  test_interpolate_BC ();  
+}
 
 
 int main () 
@@ -323,4 +318,4 @@ int main ()
     };
 
   return 0;
-};
+}
index 835823ad10b3e0ae01ec565dbac5aa8ac2e3edb7..066c64339f561767bd6b882b58d365b151baca1f 100644 (file)
@@ -28,7 +28,7 @@ void check (const char *p)
   prm.read_input (in);
 
   deallog << "test_1=" << prm.get ("test_1") << std::endl;
-};
+}
 
 
 int main () 
@@ -40,4 +40,4 @@ int main ()
   check ("parameter_handler_1.prm1");
   
   return 0;
-};
+}
index 38ca26f634c0ef16bfa79e8d6ba1783d74bf49bb..054626f4239046e15d11f3823a53d8b06f1bbf0b 100644 (file)
@@ -33,7 +33,7 @@ void check_cell1 (const FiniteElement<dim> &fe)
             fe.unit_support_point(i),
             ExcInternalError());
   deallog << "dim=" << dim << ", cell=ok" << std::endl;
-};
+}
 
 
 template <int dim>
@@ -44,11 +44,11 @@ void check_face1 (const FiniteElement<dim> &fe)
             fe.unit_face_support_point(i),
             ExcInternalError());
   deallog << "dim=" << dim << ", face=ok" << std::endl;
-};
+}
 
 
 void check_face1 (const FiniteElement<1> &) 
-{};
+{}
 
 
 
@@ -57,7 +57,7 @@ void check1 (const FiniteElement<dim> &fe)
 {
   check_cell1 (fe);
   check_face1 (fe);
-};
+}
 
 
 template <int dim>
@@ -69,7 +69,7 @@ void check_cell2 (const FiniteElement<dim> &fe,
       deallog << i << " " << fe.unit_support_point(i)
               << std::endl;
   deallog << "dim=" << dim << ", cell=ok" << std::endl;
-};
+}
 
 
 template <int dim>
@@ -81,12 +81,12 @@ void check_face2 (const FiniteElement<dim> &fe,
           deallog << i << " " << fe.unit_face_support_point(i)
                   << std::endl;
       deallog << "dim=" << dim << ", face=ok" << std::endl;
-};
+}
 
 
 void check_face2 (const FiniteElement<1> &,
                   const unsigned int) 
-{};
+{}
 
 
 
@@ -96,7 +96,7 @@ void check2 (const FiniteElement<dim> &fe,
 {
   check_cell2 (fe, comp);
   check_face2 (fe, comp);
-};
+}
 
 
 
@@ -117,7 +117,7 @@ void check ()
   check2 (FESystem<dim> (FE_Q<dim> (2), 1,
                          FE_DGP<dim> (2), 1),
           0);
-};
+}
 
     
 
@@ -131,4 +131,4 @@ int main ()
   check<2> ();
   check<3> ();
   return 0;
-};
+}
index 7fea52e91d244de82f5b7cd1115bac29e7df1a98..b83e8c08305a23a426735620e58172af7bba832c 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2000, 2001 by the deal.II authors
+//    Copyright (C) 2000, 2001, 2003 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -87,7 +87,7 @@ LaplaceProblem<Vector,Matrix,Sparsity>::LaplaceProblem (const unsigned int n_blo
                dof_handler (triangulation)
 {
   sparsity_pattern.reinit (n_blocks, n_blocks);
-};
+}
 
 
 
@@ -96,7 +96,7 @@ LaplaceProblem<Vector<double>,SparseMatrix<double>,SparsityPattern>::LaplaceProb
                n_blocks (n_blocks),
                fe(1),
                dof_handler (triangulation)
-{};
+{}
 
 
 
@@ -105,7 +105,7 @@ LaplaceProblem<Vector<float>,SparseMatrix<float>,SparsityPattern>::LaplaceProble
                n_blocks (n_blocks),
                fe(1),
                dof_handler (triangulation)
-{};
+{}
 
 
 
@@ -133,7 +133,7 @@ void LaplaceProblem<Vector,Matrix,Sparsity>::make_grid_and_dofs ()
 
   system_matrix.reinit (sparsity_pattern);
   reinit_vectors ();
-};
+}
 
 
 template <>
@@ -142,7 +142,7 @@ void LaplaceProblem<Vector<double>,SparseMatrix<double>,SparsityPattern>::reinit
   sparsity_pattern.reinit (dof_handler.n_dofs(),
                           dof_handler.n_dofs(),
                           dof_handler.max_couplings_between_dofs());
-};
+}
 
 
 
@@ -151,7 +151,7 @@ void LaplaceProblem<Vector<double>,SparseMatrix<double>,SparsityPattern>::reinit
 {
   solution.reinit (dof_handler.n_dofs());
   system_rhs.reinit (dof_handler.n_dofs());
-};
+}
 
 
 
@@ -161,7 +161,7 @@ void LaplaceProblem<Vector<float>,SparseMatrix<float>,SparsityPattern>::reinit_s
   sparsity_pattern.reinit (dof_handler.n_dofs(),
                           dof_handler.n_dofs(),
                           dof_handler.max_couplings_between_dofs());
-};
+}
 
 
 
@@ -170,7 +170,7 @@ void LaplaceProblem<Vector<float>,SparseMatrix<float>,SparsityPattern>::reinit_v
 {
   solution.reinit (dof_handler.n_dofs());
   system_rhs.reinit (dof_handler.n_dofs());
-};
+}
 
 
 
@@ -210,7 +210,7 @@ void LaplaceProblem<BlockVector<double>,BlockSparseMatrix<double>,BlockSparsityP
       default:
            AssertThrow (false, ExcNotImplemented());
     }; 
-};
+}
 
 
 
@@ -248,7 +248,7 @@ void LaplaceProblem<BlockVector<double>,BlockSparseMatrix<double>,BlockSparsityP
       default:
            AssertThrow (false, ExcNotImplemented());
     };
-};
+}
 
 
 
@@ -313,7 +313,7 @@ void LaplaceProblem<Vector,Matrix,Sparsity>::assemble_system ()
                                      system_matrix,
                                      solution,
                                      system_rhs);
-};
+}
 
 
 template <class Vector, class Matrix, class Sparsity>
@@ -328,7 +328,7 @@ void LaplaceProblem<Vector,Matrix,Sparsity>::solve ()
   
   cg.solve (system_matrix, solution, system_rhs,
            preconditioner);
-};
+}
 
 
 template <class Vector, class Matrix, class Sparsity>
@@ -345,7 +345,7 @@ void LaplaceProblem<Vector,Matrix,Sparsity>::run ()
                                       //<< typeid(Matrix).name ()
                                       //<< '-'
            << i << ' ' << solution(i) << std::endl;
-};
+}
 
     
 
@@ -440,4 +440,4 @@ int main ()
   
     
   return 0;
-};
+}
index b5b3b39f369a2badb2d72c138ff328440eae5a2b..6c4565c2aaa9c8f8e7a12f6b53617d342d206b81 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2000, 2001 by the deal.II authors
+//    Copyright (C) 2000, 2001, 2003 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -48,7 +48,7 @@ class MySquareFunction : public Function<dim>
     
     virtual void   vector_value (const Point<dim>   &p,
                                 Vector<double>     &values) const
-      { for (unsigned int d=0; d<n_components; ++d) values(d) = value(p,d); };
+      { for (unsigned int d=0; d<this->n_components; ++d) values(d) = value(p,d); };
 };
 
 
@@ -58,14 +58,14 @@ boundary_q (const DoFHandler<dim> &)
 {
   static const QGauss4<dim-1> q;
   return q;
-};
+}
 
 
 const Quadrature<0> &
 boundary_q (const DoFHandler<1> &)
 {
   return *static_cast<const Quadrature<0>*>(0);
-};
+}
 
 
 void write_map (const std::map<unsigned int,double> &bv)
@@ -73,7 +73,7 @@ void write_map (const std::map<unsigned int,double> &bv)
   for (std::map<unsigned int,double>::const_iterator
         i=bv.begin(); i!=bv.end(); ++i)
     deallog << i->first << ' ' << i->second <<std::endl;
-};
+}
 
       
 
index ca8e4a319aa587d4e0ac075d4c12b0a6edfb21f3..62adc1635407a69d09abd501e5cc919d17c3edc8 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1998, 1999, 2000, 2001 by the deal.II authors
+//    Copyright (C) 1998, 1999, 2000, 2001, 2003 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -230,7 +230,7 @@ void make_tria (Triangulation<3> &tria, int step)
        break;
       };
     };
-};
+}
 
 
 
@@ -281,7 +281,7 @@ void merge_check ()
       c1.merge (c2);
       c1.print (logfile);
     };
-};
+}
 
 
 int main ()
@@ -331,5 +331,5 @@ int main ()
     };
 
   merge_check ();
-};
+}
 
index afa9ef442391ce6d1b55657bdbc113d57c8525d0..386f1902ac3ffc39ecb67e9a4e14809355d48f2b 100644 (file)
@@ -102,7 +102,7 @@ double RightHandSide<dim>::value (const Point<dim> &p,
     return_value += 4*pow(p(i), 4);
 
   return return_value;
-};
+}
 
 
 template <int dim>
@@ -110,7 +110,7 @@ double BoundaryValues<dim>::value (const Point<dim> &p,
                                   const unsigned int) const 
 {
   return p.square();
-};
+}
 
 
 
@@ -118,7 +118,7 @@ double BoundaryValues<dim>::value (const Point<dim> &p,
 template <int dim>
 LaplaceProblem<dim>::LaplaceProblem () :
   fe (1), dof_handler (triangulation)
-{};
+{}
 
 
 
@@ -157,7 +157,7 @@ void LaplaceProblem<dim>::make_grid_and_dofs ()
 
   solution.reinit (dof_handler.n_dofs());
   system_rhs.reinit (dof_handler.n_dofs());
-};
+}
 
 
 
@@ -169,7 +169,7 @@ void LaplaceProblem<dim>::solve ()
                                   // arbitrary values
   for (unsigned int i=0; i<solution.size(); ++i)
     solution(i) = i;
-};
+}
 
 
 
@@ -205,7 +205,7 @@ void LaplaceProblem<2>::output_results () const
       data_out.write_gnuplot (logfile);
       data_out.write_ucd (logfile);
     };
-};
+}
 
 
 
@@ -241,7 +241,7 @@ void LaplaceProblem<3>::output_results () const
       data_out.write_gnuplot (logfile);
       data_out.write_ucd (logfile);
     };
-};
+}
 
 
 
@@ -251,7 +251,7 @@ void LaplaceProblem<dim>::run ()
   make_grid_and_dofs();
   solve ();
   output_results ();
-};
+}
 
     
 
@@ -267,4 +267,4 @@ int main ()
   laplace_problem_3d.run ();
   
   return 0;
-};
+}
index 6575ca79f9729707c836141e8f7e83e6b93487ab..c28798dc7f6f4c92f7764d3456e2eb610e6ac2dd 100644 (file)
@@ -135,7 +135,7 @@ CurvedLine<dim>::get_new_point_on_line (const typename Triangulation<dim>::line_
       middle(1) = 1+0.04*sin(6*3.141592*middle(0));
   
   return middle;
-};
+}
 
 
 
@@ -170,7 +170,7 @@ CurvedLine<dim>::get_new_point_on_quad (const typename Triangulation<dim>::quad_
       middle(1) = 1+0.04*sin(6*3.141592*middle(0));
   
   return middle;
-};
+}
 
 
 
@@ -195,7 +195,7 @@ class TestCases
 
 template <int dim>
 TestCases<dim>::TestCases () :
-               tria(0), dof(0) {};
+               tria(0), dof(0) {}
 
 
 
@@ -204,7 +204,7 @@ TestCases<dim>::~TestCases ()
 {
   if (dof)  delete dof;
   if (tria) delete tria;
-};
+}
 
 
 
@@ -218,7 +218,7 @@ void TestCases<dim>::create_new ()
   GridGenerator::hyper_cube(*tria);
 
   dof = new DoFHandler<dim> (*tria);
-};
+}
 
 
 
@@ -336,7 +336,7 @@ void TestCases<dim>::run (const unsigned int test_case)
                                   // release the lock that dof has to the
                                   // finite element object
   dof->clear ();
-};
+}
 
 
 
@@ -360,5 +360,5 @@ int main ()
     };
   
   return 0;
-};
+}
 
index 0a069139281195b30fb0a793ec2168b557309d79..13dd7ed97bf37eb93cd7ff5988a87947776e4955 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2000, 2001 by the deal.II authors
+//    Copyright (C) 2000, 2001, 2003 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -57,14 +57,14 @@ get_q_face (Function<dim>&)
 {
   static QGauss4<dim-1> q;
   return q;
-};
+}
 
 
 Quadrature<0> &
 get_q_face (Function<1>&)
 {
   return *static_cast<Quadrature<0>*>(0);
-};
+}
 
 
 
index 97526e43ee7e0ebf846b027c6f9136d9b5a6ca7c..cc9b70db6623939962c9f898430769cc732ed9ef 100644 (file)
@@ -50,8 +50,8 @@ print_fe_statistics(const FiniteElement<dim>& fe)
   DoFHandler<dim> dof(tr);
   dof.distribute_dofs(fe);
   StraightBoundary<dim> boundary;
-  DoFHandler<dim>::active_cell_iterator cell = dof.begin_active();
-  DoFHandler<dim>::active_face_iterator face = dof.begin_active_face();
+  typename DoFHandler<dim>::active_cell_iterator cell = dof.begin_active();
+  typename DoFHandler<dim>::active_face_iterator face = dof.begin_active_face();
 
   const std::vector<Point<dim> > unit_points = fe.get_unit_support_points();
   const std::vector<Point<dim> > support_points = fe.get_support_points();
index 254c41f40ed88f7293aaf25a998e5c99e99289c4..f5f30e7c26afa2e59e6195b4b3a07752a576c2c9 100644 (file)
@@ -43,7 +43,7 @@ template <typename Iterator>
 bool level_equal_to_3 (const Iterator c)
 {
   return (static_cast<unsigned int>(c->level()) == 3);
-};
+}
 
 
 
@@ -52,7 +52,7 @@ bool level_equal_to (const Iterator     c,
                     const unsigned int level)
 {
   return (static_cast<unsigned int>(c->level()) == level);
-};
+}
 
 
 void test ()
@@ -206,7 +206,7 @@ void test ()
       
       logfile << "Check 5: OK" << std::endl;
     };
-};
+}
 
 
 int main ()
@@ -218,5 +218,5 @@ int main ()
   test ();
   
   return 0;
-};
+}
 
index 752fa4fdc38fdcca89a54b7cd5783f50086c70ab..7e2516f02a8517994d40e82cb5181c7d5c0555bd 100644 (file)
@@ -68,7 +68,7 @@ solve_filtered (std::map<unsigned int,double> &bv,
        i!=bv.end(); ++i)
     Assert (std::fabs(u(i->first) - i->second) < 1e-8,
            ExcInternalError());
-};
+}
 
 
 
@@ -88,7 +88,7 @@ solve_eliminated (std::map<unsigned int,double> &bv,
   prec.initialize (A, 1.2);
   
   solver.solve (A, u, f, prec);
-};
+}
 
 
 
index 22e8b3c66c8440db8daa8dcca390a8925685752e..cc25fb9a4d2d9303e03c6c87d1bcbc5ad3a97d5b 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1998, 1999, 2000 by the deal.II authors
+//    Copyright (C) 1998, 1999, 2000, 2003 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -50,7 +50,7 @@ int main ()
   fevalues.reinit (dof.begin_active());
 
 
-Vector<double> val(4);
+  Vector<double> val(4);
 
   deallog << "Testing transformation of gradients of shape function:" << std::endl;
   
@@ -66,7 +66,7 @@ Vector<double> val(4);
       fevalues.get_function_grads (val, grads);
 
 
-bool ok;
+      bool ok;
       switch (vertex) 
        {
          case 0:
@@ -108,4 +108,4 @@ bool ok;
     return 0;
   else
     return 1;
-};
+}
index 102b1e5d42be26b9c9e0606cfac9214f772c6975..014804e2bbada78a823b763f2ccc1274cca5d08a 100644 (file)
@@ -40,7 +40,7 @@ void test1 ()
   
   GridOut grid_out;
   grid_out.write_ucd (tria, logfile);
-};
+}
 
 
 template <int dim>
@@ -66,7 +66,7 @@ void test2 ()
     for (unsigned int i=0; i<GeometryInfo<dim>::vertices_per_cell; ++i)
       hash += (index * i * c->vertex_index(i)) % (tria.n_active_cells()+1);
   deallog << hash << std::endl;
-};
+}
 
 
 int main ()
@@ -77,5 +77,5 @@ int main ()
 
   test1<2> ();
   test2<2> ();
-};
+}
 
index 6ad2e2de944bb6a1b7ce8175274dbcdbd811b33f..fcc5cdb770295a3df1efa5bad0a1086d4a06bd6f 100644 (file)
@@ -51,7 +51,7 @@ void test ()
   grid_out.write_ucd (tria, logfile);
   if (dim != 1)
     grid_out.write_dx (tria, logfile);
-};
+}
 
 
 int main ()
@@ -63,5 +63,5 @@ int main ()
   test<1> ();
   test<2> ();
   test<3> ();
-};
+}
 
index a2dfcc9fbc5c602fc5ee6f55c574df0bd3357825..9fb242d70f119ab6b955d7a1870593a9179bb99c 100644 (file)
@@ -51,7 +51,7 @@ class Ball :
     };
 
 
-virtual Point<dim>
+    virtual Point<dim>
     get_new_point_on_quad (const typename Triangulation<dim>::quad_iterator &quad) const {
       Point<dim> middle = StraightBoundary<dim>::get_new_point_on_quad(quad);
       
@@ -125,7 +125,7 @@ CurvedLine<dim>::get_new_point_on_line (const typename Triangulation<dim>::line_
       middle(1) = 1+0.04*sin(6*3.141592*middle(0));
   
   return middle;
-};
+}
 
 
 template <int dim>
@@ -159,7 +159,7 @@ CurvedLine<dim>::get_new_point_on_quad (const typename Triangulation<dim>::quad_
       middle(1) = 1+0.04*sin(6*3.141592*middle(0));
   
   return middle;
-};
+}
 
 
 template <int dim>
@@ -262,7 +262,7 @@ void test (const int test_case)
          << "     Total number of active cells = " << tria.n_active_cells() << std::endl;
 
   deallog.pop();
-};
+}
 
 
 int main ()
@@ -277,4 +277,4 @@ int main ()
     test<3> (i);
   
   return 0;
-};
+}
index 8403c56da231feb83d45595b34475caffbdf5b4e..4e9d196a6d64c4237554f0c2e0bf2888b5924f55 100644 (file)
@@ -64,7 +64,7 @@ void test1 ()
                  << std::endl;
        };
     };
-};
+}
 
 
 // GridTools::transform
@@ -84,7 +84,7 @@ void test2 ()
   logfile << "Rotated grid:" << std::endl;
   GridTools::rotate (3.14159265258/4, tria);
   GridOut().write_gnuplot (tria, logfile);
-};
+}
 
 
 int main ()
@@ -100,5 +100,5 @@ int main ()
   test2 ();
   
   return 0;
-};
+}
 
index e5ad1d47bd2cba5e3cd3b1b16d24add0cd6f15d1..d8f9798a884e765fd2e006b7624476851a176473 100644 (file)
@@ -116,4 +116,4 @@ int main ()
   tria.clear();
   
   return 0;
-};
+}
index 46057b6f21b4f92b6f71a07cc1d2f931564cec5f..65cc7eb6693dd535ab282df6dd34c67a019c98de 100644 (file)
@@ -217,7 +217,7 @@ void check ()
   delete fe_2;
   if (fe_dq_quadratic != 0)
     delete fe_dq_quadratic;
-};
+}
 
 
 
@@ -231,5 +231,5 @@ int main ()
   check<1> ();
   check<2> ();
   check<3> ();
-};
+}
 
index 44765e42632a2e2c7e7b4b15a1370d6d842c4b0f..f5853028765b240d39845ec0c96700caf02d96f5 100644 (file)
@@ -95,7 +95,7 @@ void check ()
       tria_1.execute_coarsening_and_refinement ();
       tria_2.execute_coarsening_and_refinement ();
     };
-};
+}
 
 
 
@@ -110,5 +110,5 @@ int main ()
   check<1> ();
   check<2> ();
   check<3> ();
-};
+}
 
index 9816d8eb6aa6e177649bddde153a25180c0750a3..31cda39d60b1a26a0b4ce7f8119f49bb2a9c1aaa 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2000, 2001 by the deal.II authors
+//    Copyright (C) 2000, 2001, 2003 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -101,14 +101,14 @@ check_boundary (const DoFHandler<dim> &dof,
   
                                   // finally write out matrix
   matrix.print (deallog.get_file_stream());
-};
+}
 
 
 
 void
 check_boundary (const DoFHandler<1> &,
                const Mapping<1>    &)
-{};
+{}
 
 
 
@@ -195,7 +195,7 @@ check ()
 
   if (dim > 1)
     check_boundary (dof, mapping);
-};
+}
 
 
 
index 53aae2dd5a62c44aedb2cf4d8b87e92051022f70..e904b1714d678015daef5da87bdfabf699ee9953 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1998, 1999, 2000, 2001 by the deal.II authors
+//    Copyright (C) 1998, 1999, 2000, 2001, 2003 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -46,7 +46,7 @@ int main ()
   QTrapez<2> q;
 
 
-Vector<double> val(4);
+  Vector<double> val(4);
 
   deallog << "Testing transformation of 2nd derivatives of shape function:" << std::endl;
   
@@ -89,4 +89,4 @@ Vector<double> val(4);
          deallog << std::endl;
        };
     };
-};
+}
index de8c17e3769d81039b72cd503c67e7fb766c4347..38ad99997ad6430b7e1a1762fdbee2e6645bebb8 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2000, 2001 by the deal.II authors
+//    Copyright (C) 2000, 2001, 2003 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -53,7 +53,7 @@ bool operator == (const SparsityPattern &sp1,
       return false;
   
   return true;
-};
+}
 
 
 
@@ -72,7 +72,7 @@ bool operator == (const BlockSparsityPattern &sp1,
        return false;
   
   return true;
-};
+}
 
 
 
@@ -108,7 +108,7 @@ check_boundary (const DoFHandler<dim> &dof)
          << " -- "
          << (sparsity_1 == sparsity_2 ? "ok" : "failed")
          << std::endl;
-};
+}
 
 
 
@@ -218,7 +218,7 @@ check ()
 
                                   // check boundary matrices
   check_boundary (dof);
-};
+}
 
 
 
index 123a9072cfe57e7f189b61b2a480d8cdac253462..9b01b69f6c1601f960973c1bdce80244d4cbd48a 100644 (file)
@@ -168,7 +168,7 @@ void test ()
        }
       deallog << "Check 4 (dim=" << dim << ") ok" << std::endl;      
     };
-};
+}
 
 
 int main ()
@@ -182,4 +182,4 @@ int main ()
   test<3> ();
   
   return 0;
-};
+}
index ea16c04beaa5331fe9bd998376f120f043c9a9c0..4d1f07b52d0c1c001b9ab88e813c1e9db6f33ace 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2000, 2001 by the deal.II authors
+//    Copyright (C) 2000, 2001, 2003 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -47,7 +47,7 @@ bool PointComp<1>::operator () (const Point<1> &p1,
                                const Point<1> &p2) const
 {
   return p1(0) < p2(0);
-};
+}
 
 
 // have somewhat weird orderings in 2d and 3d
@@ -58,7 +58,7 @@ bool PointComp<2>::operator () (const Point<2> &p1,
   return ((p1(0)+p1(1) < p2(0)+p2(1)) ||
          ((p1(0)+p1(1) == p2(0)+p2(1)) &&
           (p1(0)-p1(1) < p2(0)-p2(1))));
-};
+}
 
 
 
@@ -71,7 +71,7 @@ bool PointComp<3>::operator () (const Point<3> &p1,
          ((p1(0)+p1(1) < p2(0)+p2(1)) ||
           ((p1(0)+p1(1) == p2(0)+p2(1)) &&
            (p1(0)-p1(1) < p2(0)-p2(1)))));
-};
+}
 
 
 
index aaff31b246a832d0390cb7869532eeb09f581f84..96edb1f297d76b31dc931a750406137b1dc7c321 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    std::copyright (C) 1998, 1999, 2000, 2001, 2002 by Wolfgang Bangerth
+//    std::copyright (C) 1998, 1999, 2000, 2001, 2002, 2003 by Wolfgang Bangerth
 //
 //    This file is subject to QPL and may not be  distributed
 //    without std::copyright and license information. Please refer
@@ -986,7 +986,7 @@ std::string int_to_string (const unsigned int i, const unsigned int digits);
 template <typename number>
 inline number sqr (const number a) {
   return a*a;
-};
+}
 
 
 /**
@@ -1802,7 +1802,7 @@ DualFunctional<dim>::DualFunctional (const bool use_primal_problem,
                time(0),
                time_step(0),
                step_no(0)
-{};
+{}
 
 
 template <int dim>
@@ -1810,7 +1810,7 @@ void DualFunctional<dim>::compute_functionals (Vector<double> &j1,
                                               Vector<double> &j2) {
   j1.reinit (dof->n_dofs());
   j2.reinit (dof->n_dofs());
-};
+}
 
 
 template <int dim>
@@ -1818,19 +1818,19 @@ void DualFunctional<dim>::compute_endtime_vectors (Vector<double> &final_u_bar,
                                                   Vector<double> &final_v_bar) {
   final_u_bar.reinit (dof->n_dofs());
   final_v_bar.reinit (dof->n_dofs());
-};
+}
 
 
 template <int dim>
 bool DualFunctional<dim>::use_primal_solutions () const {
   return use_primal_problem;
-};
+}
 
 
 template <int dim>
 bool DualFunctional<dim>::use_primal_solutions_at_endtime () const {
   return use_primal_problem_at_endtime;
-};
+}
 
 
 template <int dim>
@@ -1847,7 +1847,7 @@ void DualFunctional<dim>::reset (const TimeStep_Primal<dim> &primal_problem) {
 
   u = &primal_problem.u;
   v = &primal_problem.v;
-};
+}
 
 
 template <int dim>
@@ -1865,7 +1865,7 @@ void DualFunctional<dim>::reset (const TimeStep_Dual<dim> &dual_problem) {
                     0 :
                     dual_problem.get_forward_timestep());
   step_no         = dual_problem.timestep_no;
-};
+}
 
 
 /* ----------------------- EndEnergy ------------------------------*/
@@ -1873,7 +1873,7 @@ void DualFunctional<dim>::reset (const TimeStep_Dual<dim> &dual_problem) {
 
 template <int dim>
 EndEnergy<dim>::EndEnergy (const bool use_primal_problem) :
-               DualFunctional<dim> (use_primal_problem, true) {};
+               DualFunctional<dim> (use_primal_problem, true) {}
 
 
 template <int dim>
@@ -1881,23 +1881,23 @@ void EndEnergy<dim>::compute_vectors (const PartOfDomain pod,
                                      Vector<double> &final_u_bar,
                                      Vector<double> &final_v_bar) const {
   const double y_offset = 300000000;
-  const unsigned int n_q_points = quadrature->n_quadrature_points;
-  const unsigned int dofs_per_cell = fe->dofs_per_cell;
+  const unsigned int n_q_points = this->quadrature->n_quadrature_points;
+  const unsigned int dofs_per_cell = this->fe->dofs_per_cell;
   
-  final_u_bar.reinit (dof->n_dofs());
-  final_v_bar.reinit (dof->n_dofs());
+  final_u_bar.reinit (this->dof->n_dofs());
+  final_v_bar.reinit (this->dof->n_dofs());
 
   typename DoFHandler<dim>::active_cell_iterator cell, primal_cell, endc;
-  cell = dof->begin_active ();
-  endc = dof->end ();
-  primal_cell = primal_dof->begin_active();
+  cell = this->dof->begin_active ();
+  endc = this->dof->end ();
+  primal_cell = this->primal_dof->begin_active();
 
-  FEValues<dim> fe_values (*fe, *quadrature,
+  FEValues<dim> fe_values (*this->fe, *this->quadrature,
                           UpdateFlags(update_values         |
                                       update_gradients      |
                                       update_JxW_values     |
                                       update_q_points));
-  FEValues<dim> fe_values_primal (*primal_fe, *quadrature,
+  FEValues<dim> fe_values_primal (*this->primal_fe, *this->quadrature,
                                  UpdateFlags(update_values | update_gradients));
   
   FullMatrix<double>  cell_matrix (dofs_per_cell, dofs_per_cell);
@@ -1905,8 +1905,8 @@ void EndEnergy<dim>::compute_vectors (const PartOfDomain pod,
   std::vector<Tensor<1,dim> > local_u_grad (n_q_points);
   std::vector<double>         local_v (n_q_points);
   
-  std::vector<double> density_values(quadrature->n_quadrature_points);
-  std::vector<double> stiffness_values(quadrature->n_quadrature_points);
+  std::vector<double> density_values(this->quadrature->n_quadrature_points);
+  std::vector<double> stiffness_values(this->quadrature->n_quadrature_points);
 
   std::vector<unsigned int> cell_dof_indices (dofs_per_cell);
 
@@ -1927,12 +1927,12 @@ void EndEnergy<dim>::compute_vectors (const PartOfDomain pod,
 
       fe_values.reinit (cell);
       fe_values_primal.reinit (primal_cell);
-      fe_values_primal.get_function_values (*v, local_v);
-      fe_values_primal.get_function_grads (*u, local_u_grad);
+      fe_values_primal.get_function_values (*this->v, local_v);
+      fe_values_primal.get_function_grads (*this->u, local_u_grad);
 
-      density->value_list (fe_values.get_quadrature_points(),
+      this->density->value_list (fe_values.get_quadrature_points(),
                           density_values);
-      stiffness->value_list (fe_values.get_quadrature_points(),
+      this->stiffness->value_list (fe_values.get_quadrature_points(),
                             stiffness_values);
       
       std::vector<double> local_functional1 (dofs_per_cell, 0);
@@ -1957,7 +1957,7 @@ void EndEnergy<dim>::compute_vectors (const PartOfDomain pod,
          final_v_bar(cell_dof_indices[shape_func]) += local_functional2[shape_func];
        };
     };
-};
+}
 
 
 /*------------------------ IntegrateValueAtOrigin --------------------------------*/
@@ -1966,11 +1966,11 @@ void EndEnergy<dim>::compute_vectors (const PartOfDomain pod,
 template <int dim>
 void IntegratedValueAtOrigin<dim>::compute_functionals (Vector<double> &j1,
                                                        Vector<double> &j2) {
-  j1.reinit (dof->n_dofs());
-  j2.reinit (dof->n_dofs());
+  j1.reinit (this->dof->n_dofs());
+  j2.reinit (this->dof->n_dofs());
 
-  typename DoFHandler<dim>::active_cell_iterator cell = dof->begin_active(),
-                                       endc = dof->end();
+  typename DoFHandler<dim>::active_cell_iterator cell = this->dof->begin_active(),
+                                       endc = this->dof->end();
 
   Point<dim> origin;
 
@@ -1986,7 +1986,7 @@ void IntegratedValueAtOrigin<dim>::compute_functionals (Vector<double> &j1,
     };
 
   Assert (origin_found, ExcVertexNotFound());
-};
+}
 
 
 /*------------------------ SeismicSignal --------------------------------*/
@@ -1997,7 +1997,7 @@ void SeismicSignal<1>::compute_functionals (Vector<double> &,
                                            Vector<double> &)
 {
   Assert (false, ExcNotImplemented());
-};
+}
 
 
 template <int dim>
@@ -2007,13 +2007,13 @@ void SeismicSignal<dim>::compute_functionals (Vector<double> &j1,
   const unsigned int n_q_points = quadrature_face->n_quadrature_points;
   const unsigned int dofs_per_cell = fe->dofs_per_cell;
   
-  j1.reinit (dof->n_dofs());
-  j2.reinit (dof->n_dofs());
+  j1.reinit (this->dof->n_dofs());
+  j2.reinit (this->dof->n_dofs());
 
   typename DoFHandler<dim>::active_cell_iterator cell, endc;
   typename DoFHandler<dim>::face_iterator        face;
-  cell = dof->begin_active();
-  endc = dof->end();
+  cell = this->dof->begin_active();
+  endc = this->dof->end();
 
   std::vector<unsigned int> cell_dof_indices (dofs_per_cell);
 
@@ -2044,7 +2044,7 @@ void SeismicSignal<dim>::compute_functionals (Vector<double> &j1,
          for (unsigned int shape_func=0; shape_func<dofs_per_cell; ++shape_func)
            j1(cell_dof_indices[shape_func]) += local_integral[shape_func];
        };
-};
+}
 
 
 /*------------------------ EarthSurface --------------------------------*/
@@ -2055,13 +2055,13 @@ void EarthSurface<1>::compute_functionals (Vector<double> &,
                                           Vector<double> &)
 {
   Assert (false, ExcNotImplemented());
-};
+}
 
 
 template <int dim>
 void EarthSurface<dim>::compute_functionals (Vector<double> &j1,
                                             Vector<double> &j2) {
-  const unsigned int face_dofs = fe->dofs_per_face;
+  const unsigned int face_dofs = this->fe->dofs_per_face;
   
   j1.reinit (dof->n_dofs());
   j2.reinit (dof->n_dofs());
@@ -2092,7 +2092,7 @@ void EarthSurface<dim>::compute_functionals (Vector<double> &j1,
          for (unsigned int shape_func=0; shape_func<face_dofs; ++shape_func)
            j1(face_dof_indices[shape_func]) = h;
        };
-};
+}
 
 
 /*------------------------ SplitSignal --------------------------------*/
@@ -2103,7 +2103,7 @@ void SplitSignal<1>::compute_functionals (Vector<double> &,
                                          Vector<double> &)
 {
   Assert (false, ExcInternalError());
-};
+}
 
 
 template <int dim>
@@ -2155,7 +2155,7 @@ void SplitSignal<dim>::compute_functionals (Vector<double> &j1,
              j1(dof_indices[i]) += sum * time_step / 2;
            };
        };
-};
+}
 
 
 /* ------------------------------ Split line 1d case ----------------------------- */
@@ -2164,7 +2164,7 @@ template <int dim>
 void SplitLine<dim>::compute_endtime_vectors (Vector<double> &,
                                              Vector<double> &) {
   Assert (false, ExcNotImplemented ());
-};
+}
 
 
 #if 2 == 1
@@ -2248,7 +2248,7 @@ void OneBranch1d<dim>::compute_functionals (Vector<double> &j1,
            j1(dof_indices[i]) += sum;
          };
       };
-};
+}
 
 
 /*------------------------ SecondCrossing --------------------------------*/
@@ -2290,7 +2290,7 @@ void SecondCrossing<dim>::compute_functionals (Vector<double> &j1,
            j1(dof_indices[i]) += sum / time_step;
          };
       };
-};
+}
 
 
 /*------------------------ HuyghensWave --------------------------------*/
@@ -2327,7 +2327,7 @@ void HuyghensWave<dim>::compute_functionals (Vector<double> &j1,
        };
   
   AssertThrow (point_found, ExcInternalError());
-};
+}
 
 
 
@@ -2377,7 +2377,7 @@ EvaluationBase<dim>::EvaluationBase () :
                time (0),
                time_step (0),
                step_no (0)
-{};
+{}
 
 
 template <int dim>
@@ -2401,21 +2401,21 @@ void EvaluationBase<dim>::reset_timelevel (const TimeStep_Primal<dim> &target) {
   base_file_name  = target.parameters.output_directory +
                    "sweep"+int_to_string(target.sweep_no, 2) + "/evaluation/" +
                    int_to_string(step_no,4);
-};
+}
 
 
 template <int dim>
-void EvaluationBase<dim>::reset () {};
+void EvaluationBase<dim>::reset () {}
 
 
 template <int dim>
-void EvaluationBase<dim>::print_final_result (std::ostream &) {};
+void EvaluationBase<dim>::print_final_result (std::ostream &) {}
 
 
 template <int dim>
 double EvaluationBase<dim>::get_final_result () {
   return 0;
-};
+}
 
 
 /*--------------------------- EvaluateEnergyContent ----------------------*/
@@ -2423,14 +2423,14 @@ double EvaluationBase<dim>::get_final_result () {
 template <int dim>
 EvaluateEnergyContent<dim>::EvaluateEnergyContent () :
                old_energy (0),
-               integrated_outflux (0) {};
+               integrated_outflux (0) {}
 
 
 template <int dim>
 void EvaluateEnergyContent<dim>::reset () {
   old_energy         = 0;
   integrated_outflux = 0;
-};
+}
 
 
 template <int dim>
@@ -2501,7 +2501,7 @@ double EvaluateEnergyContent<dim>::compute_energy (const PartOfDomain pod) const
     };
 
   return total_energy;
-};
+}
 
 
 /* ---------------------------- EvaluateIntegratedValueAtOrigin ------------------- */
@@ -2511,25 +2511,25 @@ template <int dim>
 void EvaluateIntegratedValueAtOrigin<dim>::print_final_result (std::ostream &out) {
   out << "    Integrated value of u at origin: "
       << integrated_value << std::endl;
-};
+}
 
 
 template <int dim>
 double EvaluateIntegratedValueAtOrigin<dim>::get_final_result () {
   return integrated_value;
-};
+}
 
 
 template <int dim>
 std::string EvaluateIntegratedValueAtOrigin<dim>::description () const {
   return "integrated value at origin";
-};
+}
 
 
 template <int dim>
 void EvaluateIntegratedValueAtOrigin<dim>::reset () {
   integrated_value = 0;
-};
+}
 
 
 template <int dim>
@@ -2557,7 +2557,7 @@ double EvaluateIntegratedValueAtOrigin<dim>::evaluate () {
     integrated_value += value_at_origin * time_step;
       
   return value_at_origin;
-};
+}
 
 
 /*------------------------- EvaluateSeismicSignal --------------------------*/
@@ -2566,25 +2566,25 @@ double EvaluateIntegratedValueAtOrigin<dim>::evaluate () {
 template <int dim>
 void EvaluateSeismicSignal<dim>::print_final_result (std::ostream &out) {
   out << "    Integrated seismic signal: " << result << std::endl;
-};
+}
 
 
 template <int dim>
 double EvaluateSeismicSignal<dim>::get_final_result () {
   return result;
-};
+}
 
 
 template <int dim>
 std::string EvaluateSeismicSignal<dim>::description () const {
   return "Integrated seismic signal at top";
-};
+}
 
 
 template <int dim>
 void EvaluateSeismicSignal<dim>::reset () {
   result = 0;
-};
+}
 
 
 template <>
@@ -2592,7 +2592,7 @@ double EvaluateSeismicSignal<1>::evaluate ()
 {
   Assert (false, ExcNotImplemented());
   return 0;
-};
+}
 
 
 template <int dim>
@@ -2647,7 +2647,7 @@ double EvaluateSeismicSignal<dim>::evaluate () {
     result += u_integrated*time_step;
   
   return u_integrated;
-};
+}
 
 
 /*------------------------- EvaluateSplitSignal --------------------------*/
@@ -2656,25 +2656,25 @@ double EvaluateSeismicSignal<dim>::evaluate () {
 template <int dim>
 void EvaluateSplitSignal<dim>::print_final_result (std::ostream &out) {
   out << "    Integrated split signal: " << result << std::endl;
-};
+}
 
 
 template <int dim>
 double EvaluateSplitSignal<dim>::get_final_result () {
   return result;
-};
+}
 
 
 template <int dim>
 std::string EvaluateSplitSignal<dim>::description () const {
   return "Integrated split signal (exact: (2+pi)/(16-pi)=0.010229)";
-};
+}
 
 
 template <int dim>
 void EvaluateSplitSignal<dim>::reset () {
   result = 0;
-};
+}
 
 
 template <>
@@ -2682,7 +2682,7 @@ double EvaluateSplitSignal<1>::evaluate ()
 {
   Assert (false, ExcNotImplemented());
   return 0;
-};
+}
 
 
 template <int dim>
@@ -2727,7 +2727,7 @@ double EvaluateSplitSignal<dim>::evaluate () {
     result += u_integrated*time_step / 2;
   
   return u_integrated;
-};
+}
 
 
 /*------------------------- EvaluateOneBranch1d --------------------------*/
@@ -2736,25 +2736,25 @@ double EvaluateSplitSignal<dim>::evaluate () {
 template <int dim>
 void EvaluateOneBranch1d<dim>::print_final_result (std::ostream &out) {
   out << "    One branch integrated: " << result << std::endl;
-};
+}
 
 
 template <int dim>
 double EvaluateOneBranch1d<dim>::get_final_result () {
   return result;
-};
+}
 
 
 template <int dim>
 std::string EvaluateOneBranch1d<dim>::description () const {
   return "One branch integrated (exact: 0.055735)";
-};
+}
 
 
 template <int dim>
 void EvaluateOneBranch1d<dim>::reset () {
   result = 0;
-};
+}
 
 
 template <int dim>
@@ -2762,7 +2762,7 @@ double EvaluateOneBranch1d<dim>::evaluate ()
 {
   Assert (false, ExcNotImplemented());
   return 0;
-};
+}
 
 
 #if 2 == 1
@@ -2806,25 +2806,25 @@ double EvaluateOneBranch1d<1>::evaluate () {
 template <int dim>
 void EvaluateSecondCrossing1d<dim>::print_final_result (std::ostream &out) {
   out << "    Second crossing: " << result << std::endl;
-};
+}
 
 
 template <int dim>
 double EvaluateSecondCrossing1d<dim>::get_final_result () {
   return result;
-};
+}
 
 
 template <int dim>
 std::string EvaluateSecondCrossing1d<dim>::description () const {
   return "Second crossing (exact: 0.011147)";
-};
+}
 
 
 template <int dim>
 void EvaluateSecondCrossing1d<dim>::reset () {
   result = 0;
-};
+}
 
 
 template <int dim>
@@ -2832,7 +2832,7 @@ double EvaluateSecondCrossing1d<dim>::evaluate ()
 {
   Assert (false, ExcNotImplemented());
   return 0;
-};
+}
 
 
 #if 2 == 1
@@ -2877,25 +2877,25 @@ template <int dim>
 void EvaluateHuyghensWave<dim>::print_final_result (std::ostream &out) {
   out << "    Hughens wave -- weighted time: " << weighted_value / integrated_value << std::endl;
   out << "                    average      : " << integrated_value << std::endl;
-};
+}
 
 
 template <int dim>
 double EvaluateHuyghensWave<dim>::get_final_result () {
   return weighted_value / integrated_value;
-};
+}
 
 
 template <int dim>
 std::string EvaluateHuyghensWave<dim>::description () const {
   return "Huyghens wave";
-};
+}
 
 
 template <int dim>
 void EvaluateHuyghensWave<dim>::reset () {
   integrated_value = weighted_value = 0;
-};
+}
 
 
 template <int dim>
@@ -2932,7 +2932,7 @@ double EvaluateHuyghensWave<dim>::evaluate ()
     };
   
   return value_at_origin;
-};
+}
 
 
 template class EvaluationBase<2>;
@@ -2968,7 +2968,7 @@ TimestepManager<dim>::TimestepManager (const WaveParameters<dim> &parameters) :
                               TimeDependent::TimeSteppingData(0,1),
                               TimeDependent::TimeSteppingData(0,1)),
                 parameters (parameters)
-{};
+{}
 
 
 template <int dim>
@@ -3035,7 +3035,7 @@ void TimestepManager<dim>::run_sweep (const unsigned int sweep_no)
   end_sweep ();
   
   deallog << std::endl << std::endl;
-};
+}
 
 
 template <int dim>
@@ -3205,7 +3205,7 @@ if (parameters.compare_indicators_globally)
 deallog << "    Got " << total_number_of_cells << " presently, expecting "
           << total_expected_cells << " for next sweep." << std::endl;
     };
-};
+}
 
 
 template <int dim>
@@ -3249,7 +3249,7 @@ void TimestepManager<dim>::write_statistics (const SweepInfo &sweep_info) const
 
       deallog << std::endl;
     };
-};
+}
 
 
 template <int dim>
@@ -3268,7 +3268,7 @@ void TimestepManager<dim>::write_stacked_data (DataOutStack<dim> &data_out_stack
   data_out_stack.set_flags (eps_flags);
   data_out_stack.write (logfile, output_format);
   deallog << '.' << std::endl;
-};
+}
 
 
 template class TimestepManager<2>;
@@ -3706,14 +3706,14 @@ WaveParameters<dim>::WaveParameters () :
                stiffness (0),
                dual_functional (0),
                coarse_grid (0)
-{};
+{}
 
 
 template <int dim>
 WaveParameters<dim>::~WaveParameters ()
 {
   delete_parameters ();
-};
+}
 
 
 template <int dim>
@@ -3759,7 +3759,7 @@ void WaveParameters<dim>::delete_parameters ()
        i!=eval_list.end(); ++i)
     delete *i;
   eval_list.erase (eval_list.begin(), eval_list.end());
-};
+}
 
 
 template <int dim>
@@ -3802,7 +3802,7 @@ void WaveParameters<dim>::set_initial_functions (const std::string &u_name,
 
   initial_u = functions[0];
   initial_v = functions[1];
-};
+}
 
 
 template <int dim>
@@ -3844,7 +3844,7 @@ void WaveParameters<dim>::set_coefficient_functions (const std::string &name) {
          }
          else
            AssertThrow (false, ExcUnknownName (name));
-};
+}
 
 
 template <int dim>
@@ -3883,7 +3883,7 @@ void WaveParameters<dim>::set_boundary_functions (const std::string &name) {
            }
          else
            AssertThrow (false, ExcUnknownName (name));
-};
+}
 
 
 template <int dim>
@@ -3929,7 +3929,7 @@ void WaveParameters<dim>::make_eval_list (const std::string &names) {
                else
                  AssertThrow (false, ExcUnknownName (name));
     };
-};
+}
 
 
 template <int dim>
@@ -3963,7 +3963,7 @@ void WaveParameters<dim>::set_dual_functional (const std::string &name) {
                    dual_functional = new HuyghensWave<dim> ();
                  else
                    AssertThrow (false, ExcUnknownName (name));
-};
+}
 
 
 #if 2 == 1
@@ -4256,7 +4256,7 @@ case square:
       default:
            Assert (false, ExcInternalError());
     };
-};
+}
 
 #endif
 
@@ -4429,7 +4429,7 @@ prm.enter_subsection ("Goal");
 prm.declare_entry ("Refinement criterion", "energy estimator",
                     Patterns::Selection ("energy estimator|dual estimator"));
   prm.declare_entry ("Sweeps", "3", Patterns::Integer());
-};
+}
 
 
 template <int dim>
@@ -4547,7 +4547,7 @@ if (prm.get("Refinement criterion")=="energy estimator")
   prm.enter_subsection ("Grid");
   make_coarse_grid (prm.get("Coarse mesh"));
   prm.leave_subsection ();
-};
+}
 
 
 template class WaveParameters<2>;
@@ -4564,7 +4564,7 @@ SweepData<dim>::SweepData (const bool use_data_out_stack)
     data_out_stack = new DataOutStack<dim>();
   else
     data_out_stack = 0;
-};
+}
 
 
 template <int dim>
@@ -4573,7 +4573,7 @@ SweepData<dim>::~SweepData ()
   if (data_out_stack != 0)
     delete data_out_stack;
   data_out_stack = 0;
-};
+}
 
 
 template class SweepData<2>;
@@ -4587,14 +4587,14 @@ SweepInfo::Data &
 SweepInfo::get_data () 
 {
   return data;
-};
+}
 
 
 SweepInfo::Timers &
 SweepInfo::get_timers () 
 {
   return timers;
-};
+}
 
 
 template <int dim>
@@ -4632,7 +4632,7 @@ SweepInfo::write_summary (const std::list<EvaluationBase<dim>*> &eval_list,
       << int_to_string (time->tm_hour, 2) << ":"
       << int_to_string (time->tm_min, 2) << ":"
       << int_to_string (time->tm_sec, 2) << std::endl;
-};
+}
 
 
 SweepInfo::Data::Data () :
@@ -4640,7 +4640,7 @@ SweepInfo::Data::Data () :
                cells (0),
                primal_dofs (0),
                dual_dofs (0)
-{};
+{}
 
 
 template 
@@ -4688,7 +4688,7 @@ template <int dim>
 TimeStepBase_Wave<dim>::TimeStepBase_Wave ():
                TimeStepBase_Tria<dim> (),
                parameters (*static_cast<WaveParameters<dim>*>(0))
-{};
+{}
 
 
 template <int dim>
@@ -4711,7 +4711,7 @@ TimeStepBase_Wave<dim>::TimeStepBase_Wave (const double                    time,
                                          WaveParameters<dim>::dual_estimator),
                                         true)),
                                            parameters (parameters)
-{};
+{}
 
 
 template <int dim>
@@ -4719,7 +4719,7 @@ const TimeStep_Primal<dim> &
 TimeStepBase_Wave<dim>::get_timestep_primal () const
 {
   return dynamic_cast<const TimeStep_Primal<dim> &> (*this);
-};
+}
 
 
 template <int dim>
@@ -4727,7 +4727,7 @@ const TimeStep_Dual<dim> &
 TimeStepBase_Wave<dim>::get_timestep_dual () const
 {
   return dynamic_cast<const TimeStep_Dual<dim> &> (*this);
-};
+}
 
 
 template <int dim>
@@ -4735,7 +4735,7 @@ const TimeStep_Postprocess<dim> &
 TimeStepBase_Wave<dim>::get_timestep_postprocess () const
 {
   return dynamic_cast<const TimeStep_Postprocess<dim> &> (*this);
-};
+}
 
 
 template <int dim>
@@ -4745,21 +4745,21 @@ std::string TimeStepBase_Wave<dim>::tmp_filename_base (const std::string &branch
          branch_signature + 's' +
          int_to_string (sweep_no, 2) + 't' +
          int_to_string (timestep_no, 4));
-};
+}
 
 
 template <int dim>
 void TimeStepBase_Wave<dim>::attach_sweep_info (SweepInfo &si)
 {
   sweep_info = &si;
-};
+}
 
 
 template <int dim>
 void TimeStepBase_Wave<dim>::attach_sweep_data (SweepData<dim> &sd)
 {
   sweep_data = &sd;
-};
+}
 
 
 /* --------------------------------------------------------------*/
@@ -4772,7 +4772,7 @@ TimeStep_Wave<dim>::TimeStep_Wave (const std::string fe_name) :
                quadrature (FEHelper<dim>::get_quadrature(fe_name)),
                quadrature_face (FEHelper<dim>::get_quadrature_face(fe_name)),
                statistic_data()
-{};
+{}
 
 
 template <int dim>
@@ -4785,7 +4785,7 @@ TimeStep_Wave<dim>::~TimeStep_Wave ()
   Assert (laplace_matrix.empty(), ExcInternalError());
   Assert (u.size() ==0, ExcInternalError());
   Assert (v.size() ==0, ExcInternalError());
-};
+}
 
 
 template <int dim>
@@ -4851,7 +4851,7 @@ constraints.clear ();
                Assert (false, ExcInternalError());
        };
     };
-};
+}
 
 
 template <int dim>
@@ -4898,7 +4898,7 @@ void TimeStep_Wave<dim>::sleep (const unsigned int sleep_level)
       default:
            Assert (false, ExcInternalError());
     };
-};
+}
 
 
 template <int dim>
@@ -4906,7 +4906,7 @@ void TimeStep_Wave<dim>::end_sweep ()
 {
   std::string tmp_filename = tmp_filename_base(branch_signature());
   remove (tmp_filename.c_str());
-};
+}
 
 
 template <int dim>
@@ -4924,7 +4924,7 @@ unsigned int TimeStep_Wave<dim>::solve (const UserMatrix       &matrix,
   constraints.distribute (solution);
 
   return control.last_step();
-};
+}
 
 
 template <int dim>
@@ -5012,7 +5012,7 @@ FEValues<dim>  fe_values (fe, quadrature,
                               cell_laplace_matrix(i,j));
          };
     };
-};
+}
 
 
 template <int dim>
@@ -5062,7 +5062,7 @@ void TimeStep_Wave<dim>::transfer_old_solutions (Vector<double> &old_u,
     transfer_old_solutions (old_cell, new_cell,
                            *old_grid_u, *old_grid_v,
                            old_u, old_v);
-};
+}
 
 
 template <int dim>
@@ -5092,7 +5092,7 @@ TimeStep_Wave<dim>::transfer_old_solutions (const typename DoFHandler<dim>::cell
       old_cell->get_interpolated_dof_values (old_grid_v, cell_data);
       new_cell->set_dof_values_by_interpolation (cell_data, old_v);
     };
-};
+}
 
 
 template <int dim>
@@ -5117,7 +5117,7 @@ TimeStep_Wave<dim>::compute_energy () {
     };
 
   return energy;
-};
+}
 
 
 template <int dim>
@@ -5128,7 +5128,7 @@ StatisticData () :
                n_solver_steps_helmholtz (0),
                n_solver_steps_projection (0),
                energy (std::make_pair(0.0, 0.0))
-{};
+{}
 
 
 template <int dim>
@@ -5143,7 +5143,7 @@ StatisticData (const unsigned int        n_active_cells,
                n_solver_steps_helmholtz (n_solver_steps_helmholtz),
                n_solver_steps_projection (n_solver_steps_projection),
                energy (energy)
-{};
+{}
 
 
 template <int dim>
@@ -5157,7 +5157,7 @@ TimeStep_Wave<dim>::StatisticData::write_descriptions (std::ostream &out)
       << "#    elastic energy"                         << std::endl
       << "#    kinetic energy"                         << std::endl
       << "#    total energy"                           << std::endl;
-};
+}
 
 
 template <int dim>
@@ -5170,7 +5170,7 @@ void TimeStep_Wave<dim>::StatisticData::write (std::ostream &out) const
       << energy.first               << ' '
       << energy.second              << ' '
       << energy.first+energy.second;
-};
+}
 
 
 template class TimeStepBase_Wave<2>;
@@ -5198,7 +5198,7 @@ template <int dim>
 TimeStep_Dual<dim>::TimeStep_Dual (const std::string &dual_fe)
                :
                TimeStep_Wave<dim> (dual_fe)
-{};
+{}
 
 
 template <int dim>
@@ -5241,7 +5241,7 @@ void TimeStep_Dual<dim>::do_initial_step () {
                                                                 0, 0,
                                                                 std::make_pair (0.0, 0.0));
   deallog << "." << std::endl;
-};
+}
 
 
 template <int dim>
@@ -5333,7 +5333,7 @@ void TimeStep_Dual<dim>::do_timestep ()
                                                               compute_energy ());
   
   deallog << "." << std::endl;
-};
+}
 
 
 template <int dim>
@@ -5345,14 +5345,14 @@ void TimeStep_Dual<dim>::solve_dual_problem ()
   else
     do_timestep ();
   sweep_info->get_timers().dual_problem.stop();
-};
+}
 
 
 template <int dim>
 std::string TimeStep_Dual<dim>::branch_signature () const 
 {
   return "d";
-};
+}
 
 
 template <int dim>
@@ -5368,7 +5368,7 @@ void TimeStep_Dual<dim>::wake_up (const unsigned int wakeup_level)
       create_matrices ();
     };
   sweep_info->get_timers().dual_problem.stop();
-};
+}
 
 
 template <int dim>
@@ -5389,7 +5389,7 @@ void TimeStep_Dual<dim>::assemble_vectors (Vector<double> &right_hand_side1,
   right_hand_side2.add (timestep, dual1);
 
   constraints.condense (right_hand_side1);
-};
+}
 
 
 template <int dim>
@@ -5419,7 +5419,7 @@ cell_iterator old_cell = previous_time_level.dof_handler->begin(),
     build_rhs (old_cell, new_cell,
               fe_values,
               right_hand_side1, right_hand_side2);
-};
+}
 
 
 template <int dim>
@@ -5549,7 +5549,7 @@ TimeStep_Dual<dim>::build_rhs (const typename DoFHandler<dim>::cell_iterator &ol
     };
 
   Assert (false, ExcInternalError());
-};
+}
 
 
 template <int dim>
@@ -5642,7 +5642,7 @@ TimeStep_Dual<dim>::collect_from_children (const typename DoFHandler<dim>::cell_
     };
 
   return level_difference;
-};
+}
 
 
 template <int dim>
@@ -5743,7 +5743,7 @@ TimeStep_Dual<dim>::distribute_to_children (const typename DoFHandler<dim>::cell
     };
 
   return level_difference;
-};
+}
 
 
 template class TimeStep_Dual<2>;
@@ -5769,7 +5769,7 @@ template class TimeStep_Dual<2>;
 
 template <int dim>
 TimeStep_ErrorEstimation<dim>::TimeStep_ErrorEstimation () 
-{};
+{}
 
 
 template <int dim>
@@ -5797,7 +5797,7 @@ void TimeStep_ErrorEstimation<dim>::estimate_error ()
   sweep_info->get_data().accumulated_error += accumulated_error;
 
   sweep_info->get_timers().error_estimation.stop();
-};
+}
 
 
 template <int dim>
@@ -5812,7 +5812,7 @@ void TimeStep_ErrorEstimation<dim>::wake_up (const unsigned int wakeup_level)
       
       estimated_error_per_cell.reinit (tria->n_active_cells());
     };
-};
+}
 
 
 template <int dim>
@@ -5831,7 +5831,7 @@ void TimeStep_ErrorEstimation<dim>::sleep (const unsigned int sleep_level)
 
       estimated_error_per_cell.reinit (0);
     };
-};
+}
 
 
 template <int dim>
@@ -5841,7 +5841,7 @@ TimeStep_ErrorEstimation<dim>::get_tria_refinement_criteria (Vector<float> &indi
   get_error_indicators (indicators);
   for (Vector<float>::iterator i=indicators.begin(); i!=indicators.end(); ++i)
     *i = fabs(*i);
-};
+}
 
 
 template <int dim>
@@ -5850,7 +5850,7 @@ TimeStep_ErrorEstimation<dim>::get_error_indicators (Vector<float> &indicators)
 {
   std::ifstream in (tmp_filename_base(branch_signature()).c_str());
   indicators.block_read (in);
-};
+}
 
 
 template <int dim>
@@ -5890,7 +5890,7 @@ void TimeStep_ErrorEstimation<dim>::estimate_error_energy (const unsigned int wh
                                          parameters.density);
       estimated_error_per_cell += v_estimator;
     };
-};
+}
 
 
 template <int dim>
@@ -5965,7 +5965,7 @@ void TimeStep_ErrorEstimation<dim>::estimate_error_dual () {
       *i = error_on_this_cell->sum();
       total_estimated_error += *error_on_this_cell;
     };
-};
+}
 
 
 template <int dim>
@@ -6120,7 +6120,7 @@ compute_error_on_new_children (primal_cell, dual_cell,
 
 
 Assert (false, ExcInternalError());
-};
+}
 
 
 template <int dim>
@@ -6189,7 +6189,7 @@ for (unsigned int child=0; child<GeometryInfo<dim>::children_per_cell; ++child)
          ++cellwise_error.next_free_slot;
        };
     };
-};
+}
 
 
 template <int dim>
@@ -6282,7 +6282,7 @@ error_sum += error_formula (old_dual_child,
     };
 
   return error_sum;
-};
+}
 
 
 template <int dim>
@@ -6317,7 +6317,7 @@ TimeStep_ErrorEstimation<dim>::error_formula (const typename DoFHandler<dim>::ac
                        local_difference_u_bar_old,
                        local_difference_v_bar_old,
                        fe_values);                     
-};
+}
 
 
 template <int dim>
@@ -6469,7 +6469,7 @@ std::vector<double> stiffness(fe_values.n_quadrature_points);
 
 
 return error_on_cell;
-};
+}
 
 #include <fe/fe_tools.h>
 
@@ -6497,40 +6497,40 @@ void TimeStep_ErrorEstimation<dim>::make_interpolation_matrices () {
   for (unsigned int i=0; i<dual_fe.dofs_per_cell; ++i)
     difference_matrix(i,i) = 1.;
   difference_matrix.add (-1, interpolation_matrix);
-};
+}
 
 
 template <int dim>
 TimeStep_ErrorEstimation<dim>::StatisticData::StatisticData () :
                estimated_error (0)
-{};
+{}
 
 
 template <int dim>
 TimeStep_ErrorEstimation<dim>::StatisticData::StatisticData (const double estimated_error) :
                estimated_error (estimated_error)
-{};
+{}
 
 
 template <int dim>
 void TimeStep_ErrorEstimation<dim>::StatisticData::write_descriptions (std::ostream &out)
 {
   out << "#    total estimated error in this timestep" << std::endl;
-};
+}
 
 
 template <int dim>
 void TimeStep_ErrorEstimation<dim>::StatisticData::write (std::ostream &out) const
 {
   out << estimated_error*100000;
-};
+}
 
 
 template <int dim>
 TimeStep_ErrorEstimation<dim>::ErrorOnCell::ErrorOnCell () {
   for (unsigned int i=0; i<sizeof(part)/sizeof(part[0]); ++i)
     part[i] = 0;
-};
+}
 
 
 template <int dim>
@@ -6539,7 +6539,7 @@ TimeStep_ErrorEstimation<dim>::ErrorOnCell::operator += (const ErrorOnCell &eoc)
   for (unsigned int i=0; i<sizeof(part)/sizeof(part[0]); ++i)
     part[i] += eoc.part[i];
   return *this;
-};
+}
 
 
 template <int dim>
@@ -6548,14 +6548,14 @@ double TimeStep_ErrorEstimation<dim>::ErrorOnCell::sum () const {
   for (unsigned int i=0; i<sizeof(part)/sizeof(part[0]); ++i)
     x += part[i];
   return x;
-};
+}
 
 
 template <int dim>
 TimeStep_ErrorEstimation<dim>::CellwiseError::CellwiseError (const unsigned int n_errors) :
                errors (n_errors),
                next_free_slot (&*errors.begin())
-{};
+{}
 
 
 template class TimeStep_ErrorEstimation<2>;
@@ -6575,7 +6575,7 @@ TimeStep<dim>::TimeStep (const double               time,
                                        parameters),
                TimeStep_Primal<dim>(parameters.primal_fe),
                TimeStep_Dual<dim>  (parameters.dual_fe)
-{};
+{}
 
 
 template <int dim>
@@ -6613,7 +6613,7 @@ void TimeStep<dim>::wake_up (const unsigned int wakeup_level)
       default:
            Assert (false, ExcInternalError());
     };
-};
+}
 
 
 template <int dim>
@@ -6652,7 +6652,7 @@ void TimeStep<dim>::sleep (const unsigned int sleep_level)
   sweep_info->get_timers().grid_generation.start();
   TimeStepBase_Wave<dim>::sleep (sleep_level);
   sweep_info->get_timers().grid_generation.stop();
-};
+}
 
 
 template <int dim>
@@ -6661,7 +6661,7 @@ void TimeStep<dim>::end_sweep ()
   TimeStep_Primal<dim>::end_sweep ();
   TimeStep_Dual<dim>::end_sweep ();
   TimeStep_Postprocess<dim>::end_sweep ();
-};
+}
 
 
 template <int dim>
@@ -6684,7 +6684,7 @@ void TimeStep<dim>::write_statistics_descriptions (std::ostream
       out << "#  Postprocessing:" << std::endl;
       TimeStep_Postprocess<dim>::StatisticData::write_descriptions (out, parameters);
     };
-};
+}
 
 
 template <int dim>
@@ -6697,7 +6697,7 @@ void TimeStep<dim>::write_statistics (std::ostream &out) const
   TimeStep_ErrorEstimation<dim>::statistic_data.write (out);
   out << "    ";
   TimeStep_Postprocess<dim>::statistic_data.write (out);
-};
+}
 
 
 template class TimeStep<2>;
@@ -6857,28 +6857,28 @@ void TimeStep_Postprocess<dim>::postprocess_timestep ()
 
 deallog << std::endl;
   sweep_info->get_timers().postprocessing.stop();
-};
+}
 
 
 template <int dim>
 void TimeStep_Postprocess<dim>::wake_up (const unsigned int wakeup_level) 
 {
   TimeStep_ErrorEstimation<dim>::wake_up (wakeup_level);
-};
+}
 
 
 template <int dim>
 void TimeStep_Postprocess<dim>::sleep (const unsigned int sleep_level) 
 {
   TimeStep_ErrorEstimation<dim>::sleep (sleep_level);
-};
+}
 
 
 template <int dim>
 std::string TimeStep_Postprocess<dim>::branch_signature () const 
 {
   return "o";
-};
+}
 
 
 template <int dim>
@@ -6886,7 +6886,7 @@ void TimeStep_Postprocess<dim>::end_sweep ()
 {
   std::string tmp_filename = tmp_filename_base(branch_signature());
   remove (tmp_filename.c_str());
-};
+}
 
 
 template <int dim>
@@ -6912,7 +6912,7 @@ void TimeStep_Postprocess<dim>::interpolate_dual_solution (Vector<double> &inter
        interpolated_u_bar(primal_vertex_index) = target.u(dual_vertex_index);
        interpolated_v_bar(primal_vertex_index) = target.v(dual_vertex_index);
       };      
-};
+}
 
 
 template <int dim>
@@ -6923,7 +6923,7 @@ write_descriptions (std::ostream &out,
   for (typename std::list<EvaluationBase<dim>*>::const_iterator i = parameters.eval_list.begin();
        i != parameters.eval_list.end(); ++i)
     out << "#    " << (*i)->description() << std::endl;
-};
+}
 
 
 template <int dim>
@@ -6931,7 +6931,7 @@ void TimeStep_Postprocess<dim>::StatisticData::write (std::ostream &out) const
 {
   for (unsigned int i=0; i<evaluation_results.size(); ++i)
     out << evaluation_results[i]*100000 << ' ';
-};
+}
 
 
 template class TimeStep_Postprocess<2>;
@@ -6958,7 +6958,7 @@ template <int dim>
 TimeStep_Primal<dim>::TimeStep_Primal (const std::string &primal_fe)
                :
                TimeStep_Wave<dim> (primal_fe)
-{};
+{}
 
 
 template <int dim>
@@ -6994,7 +6994,7 @@ void TimeStep_Primal<dim>::do_initial_step ()
                                                               std::make_pair (0.0, 0.0));
 
   deallog << "." << std::endl;
-};
+}
 
 
 template <int dim>
@@ -7099,7 +7099,7 @@ if (parameters.extrapolate_old_solutions)
                                                               compute_energy ());
   
   deallog << "." << std::endl;
-};
+}
 
 
 template <int dim>
@@ -7111,14 +7111,14 @@ void TimeStep_Primal<dim>::solve_primal_problem ()
   else
     do_timestep ();
   sweep_info->get_timers().primal_problem.stop();
-};
+}
 
 
 template <int dim>
 std::string TimeStep_Primal<dim>::branch_signature () const 
 {
   return "p";
-};
+}
 
 
 template <int dim>
@@ -7134,7 +7134,7 @@ void TimeStep_Primal<dim>::wake_up (const unsigned int wakeup_level)
       create_matrices ();
     };
   sweep_info->get_timers().primal_problem.stop();
-};
+}
 
 
 template <int dim>
@@ -7144,7 +7144,7 @@ void TimeStep_Primal<dim>::assemble_vectors (Vector<double> &right_hand_side1,
   
   build_rhs (right_hand_side1, right_hand_side2);
   constraints.condense (right_hand_side1);
-};
+}
 
 
 template <int dim>
@@ -7174,7 +7174,7 @@ cell_iterator old_cell = previous_time_level.dof_handler->begin(),
     build_rhs (old_cell, new_cell,
               fe_values,
               right_hand_side1, right_hand_side2);
-};
+}
 
 
 template <int dim>
@@ -7305,7 +7305,7 @@ rhs1 = local_M_u;
     };
 
   Assert (false, ExcInternalError());
-};
+}
 
 
 template <int dim>
@@ -7401,7 +7401,7 @@ FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
     };
 
   return level_difference;
-};
+}
 
 
 template <int dim>
@@ -7502,7 +7502,7 @@ TimeStep_Primal<dim>::distribute_to_children (const typename DoFHandler<dim>::ce
     };
 
   return level_difference;
-};
+}
 
 
 template class TimeStep_Primal<2>;
@@ -7527,7 +7527,7 @@ void UserMatrix::precondition (Vector<double> &dst,
            dst = src;
            return;
     };
-};
+}
 
 
 #include <fe/mapping_q1.h>
@@ -7535,11 +7535,11 @@ void UserMatrix::precondition (Vector<double> &dst,
 
 
 
-const FE_Q<2>   FEHelper<2>::fe_linear(1);
-const FE_Q<2>   FEHelper<2>::fe_quadratic_sub(2);
+const FE_Q<2>   FEHelper<2>::fe_linear(1)
+const FE_Q<2>   FEHelper<2>::fe_quadratic_sub(2)
 #if 2 < 3
-const FE_Q<2>   FEHelper<2>::fe_cubic_sub(3);
-const FE_Q<2>   FEHelper<2>::fe_quartic_sub(4);
+const FE_Q<2>   FEHelper<2>::fe_cubic_sub(3)
+const FE_Q<2>   FEHelper<2>::fe_quartic_sub(4)
 #endif
     
 const QGauss2<2> FEHelper<2>::q_gauss_2;
@@ -7578,7 +7578,7 @@ const FiniteElement<dim> & FEHelper<dim>::get_fe (const std::string &name) {
   Assert (false, ExcInternalError());
 
   return fe_linear;
-};
+}
 
 
 template <int dim>
@@ -7600,14 +7600,14 @@ const Quadrature<dim> &FEHelper<dim>::get_quadrature (const std::string &name) {
   Assert (false, ExcInternalError());
 
   return q_gauss_2;
-};
+}
 
 
 template <>
 const Quadrature<0> &FEHelper<1>::get_quadrature_face (const std::string &) {
   static const Quadrature<0> dummy_quadrature(1);
   return dummy_quadrature;
-};
+}
 
 
 template <int dim>
@@ -7629,7 +7629,7 @@ const Quadrature<dim-1> &FEHelper<dim>::get_quadrature_face (const std::string &
   Assert (false, ExcInternalError());
 
   return q_gauss_2_face;
-};
+}
 
 
 std::string int_to_string (const unsigned int i, const unsigned int digits) {
@@ -7649,7 +7649,7 @@ std::string int_to_string (const unsigned int i, const unsigned int digits) {
            s += "invalid digits information";
     };
   return s;
-};
+}
 
 
 template class FEHelper<2>;
@@ -7666,33 +7666,33 @@ template class FEHelper<2>;
 
 template <int dim>
 WaveProblem<dim>::WaveProblem ()
-{};
+{}
 
 
 template <int dim>
 WaveProblem<dim>::~WaveProblem ()
-{};
+{}
 
 
 template <int dim>
 void WaveProblem<dim>::declare_parameters (ParameterHandler &prm)
 {
   parameters.declare_parameters (prm);
-};
+}
 
 
 template <int dim>
 void WaveProblem<dim>::parse_parameters (ParameterHandler &prm)
 {
   parameters.parse_parameters (prm);
-};
+}
 
 
 template <int dim>
 void WaveProblem<dim>::create_new (const unsigned int)
 {
   parameters.delete_parameters ();
-};
+}
 
 
 template <int dim>
@@ -7729,7 +7729,7 @@ void WaveProblem<dim>::run (ParameterHandler &prm)
 
   for (unsigned int sweep=0; sweep<parameters.number_of_sweeps; ++sweep)
     timestep_manager.run_sweep (sweep);
-};
+}
 
 
 int main ()
@@ -7789,6 +7789,6 @@ int main ()
 
 
 return 0;
-};
+}
 
 
index b3bf61bdc6f9bf2a3be9317a88424906550a3bdd..cb5fbed965d212bce522712c8d83e47268a56578 100644 (file)
@@ -82,7 +82,7 @@ void make_grid (Triangulation<2> &triangulation)
 
       triangulation.execute_coarsening_and_refinement ();
     };
-};
+}
 
 
 template<int dim>
@@ -178,7 +178,7 @@ void test(const Triangulation<dim> &tria,
 //  file2.setf(std::ios::showpoint | std::ios::left);
 //  data_out.write_gnuplot(file2);
 //  file2.close();
-};
+}
 
 
 
index 36e8a3723c54f213835e9ba21a8fcbbe2bc3a633..deca1e696ebe58d42da67356bd2c8db7ccbb3c1c 100644 (file)
@@ -63,7 +63,7 @@ void check (const FiniteElement<dim> &fe)
        };
       deallog << std::endl;
     };
-};
+}
 
 
 
@@ -110,7 +110,7 @@ void check ()
              << std::endl;
       check (FESystem<dim> (FESystem<dim> (FE_Q<dim>(p),2), 2));
     };
-};
+}
 
   
 
@@ -124,5 +124,5 @@ int main ()
   check<1> ();
   check<2> ();
   check<3> ();
-};
+}
 
index cd9861325c2836c8bd1c265b273bfda877eda53d..7da8b4146f1f02860a0acd39813f2d41942e08a6 100644 (file)
@@ -42,7 +42,7 @@ void print_formatted (const FullMatrix<number> &A,
        };
       deallog << std::endl;
     };
-};
+}
 
 
 template <int dim>
index 4e474a998c2dfdb6de5de133d2788e9f5e8a74d9..2757606834bd2c9fdf2f583ddeaa68524544df71 100644 (file)
@@ -1,5 +1,5 @@
 // $Id$
-// Copyright (C) 2001, 2002 Ralf Hartmann
+// Copyright (C) 2001, 2002, 2003 Ralf Hartmann
 //
 // Shows the shape functions implemented and computes the area of cells.
 
@@ -172,7 +172,7 @@ plot_faces(Mapping<1>&,
           FiniteElement<1>&,
           DoFHandler<1>::cell_iterator&,
           const std::string&)
-{};
+{}
 
 
 
@@ -182,7 +182,7 @@ plot_subfaces(Mapping<1>&,
              FiniteElement<1>&,
              DoFHandler<1>::cell_iterator&,
              const std::string&)
-{};
+{}
 
 
 
index 9b25c8d481dc7b69aef0915f84d179dae8b1e037..3bb53ef353d3b6b1ea06087cea2345cd2f83aba2 100644 (file)
@@ -1,5 +1,5 @@
 // $Id$
-// Copyright (C) 2001 Wolfgang Bangerth
+// Copyright (C) 2001, 2003 Wolfgang Bangerth
 //
 // Test the continuity of normal vectors at vertices, and thus the
 // C1-ness of the C1-mapping
@@ -115,4 +115,4 @@ int main ()
                      ExcInternalError());
            };
        };  
-};
+}
index ffedb0f0f1de7152c36ceee4a3e49222e1aedff7..7b787b01c190fb413386935b6ed488aa39f2ba94 100644 (file)
 Point<2> stretch_coordinates (const Point<2> p)
 {
   return Point<2>(2*p(0), p(1));
-};
+}
 
 
 
 Point<2> tilt_coordinates (const Point<2> p)
 {
   return Point<2>(p(0)+p(1), p(1));
-};
+}
 
 
 void
@@ -72,7 +72,7 @@ transform_grid (Triangulation<2> &tria,
       default:
            Assert (false, ExcNotImplemented());
     };
-};
+}
 
            
 
@@ -138,7 +138,7 @@ plot_shape_functions()
 
       deallog << std::endl;
     }
-};
+}
 
 
 int
index 9e352d6a7d0482b5881350e445b76c0f37fb9bc0..dc12f97f5660900b11355fd3b683c4c35b553c9d 100644 (file)
@@ -81,7 +81,7 @@ plot (const Triangulation<dim> &tr)
                 
       deallog << std::endl;
     }
-};
+}
 
 
 
@@ -101,7 +101,7 @@ check ()
   tr.begin_active()->set_refine_flag ();
   tr.execute_coarsening_and_refinement ();
   plot (tr);
-};
+}
 
 
 int
index 44e909de25b05435c7b57af1dd74b8266975af81..19c05216291a9e7e33c3dadfeb2107cfd090c43e 100644 (file)
@@ -95,7 +95,7 @@ check ()
                 
       deallog << std::endl;
     }
-};
+}
 
 
 int
index 2968c73ee90eda53180e6ee9d8918f9f9afceb4d..c57806684d5c3c7f82a63f3458d2eeeee78b19ae 100644 (file)
@@ -106,7 +106,7 @@ create_stokes_matrix_1 (const DoFHandler<dim> &dof_handler,
                 local_dof_indices[j],
                 local_matrix(i,j));
     };
-};
+}
 
 
 
@@ -180,7 +180,7 @@ create_stokes_matrix_2 (const DoFHandler<dim> &dof_handler,
                 local_dof_indices[j],
                 local_matrix(i,j));
     };
-};
+}
 
 
 
@@ -258,7 +258,7 @@ create_stokes_matrix_3 (const DoFHandler<dim> &dof_handler,
                 local_dof_indices[j],
                 local_matrix(i,j));
     };
-};
+}
 
 
 
@@ -326,7 +326,7 @@ test ()
       Assert (A1.global_entry(i) == A3.global_entry(i),
              ExcInternalError());
     };
-};
+}
 
 
 
@@ -339,7 +339,7 @@ int main ()
   test<1> ();
   test<2> ();
   test<3> ();
-};
+}
 
 
 
index 93e9c0d249dba46eb7bf507eaa5d0f4c578e0cd3..ebdbcbd3eb41b4b69a9f6615c25eec788b72b6bd 100644 (file)
@@ -109,7 +109,7 @@ create_stokes_matrix_2 (const DoFHandler<dim> &dof_handler,
                 local_dof_indices[j],
                 local_matrix(i,j));
     };
-};
+}
 
 
 
@@ -187,7 +187,7 @@ create_stokes_matrix_3 (const DoFHandler<dim> &dof_handler,
                 local_dof_indices[j],
                 local_matrix(i,j));
     };
-};
+}
 
 
 
@@ -251,7 +251,7 @@ test ()
       Assert (A3.global_entry(i) == A2.global_entry(i),
              ExcInternalError());
     };
-};
+}
 
 
 
@@ -263,7 +263,7 @@ int main ()
 
   test<2> ();
   test<3> ();
-};
+}
 
 
 
index 337ee9c8ff29ac17dba1b4ad4dbc814699b134ae..085a836331e450a86a2fb6030e4850c9dcc2a388 100644 (file)
@@ -364,7 +364,7 @@ void test_compute_functions (const Mapping<dim> &mapping,
       fe_values.reinit(dof.begin_active());
       check_values_and_derivatives (fe, fe_values, q);
     };
-};
+}
 
 
 
@@ -530,7 +530,7 @@ void plot_FE_Nedelec_shape_functions()
 //   plot_shape_functions(m, p1, "Nedelec1");
 //   plot_face_shape_functions(m, p1, "Nedelec1");
   test_compute_functions(m, p1, "Nedelec1");
-};
+}
 
 
 
@@ -584,7 +584,7 @@ void plot_FE_System_shape_functions()
           test_compute_functions(m, p4, "System_Nedelec_2");
         };
     };
-};
+}
 
 
 int
index 86f04759ca6f30bf255339071c88ff4584000091..252ade450c05e75745aeedd257d976a71dd4bc28 100644 (file)
@@ -45,7 +45,7 @@ print_matrix(std::ostream& of,
             Triangulation<dim>& tr,
             unsigned int level,
             const FiniteElement<dim>& finel,
-            const char* name)
+            const char* /*name*/)
 {
   MGDoFHandler<dim> dof(tr);
   dof.distribute_dofs(finel);
index e3cc52ea27619967e813e59379def7e672c4cd7f..3a0c50aea1829605d8bd9123013136e0746309ea 100644 (file)
@@ -49,7 +49,7 @@ Point<dim> transform (const Point<dim> p)
             Assert (false, ExcNotImplemented());
             return Point<dim>();
     };
-};
+}
 
 
 template <int dim>
@@ -116,7 +116,7 @@ void check_element (const Triangulation<dim> &tr,
           << std::endl;
   
   Assert (relative_residual < threshold*x.l2_norm(), ExcInternalError());
-};
+}
 
 
 template <int dim>
@@ -130,7 +130,8 @@ void test ()
                                    // difficult. then refine it twice
   Triangulation<dim> tr;
   GridGenerator::hyper_cube(tr, 0., 1.);
-  GridTools::transform (&transform<dim>, tr);
+  Point<dim> (*p) (Point<dim>) = &transform<dim>;
+  GridTools::transform (p, tr);
   tr.refine_global (2);
 
                                    // now for a list of finite
@@ -226,8 +227,8 @@ void test ()
       {
         deallog << dim << "d, uniform grid, fe #" << i;
         check_element (tr, *fe_list[i]);
-      };
-};
+      }
+}
 
 
 
index 9c5c47684713806eeb6d16f82cb908ac4b74351b..5864e08388ea3646f438c0d9dc3404eab9d3b038 100644 (file)
@@ -200,7 +200,7 @@ void test ()
   const double msp2 = bsm.matrix_scalar_product (dst, src);
   Assert (msp1 == msp2, ExcInternalError());
   deallog << "matrix_scalar_product " << msp1 << ' ' << msp2 << std::endl;
-};
+}
 
 
 
@@ -238,4 +238,4 @@ int main ()
   
   
   return 0;
-};
+}
index f226757e315807642e635619669a836ca8414840..67c3a72e869b803b8c06f02a2ecab2df88b533b9 100644 (file)
@@ -187,5 +187,5 @@ int main ()
   
   
   return 0;
-};
+}
 
index 32b524fd48c6870ba3d514d8fa163fd82b65753b..84330d497d03bc4c7d80dbd1f829fdf4a8a0afa7 100644 (file)
@@ -32,7 +32,7 @@ bool operator == (const BlockVector<number> &v1,
     if (v1(i) != v2(i))
       return false;
   return true;
-};
+}
 
 
 void test ()
@@ -309,7 +309,7 @@ void test ()
                                       // everything is alright
       deallog << "Check 19: true" << std::endl;      
     };
-};
+}
 
 
 
@@ -354,5 +354,5 @@ int main ()
   
   
   return 0;
-};
+}
 
index 9e42e89b7901ae1b69dd28c793c5b09c16ec7242..71a84996343f58ff597a5d80a60bdbca45229904 100644 (file)
@@ -73,4 +73,4 @@ int main ()
                                MatrixOut::Options (false, 4));
       matrix_out.write_gmv (logfile);
     };
-};
+}
index 80e6297046a6cb5d02be990fd390ac2aa38f6e5b..7d0bdec2ad86aa00b0a59f1a4a99938e83d11ea7 100644 (file)
@@ -144,5 +144,5 @@ int main()
          std::cerr << e.what() << std::endl;
        }
     };
-};
+}
 
index babc7929a4054c5167387ad73077dc169ca0fb09..c73fd28820bcd379f80662da4418f45796f07b02 100644 (file)
@@ -118,5 +118,5 @@ int main()
        };
       
     };
-};
+}
 
index 69c3c56f8e8e130879f6b1f1fd9835f8b8032610..85ae8e89d364010aec03bc2add675765763f2c70 100644 (file)
@@ -155,7 +155,7 @@ main ()
            ++sp3_p, ++sp4_p)
        Assert (*sp3_p == *sp4_p, ExcInternalError());
     };
-};
+}
 
   
   
index dce736b5385fa83c4b2c30edaeb979cc3327109c..c6ee0f897aa3336221c08aa366c6a10e3620f2e0 100644 (file)
@@ -226,14 +226,14 @@ FDMatrix::gnuplot_print(std::ostream& s, const Vector<number>& V) const
 
 
 
-template void FDMatrix::five_point(SparseMatrix<long double>&) const;
-template void FDMatrix::five_point(SparseMatrix<double>&) const;
-template void FDMatrix::five_point(SparseMatrixEZ<double>&) const;
-template void FDMatrix::five_point(SparseMatrix<float>&) const;
-template void FDMatrix::nine_point(SparseMatrix<long double>&) const;
-template void FDMatrix::nine_point(SparseMatrix<double>&) const;
-template void FDMatrix::nine_point(SparseMatrixEZ<double>&) const;
-template void FDMatrix::nine_point(SparseMatrix<float>&) const;
+template void FDMatrix::five_point(SparseMatrix<long double>&, bool) const;
+template void FDMatrix::five_point(SparseMatrix<double>&, bool) const;
+template void FDMatrix::five_point(SparseMatrixEZ<double>&, bool) const;
+template void FDMatrix::five_point(SparseMatrix<float>&, bool) const;
+template void FDMatrix::nine_point(SparseMatrix<long double>&, bool) const;
+template void FDMatrix::nine_point(SparseMatrix<double>&, bool) const;
+template void FDMatrix::nine_point(SparseMatrixEZ<double>&, bool) const;
+template void FDMatrix::nine_point(SparseMatrix<float>&, bool) const;
 template void FDMatrix::gnuplot_print(std::ostream& s, const Vector<long double>& V) const;
 template void FDMatrix::gnuplot_print(std::ostream& s, const Vector<double>& V) const;
 template void FDMatrix::gnuplot_print(std::ostream& s, const Vector<float>& V) const;
index 6b7e6c4fd8c64182899bb789a9ca03125d91d26a..448d2b2b5f345121a24cf9b3e10aa8be750b6f50 100644 (file)
@@ -36,7 +36,7 @@ void print (const Vector<number> &v)
   for (unsigned int i=0; i<v.size(); ++i)
     deallog << v(i) << '\t';
   deallog << std::endl;
-};
+}
 
 
 
@@ -146,7 +146,7 @@ void check_vectors (Vector<number1> &d1, Vector<number2> &d2)
   
   d1.ratio (d1, d2);
   print (d1);
-};
+}
 
 
 int main()
@@ -170,6 +170,6 @@ int main()
   check_vectors (d1, d2);
   check_vectors (f1, f2);
   check_vectors (l1, l2);
-};
+}
 
   

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.