]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Fix bug introduced in revision 28895 and change the steps in examples to work with...
authorturcksin <turcksin@0785d39b-7218-0410-832d-ea1e28bc413d>
Thu, 14 Mar 2013 15:21:28 +0000 (15:21 +0000)
committerturcksin <turcksin@0785d39b-7218-0410-832d-ea1e28bc413d>
Thu, 14 Mar 2013 15:21:28 +0000 (15:21 +0000)
git-svn-id: https://svn.dealii.org/branches/branch_bigger_global_dof_indices_4@28903 0785d39b-7218-0410-832d-ea1e28bc413d

30 files changed:
deal.II/examples/step-13/step-13.cc
deal.II/examples/step-14/step-14.cc
deal.II/examples/step-15/step-15.cc
deal.II/examples/step-16/step-16.cc
deal.II/examples/step-17/step-17.cc
deal.II/examples/step-20/step-20.cc
deal.II/examples/step-21/step-21.cc
deal.II/examples/step-22/step-22.cc
deal.II/examples/step-23/step-23.cc
deal.II/examples/step-24/step-24.cc
deal.II/examples/step-25/step-25.cc
deal.II/examples/step-26/step-26.cc
deal.II/examples/step-27/step-27.cc
deal.II/examples/step-28/step-28.cc
deal.II/examples/step-29/step-29.cc
deal.II/examples/step-3/step-3.cc
deal.II/examples/step-30/step-30.cc
deal.II/examples/step-34/step-34.cc
deal.II/examples/step-35/step-35.cc
deal.II/examples/step-38/step-38.cc
deal.II/examples/step-4/step-4.cc
deal.II/examples/step-45/step-45.cc
deal.II/examples/step-46/step-46.cc
deal.II/examples/step-5/step-5.cc
deal.II/examples/step-7/step-7.cc
deal.II/examples/step-8/step-8.cc
deal.II/examples/step-9/step-9.cc
deal.II/include/deal.II/base/mpi.h
deal.II/include/deal.II/base/types.h
deal.II/source/base/utilities.cc

