]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Change the steps in examples to work with types::global_dof_index.
authorturcksin <turcksin@0785d39b-7218-0410-832d-ea1e28bc413d>
Fri, 15 Mar 2013 15:32:26 +0000 (15:32 +0000)
committerturcksin <turcksin@0785d39b-7218-0410-832d-ea1e28bc413d>
Fri, 15 Mar 2013 15:32:26 +0000 (15:32 +0000)
git-svn-id: https://svn.dealii.org/branches/branch_bigger_global_dof_indices_4@28913 0785d39b-7218-0410-832d-ea1e28bc413d

12 files changed:
deal.II/examples/step-18/step-18.cc
deal.II/examples/step-31/step-31.cc
deal.II/examples/step-32/step-32.cc
deal.II/examples/step-33/step-33.cc
deal.II/examples/step-36/step-36.cc
deal.II/examples/step-37/step-37.cc
deal.II/examples/step-40/step-40.cc
deal.II/examples/step-41/step-41.cc
deal.II/examples/step-42/step-42.cc
deal.II/examples/step-43/step-43.cc
deal.II/examples/step-44/step-44.cc
deal.II/examples/step-47/step-47.cc

index 6785d57d134eb069ea311df2221dbc64aa9166bc..195a1cc20487df40fd7951fa5265113a8b7e8784 100644 (file)
@@ -512,12 +512,12 @@ namespace Step18
 
     // Here is a vector where each entry denotes the numbers of degrees of
     // freedom that are stored on the processor with that particular number:
-    std::vector<unsigned int> local_dofs_per_process;
+    std::vector<types::global_dof_index> local_dofs_per_process;
 
     // Next, how many degrees of freedom the present processor stores. This
     // is, of course, an abbreviation to
     // <code>local_dofs_per_process[this_mpi_process]</code>.
-    unsigned int         n_local_dofs;
+    types::global_dof_index n_local_dofs;
 
     // In the same direction, also cache how many cells the present processor
     // owns. Note that the cells that belong to a processor are not
@@ -1182,7 +1182,7 @@ namespace Step18
     // for each vector component and because we only want to restrict vertical
     // motion, it has only its last component set:
     FEValuesExtractors::Scalar z_component (dim-1);
-    std::map<unsigned int,double> boundary_values;
+    std::map<types::global_dof_index,double> boundary_values;
     VectorTools::
     interpolate_boundary_values (dof_handler,
                                  0,
index 7d9a55ac919fbe2f6aa0051c629e6b0c7e27c943..65fc00a3ec943b68339e361c8d1e8516211fd49f 100644 (file)
@@ -492,7 +492,7 @@ namespace Step31
     DoFHandler<dim>                     stokes_dof_handler;
     ConstraintMatrix                    stokes_constraints;
 
-    std::vector<unsigned int>           stokes_block_sizes;
+    std::vector<types::global_dof_index> stokes_block_sizes;
     TrilinosWrappers::BlockSparseMatrix stokes_matrix;
     TrilinosWrappers::BlockSparseMatrix stokes_preconditioner_matrix;
 
@@ -886,7 +886,7 @@ namespace Step31
       temperature_constraints.close ();
     }
 
-    std::vector<unsigned int> stokes_dofs_per_block (2);
+    std::vector<types::global_dof_index> stokes_dofs_per_block (2);
     DoFTools::count_dofs_per_block (stokes_dof_handler, stokes_dofs_per_block,
                                     stokes_sub_blocks);
 
@@ -1076,7 +1076,7 @@ namespace Step31
     const unsigned int   n_q_points      = quadrature_formula.size();
 
     FullMatrix<double>   local_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<Tensor<2,dim> > grad_phi_u (dofs_per_cell);
     std::vector<double>         phi_p      (dofs_per_cell);
@@ -1293,7 +1293,7 @@ namespace Step31
     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);
 
     // Next we need a vector that will contain the values of the temperature
     // solution at the previous time level at the quadrature points to
