From: turcksin Date: Tue, 19 Mar 2013 23:35:21 +0000 (+0000) Subject: Convert unsigned int to types::global_dof_index in the tests. X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=02c9987f6543552682aac5911cbcdb13dd730bc8;p=dealii-svn.git Convert unsigned int to types::global_dof_index in the tests. git-svn-id: https://svn.dealii.org/branches/branch_bigger_global_dof_indices_4@28946 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/include/deal.II/lac/eigen.h b/deal.II/include/deal.II/lac/eigen.h index 1534bcaa92..d0ccf1f91e 100644 --- a/deal.II/include/deal.II/lac/eigen.h +++ b/deal.II/include/deal.II/lac/eigen.h @@ -144,6 +144,11 @@ template > class EigenInverse : private Solver { public: + /** + * Declare type of container size. + */ + typedef types::global_dof_index size_type; + /** * Standardized data struct to * pipe additional data to the diff --git a/tests/bits/count_dofs_per_block_01.cc b/tests/bits/count_dofs_per_block_01.cc index 64f510f82f..358308d8d6 100644 --- a/tests/bits/count_dofs_per_block_01.cc +++ b/tests/bits/count_dofs_per_block_01.cc @@ -75,13 +75,13 @@ check () // no grouping { - std::vector dpc(dim+1); + std::vector dpc(dim+1); DoFTools::count_dofs_per_component (dof_handler, dpc); print (dpc); } { - std::vector dpc(dim+1); + std::vector dpc(dim+1); DoFTools::count_dofs_per_block (dof_handler, dpc); print (dpc); } @@ -92,7 +92,7 @@ check () { std::vector group(dim+1, 0); group[dim] = 1; - std::vector dpc(2); + std::vector dpc(2); DoFTools::count_dofs_per_component (dof_handler, dpc, false, group); Assert (dpc.size() == 2, ExcInternalError()); print (dpc); @@ -101,7 +101,7 @@ check () { std::vector group(dim+1, 0); group[dim] = 1; - std::vector dpc(2); + std::vector dpc(2); DoFTools::count_dofs_per_block (dof_handler, dpc, group); Assert (dpc.size() == 2, ExcInternalError()); print (dpc); @@ -112,7 +112,7 @@ check () { std::vector group(dim+1, 2*dim); group[dim] = 0; - std::vector dpc(2*dim+1); + std::vector dpc(2*dim+1); DoFTools::count_dofs_per_component (dof_handler, dpc, false, group); Assert (dpc.size() == 2*dim+1, ExcInternalError()); print (dpc); @@ -121,7 +121,7 @@ check () { std::vector group(dim+1, 2*dim); group[dim] = 0; - std::vector dpc(2*dim+1); + std::vector dpc(2*dim+1); DoFTools::count_dofs_per_block (dof_handler, dpc, group); Assert (dpc.size() == 2*dim+1, ExcInternalError()); print (dpc); diff --git a/tests/bits/count_dofs_per_block_02.cc b/tests/bits/count_dofs_per_block_02.cc index affa5c9f3c..fab2b1f112 100644 --- a/tests/bits/count_dofs_per_block_02.cc +++ b/tests/bits/count_dofs_per_block_02.cc @@ -73,13 +73,13 @@ check () // no grouping { - std::vector dpc(dim+1); + std::vector dpc(dim+1); DoFTools::count_dofs_per_component (dof_handler, dpc); print (dpc); } { - std::vector dpc(2); + std::vector dpc(2); DoFTools::count_dofs_per_block (dof_handler, dpc); print (dpc); } @@ -90,7 +90,7 @@ check () { std::vector group(dim+1, 0); group[dim] = 1; - std::vector dpc(2); + std::vector dpc(2); DoFTools::count_dofs_per_component (dof_handler, dpc, false, group); Assert (dpc.size() == 2, ExcInternalError()); print (dpc); @@ -99,7 +99,7 @@ check () { std::vector group(2, 0); group[1] = 1; - std::vector dpc(2); + std::vector dpc(2); DoFTools::count_dofs_per_block (dof_handler, dpc, group); Assert (dpc.size() == 2, ExcInternalError()); print (dpc); @@ -110,7 +110,7 @@ check () { std::vector group(dim+1, 2*dim); group[dim] = 0; - std::vector dpc(2*dim+1); + std::vector dpc(2*dim+1); DoFTools::count_dofs_per_component (dof_handler, dpc, false, group); Assert (dpc.size() == 2*dim+1, ExcInternalError()); print (dpc); @@ -119,7 +119,7 @@ check () { std::vector group(2, 2*dim); group[1] = 0; - std::vector dpc(2*dim+1); + std::vector dpc(2*dim+1); DoFTools::count_dofs_per_block (dof_handler, dpc, group); Assert (dpc.size() == 2*dim+1, ExcInternalError()); print (dpc); diff --git a/tests/bits/count_dofs_per_component_hp_01.cc b/tests/bits/count_dofs_per_component_hp_01.cc index 96ad381c03..2944cc5e5e 100644 --- a/tests/bits/count_dofs_per_component_hp_01.cc +++ b/tests/bits/count_dofs_per_component_hp_01.cc @@ -53,8 +53,8 @@ void test () dof_handler.distribute_dofs(fe_system); //count dofs per component and show them on the screen - std::vector dofs_per_component(3,0); - std::vector dofs_per_component_hp(3,0); + std::vector dofs_per_component(3,0); + std::vector dofs_per_component_hp(3,0); DoFTools::count_dofs_per_component(dof_handler, dofs_per_component); DoFTools::count_dofs_per_component(hp_dof_handler, dofs_per_component_hp); diff --git a/tests/bits/data_out_common.h b/tests/bits/data_out_common.h index 800b573be5..21344d8a97 100644 --- a/tests/bits/data_out_common.h +++ b/tests/bits/data_out_common.h @@ -53,7 +53,7 @@ void make_block_vector (const Vector &in, BlockVector &out) { - std::vector block_sizes(2); + std::vector block_sizes(2); block_sizes[0] = in.size() / 2; block_sizes[1] = in.size() - block_sizes[0]; diff --git a/tests/codim_one/interpolate_boundary_values_01.cc b/tests/codim_one/interpolate_boundary_values_01.cc index 4229f17927..d4904b9217 100644 --- a/tests/codim_one/interpolate_boundary_values_01.cc +++ b/tests/codim_one/interpolate_boundary_values_01.cc @@ -45,14 +45,14 @@ void test(std::string filename) { deallog << dof_handler.n_dofs() << " degrees of freedom" << std::endl; - std::map bv; + std::map bv; VectorTools::interpolate_boundary_values (dof_handler, 0, Functions::SquareFunction(), bv); deallog << bv.size() << " boundary degrees of freedom" << std::endl; - for (std::map::const_iterator i = bv.begin(); + for (std::map::const_iterator i = bv.begin(); i != bv.end(); ++i) deallog << i->first << ' ' << i->second << std::endl; diff --git a/tests/codim_one/interpolate_boundary_values_01_vector_valued.cc b/tests/codim_one/interpolate_boundary_values_01_vector_valued.cc index 7c3c581966..ead9794ba1 100644 --- a/tests/codim_one/interpolate_boundary_values_01_vector_valued.cc +++ b/tests/codim_one/interpolate_boundary_values_01_vector_valued.cc @@ -61,14 +61,14 @@ void test(std::string filename) { deallog << dof_handler.n_dofs() << " degrees of freedom" << std::endl; - std::map bv; + std::map bv; VectorTools::interpolate_boundary_values (dof_handler, 0, X(), bv); deallog << bv.size() << " boundary degrees of freedom" << std::endl; - for (std::map::const_iterator i = bv.begin(); + for (std::map::const_iterator i = bv.begin(); i != bv.end(); ++i) deallog << i->first << ' ' << i->second << std::endl; diff --git a/tests/codim_one/interpolate_boundary_values_02.cc b/tests/codim_one/interpolate_boundary_values_02.cc index dc43396160..2ae6c3d28f 100644 --- a/tests/codim_one/interpolate_boundary_values_02.cc +++ b/tests/codim_one/interpolate_boundary_values_02.cc @@ -48,14 +48,14 @@ void test() { // separatel for (unsigned int boundary_id=0; boundary_id<2; ++boundary_id) { - std::map bv; + std::map bv; VectorTools::interpolate_boundary_values (dof_handler, boundary_id, Functions::SquareFunction(), bv); deallog << bv.size() << " boundary degrees of freedom" << std::endl; - for (std::map::const_iterator i = bv.begin(); + for (std::map::const_iterator i = bv.begin(); i != bv.end(); ++i) deallog << i->first << ' ' << i->second << std::endl; diff --git a/tests/codim_one/interpolate_boundary_values_03.cc b/tests/codim_one/interpolate_boundary_values_03.cc index 225d791cca..d1a95331ea 100644 --- a/tests/codim_one/interpolate_boundary_values_03.cc +++ b/tests/codim_one/interpolate_boundary_values_03.cc @@ -55,7 +55,7 @@ void test() { // separately for (unsigned int boundary_id=0; boundary_id<2; ++boundary_id) { - std::map bv; + std::map bv; VectorTools::interpolate_boundary_values (dof_handler, boundary_id, Functions::SquareFunction(), diff --git a/tests/codim_one/interpolate_boundary_values_1d_closed_ring.cc b/tests/codim_one/interpolate_boundary_values_1d_closed_ring.cc index a90f16a238..8bf60f5b1c 100644 --- a/tests/codim_one/interpolate_boundary_values_1d_closed_ring.cc +++ b/tests/codim_one/interpolate_boundary_values_1d_closed_ring.cc @@ -63,7 +63,7 @@ void test() { // separatel for (unsigned int boundary_id=0; boundary_id<2; ++boundary_id) { - std::map bv; + std::map bv; VectorTools::interpolate_boundary_values (dof_handler, boundary_id, Functions::SquareFunction(), diff --git a/tests/codim_one/renumber_component_wise_01.cc b/tests/codim_one/renumber_component_wise_01.cc index 51495e1e62..c571c16725 100644 --- a/tests/codim_one/renumber_component_wise_01.cc +++ b/tests/codim_one/renumber_component_wise_01.cc @@ -52,7 +52,7 @@ void test(std::string filename) for (typename DoFHandler::active_cell_iterator cell = dof_handler.begin_active(); cell!=dof_handler.end(); ++cell) { - std::vector x (cell->get_fe().dofs_per_cell); + std::vector x (cell->get_fe().dofs_per_cell); cell->get_dof_indices (x); deallog << cell << std::endl; diff --git a/tests/deal.II/derivatives.cc b/tests/deal.II/derivatives.cc index 0d29793ef8..336fae9e15 100644 --- a/tests/deal.II/derivatives.cc +++ b/tests/deal.II/derivatives.cc @@ -74,7 +74,7 @@ check (const unsigned int level, update_values | update_q_points | update_JxW_values); - std::vector global_dofs (element.dofs_per_cell); + std::vector global_dofs (element.dofs_per_cell); std::vector function (quadrature.size()); Vector u (dof.n_dofs ()); diff --git a/tests/deal.II/dof_handler_number_cache.cc b/tests/deal.II/dof_handler_number_cache.cc index 1ffd746b59..d5371c9951 100644 --- a/tests/deal.II/dof_handler_number_cache.cc +++ b/tests/deal.II/dof_handler_number_cache.cc @@ -92,7 +92,7 @@ void test() Assert (dof_handler.locally_owned_dofs() == all, ExcInternalError()); Assert (dof_handler.n_locally_owned_dofs_per_processor() == - std::vector (1,N), + std::vector (1,N), ExcInternalError()); Assert (dof_handler.locally_owned_dofs_per_processor() == std::vector(1,all), diff --git a/tests/deal.II/dof_handler_number_cache_02.cc b/tests/deal.II/dof_handler_number_cache_02.cc index 34b68fd7e7..73cc6512a3 100644 --- a/tests/deal.II/dof_handler_number_cache_02.cc +++ b/tests/deal.II/dof_handler_number_cache_02.cc @@ -90,7 +90,7 @@ void test() Assert (dof_handler.locally_owned_dofs() == all, ExcInternalError()); Assert (dof_handler.n_locally_owned_dofs_per_processor() == - std::vector (1,N), + std::vector (1,N), ExcInternalError()); Assert (dof_handler.locally_owned_dofs_per_processor() == std::vector(1,all), diff --git a/tests/deal.II/dof_renumbering.cc b/tests/deal.II/dof_renumbering.cc index 4ff20a5017..91b93e151d 100644 --- a/tests/deal.II/dof_renumbering.cc +++ b/tests/deal.II/dof_renumbering.cc @@ -40,7 +40,7 @@ template void print_dofs (const DoFHandler &dof) { - std::vector v (dof.get_fe().dofs_per_cell); + std::vector v (dof.get_fe().dofs_per_cell); for (typename DoFHandler::active_cell_iterator cell=dof.begin_active(); cell != dof.end(); ++cell) { diff --git a/tests/deal.II/dof_renumbering_02.cc b/tests/deal.II/dof_renumbering_02.cc index 17c337021f..eca4ea3ab9 100644 --- a/tests/deal.II/dof_renumbering_02.cc +++ b/tests/deal.II/dof_renumbering_02.cc @@ -40,7 +40,7 @@ void print_dofs (const DoFHandler &dof) { const FiniteElement& fe = dof.get_fe(); - std::vector v (fe.dofs_per_cell); + std::vector v (fe.dofs_per_cell); std_cxx1x::shared_ptr > fevalues; if (fe.has_support_points()) @@ -73,7 +73,7 @@ void print_dofs (const MGDoFHandler &dof, unsigned int level) { const FiniteElement& fe = dof.get_fe(); - std::vector v (fe.dofs_per_cell); + std::vector v (fe.dofs_per_cell); std_cxx1x::shared_ptr > fevalues; if (fe.has_support_points()) diff --git a/tests/deal.II/dof_renumbering_03.cc b/tests/deal.II/dof_renumbering_03.cc index 936c85e9e2..18f6f585e1 100644 --- a/tests/deal.II/dof_renumbering_03.cc +++ b/tests/deal.II/dof_renumbering_03.cc @@ -40,7 +40,7 @@ void print_dofs (const DoFHandler &dof) { const FiniteElement& fe = dof.get_fe(); - std::vector v (fe.dofs_per_cell); + std::vector v (fe.dofs_per_cell); std_cxx1x::shared_ptr > fevalues; if (fe.has_support_points()) diff --git a/tests/deal.II/dof_renumbering_04.cc b/tests/deal.II/dof_renumbering_04.cc index d72c082c1a..eafc0207aa 100644 --- a/tests/deal.II/dof_renumbering_04.cc +++ b/tests/deal.II/dof_renumbering_04.cc @@ -40,7 +40,7 @@ void print_dofs (const DoFHandler &dof) { const FiniteElement& fe = dof.get_fe(); - std::vector v (fe.dofs_per_cell); + std::vector v (fe.dofs_per_cell); std_cxx1x::shared_ptr > fevalues; if (fe.has_support_points()) diff --git a/tests/deal.II/dof_renumbering_04a.cc b/tests/deal.II/dof_renumbering_04a.cc index f104118487..3bb924e0ce 100644 --- a/tests/deal.II/dof_renumbering_04a.cc +++ b/tests/deal.II/dof_renumbering_04a.cc @@ -40,7 +40,7 @@ template void print_dofs (const DoFHandler &dof) { - std::vector v (dof.get_fe().dofs_per_cell); + std::vector v (dof.get_fe().dofs_per_cell); for (typename DoFHandler::active_cell_iterator cell=dof.begin_active(); cell != dof.end(); ++cell) diff --git a/tests/deal.II/dof_renumbering_05.cc b/tests/deal.II/dof_renumbering_05.cc index 317df05728..02fc1c4e78 100644 --- a/tests/deal.II/dof_renumbering_05.cc +++ b/tests/deal.II/dof_renumbering_05.cc @@ -40,7 +40,7 @@ void print_dofs (const DoFHandler &dof) { const FiniteElement& fe = dof.get_fe(); - std::vector v (fe.dofs_per_cell); + std::vector v (fe.dofs_per_cell); std_cxx1x::shared_ptr > fevalues; if (fe.has_support_points()) diff --git a/tests/deal.II/dof_renumbering_06.cc b/tests/deal.II/dof_renumbering_06.cc index 6cffb2ecb2..1b13639588 100644 --- a/tests/deal.II/dof_renumbering_06.cc +++ b/tests/deal.II/dof_renumbering_06.cc @@ -40,7 +40,7 @@ void print_dofs (const DoFHandler &dof) { const FiniteElement& fe = dof.get_fe(); - std::vector v (fe.dofs_per_cell); + std::vector v (fe.dofs_per_cell); std_cxx1x::shared_ptr > fevalues; if (fe.has_support_points()) diff --git a/tests/deal.II/dof_renumbering_07.cc b/tests/deal.II/dof_renumbering_07.cc index 5f020cf281..08f53a83f9 100644 --- a/tests/deal.II/dof_renumbering_07.cc +++ b/tests/deal.II/dof_renumbering_07.cc @@ -39,7 +39,7 @@ void print_dofs (const DoFHandler &dof) { const FiniteElement& fe = dof.get_fe(); - std::vector v (fe.dofs_per_cell); + std::vector v (fe.dofs_per_cell); std_cxx1x::shared_ptr > fevalues; if (fe.has_support_points()) diff --git a/tests/deal.II/dof_renumbering_zorder_01.cc b/tests/deal.II/dof_renumbering_zorder_01.cc index f5f6f0e0db..ffd0d90ec9 100644 --- a/tests/deal.II/dof_renumbering_zorder_01.cc +++ b/tests/deal.II/dof_renumbering_zorder_01.cc @@ -38,7 +38,7 @@ void print_dofs (const DoFHandler &dof, stream & out) { const FiniteElement& fe = dof.get_fe(); - std::vector v (fe.dofs_per_cell); + std::vector v (fe.dofs_per_cell); std_cxx1x::shared_ptr > fevalues; if (fe.has_support_points()) diff --git a/tests/deal.II/dof_renumbering_zorder_02.cc b/tests/deal.II/dof_renumbering_zorder_02.cc index 35960c6e60..d2641d113c 100644 --- a/tests/deal.II/dof_renumbering_zorder_02.cc +++ b/tests/deal.II/dof_renumbering_zorder_02.cc @@ -41,7 +41,7 @@ print_dofs (const DoFHandler &dof, stream & out) out << std::setprecision (2); out << std::fixed; const FiniteElement& fe = dof.get_fe(); - std::vector v (fe.dofs_per_cell); + std::vector v (fe.dofs_per_cell); std_cxx1x::shared_ptr > fevalues; if (fe.has_support_points()) diff --git a/tests/deal.II/extract_dofs_by_component_05.cc b/tests/deal.II/extract_dofs_by_component_05.cc index e0bf695b15..392fb5b553 100644 --- a/tests/deal.II/extract_dofs_by_component_05.cc +++ b/tests/deal.II/extract_dofs_by_component_05.cc @@ -53,7 +53,7 @@ check () DoFHandler dof(tr); dof.distribute_dofs(element); - std::vector count (element.n_components()); + std::vector count (element.n_components()); DoFTools::count_dofs_per_component (dof, count, false); for (unsigned int d=0; dset_active_fe_index(1); dof.distribute_dofs(element); - std::vector count (element.n_components()); + std::vector count (element.n_components()); DoFTools::count_dofs_per_component (dof, count, false); for (unsigned int d=0; d dof(tr); dof.distribute_dofs(element); - std::vector count (element.n_components()); + std::vector count (element.n_components()); DoFTools::count_dofs_per_component (dof, count, true); for (unsigned int d=0; d::make_grid_and_dofs() DoFRenumbering::component_wise(dof_handler); // total number of dof per block component - std::vector dofs_per_block(2); + std::vector dofs_per_block(2); DoFTools::count_dofs_per_block(dof_handler, dofs_per_block, block_component); const unsigned int n_stress_dof = dofs_per_block[0]; diff --git a/tests/deal.II/filtered_matrix.cc b/tests/deal.II/filtered_matrix.cc index 6f69072c69..bce56ebe86 100644 --- a/tests/deal.II/filtered_matrix.cc +++ b/tests/deal.II/filtered_matrix.cc @@ -77,7 +77,7 @@ solve_filtered (std::map &bv, template void -solve_eliminated (std::map &bv, +solve_eliminated (std::map &bv, SparseMatrix &A, Vector &u, Vector &f) @@ -121,7 +121,7 @@ check () update_values | update_gradients | update_q_points | update_JxW_values); - std::vector global_dofs (element.dofs_per_cell); + std::vector global_dofs (element.dofs_per_cell); std::vector function (quadrature.size()); Vector f (dof.n_dofs ()); @@ -165,13 +165,13 @@ check () } // interpolate boundary values - std::map bv; + std::map bv; VectorTools::interpolate_boundary_values (mapping, dof, 0, cosine, bv, std::vector()); // the cosine has too many zero // values on the boundary of the // domain, so reset the elements to // some other value - for (typename std::map::iterator i=bv.begin(); + for (typename std::map::iterator i=bv.begin(); i!=bv.end(); ++i) i->second = std::sin(i->second+0.5)+1.0; diff --git a/tests/deal.II/grid_transform.cc b/tests/deal.II/grid_transform.cc index 2891a3054c..44b49f8b81 100644 --- a/tests/deal.II/grid_transform.cc +++ b/tests/deal.II/grid_transform.cc @@ -42,7 +42,7 @@ int main () // build up a map of vertex indices // of boundary vertices to the new // boundary points - std::map > new_points; + std::map > new_points; // new center and new radius // of the inner circle. @@ -68,7 +68,7 @@ int main () // leave the // point, where // they are. - new_points.insert(std::pair > ( + new_points.insert(std::pair > ( face->vertex_index(vertex_no), v)); } else if (std::fabs(std::sqrt(v.square())-inner_radius)<1e-12) @@ -82,7 +82,7 @@ int main () // the radius // of the // circle. - new_points.insert(std::pair > ( + new_points.insert(std::pair > ( face->vertex_index(vertex_no), n_radius/inner_radius*v+n_center)); face->set_boundary_indicator(1); } diff --git a/tests/deal.II/inhomogeneous_constraints_02.cc b/tests/deal.II/inhomogeneous_constraints_02.cc index 43f7789151..e7bf753c5c 100644 --- a/tests/deal.II/inhomogeneous_constraints_02.cc +++ b/tests/deal.II/inhomogeneous_constraints_02.cc @@ -76,7 +76,7 @@ void test(bool use_inhomogeneity_for_rhs) SparseMatrix mat(sp); Vector rhs(5); - std::vector local_dofs; + std::vector local_dofs; for (unsigned int i=0;i<5;++i) local_dofs.push_back(i); diff --git a/tests/deal.II/inhomogeneous_constraints_03.cc b/tests/deal.II/inhomogeneous_constraints_03.cc index 75102a7896..61b8b720c5 100644 --- a/tests/deal.II/inhomogeneous_constraints_03.cc +++ b/tests/deal.II/inhomogeneous_constraints_03.cc @@ -81,11 +81,11 @@ void test(bool use_inhomogeneity_for_rhs) // "assemble": - std::vector local_dofs1; + std::vector local_dofs1; for (unsigned int i=0;i<5;++i) local_dofs1.push_back(i); - std::vector local_dofs2; + std::vector local_dofs2; local_dofs2.push_back(1); for (unsigned int i=1;i<5;++i) local_dofs2.push_back(3+i); diff --git a/tests/deal.II/interpolate_boundary_values_02.cc b/tests/deal.II/interpolate_boundary_values_02.cc index 985ab1c6da..bde597b633 100644 --- a/tests/deal.II/interpolate_boundary_values_02.cc +++ b/tests/deal.II/interpolate_boundary_values_02.cc @@ -64,7 +64,7 @@ void test () Functions::SquareFunction(), boundary_values); deallog << boundary_values.size() << std::endl; - for (std::map::const_iterator + for (std::map::const_iterator p = boundary_values.begin(); p != boundary_values.end(); ++p) deallog << p->first << ' ' << p->second << std::endl; diff --git a/tests/fe/fe_q_dg0.cc b/tests/fe/fe_q_dg0.cc index 17156aaeff..bd8d233cbb 100644 --- a/tests/fe/fe_q_dg0.cc +++ b/tests/fe/fe_q_dg0.cc @@ -450,7 +450,7 @@ namespace Step22 constraints.close (); - std::vector dofs_per_block (2); + std::vector dofs_per_block (2); DoFTools::count_dofs_per_block (dof_handler, dofs_per_block, block_component); const unsigned int n_u = dofs_per_block[0], diff --git a/tests/hp/crash_16.cc b/tests/hp/crash_16.cc index 956d094f55..5405f3f124 100644 --- a/tests/hp/crash_16.cc +++ b/tests/hp/crash_16.cc @@ -70,8 +70,8 @@ void test () // loop over all lines and make sure that // all the DoF indices on these lines are // identical - std::vector indices_1; - std::vector indices_2; + std::vector indices_1; + std::vector indices_2; std::set line_already_treated; diff --git a/tests/hp/crash_19.cc b/tests/hp/crash_19.cc index d6add85e3d..693a0f90e9 100644 --- a/tests/hp/crash_19.cc +++ b/tests/hp/crash_19.cc @@ -100,7 +100,7 @@ void test () exact_solution, boundary_values); - for (std::map::iterator i=boundary_values.begin(); + for (std::map::iterator i=boundary_values.begin(); i != boundary_values.end(); ++i) deallog << i->first << ' ' << i->second << std::endl; } diff --git a/tests/hp/dof_handler_number_cache.cc b/tests/hp/dof_handler_number_cache.cc index 317ccba627..5dedf2dca5 100644 --- a/tests/hp/dof_handler_number_cache.cc +++ b/tests/hp/dof_handler_number_cache.cc @@ -102,7 +102,7 @@ void test() Assert (dof_handler.locally_owned_dofs() == all, ExcInternalError()); Assert (dof_handler.n_locally_owned_dofs_per_processor() == - std::vector (1,N), + std::vector (1,N), ExcInternalError()); Assert (dof_handler.locally_owned_dofs_per_processor() == std::vector(1,all), diff --git a/tests/hp/dof_renumbering_04.cc b/tests/hp/dof_renumbering_04.cc index 43362a9414..be68d8a262 100644 --- a/tests/hp/dof_renumbering_04.cc +++ b/tests/hp/dof_renumbering_04.cc @@ -39,7 +39,7 @@ template void print_dofs (const hp::DoFHandler &dof) { - std::vector v; + std::vector v; for (typename hp::DoFHandler::active_cell_iterator cell=dof.begin_active(); cell != dof.end(); ++cell) { diff --git a/tests/hp/dof_renumbering_05.cc b/tests/hp/dof_renumbering_05.cc index 0739f745c5..5cd9a9be3d 100644 --- a/tests/hp/dof_renumbering_05.cc +++ b/tests/hp/dof_renumbering_05.cc @@ -39,7 +39,7 @@ template void print_dofs (const hp::DoFHandler &dof) { - std::vector v; + std::vector v; for (typename hp::DoFHandler::active_cell_iterator cell=dof.begin_active(); cell != dof.end(); ++cell) { diff --git a/tests/hp/dof_renumbering_06.cc b/tests/hp/dof_renumbering_06.cc index de23ff3cb1..b4b9548c4b 100644 --- a/tests/hp/dof_renumbering_06.cc +++ b/tests/hp/dof_renumbering_06.cc @@ -39,7 +39,7 @@ template void print_dofs (const hp::DoFHandler &dof) { - std::vector v; + std::vector v; for (typename hp::DoFHandler::active_cell_iterator cell=dof.begin_active(); cell != dof.end(); ++cell) { diff --git a/tests/hp/fe_nothing_08.cc b/tests/hp/fe_nothing_08.cc index 7e9b37e357..c8aa6e51c1 100644 --- a/tests/hp/fe_nothing_08.cc +++ b/tests/hp/fe_nothing_08.cc @@ -65,12 +65,12 @@ void test () dof_handler.distribute_dofs (fe_collection); deallog << dof_handler.n_dofs() << " dofs" << std::endl; - std::map bv; + std::map bv; VectorTools::interpolate_boundary_values (dof_handler, 0, ZeroFunction(1), bv); - for (std::map::iterator + for (std::map::iterator p = bv.begin(); p!=bv.end(); ++p) deallog << p->first << ' ' << p->second << std::endl; } diff --git a/tests/hp/fe_nothing_11.cc b/tests/hp/fe_nothing_11.cc index 2e536e19e2..8aa4b34f50 100644 --- a/tests/hp/fe_nothing_11.cc +++ b/tests/hp/fe_nothing_11.cc @@ -69,12 +69,12 @@ void test () dof_handler.distribute_dofs (fe_collection); deallog << dof_handler.n_dofs() << " dofs" << std::endl; - std::map bv; + std::map bv; VectorTools::interpolate_boundary_values (dof_handler, 0, ZeroFunction(4), bv); - for (std::map::iterator + for (std::map::iterator p = bv.begin(); p!=bv.end(); ++p) deallog << p->first << ' ' << p->second << std::endl; } diff --git a/tests/hp/matrices.cc b/tests/hp/matrices.cc index 61f8c6f9a2..5cc5006479 100644 --- a/tests/hp/matrices.cc +++ b/tests/hp/matrices.cc @@ -72,7 +72,7 @@ check_boundary (const hp::DoFHandler &dof, hp::QCollection face_quadrature; face_quadrature.push_back (QGauss(6)); - std::vector dof_to_boundary_mapping; + std::vector dof_to_boundary_mapping; DoFTools::map_dof_to_boundary_indices (dof, dof_to_boundary_mapping); diff --git a/tests/hp/matrices_hp.cc b/tests/hp/matrices_hp.cc index 0c05043902..121d9ef7a2 100644 --- a/tests/hp/matrices_hp.cc +++ b/tests/hp/matrices_hp.cc @@ -71,7 +71,7 @@ check_boundary (const hp::DoFHandler &dof, for (unsigned int i=1; i<7-dim; ++i) face_quadrature.push_back (QGauss(3+i)); - std::vector dof_to_boundary_mapping; + std::vector dof_to_boundary_mapping; DoFTools::map_dof_to_boundary_indices (dof, dof_to_boundary_mapping); diff --git a/tests/hp/renumber_block_wise_01.cc b/tests/hp/renumber_block_wise_01.cc index 4eb2a55aa0..7404a49bc8 100644 --- a/tests/hp/renumber_block_wise_01.cc +++ b/tests/hp/renumber_block_wise_01.cc @@ -40,11 +40,11 @@ template -std::vector +std::vector get_dofs (const hp::DoFHandler &dof) { - std::vector local; - std::vector global; + std::vector local; + std::vector global; for (typename hp::DoFHandler::active_cell_iterator cell=dof.begin_active(); cell != dof.end(); ++cell) { @@ -66,11 +66,11 @@ check_renumbering(hp::DoFHandler& dof) // do component-wise and save the // results DoFRenumbering::component_wise (dof); - const std::vector vc = get_dofs (dof); + const std::vector vc = get_dofs (dof); // now do the same with blocks DoFRenumbering::block_wise (dof); - const std::vector vb = get_dofs (dof); + const std::vector vb = get_dofs (dof); Assert (vc == vb, ExcInternalError()); diff --git a/tests/hp/renumber_block_wise_01a.cc b/tests/hp/renumber_block_wise_01a.cc index e3f4c54abe..75fd72215e 100644 --- a/tests/hp/renumber_block_wise_01a.cc +++ b/tests/hp/renumber_block_wise_01a.cc @@ -42,8 +42,8 @@ template std::vector get_dofs (const hp::DoFHandler &dof) { - std::vector local; - std::vector global; + std::vector local; + std::vector global; for (typename hp::DoFHandler::active_cell_iterator cell=dof.begin_active(); cell != dof.end(); ++cell) { diff --git a/tests/hp/renumber_block_wise_02.cc b/tests/hp/renumber_block_wise_02.cc index 771d28d398..98d39195af 100644 --- a/tests/hp/renumber_block_wise_02.cc +++ b/tests/hp/renumber_block_wise_02.cc @@ -41,11 +41,11 @@ template -std::vector +std::vector get_dofs (const hp::DoFHandler &dof) { - std::vector local; - std::vector global; + std::vector local; + std::vector global; for (typename hp::DoFHandler::active_cell_iterator cell=dof.begin_active(); cell != dof.end(); ++cell) { @@ -76,11 +76,11 @@ check_renumbering(hp::DoFHandler& dof) // do component-wise and save the // results DoFRenumbering::component_wise (dof, order); - const std::vector vc = get_dofs (dof); + const std::vector vc = get_dofs (dof); // now do the same with blocks DoFRenumbering::block_wise (dof); - const std::vector vb = get_dofs (dof); + const std::vector vb = get_dofs (dof); Assert (vc == vb, ExcInternalError()); diff --git a/tests/hp/renumber_component_wise.cc b/tests/hp/renumber_component_wise.cc index dba4384303..6acab0ab7c 100644 --- a/tests/hp/renumber_component_wise.cc +++ b/tests/hp/renumber_component_wise.cc @@ -41,7 +41,7 @@ template void print_dofs (const hp::DoFHandler &dof) { - std::vector v; + std::vector v; for (typename hp::DoFHandler::active_cell_iterator cell=dof.begin_active(); cell != dof.end(); ++cell) { diff --git a/tests/hp/step-12.cc b/tests/hp/step-12.cc index cf4d2fe047..87c27cb46d 100644 --- a/tests/hp/step-12.cc +++ b/tests/hp/step-12.cc @@ -405,8 +405,8 @@ template void DGMethod::assemble_system1 () { const unsigned int dofs_per_cell = dof_handler.get_fe()[0].dofs_per_cell; - std::vector dofs (dofs_per_cell); - std::vector dofs_neighbor (dofs_per_cell); + std::vector dofs (dofs_per_cell); + std::vector dofs_neighbor (dofs_per_cell); const UpdateFlags update_flags = update_values | update_gradients diff --git a/tests/lac/constraints_c1.cc b/tests/lac/constraints_c1.cc index 338eb1eef5..ecdbf6c39a 100644 --- a/tests/lac/constraints_c1.cc +++ b/tests/lac/constraints_c1.cc @@ -62,8 +62,8 @@ setup_constraints(const DoFHandler& dof_handler) } } - std::vector cell_indices(fe.dofs_per_cell); - std::vector neighbor_indices(fe.dofs_per_cell); + std::vector cell_indices(fe.dofs_per_cell); + std::vector neighbor_indices(fe.dofs_per_cell); for (typename DoFHandler::active_cell_iterator cell = dof_handler.begin_active(); cell != dof_handler.end();++cell) @@ -90,7 +90,7 @@ setup_constraints(const DoFHandler& dof_handler) const unsigned int d = GeometryInfo::unit_normal_direction[other_face]; - std::vector > rhs; + std::vector > rhs; const unsigned int constrained = fe.face_to_cell_index( (fvertex == 0) ? 2 : fe.dofs_per_face-1, face); double constrained_weight = 0.; diff --git a/tests/lac/constraints_c1_02.cc b/tests/lac/constraints_c1_02.cc index a26fb1519a..c53f78c7f7 100644 --- a/tests/lac/constraints_c1_02.cc +++ b/tests/lac/constraints_c1_02.cc @@ -27,23 +27,23 @@ run() { constraints.add_line(7); - std::vector > rhs; - rhs.push_back(std::pair(41,1.0)); - rhs.push_back(std::pair(42,1.0)); + std::vector > rhs; + rhs.push_back(std::pair(41,1.0)); + rhs.push_back(std::pair(42,1.0)); constraints.add_entries(7, rhs); } { constraints.add_line(41); - std::vector > rhs; - rhs.push_back(std::pair(42,1.0)); + std::vector > rhs; + rhs.push_back(std::pair(42,1.0)); constraints.add_entries(41, rhs); } { constraints.add_line(42); - std::vector > rhs; - rhs.push_back(std::pair(41,1.0)); + std::vector > rhs; + rhs.push_back(std::pair(41,1.0)); constraints.add_entries(42, rhs); } diff --git a/tests/lac/solver.cc b/tests/lac/solver.cc index 07ad60d193..1b5fa4cf78 100644 --- a/tests/lac/solver.cc +++ b/tests/lac/solver.cc @@ -106,8 +106,8 @@ int main() PreconditionSSOR<> prec_ssor; prec_ssor.initialize(A, 1.2); - std::vector permutation(dim); - std::vector inverse_permutation(dim); + std::vector permutation(dim); + std::vector inverse_permutation(dim); // Create a permutation: Blocks // backwards and every second diff --git a/tests/lac/solver_relaxation_01.cc b/tests/lac/solver_relaxation_01.cc index b5a680f11c..90cfc458fb 100644 --- a/tests/lac/solver_relaxation_01.cc +++ b/tests/lac/solver_relaxation_01.cc @@ -134,8 +134,8 @@ int main() PreconditionSOR<> prec_sor; prec_sor.initialize(A, 1.); - std::vector permutation(dim); - std::vector inverse_permutation(dim); + std::vector permutation(dim); + std::vector inverse_permutation(dim); // Create a permutation: Blocks // backwards and every second diff --git a/tests/lac/solver_relaxation_03.cc b/tests/lac/solver_relaxation_03.cc index 7050b697d4..9d059c2afe 100644 --- a/tests/lac/solver_relaxation_03.cc +++ b/tests/lac/solver_relaxation_03.cc @@ -77,8 +77,8 @@ int main() testproblem.five_point(A, true); // The permutation vectors; - std::vector perm(dim); - std::vector iperm(dim); + std::vector perm(dim); + std::vector iperm(dim); for (unsigned int blocksize = 4; blocksize < 32; blocksize <<= 1) { diff --git a/tests/lac/sparse_matrices.cc b/tests/lac/sparse_matrices.cc index b12541bc74..f3fd33f52c 100644 --- a/tests/lac/sparse_matrices.cc +++ b/tests/lac/sparse_matrices.cc @@ -54,13 +54,13 @@ check_vmult_quadratic(std::vector& residuals, SolverRichardson<> rich(control, mem, .01); SolverRichardson<> prich(control, mem, 1.); - const unsigned int block_size = (unsigned int) std::sqrt(A.n()+.3); + const types::global_dof_index block_size = (types::global_dof_index) std::sqrt(A.n()+.3); const unsigned int n_blocks = A.n()/block_size; typename PreconditionBlock::AdditionalData data(block_size, 1.2); - std::vector perm(A.n()); - std::vector iperm(A.n()); + std::vector perm(A.n()); + std::vector iperm(A.n()); for (unsigned int i=0;i &data, const unsigned int dofs_per_cell = fe_eval.dofs_per_cell; AlignedVector > values (n_q_points); AlignedVector > gradients (dim*n_q_points); - std::vector dof_indices (dofs_per_cell); + std::vector dof_indices (dofs_per_cell); for(unsigned int cell=cell_range.first;cell &data, AlignedVector > gradients0 (dim*n_q_points0); AlignedVector > values1 (n_q_points1); AlignedVector > gradients1 (dim*n_q_points1); - std::vector dof_indices0 (dofs_per_cell0); - std::vector dof_indices1 (dofs_per_cell1); + std::vector dof_indices0 (dofs_per_cell0); + std::vector dof_indices1 (dofs_per_cell1); for(unsigned int cell=cell_range.first;cell &data, AlignedVector > gradients0 (dim*n_q_points0); AlignedVector > values1 (n_q_points1); AlignedVector > gradients1 (dim*n_q_points1); - std::vector dof_indices0 (dofs_per_cell0); - std::vector dof_indices1 (dofs_per_cell1); + std::vector dof_indices0 (dofs_per_cell0); + std::vector dof_indices1 (dofs_per_cell1); for(unsigned int cell=cell_range.first;cell::type dirichlet_boundary; ZeroFunction homogeneous_dirichlet_bc (1); dirichlet_boundary[0] = &homogeneous_dirichlet_bc; - std::vector > boundary_indices(nlevels); + std::vector > boundary_indices(nlevels); MGTools::make_boundary_list (dof, dirichlet_boundary, boundary_indices); for (unsigned int level=0;level::iterator bc_it = boundary_indices[level].begin(); + std::set::iterator bc_it = boundary_indices[level].begin(); for ( ; bc_it != boundary_indices[level].end(); ++bc_it) mg_constraints[level].add_line(*bc_it); mg_constraints[level].close(); diff --git a/tests/matrix_free/matrix_vector_stokes.cc b/tests/matrix_free/matrix_vector_stokes.cc index e201bc83b7..cdc067c731 100644 --- a/tests/matrix_free/matrix_vector_stokes.cc +++ b/tests/matrix_free/matrix_vector_stokes.cc @@ -146,7 +146,7 @@ void test () constraints.close (); - std::vector dofs_per_block (dim+1); + std::vector dofs_per_block (dim+1); DoFTools::count_dofs_per_component (dof_handler, dofs_per_block); //std::cout << " Number of active cells: " diff --git a/tests/matrix_free/matrix_vector_stokes_noflux.cc b/tests/matrix_free/matrix_vector_stokes_noflux.cc index ae78558ab3..4013c21de3 100644 --- a/tests/matrix_free/matrix_vector_stokes_noflux.cc +++ b/tests/matrix_free/matrix_vector_stokes_noflux.cc @@ -172,7 +172,7 @@ void test () constraints_p); constraints_p.close (); - std::vector dofs_per_block (2); + std::vector dofs_per_block (2); DoFTools::count_dofs_per_block (dof_handler, dofs_per_block, stokes_sub_blocks); diff --git a/tests/matrix_free/step-37.cc b/tests/matrix_free/step-37.cc index 1c8a8298f7..ba45196588 100644 --- a/tests/matrix_free/step-37.cc +++ b/tests/matrix_free/step-37.cc @@ -305,7 +305,7 @@ namespace Step37 { data.cell_loop (&LaplaceOperator::local_apply, this, dst, src); - const std::vector & + const std::vector & constrained_dofs = data.get_constrained_dofs(); for (unsigned int i=0; i::type dirichlet_boundary; ZeroFunction homogeneous_dirichlet_bc (1); dirichlet_boundary[0] = &homogeneous_dirichlet_bc; - std::vector > boundary_indices(triangulation.n_levels()); + std::vector > boundary_indices(triangulation.n_levels()); MGTools::make_boundary_list (mg_dof_handler, dirichlet_boundary, boundary_indices); diff --git a/tests/mpi/count_dofs_per_block_01.cc b/tests/mpi/count_dofs_per_block_01.cc index 1d72b80e90..2f79c333ca 100644 --- a/tests/mpi/count_dofs_per_block_01.cc +++ b/tests/mpi/count_dofs_per_block_01.cc @@ -51,7 +51,7 @@ void test() DoFHandler dof_handler (triangulation); dof_handler.distribute_dofs (fe); - std::vector dofs_per_block (fe.n_blocks()); + std::vector dofs_per_block (fe.n_blocks()); DoFTools::count_dofs_per_block (dof_handler, dofs_per_block); if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0) diff --git a/tests/mpi/count_dofs_per_block_02.cc b/tests/mpi/count_dofs_per_block_02.cc index af7269705f..94a8dc87c4 100644 --- a/tests/mpi/count_dofs_per_block_02.cc +++ b/tests/mpi/count_dofs_per_block_02.cc @@ -84,7 +84,7 @@ void test() triangulation.execute_coarsening_and_refinement (); dof_handler.distribute_dofs (fe); - std::vector dofs_per_block (fe.n_components()); + std::vector dofs_per_block (fe.n_components()); DoFTools::count_dofs_per_block (dof_handler, dofs_per_block); Assert (std::accumulate (dofs_per_block.begin(), dofs_per_block.end(), 0U) diff --git a/tests/mpi/count_dofs_per_component_01.cc b/tests/mpi/count_dofs_per_component_01.cc index 62c67c6abf..aa8dd94668 100644 --- a/tests/mpi/count_dofs_per_component_01.cc +++ b/tests/mpi/count_dofs_per_component_01.cc @@ -51,7 +51,7 @@ void test() triangulation.refine_global (2); dof_handler.distribute_dofs (fe); - std::vector dofs_per_component (fe.n_components()); + std::vector dofs_per_component (fe.n_components()); DoFTools::count_dofs_per_component (dof_handler, dofs_per_component); Assert (std::accumulate (dofs_per_component.begin(), dofs_per_component.end(), 0U) diff --git a/tests/mpi/distribute_sp_01.cc b/tests/mpi/distribute_sp_01.cc index 4d7e4d74e4..a282655b2e 100644 --- a/tests/mpi/distribute_sp_01.cc +++ b/tests/mpi/distribute_sp_01.cc @@ -38,7 +38,7 @@ void test_mpi() unsigned int num_local=10; unsigned int n=numprocs*num_local; - std::vector rows_per_cpu; + std::vector rows_per_cpu; for (unsigned int i=0;i rows_per_cpu; + std::vector rows_per_cpu; for (unsigned int i=0;i dofh(tr); dofh.distribute_dofs (fe); - std::map > points; + std::map > points; DoFTools::map_dofs_to_support_points (MappingQ1(), dofh, points); diff --git a/tests/mpi/mg_03.cc b/tests/mpi/mg_03.cc index 734d90fd6c..b2c03db88f 100644 --- a/tests/mpi/mg_03.cc +++ b/tests/mpi/mg_03.cc @@ -94,7 +94,7 @@ void test() for (;cell!=endc;++cell) { - std::vector dofs(fe.n_dofs_per_cell()); + std::vector dofs(fe.n_dofs_per_cell()); cell->get_mg_dof_indices(dofs); for (unsigned int i=0;i > new_dofs(mg_dof.get_tria().n_levels(), - std::vector(selected.size())); + std::vector(selected.size())); std::swap(ndofs, new_dofs); MGTools::count_dofs_per_block (mg_dof, ndofs); } diff --git a/tests/multigrid/transfer_system_04.cc b/tests/multigrid/transfer_system_04.cc index 85889511b3..61e2d55ad9 100644 --- a/tests/multigrid/transfer_system_04.cc +++ b/tests/multigrid/transfer_system_04.cc @@ -109,7 +109,7 @@ void check (const FiniteElement& fe) 0, 0, block_component, block_component); - std::vector > dofs_per_block(tr.n_levels(), std::vector(2)); + std::vector > dofs_per_block(tr.n_levels(), std::vector(2)); MGTools::count_dofs_per_block(mg_dof_handler, dofs_per_block, block_component); FullMatrix prolong_0_1 (dofs_per_block[1][0], dofs_per_block[0][0]); diff --git a/tests/multigrid/transfer_system_05.cc b/tests/multigrid/transfer_system_05.cc index c75b27ae11..4f7b7a1467 100644 --- a/tests/multigrid/transfer_system_05.cc +++ b/tests/multigrid/transfer_system_05.cc @@ -65,9 +65,10 @@ void check (const FiniteElement& fe, const unsigned int selected_block) selected_block, selected_block, block_component, block_component); - std::vector dofs_per_block(3); + std::vector dofs_per_block(3); DoFTools::count_dofs_per_block(mg_dof_handler, dofs_per_block, block_component); - std::vector > mg_dofs_per_block(tr.n_levels(), std::vector(3)); + std::vector > mg_dofs_per_block(tr.n_levels(), + std::vector(3)); MGTools::count_dofs_per_block(mg_dof_handler, mg_dofs_per_block, block_component); deallog << "Global dofs:"; diff --git a/tests/multigrid/transfer_system_adaptive_04.cc b/tests/multigrid/transfer_system_adaptive_04.cc index 596f8503f9..0f79d94fdb 100644 --- a/tests/multigrid/transfer_system_adaptive_04.cc +++ b/tests/multigrid/transfer_system_adaptive_04.cc @@ -143,7 +143,7 @@ void check (const FiniteElement& fe) for (unsigned int level=0; level > boundary_indices(tr.n_levels()); + std::vector > boundary_indices(tr.n_levels()); typename FunctionMap::type dirichlet_boundary; ZeroFunction dirichlet_bc(fe.n_components()); dirichlet_boundary[3] = &dirichlet_bc; diff --git a/tests/multigrid/transfer_system_adaptive_06.cc b/tests/multigrid/transfer_system_adaptive_06.cc index 9a1cea4cfe..4300343caa 100644 --- a/tests/multigrid/transfer_system_adaptive_06.cc +++ b/tests/multigrid/transfer_system_adaptive_06.cc @@ -143,7 +143,7 @@ void check (const FiniteElement& fe) for (unsigned int level=0; level > boundary_indices(tr.n_levels()); + std::vector > boundary_indices(tr.n_levels()); typename FunctionMap::type dirichlet_boundary; ZeroFunction dirichlet_bc(fe.n_components()); dirichlet_boundary[3] = &dirichlet_bc; diff --git a/tests/multigrid/transfer_system_adaptive_07.cc b/tests/multigrid/transfer_system_adaptive_07.cc index b218b7055b..9000bbfdd7 100644 --- a/tests/multigrid/transfer_system_adaptive_07.cc +++ b/tests/multigrid/transfer_system_adaptive_07.cc @@ -154,8 +154,8 @@ void check (const FiniteElement& fe) transfer.build_matrices(mg_dof_handler, mg_dof_handler, 0, 0, block_selected, block_selected); - std::vector > - dofs_per_block(tr.n_levels(), std::vector(2)); + std::vector > + dofs_per_block(tr.n_levels(), std::vector(2)); MGTools::count_dofs_per_block(mg_dof_handler, dofs_per_block, block_selected); diff --git a/tests/multigrid/transfer_system_adaptive_08.cc b/tests/multigrid/transfer_system_adaptive_08.cc index 4075fde994..e6e307ce4a 100644 --- a/tests/multigrid/transfer_system_adaptive_08.cc +++ b/tests/multigrid/transfer_system_adaptive_08.cc @@ -149,7 +149,7 @@ void check (const FiniteElement& fe) DoFRenumbering::component_wise (mg_dof_handler, level, block_selected); - std::vector > boundary_indices(tr.n_levels()); + std::vector > boundary_indices(tr.n_levels()); typename FunctionMap::type dirichlet_boundary; ZeroFunction dirichlet_bc(fe.n_components()); dirichlet_boundary[3] = &dirichlet_bc; @@ -161,8 +161,8 @@ void check (const FiniteElement& fe) transfer.build_matrices(mg_dof_handler, mg_dof_handler, 0, 0, block_selected, block_selected, boundary_indices); - std::vector > - dofs_per_block(tr.n_levels(), std::vector(2)); + std::vector > + dofs_per_block(tr.n_levels(), std::vector(2)); MGTools::count_dofs_per_block(mg_dof_handler, dofs_per_block, block_selected); diff --git a/tests/multigrid/transfer_system_adaptive_09.cc b/tests/multigrid/transfer_system_adaptive_09.cc index f36ed57300..0088a68ce9 100644 --- a/tests/multigrid/transfer_system_adaptive_09.cc +++ b/tests/multigrid/transfer_system_adaptive_09.cc @@ -108,9 +108,10 @@ void check (const FiniteElement& fe, const unsigned int selected_block) selected_block, selected_block, block_component, block_component); - std::vector dofs_per_block(3); + std::vector dofs_per_block(3); DoFTools::count_dofs_per_block(mg_dof_handler, dofs_per_block, block_component); - std::vector > mg_dofs_per_block(tr.n_levels(), std::vector(3)); + std::vector > mg_dofs_per_block(tr.n_levels(), + std::vector(3)); MGTools::count_dofs_per_block(mg_dof_handler, mg_dofs_per_block, block_component); deallog << "Global dofs:"; diff --git a/tests/serialization/dof_handler_01.cc b/tests/serialization/dof_handler_01.cc index a218b2f7b8..159f5aad00 100644 --- a/tests/serialization/dof_handler_01.cc +++ b/tests/serialization/dof_handler_01.cc @@ -86,8 +86,8 @@ namespace dealii // compare dofs on this cell and then on the faces if (c1->has_children() == false) { - std::vector local_dofs_1 (c1->get_fe().dofs_per_cell); - std::vector local_dofs_2 (c2->get_fe().dofs_per_cell); + std::vector local_dofs_1 (c1->get_fe().dofs_per_cell); + std::vector local_dofs_2 (c2->get_fe().dofs_per_cell); c1->get_dof_indices (local_dofs_1); c2->get_dof_indices (local_dofs_2); @@ -96,8 +96,8 @@ namespace dealii for (unsigned int f=0; f::faces_per_cell; ++f) { - std::vector local_dofs_1 (c1->get_fe().dofs_per_face); - std::vector local_dofs_2 (c2->get_fe().dofs_per_face); + std::vector local_dofs_1 (c1->get_fe().dofs_per_face); + std::vector local_dofs_2 (c2->get_fe().dofs_per_face); c1->face(f)->get_dof_indices (local_dofs_1); c2->face(f)->get_dof_indices (local_dofs_2);