From 8905cc28ac5efa54033b08dcaab2f9a1c8694e00 Mon Sep 17 00:00:00 2001 From: Wolfgang Bangerth Date: Fri, 10 Apr 2009 23:59:59 +0000 Subject: [PATCH] Don't implicitly use elements of namespace std, since we don't do that either anywhere else in deal.II. git-svn-id: https://svn.dealii.org/trunk@18582 0785d39b-7218-0410-832d-ea1e28bc413d --- deal.II/examples/step-34/step-34.cc | 30 ++++++++++++++--------------- 1 file changed, 15 insertions(+), 15 deletions(-) diff --git a/deal.II/examples/step-34/step-34.cc b/deal.II/examples/step-34/step-34.cc index eeacc226d2..d1491ce28b 100644 --- a/deal.II/examples/step-34/step-34.cc +++ b/deal.II/examples/step-34/step-34.cc @@ -55,7 +55,7 @@ #include #include -using namespace std; + using namespace dealii; @@ -553,7 +553,7 @@ void BEMProblem::assemble_system() { // centered at one of the vertices. Here we define a vector of // four such quadratures that will be used later on, only in the // three dimensional case. - vector > sing_quadratures_3d; + std::vector > sing_quadratures_3d; for(unsigned int i=0; i<4; ++i) { sing_quadratures_3d.push_back (QGaussOneOverR<2>(singular_quadrature_order, i, true)); @@ -567,9 +567,9 @@ void BEMProblem::assemble_system() { const unsigned int n_q_points = fe_v.n_quadrature_points; - vector dofs(fe.dofs_per_cell); + std::vector dofs(fe.dofs_per_cell); - vector > cell_wind(n_q_points, Vector(dim) ); + std::vector > cell_wind(n_q_points, Vector(dim) ); double normal_wind; // Unlike in finite element methods, if we use a collocation @@ -608,8 +608,8 @@ void BEMProblem::assemble_system() { fe_v.reinit(cell); cell->get_dof_indices(dofs); - const vector > &q_points = fe_v.get_quadrature_points(); - const vector > &normals = fe_v.get_cell_normal_vectors(); + const std::vector > &q_points = fe_v.get_quadrature_points(); + const std::vector > &normals = fe_v.get_cell_normal_vectors(); wind.vector_value_list(q_points, cell_wind); @@ -721,11 +721,11 @@ void BEMProblem::assemble_system() { fe_v_singular.reinit(cell); - static vector > singular_cell_wind( (*singular_quadrature).size(), + static std::vector > singular_cell_wind( (*singular_quadrature).size(), Vector(dim) ); - const vector > &singular_normals = fe_v_singular.get_cell_normal_vectors(); - const vector > &singular_q_points = fe_v_singular.get_quadrature_points(); + const std::vector > &singular_normals = fe_v_singular.get_cell_normal_vectors(); + const std::vector > &singular_q_points = fe_v_singular.get_quadrature_points(); wind.vector_value_list(singular_q_points, singular_cell_wind); @@ -853,11 +853,11 @@ void BEMProblem::interpolate() { const unsigned int n_q_points = fe_v.n_quadrature_points; - vector dofs(fe.dofs_per_cell); + std::vector dofs(fe.dofs_per_cell); - vector local_phi(n_q_points); - vector normal_wind(n_q_points); - vector > local_wind(n_q_points, Vector(dim) ); + std::vector local_phi(n_q_points); + std::vector normal_wind(n_q_points); + std::vector > local_wind(n_q_points, Vector(dim) ); LaplaceKernel kernel; Point R; @@ -874,8 +874,8 @@ void BEMProblem::interpolate() { for(cell = dh.begin_active(); cell != endc; ++cell) { fe_v.reinit(cell); - const vector > &q_points = fe_v.get_quadrature_points(); - const vector > &normals = fe_v.get_cell_normal_vectors(); + const std::vector > &q_points = fe_v.get_quadrature_points(); + const std::vector > &normals = fe_v.get_cell_normal_vectors(); cell->get_dof_indices(dofs); fe_v.get_function_values(phi, local_phi); -- 2.39.5