From b88741feee25469bb41528127c0c215da6d16a89 Mon Sep 17 00:00:00 2001 From: wolf Date: Wed, 9 Apr 2003 15:49:56 +0000 Subject: [PATCH] Purge most warnings from gcc 3.4. wave-test has a lot to do, though. git-svn-id: https://svn.dealii.org/trunk@7383 0785d39b-7218-0410-832d-ea1e28bc413d --- tests/base/auto_derivative_function.cc | 6 +- tests/base/table.cc | 2 +- tests/base/tensor.cc | 2 +- tests/bits/anna_1.cc | 18 +- tests/bits/anna_2.cc | 25 +- tests/bits/anna_3.cc | 13 +- tests/bits/anna_4.cc | 15 +- tests/bits/anna_5.cc | 2 +- tests/bits/anna_6.cc | 27 +- tests/bits/parameter_handler_1.cc | 4 +- tests/bits/unit_support_points.cc | 20 +- tests/deal.II/block_matrices.cc | 30 +- tests/deal.II/boundaries.cc | 10 +- tests/deal.II/constraints.cc | 8 +- tests/deal.II/data_out.cc | 18 +- tests/deal.II/dof_test.cc | 14 +- tests/deal.II/error_estimator.cc | 6 +- tests/deal.II/fe_tables.cc | 4 +- tests/deal.II/filtered_iterator.cc | 8 +- tests/deal.II/filtered_matrix.cc | 4 +- tests/deal.II/gradients.cc | 8 +- tests/deal.II/grid_in.cc | 6 +- tests/deal.II/grid_out.cc | 4 +- tests/deal.II/grid_test.cc | 10 +- tests/deal.II/grid_tools.cc | 6 +- tests/deal.II/grid_transform.cc | 2 +- tests/deal.II/intergrid_constraints.cc | 4 +- tests/deal.II/intergrid_map.cc | 4 +- tests/deal.II/matrices.cc | 8 +- tests/deal.II/second_derivatives.cc | 6 +- tests/deal.II/sparsity_pattern.cc | 10 +- tests/deal.II/subdomain_ids.cc | 4 +- tests/deal.II/support_point_map.cc | 8 +- tests/deal.II/wave-test-3.cc | 410 ++++++++++++------------- tests/fe/fe_tools_test.cc | 4 +- tests/fe/fe_traits.cc | 6 +- tests/fe/internals.cc | 2 +- tests/fe/mapping.cc | 6 +- tests/fe/mapping_c1.cc | 4 +- tests/fe/nedelec.cc | 8 +- tests/fe/nedelec_2.cc | 4 +- tests/fe/nedelec_3.cc | 2 +- tests/fe/non_primitive_1.cc | 10 +- tests/fe/non_primitive_2.cc | 8 +- tests/fe/shapes.cc | 6 +- tests/fe/transfer.cc | 2 +- tests/fe/up_and_down.cc | 11 +- tests/lac/block_matrices.cc | 4 +- tests/lac/block_vector.cc | 2 +- tests/lac/block_vector_iterator.cc | 6 +- tests/lac/matrix_out.cc | 2 +- tests/lac/solver.cc | 2 +- tests/lac/sparse_ilu.cc | 2 +- tests/lac/sparsity_pattern.cc | 2 +- tests/lac/testmatrix.cc | 16 +- tests/lac/vector-vector.cc | 6 +- 56 files changed, 417 insertions(+), 424 deletions(-) diff --git a/tests/base/auto_derivative_function.cc b/tests/base/auto_derivative_function.cc index 8d19af46d6..99df0403d4 100644 --- a/tests/base/auto_derivative_function.cc +++ b/tests/base/auto_derivative_function.cc @@ -66,7 +66,8 @@ template void AutoSinExp::vector_value (const Point &p, Vector &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 void ExactSinExp::vector_gradient (const Point &p, typename std::vector > &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); diff --git a/tests/base/table.cc b/tests/base/table.cc index dbde4ab5b2..3b79f44c64 100644 --- a/tests/base/table.cc +++ b/tests/base/table.cc @@ -322,7 +322,7 @@ main () ExcDimensionMismatch(Td[i][j][k][l][m].end() - Td[i][j][k][l][m].begin(), static_cast(N))); }; -}; +} diff --git a/tests/base/tensor.cc b/tests/base/tensor.cc index 6ab322e1a2..784aea7215 100644 --- a/tests/base/tensor.cc +++ b/tests/base/tensor.cc @@ -98,4 +98,4 @@ int main () deallog << "Result WRONG!" << std::endl; }; -}; +} diff --git a/tests/bits/anna_1.cc b/tests/bits/anna_1.cc index 9acfd07507..6d64cda088 100644 --- a/tests/bits/anna_1.cc +++ b/tests/bits/anna_1.cc @@ -63,7 +63,7 @@ SystemTest::SystemTest () : fe (FE_Nedelec(1), 2, FE_Q(1), 1), dof_handler (triangulation) -{}; +{} template @@ -81,7 +81,7 @@ void SystemTest::make_grid_and_dofs () deallog << "Number of degrees of freedom: " << dof_handler.n_dofs() << std::endl; -}; +} template void SystemTest::shape_to_components () @@ -94,15 +94,16 @@ void SystemTest::shape_to_components () for(unsigned int i = 0; i void SystemTest::check_numbering () { - DoFHandler::active_cell_iterator cell = dof_handler.begin_active(), - endc = dof_handler.end(); + typename DoFHandler::active_cell_iterator + cell = dof_handler.begin_active(), + endc = dof_handler.end(); std::vector local_dof_indices(fe.dofs_per_cell); for (; cell!=endc; ++cell) @@ -136,8 +137,7 @@ void SystemTest::check_numbering () << std::endl; deallog << std::endl; }; - -}; +} template @@ -146,7 +146,7 @@ void SystemTest::run () make_grid_and_dofs (); shape_to_components (); check_numbering(); -}; +} @@ -159,4 +159,4 @@ int main () SystemTest<2>().run(); SystemTest<3>().run(); return 0; -}; +} diff --git a/tests/bits/anna_2.cc b/tests/bits/anna_2.cc index 071401b1bb..96f55918e3 100644 --- a/tests/bits/anna_2.cc +++ b/tests/bits/anna_2.cc @@ -57,9 +57,7 @@ class SystemTest Triangulation triangulation; FESystem fe; - DoFHandler dof_handler; - - + DoFHandler dof_handler; }; template @@ -67,7 +65,7 @@ SystemTest::SystemTest () : fe (FE_Nedelec(1), 2, FE_Q(1), 1), dof_handler (triangulation) -{}; +{} template @@ -83,9 +81,8 @@ void SystemTest::make_grid_and_dofs () dof_handler.distribute_dofs (fe); deallog << "Number of degrees of freedom: " << dof_handler.n_dofs() - << std::endl; - -}; + << std::endl; +} template void SystemTest::shape_to_components () @@ -98,15 +95,16 @@ void SystemTest::shape_to_components () for(unsigned int i = 0; i void SystemTest::check_numbering () { - DoFHandler::active_cell_iterator cell = dof_handler.begin_active(), - endc = dof_handler.end(); + typename DoFHandler::active_cell_iterator + cell = dof_handler.begin_active(), + endc = dof_handler.end(); std::vector local_dof_indices(fe.dofs_per_cell); for (; cell!=endc; ++cell) @@ -143,8 +141,7 @@ void SystemTest::check_numbering () << std::endl; deallog << std::endl; }; - -}; +} template @@ -153,7 +150,7 @@ void SystemTest::run () make_grid_and_dofs (); shape_to_components (); check_numbering(); -}; +} @@ -166,4 +163,4 @@ int main () SystemTest<2>().run(); SystemTest<3>().run(); return 0; -}; +} diff --git a/tests/bits/anna_3.cc b/tests/bits/anna_3.cc index f7890b1027..59b688b0bf 100644 --- a/tests/bits/anna_3.cc +++ b/tests/bits/anna_3.cc @@ -61,13 +61,12 @@ SystemTest::SystemTest () : fe (FE_Nedelec(1), 2, FE_Q(1), 1), dof_handler (triangulation) -{}; +{} template void SystemTest::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::make_grid_and_dofs () deallog << "Number of degrees of freedom: " << dof_handler.n_dofs() << std::endl; -}; +} template @@ -104,7 +103,7 @@ void SystemTest::check () for (unsigned int i=0; i @@ -119,7 +118,7 @@ void SystemTest::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; -}; +} diff --git a/tests/bits/anna_4.cc b/tests/bits/anna_4.cc index 653e478817..6e58f05277 100644 --- a/tests/bits/anna_4.cc +++ b/tests/bits/anna_4.cc @@ -69,7 +69,7 @@ void VectorBoundaryValues::vector_value (const Point &p, for (unsigned int i=0; i<2; ++i) values(i) = p(i)*p(i); -}; +} @@ -87,7 +87,7 @@ class FindBug FESystem fe; DoFHandler dof_handler; Vector solution; -}; +} // Construct FESystem with @@ -98,7 +98,7 @@ FindBug::FindBug () : fe (FE_Q(1), 1, FE_DGP(0), 1), dof_handler (triangulation) -{}; +{} template @@ -125,8 +125,7 @@ void FindBug::make_grid_and_dofs () << std::endl; solution.reinit(dof_handler.n_dofs()); - -}; +} template @@ -227,7 +226,7 @@ void FindBug::dirichlet_conditions () for (unsigned int i=0; i::run () { make_grid_and_dofs (); dirichlet_conditions (); -}; +} @@ -250,5 +249,5 @@ int main () FindBug<3>().run (); return 0; -}; +} diff --git a/tests/bits/anna_5.cc b/tests/bits/anna_5.cc index 9674075b97..1e79d42cff 100644 --- a/tests/bits/anna_5.cc +++ b/tests/bits/anna_5.cc @@ -21,4 +21,4 @@ int main () { std::ofstream o("anna_5.output"); BlockSparsityPattern sparsity_pattern; -}; +} diff --git a/tests/bits/anna_6.cc b/tests/bits/anna_6.cc index 07b2aaaa1b..15d6641cca 100644 --- a/tests/bits/anna_6.cc +++ b/tests/bits/anna_6.cc @@ -112,13 +112,13 @@ class BoundaryFunction : public Function template BoundaryFunction::BoundaryFunction () : - Function (dim+1) {}; + Function (dim+1) {} template inline -void BoundaryFunction::vector_value (const Point &p, +void BoundaryFunction::vector_value (const Point &, Vector &values) const { @@ -127,7 +127,7 @@ void BoundaryFunction::vector_value (const Point &p, values.clear (); values(dim) = 1.; -}; +} @@ -138,10 +138,8 @@ void BoundaryFunction::vector_value (const Point &p, template ImposeBC::ImposeBC() : fe (FE_Nedelec(1), 1, FE_Q(1), 1), - dof_handler (triangulation) - - -{}; + dof_handler (triangulation) +{} @@ -149,7 +147,7 @@ template ImposeBC::~ImposeBC() { dof_handler.clear (); -}; +} template @@ -195,9 +193,7 @@ void ImposeBC::test_extract_boundary_DoFs () for (unsigned int i=0; i::test_interpolate_BC () deallog << boundary_values[i] << ' '; } deallog << std::endl; -}; +} @@ -280,9 +276,8 @@ void ImposeBC::run () << std::endl; test_extract_boundary_DoFs (); - test_interpolate_BC (); - -}; + test_interpolate_BC (); +} int main () @@ -323,4 +318,4 @@ int main () }; return 0; -}; +} diff --git a/tests/bits/parameter_handler_1.cc b/tests/bits/parameter_handler_1.cc index 835823ad10..066c64339f 100644 --- a/tests/bits/parameter_handler_1.cc +++ b/tests/bits/parameter_handler_1.cc @@ -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; -}; +} diff --git a/tests/bits/unit_support_points.cc b/tests/bits/unit_support_points.cc index 38ca26f634..054626f423 100644 --- a/tests/bits/unit_support_points.cc +++ b/tests/bits/unit_support_points.cc @@ -33,7 +33,7 @@ void check_cell1 (const FiniteElement &fe) fe.unit_support_point(i), ExcInternalError()); deallog << "dim=" << dim << ", cell=ok" << std::endl; -}; +} template @@ -44,11 +44,11 @@ void check_face1 (const FiniteElement &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 &fe) { check_cell1 (fe); check_face1 (fe); -}; +} template @@ -69,7 +69,7 @@ void check_cell2 (const FiniteElement &fe, deallog << i << " " << fe.unit_support_point(i) << std::endl; deallog << "dim=" << dim << ", cell=ok" << std::endl; -}; +} template @@ -81,12 +81,12 @@ void check_face2 (const FiniteElement &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 &fe, { check_cell2 (fe, comp); check_face2 (fe, comp); -}; +} @@ -117,7 +117,7 @@ void check () check2 (FESystem (FE_Q (2), 1, FE_DGP (2), 1), 0); -}; +} @@ -131,4 +131,4 @@ int main () check<2> (); check<3> (); return 0; -}; +} diff --git a/tests/deal.II/block_matrices.cc b/tests/deal.II/block_matrices.cc index 7fea52e91d..b83e8c0830 100644 --- a/tests/deal.II/block_matrices.cc +++ b/tests/deal.II/block_matrices.cc @@ -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::LaplaceProblem (const unsigned int n_blo dof_handler (triangulation) { sparsity_pattern.reinit (n_blocks, n_blocks); -}; +} @@ -96,7 +96,7 @@ LaplaceProblem,SparseMatrix,SparsityPattern>::LaplaceProb n_blocks (n_blocks), fe(1), dof_handler (triangulation) -{}; +{} @@ -105,7 +105,7 @@ LaplaceProblem,SparseMatrix,SparsityPattern>::LaplaceProble n_blocks (n_blocks), fe(1), dof_handler (triangulation) -{}; +{} @@ -133,7 +133,7 @@ void LaplaceProblem::make_grid_and_dofs () system_matrix.reinit (sparsity_pattern); reinit_vectors (); -}; +} template <> @@ -142,7 +142,7 @@ void LaplaceProblem,SparseMatrix,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,SparseMatrix,SparsityPattern>::reinit { solution.reinit (dof_handler.n_dofs()); system_rhs.reinit (dof_handler.n_dofs()); -}; +} @@ -161,7 +161,7 @@ void LaplaceProblem,SparseMatrix,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,SparseMatrix,SparsityPattern>::reinit_v { solution.reinit (dof_handler.n_dofs()); system_rhs.reinit (dof_handler.n_dofs()); -}; +} @@ -210,7 +210,7 @@ void LaplaceProblem,BlockSparseMatrix,BlockSparsityP default: AssertThrow (false, ExcNotImplemented()); }; -}; +} @@ -248,7 +248,7 @@ void LaplaceProblem,BlockSparseMatrix,BlockSparsityP default: AssertThrow (false, ExcNotImplemented()); }; -}; +} @@ -313,7 +313,7 @@ void LaplaceProblem::assemble_system () system_matrix, solution, system_rhs); -}; +} template @@ -328,7 +328,7 @@ void LaplaceProblem::solve () cg.solve (system_matrix, solution, system_rhs, preconditioner); -}; +} template @@ -345,7 +345,7 @@ void LaplaceProblem::run () //<< typeid(Matrix).name () //<< '-' << i << ' ' << solution(i) << std::endl; -}; +} @@ -440,4 +440,4 @@ int main () return 0; -}; +} diff --git a/tests/deal.II/boundaries.cc b/tests/deal.II/boundaries.cc index b5b3b39f36..6c4565c2aa 100644 --- a/tests/deal.II/boundaries.cc +++ b/tests/deal.II/boundaries.cc @@ -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 virtual void vector_value (const Point &p, Vector &values) const - { for (unsigned int d=0; dn_components; ++d) values(d) = value(p,d); }; }; @@ -58,14 +58,14 @@ boundary_q (const DoFHandler &) { static const QGauss4 q; return q; -}; +} const Quadrature<0> & boundary_q (const DoFHandler<1> &) { return *static_cast*>(0); -}; +} void write_map (const std::map &bv) @@ -73,7 +73,7 @@ void write_map (const std::map &bv) for (std::map::const_iterator i=bv.begin(); i!=bv.end(); ++i) deallog << i->first << ' ' << i->second < &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 (); -}; +} diff --git a/tests/deal.II/data_out.cc b/tests/deal.II/data_out.cc index afa9ef4423..386f1902ac 100644 --- a/tests/deal.II/data_out.cc +++ b/tests/deal.II/data_out.cc @@ -102,7 +102,7 @@ double RightHandSide::value (const Point &p, return_value += 4*pow(p(i), 4); return return_value; -}; +} template @@ -110,7 +110,7 @@ double BoundaryValues::value (const Point &p, const unsigned int) const { return p.square(); -}; +} @@ -118,7 +118,7 @@ double BoundaryValues::value (const Point &p, template LaplaceProblem::LaplaceProblem () : fe (1), dof_handler (triangulation) -{}; +{} @@ -157,7 +157,7 @@ void LaplaceProblem::make_grid_and_dofs () solution.reinit (dof_handler.n_dofs()); system_rhs.reinit (dof_handler.n_dofs()); -}; +} @@ -169,7 +169,7 @@ void LaplaceProblem::solve () // arbitrary values for (unsigned int i=0; i::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::run () make_grid_and_dofs(); solve (); output_results (); -}; +} @@ -267,4 +267,4 @@ int main () laplace_problem_3d.run (); return 0; -}; +} diff --git a/tests/deal.II/dof_test.cc b/tests/deal.II/dof_test.cc index 6575ca79f9..c28798dc7f 100644 --- a/tests/deal.II/dof_test.cc +++ b/tests/deal.II/dof_test.cc @@ -135,7 +135,7 @@ CurvedLine::get_new_point_on_line (const typename Triangulation::line_ middle(1) = 1+0.04*sin(6*3.141592*middle(0)); return middle; -}; +} @@ -170,7 +170,7 @@ CurvedLine::get_new_point_on_quad (const typename Triangulation::quad_ middle(1) = 1+0.04*sin(6*3.141592*middle(0)); return middle; -}; +} @@ -195,7 +195,7 @@ class TestCases template TestCases::TestCases () : - tria(0), dof(0) {}; + tria(0), dof(0) {} @@ -204,7 +204,7 @@ TestCases::~TestCases () { if (dof) delete dof; if (tria) delete tria; -}; +} @@ -218,7 +218,7 @@ void TestCases::create_new () GridGenerator::hyper_cube(*tria); dof = new DoFHandler (*tria); -}; +} @@ -336,7 +336,7 @@ void TestCases::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; -}; +} diff --git a/tests/deal.II/error_estimator.cc b/tests/deal.II/error_estimator.cc index 0a06913928..13dd7ed97b 100644 --- a/tests/deal.II/error_estimator.cc +++ b/tests/deal.II/error_estimator.cc @@ -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&) { static QGauss4 q; return q; -}; +} Quadrature<0> & get_q_face (Function<1>&) { return *static_cast*>(0); -}; +} diff --git a/tests/deal.II/fe_tables.cc b/tests/deal.II/fe_tables.cc index 97526e43ee..cc9b70db66 100644 --- a/tests/deal.II/fe_tables.cc +++ b/tests/deal.II/fe_tables.cc @@ -50,8 +50,8 @@ print_fe_statistics(const FiniteElement& fe) DoFHandler dof(tr); dof.distribute_dofs(fe); StraightBoundary boundary; - DoFHandler::active_cell_iterator cell = dof.begin_active(); - DoFHandler::active_face_iterator face = dof.begin_active_face(); + typename DoFHandler::active_cell_iterator cell = dof.begin_active(); + typename DoFHandler::active_face_iterator face = dof.begin_active_face(); const std::vector > unit_points = fe.get_unit_support_points(); const std::vector > support_points = fe.get_support_points(); diff --git a/tests/deal.II/filtered_iterator.cc b/tests/deal.II/filtered_iterator.cc index 254c41f40e..f5f30e7c26 100644 --- a/tests/deal.II/filtered_iterator.cc +++ b/tests/deal.II/filtered_iterator.cc @@ -43,7 +43,7 @@ template bool level_equal_to_3 (const Iterator c) { return (static_cast(c->level()) == 3); -}; +} @@ -52,7 +52,7 @@ bool level_equal_to (const Iterator c, const unsigned int level) { return (static_cast(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; -}; +} diff --git a/tests/deal.II/filtered_matrix.cc b/tests/deal.II/filtered_matrix.cc index 752fa4fdc3..7e2516f02a 100644 --- a/tests/deal.II/filtered_matrix.cc +++ b/tests/deal.II/filtered_matrix.cc @@ -68,7 +68,7 @@ solve_filtered (std::map &bv, i!=bv.end(); ++i) Assert (std::fabs(u(i->first) - i->second) < 1e-8, ExcInternalError()); -}; +} @@ -88,7 +88,7 @@ solve_eliminated (std::map &bv, prec.initialize (A, 1.2); solver.solve (A, u, f, prec); -}; +} diff --git a/tests/deal.II/gradients.cc b/tests/deal.II/gradients.cc index 22e8b3c66c..cc25fb9a4d 100644 --- a/tests/deal.II/gradients.cc +++ b/tests/deal.II/gradients.cc @@ -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 val(4); + Vector val(4); deallog << "Testing transformation of gradients of shape function:" << std::endl; @@ -66,7 +66,7 @@ Vector 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; -}; +} diff --git a/tests/deal.II/grid_in.cc b/tests/deal.II/grid_in.cc index 102b1e5d42..014804e2bb 100644 --- a/tests/deal.II/grid_in.cc +++ b/tests/deal.II/grid_in.cc @@ -40,7 +40,7 @@ void test1 () GridOut grid_out; grid_out.write_ucd (tria, logfile); -}; +} template @@ -66,7 +66,7 @@ void test2 () for (unsigned int i=0; i::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> (); -}; +} diff --git a/tests/deal.II/grid_out.cc b/tests/deal.II/grid_out.cc index 6ad2e2de94..fcc5cdb770 100644 --- a/tests/deal.II/grid_out.cc +++ b/tests/deal.II/grid_out.cc @@ -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> (); -}; +} diff --git a/tests/deal.II/grid_test.cc b/tests/deal.II/grid_test.cc index a2dfcc9fbc..9fb242d70f 100644 --- a/tests/deal.II/grid_test.cc +++ b/tests/deal.II/grid_test.cc @@ -51,7 +51,7 @@ class Ball : }; -virtual Point + virtual Point get_new_point_on_quad (const typename Triangulation::quad_iterator &quad) const { Point middle = StraightBoundary::get_new_point_on_quad(quad); @@ -125,7 +125,7 @@ CurvedLine::get_new_point_on_line (const typename Triangulation::line_ middle(1) = 1+0.04*sin(6*3.141592*middle(0)); return middle; -}; +} template @@ -159,7 +159,7 @@ CurvedLine::get_new_point_on_quad (const typename Triangulation::quad_ middle(1) = 1+0.04*sin(6*3.141592*middle(0)); return middle; -}; +} template @@ -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; -}; +} diff --git a/tests/deal.II/grid_tools.cc b/tests/deal.II/grid_tools.cc index 8403c56da2..4e9d196a6d 100644 --- a/tests/deal.II/grid_tools.cc +++ b/tests/deal.II/grid_tools.cc @@ -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; -}; +} diff --git a/tests/deal.II/grid_transform.cc b/tests/deal.II/grid_transform.cc index e5ad1d47bd..d8f9798a88 100644 --- a/tests/deal.II/grid_transform.cc +++ b/tests/deal.II/grid_transform.cc @@ -116,4 +116,4 @@ int main () tria.clear(); return 0; -}; +} diff --git a/tests/deal.II/intergrid_constraints.cc b/tests/deal.II/intergrid_constraints.cc index 46057b6f21..65cc7eb669 100644 --- a/tests/deal.II/intergrid_constraints.cc +++ b/tests/deal.II/intergrid_constraints.cc @@ -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> (); -}; +} diff --git a/tests/deal.II/intergrid_map.cc b/tests/deal.II/intergrid_map.cc index 44765e4263..f585302876 100644 --- a/tests/deal.II/intergrid_map.cc +++ b/tests/deal.II/intergrid_map.cc @@ -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> (); -}; +} diff --git a/tests/deal.II/matrices.cc b/tests/deal.II/matrices.cc index 9816d8eb6a..31cda39d60 100644 --- a/tests/deal.II/matrices.cc +++ b/tests/deal.II/matrices.cc @@ -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 &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); -}; +} diff --git a/tests/deal.II/second_derivatives.cc b/tests/deal.II/second_derivatives.cc index 53aae2dd5a..e904b1714d 100644 --- a/tests/deal.II/second_derivatives.cc +++ b/tests/deal.II/second_derivatives.cc @@ -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 val(4); + Vector val(4); deallog << "Testing transformation of 2nd derivatives of shape function:" << std::endl; @@ -89,4 +89,4 @@ Vector val(4); deallog << std::endl; }; }; -}; +} diff --git a/tests/deal.II/sparsity_pattern.cc b/tests/deal.II/sparsity_pattern.cc index de8c17e376..38ad99997a 100644 --- a/tests/deal.II/sparsity_pattern.cc +++ b/tests/deal.II/sparsity_pattern.cc @@ -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 &dof) << " -- " << (sparsity_1 == sparsity_2 ? "ok" : "failed") << std::endl; -}; +} @@ -218,7 +218,7 @@ check () // check boundary matrices check_boundary (dof); -}; +} diff --git a/tests/deal.II/subdomain_ids.cc b/tests/deal.II/subdomain_ids.cc index 123a9072cf..9b01b69f6c 100644 --- a/tests/deal.II/subdomain_ids.cc +++ b/tests/deal.II/subdomain_ids.cc @@ -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; -}; +} diff --git a/tests/deal.II/support_point_map.cc b/tests/deal.II/support_point_map.cc index ea16c04bea..4d1f07b52d 100644 --- a/tests/deal.II/support_point_map.cc +++ b/tests/deal.II/support_point_map.cc @@ -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))))); -}; +} diff --git a/tests/deal.II/wave-test-3.cc b/tests/deal.II/wave-test-3.cc index aaff31b246..96edb1f297 100644 --- a/tests/deal.II/wave-test-3.cc +++ b/tests/deal.II/wave-test-3.cc @@ -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 inline number sqr (const number a) { return a*a; -}; +} /** @@ -1802,7 +1802,7 @@ DualFunctional::DualFunctional (const bool use_primal_problem, time(0), time_step(0), step_no(0) -{}; +{} template @@ -1810,7 +1810,7 @@ void DualFunctional::compute_functionals (Vector &j1, Vector &j2) { j1.reinit (dof->n_dofs()); j2.reinit (dof->n_dofs()); -}; +} template @@ -1818,19 +1818,19 @@ void DualFunctional::compute_endtime_vectors (Vector &final_u_bar, Vector &final_v_bar) { final_u_bar.reinit (dof->n_dofs()); final_v_bar.reinit (dof->n_dofs()); -}; +} template bool DualFunctional::use_primal_solutions () const { return use_primal_problem; -}; +} template bool DualFunctional::use_primal_solutions_at_endtime () const { return use_primal_problem_at_endtime; -}; +} template @@ -1847,7 +1847,7 @@ void DualFunctional::reset (const TimeStep_Primal &primal_problem) { u = &primal_problem.u; v = &primal_problem.v; -}; +} template @@ -1865,7 +1865,7 @@ void DualFunctional::reset (const TimeStep_Dual &dual_problem) { 0 : dual_problem.get_forward_timestep()); step_no = dual_problem.timestep_no; -}; +} /* ----------------------- EndEnergy ------------------------------*/ @@ -1873,7 +1873,7 @@ void DualFunctional::reset (const TimeStep_Dual &dual_problem) { template EndEnergy::EndEnergy (const bool use_primal_problem) : - DualFunctional (use_primal_problem, true) {}; + DualFunctional (use_primal_problem, true) {} template @@ -1881,23 +1881,23 @@ void EndEnergy::compute_vectors (const PartOfDomain pod, Vector &final_u_bar, Vector &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::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 fe_values (*fe, *quadrature, + FEValues fe_values (*this->fe, *this->quadrature, UpdateFlags(update_values | update_gradients | update_JxW_values | update_q_points)); - FEValues fe_values_primal (*primal_fe, *quadrature, + FEValues fe_values_primal (*this->primal_fe, *this->quadrature, UpdateFlags(update_values | update_gradients)); FullMatrix cell_matrix (dofs_per_cell, dofs_per_cell); @@ -1905,8 +1905,8 @@ void EndEnergy::compute_vectors (const PartOfDomain pod, std::vector > local_u_grad (n_q_points); std::vector local_v (n_q_points); - std::vector density_values(quadrature->n_quadrature_points); - std::vector stiffness_values(quadrature->n_quadrature_points); + std::vector density_values(this->quadrature->n_quadrature_points); + std::vector stiffness_values(this->quadrature->n_quadrature_points); std::vector cell_dof_indices (dofs_per_cell); @@ -1927,12 +1927,12 @@ void EndEnergy::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 local_functional1 (dofs_per_cell, 0); @@ -1957,7 +1957,7 @@ void EndEnergy::compute_vectors (const PartOfDomain pod, final_v_bar(cell_dof_indices[shape_func]) += local_functional2[shape_func]; }; }; -}; +} /*------------------------ IntegrateValueAtOrigin --------------------------------*/ @@ -1966,11 +1966,11 @@ void EndEnergy::compute_vectors (const PartOfDomain pod, template void IntegratedValueAtOrigin::compute_functionals (Vector &j1, Vector &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::active_cell_iterator cell = dof->begin_active(), - endc = dof->end(); + typename DoFHandler::active_cell_iterator cell = this->dof->begin_active(), + endc = this->dof->end(); Point origin; @@ -1986,7 +1986,7 @@ void IntegratedValueAtOrigin::compute_functionals (Vector &j1, }; Assert (origin_found, ExcVertexNotFound()); -}; +} /*------------------------ SeismicSignal --------------------------------*/ @@ -1997,7 +1997,7 @@ void SeismicSignal<1>::compute_functionals (Vector &, Vector &) { Assert (false, ExcNotImplemented()); -}; +} template @@ -2007,13 +2007,13 @@ void SeismicSignal::compute_functionals (Vector &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::active_cell_iterator cell, endc; typename DoFHandler::face_iterator face; - cell = dof->begin_active(); - endc = dof->end(); + cell = this->dof->begin_active(); + endc = this->dof->end(); std::vector cell_dof_indices (dofs_per_cell); @@ -2044,7 +2044,7 @@ void SeismicSignal::compute_functionals (Vector &j1, for (unsigned int shape_func=0; shape_func::compute_functionals (Vector &, Vector &) { Assert (false, ExcNotImplemented()); -}; +} template void EarthSurface::compute_functionals (Vector &j1, Vector &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::compute_functionals (Vector &j1, for (unsigned int shape_func=0; shape_func::compute_functionals (Vector &, Vector &) { Assert (false, ExcInternalError()); -}; +} template @@ -2155,7 +2155,7 @@ void SplitSignal::compute_functionals (Vector &j1, j1(dof_indices[i]) += sum * time_step / 2; }; }; -}; +} /* ------------------------------ Split line 1d case ----------------------------- */ @@ -2164,7 +2164,7 @@ template void SplitLine::compute_endtime_vectors (Vector &, Vector &) { Assert (false, ExcNotImplemented ()); -}; +} #if 2 == 1 @@ -2248,7 +2248,7 @@ void OneBranch1d::compute_functionals (Vector &j1, j1(dof_indices[i]) += sum; }; }; -}; +} /*------------------------ SecondCrossing --------------------------------*/ @@ -2290,7 +2290,7 @@ void SecondCrossing::compute_functionals (Vector &j1, j1(dof_indices[i]) += sum / time_step; }; }; -}; +} /*------------------------ HuyghensWave --------------------------------*/ @@ -2327,7 +2327,7 @@ void HuyghensWave::compute_functionals (Vector &j1, }; AssertThrow (point_found, ExcInternalError()); -}; +} @@ -2377,7 +2377,7 @@ EvaluationBase::EvaluationBase () : time (0), time_step (0), step_no (0) -{}; +{} template @@ -2401,21 +2401,21 @@ void EvaluationBase::reset_timelevel (const TimeStep_Primal &target) { base_file_name = target.parameters.output_directory + "sweep"+int_to_string(target.sweep_no, 2) + "/evaluation/" + int_to_string(step_no,4); -}; +} template -void EvaluationBase::reset () {}; +void EvaluationBase::reset () {} template -void EvaluationBase::print_final_result (std::ostream &) {}; +void EvaluationBase::print_final_result (std::ostream &) {} template double EvaluationBase::get_final_result () { return 0; -}; +} /*--------------------------- EvaluateEnergyContent ----------------------*/ @@ -2423,14 +2423,14 @@ double EvaluationBase::get_final_result () { template EvaluateEnergyContent::EvaluateEnergyContent () : old_energy (0), - integrated_outflux (0) {}; + integrated_outflux (0) {} template void EvaluateEnergyContent::reset () { old_energy = 0; integrated_outflux = 0; -}; +} template @@ -2501,7 +2501,7 @@ double EvaluateEnergyContent::compute_energy (const PartOfDomain pod) const }; return total_energy; -}; +} /* ---------------------------- EvaluateIntegratedValueAtOrigin ------------------- */ @@ -2511,25 +2511,25 @@ template void EvaluateIntegratedValueAtOrigin::print_final_result (std::ostream &out) { out << " Integrated value of u at origin: " << integrated_value << std::endl; -}; +} template double EvaluateIntegratedValueAtOrigin::get_final_result () { return integrated_value; -}; +} template std::string EvaluateIntegratedValueAtOrigin::description () const { return "integrated value at origin"; -}; +} template void EvaluateIntegratedValueAtOrigin::reset () { integrated_value = 0; -}; +} template @@ -2557,7 +2557,7 @@ double EvaluateIntegratedValueAtOrigin::evaluate () { integrated_value += value_at_origin * time_step; return value_at_origin; -}; +} /*------------------------- EvaluateSeismicSignal --------------------------*/ @@ -2566,25 +2566,25 @@ double EvaluateIntegratedValueAtOrigin::evaluate () { template void EvaluateSeismicSignal::print_final_result (std::ostream &out) { out << " Integrated seismic signal: " << result << std::endl; -}; +} template double EvaluateSeismicSignal::get_final_result () { return result; -}; +} template std::string EvaluateSeismicSignal::description () const { return "Integrated seismic signal at top"; -}; +} template void EvaluateSeismicSignal::reset () { result = 0; -}; +} template <> @@ -2592,7 +2592,7 @@ double EvaluateSeismicSignal<1>::evaluate () { Assert (false, ExcNotImplemented()); return 0; -}; +} template @@ -2647,7 +2647,7 @@ double EvaluateSeismicSignal::evaluate () { result += u_integrated*time_step; return u_integrated; -}; +} /*------------------------- EvaluateSplitSignal --------------------------*/ @@ -2656,25 +2656,25 @@ double EvaluateSeismicSignal::evaluate () { template void EvaluateSplitSignal::print_final_result (std::ostream &out) { out << " Integrated split signal: " << result << std::endl; -}; +} template double EvaluateSplitSignal::get_final_result () { return result; -}; +} template std::string EvaluateSplitSignal::description () const { return "Integrated split signal (exact: (2+pi)/(16-pi)=0.010229)"; -}; +} template void EvaluateSplitSignal::reset () { result = 0; -}; +} template <> @@ -2682,7 +2682,7 @@ double EvaluateSplitSignal<1>::evaluate () { Assert (false, ExcNotImplemented()); return 0; -}; +} template @@ -2727,7 +2727,7 @@ double EvaluateSplitSignal::evaluate () { result += u_integrated*time_step / 2; return u_integrated; -}; +} /*------------------------- EvaluateOneBranch1d --------------------------*/ @@ -2736,25 +2736,25 @@ double EvaluateSplitSignal::evaluate () { template void EvaluateOneBranch1d::print_final_result (std::ostream &out) { out << " One branch integrated: " << result << std::endl; -}; +} template double EvaluateOneBranch1d::get_final_result () { return result; -}; +} template std::string EvaluateOneBranch1d::description () const { return "One branch integrated (exact: 0.055735)"; -}; +} template void EvaluateOneBranch1d::reset () { result = 0; -}; +} template @@ -2762,7 +2762,7 @@ double EvaluateOneBranch1d::evaluate () { Assert (false, ExcNotImplemented()); return 0; -}; +} #if 2 == 1 @@ -2806,25 +2806,25 @@ double EvaluateOneBranch1d<1>::evaluate () { template void EvaluateSecondCrossing1d::print_final_result (std::ostream &out) { out << " Second crossing: " << result << std::endl; -}; +} template double EvaluateSecondCrossing1d::get_final_result () { return result; -}; +} template std::string EvaluateSecondCrossing1d::description () const { return "Second crossing (exact: 0.011147)"; -}; +} template void EvaluateSecondCrossing1d::reset () { result = 0; -}; +} template @@ -2832,7 +2832,7 @@ double EvaluateSecondCrossing1d::evaluate () { Assert (false, ExcNotImplemented()); return 0; -}; +} #if 2 == 1 @@ -2877,25 +2877,25 @@ template void EvaluateHuyghensWave::print_final_result (std::ostream &out) { out << " Hughens wave -- weighted time: " << weighted_value / integrated_value << std::endl; out << " average : " << integrated_value << std::endl; -}; +} template double EvaluateHuyghensWave::get_final_result () { return weighted_value / integrated_value; -}; +} template std::string EvaluateHuyghensWave::description () const { return "Huyghens wave"; -}; +} template void EvaluateHuyghensWave::reset () { integrated_value = weighted_value = 0; -}; +} template @@ -2932,7 +2932,7 @@ double EvaluateHuyghensWave::evaluate () }; return value_at_origin; -}; +} template class EvaluationBase<2>; @@ -2968,7 +2968,7 @@ TimestepManager::TimestepManager (const WaveParameters ¶meters) : TimeDependent::TimeSteppingData(0,1), TimeDependent::TimeSteppingData(0,1)), parameters (parameters) -{}; +{} template @@ -3035,7 +3035,7 @@ void TimestepManager::run_sweep (const unsigned int sweep_no) end_sweep (); deallog << std::endl << std::endl; -}; +} template @@ -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 @@ -3249,7 +3249,7 @@ void TimestepManager::write_statistics (const SweepInfo &sweep_info) const deallog << std::endl; }; -}; +} template @@ -3268,7 +3268,7 @@ void TimestepManager::write_stacked_data (DataOutStack &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::WaveParameters () : stiffness (0), dual_functional (0), coarse_grid (0) -{}; +{} template WaveParameters::~WaveParameters () { delete_parameters (); -}; +} template @@ -3759,7 +3759,7 @@ void WaveParameters::delete_parameters () i!=eval_list.end(); ++i) delete *i; eval_list.erase (eval_list.begin(), eval_list.end()); -}; +} template @@ -3802,7 +3802,7 @@ void WaveParameters::set_initial_functions (const std::string &u_name, initial_u = functions[0]; initial_v = functions[1]; -}; +} template @@ -3844,7 +3844,7 @@ void WaveParameters::set_coefficient_functions (const std::string &name) { } else AssertThrow (false, ExcUnknownName (name)); -}; +} template @@ -3883,7 +3883,7 @@ void WaveParameters::set_boundary_functions (const std::string &name) { } else AssertThrow (false, ExcUnknownName (name)); -}; +} template @@ -3929,7 +3929,7 @@ void WaveParameters::make_eval_list (const std::string &names) { else AssertThrow (false, ExcUnknownName (name)); }; -}; +} template @@ -3963,7 +3963,7 @@ void WaveParameters::set_dual_functional (const std::string &name) { dual_functional = new HuyghensWave (); 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 @@ -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::SweepData (const bool use_data_out_stack) data_out_stack = new DataOutStack(); else data_out_stack = 0; -}; +} template @@ -4573,7 +4573,7 @@ SweepData::~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 @@ -4632,7 +4632,7 @@ SweepInfo::write_summary (const std::list*> &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 TimeStepBase_Wave::TimeStepBase_Wave (): TimeStepBase_Tria (), parameters (*static_cast*>(0)) -{}; +{} template @@ -4711,7 +4711,7 @@ TimeStepBase_Wave::TimeStepBase_Wave (const double time, WaveParameters::dual_estimator), true)), parameters (parameters) -{}; +{} template @@ -4719,7 +4719,7 @@ const TimeStep_Primal & TimeStepBase_Wave::get_timestep_primal () const { return dynamic_cast &> (*this); -}; +} template @@ -4727,7 +4727,7 @@ const TimeStep_Dual & TimeStepBase_Wave::get_timestep_dual () const { return dynamic_cast &> (*this); -}; +} template @@ -4735,7 +4735,7 @@ const TimeStep_Postprocess & TimeStepBase_Wave::get_timestep_postprocess () const { return dynamic_cast &> (*this); -}; +} template @@ -4745,21 +4745,21 @@ std::string TimeStepBase_Wave::tmp_filename_base (const std::string &branch branch_signature + 's' + int_to_string (sweep_no, 2) + 't' + int_to_string (timestep_no, 4)); -}; +} template void TimeStepBase_Wave::attach_sweep_info (SweepInfo &si) { sweep_info = &si; -}; +} template void TimeStepBase_Wave::attach_sweep_data (SweepData &sd) { sweep_data = &sd; -}; +} /* --------------------------------------------------------------*/ @@ -4772,7 +4772,7 @@ TimeStep_Wave::TimeStep_Wave (const std::string fe_name) : quadrature (FEHelper::get_quadrature(fe_name)), quadrature_face (FEHelper::get_quadrature_face(fe_name)), statistic_data() -{}; +{} template @@ -4785,7 +4785,7 @@ TimeStep_Wave::~TimeStep_Wave () Assert (laplace_matrix.empty(), ExcInternalError()); Assert (u.size() ==0, ExcInternalError()); Assert (v.size() ==0, ExcInternalError()); -}; +} template @@ -4851,7 +4851,7 @@ constraints.clear (); Assert (false, ExcInternalError()); }; }; -}; +} template @@ -4898,7 +4898,7 @@ void TimeStep_Wave::sleep (const unsigned int sleep_level) default: Assert (false, ExcInternalError()); }; -}; +} template @@ -4906,7 +4906,7 @@ void TimeStep_Wave::end_sweep () { std::string tmp_filename = tmp_filename_base(branch_signature()); remove (tmp_filename.c_str()); -}; +} template @@ -4924,7 +4924,7 @@ unsigned int TimeStep_Wave::solve (const UserMatrix &matrix, constraints.distribute (solution); return control.last_step(); -}; +} template @@ -5012,7 +5012,7 @@ FEValues fe_values (fe, quadrature, cell_laplace_matrix(i,j)); }; }; -}; +} template @@ -5062,7 +5062,7 @@ void TimeStep_Wave::transfer_old_solutions (Vector &old_u, transfer_old_solutions (old_cell, new_cell, *old_grid_u, *old_grid_v, old_u, old_v); -}; +} template @@ -5092,7 +5092,7 @@ TimeStep_Wave::transfer_old_solutions (const typename DoFHandler::cell old_cell->get_interpolated_dof_values (old_grid_v, cell_data); new_cell->set_dof_values_by_interpolation (cell_data, old_v); }; -}; +} template @@ -5117,7 +5117,7 @@ TimeStep_Wave::compute_energy () { }; return energy; -}; +} template @@ -5128,7 +5128,7 @@ StatisticData () : n_solver_steps_helmholtz (0), n_solver_steps_projection (0), energy (std::make_pair(0.0, 0.0)) -{}; +{} template @@ -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 @@ -5157,7 +5157,7 @@ TimeStep_Wave::StatisticData::write_descriptions (std::ostream &out) << "# elastic energy" << std::endl << "# kinetic energy" << std::endl << "# total energy" << std::endl; -}; +} template @@ -5170,7 +5170,7 @@ void TimeStep_Wave::StatisticData::write (std::ostream &out) const << energy.first << ' ' << energy.second << ' ' << energy.first+energy.second; -}; +} template class TimeStepBase_Wave<2>; @@ -5198,7 +5198,7 @@ template TimeStep_Dual::TimeStep_Dual (const std::string &dual_fe) : TimeStep_Wave (dual_fe) -{}; +{} template @@ -5241,7 +5241,7 @@ void TimeStep_Dual::do_initial_step () { 0, 0, std::make_pair (0.0, 0.0)); deallog << "." << std::endl; -}; +} template @@ -5333,7 +5333,7 @@ void TimeStep_Dual::do_timestep () compute_energy ()); deallog << "." << std::endl; -}; +} template @@ -5345,14 +5345,14 @@ void TimeStep_Dual::solve_dual_problem () else do_timestep (); sweep_info->get_timers().dual_problem.stop(); -}; +} template std::string TimeStep_Dual::branch_signature () const { return "d"; -}; +} template @@ -5368,7 +5368,7 @@ void TimeStep_Dual::wake_up (const unsigned int wakeup_level) create_matrices (); }; sweep_info->get_timers().dual_problem.stop(); -}; +} template @@ -5389,7 +5389,7 @@ void TimeStep_Dual::assemble_vectors (Vector &right_hand_side1, right_hand_side2.add (timestep, dual1); constraints.condense (right_hand_side1); -}; +} template @@ -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 @@ -5549,7 +5549,7 @@ TimeStep_Dual::build_rhs (const typename DoFHandler::cell_iterator &ol }; Assert (false, ExcInternalError()); -}; +} template @@ -5642,7 +5642,7 @@ TimeStep_Dual::collect_from_children (const typename DoFHandler::cell_ }; return level_difference; -}; +} template @@ -5743,7 +5743,7 @@ TimeStep_Dual::distribute_to_children (const typename DoFHandler::cell }; return level_difference; -}; +} template class TimeStep_Dual<2>; @@ -5769,7 +5769,7 @@ template class TimeStep_Dual<2>; template TimeStep_ErrorEstimation::TimeStep_ErrorEstimation () -{}; +{} template @@ -5797,7 +5797,7 @@ void TimeStep_ErrorEstimation::estimate_error () sweep_info->get_data().accumulated_error += accumulated_error; sweep_info->get_timers().error_estimation.stop(); -}; +} template @@ -5812,7 +5812,7 @@ void TimeStep_ErrorEstimation::wake_up (const unsigned int wakeup_level) estimated_error_per_cell.reinit (tria->n_active_cells()); }; -}; +} template @@ -5831,7 +5831,7 @@ void TimeStep_ErrorEstimation::sleep (const unsigned int sleep_level) estimated_error_per_cell.reinit (0); }; -}; +} template @@ -5841,7 +5841,7 @@ TimeStep_ErrorEstimation::get_tria_refinement_criteria (Vector &indi get_error_indicators (indicators); for (Vector::iterator i=indicators.begin(); i!=indicators.end(); ++i) *i = fabs(*i); -}; +} template @@ -5850,7 +5850,7 @@ TimeStep_ErrorEstimation::get_error_indicators (Vector &indicators) { std::ifstream in (tmp_filename_base(branch_signature()).c_str()); indicators.block_read (in); -}; +} template @@ -5890,7 +5890,7 @@ void TimeStep_ErrorEstimation::estimate_error_energy (const unsigned int wh parameters.density); estimated_error_per_cell += v_estimator; }; -}; +} template @@ -5965,7 +5965,7 @@ void TimeStep_ErrorEstimation::estimate_error_dual () { *i = error_on_this_cell->sum(); total_estimated_error += *error_on_this_cell; }; -}; +} template @@ -6120,7 +6120,7 @@ compute_error_on_new_children (primal_cell, dual_cell, Assert (false, ExcInternalError()); -}; +} template @@ -6189,7 +6189,7 @@ for (unsigned int child=0; child::children_per_cell; ++child) ++cellwise_error.next_free_slot; }; }; -}; +} template @@ -6282,7 +6282,7 @@ error_sum += error_formula (old_dual_child, }; return error_sum; -}; +} template @@ -6317,7 +6317,7 @@ TimeStep_ErrorEstimation::error_formula (const typename DoFHandler::ac local_difference_u_bar_old, local_difference_v_bar_old, fe_values); -}; +} template @@ -6469,7 +6469,7 @@ std::vector stiffness(fe_values.n_quadrature_points); return error_on_cell; -}; +} #include @@ -6497,40 +6497,40 @@ void TimeStep_ErrorEstimation::make_interpolation_matrices () { for (unsigned int i=0; i TimeStep_ErrorEstimation::StatisticData::StatisticData () : estimated_error (0) -{}; +{} template TimeStep_ErrorEstimation::StatisticData::StatisticData (const double estimated_error) : estimated_error (estimated_error) -{}; +{} template void TimeStep_ErrorEstimation::StatisticData::write_descriptions (std::ostream &out) { out << "# total estimated error in this timestep" << std::endl; -}; +} template void TimeStep_ErrorEstimation::StatisticData::write (std::ostream &out) const { out << estimated_error*100000; -}; +} template TimeStep_ErrorEstimation::ErrorOnCell::ErrorOnCell () { for (unsigned int i=0; i @@ -6539,7 +6539,7 @@ TimeStep_ErrorEstimation::ErrorOnCell::operator += (const ErrorOnCell &eoc) for (unsigned int i=0; i @@ -6548,14 +6548,14 @@ double TimeStep_ErrorEstimation::ErrorOnCell::sum () const { for (unsigned int i=0; i TimeStep_ErrorEstimation::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::TimeStep (const double time, parameters), TimeStep_Primal(parameters.primal_fe), TimeStep_Dual (parameters.dual_fe) -{}; +{} template @@ -6613,7 +6613,7 @@ void TimeStep::wake_up (const unsigned int wakeup_level) default: Assert (false, ExcInternalError()); }; -}; +} template @@ -6652,7 +6652,7 @@ void TimeStep::sleep (const unsigned int sleep_level) sweep_info->get_timers().grid_generation.start(); TimeStepBase_Wave::sleep (sleep_level); sweep_info->get_timers().grid_generation.stop(); -}; +} template @@ -6661,7 +6661,7 @@ void TimeStep::end_sweep () TimeStep_Primal::end_sweep (); TimeStep_Dual::end_sweep (); TimeStep_Postprocess::end_sweep (); -}; +} template @@ -6684,7 +6684,7 @@ void TimeStep::write_statistics_descriptions (std::ostream out << "# Postprocessing:" << std::endl; TimeStep_Postprocess::StatisticData::write_descriptions (out, parameters); }; -}; +} template @@ -6697,7 +6697,7 @@ void TimeStep::write_statistics (std::ostream &out) const TimeStep_ErrorEstimation::statistic_data.write (out); out << " "; TimeStep_Postprocess::statistic_data.write (out); -}; +} template class TimeStep<2>; @@ -6857,28 +6857,28 @@ void TimeStep_Postprocess::postprocess_timestep () deallog << std::endl; sweep_info->get_timers().postprocessing.stop(); -}; +} template void TimeStep_Postprocess::wake_up (const unsigned int wakeup_level) { TimeStep_ErrorEstimation::wake_up (wakeup_level); -}; +} template void TimeStep_Postprocess::sleep (const unsigned int sleep_level) { TimeStep_ErrorEstimation::sleep (sleep_level); -}; +} template std::string TimeStep_Postprocess::branch_signature () const { return "o"; -}; +} template @@ -6886,7 +6886,7 @@ void TimeStep_Postprocess::end_sweep () { std::string tmp_filename = tmp_filename_base(branch_signature()); remove (tmp_filename.c_str()); -}; +} template @@ -6912,7 +6912,7 @@ void TimeStep_Postprocess::interpolate_dual_solution (Vector &inter interpolated_u_bar(primal_vertex_index) = target.u(dual_vertex_index); interpolated_v_bar(primal_vertex_index) = target.v(dual_vertex_index); }; -}; +} template @@ -6923,7 +6923,7 @@ write_descriptions (std::ostream &out, for (typename std::list*>::const_iterator i = parameters.eval_list.begin(); i != parameters.eval_list.end(); ++i) out << "# " << (*i)->description() << std::endl; -}; +} template @@ -6931,7 +6931,7 @@ void TimeStep_Postprocess::StatisticData::write (std::ostream &out) const { for (unsigned int i=0; i; @@ -6958,7 +6958,7 @@ template TimeStep_Primal::TimeStep_Primal (const std::string &primal_fe) : TimeStep_Wave (primal_fe) -{}; +{} template @@ -6994,7 +6994,7 @@ void TimeStep_Primal::do_initial_step () std::make_pair (0.0, 0.0)); deallog << "." << std::endl; -}; +} template @@ -7099,7 +7099,7 @@ if (parameters.extrapolate_old_solutions) compute_energy ()); deallog << "." << std::endl; -}; +} template @@ -7111,14 +7111,14 @@ void TimeStep_Primal::solve_primal_problem () else do_timestep (); sweep_info->get_timers().primal_problem.stop(); -}; +} template std::string TimeStep_Primal::branch_signature () const { return "p"; -}; +} template @@ -7134,7 +7134,7 @@ void TimeStep_Primal::wake_up (const unsigned int wakeup_level) create_matrices (); }; sweep_info->get_timers().primal_problem.stop(); -}; +} template @@ -7144,7 +7144,7 @@ void TimeStep_Primal::assemble_vectors (Vector &right_hand_side1, build_rhs (right_hand_side1, right_hand_side2); constraints.condense (right_hand_side1); -}; +} template @@ -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 @@ -7305,7 +7305,7 @@ rhs1 = local_M_u; }; Assert (false, ExcInternalError()); -}; +} template @@ -7401,7 +7401,7 @@ FullMatrix cell_matrix (dofs_per_cell, dofs_per_cell); }; return level_difference; -}; +} template @@ -7502,7 +7502,7 @@ TimeStep_Primal::distribute_to_children (const typename DoFHandler::ce }; return level_difference; -}; +} template class TimeStep_Primal<2>; @@ -7527,7 +7527,7 @@ void UserMatrix::precondition (Vector &dst, dst = src; return; }; -}; +} #include @@ -7535,11 +7535,11 @@ void UserMatrix::precondition (Vector &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 & FEHelper::get_fe (const std::string &name) { Assert (false, ExcInternalError()); return fe_linear; -}; +} template @@ -7600,14 +7600,14 @@ const Quadrature &FEHelper::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 @@ -7629,7 +7629,7 @@ const Quadrature &FEHelper::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 WaveProblem::WaveProblem () -{}; +{} template WaveProblem::~WaveProblem () -{}; +{} template void WaveProblem::declare_parameters (ParameterHandler &prm) { parameters.declare_parameters (prm); -}; +} template void WaveProblem::parse_parameters (ParameterHandler &prm) { parameters.parse_parameters (prm); -}; +} template void WaveProblem::create_new (const unsigned int) { parameters.delete_parameters (); -}; +} template @@ -7729,7 +7729,7 @@ void WaveProblem::run (ParameterHandler &prm) for (unsigned int sweep=0; sweep &triangulation) triangulation.execute_coarsening_and_refinement (); }; -}; +} template @@ -178,7 +178,7 @@ void test(const Triangulation &tria, // file2.setf(std::ios::showpoint | std::ios::left); // data_out.write_gnuplot(file2); // file2.close(); -}; +} diff --git a/tests/fe/fe_traits.cc b/tests/fe/fe_traits.cc index 36e8a3723c..deca1e696e 100644 --- a/tests/fe/fe_traits.cc +++ b/tests/fe/fe_traits.cc @@ -63,7 +63,7 @@ void check (const FiniteElement &fe) }; deallog << std::endl; }; -}; +} @@ -110,7 +110,7 @@ void check () << std::endl; check (FESystem (FESystem (FE_Q(p),2), 2)); }; -}; +} @@ -124,5 +124,5 @@ int main () check<1> (); check<2> (); check<3> (); -}; +} diff --git a/tests/fe/internals.cc b/tests/fe/internals.cc index cd9861325c..7da8b4146f 100644 --- a/tests/fe/internals.cc +++ b/tests/fe/internals.cc @@ -42,7 +42,7 @@ void print_formatted (const FullMatrix &A, }; deallog << std::endl; }; -}; +} template diff --git a/tests/fe/mapping.cc b/tests/fe/mapping.cc index 4e474a998c..2757606834 100644 --- a/tests/fe/mapping.cc +++ b/tests/fe/mapping.cc @@ -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&) -{}; +{} diff --git a/tests/fe/mapping_c1.cc b/tests/fe/mapping_c1.cc index 9b25c8d481..3bb53ef353 100644 --- a/tests/fe/mapping_c1.cc +++ b/tests/fe/mapping_c1.cc @@ -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()); }; }; -}; +} diff --git a/tests/fe/nedelec.cc b/tests/fe/nedelec.cc index ffedb0f0f1..7b787b01c1 100644 --- a/tests/fe/nedelec.cc +++ b/tests/fe/nedelec.cc @@ -26,14 +26,14 @@ 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 diff --git a/tests/fe/nedelec_2.cc b/tests/fe/nedelec_2.cc index 9e352d6a7d..dc12f97f56 100644 --- a/tests/fe/nedelec_2.cc +++ b/tests/fe/nedelec_2.cc @@ -81,7 +81,7 @@ plot (const Triangulation &tr) deallog << std::endl; } -}; +} @@ -101,7 +101,7 @@ check () tr.begin_active()->set_refine_flag (); tr.execute_coarsening_and_refinement (); plot (tr); -}; +} int diff --git a/tests/fe/nedelec_3.cc b/tests/fe/nedelec_3.cc index 44e909de25..19c0521629 100644 --- a/tests/fe/nedelec_3.cc +++ b/tests/fe/nedelec_3.cc @@ -95,7 +95,7 @@ check () deallog << std::endl; } -}; +} int diff --git a/tests/fe/non_primitive_1.cc b/tests/fe/non_primitive_1.cc index 2968c73ee9..c57806684d 100644 --- a/tests/fe/non_primitive_1.cc +++ b/tests/fe/non_primitive_1.cc @@ -106,7 +106,7 @@ create_stokes_matrix_1 (const DoFHandler &dof_handler, local_dof_indices[j], local_matrix(i,j)); }; -}; +} @@ -180,7 +180,7 @@ create_stokes_matrix_2 (const DoFHandler &dof_handler, local_dof_indices[j], local_matrix(i,j)); }; -}; +} @@ -258,7 +258,7 @@ create_stokes_matrix_3 (const DoFHandler &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> (); -}; +} diff --git a/tests/fe/non_primitive_2.cc b/tests/fe/non_primitive_2.cc index 93e9c0d249..ebdbcbd3eb 100644 --- a/tests/fe/non_primitive_2.cc +++ b/tests/fe/non_primitive_2.cc @@ -109,7 +109,7 @@ create_stokes_matrix_2 (const DoFHandler &dof_handler, local_dof_indices[j], local_matrix(i,j)); }; -}; +} @@ -187,7 +187,7 @@ create_stokes_matrix_3 (const DoFHandler &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> (); -}; +} diff --git a/tests/fe/shapes.cc b/tests/fe/shapes.cc index 337ee9c8ff..085a836331 100644 --- a/tests/fe/shapes.cc +++ b/tests/fe/shapes.cc @@ -364,7 +364,7 @@ void test_compute_functions (const Mapping &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 diff --git a/tests/fe/transfer.cc b/tests/fe/transfer.cc index 86f04759ca..252ade450c 100644 --- a/tests/fe/transfer.cc +++ b/tests/fe/transfer.cc @@ -45,7 +45,7 @@ print_matrix(std::ostream& of, Triangulation& tr, unsigned int level, const FiniteElement& finel, - const char* name) + const char* /*name*/) { MGDoFHandler dof(tr); dof.distribute_dofs(finel); diff --git a/tests/fe/up_and_down.cc b/tests/fe/up_and_down.cc index e3cc52ea27..3a0c50aea1 100644 --- a/tests/fe/up_and_down.cc +++ b/tests/fe/up_and_down.cc @@ -49,7 +49,7 @@ Point transform (const Point p) Assert (false, ExcNotImplemented()); return Point(); }; -}; +} template @@ -116,7 +116,7 @@ void check_element (const Triangulation &tr, << std::endl; Assert (relative_residual < threshold*x.l2_norm(), ExcInternalError()); -}; +} template @@ -130,7 +130,8 @@ void test () // difficult. then refine it twice Triangulation tr; GridGenerator::hyper_cube(tr, 0., 1.); - GridTools::transform (&transform, tr); + Point (*p) (Point) = &transform; + 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]); - }; -}; + } +} diff --git a/tests/lac/block_matrices.cc b/tests/lac/block_matrices.cc index 9c5c476847..5864e08388 100644 --- a/tests/lac/block_matrices.cc +++ b/tests/lac/block_matrices.cc @@ -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; -}; +} diff --git a/tests/lac/block_vector.cc b/tests/lac/block_vector.cc index f226757e31..67c3a72e86 100644 --- a/tests/lac/block_vector.cc +++ b/tests/lac/block_vector.cc @@ -187,5 +187,5 @@ int main () return 0; -}; +} diff --git a/tests/lac/block_vector_iterator.cc b/tests/lac/block_vector_iterator.cc index 32b524fd48..84330d497d 100644 --- a/tests/lac/block_vector_iterator.cc +++ b/tests/lac/block_vector_iterator.cc @@ -32,7 +32,7 @@ bool operator == (const BlockVector &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; -}; +} diff --git a/tests/lac/matrix_out.cc b/tests/lac/matrix_out.cc index 9e42e89b79..71a8499634 100644 --- a/tests/lac/matrix_out.cc +++ b/tests/lac/matrix_out.cc @@ -73,4 +73,4 @@ int main () MatrixOut::Options (false, 4)); matrix_out.write_gmv (logfile); }; -}; +} diff --git a/tests/lac/solver.cc b/tests/lac/solver.cc index 80e6297046..7d0bdec2ad 100644 --- a/tests/lac/solver.cc +++ b/tests/lac/solver.cc @@ -144,5 +144,5 @@ int main() std::cerr << e.what() << std::endl; } }; -}; +} diff --git a/tests/lac/sparse_ilu.cc b/tests/lac/sparse_ilu.cc index babc7929a4..c73fd28820 100644 --- a/tests/lac/sparse_ilu.cc +++ b/tests/lac/sparse_ilu.cc @@ -118,5 +118,5 @@ int main() }; }; -}; +} diff --git a/tests/lac/sparsity_pattern.cc b/tests/lac/sparsity_pattern.cc index 69c3c56f8e..85ae8e89d3 100644 --- a/tests/lac/sparsity_pattern.cc +++ b/tests/lac/sparsity_pattern.cc @@ -155,7 +155,7 @@ main () ++sp3_p, ++sp4_p) Assert (*sp3_p == *sp4_p, ExcInternalError()); }; -}; +} diff --git a/tests/lac/testmatrix.cc b/tests/lac/testmatrix.cc index dce736b538..c6ee0f897a 100644 --- a/tests/lac/testmatrix.cc +++ b/tests/lac/testmatrix.cc @@ -226,14 +226,14 @@ FDMatrix::gnuplot_print(std::ostream& s, const Vector& V) const -template void FDMatrix::five_point(SparseMatrix&) const; -template void FDMatrix::five_point(SparseMatrix&) const; -template void FDMatrix::five_point(SparseMatrixEZ&) const; -template void FDMatrix::five_point(SparseMatrix&) const; -template void FDMatrix::nine_point(SparseMatrix&) const; -template void FDMatrix::nine_point(SparseMatrix&) const; -template void FDMatrix::nine_point(SparseMatrixEZ&) const; -template void FDMatrix::nine_point(SparseMatrix&) const; +template void FDMatrix::five_point(SparseMatrix&, bool) const; +template void FDMatrix::five_point(SparseMatrix&, bool) const; +template void FDMatrix::five_point(SparseMatrixEZ&, bool) const; +template void FDMatrix::five_point(SparseMatrix&, bool) const; +template void FDMatrix::nine_point(SparseMatrix&, bool) const; +template void FDMatrix::nine_point(SparseMatrix&, bool) const; +template void FDMatrix::nine_point(SparseMatrixEZ&, bool) const; +template void FDMatrix::nine_point(SparseMatrix&, bool) const; template void FDMatrix::gnuplot_print(std::ostream& s, const Vector& V) const; template void FDMatrix::gnuplot_print(std::ostream& s, const Vector& V) const; template void FDMatrix::gnuplot_print(std::ostream& s, const Vector& V) const; diff --git a/tests/lac/vector-vector.cc b/tests/lac/vector-vector.cc index 6b7e6c4fd8..448d2b2b5f 100644 --- a/tests/lac/vector-vector.cc +++ b/tests/lac/vector-vector.cc @@ -36,7 +36,7 @@ void print (const Vector &v) for (unsigned int i=0; i &d1, Vector &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); -}; +} -- 2.39.5