@@ -1459,7 +1459,7 @@ namespace Step31
     FullMatrix<double>   local_mass_matrix (dofs_per_cell, dofs_per_cell);
     FullMatrix<double>   local_stiffness_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>         phi_T       (dofs_per_cell);
     std::vector<Tensor<1,dim> > grad_phi_T  (dofs_per_cell);
@@ -1571,7 +1571,7 @@ namespace Step31
 
     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);
 
     // Next comes the declaration of vectors to hold the old and older
     // solution values (as a notation for time levels <i>n-1</i> and
@@ -1967,9 +1967,9 @@ namespace Step31
     // output as only a qualititative means to understand a solution, we
     // ignore this $\mathcal{O}(h)$ error.
     {
-      std::vector<unsigned int> local_joint_dof_indices (joint_fe.dofs_per_cell);
-      std::vector<unsigned int> local_stokes_dof_indices (stokes_fe.dofs_per_cell);
-      std::vector<unsigned int> local_temperature_dof_indices (temperature_fe.dofs_per_cell);
+      std::vector<types::global_dof_index> local_joint_dof_indices (joint_fe.dofs_per_cell);
+      std::vector<types::global_dof_index> local_stokes_dof_indices (stokes_fe.dofs_per_cell);
+      std::vector<types::global_dof_index> local_temperature_dof_indices (temperature_fe.dofs_per_cell);
 
       typename DoFHandler<dim>::active_cell_iterator
       joint_cell       = joint_dof_handler.begin_active(),
index ba978a498dd896b06801c30c533c3bcb26ae654c..c22c7a0e778707a8e0c8c5a2a7919e1d49c9f4de 100644 (file)
@@ -617,7 +617,7 @@ namespace Step32
         StokesPreconditioner (const StokesPreconditioner &data);
 
         FullMatrix<double>          local_matrix;
-        std::vector<unsigned int>   local_dof_indices;
+        std::vector<types::global_dof_index> local_dof_indices;
       };
 
       template <int dim>
@@ -674,7 +674,7 @@ namespace Step32
 
         FullMatrix<double>          local_mass_matrix;
         FullMatrix<double>          local_stiffness_matrix;
-        std::vector<unsigned int>   local_dof_indices;
+        std::vector<types::global_dof_index>   local_dof_indices;
       };
 
       template <int dim>
@@ -706,7 +706,7 @@ namespace Step32
         TemperatureRHS (const TemperatureRHS &data);
 
         Vector<double>              local_rhs;
-        std::vector<unsigned int>   local_dof_indices;
+        std::vector<types::global_dof_index> local_dof_indices;
         FullMatrix<double>          matrix_for_bc;
       };
 
@@ -1690,7 +1690,7 @@ namespace Step32
     const unsigned int dofs_per_cell = fe_values.dofs_per_cell,
                        n_q_points    = fe_values.n_quadrature_points;
 
-    std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+    std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
     Vector<double> cell_vector (dofs_per_cell);
     FullMatrix<double> matrix_for_bc (dofs_per_cell, dofs_per_cell);
 
@@ -1945,7 +1945,7 @@ namespace Step32
 
     temperature_dof_handler.distribute_dofs (temperature_fe);
 
-    std::vector<unsigned int> stokes_dofs_per_block (2);
+    std::vector<types::global_dof_index> stokes_dofs_per_block (2);
     DoFTools::count_dofs_per_block (stokes_dof_handler, stokes_dofs_per_block,
                                     stokes_sub_blocks);
 