index 054b3b5f79658cae0041cd4e7225fda1cd857db7..bc0412e6a5f87d8c41024dec78097bf278a2f33f 100644 (file)
@@ -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<unsigned int,double> boundary_value_map;
+      std::map<types::global_dof_index,double> boundary_value_map;
       VectorTools::interpolate_boundary_values (dof_handler,
                                                 0,
                                                 *boundary_values,
@@ -807,7 +807,7 @@ namespace Step13
 
       FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
 
-      std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+      std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
       for (typename DoFHandler<dim>::active_cell_iterator cell=begin_cell;
            cell!=end_cell; ++cell)
@@ -1026,7 +1026,7 @@ namespace Step13
 
       Vector<double>       cell_rhs (dofs_per_cell);
       std::vector<double>  rhs_values (n_q_points);
-      std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+      std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
       typename DoFHandler<dim>::active_cell_iterator
       cell = this->dof_handler.begin_active(),
index 9536e7d82c1715699e6fe37f19b787b450d2fe6e..7c26dd5c6aea4d45086b5097dac74504c5925f96 100644 (file)
@@ -554,7 +554,7 @@ namespace Step14
       assemble_rhs (linear_system.rhs);
       linear_system.hanging_node_constraints.condense (linear_system.rhs);
 
-      std::map<unsigned int,double> boundary_value_map;
+      std::map<types::global_dof_index,double> boundary_value_map;
       VectorTools::interpolate_boundary_values (dof_handler,
                                                 0,
                                                 *boundary_values,
@@ -585,7 +585,7 @@ namespace Step14
 
       FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
 
-      std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+      std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
       for (typename DoFHandler<dim>::active_cell_iterator cell=begin_cell;
            cell!=end_cell; ++cell)
@@ -806,7 +806,7 @@ namespace Step14
 
       Vector<double>       cell_rhs (dofs_per_cell);
       std::vector<double>  rhs_values (n_q_points);
-      std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+      std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
       typename DoFHandler<dim>::active_cell_iterator
       cell = this->dof_handler.begin_active(),
index 098be10b69029422bce32154525b176040996c35..5a8890056c0b99e911c9e6680bf9f43d07b868f6 100644 (file)
@@ -243,7 +243,7 @@ namespace Step15
 
     std::vector<Tensor<1, dim> > old_solution_gradients(n_q_points);
 
-    std::vector<unsigned int>    local_dof_indices (dofs_per_cell);
+    std::vector<types::global_dof_index>    local_dof_indices (dofs_per_cell);
 
     typename DoFHandler<dim>::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<unsigned int,double> boundary_values;
+    std::map<types::global_dof_index,double> boundary_values;
     VectorTools::interpolate_boundary_values (dof_handler,
                                               0,
                                               ZeroFunction<dim>(),
@@ -464,12 +464,12 @@ namespace Step15
   template <int dim>
   void MinimalSurfaceProblem<dim>::set_boundary_values ()
   {
-    std::map<unsigned int, double> boundary_values;
+    std::map<types::global_dof_index, double> boundary_values;
     VectorTools::interpolate_boundary_values (dof_handler,
                                               0,
                                               BoundaryValues<dim>(),
                                               boundary_values);
-    for (std::map<unsigned int, double>::const_iterator
+    for (std::map<types::global_dof_index, double>::const_iterator
          p = boundary_values.begin();
          p != boundary_values.end(); ++p)
       present_solution(p->first) = p->second;
@@ -514,7 +514,7 @@ namespace Step15
     Vector<double>               cell_rhs (dofs_per_cell);
     std::vector<Tensor<1, dim> > gradients(n_q_points);
 
-    std::vector<unsigned int>    local_dof_indices (dofs_per_cell);
+    std::vector<types::global_dof_index>    local_dof_indices (dofs_per_cell);
 
     typename DoFHandler<dim>::active_cell_iterator
     cell = dof_handler.begin_active(),
index 8ebda662544baea6333d7950d4c701298a6708bf..25f909eb02b2090fa2bdae5db14b8c913a077f72 100644 (file)
@@ -367,7 +367,7 @@ namespace Step16
     FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
     Vector<double>       cell_rhs (dofs_per_cell);
 
-    std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+    std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
     const Coefficient<dim> coefficient;
     std::vector<double>    coefficient_values (n_q_points);
@@ -433,7 +433,7 @@ namespace Step16
 
     FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
 
-    std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+    std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
     const Coefficient<dim> coefficient;
     std::vector<double>    coefficient_values (n_q_points);
index f90d693cab8fadb55256e265d5ea4e0344d337d7..b099e1980be0fc984bd8ff3e0adcef25b1670651 100644 (file)
@@ -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<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
     Vector<double>       cell_rhs (dofs_per_cell);
 
-    std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+    std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
     std::vector<double>     lambda_values (n_q_points);
     std::vector<double>     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<unsigned int,double> boundary_values;
+    std::map<types::global_dof_index,double> boundary_values;
     VectorTools::interpolate_boundary_values (dof_handler,
                                               0,
                                               ZeroFunction<dim>(dim),
index cea600c2d711f159789066b84b00eb4719d6869b..4101153ee31d6333ae7a90fa6baa1a762f0afb85 100644 (file)
@@ -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<unsigned int> dofs_per_component (dim+1);
+    std::vector<types::global_dof_index> 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<double>   local_matrix (dofs_per_cell, dofs_per_cell);
     Vector<double>       local_rhs (dofs_per_cell);
 
-    std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+    std::vector<types::global_dof_index> 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
index bd22cb396b6ba03462f2080f133417adc109193a..bbddc8de03e990f6a50de88bfffe901c50ca7efe 100644 (file)
@@ -477,7 +477,7 @@ namespace Step21
   void InverseMatrix<Matrix>::vmult (Vector<double>       &dst,
                                      const Vector<double> &src) const
   {
-    SolverControl solver_control (std::max(src.size(), 200U),
+    SolverControl solver_control (std::max(src.size(), static_cast<std::size_t> 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<unsigned int> dofs_per_component (dim+2);
+    std::vector<types::global_dof_index> 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<double>   local_matrix (dofs_per_cell, dofs_per_cell);
     Vector<double>       local_rhs (dofs_per_cell);
 
-    std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+    std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
     const PressureRightHandSide<dim>  pressure_right_hand_side;
     const PressureBoundaryValues<dim> pressure_boundary_values;
@@ -863,7 +863,7 @@ namespace Step21
     std::vector<Vector<double> > present_solution_values_face(n_face_q_points, Vector<double>(dim+2));
 
     std::vector<double> neighbor_saturation (n_face_q_points);
-    std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+    std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
     SaturationBoundaryValues<dim> saturation_boundary_values;
 
index 3e8f8563b5c2d9d0b6f358e1e9a8f4a863f4c911..8e30a640599ad862347408fa2dddf60e4acd18cb 100644 (file)
@@ -481,7 +481,7 @@ namespace Step22
     // <code>DoFTools::count_dofs_per_block</code> does the same as
     // <code>DoFTools::count_dofs_per_component</code>, but now grouped as
     // velocity and pressure block via <code>block_component</code>.
-    std::vector<unsigned int> dofs_per_block (2);
+    std::vector<types::global_dof_index> 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<double>   local_matrix (dofs_per_cell, dofs_per_cell);
     Vector<double>       local_rhs (dofs_per_cell);
 
-    std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+    std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
     const RightHandSide<dim>          right_hand_side;
     std::vector<Vector<double> >      rhs_values (n_q_points,
index b8c35a0eb01130afad141a75ba063bf8757c2e3c..331c3b1bd413ae2ba3f6e10f7df63c533fc6e274 100644 (file)
@@ -542,7 +542,7 @@ namespace Step23
           BoundaryValuesU<dim> boundary_values_u_function;
           boundary_values_u_function.set_time (time);
 
-          std::map<unsigned int,double> boundary_values;
+          std::map<types::global_dof_index,double> boundary_values;
           VectorTools::interpolate_boundary_values (dof_handler,
                                                     0,
                                                     boundary_values_u_function,
@@ -588,7 +588,7 @@ namespace Step23
           BoundaryValuesV<dim> boundary_values_v_function;
           boundary_values_v_function.set_time (time);
 
-          std::map<unsigned int,double> boundary_values;
+          std::map<types::global_dof_index,double> boundary_values;
           VectorTools::interpolate_boundary_values (dof_handler,
                                                     0,
                                                     boundary_values_v_function,
index 45b3871515f6883f0a6e019a4656ff2f7c38b6ac..42d49c6fe18fc8125e96c08401e78bf5993b5295 100644 (file)
@@ -346,7 +346,7 @@ namespace Step24
 
       FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
 
-      std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+      std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
 
 
index 057371fa19b5dbf715585cfdb176370480eee962..c7e1326ae7d105ad24544af4ce1af8c7cfd81de8 100644 (file)
@@ -413,7 +413,7 @@ namespace Step25
     const unsigned int n_q_points    = quadrature_formula.size();
 
     Vector<double> local_nl_term (dofs_per_cell);
-    std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+    std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
     std::vector<double> old_data_values (n_q_points);
     std::vector<double> new_data_values (n_q_points);
 
@@ -475,7 +475,7 @@ namespace Step25
     const unsigned int n_q_points    = quadrature_formula.size();
 
     FullMatrix<double> local_nl_matrix (dofs_per_cell, dofs_per_cell);
-    std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+    std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
     std::vector<double> old_data_values (n_q_points);
     std::vector<double> new_data_values (n_q_points);
 
index 25ebd7f654bf804107b40f69ef834e3788d7a19f..a4107b9803276e5784993353e63708f5d4058ae9 100644 (file)
@@ -515,7 +515,7 @@ namespace Step26
                                         system_matrix);
     system_rhs = 0;
 
-    std::map<unsigned int,double> boundary_values;
+    std::map<types::global_dof_index,double> boundary_values;
     VectorTools::interpolate_boundary_values (dof_handler,
                                               0,
                                               BoundaryValues<dim>(),
index 2ebbd9fa4d02ce320546455c8923e59e112d1fcb..8400b3c6e75b1a8841d436580f6165e653190b1f 100644 (file)
@@ -269,7 +269,7 @@ namespace Step27
     FullMatrix<double>   cell_matrix;
     Vector<double>       cell_rhs;
 
-    std::vector<unsigned int> local_dof_indices;
+    std::vector<types::global_dof_index> local_dof_indices;
 
     typename hp::DoFHandler<dim>::active_cell_iterator
     cell = dof_handler.begin_active(),
index 049d63568e5c2789781e05f4a73425110413febe..fe9100ccdac3220b6569fec74c815e935cb66beb 100644 (file)
@@ -492,7 +492,7 @@ namespace Step28
 
     Vector<double>                system_rhs;
 
-    std::map<unsigned int,double> boundary_values;
+    std::map<types::global_dof_index,double> boundary_values;
     ConstraintMatrix              hanging_node_constraints;
 
 
@@ -667,7 +667,7 @@ namespace Step28
     FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
     Vector<double>     cell_rhs (dofs_per_cell);
 
-    std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+    std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
     typename DoFHandler<dim>::active_cell_iterator
     cell = dof_handler.begin_active(),
@@ -743,7 +743,7 @@ namespace Step28
     std::vector<double>       extraneous_source_values (n_q_points);
     std::vector<double>       solution_old_values (n_q_points);
 
-    std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+    std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
     typename DoFHandler<dim>::active_cell_iterator
     cell = dof_handler.begin_active(),
@@ -941,7 +941,7 @@ namespace Step28
             prolongation_matrix.Tvmult_add (cell_rhs, tmp);
           }
 
-        std::vector<unsigned int> local_dof_indices (fe.dofs_per_cell);
+        std::vector<types::global_dof_index> local_dof_indices (fe.dofs_per_cell);
         cell_g->get_dof_indices (local_dof_indices);
 
         for (unsigned int i=0; i<fe.dofs_per_cell; ++i)
@@ -1580,7 +1580,7 @@ namespace Step28
   template <int dim>
   void NeutronDiffusionProblem<dim>::refine_grid ()
   {
-    std::vector<unsigned int> n_cells (parameters.n_groups);
+    std::vector<types::global_dof_index> n_cells (parameters.n_groups);
     for (unsigned int group=0; group<parameters.n_groups; ++group)
       n_cells[group] = energy_groups[group]->n_active_cells();
 
index b97a0558b7bcbf4125278640f1394f0294421846..5c428f66efa7bcae47c1f62f3390b5f5d3e83689 100644 (file)
@@ -602,7 +602,7 @@ namespace Step29
     // vector to transfer the cell contributions to the appropriate location
     // in the global system matrix after.
     FullMatrix<double> cell_matrix (dofs_per_cell, dofs_per_cell);
-    std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+    std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
     typename DoFHandler<dim>::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 <code>DirichletBoundaryValues</code> class
     // we defined above:
-    std::map<unsigned int,double> boundary_values;
+    std::map<types::global_dof_index,double> boundary_values;
     VectorTools::interpolate_boundary_values (dof_handler,
                                               1,
                                               DirichletBoundaryValues<dim>(),
index 7a991c7211649a7531d3e4d26c74cf5a2771acdc..7d83c5211cd33c79b9f1e7fa75ecfde4e44a0767 100644 (file)
@@ -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<unsigned int> local_dof_indices (dofs_per_cell);
+  std::vector<types::global_dof_index> 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 <code>std::map</code>
   // class.
-  std::map<unsigned int,double> boundary_values;
+  std::map<types::global_dof_index,double> boundary_values;
   VectorTools::interpolate_boundary_values (dof_handler,
                                             0,
                                             ZeroFunction<2>(),
index e9eeca97e6af7f8ee06481648bde73fc419d9f4e..4319302767602eb9078c2ab4aad98fafb1397d17 100644 (file)
@@ -426,8 +426,8 @@ namespace Step30
   void DGMethod<dim>::assemble_system2 ()
   {
     const unsigned int dofs_per_cell = dof_handler.get_fe().dofs_per_cell;
-    std::vector<unsigned int> dofs (dofs_per_cell);
-    std::vector<unsigned int> dofs_neighbor (dofs_per_cell);
+    std::vector<types::global_dof_index> dofs (dofs_per_cell);
+    std::vector<types::global_dof_index> dofs_neighbor (dofs_per_cell);
 
     const UpdateFlags update_flags = update_values
                                      | update_gradients
index e5b9c78bb25fb61e6bd7bf2be66a7d7e52214028..08b3a319d9984a7db378fa492bc6ae7c52111ecb 100644 (file)
@@ -553,7 +553,7 @@ namespace Step34
 
     const unsigned int n_q_points = fe_v.n_quadrature_points;
 
-    std::vector<unsigned int> local_dof_indices(fe.dofs_per_cell);
+    std::vector<types::global_dof_index> local_dof_indices(fe.dofs_per_cell);
 
     std::vector<Vector<double> > cell_wind(n_q_points, Vector<double>(dim) );
     double normal_wind;
@@ -932,7 +932,7 @@ namespace Step34
 
     const unsigned int n_q_points = fe_v.n_quadrature_points;
 
-    std::vector<unsigned int> dofs(fe.dofs_per_cell);
+    std::vector<types::global_dof_index> dofs(fe.dofs_per_cell);
 
     std::vector<double> local_phi(n_q_points);
     std::vector<double> normal_wind(n_q_points);
index d5fffbf38e367e0277fc5690a85fe5d810f4f8a0..b8663462a2ea91d86784eb52f48b071dcbb42813 100644 (file)
@@ -402,7 +402,7 @@ namespace Step35
     const double       t_0, T, Re;
 
     EquationData::Velocity<dim>       vel_exact;
-    std::map<unsigned int, double>    boundary_values;
+    std::map<types::global_dof_index, double>    boundary_values;
     std::vector<types::boundary_id> boundary_indicators;
 
     Triangulation<dim> triangulation;
@@ -516,8 +516,8 @@ namespace Step35
       unsigned int              vel_dpc;
       unsigned int              pres_dpc;
       FullMatrix<double>        local_grad;
-      std::vector<unsigned int> vel_local_dof_indices;
-      std::vector<unsigned int> pres_local_dof_indices;
+      std::vector<types::global_dof_index> vel_local_dof_indices;
+      std::vector<types::global_dof_index> pres_local_dof_indices;
 
       InitGradPerTaskData (const unsigned int dd,
                            const unsigned int vdpc,
@@ -572,7 +572,7 @@ namespace Step35
     struct AdvectionPerTaskData
     {
       FullMatrix<double>        local_advection;
-      std::vector<unsigned int> local_dof_indices;
+      std::vector<types::global_dof_index> 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<unsigned int, double> bval;
+    static std::map<types::global_dof_index, double> bval;
     if (reinit_prec)
       VectorTools::interpolate_boundary_values (dof_handler_pressure, 3,
                                                 ZeroFunction<dim>(), bval);
@@ -1276,7 +1276,7 @@ namespace Step35
              dof_handler_pressure.n_dofs()),
             ExcInternalError());
     static Vector<double> joint_solution (joint_dof_handler.n_dofs());
-    std::vector<unsigned int> loc_joint_dof_indices (joint_fe.dofs_per_cell),
+    std::vector<types::global_dof_index> 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<dim>::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<unsigned int> ldi (dpc);
+    std::vector<types::global_dof_index> ldi (dpc);
     Vector<double> loc_rot (dpc);
 
     std::vector< Tensor<1,dim> > grad_u1 (nqp), grad_u2 (nqp);
index e9891e7d4a624a287cc32e090d19a45667847cfa..3071898f6dfd8f87ba50a5bf8b6bed942cb9cb75 100644 (file)
@@ -374,7 +374,7 @@ namespace Step38
     Vector<double>            cell_rhs (dofs_per_cell);
 
     std::vector<double>       rhs_values(n_q_points);
-    std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+    std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
     const RightHandSide<spacedim> rhs;
 
@@ -415,7 +415,7 @@ namespace Step38
           }
       }
 
-    std::map<unsigned int,double> boundary_values;
+    std::map<types::global_dof_index,double> boundary_values;
     VectorTools::interpolate_boundary_values (mapping,
                                               dof_handler,
                                               0,
index a39f1010f9d5b1a12caee1d7ea7635eaf821704a..ade3b41bfca4e54bedf2de6735754caef9824bf7 100644 (file)
@@ -400,7 +400,7 @@ void Step4<dim>::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 <code>BoundaryValues</code> class declared above):
-  std::map<unsigned int,double> boundary_values;
+  std::map<types::global_dof_index,double> boundary_values;
   VectorTools::interpolate_boundary_values (dof_handler,
                                             0,
                                             BoundaryValues<dim>(),
index f876aa75ed9931d150252dff67b40479081eebee..d2e11901f168a3c7fb82ffb517c95e722be43429 100644 (file)
@@ -316,7 +316,7 @@ namespace Step45
     FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
     Vector<double>       cell_rhs (dofs_per_cell);
 
-    std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+    std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
     const RightHandSide right_hand_side;
 
index ffd556b8f5b67f4cd79d66b3c07819cb91ddd737..7fdc20b2a8c68a810dd01f0f44a7cd80035d93bc 100644 (file)
@@ -400,7 +400,7 @@ namespace Step46
     // solid. The following piece of code was already presented in the
     // introduction:
     {
-      std::vector<unsigned int> local_face_dof_indices (stokes_fe.dofs_per_face);
+      std::vector<types::global_dof_index> local_face_dof_indices (stokes_fe.dofs_per_face);
       for (typename hp::DoFHandler<dim>::active_cell_iterator
            cell = dof_handler.begin_active();
            cell != dof_handler.end(); ++cell)
@@ -544,8 +544,8 @@ namespace Step46
                                                       stokes_dofs_per_cell);
     Vector<double>            local_rhs;
 
-    std::vector<unsigned int> local_dof_indices;
-    std::vector<unsigned int> neighbor_dof_indices (stokes_dofs_per_cell);
+    std::vector<types::global_dof_index> local_dof_indices;
+    std::vector<types::global_dof_index> neighbor_dof_indices (stokes_dofs_per_cell);
 
     const RightHandSide<dim>  right_hand_side;
 
index 7b366068304412a0c8af59e1911f604599abe0c1..18dfd8036e532368881717e6900296da3685ee32 100644 (file)
@@ -387,7 +387,7 @@ void Step5<dim>::assemble_system ()
     }
 
   // With the matrix so built, we use zero boundary values again:
-  std::map<unsigned int,double> boundary_values;
+  std::map<types::global_dof_index,double> boundary_values;
   VectorTools::interpolate_boundary_values (dof_handler,
                                             0,
                                             ZeroFunction<dim>(),
index 8e0d0bde1424e06454f5b05dc04f4d7d0fe5b321..85393fd73352df14af99825a457c1eea5ee41745 100644 (file)
@@ -563,7 +563,7 @@ namespace Step7
     FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
     Vector<double>       cell_rhs (dofs_per_cell);
 
-    std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+    std::vector<types::global_dof_index> 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<unsigned int,double> boundary_values;
+    std::map<types::global_dof_index,double> boundary_values;
     VectorTools::interpolate_boundary_values (dof_handler,
                                               0,
                                               Solution<dim>(),
index 2b75487b3e0eb6008c6359d7a5e19d00e8a4b5c5..9bbacd9d1fba18976ab74d361448f4b83d832df4 100644 (file)
@@ -380,7 +380,7 @@ namespace Step8
     FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
     Vector<double>       cell_rhs (dofs_per_cell);
 
-    std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+    std::vector<types::global_dof_index> 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
     // <code>dim</code> components, we need to pass <code>dim</code> as number
     // of components to the zero function as well.
-    std::map<unsigned int,double> boundary_values;
+    std::map<types::global_dof_index,double> boundary_values;
     VectorTools::interpolate_boundary_values (dof_handler,
                                               0,
                                               ZeroFunction<dim>(dim),
index 9a9bef869896a0ed15c13f8dab20212210f9702d..b5589551e5764520e174c348736369414a804de5 100644 (file)
@@ -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<unsigned int> local_dof_indices (dofs_per_cell);
+    std::vector<types::global_dof_index> 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
index 8629515cc12d05530712d56621de09b71da73e24..cc09b776a4c6d977e8f2f51e8e73bd14aaa50ca2 100644 (file)
@@ -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;
index 2e4c516020baa2a634b5d84e67bec57f3958b520..544178d1720b0c53bea2acee0f3198192fb61dfc 100644 (file)
@@ -52,7 +52,7 @@ namespace types
    */
   const unsigned int artificial_subdomain_id DEAL_II_DEPRECATED = static_cast<subdomain_id>(-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
index ab8dd4af9c5b6bf6083ad1f352799ba4cff7d5b1..6132d457629d758d1059e2f37b81c7c0860daea3 100644 (file)
@@ -479,7 +479,7 @@ namespace Utilities
 
 
   std::vector<unsigned long long int>
-  invert_permutation (const std::vector<unsigned long int> &permutation)
+  invert_permutation (const std::vector<unsigned long long int> &permutation)
   {
     const unsigned long long int n = permutation.size();
 

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.