From: turcksin Date: Thu, 14 Mar 2013 15:21:28 +0000 (+0000) Subject: Fix bug introduced in revision 28895 and change the steps in examples to work with... X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=a70f9b5ec8751484e583a4f787a5a8dae33a022b;p=dealii-svn.git Fix bug introduced in revision 28895 and change the steps in examples to work with types::global_dof_index. git-svn-id: https://svn.dealii.org/branches/branch_bigger_global_dof_indices_4@28903 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/examples/step-13/step-13.cc b/deal.II/examples/step-13/step-13.cc index 054b3b5f79..bc0412e6a5 100644 --- a/deal.II/examples/step-13/step-13.cc +++ b/deal.II/examples/step-13/step-13.cc @@ -765,7 +765,7 @@ namespace Step13 // And while we're already computing things in parallel, interpolating // boundary values is one more thing that can be done independently, so // we do it here: - std::map boundary_value_map; + std::map boundary_value_map; VectorTools::interpolate_boundary_values (dof_handler, 0, *boundary_values, @@ -807,7 +807,7 @@ namespace Step13 FullMatrix cell_matrix (dofs_per_cell, dofs_per_cell); - std::vector local_dof_indices (dofs_per_cell); + std::vector local_dof_indices (dofs_per_cell); for (typename DoFHandler::active_cell_iterator cell=begin_cell; cell!=end_cell; ++cell) @@ -1026,7 +1026,7 @@ namespace Step13 Vector cell_rhs (dofs_per_cell); std::vector rhs_values (n_q_points); - std::vector local_dof_indices (dofs_per_cell); + std::vector local_dof_indices (dofs_per_cell); typename DoFHandler::active_cell_iterator cell = this->dof_handler.begin_active(), diff --git a/deal.II/examples/step-14/step-14.cc b/deal.II/examples/step-14/step-14.cc index 9536e7d82c..7c26dd5c6a 100644 --- a/deal.II/examples/step-14/step-14.cc +++ b/deal.II/examples/step-14/step-14.cc @@ -554,7 +554,7 @@ namespace Step14 assemble_rhs (linear_system.rhs); linear_system.hanging_node_constraints.condense (linear_system.rhs); - std::map boundary_value_map; + std::map boundary_value_map; VectorTools::interpolate_boundary_values (dof_handler, 0, *boundary_values, @@ -585,7 +585,7 @@ namespace Step14 FullMatrix cell_matrix (dofs_per_cell, dofs_per_cell); - std::vector local_dof_indices (dofs_per_cell); + std::vector local_dof_indices (dofs_per_cell); for (typename DoFHandler::active_cell_iterator cell=begin_cell; cell!=end_cell; ++cell) @@ -806,7 +806,7 @@ namespace Step14 Vector cell_rhs (dofs_per_cell); std::vector rhs_values (n_q_points); - std::vector local_dof_indices (dofs_per_cell); + std::vector local_dof_indices (dofs_per_cell); typename DoFHandler::active_cell_iterator cell = this->dof_handler.begin_active(), diff --git a/deal.II/examples/step-15/step-15.cc b/deal.II/examples/step-15/step-15.cc index 098be10b69..5a8890056c 100644 --- a/deal.II/examples/step-15/step-15.cc +++ b/deal.II/examples/step-15/step-15.cc @@ -243,7 +243,7 @@ namespace Step15 std::vector > old_solution_gradients(n_q_points); - std::vector local_dof_indices (dofs_per_cell); + std::vector local_dof_indices (dofs_per_cell); typename DoFHandler::active_cell_iterator cell = dof_handler.begin_active(), @@ -323,7 +323,7 @@ namespace Step15 hanging_node_constraints.condense (system_matrix); hanging_node_constraints.condense (system_rhs); - std::map boundary_values; + std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, ZeroFunction(), @@ -464,12 +464,12 @@ namespace Step15 template void MinimalSurfaceProblem::set_boundary_values () { - std::map boundary_values; + std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, BoundaryValues(), boundary_values); - for (std::map::const_iterator + for (std::map::const_iterator p = boundary_values.begin(); p != boundary_values.end(); ++p) present_solution(p->first) = p->second; @@ -514,7 +514,7 @@ namespace Step15 Vector cell_rhs (dofs_per_cell); std::vector > gradients(n_q_points); - std::vector local_dof_indices (dofs_per_cell); + std::vector local_dof_indices (dofs_per_cell); typename DoFHandler::active_cell_iterator cell = dof_handler.begin_active(), diff --git a/deal.II/examples/step-16/step-16.cc b/deal.II/examples/step-16/step-16.cc index 8ebda66254..25f909eb02 100644 --- a/deal.II/examples/step-16/step-16.cc +++ b/deal.II/examples/step-16/step-16.cc @@ -367,7 +367,7 @@ namespace Step16 FullMatrix cell_matrix (dofs_per_cell, dofs_per_cell); Vector cell_rhs (dofs_per_cell); - std::vector local_dof_indices (dofs_per_cell); + std::vector local_dof_indices (dofs_per_cell); const Coefficient coefficient; std::vector coefficient_values (n_q_points); @@ -433,7 +433,7 @@ namespace Step16 FullMatrix cell_matrix (dofs_per_cell, dofs_per_cell); - std::vector local_dof_indices (dofs_per_cell); + std::vector local_dof_indices (dofs_per_cell); const Coefficient coefficient; std::vector coefficient_values (n_q_points); diff --git a/deal.II/examples/step-17/step-17.cc b/deal.II/examples/step-17/step-17.cc index f90d693cab..b099e1980b 100644 --- a/deal.II/examples/step-17/step-17.cc +++ b/deal.II/examples/step-17/step-17.cc @@ -298,7 +298,7 @@ namespace Step17 // While we're at it, let us also count how many degrees of freedom there // exist on the present process: - const unsigned int n_local_dofs + const types::global_dof_index n_local_dofs = DoFTools::count_dofs_with_subdomain_association (dof_handler, this_mpi_process); @@ -390,7 +390,7 @@ namespace Step17 FullMatrix cell_matrix (dofs_per_cell, dofs_per_cell); Vector cell_rhs (dofs_per_cell); - std::vector local_dof_indices (dofs_per_cell); + std::vector local_dof_indices (dofs_per_cell); std::vector lambda_values (n_q_points); std::vector mu_values (n_q_points); @@ -517,7 +517,7 @@ namespace Step17 // // However, we still have to apply boundary values, in the same way as we // always do: - std::map boundary_values; + std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, ZeroFunction(dim), diff --git a/deal.II/examples/step-20/step-20.cc b/deal.II/examples/step-20/step-20.cc index cea600c2d7..4101153ee3 100644 --- a/deal.II/examples/step-20/step-20.cc +++ b/deal.II/examples/step-20/step-20.cc @@ -330,7 +330,7 @@ namespace Step20 // of pressure variables equals the number of shape functions that are // nonzero in the dim-th component. Let us compute these numbers and then // create some nice output with that: - std::vector dofs_per_component (dim+1); + std::vector dofs_per_component (dim+1); DoFTools::count_dofs_per_component (dof_handler, dofs_per_component); const unsigned int n_u = dofs_per_component[0], n_p = dofs_per_component[dim]; @@ -422,7 +422,7 @@ namespace Step20 FullMatrix local_matrix (dofs_per_cell, dofs_per_cell); Vector local_rhs (dofs_per_cell); - std::vector local_dof_indices (dofs_per_cell); + std::vector local_dof_indices (dofs_per_cell); // The next step is to declare objects that represent the source term, // pressure boundary value, and coefficient in the equation. In addition diff --git a/deal.II/examples/step-21/step-21.cc b/deal.II/examples/step-21/step-21.cc index bd22cb396b..bbddc8de03 100644 --- a/deal.II/examples/step-21/step-21.cc +++ b/deal.II/examples/step-21/step-21.cc @@ -477,7 +477,7 @@ namespace Step21 void InverseMatrix::vmult (Vector &dst, const Vector &src) const { - SolverControl solver_control (std::max(src.size(), 200U), + SolverControl solver_control (std::max(src.size(), static_cast 200), 1e-8*src.l2_norm()); SolverCG<> cg (solver_control); @@ -606,7 +606,7 @@ namespace Step21 dof_handler.distribute_dofs (fe); DoFRenumbering::component_wise (dof_handler); - std::vector dofs_per_component (dim+2); + std::vector dofs_per_component (dim+2); DoFTools::count_dofs_per_component (dof_handler, dofs_per_component); const unsigned int n_u = dofs_per_component[0], n_p = dofs_per_component[dim], @@ -704,7 +704,7 @@ namespace Step21 FullMatrix local_matrix (dofs_per_cell, dofs_per_cell); Vector local_rhs (dofs_per_cell); - std::vector local_dof_indices (dofs_per_cell); + std::vector local_dof_indices (dofs_per_cell); const PressureRightHandSide pressure_right_hand_side; const PressureBoundaryValues pressure_boundary_values; @@ -863,7 +863,7 @@ namespace Step21 std::vector > present_solution_values_face(n_face_q_points, Vector(dim+2)); std::vector neighbor_saturation (n_face_q_points); - std::vector local_dof_indices (dofs_per_cell); + std::vector local_dof_indices (dofs_per_cell); SaturationBoundaryValues saturation_boundary_values; diff --git a/deal.II/examples/step-22/step-22.cc b/deal.II/examples/step-22/step-22.cc index 3e8f8563b5..8e30a64059 100644 --- a/deal.II/examples/step-22/step-22.cc +++ b/deal.II/examples/step-22/step-22.cc @@ -481,7 +481,7 @@ namespace Step22 // DoFTools::count_dofs_per_block does the same as // DoFTools::count_dofs_per_component, but now grouped as // velocity and pressure block via 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_u = dofs_per_block[0], n_p = dofs_per_block[1]; @@ -593,7 +593,7 @@ namespace Step22 FullMatrix local_matrix (dofs_per_cell, dofs_per_cell); Vector local_rhs (dofs_per_cell); - std::vector local_dof_indices (dofs_per_cell); + std::vector local_dof_indices (dofs_per_cell); const RightHandSide right_hand_side; std::vector > rhs_values (n_q_points, diff --git a/deal.II/examples/step-23/step-23.cc b/deal.II/examples/step-23/step-23.cc index b8c35a0eb0..331c3b1bd4 100644 --- a/deal.II/examples/step-23/step-23.cc +++ b/deal.II/examples/step-23/step-23.cc @@ -542,7 +542,7 @@ namespace Step23 BoundaryValuesU boundary_values_u_function; boundary_values_u_function.set_time (time); - std::map boundary_values; + std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, boundary_values_u_function, @@ -588,7 +588,7 @@ namespace Step23 BoundaryValuesV boundary_values_v_function; boundary_values_v_function.set_time (time); - std::map boundary_values; + std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, boundary_values_v_function, diff --git a/deal.II/examples/step-24/step-24.cc b/deal.II/examples/step-24/step-24.cc index 45b3871515..42d49c6fe1 100644 --- a/deal.II/examples/step-24/step-24.cc +++ b/deal.II/examples/step-24/step-24.cc @@ -346,7 +346,7 @@ namespace Step24 FullMatrix cell_matrix (dofs_per_cell, dofs_per_cell); - std::vector local_dof_indices (dofs_per_cell); + std::vector local_dof_indices (dofs_per_cell); diff --git a/deal.II/examples/step-25/step-25.cc b/deal.II/examples/step-25/step-25.cc index 057371fa19..c7e1326ae7 100644 --- a/deal.II/examples/step-25/step-25.cc +++ b/deal.II/examples/step-25/step-25.cc @@ -413,7 +413,7 @@ namespace Step25 const unsigned int n_q_points = quadrature_formula.size(); Vector local_nl_term (dofs_per_cell); - std::vector local_dof_indices (dofs_per_cell); + std::vector local_dof_indices (dofs_per_cell); std::vector old_data_values (n_q_points); std::vector new_data_values (n_q_points); @@ -475,7 +475,7 @@ namespace Step25 const unsigned int n_q_points = quadrature_formula.size(); FullMatrix local_nl_matrix (dofs_per_cell, dofs_per_cell); - std::vector local_dof_indices (dofs_per_cell); + std::vector local_dof_indices (dofs_per_cell); std::vector old_data_values (n_q_points); std::vector new_data_values (n_q_points); diff --git a/deal.II/examples/step-26/step-26.cc b/deal.II/examples/step-26/step-26.cc index 25ebd7f654..a4107b9803 100644 --- a/deal.II/examples/step-26/step-26.cc +++ b/deal.II/examples/step-26/step-26.cc @@ -515,7 +515,7 @@ namespace Step26 system_matrix); system_rhs = 0; - std::map boundary_values; + std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, BoundaryValues(), diff --git a/deal.II/examples/step-27/step-27.cc b/deal.II/examples/step-27/step-27.cc index 2ebbd9fa4d..8400b3c6e7 100644 --- a/deal.II/examples/step-27/step-27.cc +++ b/deal.II/examples/step-27/step-27.cc @@ -269,7 +269,7 @@ namespace Step27 FullMatrix cell_matrix; Vector cell_rhs; - std::vector local_dof_indices; + std::vector local_dof_indices; typename hp::DoFHandler::active_cell_iterator cell = dof_handler.begin_active(), diff --git a/deal.II/examples/step-28/step-28.cc b/deal.II/examples/step-28/step-28.cc index 049d63568e..fe9100ccda 100644 --- a/deal.II/examples/step-28/step-28.cc +++ b/deal.II/examples/step-28/step-28.cc @@ -492,7 +492,7 @@ namespace Step28 Vector system_rhs; - std::map boundary_values; + std::map boundary_values; ConstraintMatrix hanging_node_constraints; @@ -667,7 +667,7 @@ namespace Step28 FullMatrix cell_matrix (dofs_per_cell, dofs_per_cell); Vector cell_rhs (dofs_per_cell); - std::vector local_dof_indices (dofs_per_cell); + std::vector local_dof_indices (dofs_per_cell); typename DoFHandler::active_cell_iterator cell = dof_handler.begin_active(), @@ -743,7 +743,7 @@ namespace Step28 std::vector extraneous_source_values (n_q_points); std::vector solution_old_values (n_q_points); - std::vector local_dof_indices (dofs_per_cell); + std::vector local_dof_indices (dofs_per_cell); typename DoFHandler::active_cell_iterator cell = dof_handler.begin_active(), @@ -941,7 +941,7 @@ namespace Step28 prolongation_matrix.Tvmult_add (cell_rhs, tmp); } - std::vector local_dof_indices (fe.dofs_per_cell); + std::vector local_dof_indices (fe.dofs_per_cell); cell_g->get_dof_indices (local_dof_indices); for (unsigned int i=0; i void NeutronDiffusionProblem::refine_grid () { - std::vector n_cells (parameters.n_groups); + std::vector n_cells (parameters.n_groups); for (unsigned int group=0; groupn_active_cells(); diff --git a/deal.II/examples/step-29/step-29.cc b/deal.II/examples/step-29/step-29.cc index b97a0558b7..5c428f66ef 100644 --- a/deal.II/examples/step-29/step-29.cc +++ b/deal.II/examples/step-29/step-29.cc @@ -602,7 +602,7 @@ namespace Step29 // vector to transfer the cell contributions to the appropriate location // in the global system matrix after. FullMatrix cell_matrix (dofs_per_cell, dofs_per_cell); - std::vector local_dof_indices (dofs_per_cell); + std::vector local_dof_indices (dofs_per_cell); typename DoFHandler::active_cell_iterator cell = dof_handler.begin_active(), @@ -769,7 +769,7 @@ namespace Step29 // which is characterized by the boundary indicator 1. The Dirichlet // values are provided by the DirichletBoundaryValues class // we defined above: - std::map boundary_values; + std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 1, DirichletBoundaryValues(), diff --git a/deal.II/examples/step-3/step-3.cc b/deal.II/examples/step-3/step-3.cc index 7a991c7211..7d83c5211c 100644 --- a/deal.II/examples/step-3/step-3.cc +++ b/deal.II/examples/step-3/step-3.cc @@ -334,7 +334,7 @@ void Step3::assemble_system () // global matrix, we have to know the global numbers of the degrees of // freedom. When we query them, we need a scratch (temporary) array for // these numbers: - std::vector local_dof_indices (dofs_per_cell); + std::vector local_dof_indices (dofs_per_cell); // Now for the loop over all cells. We have seen before how this works, so // this should be familiar including the conventional names for these @@ -458,7 +458,7 @@ void Step3::assemble_system () // their boundary values (which are zero here for all entries). This mapping // of DoF numbers to boundary values is done by the std::map // class. - std::map boundary_values; + std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, ZeroFunction<2>(), diff --git a/deal.II/examples/step-30/step-30.cc b/deal.II/examples/step-30/step-30.cc index e9eeca97e6..4319302767 100644 --- a/deal.II/examples/step-30/step-30.cc +++ b/deal.II/examples/step-30/step-30.cc @@ -426,8 +426,8 @@ namespace Step30 void DGMethod::assemble_system2 () { const unsigned int dofs_per_cell = dof_handler.get_fe().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/deal.II/examples/step-34/step-34.cc b/deal.II/examples/step-34/step-34.cc index e5b9c78bb2..08b3a319d9 100644 --- a/deal.II/examples/step-34/step-34.cc +++ b/deal.II/examples/step-34/step-34.cc @@ -553,7 +553,7 @@ namespace Step34 const unsigned int n_q_points = fe_v.n_quadrature_points; - std::vector local_dof_indices(fe.dofs_per_cell); + std::vector local_dof_indices(fe.dofs_per_cell); std::vector > cell_wind(n_q_points, Vector(dim) ); double normal_wind; @@ -932,7 +932,7 @@ namespace Step34 const unsigned int n_q_points = fe_v.n_quadrature_points; - std::vector dofs(fe.dofs_per_cell); + std::vector dofs(fe.dofs_per_cell); std::vector local_phi(n_q_points); std::vector normal_wind(n_q_points); diff --git a/deal.II/examples/step-35/step-35.cc b/deal.II/examples/step-35/step-35.cc index d5fffbf38e..b8663462a2 100644 --- a/deal.II/examples/step-35/step-35.cc +++ b/deal.II/examples/step-35/step-35.cc @@ -402,7 +402,7 @@ namespace Step35 const double t_0, T, Re; EquationData::Velocity vel_exact; - std::map boundary_values; + std::map boundary_values; std::vector boundary_indicators; Triangulation triangulation; @@ -516,8 +516,8 @@ namespace Step35 unsigned int vel_dpc; unsigned int pres_dpc; FullMatrix local_grad; - std::vector vel_local_dof_indices; - std::vector pres_local_dof_indices; + std::vector vel_local_dof_indices; + std::vector pres_local_dof_indices; InitGradPerTaskData (const unsigned int dd, const unsigned int vdpc, @@ -572,7 +572,7 @@ namespace Step35 struct AdvectionPerTaskData { FullMatrix local_advection; - std::vector local_dof_indices; + std::vector local_dof_indices; AdvectionPerTaskData (const unsigned int dpc) : local_advection (dpc, dpc), @@ -1192,7 +1192,7 @@ namespace Step35 phi_n_minus_1 = phi_n; - static std::map bval; + static std::map bval; if (reinit_prec) VectorTools::interpolate_boundary_values (dof_handler_pressure, 3, ZeroFunction(), bval); @@ -1276,7 +1276,7 @@ namespace Step35 dof_handler_pressure.n_dofs()), ExcInternalError()); static Vector joint_solution (joint_dof_handler.n_dofs()); - std::vector loc_joint_dof_indices (joint_fe.dofs_per_cell), + std::vector loc_joint_dof_indices (joint_fe.dofs_per_cell), loc_vel_dof_indices (fe_velocity.dofs_per_cell), loc_pres_dof_indices (fe_pressure.dofs_per_cell); typename DoFHandler::active_cell_iterator @@ -1361,7 +1361,7 @@ namespace Step35 update_values); const unsigned int dpc = fe_velocity.dofs_per_cell, nqp = quadrature_velocity.size(); - std::vector ldi (dpc); + std::vector ldi (dpc); Vector loc_rot (dpc); std::vector< Tensor<1,dim> > grad_u1 (nqp), grad_u2 (nqp); diff --git a/deal.II/examples/step-38/step-38.cc b/deal.II/examples/step-38/step-38.cc index e9891e7d4a..3071898f6d 100644 --- a/deal.II/examples/step-38/step-38.cc +++ b/deal.II/examples/step-38/step-38.cc @@ -374,7 +374,7 @@ namespace Step38 Vector cell_rhs (dofs_per_cell); std::vector rhs_values(n_q_points); - std::vector local_dof_indices (dofs_per_cell); + std::vector local_dof_indices (dofs_per_cell); const RightHandSide rhs; @@ -415,7 +415,7 @@ namespace Step38 } } - std::map boundary_values; + std::map boundary_values; VectorTools::interpolate_boundary_values (mapping, dof_handler, 0, diff --git a/deal.II/examples/step-4/step-4.cc b/deal.II/examples/step-4/step-4.cc index a39f1010f9..ade3b41bfc 100644 --- a/deal.II/examples/step-4/step-4.cc +++ b/deal.II/examples/step-4/step-4.cc @@ -400,7 +400,7 @@ void Step4::assemble_system () // task, we only have to replace the ZeroFunction used there by an object of // the class which describes the boundary values we would like to use // (i.e. the BoundaryValues class declared above): - std::map boundary_values; + std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, BoundaryValues(), diff --git a/deal.II/examples/step-45/step-45.cc b/deal.II/examples/step-45/step-45.cc index f876aa75ed..d2e11901f1 100644 --- a/deal.II/examples/step-45/step-45.cc +++ b/deal.II/examples/step-45/step-45.cc @@ -316,7 +316,7 @@ namespace Step45 FullMatrix cell_matrix (dofs_per_cell, dofs_per_cell); Vector cell_rhs (dofs_per_cell); - std::vector local_dof_indices (dofs_per_cell); + std::vector local_dof_indices (dofs_per_cell); const RightHandSide right_hand_side; diff --git a/deal.II/examples/step-46/step-46.cc b/deal.II/examples/step-46/step-46.cc index ffd556b8f5..7fdc20b2a8 100644 --- a/deal.II/examples/step-46/step-46.cc +++ b/deal.II/examples/step-46/step-46.cc @@ -400,7 +400,7 @@ namespace Step46 // solid. The following piece of code was already presented in the // introduction: { - std::vector local_face_dof_indices (stokes_fe.dofs_per_face); + std::vector local_face_dof_indices (stokes_fe.dofs_per_face); for (typename hp::DoFHandler::active_cell_iterator cell = dof_handler.begin_active(); cell != dof_handler.end(); ++cell) @@ -544,8 +544,8 @@ namespace Step46 stokes_dofs_per_cell); Vector local_rhs; - std::vector local_dof_indices; - std::vector neighbor_dof_indices (stokes_dofs_per_cell); + std::vector local_dof_indices; + std::vector neighbor_dof_indices (stokes_dofs_per_cell); const RightHandSide right_hand_side; diff --git a/deal.II/examples/step-5/step-5.cc b/deal.II/examples/step-5/step-5.cc index 7b36606830..18dfd8036e 100644 --- a/deal.II/examples/step-5/step-5.cc +++ b/deal.II/examples/step-5/step-5.cc @@ -387,7 +387,7 @@ void Step5::assemble_system () } // With the matrix so built, we use zero boundary values again: - std::map boundary_values; + std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, ZeroFunction(), diff --git a/deal.II/examples/step-7/step-7.cc b/deal.II/examples/step-7/step-7.cc index 8e0d0bde14..85393fd733 100644 --- a/deal.II/examples/step-7/step-7.cc +++ b/deal.II/examples/step-7/step-7.cc @@ -563,7 +563,7 @@ namespace Step7 FullMatrix cell_matrix (dofs_per_cell, dofs_per_cell); Vector cell_rhs (dofs_per_cell); - std::vector local_dof_indices (dofs_per_cell); + std::vector local_dof_indices (dofs_per_cell); // Then we need objects which can evaluate the values, gradients, etc of // the shape functions at the quadrature points. While it seems that it @@ -722,7 +722,7 @@ namespace Step7 hanging_node_constraints.condense (system_matrix); hanging_node_constraints.condense (system_rhs); - std::map boundary_values; + std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, Solution(), diff --git a/deal.II/examples/step-8/step-8.cc b/deal.II/examples/step-8/step-8.cc index 2b75487b3e..9bbacd9d1f 100644 --- a/deal.II/examples/step-8/step-8.cc +++ b/deal.II/examples/step-8/step-8.cc @@ -380,7 +380,7 @@ namespace Step8 FullMatrix cell_matrix (dofs_per_cell, dofs_per_cell); Vector cell_rhs (dofs_per_cell); - std::vector local_dof_indices (dofs_per_cell); + std::vector local_dof_indices (dofs_per_cell); // As was shown in previous examples as well, we need a place where to // store the values of the coefficients at all the quadrature points on a @@ -548,7 +548,7 @@ namespace Step8 // object would represent a scalar function. Since the solution vector has // dim components, we need to pass dim as number // of components to the zero function as well. - std::map boundary_values; + std::map boundary_values; VectorTools::interpolate_boundary_values (dof_handler, 0, ZeroFunction(dim), diff --git a/deal.II/examples/step-9/step-9.cc b/deal.II/examples/step-9/step-9.cc index 9a9bef8698..b5589551e5 100644 --- a/deal.II/examples/step-9/step-9.cc +++ b/deal.II/examples/step-9/step-9.cc @@ -685,7 +685,7 @@ namespace Step9 // ... an array to hold the global indices of the degrees of freedom of // the cell on which we are presently working... - std::vector local_dof_indices (dofs_per_cell); + std::vector local_dof_indices (dofs_per_cell); // ... and array in which the values of right hand side, advection // direction, and boundary values will be stored, for cell and face diff --git a/deal.II/include/deal.II/base/mpi.h b/deal.II/include/deal.II/base/mpi.h index 8629515cc1..cc09b776a4 100644 --- a/deal.II/include/deal.II/base/mpi.h +++ b/deal.II/include/deal.II/base/mpi.h @@ -365,12 +365,6 @@ namespace Utilities } - inline MPI_Datatype mpi_type_id (const unsigned long long int *) - { - return MPI_UNSIGNED_LONG; - } - - inline MPI_Datatype mpi_type_id (const unsigned long long int *) { return MPI_UNSIGNED_LONG_LONG; diff --git a/deal.II/include/deal.II/base/types.h b/deal.II/include/deal.II/base/types.h index 2e4c516020..544178d172 100644 --- a/deal.II/include/deal.II/base/types.h +++ b/deal.II/include/deal.II/base/types.h @@ -52,7 +52,7 @@ namespace types */ const unsigned int artificial_subdomain_id DEAL_II_DEPRECATED = static_cast(-2); -#define DEAL_II_USE_LARGE_INDEX_TYPE +//#define DEAL_II_USE_LARGE_INDEX_TYPE #ifdef DEAL_II_USE_LARGE_INDEX_TYPE /** * The type used for global indices of diff --git a/deal.II/source/base/utilities.cc b/deal.II/source/base/utilities.cc index ab8dd4af9c..6132d45762 100644 --- a/deal.II/source/base/utilities.cc +++ b/deal.II/source/base/utilities.cc @@ -479,7 +479,7 @@ namespace Utilities std::vector - invert_permutation (const std::vector &permutation) + invert_permutation (const std::vector &permutation) { const unsigned long long int n = permutation.size();