@@ -3251,9 +3251,9 @@ namespace Step32
     joint_solution.reinit (joint_dof_handler.locally_owned_dofs(), MPI_COMM_WORLD);
 
     {
-      std::vector<unsigned int> local_joint_dof_indices (joint_fe.dofs_per_cell);
-      std::vector<unsigned int> local_stokes_dof_indices (stokes_fe.dofs_per_cell);
-      std::vector<unsigned int> local_temperature_dof_indices (temperature_fe.dofs_per_cell);
+      std::vector<types::global_dof_index> local_joint_dof_indices (joint_fe.dofs_per_cell);
+      std::vector<types::global_dof_index> local_stokes_dof_indices (stokes_fe.dofs_per_cell);
+      std::vector<types::global_dof_index> local_temperature_dof_indices (temperature_fe.dofs_per_cell);
 
       typename DoFHandler<dim>::active_cell_iterator
       joint_cell       = joint_dof_handler.begin_active(),
index 37c8cf97921e2b4840ce5e7c190effd6adf48637..16967816da951339fffa23a4f928c08ba4e12295 100644 (file)
@@ -1290,12 +1290,12 @@ namespace Step33
 
     void assemble_system ();
     void assemble_cell_term (const FEValues<dim>             &fe_v,
-                             const std::vector<unsigned int> &dofs);
+                             const std::vector<types::global_dof_index> &dofs);
     void assemble_face_term (const unsigned int               face_no,
                              const FEFaceValuesBase<dim>     &fe_v,
                              const FEFaceValuesBase<dim>     &fe_v_neighbor,
-                             const std::vector<unsigned int> &dofs,
-                             const std::vector<unsigned int> &dofs_neighbor,
+                             const std::vector<types::global_dof_index> &dofs,
+                             const std::vector<types::global_dof_index> &dofs_neighbor,
                              const bool                       external_face,
                              const unsigned int               boundary_id,
                              const double                     face_diameter);
