From 9ed8e1ee5857227446d7b2e7dd4cb926b4249357 Mon Sep 17 00:00:00 2001 From: Wolfgang Bangerth Date: Tue, 22 May 2001 12:52:27 +0000 Subject: [PATCH] Make things more C++ conformant. git-svn-id: https://svn.dealii.org/trunk@4693 0785d39b-7218-0410-832d-ea1e28bc413d --- tests/deal.II/block_matrices.cc | 22 +- tests/deal.II/boundaries.cc | 4 +- tests/deal.II/constraints.cc | 18 +- tests/deal.II/data_out.cc | 2 +- tests/deal.II/derivative_approximation.cc | 4 +- tests/deal.II/derivatives.cc | 22 +- tests/deal.II/dof_renumbering.cc | 4 +- tests/deal.II/dof_test.cc | 4 +- tests/deal.II/error_estimator.cc | 4 +- tests/deal.II/fe_tables.cc | 20 +- tests/deal.II/filtered_matrix.cc | 10 +- tests/deal.II/gradients.cc | 4 +- tests/deal.II/grid_test.cc | 2 +- tests/deal.II/grid_transform.cc | 12 +- tests/deal.II/helmholtz1mg.th | 2 +- tests/deal.II/intergrid_constraints.cc | 2 +- tests/deal.II/intergrid_map.cc | 2 +- tests/deal.II/matrices.cc | 4 +- tests/deal.II/mg.cc | 2 +- tests/deal.II/mglocal.cc | 8 +- tests/deal.II/second_derivatives.cc | 4 +- tests/deal.II/support_point_map.cc | 4 +- tests/deal.II/wave-test-3.cc | 762 +++++++++++----------- 23 files changed, 461 insertions(+), 461 deletions(-) diff --git a/tests/deal.II/block_matrices.cc b/tests/deal.II/block_matrices.cc index 64fe0b4e31..6334b73511 100644 --- a/tests/deal.II/block_matrices.cc +++ b/tests/deal.II/block_matrices.cc @@ -223,7 +223,7 @@ void LaplaceProblem,BlockSparseMatrix,BlockSparsityP { const unsigned int n_dofs = dof_handler.n_dofs(); const unsigned int block_size_[2] = { n_dofs/3, n_dofs - n_dofs/3 }; - const vector block_size (&block_size_[0], + const std::vector block_size (&block_size_[0], &block_size_[2]); solution.reinit (block_size); @@ -236,7 +236,7 @@ void LaplaceProblem,BlockSparseMatrix,BlockSparsityP { const unsigned int n_dofs = dof_handler.n_dofs(); const unsigned int block_size_[3] = { n_dofs/5, n_dofs/7, n_dofs - n_dofs/5 - n_dofs/7 }; - const vector block_size (&block_size_[0], + const std::vector block_size (&block_size_[0], &block_size_[3]); solution.reinit (block_size); @@ -267,7 +267,7 @@ void LaplaceProblem::assemble_system () FullMatrix cell_matrix (dofs_per_cell, dofs_per_cell); ::Vector cell_rhs (dofs_per_cell); - vector local_dof_indices (dofs_per_cell); + std::vector local_dof_indices (dofs_per_cell); DoFHandler<2>::active_cell_iterator cell = dof_handler.begin_active(), endc = dof_handler.end(); @@ -304,7 +304,7 @@ void LaplaceProblem::assemble_system () }; - map boundary_values; + std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, ZeroFunction<2>(), @@ -351,7 +351,7 @@ void LaplaceProblem::run () int main () { - ofstream logfile("block_matrices.output"); + std::ofstream logfile("block_matrices.output"); logfile.precision(2); deallog.attach(logfile); @@ -359,7 +359,7 @@ int main () // vector of solution vectors - vector > solutions; + std::vector > solutions; if (true) { @@ -367,7 +367,7 @@ int main () laplace_problem (2); laplace_problem.run (); - solutions.push_back (vector()); + solutions.push_back (std::vector()); solutions.back().resize (laplace_problem.solution.size()); for (unsigned int i=0; i()); + solutions.push_back (std::vector()); solutions.back().resize (laplace_problem.solution.size()); for (unsigned int i=0; i()); + solutions.push_back (std::vector()); solutions.back().resize (laplace_problem.solution.size()); for (unsigned int i=0; i()); + solutions.push_back (std::vector()); solutions.back().resize (laplace_problem.solution.size()); for (unsigned int i=0; i &tria, int step) Point<3>(1,2,1), Point<3>(0,2,1) }; const int cell_vertices[2][8] = { { 0,1,2,3,4,5,6,7 }, { 4,5,6,7,8,9,10,11 } }; - vector > cells (2, CellData<3>()); + std::vector > cells (2, CellData<3>()); for (unsigned int cell=0; cell<2; ++cell) for (unsigned int j=0; j<8; ++j) cells[cell].vertices[j] = cell_vertices[cell][j]; cells[0].material_id = 0; cells[1].material_id = 0; - tria.create_triangulation (vector >(&vertices[0], &vertices[12]), + tria.create_triangulation (std::vector >(&vertices[0], &vertices[12]), cells, SubCellData()); // no boundary information @@ -98,14 +98,14 @@ void make_tria (Triangulation<3> &tria, int step) Point<3>(2,1,0), Point<3>(2,1,1) }; const int cell_vertices[2][8] = { { 0,1,2,3,4,5,6,7 }, { 1,8,9,2,5,10,11,6 } }; - vector > cells (2, CellData<3>()); + std::vector > cells (2, CellData<3>()); for (unsigned int cell=0; cell<2; ++cell) for (unsigned int j=0; j<8; ++j) cells[cell].vertices[j] = cell_vertices[cell][j]; cells[0].material_id = 0; cells[1].material_id = 0; - tria.create_triangulation (vector >(&vertices[0], &vertices[12]), + tria.create_triangulation (std::vector >(&vertices[0], &vertices[12]), cells, SubCellData()); // no boundary information @@ -139,14 +139,14 @@ void make_tria (Triangulation<3> &tria, int step) Point<3>(1,1,2), Point<3>(0,1,2) }; const int cell_vertices[2][8] = { { 0,1,2,3,4,5,6,7 }, { 3, 2, 8, 9 , 7, 6, 10, 11} }; - vector > cells (2, CellData<3>()); + std::vector > cells (2, CellData<3>()); for (unsigned int cell=0; cell<2; ++cell) for (unsigned int j=0; j<8; ++j) cells[cell].vertices[j] = cell_vertices[cell][j]; cells[0].material_id = 0; cells[1].material_id = 0; - tria.create_triangulation (vector >(&vertices[0], &vertices[12]), + tria.create_triangulation (std::vector >(&vertices[0], &vertices[12]), cells, SubCellData()); // no boundary information @@ -193,7 +193,7 @@ void make_tria (Triangulation<3> &tria, int step) { 1,8,9,2,5,10,11,6 }, { 4,5,6,7,12,13,14,15}, { 5,10,11,6,13,16,17,14} }; - vector > cells (4, CellData<3>()); + std::vector > cells (4, CellData<3>()); for (unsigned int cell=0; cell<4; ++cell) for (unsigned int j=0; j<8; ++j) cells[cell].vertices[j] = cell_vertices[cell][j]; @@ -202,7 +202,7 @@ void make_tria (Triangulation<3> &tria, int step) cells[2].material_id = 0; cells[3].material_id = 0; - tria.create_triangulation (vector >(&vertices[0], &vertices[18]), + tria.create_triangulation (std::vector >(&vertices[0], &vertices[18]), cells, SubCellData()); // no boundary information @@ -232,7 +232,7 @@ void make_tria (Triangulation<3> &tria, int step) int main () { - ofstream logfile("constraints.output"); + std::ofstream logfile("constraints.output"); logfile.precision (2); deallog.attach(logfile); deallog.depth_console(0); diff --git a/tests/deal.II/data_out.cc b/tests/deal.II/data_out.cc index af9e34411a..6bced2582a 100644 --- a/tests/deal.II/data_out.cc +++ b/tests/deal.II/data_out.cc @@ -45,7 +45,7 @@ #include -ofstream logfile("data_out.output"); +std::ofstream logfile("data_out.output"); template diff --git a/tests/deal.II/derivative_approximation.cc b/tests/deal.II/derivative_approximation.cc index dff8d4dd82..d879b2a1bf 100644 --- a/tests/deal.II/derivative_approximation.cc +++ b/tests/deal.II/derivative_approximation.cc @@ -75,9 +75,9 @@ check () int main () { - ofstream logfile ("derivative_approximation.output"); + std::ofstream logfile ("derivative_approximation.output"); logfile.precision (2); - logfile.setf(ios::fixed); + logfile.setf(std::ios::fixed); deallog.attach(logfile); deallog.depth_console (0); diff --git a/tests/deal.II/derivatives.cc b/tests/deal.II/derivatives.cc index 6adecfd3fb..e8ab47eedf 100644 --- a/tests/deal.II/derivatives.cc +++ b/tests/deal.II/derivatives.cc @@ -72,8 +72,8 @@ check (const unsigned int level, update_values | update_q_points | update_JxW_values); - vector global_dofs (element.dofs_per_cell); - vector function (quadrature.n_quadrature_points); + std::vector global_dofs (element.dofs_per_cell); + std::vector function (quadrature.n_quadrature_points); Vector u (dof.n_dofs ()); Vector f (dof.n_dofs ()); @@ -130,11 +130,11 @@ check (const unsigned int level, double h1 = 0.; double h2 = 0.; - vector u_local (quadrature.n_quadrature_points); - vector > Du (quadrature.n_quadrature_points); - vector > Df (quadrature.n_quadrature_points); - vector > DDu (quadrature.n_quadrature_points); - vector > DDf (quadrature.n_quadrature_points); + std::vector u_local (quadrature.n_quadrature_points); + std::vector > Du (quadrature.n_quadrature_points); + std::vector > Df (quadrature.n_quadrature_points); + std::vector > DDu (quadrature.n_quadrature_points); + std::vector > DDf (quadrature.n_quadrature_points); for (cell = dof.begin_active(); cell != end;++cell) { @@ -177,12 +177,12 @@ void loop () { QGauss gauss((dim<3) ? 5 : 3); - vector*> maps; + std::vector*> maps; // maps.push_back (new MappingCartesian); maps.push_back (new MappingQ1); maps.push_back (new MappingQ(2)); - vector*> elements; + std::vector*> elements; elements.push_back (new FE_Q (1)); elements.push_back (new FE_Q (2)); if (dim<3) @@ -210,9 +210,9 @@ void loop () int main () { - ofstream logfile ("derivatives.output"); + std::ofstream logfile ("derivatives.output"); logfile.precision (2); - logfile.setf(ios::fixed); + logfile.setf(std::ios::fixed); deallog.attach(logfile); if (!errors) deallog.depth_console(0); diff --git a/tests/deal.II/dof_renumbering.cc b/tests/deal.II/dof_renumbering.cc index 55895dc04e..69d90e1aaa 100644 --- a/tests/deal.II/dof_renumbering.cc +++ b/tests/deal.II/dof_renumbering.cc @@ -91,9 +91,9 @@ check () int main () { - ofstream logfile ("dof_renumbering.output"); + std::ofstream logfile ("dof_renumbering.output"); logfile.precision (2); - logfile.setf(ios::fixed); + logfile.setf(std::ios::fixed); deallog.attach(logfile); deallog.depth_console (0); diff --git a/tests/deal.II/dof_test.cc b/tests/deal.II/dof_test.cc index 8a953dc505..26a503fd1c 100644 --- a/tests/deal.II/dof_test.cc +++ b/tests/deal.II/dof_test.cc @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 1998, 1999, 2000 by the deal.II authors +// Copyright (C) 1998, 1999, 2000, 2001 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -35,7 +35,7 @@ // 2: refinement of the circle at the boundary // 2: refinement of a wiggled area at the boundary -ofstream logfile("dof_test.output"); +std::ofstream logfile("dof_test.output"); template diff --git a/tests/deal.II/error_estimator.cc b/tests/deal.II/error_estimator.cc index 67874c0b79..2f1c2711d3 100644 --- a/tests/deal.II/error_estimator.cc +++ b/tests/deal.II/error_estimator.cc @@ -112,9 +112,9 @@ check () int main () { - ofstream logfile ("error_estimator.output"); + std::ofstream logfile ("error_estimator.output"); logfile.precision (2); - logfile.setf(ios::fixed); + logfile.setf(std::ios::fixed); deallog.attach(logfile); deallog.depth_console (0); diff --git a/tests/deal.II/fe_tables.cc b/tests/deal.II/fe_tables.cc index c0f17f5af0..c05af66913 100644 --- a/tests/deal.II/fe_tables.cc +++ b/tests/deal.II/fe_tables.cc @@ -2,7 +2,7 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 1998, 1999, 2000 by the deal.II authors +// Copyright (C) 1998, 1999, 2000, 2001 by the deal.II authors // // This file is subject to QPL and may not be distributed // without copyright and license information. Please refer @@ -31,7 +31,7 @@ #include -ofstream logfile("fe_tables.output"); +std::ofstream logfile("fe_tables.output"); #define TEST_ELEMENT(e) { deallog.push(#e); e el;\ print_fe_statistics(el); deallog.pop(); deallog << std::endl; } @@ -55,13 +55,9 @@ print_fe_statistics(const FiniteElement& fe) DoFHandler::active_cell_iterator cell = dof.begin_active(); DoFHandler::active_face_iterator face = dof.begin_active_face(); - vector > unit_points(fe.dofs_per_cell); - vector > support_points(fe.dofs_per_cell); - vector > face_support_points(fe.dofs_per_face); - - fe.get_unit_support_points(unit_points); - fe.get_support_points(cell, support_points); - fe.get_face_support_points(face, face_support_points); + const std::vector > unit_points = fe.get_unit_support_points(); + const std::vector > support_points = fe.get_support_points(); + const std::vector > face_support_points = fe.get_face_support_points(); deallog << "dofs_per_cell" << " " << fe.dofs_per_cell; deallog << ": vertex" << " " << fe.dofs_per_vertex; @@ -72,7 +68,7 @@ print_fe_statistics(const FiniteElement& fe) deallog.push("components"); for (unsigned i=0;i p = fe.system_to_component_index(i); + std::pair p = fe.system_to_component_index(i); deallog << "Index " << i << " (" << p.first << "," << p.second << ") -> " << fe.component_to_system_index(p.first, p.second) @@ -81,7 +77,7 @@ print_fe_statistics(const FiniteElement& fe) } for (unsigned i=0;i p = fe.face_system_to_component_index(i); + std::pair p = fe.face_system_to_component_index(i); deallog << "FaceIndex " << i << " (" << p.first << "," << p.second << ") -> " << fe.face_component_to_system_index(p.first, p.second) @@ -109,7 +105,7 @@ int main() deallog.depth_console(0); logfile.precision(4); - logfile.setf(ios::fixed); + logfile.setf(std::ios::fixed); deallog.push("GeometryInfo"); diff --git a/tests/deal.II/filtered_matrix.cc b/tests/deal.II/filtered_matrix.cc index 7864d44025..08d47bf793 100644 --- a/tests/deal.II/filtered_matrix.cc +++ b/tests/deal.II/filtered_matrix.cc @@ -64,7 +64,7 @@ solve_filtered (std::map &bv, solver.solve (A1, u, f1, prec); - for (typename std::map::const_iterator i=bv.begin(); + for (std::map::const_iterator i=bv.begin(); i!=bv.end(); ++i) Assert (std::fabs(u(i->first) - i->second) < 1e-8, ExcInternalError()); @@ -118,8 +118,8 @@ check () update_values | update_gradients | update_q_points | update_JxW_values); - vector global_dofs (element.dofs_per_cell); - vector function (quadrature.n_quadrature_points); + std::vector global_dofs (element.dofs_per_cell); + std::vector function (quadrature.n_quadrature_points); Vector f (dof.n_dofs ()); @@ -196,9 +196,9 @@ check () int main () { - ofstream logfile ("filtered_matrix.output"); + std::ofstream logfile ("filtered_matrix.output"); logfile.precision (2); - logfile.setf(ios::fixed); + logfile.setf(std::ios::fixed); deallog.attach(logfile); deallog.depth_console(0); diff --git a/tests/deal.II/gradients.cc b/tests/deal.II/gradients.cc index 2af601e8b9..22e8b3c66c 100644 --- a/tests/deal.II/gradients.cc +++ b/tests/deal.II/gradients.cc @@ -30,7 +30,7 @@ int main () { - ofstream logfile("gradients.output"); + std::ofstream logfile("gradients.output"); // limit output a bit logfile.precision (3); deallog.attach(logfile); @@ -62,7 +62,7 @@ Vector val(4); val.clear (); val(vertex) = 1; - vector > grads(4); + std::vector > grads(4); fevalues.get_function_grads (val, grads); diff --git a/tests/deal.II/grid_test.cc b/tests/deal.II/grid_test.cc index 8252eaf2e5..b0fceeb12b 100644 --- a/tests/deal.II/grid_test.cc +++ b/tests/deal.II/grid_test.cc @@ -25,7 +25,7 @@ #include #include -ofstream logfile("grid_test.output"); +std::ofstream logfile("grid_test.output"); // 1: continuous refinement of the unit square always in the middle // 2: refinement of the circle at the boundary diff --git a/tests/deal.II/grid_transform.cc b/tests/deal.II/grid_transform.cc index aa4a396fe6..f6207cefaa 100644 --- a/tests/deal.II/grid_transform.cc +++ b/tests/deal.II/grid_transform.cc @@ -40,7 +40,7 @@ int main () GridOut grid_out; if (false) { - ofstream eps_stream1("grid_untransformed.output"); + std::ofstream eps_stream1("grid_untransformed.output"); grid_out.write_eps(tria, eps_stream1, &mapping); } @@ -73,7 +73,7 @@ int main () // leave the // point, where // they are. - new_points.insert(pair > ( + new_points.insert(std::pair > ( face->vertex_index(vertex_no), v)); } else if (fabs(sqrt(v.square())-inner_radius)<1e-15) @@ -87,7 +87,7 @@ int main () // the radius // of the // circle. - new_points.insert(pair > ( + new_points.insert(std::pair > ( face->vertex_index(vertex_no), n_radius/inner_radius*v+n_center)); face->set_boundary_indicator(1); } @@ -100,16 +100,16 @@ int main () // test output if (false) { - cout << "New points:" << endl; + std::cout << "New points:" << std::endl; std::map >::const_iterator map_iter; for (map_iter=new_points.begin(); map_iter!=new_points.end(); ++map_iter) - cout << "vertex " << map_iter->first << ": " << map_iter->second << endl; + std::cout << "vertex " << map_iter->first << ": " << map_iter->second << std::endl; } GridGenerator::laplace_transformation (tria, new_points); HyperBallBoundary inner_ball(n_center, n_radius); tria.set_boundary(1, inner_ball); - ofstream eps_stream2("grid_transform.output"); + std::ofstream eps_stream2("grid_transform.output"); grid_out.write_eps(tria, eps_stream2, &mapping); tria.clear(); diff --git a/tests/deal.II/helmholtz1mg.th b/tests/deal.II/helmholtz1mg.th index 4f56eaec1d..9e31b835b7 100644 --- a/tests/deal.II/helmholtz1mg.th +++ b/tests/deal.II/helmholtz1mg.th @@ -13,7 +13,7 @@ Helmholtz::build_mgmatrix(MGLevelObject& A, Vector elvec(fe_dofs); FullMatrix elmat(fe_dofs); - vector indices(fe_dofs); + std::vector indices(fe_dofs); //////////////////////////////////////////////////// // Loop for computing the element matrices diff --git a/tests/deal.II/intergrid_constraints.cc b/tests/deal.II/intergrid_constraints.cc index 79f29ca4f3..46057b6f21 100644 --- a/tests/deal.II/intergrid_constraints.cc +++ b/tests/deal.II/intergrid_constraints.cc @@ -25,7 +25,7 @@ -ofstream logfile("intergrid_constraints.output"); +std::ofstream logfile("intergrid_constraints.output"); template diff --git a/tests/deal.II/intergrid_map.cc b/tests/deal.II/intergrid_map.cc index bdb28afa9c..44765e4263 100644 --- a/tests/deal.II/intergrid_map.cc +++ b/tests/deal.II/intergrid_map.cc @@ -101,7 +101,7 @@ void check () int main () { - ofstream logfile("intergrid_map.output"); + std::ofstream logfile("intergrid_map.output"); logfile.precision(2); deallog.attach(logfile); diff --git a/tests/deal.II/matrices.cc b/tests/deal.II/matrices.cc index 4d53734821..0794de877b 100644 --- a/tests/deal.II/matrices.cc +++ b/tests/deal.II/matrices.cc @@ -201,9 +201,9 @@ check () int main () { - ofstream logfile ("matrices.output"); + std::ofstream logfile ("matrices.output"); logfile.precision (2); - logfile.setf(ios::fixed); + logfile.setf(std::ios::fixed); deallog.attach(logfile); deallog.depth_console (0); diff --git a/tests/deal.II/mg.cc b/tests/deal.II/mg.cc index 5b687d48dd..ec56a1ee52 100644 --- a/tests/deal.II/mg.cc +++ b/tests/deal.II/mg.cc @@ -71,7 +71,7 @@ int main() { try { - ofstream logfile("mg.output"); + std::ofstream logfile("mg.output"); deallog.attach(logfile); deallog.depth_console(0); diff --git a/tests/deal.II/mglocal.cc b/tests/deal.II/mglocal.cc index 45b8742aef..c8eaacb5fa 100644 --- a/tests/deal.II/mglocal.cc +++ b/tests/deal.II/mglocal.cc @@ -69,8 +69,8 @@ extern void write_gnuplot (const MGDoFHandler<2>& dofs, int main() { - ofstream logfile("mglocal.output"); - // logfile.setf(ios::fixed); + std::ofstream logfile("mglocal.output"); + // logfile.setf(std::ios::fixed); // logfile.precision (3); deallog.attach(logfile); // deallog.log_execution_time(true); @@ -126,7 +126,7 @@ int main() if (false) { - ofstream out_file("MGf"); + std::ofstream out_file("MGf"); DataOut<2> out; out.attach_dof_handler(dof); out.add_data_vector(f, "v"); @@ -186,7 +186,7 @@ Multigrid<2> multigrid(mgdof, hanging_nodes, mgstruct, mgA, transfer, tr.n_level sprintf(name, "MG-Q%d-%d", degree, step); - ofstream ofile(name); + std::ofstream ofile(name); out.attach_dof_handler(dof); out.add_data_vector(u,"u"); out.add_data_vector(f,"f"); diff --git a/tests/deal.II/second_derivatives.cc b/tests/deal.II/second_derivatives.cc index 060f90cf6e..53aae2dd5a 100644 --- a/tests/deal.II/second_derivatives.cc +++ b/tests/deal.II/second_derivatives.cc @@ -30,7 +30,7 @@ int main () { - ofstream logfile("second_derivatives.output"); + std::ofstream logfile("second_derivatives.output"); logfile.precision(2); deallog.attach(logfile); deallog.depth_console(0); @@ -78,7 +78,7 @@ Vector val(4); val.clear (); val(vertex) = 1; - vector > derivs(4); + std::vector > derivs(4); fevalues.get_function_2nd_derivatives (val, derivs); deallog << "Vertex " << vertex << ": " << std::endl; diff --git a/tests/deal.II/support_point_map.cc b/tests/deal.II/support_point_map.cc index e59039e2e3..0c131cf340 100644 --- a/tests/deal.II/support_point_map.cc +++ b/tests/deal.II/support_point_map.cc @@ -122,9 +122,9 @@ check () int main () { - ofstream logfile ("support_point_map.output"); + std::ofstream logfile ("support_point_map.output"); logfile.precision (2); - logfile.setf(ios::fixed); + logfile.setf(std::ios::fixed); deallog.attach(logfile); deallog.depth_console (0); diff --git a/tests/deal.II/wave-test-3.cc b/tests/deal.II/wave-test-3.cc index 55014528b7..6111e3b30d 100644 --- a/tests/deal.II/wave-test-3.cc +++ b/tests/deal.II/wave-test-3.cc @@ -2,10 +2,10 @@ // $Id$ // Version: $Name$ // -// Copyright (C) 1998, 1999, 2000, 2001 by Wolfgang Bangerth +// std::copyright (C) 1998, 1999, 2000, 2001 by Wolfgang Bangerth // // This file is subject to QPL and may not be distributed -// without copyright and license information. Please refer +// without std::copyright and license information. Please refer // to the file deal.II/doc/license.html for the text and // further information on this license. // @@ -17,6 +17,7 @@ #include #include #include +#include #include #include #include @@ -26,6 +27,7 @@ #include #include #include +#include #include #include @@ -33,7 +35,9 @@ #include #include -ofstream logfile("wave-test-3.output"); +using namespace std; + +std::ofstream logfile("wave-test-3.output"); class UserMatrix; class SweepInfo; @@ -57,7 +61,7 @@ class TimeStepBase_Wave : public TimeStepBase_Tria{ const TimeStep_Primal & get_timestep_primal () const; const TimeStep_Dual & get_timestep_dual () const; const TimeStep_Postprocess & get_timestep_postprocess () const; - string tmp_filename_base (const string &branch_signature) const; + std::string tmp_filename_base (const std::string &branch_signature) const; void attach_sweep_info (SweepInfo &sweep_info); void attach_sweep_data (SweepData &sweep_data); @@ -72,7 +76,7 @@ template class TimeStep_Wave : public virtual TimeStepBase_Wave { public: - TimeStep_Wave (const string fe_name); + TimeStep_Wave (const std::string fe_name); ~TimeStep_Wave(); virtual void wake_up (const unsigned int wakeup_level); virtual void sleep (const unsigned int sleep_level); @@ -80,7 +84,7 @@ class TimeStep_Wave : public virtual TimeStepBase_Wave unsigned int solve (const UserMatrix &matrix, Vector &solution, const Vector &rhs) const; - virtual string branch_signature () const = 0; + virtual std::string branch_signature () const = 0; DeclException0 (ExcIO); DeclException0 (ExcCoarsestGridsDiffer); @@ -93,14 +97,14 @@ protected: const unsigned int n_dofs, const unsigned int n_solver_steps_helmholtz, const unsigned int n_solver_steps_projection, - const pair energy); - static void write_descriptions (ostream &out); - void write (ostream &out) const; + const std::pair energy); + static void write_descriptions (std::ostream &out); + void write (std::ostream &out) const; unsigned int n_active_cells; unsigned int n_dofs; unsigned int n_solver_steps_helmholtz; unsigned int n_solver_steps_projection; - pair energy; + std::pair energy; }; DoFHandler *dof_handler; @@ -121,7 +125,7 @@ protected: const Vector &old_grid_v, Vector &old_u, Vector &old_v) const; - pair compute_energy (); + std::pair compute_energy (); template friend class DualFunctional; template friend class EvaluationBase; template friend class TimeStep_ErrorEstimation; @@ -133,11 +137,11 @@ template class TimeStep_Primal : public TimeStep_Wave { public: - TimeStep_Primal (const string &primal_fe); + TimeStep_Primal (const std::string &primal_fe); void do_initial_step (); void do_timestep (); virtual void solve_primal_problem (); - virtual string branch_signature () const; + virtual std::string branch_signature () const; virtual void wake_up (const unsigned int wakeup_level); virtual void end_sweep () { @@ -178,11 +182,11 @@ template class TimeStep_Dual : public TimeStep_Wave { public: - TimeStep_Dual (const string &dual_fe); + TimeStep_Dual (const std::string &dual_fe); void do_initial_step (); void do_timestep (); virtual void solve_dual_problem (); - virtual string branch_signature () const; + virtual std::string branch_signature () const; virtual void wake_up (const unsigned int wakeup_level); virtual void end_sweep () @@ -232,15 +236,15 @@ class TimeStep_ErrorEstimation : public virtual TimeStepBase_Wave virtual void sleep (const unsigned int sleep_level); virtual void get_tria_refinement_criteria (Vector &indicators) const; void get_error_indicators (Vector &indicators) const; - virtual string branch_signature () const = 0; + virtual std::string branch_signature () const = 0; protected: struct StatisticData { StatisticData (); StatisticData (const double estimated_error); - static void write_descriptions (ostream &out); - void write (ostream &out) const; + static void write_descriptions (std::ostream &out); + void write (std::ostream &out) const; double estimated_error; }; @@ -255,8 +259,8 @@ class TimeStep_ErrorEstimation : public virtual TimeStepBase_Wave struct CellwiseError { CellwiseError (const unsigned int n_errors); - vector errors; - typename vector::iterator next_free_slot; + std::vector errors; + typename ErrorOnCell* next_free_slot; }; Vector estimated_error_per_cell; @@ -329,15 +333,15 @@ class TimeStep_Postprocess : public TimeStep_ErrorEstimation virtual void wake_up (const unsigned int wakeup_level); virtual void sleep (const unsigned int sleep_level); virtual void end_sweep (); - string branch_signature () const; + std::string branch_signature () const; protected: struct StatisticData { - static void write_descriptions (ostream &out, + static void write_descriptions (std::ostream &out, const WaveParameters ¶meters); - void write (ostream &out) const; - vector evaluation_results; + void write (std::ostream &out) const; + std::vector evaluation_results; }; StatisticData statistic_data; @@ -361,9 +365,9 @@ class TimeStep : public TimeStep_Primal, public TimeStep_Dual, public virtual void wake_up (const unsigned int wakeup_level); virtual void sleep (const unsigned int sleep_level); virtual void end_sweep (); - static void write_statistics_descriptions (ostream &out, + static void write_statistics_descriptions (std::ostream &out, const WaveParameters ¶meters); - void write_statistics (ostream &out) const; + void write_statistics (std::ostream &out) const; }; template class TimeStep_Primal; @@ -545,7 +549,7 @@ class EvaluationBase { * * Default is: do nothing. */ - virtual void print_final_result (ostream &out); + virtual void print_final_result (std::ostream &out); /** * Return the final result as a number @@ -556,11 +560,11 @@ class EvaluationBase { virtual double get_final_result (); /** - * Return a brief string of description + * Return a brief std::string of description * which will go into the first line * of the "results" file. */ - virtual string description () const = 0; + virtual std::string description () const = 0; /** * Exception. @@ -636,7 +640,7 @@ class EvaluationBase { * Base of the filenames under which * we shall store our results. */ - string base_file_name; + std::string base_file_name; }; @@ -706,9 +710,9 @@ class EvaluateIntegratedValueAtOrigin : public EvaluationBase { integrated_value (0) {}; virtual double evaluate (); - virtual void print_final_result (ostream &out); + virtual void print_final_result (std::ostream &out); virtual double get_final_result (); - virtual string description () const; + virtual std::string description () const; /** * Reset the average value to zero. @@ -742,9 +746,9 @@ class EvaluateSeismicSignal : public EvaluationBase { virtual double evaluate (); - virtual void print_final_result (ostream &out); + virtual void print_final_result (std::ostream &out); virtual double get_final_result (); - virtual string description () const; + virtual std::string description () const; /** * Reset the value to zero. @@ -767,9 +771,9 @@ class EvaluateSplitSignal : public EvaluationBase { virtual double evaluate (); - virtual void print_final_result (ostream &out); + virtual void print_final_result (std::ostream &out); virtual double get_final_result (); - virtual string description () const; + virtual std::string description () const; /** * Reset the value to zero. @@ -789,9 +793,9 @@ class EvaluateOneBranch1d : public EvaluationBase { virtual double evaluate (); - virtual void print_final_result (ostream &out); + virtual void print_final_result (std::ostream &out); virtual double get_final_result (); - virtual string description () const; + virtual std::string description () const; /** * Reset the value to zero. @@ -811,9 +815,9 @@ class EvaluateSecondCrossing1d : public EvaluationBase { virtual double evaluate (); - virtual void print_final_result (ostream &out); + virtual void print_final_result (std::ostream &out); virtual double get_final_result (); - virtual string description () const; + virtual std::string description () const; /** * Reset the value to zero. @@ -834,9 +838,9 @@ class EvaluateHuyghensWave : public EvaluationBase { virtual double evaluate (); - virtual void print_final_result (ostream &out); + virtual void print_final_result (std::ostream &out); virtual double get_final_result (); - virtual string description () const; + virtual std::string description () const; /** * Reset the value to zero. @@ -909,8 +913,8 @@ Data & get_data (); template - void write_summary (const list*> & eval_list, - ostream &out) const; + void write_summary (const std::list*> & eval_list, + std::ostream &out) const; private: Data data; @@ -976,7 +980,7 @@ class UserMatrix : public SparseMatrix { -string int_to_string (const unsigned int i, const unsigned int digits); +std::string int_to_string (const unsigned int i, const unsigned int digits); template @@ -1019,21 +1023,21 @@ struct FEHelper { * element specified by the name * #name#. */ - static const FiniteElement & get_fe (const string &name); + static const FiniteElement & get_fe (const std::string &name); /** * Return the correct domain quadrature * formula for the finite element denoted * by the name #name#. */ - static const Quadrature & get_quadrature (const string &name); + static const Quadrature & get_quadrature (const std::string &name); /** * Return the correct boundary quadrature * formula for the finite element denoted * by the name #name#. */ - static const Quadrature & get_quadrature_face (const string &name); + static const Quadrature & get_quadrature_face (const std::string &name); }; @@ -1051,7 +1055,7 @@ template class EvaluationBase; * * \section{Description of the input parameters} * - * Note that this list may not be up-tp-date at present. + * Note that this std::list may not be up-tp-date at present. * * \subsection{Subsection #Grid#} * \begin{itemize} @@ -1081,7 +1085,7 @@ template class EvaluationBase; * @begin{itemize} * @item #Initial refinement#: States how often the grid named by the above * parameter shall be globally refined to form the coarse mesh. - * @item #Maximum refinement#: maximum refinement level a cell may attain. + * @item #Maximum refinement#: std::maximum refinement level a cell may attain. * Cells with such a refinement level are flagged as others are, but they * are not refined any more; it is therefore not necessary to lower the * fraction of cells to be refined in order to avoid the refinement of a @@ -1211,7 +1215,7 @@ class WaveParameters void delete_parameters (); /** - * Enum holding a list of possible coarse + * Enum holding a std::list of possible coarse * mesh choices. */ enum InitialMesh { @@ -1228,7 +1232,7 @@ class WaveParameters }; /** - * Enum holding a list of possible + * Enum holding a std::list of possible * boundary condition choices. */ enum BoundaryConditions { @@ -1321,13 +1325,13 @@ class WaveParameters /** * Level of initial refinement, i.e. the - * minimum level cells on all grids at + * std::minimum level cells on all grids at * all times need to have. */ unsigned int initial_refinement; /** - * Maximum refinement level a cell may + * std::maximum refinement level a cell may * have. This one defaults to zero, * meaning no limit. */ @@ -1348,7 +1352,7 @@ class WaveParameters * are to be refined (first) and * coarsened (second). */ - pair refinement_fraction; + std::pair refinement_fraction; /** * Fraction by which the number of cells @@ -1357,7 +1361,7 @@ class WaveParameters * (first: top deviation, second: bottom * deviation). */ - pair cell_number_corridor; + std::pair cell_number_corridor; /** * Number of iterations to be performed @@ -1414,19 +1418,19 @@ class WaveParameters * Directory to which we want the output * written. */ - string output_directory; + std::string output_directory; /** * Directory to which we want the temporary * file to be written. */ - string tmp_directory; + std::string tmp_directory; /** * Format in which the results on the * meshes is to be written to files. */ - string output_format; + std::string output_format; /** * Denotes in which sweeps the solution is @@ -1478,13 +1482,13 @@ class WaveParameters * How to break the intervals: linear * or logarithmic. */ - string error_statistics_scaling; + std::string error_statistics_scaling; /** * Names of the finite element classes to * be used for the primal and dual problems. */ - string primal_fe, dual_fe; + std::string primal_fe, dual_fe; /** * Strategy for mesh refinement. @@ -1523,11 +1527,11 @@ class WaveParameters unsigned int number_of_sweeps; /** - * List of operations which shall be + * std::list of operations which shall be * done on each time step after finishing * a sweep. */ - list*> eval_list; + std::list*> eval_list; /** * Symbolic name of the boundary conditions @@ -1542,89 +1546,89 @@ class WaveParameters * Exception. */ DeclException1 (ExcParameterNotInList, - string, + std::string, << "The given parameter <" << arg1 << "> is not " << "recognized to be a valid one."); private: /** - * Undefined copy constructor. + * Undefined std::copy constructor. */ WaveParameters (const WaveParameters &); /** - * Undefined copy operator. + * Undefined std::copy operator. */ WaveParameters & operator = (const WaveParameters &); /** - * List of names for the initial values. + * std::list of names for the initial values. * Make this a member of the templated * class since the supported initial * values could be different from * dimension to dimension. */ - static const string initial_value_names; + static const std::string initial_value_names; /** * Names of coefficient functions. The * same applies as for * #initial_value_names#. */ - static const string coefficient_names; + static const std::string coefficient_names; /** * Names of boundary value functions. The * same applies as for * #initial_value_names#. */ - static const string boundary_function_names; + static const std::string boundary_function_names; /** * Names of error functionals. The * same applies as for * #initial_value_names#. */ - static const string dual_functional_names; + static const std::string dual_functional_names; /** * Set the initial function pointers * depending on the given names. */ - void set_initial_functions (const string &u_name, - const string &v_name); + void set_initial_functions (const std::string &u_name, + const std::string &v_name); /** * Set the coefficient functions. */ - void set_coefficient_functions (const string &name); + void set_coefficient_functions (const std::string &name); /** * Set the boundary values. */ - void set_boundary_functions (const string &name); + void set_boundary_functions (const std::string &name); /** - * Make a list of evaluations to be + * Make a std::list of evaluations to be * performed after each sweep. */ - void make_eval_list (const string &names); + void make_eval_list (const std::string &names); /** * Set the dual functional after * which the dual solution will be * computed. */ - void set_dual_functional (const string &name); + void set_dual_functional (const std::string &name); /** * Create the coarse grid for * this run. */ - void make_coarse_grid (const string &name); + void make_coarse_grid (const std::string &name); }; @@ -1723,7 +1727,7 @@ class WaveProblem : public MultipleParameterLoop::UserClass { virtual void create_new (const unsigned int run_no); /** - * Make the list of parameters known + * Make the std::list of parameters known * to the parameter handler. This * function only delegates its work * to the #parameters# sub-object. @@ -1731,7 +1735,7 @@ class WaveProblem : public MultipleParameterLoop::UserClass { virtual void declare_parameters (ParameterHandler &prm); /** - * Parse the list of parameters given + * Parse the std::list of parameters given * by the parameter handler. This * function only delegates its work * to the #parameters# sub-object. @@ -1892,13 +1896,13 @@ void EndEnergy::compute_vectors (const PartOfDomain pod, FullMatrix cell_matrix (dofs_per_cell, dofs_per_cell); - vector > local_u_grad (n_q_points); - vector local_v (n_q_points); + std::vector > local_u_grad (n_q_points); + std::vector local_v (n_q_points); - vector density_values(quadrature->n_quadrature_points); - vector stiffness_values(quadrature->n_quadrature_points); + std::vector density_values(quadrature->n_quadrature_points); + std::vector stiffness_values(quadrature->n_quadrature_points); - vector cell_dof_indices (dofs_per_cell); + std::vector cell_dof_indices (dofs_per_cell); for (; cell!=endc; ++cell, ++primal_cell) { @@ -1925,12 +1929,12 @@ fe_values.reinit (cell); stiffness->value_list (fe_values.get_quadrature_points(), stiffness_values); - const vector > > &shape_grads = fe_values.get_shape_grads (); + const std::vector > > &shape_grads = fe_values.get_shape_grads (); const FullMatrix &shape_values = fe_values.get_shape_values (); - const vector &JxW_values (fe_values.get_JxW_values()); + const std::vector &JxW_values (fe_values.get_JxW_values()); - vector local_functional1 (dofs_per_cell, 0); - vector local_functional2 (dofs_per_cell, 0); + std::vector local_functional1 (dofs_per_cell, 0); + std::vector local_functional2 (dofs_per_cell, 0); for (unsigned int shape_func=0; shape_func::compute_functionals (Vector &j1, cell = dof->begin_active(); endc = dof->end(); - vector cell_dof_indices (dofs_per_cell); + std::vector cell_dof_indices (dofs_per_cell); FEFaceValues fe_face_values (*fe, *quadrature_face, UpdateFlags(update_values | @@ -2026,11 +2030,11 @@ void SeismicSignal::compute_functionals (Vector &j1, fe_face_values.reinit (cell, face_no); const FullMatrix &shape_values = fe_face_values. get_shape_values (); - const vector &JxW_values (fe_face_values. + const std::vector &JxW_values (fe_face_values. get_JxW_values()); - const vector > &q_points (fe_face_values.get_quadrature_points()); + const std::vector > &q_points (fe_face_values.get_quadrature_points()); - vector local_integral (dofs_per_cell, 0); + std::vector local_integral (dofs_per_cell, 0); for (unsigned int shape_func=0; shape_func::compute_functionals (Vector &j1, cell = dof->begin_active(); endc = dof->end(); - vector face_dof_indices (face_dofs); + std::vector face_dof_indices (face_dofs); for (; cell!=endc; ++cell) for (unsigned int face_no=0; face_no::faces_per_cell; @@ -2121,7 +2125,7 @@ void SplitSignal::compute_functionals (Vector &j1, cell = dof->begin_active(); endc = dof->end(); - vector dof_indices (fe->dofs_per_cell); + std::vector dof_indices (fe->dofs_per_cell); FEFaceValues fe_face_values (*fe, *quadrature_face, UpdateFlags(update_values | update_JxW_values)); for (; cell!=endc; ++cell) @@ -2143,7 +2147,7 @@ void SplitSignal::compute_functionals (Vector &j1, fe_face_values.reinit (cell, face_no); const FullMatrix &shape_values = fe_face_values.get_shape_values (); - const vector &JxW_values = fe_face_values.get_JxW_values(); + const std::vector &JxW_values = fe_face_values.get_JxW_values(); cell->get_dof_indices (dof_indices); for (unsigned int i=0; i::compute_endtime_vectors (Vector &final_u_bar, endc = dof->end (); FEValues fe_values (*fe, *quadrature, UpdateFlags(update_values | update_JxW_values)); - vector cell_dof_indices (dofs_per_cell); + std::vector cell_dof_indices (dofs_per_cell); for (; cell!=endc; ++cell) { @@ -2195,9 +2199,9 @@ void SplitLine<1>::compute_endtime_vectors (Vector &final_u_bar, fe_values.reinit (cell); const FullMatrix &shape_values = fe_values.get_shape_values (); - const vector &JxW_values (fe_values.get_JxW_values()); + const std::vector &JxW_values (fe_values.get_JxW_values()); - vector local_functional (dofs_per_cell, 0); + std::vector local_functional (dofs_per_cell, 0); for (unsigned int shape_func=0; shape_func::compute_functionals (Vector &j1, cell = dof->begin_active(); endc = dof->end(); - vector dof_indices (fe->dofs_per_cell); + std::vector dof_indices (fe->dofs_per_cell); FEValues fe_values (*fe, *quadrature, UpdateFlags(update_values | update_JxW_values)); for (; cell!=endc; ++cell) @@ -2240,7 +2244,7 @@ void OneBranch1d::compute_functionals (Vector &j1, { fe_values.reinit (cell); const FullMatrix &shape_values = fe_values.get_shape_values (); - const vector &JxW_values = fe_values.get_JxW_values(); + const std::vector &JxW_values = fe_values.get_JxW_values(); cell->get_dof_indices (dof_indices); for (unsigned int i=0; i::compute_functionals (Vector &j1, cell = dof->begin_active(); endc = dof->end(); - vector dof_indices (fe->dofs_per_cell); + std::vector dof_indices (fe->dofs_per_cell); FEValues fe_values (*fe, *quadrature, UpdateFlags(update_values | update_JxW_values)); for (; cell!=endc; ++cell) @@ -2284,7 +2288,7 @@ void SecondCrossing::compute_functionals (Vector &j1, { fe_values.reinit (cell); const FullMatrix &shape_values = fe_values.get_shape_values (); - const vector &JxW_values = fe_values.get_JxW_values(); + const std::vector &JxW_values = fe_values.get_JxW_values(); cell->get_dof_indices (dof_indices); for (unsigned int i=0; i::reset () {}; template -void EvaluationBase::print_final_result (ostream &) {}; +void EvaluationBase::print_final_result (std::ostream &) {}; template @@ -2457,8 +2461,8 @@ double EvaluateEnergyContent::compute_energy (const PartOfDomain pod) const Vector local_u (fe->dofs_per_cell); Vector local_v (fe->dofs_per_cell); - vector density_values(quadrature->n_quadrature_points); - vector stiffness_values(quadrature->n_quadrature_points); + std::vector density_values(quadrature->n_quadrature_points); + std::vector stiffness_values(quadrature->n_quadrature_points); double total_energy = 0; @@ -2479,8 +2483,8 @@ double EvaluateEnergyContent::compute_energy (const PartOfDomain pod) const fe_values.reinit (cell); const FullMatrix &values = fe_values.get_shape_values(); - const vector > >&gradients = fe_values.get_shape_grads (); - const vector &weights = fe_values.get_JxW_values (); + const std::vector > >&gradients = fe_values.get_shape_grads (); + const std::vector &weights = fe_values.get_JxW_values (); cell->get_dof_values (*u, local_u); cell->get_dof_values (*v, local_v); @@ -2519,9 +2523,9 @@ fe_values.reinit (cell); template -void EvaluateIntegratedValueAtOrigin::print_final_result (ostream &out) { +void EvaluateIntegratedValueAtOrigin::print_final_result (std::ostream &out) { out << " Integrated value of u at origin: " - << integrated_value << endl; + << integrated_value << std::endl; }; @@ -2532,7 +2536,7 @@ double EvaluateIntegratedValueAtOrigin::get_final_result () { template -string EvaluateIntegratedValueAtOrigin::description () const { +std::string EvaluateIntegratedValueAtOrigin::description () const { return "integrated value at origin"; }; @@ -2575,8 +2579,8 @@ double EvaluateIntegratedValueAtOrigin::evaluate () { template -void EvaluateSeismicSignal::print_final_result (ostream &out) { - out << " Integrated seismic signal: " << result << endl; +void EvaluateSeismicSignal::print_final_result (std::ostream &out) { + out << " Integrated seismic signal: " << result << std::endl; }; @@ -2587,7 +2591,7 @@ double EvaluateSeismicSignal::get_final_result () { template -string EvaluateSeismicSignal::description () const { +std::string EvaluateSeismicSignal::description () const { return "Integrated seismic signal at top"; }; @@ -2610,7 +2614,7 @@ template double EvaluateSeismicSignal::evaluate () { const unsigned int n_q_points = quadrature_face->n_quadrature_points; - ofstream out((base_file_name + ".seismic").c_str()); + std::ofstream out((base_file_name + ".seismic").c_str()); AssertThrow (out, typename EvaluationBase::ExcIO()); DoFHandler::active_cell_iterator cell = dof->begin_active(), @@ -2620,7 +2624,7 @@ double EvaluateSeismicSignal::evaluate () { UpdateFlags(update_values | update_JxW_values | update_q_points)); - vector face_u (fe->dofs_per_face); + std::vector face_u (fe->dofs_per_face); for (; cell!=endc; ++cell) for (unsigned int face=0; face::faces_per_cell; ++face) @@ -2628,8 +2632,8 @@ double EvaluateSeismicSignal::evaluate () { { face_values.reinit (cell, face); face_values.get_function_values (*u, face_u); - const vector &JxW_values (face_values.get_JxW_values()); - const vector > &q_points (face_values.get_quadrature_points()); + const std::vector &JxW_values (face_values.get_JxW_values()); + const std::vector > &q_points (face_values.get_quadrature_points()); double local_integral = 0; for (unsigned int point=0; point::evaluate () { << cell->face(face)->vertex(0)(0) << " " << (*u)(cell->face(face)->vertex_dof_index(0,0)) - << endl + << std::endl << time << ' ' << cell->face(face)->vertex(1)(0) << " " << (*u)(cell->face(face)->vertex_dof_index(1,0)) - << endl - << endl; + << std::endl + << std::endl; }; AssertThrow (out, typename EvaluationBase::ExcIO()); out.close (); @@ -2666,8 +2670,8 @@ double EvaluateSeismicSignal::evaluate () { template -void EvaluateSplitSignal::print_final_result (ostream &out) { - out << " Integrated split signal: " << result << endl; +void EvaluateSplitSignal::print_final_result (std::ostream &out) { + out << " Integrated split signal: " << result << std::endl; }; @@ -2678,7 +2682,7 @@ double EvaluateSplitSignal::get_final_result () { template -string EvaluateSplitSignal::description () const { +std::string EvaluateSplitSignal::description () const { return "Integrated split signal (exact: (2+pi)/(16-pi)=0.010229)"; }; @@ -2707,7 +2711,7 @@ double EvaluateSplitSignal::evaluate () { endc = dof->end(); double u_integrated=0; FEFaceValues face_values (*fe, *quadrature_face, UpdateFlags(update_values | update_JxW_values)); - vector face_u (fe->dofs_per_face); + std::vector face_u (fe->dofs_per_face); for (; cell!=endc; ++cell) for (unsigned int face_no=0; face_no::faces_per_cell; ++face_no) @@ -2727,7 +2731,7 @@ double EvaluateSplitSignal::evaluate () { face_values.reinit (cell, face_no); face_values.get_function_values (*u, face_u); - const vector &JxW_values (face_values.get_JxW_values()); + const std::vector &JxW_values (face_values.get_JxW_values()); double local_integral = 0; for (unsigned int point=0; point::evaluate () { template -void EvaluateOneBranch1d::print_final_result (ostream &out) { - out << " One branch integrated: " << result << endl; +void EvaluateOneBranch1d::print_final_result (std::ostream &out) { + out << " One branch integrated: " << result << std::endl; }; @@ -2759,7 +2763,7 @@ double EvaluateOneBranch1d::get_final_result () { template -string EvaluateOneBranch1d::description () const { +std::string EvaluateOneBranch1d::description () const { return "One branch integrated (exact: 0.055735)"; }; @@ -2790,7 +2794,7 @@ double EvaluateOneBranch1d<1>::evaluate () { endc = dof->end(); double u_integrated=0; FEValues<1> fe_values (*fe, *quadrature, UpdateFlags(update_values | update_JxW_values)); - vector cell_u (fe->dofs_per_cell); + std::vector cell_u (fe->dofs_per_cell); for (; cell!=endc; ++cell) if ((cell->center()(0) > -0.6) && @@ -2798,7 +2802,7 @@ double EvaluateOneBranch1d<1>::evaluate () { { fe_values.reinit (cell); fe_values.get_function_values (*u, cell_u); - const vector &JxW_values (fe_values.get_JxW_values()); + const std::vector &JxW_values (fe_values.get_JxW_values()); double local_integral = 0; for (unsigned int point=0; point::evaluate () { template -void EvaluateSecondCrossing1d::print_final_result (ostream &out) { - out << " Second crossing: " << result << endl; +void EvaluateSecondCrossing1d::print_final_result (std::ostream &out) { + out << " Second crossing: " << result << std::endl; }; @@ -2830,7 +2834,7 @@ double EvaluateSecondCrossing1d::get_final_result () { template -string EvaluateSecondCrossing1d::description () const { +std::string EvaluateSecondCrossing1d::description () const { return "Second crossing (exact: 0.011147)"; }; @@ -2862,7 +2866,7 @@ double EvaluateSecondCrossing1d<1>::evaluate () { double u_integrated=0; FEValues<1> fe_values (*fe, *quadrature, UpdateFlags(update_values | update_JxW_values | update_q_points)); - vector cell_u (fe->dofs_per_cell); + std::vector cell_u (fe->dofs_per_cell); for (; cell!=endc; ++cell) if ((cell->center()(0) > -0.03) && @@ -2870,8 +2874,8 @@ double EvaluateSecondCrossing1d<1>::evaluate () { { fe_values.reinit (cell); fe_values.get_function_values (*u, cell_u); - const vector &JxW_values (fe_values.get_JxW_values()); - const vector > &quadrature_points (fe_values.get_quadrature_points()); + const std::vector &JxW_values (fe_values.get_JxW_values()); + const std::vector > &quadrature_points (fe_values.get_quadrature_points()); double local_integral = 0; for (unsigned int point=0; point::evaluate () { template -void EvaluateHuyghensWave::print_final_result (ostream &out) { - out << " Hughens wave -- weighted time: " << weighted_value / integrated_value << endl; - out << " average : " << integrated_value << endl; +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; }; @@ -2904,7 +2908,7 @@ double EvaluateHuyghensWave::get_final_result () { template -string EvaluateHuyghensWave::description () const { +std::string EvaluateHuyghensWave::description () const { return "Huyghens wave"; }; @@ -3010,16 +3014,16 @@ void TimestepManager::run_sweep (const unsigned int sweep_no) }; -deallog << "Sweep " << setw(2) << sweep_no << ':' << endl - << "---------" << endl; + deallog << "Sweep " << std::setw(2) << sweep_no << ':' << std::endl + << "---------" << std::endl; - for (typename list*>::const_iterator i = parameters.eval_list.begin(); + for (typename std::list*>::const_iterator i = parameters.eval_list.begin(); i != parameters.eval_list.end(); ++i) (*i)->reset (); start_sweep (sweep_no); - for (vector::iterator timestep=timesteps.begin(); + for (std::vector::iterator timestep=timesteps.begin(); timestep!=timesteps.end(); ++timestep) { dynamic_cast*>(*timestep)->attach_sweep_info (sweep_info); @@ -3027,14 +3031,14 @@ deallog << "Sweep " << setw(2) << sweep_no << ':' << endl }; solve_primal_problem (); - deallog << endl; + deallog << std::endl; if ((parameters.refinement_strategy == WaveParameters::dual_estimator) && (sweep_no >= parameters.initial_energy_estimator_sweeps)) { solve_dual_problem (); - deallog << endl; + deallog << std::endl; }; postprocess (); @@ -3042,7 +3046,7 @@ deallog << "Sweep " << setw(2) << sweep_no << ':' << endl if (parameters.write_stacked_data) write_stacked_data (*sweep_data.data_out_stack); - deallog << endl; + deallog << std::endl; if (sweep_no != parameters.number_of_sweeps-1) refine_grids (); @@ -3051,19 +3055,19 @@ deallog << "Sweep " << setw(2) << sweep_no << ':' << endl end_sweep (); - deallog << endl << endl; + deallog << std::endl << std::endl; }; template void TimestepManager::refine_grids () { - deallog << " Collecting refinement data: " << endl; + deallog << " Collecting refinement data: " << std::endl; const unsigned int n_timesteps = timesteps.size(); - vector > indicators (n_timesteps); + std::vector > indicators (n_timesteps); for (unsigned int i=0; i*>(timesteps[i]) @@ -3079,7 +3083,7 @@ if (parameters.produce_error_statistics) { deallog << " Generating error statistics "; - vector time_values (timesteps.size()); + std::vector time_values (timesteps.size()); for (unsigned int i=0; iget_time(); @@ -3090,7 +3094,7 @@ if (parameters.produce_error_statistics) Histogram::parse_interval_spacing(parameters.error_statistics_scaling)); error_statistics.write_gnuplot (logfile); - deallog << endl; + deallog << std::endl; }; @@ -3101,7 +3105,7 @@ if (parameters.compare_indicators_globally) unsigned int next_index=0; for (unsigned int i=0; i partial_sums(all_indicators.size()); - sort (all_indicators.begin(), all_indicators.end(), greater()); - partial_sum (all_indicators.begin(), all_indicators.end(), + std::sort (all_indicators.begin(), all_indicators.end(), std::greater()); + std::partial_sum (all_indicators.begin(), all_indicators.end(), partial_sums.begin()); const Vector::const_iterator - p = upper_bound (partial_sums.begin(), partial_sums.end(), + p = std::upper_bound (partial_sums.begin(), partial_sums.end(), total_error*(1-parameters.refinement_fraction.second)), - q = lower_bound (partial_sums.begin(), partial_sums.end(), + q = std::lower_bound (partial_sums.begin(), partial_sums.end(), parameters.refinement_fraction.first*total_error); double bottom_threshold = all_indicators(p != partial_sums.end() ? @@ -3135,20 +3139,20 @@ if (parameters.compare_indicators_globally) deallog << " " << all_indicators.size() << " cells in total." - << endl; + << std::endl; deallog << " Thresholds are [" << bottom_threshold << "," << top_threshold << "]" << " out of [" << *min_element(all_indicators.begin(),all_indicators.end()) << ',' << *max_element(all_indicators.begin(),all_indicators.end()) << "]. " - << endl; + << std::endl; deallog << " Expecting " << (all_indicators.size() + (q-partial_sums.begin())*(GeometryInfo::children_per_cell-1) - (partial_sums.end() - p)/(GeometryInfo::children_per_cell-1)) << " cells in next sweep." - << endl; + << std::endl; deallog << " Now refining..."; do_loop (mem_fun (&TimeStepBase_Tria::init_for_refinement), bind2nd (mem_fun1 (&TimeStepBase_Wave::refine_grid), @@ -3156,12 +3160,12 @@ if (parameters.compare_indicators_globally) bottom_threshold)), TimeDependent::TimeSteppingData (0,1), TimeDependent::forward); - deallog << endl; + deallog << std::endl; } else { - deallog << " Refining each time step separately." << endl; + deallog << " Refining each time step separately." << std::endl; for (unsigned int timestep=0; timestep*>(timesteps[timestep])->init_for_refinement(); @@ -3183,14 +3187,14 @@ if (parameters.compare_indicators_globally) Vector partial_sums(criteria.size()); - sort (criteria.begin(), criteria.end(), greater()); - partial_sum (criteria.begin(), criteria.end(), + std::sort (criteria.begin(), criteria.end(), std::greater()); + std::partial_sum (criteria.begin(), criteria.end(), partial_sums.begin()); const Vector::const_iterator - p = upper_bound (partial_sums.begin(), partial_sums.end(), + p = std::upper_bound (partial_sums.begin(), partial_sums.end(), total_error*(1-parameters.refinement_fraction.second)), - q = lower_bound (partial_sums.begin(), partial_sums.end(), + q = std::lower_bound (partial_sums.begin(), partial_sums.end(), parameters.refinement_fraction.first*total_error); double bottom_threshold = criteria(p != partial_sums.end() ? @@ -3220,7 +3224,7 @@ if (parameters.compare_indicators_globally) deallog << " Got " << total_number_of_cells << " presently, expecting " - << total_expected_cells << " for next sweep." << endl; + << total_expected_cells << " for next sweep." << std::endl; }; }; @@ -3232,13 +3236,13 @@ void TimestepManager::write_statistics (const SweepInfo &sweep_info) const { deallog << " Writing statistics for whole sweep."; - deallog << "# Description of fields" << endl - << "# =====================" << endl - << "# General:" << endl - << "# time" << endl; + deallog << "# Description of fields" << std::endl + << "# =====================" << std::endl + << "# General:" << std::endl + << "# time" << std::endl; TimeStep::write_statistics_descriptions (logfile, parameters); - deallog << endl << endl; + deallog << std::endl << std::endl; for (unsigned int timestep=0; timestep::write_statistics (const SweepInfo &sweep_info) const dynamic_cast*> (static_cast*> (timesteps[timestep]))->write_statistics (logfile); - deallog << endl; + deallog << std::endl; }; AssertThrow (logfile, ExcIO()); - deallog << endl; + deallog << std::endl; }; @@ -3264,7 +3268,7 @@ void TimestepManager::write_statistics (const SweepInfo &sweep_info) const logfile); AssertThrow (logfile, ExcIO()); - deallog << endl; + deallog << std::endl; }; }; @@ -3284,7 +3288,7 @@ void TimestepManager::write_stacked_data (DataOutStack &data_out_stack eps_flags.turn_angle = 0; data_out_stack.set_flags (eps_flags); data_out_stack.write (logfile, output_format); - deallog << '.' << endl; + deallog << '.' << std::endl; }; @@ -3308,7 +3312,7 @@ template class TimestepManager<2>; template -const string WaveParameters::initial_value_names ("zero" +const std::string WaveParameters::initial_value_names ("zero" "|eigenmode" "|bump" "|small bump" @@ -3317,19 +3321,19 @@ const string WaveParameters::initial_value_names ("zero" "|plateau" "|earthquake"); template -const string WaveParameters::coefficient_names ("unit" +const std::string WaveParameters::coefficient_names ("unit" "|kink" "|gradient" "|preliminary earth model" "|distorted"); template -const string WaveParameters::boundary_function_names ("wave from left" +const std::string WaveParameters::boundary_function_names ("wave from left" "|fast wave from left" "|wave from left center" "|wave from left bottom" "|zero"); template -const string WaveParameters::dual_functional_names ("none" +const std::string WaveParameters::dual_functional_names ("none" "|integrated value at origin" "|seismic signature" "|split signal" @@ -3341,8 +3345,8 @@ const string WaveParameters::dual_functional_names ("none" DeclException1 (ExcUnknownName, - string, - << "Unknown description string " << arg1); + std::string, + << "Unknown description std::string " << arg1); template @@ -3442,8 +3446,8 @@ class Coefficients { return 1+8*(p(dim-1)>1./5. ? 1. : 0.); }; - virtual void value_list (const vector > &points, - vector &values, + virtual void value_list (const std::vector > &points, + std::vector &values, const unsigned int) const { Assert (values.size() == points.size(), ExcDimensionMismatch(values.size(), points.size())); @@ -3459,8 +3463,8 @@ class Coefficients { return tmp; }; - virtual void gradient_list (const vector > &points, - vector > &gradients, + virtual void gradient_list (const std::vector > &points, + std::vector > &gradients, const unsigned int) const { for (unsigned int i=0; i { return 1+8*p(1)*p(1); }; - virtual void value_list (const vector > &points, - vector &values, + virtual void value_list (const std::vector > &points, + std::vector &values, const unsigned int) const { Assert (values.size() == points.size(), ExcDimensionMismatch(values.size(), points.size())); @@ -3491,8 +3495,8 @@ class Gradient : public Function { return tmp; }; - virtual void gradient_list (const vector > &points, - vector > &gradients, + virtual void gradient_list (const std::vector > &points, + std::vector > &gradients, const unsigned int) const { for (unsigned int i=0; i { return 10+2.5*(2-r/6371)*(2-r/6371)+20*(r<2000 ? 1 : 0); }; - virtual void value_list (const vector > &points, - vector &values, + virtual void value_list (const std::vector > &points, + std::vector &values, const unsigned int) const { Assert (values.size() == points.size(), ExcDimensionMismatch(values.size(), points.size())); @@ -3525,8 +3529,8 @@ class PreliminaryEarthModel : public Function { return tmp; }; - virtual void gradient_list (const vector > &points, - vector > &gradients, + virtual void gradient_list (const std::vector > &points, + std::vector > &gradients, const unsigned int) const { for (unsigned int i=0; i { (sin(3*pi*(2*x+y)/sqrt(3)))>0 ? 1 : 0)); }; - virtual void value_list (const vector > &points, - vector &values, + virtual void value_list (const std::vector > &points, + std::vector &values, const unsigned int) const { Assert (values.size() == points.size(), ExcDimensionMismatch(values.size(), points.size())); @@ -3560,8 +3564,8 @@ class Distorted : public Function { return Tensor<1,dim>(); }; - virtual void gradient_list (const vector > &points, - vector > &gradients, + virtual void gradient_list (const std::vector > &points, + std::vector > &gradients, const unsigned int) const { for (unsigned int i=0; i::delete_parameters () delete coarse_grid; coarse_grid = 0; - for (typename list*>::iterator i=eval_list.begin(); + for (typename std::list*>::iterator i=eval_list.begin(); i!=eval_list.end(); ++i) delete *i; eval_list.erase (eval_list.begin(), eval_list.end()); @@ -3780,12 +3784,12 @@ void WaveParameters::delete_parameters () template -void WaveParameters::set_initial_functions (const string &u_name, - const string &v_name) { +void WaveParameters::set_initial_functions (const std::string &u_name, + const std::string &v_name) { Assert (initial_u==0, ExcInternalError()); Assert (initial_v==0, ExcInternalError()); - const string names[2] = {u_name, v_name}; + const std::string names[2] = {u_name, v_name}; Function *functions[2]; for (unsigned int i=0; i<2; ++i) @@ -3823,7 +3827,7 @@ void WaveParameters::set_initial_functions (const string &u_name, template -void WaveParameters::set_coefficient_functions (const string &name) { +void WaveParameters::set_coefficient_functions (const std::string &name) { Assert (density==0, ExcInternalError()); Assert (stiffness==0, ExcInternalError()); @@ -3865,7 +3869,7 @@ void WaveParameters::set_coefficient_functions (const string &name) { template -void WaveParameters::set_boundary_functions (const string &name) { +void WaveParameters::set_boundary_functions (const std::string &name) { Assert (boundary_values_u==0, ExcInternalError()); Assert (boundary_values_v==0, ExcInternalError()); @@ -3904,18 +3908,18 @@ void WaveParameters::set_boundary_functions (const string &name) { template -void WaveParameters::make_eval_list (const string &names) { +void WaveParameters::make_eval_list (const std::string &names) { Assert (eval_list.size()==0, ExcInternalError()); - string split_list = names; + std::string split_list = names; while (split_list.length()) { - string name; + std::string name; name = split_list; - if (name.find(",") != string::npos) + if (name.find(",") != std::string::npos) { - name.erase (name.find(","), string::npos); + name.erase (name.find(","), std::string::npos); split_list.erase (0, split_list.find(",")+1); } else @@ -3950,7 +3954,7 @@ void WaveParameters::make_eval_list (const string &names) { template -void WaveParameters::set_dual_functional (const string &name) { +void WaveParameters::set_dual_functional (const std::string &name) { Assert (dual_functional==0, ExcInternalError()); if (name == "none") dual_functional = new DualFunctional(); @@ -3986,7 +3990,7 @@ void WaveParameters::set_dual_functional (const string &name) { #if 2 == 1 template <> -void WaveParameters<1>::make_coarse_grid (const string &name) { +void WaveParameters<1>::make_coarse_grid (const std::string &name) { const unsigned int dim = 1; coarse_grid = new Triangulation(MeshSmoothing(smoothing_on_refinement | @@ -4001,7 +4005,7 @@ void WaveParameters<1>::make_coarse_grid (const string &name) { Point<1>(-1./3.), Point<1>(1./3.), Point<1>(1.) }; - vector > cells (3, CellData<1>()); + std::vector > cells (3, CellData<1>()); cells[0].vertices[0] = 0; cells[0].vertices[1] = 1; cells[0].material_id = 0; @@ -4014,7 +4018,7 @@ void WaveParameters<1>::make_coarse_grid (const string &name) { cells[2].vertices[1] = 3; cells[2].material_id = 0; - coarse_grid->create_triangulation (vector >(&vertices[0], + coarse_grid->create_triangulation (std::vector >(&vertices[0], &vertices[4]), cells, SubCellData()); @@ -4044,10 +4048,10 @@ void WaveParameters<1>::make_coarse_grid (const string &name) { #if 2 == 2 template <> -void WaveParameters<2>::make_coarse_grid (const string &name) { +void WaveParameters<2>::make_coarse_grid (const std::string &name) { const unsigned int dim=2; - map initial_mesh_list; + std::map initial_mesh_list; initial_mesh_list["split channel bottom"] = split_channel_bottom; initial_mesh_list["split channel left"] = split_channel_left; initial_mesh_list["split channel right"] = split_channel_right; @@ -4084,7 +4088,7 @@ void WaveParameters<2>::make_coarse_grid (const string &name) { {1, 4, 5, 2}, {4, 6, 7, 5}}; - vector > cells (3, CellData()); + std::vector > cells (3, CellData()); for (unsigned int i=0; i<3; ++i) { @@ -4125,7 +4129,7 @@ void WaveParameters<2>::make_coarse_grid (const string &name) { boundary_info.boundary_lines[0].vertices[1] = 3; }; - coarse_grid->create_triangulation (vector >(&vertices[0], + coarse_grid->create_triangulation (std::vector >(&vertices[0], &vertices[8]), cells, boundary_info); @@ -4247,7 +4251,7 @@ case square: {1, 7, 5, 3}, {6, 4, 5, 7}}; - vector > cells (4, CellData<2>()); + std::vector > cells (4, CellData<2>()); for (unsigned int i=0; i<4; ++i) { @@ -4256,7 +4260,7 @@ case square: cells[i].material_id = 0; }; - coarse_grid->create_triangulation (vector >(&vertices[0], + coarse_grid->create_triangulation (std::vector >(&vertices[0], &vertices[8]), cells, SubCellData()); @@ -4281,10 +4285,10 @@ case square: #if 2 == 3 template <> -void WaveParameters<3>::make_coarse_grid (const string &name) { +void WaveParameters<3>::make_coarse_grid (const std::string &name) { const unsigned int dim=3; - map initial_mesh_list; + std::map initial_mesh_list; initial_mesh_list["square"] = square; initial_mesh_list["earth"] = earth; initial_mesh_list["seismic square"] = seismic_square; @@ -4451,20 +4455,20 @@ prm.declare_entry ("Refinement criterion", "energy estimator", template void WaveParameters::parse_parameters (ParameterHandler &prm) { - map boundary_conditions_list; + std::map boundary_conditions_list; boundary_conditions_list["wave from left"] = wave_from_left; boundary_conditions_list["fast wave from left"] = fast_wave_from_left; boundary_conditions_list["wave from left center"] = wave_from_left_center; boundary_conditions_list["wave from left bottom"] = wave_from_left_bottom; boundary_conditions_list["zero"] = zero; - map preconditioning_list; + std::map preconditioning_list; preconditioning_list["jacobi"] = jacobi; preconditioning_list["sor"] = sor; preconditioning_list["ssor"] = ssor; preconditioning_list["none"] = no_preconditioning; - map write_strategy_list; + std::map write_strategy_list; write_strategy_list["never"] = never; write_strategy_list["all sweeps"] = all_sweeps; write_strategy_list["last sweep only"] = last_sweep_only; @@ -4616,25 +4620,25 @@ SweepInfo::get_timers () template void -SweepInfo::write_summary (const list*> &eval_list, - ostream &out) const +SweepInfo::write_summary (const std::list*> &eval_list, + std::ostream &out) const { - out << "Summary of this sweep:" << endl - << "======================" << endl - << endl; - - out << " Accumulated number of cells: " << data.cells << endl - << " Acc. number of primal dofs : " << data.primal_dofs << endl - << " Acc. number of dual dofs : " << data.dual_dofs << endl - << " Accumulated error : " << data.accumulated_error << endl; + out << "Summary of this sweep:" << std::endl + << "======================" << std::endl + << std::endl; + + out << " Accumulated number of cells: " << data.cells << std::endl + << " Acc. number of primal dofs : " << data.primal_dofs << std::endl + << " Acc. number of dual dofs : " << data.dual_dofs << std::endl + << " Accumulated error : " << data.accumulated_error << std::endl; if (eval_list.size() != 0) { - out << endl; - out << " Evaluations:" << endl - << " ------------" << endl; + out << std::endl; + out << " Evaluations:" << std::endl + << " ------------" << std::endl; - for (typename list*>::const_iterator i = eval_list.begin(); + for (typename std::list*>::const_iterator i = eval_list.begin(); i != eval_list.end(); ++i) (*i)->print_final_result (out); @@ -4648,7 +4652,7 @@ SweepInfo::write_summary (const list*> &eval_list, << time->tm_mday << ' ' << int_to_string (time->tm_hour, 2) << ":" << int_to_string (time->tm_min, 2) << ":" - << int_to_string (time->tm_sec, 2) << endl; + << int_to_string (time->tm_sec, 2) << std::endl; }; @@ -4661,8 +4665,8 @@ SweepInfo::Data::Data () : template -void SweepInfo::write_summary (const list*> &eval_list, - ostream &out) const; +void SweepInfo::write_summary (const std::list*> &eval_list, + std::ostream &out) const; @@ -4691,13 +4695,13 @@ void SweepInfo::write_summary (const list*> &eval_list, #include -static const pair relaxations[3] -= { make_pair(100,5), make_pair(300,3), make_pair(500,2) }; +static const std::pair relaxations[3] += { std::make_pair(100,5), std::make_pair(300,3), std::make_pair(500,2) }; static const TimeStepBase_Tria<2>::RefinementFlags::CorrectionRelaxations wave_correction_relaxations (1, - vector > (&relaxations[0], + std::vector > (&relaxations[0], &relaxations[3])); @@ -4756,7 +4760,7 @@ TimeStepBase_Wave::get_timestep_postprocess () const template -string TimeStepBase_Wave::tmp_filename_base (const string &branch_signature) const +std::string TimeStepBase_Wave::tmp_filename_base (const std::string &branch_signature) const { return (parameters.tmp_directory + branch_signature + 's' + @@ -4783,7 +4787,7 @@ void TimeStepBase_Wave::attach_sweep_data (SweepData &sd) template -TimeStep_Wave::TimeStep_Wave (const string fe_name) : +TimeStep_Wave::TimeStep_Wave (const std::string fe_name) : dof_handler (0), fe (FEHelper::get_fe(fe_name)), quadrature (FEHelper::get_quadrature(fe_name)), @@ -4854,7 +4858,7 @@ constraints.clear (); case postprocess: { sweep_info->get_timers().postprocessing.start(); - ifstream tmp_in(tmp_filename_base(branch_signature()).c_str()); + std::ifstream tmp_in(tmp_filename_base(branch_signature()).c_str()); u.block_read (tmp_in); v.block_read (tmp_in); tmp_in.close (); @@ -4886,7 +4890,7 @@ void TimeStep_Wave::sleep (const unsigned int sleep_level) Assert (u.size() != 0, ExcInternalError()); Assert (v.size() != 0, ExcInternalError()); - ofstream tmp_out(tmp_filename_base(branch_signature()).c_str()); + std::ofstream tmp_out(tmp_filename_base(branch_signature()).c_str()); u.block_write (tmp_out); v.block_write (tmp_out); tmp_out.close (); @@ -4921,7 +4925,7 @@ void TimeStep_Wave::sleep (const unsigned int sleep_level) template void TimeStep_Wave::end_sweep () { - string tmp_filename = tmp_filename_base(branch_signature()); + std::string tmp_filename = tmp_filename_base(branch_signature()); remove (tmp_filename.c_str()); }; @@ -4962,8 +4966,8 @@ void TimeStep_Wave::create_matrices () const bool density_constant = parameters.density_constant, stiffness_constant = parameters.stiffness_constant; - vector density_values (n_q_points, 1.); - vector stiffness_values (n_q_points, 1.); + std::vector density_values (n_q_points, 1.); + std::vector stiffness_values (n_q_points, 1.); if (density_constant) fill_n (density_values.begin(), n_q_points, @@ -4981,7 +4985,7 @@ FEValues fe_values (fe, quadrature, update_q_points : 0))); - vector dof_indices_on_cell (dofs_per_cell); + std::vector dof_indices_on_cell (dofs_per_cell); FullMatrix cell_mass_matrix (dofs_per_cell, dofs_per_cell); FullMatrix cell_laplace_matrix (dofs_per_cell, dofs_per_cell); @@ -4995,12 +4999,12 @@ for (typename DoFHandler::active_cell_iterator cell=dof_handler->begin_acti cell->get_dof_indices (dof_indices_on_cell); const FullMatrix &shape_values = fe_values.get_shape_values (); - const vector > > &shape_grads = fe_values.get_shape_grads (); - const vector &JxW_values = fe_values.get_JxW_values (); + const std::vector > > &shape_grads = fe_values.get_shape_grads (); + const std::vector &JxW_values = fe_values.get_JxW_values (); if (!density_constant || !stiffness_constant) { - const vector > &quadrature_points = fe_values.get_quadrature_points (); + const std::vector > &quadrature_points = fe_values.get_quadrature_points (); if (!density_constant) parameters.density->value_list (quadrature_points, density_values); @@ -5118,9 +5122,9 @@ TimeStep_Wave::transfer_old_solutions (const typename DoFHandler::cell template -pair +std::pair TimeStep_Wave::compute_energy () { - pair energy; + std::pair energy; switch (next_action) { @@ -5149,7 +5153,7 @@ StatisticData () : n_dofs (0), n_solver_steps_helmholtz (0), n_solver_steps_projection (0), - energy (make_pair(0.0, 0.0)) + energy (std::make_pair(0.0, 0.0)) {}; @@ -5159,7 +5163,7 @@ StatisticData (const unsigned int n_active_cells, const unsigned int n_dofs, const unsigned int n_solver_steps_helmholtz, const unsigned int n_solver_steps_projection, - const pair energy) : + const std::pair energy) : n_active_cells (n_active_cells), n_dofs (n_dofs), n_solver_steps_helmholtz (n_solver_steps_helmholtz), @@ -5170,20 +5174,20 @@ StatisticData (const unsigned int n_active_cells, template void -TimeStep_Wave::StatisticData::write_descriptions (ostream &out) +TimeStep_Wave::StatisticData::write_descriptions (std::ostream &out) { - out << "# number of active cells" << endl - << "# number of degrees of freedom" << endl - << "# iterations for the helmholtz equation" << endl - << "# iterations for the projection equation" << endl - << "# elastic energy" << endl - << "# kinetic energy" << endl - << "# total energy" << endl; + out << "# number of active cells" << std::endl + << "# number of degrees of freedom" << std::endl + << "# iterations for the helmholtz equation" << std::endl + << "# iterations for the projection equation" << std::endl + << "# elastic energy" << std::endl + << "# kinetic energy" << std::endl + << "# total energy" << std::endl; }; template -void TimeStep_Wave::StatisticData::write (ostream &out) const +void TimeStep_Wave::StatisticData::write (std::ostream &out) const { out << n_active_cells << ' ' << n_dofs << ' ' @@ -5217,7 +5221,7 @@ template class TimeStep_Wave<2>; template -TimeStep_Dual::TimeStep_Dual (const string &dual_fe) +TimeStep_Dual::TimeStep_Dual (const std::string &dual_fe) : TimeStep_Wave (dual_fe) {}; @@ -5261,8 +5265,8 @@ void TimeStep_Dual::do_initial_step () { statistic_data = typename TimeStep_Wave::StatisticData (tria->n_active_cells(), dof_handler->n_dofs(), 0, 0, - make_pair (0.0, 0.0)); - deallog << "." << endl; + std::make_pair (0.0, 0.0)); + deallog << "." << std::endl; }; @@ -5310,7 +5314,7 @@ void TimeStep_Dual::do_timestep () }; - map boundary_value_list; + std::map boundary_value_list; if (dim != 1) { static const ZeroFunction boundary_values; @@ -5354,7 +5358,7 @@ void TimeStep_Dual::do_timestep () solver_steps2, compute_energy ()); - deallog << "." << endl; + deallog << "." << std::endl; }; @@ -5371,7 +5375,7 @@ void TimeStep_Dual::solve_dual_problem () template -string TimeStep_Dual::branch_signature () const +std::string TimeStep_Dual::branch_signature () const { return "d"; }; @@ -5475,12 +5479,12 @@ TimeStep_Dual::build_rhs (const DoFHandler::cell_iterator &old_cell, { fe_values.reinit (old_cell); const FullMatrix &values = fe_values.get_shape_values (); - const vector > >&gradients = fe_values.get_shape_grads (); - const vector &weights = fe_values.get_JxW_values (); + const std::vector > >&gradients = fe_values.get_shape_grads (); + const std::vector &weights = fe_values.get_JxW_values (); FullMatrix cell_matrix (dofs_per_cell, dofs_per_cell); - vector density_values(fe_values.n_quadrature_points); + std::vector density_values(fe_values.n_quadrature_points); parameters.density->value_list (fe_values.get_quadrature_points(), density_values); for (unsigned int point=0; point::build_rhs (const DoFHandler::cell_iterator &old_cell, cell_matrix.vmult (local_M_u, tmp); cell_matrix.clear (); - vector stiffness_values(fe_values.n_quadrature_points); + std::vector stiffness_values(fe_values.n_quadrature_points); parameters.stiffness->value_list (fe_values.get_quadrature_points(), stiffness_values); for (unsigned int point=0; point::build_rhs (const DoFHandler::cell_iterator &old_cell, time_step, local_A_v); - vector new_dof_indices (dofs_per_cell, DoFHandler::invalid_dof_index); + std::vector new_dof_indices (dofs_per_cell, DoFHandler::invalid_dof_index); new_cell->get_dof_indices (new_dof_indices); for (unsigned int i=0; i::build_rhs (const DoFHandler::cell_iterator &old_cell, collect_from_children (old_cell, fe_values, rhs1, rhs2); - vector new_dof_indices (dofs_per_cell); + std::vector new_dof_indices (dofs_per_cell); new_cell->get_dof_indices (new_dof_indices); for (unsigned int i=0; i::collect_from_children (const DoFHandler::cell_iterator { const unsigned int l = collect_from_children (old_child, fe_values, child_rhs1, child_rhs2); - level_difference = max (l+1, level_difference); + level_difference = std::max (l+1, level_difference); } else { fe_values.reinit (old_child); const FullMatrix &values = fe_values.get_shape_values(); - const vector > >&gradients = fe_values.get_shape_grads (); - const vector &weights = fe_values.get_JxW_values (); + const std::vector > >&gradients = fe_values.get_shape_grads (); + const std::vector &weights = fe_values.get_JxW_values (); old_child->get_dof_values (previous_time_level.u, local_old_dof_values_u); old_child->get_dof_values (previous_time_level.v, local_old_dof_values_v); cell_matrix.clear (); - vector density_values(fe_values.n_quadrature_points); + std::vector density_values(fe_values.n_quadrature_points); parameters.density->value_list (fe_values.get_quadrature_points(), density_values); for (unsigned int point=0; point::collect_from_children (const DoFHandler::cell_iterator cell_matrix.vmult (local_M_v, local_old_dof_values_v); cell_matrix.clear (); - vector stiffness_values(fe_values.n_quadrature_points); + std::vector stiffness_values(fe_values.n_quadrature_points); parameters.stiffness->value_list (fe_values.get_quadrature_points(), stiffness_values); for (unsigned int point=0; point::distribute_to_children (const DoFHandler::cell_iterator Vector rhs2 (dofs_per_cell); - vector new_dof_indices (dofs_per_cell, DoFHandler::invalid_dof_index); + std::vector new_dof_indices (dofs_per_cell, DoFHandler::invalid_dof_index); for (unsigned int c=0; c::children_per_cell; ++c) @@ -5718,17 +5722,17 @@ TimeStep_Dual::distribute_to_children (const DoFHandler::cell_iterator local_old_dof_values_v, right_hand_side1, right_hand_side2); - level_difference = max (l+1, level_difference); + level_difference = std::max (l+1, level_difference); } else { fe_values.reinit (new_child); const FullMatrix &values = fe_values.get_shape_values(); - const vector > >&gradients = fe_values.get_shape_grads (); - const vector &weights = fe_values.get_JxW_values (); + const std::vector > >&gradients = fe_values.get_shape_grads (); + const std::vector &weights = fe_values.get_JxW_values (); cell_matrix.clear (); - vector density_values(fe_values.n_quadrature_points); + std::vector density_values(fe_values.n_quadrature_points); parameters.density->value_list (fe_values.get_quadrature_points(), density_values); for (unsigned int point=0; point::distribute_to_children (const DoFHandler::cell_iterator cell_matrix.vmult (local_M_v, local_old_dof_values_v); cell_matrix.clear (); - vector stiffness_values(fe_values.n_quadrature_points); + std::vector stiffness_values(fe_values.n_quadrature_points); parameters.stiffness->value_list (fe_values.get_quadrature_points(), stiffness_values); for (unsigned int point=0; point::estimate_error () estimate_error_dual (); }; - const double accumulated_error = accumulate (estimated_error_per_cell.begin(), - estimated_error_per_cell.end(), - 0.0); + const double accumulated_error = std::accumulate (estimated_error_per_cell.begin(), + estimated_error_per_cell.end(), + 0.0); statistic_data = StatisticData (accumulated_error); sweep_info->get_data().accumulated_error += accumulated_error; @@ -5858,7 +5862,7 @@ void TimeStep_ErrorEstimation::sleep (const unsigned int sleep_level) Assert (estimated_error_per_cell.size()!=0, ExcInternalError()); - ofstream tmp_out(tmp_filename_base(branch_signature()).c_str()); + std::ofstream tmp_out(tmp_filename_base(branch_signature()).c_str()); estimated_error_per_cell.block_write (tmp_out); tmp_out.close (); @@ -5881,7 +5885,7 @@ template void TimeStep_ErrorEstimation::get_error_indicators (Vector &indicators) const { - ifstream in (tmp_filename_base(branch_signature()).c_str()); + std::ifstream in (tmp_filename_base(branch_signature()).c_str()); indicators.block_read (in); }; @@ -5905,7 +5909,7 @@ void TimeStep_ErrorEstimation::estimate_error_energy (const unsigned int wh target.u : target.v), estimated_error_per_cell, - vector(), + std::vector(), parameters.stiffness); if (((previous_timestep == 0) && (which_variables==0)) || @@ -5919,7 +5923,7 @@ void TimeStep_ErrorEstimation::estimate_error_energy (const unsigned int wh target.v : target.u), v_estimator, - vector(), + std::vector(), parameters.density); estimated_error_per_cell += v_estimator; }; @@ -5975,7 +5979,7 @@ void TimeStep_ErrorEstimation::estimate_error_dual () { cellwise_error, fe_values); - Assert (cellwise_error.next_free_slot == cellwise_error.errors.end(), + Assert (cellwise_error.next_free_slot == &*cellwise_error.errors.end(), ::ExcInternalError()); }; @@ -5989,8 +5993,8 @@ void TimeStep_ErrorEstimation::estimate_error_dual () { endc = primal_problem.dof_handler->end(); for (; cell!=endc; ++cell, ++i) { - const typename vector::iterator - error_on_this_cell = static_cast::iterator>(cell->user_pointer()); + const ErrorOnCell * + error_on_this_cell = static_cast(cell->user_pointer()); Assert (error_on_this_cell != 0, ::ExcInternalError()); cell->clear_user_pointer (); @@ -6378,10 +6382,10 @@ TimeStep_ErrorEstimation::error_formula (const DoFHandler::active_cell Vector tmp2(dofs_per_cell); -vector stiffness(fe_values.n_quadrature_points); +std::vector stiffness(fe_values.n_quadrature_points); parameters.stiffness->value_list (fe_values.get_quadrature_points(), stiffness); - vector > grad_stiffness(fe_values.n_quadrature_points); + std::vector > grad_stiffness(fe_values.n_quadrature_points); parameters.stiffness->gradient_list (fe_values.get_quadrature_points(), grad_stiffness); @@ -6390,12 +6394,12 @@ vector stiffness(fe_values.n_quadrature_points); fe_values.reinit (cell); const FullMatrix &values = fe_values.get_shape_values(); - const vector > >&gradients = fe_values.get_shape_grads (); - const vector > >&second_derivatives + const std::vector > >&gradients = fe_values.get_shape_grads (); + const std::vector > >&second_derivatives = fe_values.get_shape_2nd_derivatives (); - const vector &weights = fe_values.get_JxW_values (); + const std::vector &weights = fe_values.get_JxW_values (); - vector density_values(fe_values.n_quadrature_points); + std::vector density_values(fe_values.n_quadrature_points); parameters.density->value_list (fe_values.get_quadrature_points(), density_values); for (unsigned int point=0; point::StatisticData::StatisticData (const double estima template -void TimeStep_ErrorEstimation::StatisticData::write_descriptions (ostream &out) +void TimeStep_ErrorEstimation::StatisticData::write_descriptions (std::ostream &out) { - out << "# total estimated error in this timestep" << endl; + out << "# total estimated error in this timestep" << std::endl; }; template -void TimeStep_ErrorEstimation::StatisticData::write (ostream &out) const +void TimeStep_ErrorEstimation::StatisticData::write (std::ostream &out) const { out << estimated_error*100000; }; @@ -6593,7 +6597,7 @@ double TimeStep_ErrorEstimation::ErrorOnCell::sum () const { template TimeStep_ErrorEstimation::CellwiseError::CellwiseError (const unsigned int n_errors) : errors (n_errors), - next_free_slot (errors.begin()) + next_free_slot (&*errors.begin()) {}; @@ -6704,30 +6708,30 @@ void TimeStep::end_sweep () template -void TimeStep::write_statistics_descriptions (ostream &out, +void TimeStep::write_statistics_descriptions (std::ostream &out, const WaveParameters ¶meters) { - out << "# Primal problem:" << endl; + out << "# Primal problem:" << std::endl; typename TimeStep_Primal::StatisticData xp; xp.write_descriptions (out); - out << "# Dual problem:" << endl; + out << "# Dual problem:" << std::endl; typename TimeStep_Dual::StatisticData xd; xd.write_descriptions (out); - out << "# Error estimation:" << endl; + out << "# Error estimation:" << std::endl; TimeStep_ErrorEstimation::StatisticData::write_descriptions (out); if (parameters.eval_list.size() != 0) { - out << "# Postprocessing:" << endl; + out << "# Postprocessing:" << std::endl; TimeStep_Postprocess::StatisticData::write_descriptions (out, parameters); }; }; template -void TimeStep::write_statistics (ostream &out) const +void TimeStep::write_statistics (std::ostream &out) const { TimeStep_Primal::statistic_data.write (out); out << " "; @@ -6772,7 +6776,7 @@ void TimeStep_Postprocess::postprocess_timestep () sweep_info->get_timers().postprocessing.start(); statistic_data.evaluation_results.clear(); - for (typename list*>::const_iterator i = parameters.eval_list.begin(); + for (typename std::list*>::const_iterator i = parameters.eval_list.begin(); i != parameters.eval_list.end(); ++i) { (*i)->reset_timelevel (get_timestep_primal()); @@ -6792,7 +6796,7 @@ void TimeStep_Postprocess::postprocess_timestep () typename DataOut::OutputFormat output_format = DataOut::parse_output_format (parameters.output_format); - string data_filename = (parameters.output_directory + + std::string data_filename = (parameters.output_directory + "sweep" + int_to_string(sweep_no,2) + "/" + int_to_string(timestep_no,4) + out.default_suffix (output_format)); @@ -6828,9 +6832,9 @@ void TimeStep_Postprocess::postprocess_timestep () if (parameters.write_error_as_cell_data) { estimated_error.reinit (estimated_error_per_cell.size()); - copy_n (estimated_error_per_cell.begin(), - estimated_error_per_cell.size(), - estimated_error.begin()); + std::copy (estimated_error_per_cell.begin(), + estimated_error_per_cell.end(), + estimated_error.begin()); } else { @@ -6894,7 +6898,7 @@ void TimeStep_Postprocess::postprocess_timestep () }; -deallog << endl; +deallog << std::endl; sweep_info->get_timers().postprocessing.stop(); }; @@ -6914,7 +6918,7 @@ void TimeStep_Postprocess::sleep (const unsigned int sleep_level) template -string TimeStep_Postprocess::branch_signature () const +std::string TimeStep_Postprocess::branch_signature () const { return "o"; }; @@ -6923,7 +6927,7 @@ string TimeStep_Postprocess::branch_signature () const template void TimeStep_Postprocess::end_sweep () { - string tmp_filename = tmp_filename_base(branch_signature()); + std::string tmp_filename = tmp_filename_base(branch_signature()); remove (tmp_filename.c_str()); }; @@ -6956,17 +6960,17 @@ void TimeStep_Postprocess::interpolate_dual_solution (Vector &inter template void TimeStep_Postprocess::StatisticData:: -write_descriptions (ostream &out, +write_descriptions (std::ostream &out, const WaveParameters ¶meters) { - for (typename list*>::const_iterator i = parameters.eval_list.begin(); + for (typename std::list*>::const_iterator i = parameters.eval_list.begin(); i != parameters.eval_list.end(); ++i) - out << "# " << (*i)->description() << endl; + out << "# " << (*i)->description() << std::endl; }; template -void TimeStep_Postprocess::StatisticData::write (ostream &out) const +void TimeStep_Postprocess::StatisticData::write (std::ostream &out) const { for (unsigned int i=0; i; template -TimeStep_Primal::TimeStep_Primal (const string &primal_fe) +TimeStep_Primal::TimeStep_Primal (const std::string &primal_fe) : TimeStep_Wave (primal_fe) {}; @@ -7030,9 +7034,9 @@ void TimeStep_Primal::do_initial_step () dof_handler->n_dofs(), 0, 0, - make_pair (0.0, 0.0)); + std::make_pair (0.0, 0.0)); - deallog << "." << endl; + deallog << "." << std::endl; }; @@ -7087,7 +7091,7 @@ assemble_vectors (right_hand_side1, right_hand_side2); parameters.boundary_values_u->set_time (time); parameters.boundary_values_v->set_time (time); - map boundary_value_list; + std::map boundary_value_list; VectorTools::interpolate_boundary_values (*dof_handler, 0, *(parameters.boundary_values_u), boundary_value_list); @@ -7111,7 +7115,7 @@ assemble_vectors (right_hand_side1, right_hand_side2); if (dim != 1) { - map boundary_value_list; + std::map boundary_value_list; VectorTools::interpolate_boundary_values (*dof_handler, 0, *(parameters.boundary_values_v), boundary_value_list); @@ -7137,7 +7141,7 @@ if (parameters.extrapolate_old_solutions) solver_steps2, compute_energy ()); - deallog << "." << endl; + deallog << "." << std::endl; }; @@ -7154,7 +7158,7 @@ void TimeStep_Primal::solve_primal_problem () template -string TimeStep_Primal::branch_signature () const +std::string TimeStep_Primal::branch_signature () const { return "p"; }; @@ -7249,10 +7253,10 @@ TimeStep_Primal::build_rhs (const DoFHandler::cell_iterator &old_cell, FullMatrix cell_matrix (dofs_per_cell, dofs_per_cell); const FullMatrix &values = fe_values.get_shape_values (); - const vector > >&gradients = fe_values.get_shape_grads (); - const vector &weights = fe_values.get_JxW_values (); + const std::vector > >&gradients = fe_values.get_shape_grads (); + const std::vector &weights = fe_values.get_JxW_values (); - vector density_values(fe_values.n_quadrature_points); + std::vector density_values(fe_values.n_quadrature_points); parameters.density->value_list (fe_values.get_quadrature_points(), density_values); for (unsigned int point=0; point::build_rhs (const DoFHandler::cell_iterator &old_cell, cell_matrix.vmult (local_M_v, tmp); cell_matrix.clear (); - vector stiffness_values(fe_values.n_quadrature_points); + std::vector stiffness_values(fe_values.n_quadrature_points); parameters.stiffness->value_list (fe_values.get_quadrature_points(), stiffness_values); for (unsigned int point=0; point new_dof_indices (dofs_per_cell, DoFHandler::invalid_dof_index); + std::vector new_dof_indices (dofs_per_cell, DoFHandler::invalid_dof_index); new_cell->get_dof_indices (new_dof_indices); for (unsigned int i=0; i new_dof_indices (dofs_per_cell); + std::vector new_dof_indices (dofs_per_cell); new_cell->get_dof_indices (new_dof_indices); for (unsigned int i=0; i cell_matrix (dofs_per_cell, dofs_per_cell); { const unsigned int l = collect_from_children (old_child, fe_values, child_rhs1, child_rhs2); - level_difference = max (l+1, level_difference); + level_difference = std::max (l+1, level_difference); } else { fe_values.reinit (old_child); const FullMatrix &values = fe_values.get_shape_values (); - const vector > >&gradients = fe_values.get_shape_grads (); - const vector &weights = fe_values.get_JxW_values (); + const std::vector > >&gradients = fe_values.get_shape_grads (); + const std::vector &weights = fe_values.get_JxW_values (); old_child->get_dof_values (previous_time_level.u, local_old_dof_values_u); old_child->get_dof_values (previous_time_level.v, local_old_dof_values_v); cell_matrix.clear (); - vector density_values(fe_values.n_quadrature_points); + std::vector density_values(fe_values.n_quadrature_points); parameters.density->value_list (fe_values.get_quadrature_points(), density_values); for (unsigned int point=0; point cell_matrix (dofs_per_cell, dofs_per_cell); cell_matrix.clear (); - vector stiffness_values(fe_values.n_quadrature_points); + std::vector stiffness_values(fe_values.n_quadrature_points); parameters.stiffness->value_list (fe_values.get_quadrature_points(), stiffness_values); for (unsigned int point=0; point::distribute_to_children (const DoFHandler::cell_iterat Vector rhs2 (dofs_per_cell); - vector new_dof_indices (dofs_per_cell, DoFHandler::invalid_dof_index); + std::vector new_dof_indices (dofs_per_cell, DoFHandler::invalid_dof_index); for (unsigned int c=0; c::children_per_cell; ++c) @@ -7494,17 +7498,17 @@ TimeStep_Primal::distribute_to_children (const DoFHandler::cell_iterat local_old_dof_values_v, right_hand_side1, right_hand_side2); - level_difference = max (l+1, level_difference); + level_difference = std::max (l+1, level_difference); } else { fe_values.reinit (new_child); const FullMatrix &values = fe_values.get_shape_values (); - const vector > >&gradients = fe_values.get_shape_grads (); - const vector &weights = fe_values.get_JxW_values (); + const std::vector > >&gradients = fe_values.get_shape_grads (); + const std::vector &weights = fe_values.get_JxW_values (); cell_matrix.clear (); - vector density_values(fe_values.n_quadrature_points); + std::vector density_values(fe_values.n_quadrature_points); parameters.density->value_list (fe_values.get_quadrature_points(), density_values); for (unsigned int point=0; point::distribute_to_children (const DoFHandler::cell_iterat cell_matrix.vmult (local_M_v, local_old_dof_values_v); cell_matrix.clear (); - vector stiffness_values(fe_values.n_quadrature_points); + std::vector stiffness_values(fe_values.n_quadrature_points); parameters.stiffness->value_list (fe_values.get_quadrature_points(), stiffness_values); for (unsigned int point=0; point FEHelper<2>::q_gauss_7_face; template -const FiniteElement & FEHelper::get_fe (const string &name) { +const FiniteElement & FEHelper::get_fe (const std::string &name) { if (name=="linear") return fe_linear; else @@ -7635,7 +7639,7 @@ const FiniteElement & FEHelper::get_fe (const string &name) { template -const Quadrature &FEHelper::get_quadrature (const string &name) { +const Quadrature &FEHelper::get_quadrature (const std::string &name) { if (name=="linear") return q_gauss_2; else @@ -7657,14 +7661,14 @@ const Quadrature &FEHelper::get_quadrature (const string &name) { template <> -const Quadrature<0> &FEHelper<1>::get_quadrature_face (const string &) { +const Quadrature<0> &FEHelper<1>::get_quadrature_face (const std::string &) { static const Quadrature<0> dummy_quadrature(1); return dummy_quadrature; }; template -const Quadrature &FEHelper::get_quadrature_face (const string &name) { +const Quadrature &FEHelper::get_quadrature_face (const std::string &name) { if (name=="linear") return q_gauss_2_face; else @@ -7685,8 +7689,8 @@ const Quadrature &FEHelper::get_quadrature_face (const string &name) }; -string int_to_string (const unsigned int i, const unsigned int digits) { - string s; +std::string int_to_string (const unsigned int i, const unsigned int digits) { + std::string s; switch (digits) { case 4: @@ -7788,7 +7792,7 @@ void WaveProblem::run (ParameterHandler &prm) int main () { deallog.attach(logfile); - logfile.setf(ios::fixed); + logfile.setf(std::ios::fixed); logfile.precision (2); deallog.depth_console(0); @@ -7801,15 +7805,15 @@ int main () { input_data.read_input ("wave-test-3.prm"); } - catch (exception &e) + catch (std::exception &e) { - cerr << endl << endl + std::cerr << std::endl << std::endl << "----------------------------------------------------" - << endl; - cerr << "Exception on input: " << e.what() << endl - << "Aborting!" << endl + << std::endl; + std::cerr << "Exception on input: " << e.what() << std::endl + << "Aborting!" << std::endl << "----------------------------------------------------" - << endl; + << std::endl; return 1; }; @@ -7817,26 +7821,26 @@ int main () { input_data.loop (waves); } - catch (exception &e) + catch (std::exception &e) { - cerr << endl << endl + std::cerr << std::endl << std::endl << "----------------------------------------------------" - << endl; - cerr << "Exception on processing: " << e.what() << endl - << "Aborting!" << endl + << std::endl; + std::cerr << "Exception on processing: " << e.what() << std::endl + << "Aborting!" << std::endl << "----------------------------------------------------" - << endl; + << std::endl; return 2; } catch (...) { - cerr << endl << endl + std::cerr << std::endl << std::endl << "----------------------------------------------------" - << endl; - cerr << "Unknown exception!" << endl - << "Aborting!" << endl + << std::endl; + std::cerr << "Unknown exception!" << std::endl + << "Aborting!" << std::endl << "----------------------------------------------------" - << endl; + << std::endl; return 3; }; -- 2.39.5