@@ -1430,8 +1430,8 @@ namespace Step33
   {
     const unsigned int dofs_per_cell = dof_handler.get_fe().dofs_per_cell;
 
-    std::vector<unsigned int> dof_indices (dofs_per_cell);
-    std::vector<unsigned int> dof_indices_neighbor (dofs_per_cell);
+    std::vector<types::global_dof_index> dof_indices (dofs_per_cell);
+    std::vector<types::global_dof_index> dof_indices_neighbor (dofs_per_cell);
 
     const UpdateFlags update_flags               = update_values
                                                    | update_gradients
@@ -1481,7 +1481,7 @@ namespace Step33
               assemble_face_term (face_no, fe_v_face,
                                   fe_v_face,
                                   dof_indices,
-                                  std::vector<unsigned int>(),
+                                  std::vector<types::global_dof_index>(),
                                   true,
                                   cell->face(face_no)->boundary_indicator(),
                                   cell->face(face_no)->diameter());
@@ -1661,7 +1661,7 @@ namespace Step33
   void
   ConservationLaw<dim>::
   assemble_cell_term (const FEValues<dim>             &fe_v,
-                      const std::vector<unsigned int> &dof_indices)
+                      const std::vector<types::global_dof_index> &dof_indices)
   {
     const unsigned int dofs_per_cell = fe_v.dofs_per_cell;
     const unsigned int n_q_points    = fe_v.n_quadrature_points;
@@ -1862,8 +1862,8 @@ namespace Step33
   ConservationLaw<dim>::assemble_face_term(const unsigned int           face_no,
                                            const FEFaceValuesBase<dim> &fe_v,
                                            const FEFaceValuesBase<dim> &fe_v_neighbor,
-                                           const std::vector<unsigned int>   &dof_indices,
-                                           const std::vector<unsigned int>   &dof_indices_neighbor,
+                                           const std::vector<types::global_dof_index>   &dof_indices,
+                                           const std::vector<types::global_dof_index>   &dof_indices_neighbor,
                                            const bool                   external_face,
                                            const unsigned int           boundary_id,
                                            const double                 face_diameter)
index 743049b17e7cdabd88241daf1666c38c18520c6f..6f2d8edbe68ac787acdb68e5f5211f90e3c89625 100644 (file)
@@ -223,7 +223,7 @@ namespace Step36
     FullMatrix<double> cell_stiffness_matrix (dofs_per_cell, dofs_per_cell);
     FullMatrix<double> cell_mass_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);
 
     FunctionParser<dim> potential;
     potential.initialize (FunctionParser<dim>::default_variable_names (),
index 59dc99a04b90887134db8cb2ae2d48be6fd9e9da..df9c6816a9d366fa7150542ae49165edde097348 100644 (file)
@@ -627,7 +627,7 @@ namespace Step37
   {
     data.cell_loop (&LaplaceOperator::local_apply, this, dst, src);
 
-    const std::vector<unsigned int> &
+    const std::vector<types::global_dof_index> &
     constrained_dofs = data.get_constrained_dofs();
     for (unsigned int i=0; i<constrained_dofs.size(); ++i)
       dst(constrained_dofs[i]) += src(constrained_dofs[i]);
@@ -668,7 +668,7 @@ namespace Step37
 
     diagonal_values = diagonal;
 
-    const std::vector<unsigned int> &
+    const std::vector<types::global_dof_index> &
     constrained_dofs = data.get_constrained_dofs();
     for (unsigned int i=0; i<constrained_dofs.size(); ++i)
       diagonal_values(constrained_dofs[i]) = 1.0;
@@ -834,13 +834,13 @@ namespace Step37
     typename FunctionMap<dim>::type dirichlet_boundary;
     ZeroFunction<dim>               homogeneous_dirichlet_bc (1);
     dirichlet_boundary[0] = &homogeneous_dirichlet_bc;
-    std::vector<std::set<unsigned int> > boundary_indices(triangulation.n_levels());
+    std::vector<std::set<types::global_dof_index> > boundary_indices(triangulation.n_levels());
     MGTools::make_boundary_list (dof_handler,
                                  dirichlet_boundary,
                                  boundary_indices);
     for (unsigned int level=0; level<nlevels; ++level)
       {
-        std::set<unsigned int>::iterator bc_it = boundary_indices[level].begin();
+        std::set<types::global_dof_index>::iterator bc_it = boundary_indices[level].begin();
         for ( ; bc_it != boundary_indices[level].end(); ++bc_it)
           mg_constraints[level].add_line(*bc_it);
 
@@ -875,7 +875,7 @@ namespace Step37
     const unsigned int   dofs_per_cell = fe.dofs_per_cell;
     const unsigned int   n_q_points    = quadrature_formula.size();
 
-    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);
 
@@ -921,7 +921,7 @@ namespace Step37
     const unsigned int   dofs_per_cell = fe.dofs_per_cell;
     const unsigned int   n_q_points    = quadrature_formula.size();
 
-    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);
     FullMatrix<double>        local_matrix (dofs_per_cell, dofs_per_cell);
index 5c2ce3bbee61d076ce9cfad15b1c82090173bb66..b5f1b3c80d58600b177cbc49999e53b51a87311b 100644 (file)
@@ -347,7 +347,7 @@ namespace Step40
     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(),
index 699b98c897dede264558e5fa870188f86704a59c..2bd479c3bd6d6d461fa80452483afaf1e059b36d 100644 (file)
@@ -293,7 +293,7 @@ namespace Step41
     FullMatrix<double>        cell_matrix (dofs_per_cell, dofs_per_cell);
     TrilinosWrappers::Vector  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(),
@@ -370,7 +370,7 @@ namespace Step41
     const unsigned int        n_q_points    = quadrature_formula.size();
 
     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(),
index 0c1e070b28e0024ad47c37c11f3b7a491e563bf6..4b8ae399b05f2f2b23ffa187e1f60c1901d07203 100644 (file)
@@ -881,7 +881,7 @@ namespace Step42
 
     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 FEValuesExtractors::Vector displacement (0);
 
@@ -992,7 +992,7 @@ namespace Step42
     for (unsigned i=0; i<dim; i++)
        ones[i] = 1.0;
 
-    std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+    std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
 
     const FEValuesExtractors::Vector displacement (0);
 
index 4086020fd7a8b630c2d64346314263b85e62e5ec..c1e604696196bfa3968ac001c3bd58ce54105eaf 100644 (file)
@@ -500,10 +500,10 @@ namespace Step43
                                             const FEValues<dim>             &darcy_fe_values,
                                             const double                     global_max_u_F_prime,
                                             const double                     global_S_variation,
-                                            const std::vector<unsigned int> &local_dof_indices);
+                                            const std::vector<types::global_dof_index> &local_dof_indices);
     void assemble_saturation_rhs_boundary_term (const FEFaceValues<dim>             &saturation_fe_face_values,
                                                 const FEFaceValues<dim>             &darcy_fe_face_values,
-                                                const std::vector<unsigned int>     &local_dof_indices);
+                                                const std::vector<types::global_dof_index>     &local_dof_indices);
     void solve ();
     void refine_mesh (const unsigned int              min_grid_level,
                       const unsigned int              max_grid_level);
@@ -709,7 +709,7 @@ namespace Step43
     }
 
 
-    std::vector<unsigned int> darcy_dofs_per_block (2);
+    std::vector<types::global_dof_index> darcy_dofs_per_block (2);
     DoFTools::count_dofs_per_block (darcy_dof_handler, darcy_dofs_per_block, darcy_block_component);
     const unsigned int n_u = darcy_dofs_per_block[0],
                        n_p = darcy_dofs_per_block[1],
@@ -893,7 +893,7 @@ namespace Step43
     std::vector<double>               old_saturation_values (n_q_points);
 
     FullMatrix<double>                local_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<Tensor<1,dim> > phi_u   (dofs_per_cell);
     std::vector<Tensor<1,dim> > grad_phi_p (dofs_per_cell);
@@ -1038,7 +1038,7 @@ namespace Step43
     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;
@@ -1235,7 +1235,7 @@ namespace Step43
     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);
 
     typename DoFHandler<dim>::active_cell_iterator
     cell = saturation_dof_handler.begin_active(),
@@ -1310,7 +1310,7 @@ namespace Step43
                                                           update_values);
 
     const unsigned int dofs_per_cell = saturation_dof_handler.get_fe().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 double                   global_max_u_F_prime = get_max_u_F_prime ();
     const std::pair<double,double> global_S_range       = get_extrapolated_saturation_range ();
@@ -1367,7 +1367,7 @@ namespace Step43
                                      const FEValues<dim>             &darcy_fe_values,
                                      const double                     global_max_u_F_prime,
                                      const double                     global_S_variation,
-                                     const std::vector<unsigned int> &local_dof_indices)
+                                     const std::vector<types::global_dof_index> &local_dof_indices)
   {
     const unsigned int dofs_per_cell = saturation_fe_values.dofs_per_cell;
     const unsigned int n_q_points    = saturation_fe_values.n_quadrature_points;
@@ -1440,7 +1440,7 @@ namespace Step43
   TwoPhaseFlowProblem<dim>::
   assemble_saturation_rhs_boundary_term (const FEFaceValues<dim>             &saturation_fe_face_values,
                                          const FEFaceValues<dim>             &darcy_fe_face_values,
-                                         const std::vector<unsigned int>     &local_dof_indices)
+                                         const std::vector<types::global_dof_index>     &local_dof_indices)
   {
     const unsigned int dofs_per_cell      = saturation_fe_face_values.dofs_per_cell;
     const unsigned int n_face_q_points    = saturation_fe_face_values.n_quadrature_points;
@@ -1771,9 +1771,9 @@ namespace Step43
     Vector<double> joint_solution (joint_dof_handler.n_dofs());
 
     {
-      std::vector<unsigned int> local_joint_dof_indices (joint_fe.dofs_per_cell);
-      std::vector<unsigned int> local_darcy_dof_indices (darcy_fe.dofs_per_cell);
-      std::vector<unsigned int> local_saturation_dof_indices (saturation_fe.dofs_per_cell);
+      std::vector<types::global_dof_index> local_joint_dof_indices (joint_fe.dofs_per_cell);
+      std::vector<types::global_dof_index> local_darcy_dof_indices (darcy_fe.dofs_per_cell);
+      std::vector<types::global_dof_index> local_saturation_dof_indices (saturation_fe.dofs_per_cell);
 
       typename DoFHandler<dim>::active_cell_iterator
       joint_cell      = joint_dof_handler.begin_active(),
index e1f3495346756596aaecc85647f77b5d3386afe9..187f6ccd55bb1c0e249afb5a7dac3b5ef61224b0 100644 (file)
@@ -996,10 +996,10 @@ namespace Step44
       J_dof = 2
     };
 
-    std::vector<unsigned int>        dofs_per_block;
-    std::vector<unsigned int>        element_indices_u;
-    std::vector<unsigned int>        element_indices_p;
-    std::vector<unsigned int>        element_indices_J;
+    std::vector<types::global_dof_index>  dofs_per_block;
+    std::vector<types::global_dof_index>        element_indices_u;
+    std::vector<types::global_dof_index>        element_indices_p;
+    std::vector<types::global_dof_index>        element_indices_J;
 
     // Rules for Gauss-quadrature on both the cell and faces. The number of
     // quadrature points on both cells and faces is recorded.
@@ -1209,7 +1209,7 @@ namespace Step44
   struct Solid<dim>::PerTaskData_K
   {
     FullMatrix<double>        cell_matrix;
-    std::vector<unsigned int> local_dof_indices;
+    std::vector<types::global_dof_index> local_dof_indices;
 
     PerTaskData_K(const unsigned int dofs_per_cell)
       :
@@ -1290,7 +1290,7 @@ namespace Step44
   struct Solid<dim>::PerTaskData_RHS
   {
     Vector<double>            cell_rhs;
-    std::vector<unsigned int> local_dof_indices;
+    std::vector<types::global_dof_index> local_dof_indices;
 
     PerTaskData_RHS(const unsigned int dofs_per_cell)
       :
@@ -1372,7 +1372,7 @@ namespace Step44
   struct Solid<dim>::PerTaskData_SC
   {
     FullMatrix<double>        cell_matrix;
-    std::vector<unsigned int> local_dof_indices;
+    std::vector<types::global_dof_index> local_dof_indices;
 
     FullMatrix<double>        k_orig;
     FullMatrix<double>        k_pu;
@@ -1567,9 +1567,9 @@ namespace Step44
     // Setup the sparsity pattern and tangent matrix
     tangent_matrix.clear();
     {
-      const unsigned int n_dofs_u = dofs_per_block[u_dof];
-      const unsigned int n_dofs_p = dofs_per_block[p_dof];
-      const unsigned int n_dofs_J = dofs_per_block[J_dof];
+      const types::global_dof_index n_dofs_u = dofs_per_block[u_dof];
+      const types::global_dof_index n_dofs_p = dofs_per_block[p_dof];
+      const types::global_dof_index n_dofs_J = dofs_per_block[J_dof];
 
       BlockCompressedSimpleSparsityPattern csp(n_blocks, n_blocks);
 
index 8d24f894f6157eb5901a3663922c66792bd5f268..de57709e155b625e38dab503b81448a7e6bd9246 100644 (file)
@@ -280,7 +280,7 @@ namespace Step47
     FullMatrix<double>   cell_matrix;
     Vector<double>       cell_rhs;
 
-    std::vector<unsigned int> local_dof_indices;
+    std::vector<types::global_dof_index> local_dof_indices;
 
     const Coefficient<dim> coefficient;
     std::vector<double>    coefficient_values (n_q_points);
@@ -424,7 +424,7 @@ namespace Step47
       }
 
 
-    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>(2),

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.