]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
convert some unsigned ints to types::global_dof_index
authorkoecher <koecher@0785d39b-7218-0410-832d-ea1e28bc413d>
Fri, 10 Aug 2012 17:31:58 +0000 (17:31 +0000)
committerkoecher <koecher@0785d39b-7218-0410-832d-ea1e28bc413d>
Fri, 10 Aug 2012 17:31:58 +0000 (17:31 +0000)
git-svn-id: https://svn.dealii.org/branches/branch_bigger_global_dof_indices_3@25891 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/files
deal.II/include/deal.II/numerics/solution_transfer.h
deal.II/include/deal.II/numerics/vector_tools.h
deal.II/include/deal.II/numerics/vector_tools.templates.h
deal.II/source/numerics/point_value_history.cc
deal.II/source/numerics/solution_transfer.cc

index ee78a245774cfdfa46c0f2032f48a3ed367ab042..01cb86101f776f9f0acaf32c75d81f7929a2993b 100644 (file)
@@ -191,13 +191,13 @@ UWE source/numerics/fe_field_function.cc
 UWE source/numerics/histogram.cc
 UWE source/numerics/matrix_free.cc
 UWE source/numerics/matrix_tools.cc
-source/numerics/mesh_worker.cc
-source/numerics/mesh_worker_info.cc
-source/numerics/mesh_worker_vector_selector.cc
-source/numerics/point_value_history.cc
-source/numerics/solution_transfer.cc
-source/numerics/time_dependent.cc
-source/numerics/vector_tools.cc
+UWE source/numerics/mesh_worker.cc
+UWE source/numerics/mesh_worker_info.cc
+UWE source/numerics/mesh_worker_vector_selector.cc
+UWE source/numerics/point_value_history.cc
+UWE source/numerics/solution_transfer.cc
+UWE source/numerics/time_dependent.cc
+UWE source/numerics/vector_tools.cc
 include/deal.II/algorithms/newton.h
 include/deal.II/algorithms/newton.templates.h
 include/deal.II/algorithms/operator.h
@@ -503,33 +503,35 @@ include/deal.II/multigrid/mg_transfer.h
 include/deal.II/multigrid/mg_transfer.templates.h
 include/deal.II/multigrid/multigrid.h
 include/deal.II/multigrid/multigrid.templates.h
-include/deal.II/numerics/data_component_interpretation.h
-include/deal.II/numerics/data_out_faces.h
-include/deal.II/numerics/data_out.h
-include/deal.II/numerics/data_out_rotation.h
-include/deal.II/numerics/data_out_stack.h
-include/deal.II/numerics/data_postprocessor.h
-include/deal.II/numerics/derivative_approximation.h
-include/deal.II/numerics/dof_output_operator.h
-include/deal.II/numerics/dof_output_operator.templates.h
-include/deal.II/numerics/dof_print_solver_step.h
-include/deal.II/numerics/error_estimator.h
-include/deal.II/numerics/fe_field_function.h
-include/deal.II/numerics/fe_field_function.templates.h
-include/deal.II/numerics/histogram.h
-include/deal.II/numerics/matrix_tools.h
-include/deal.II/numerics/mesh_worker_assembler.h
-include/deal.II/numerics/mesh_worker.h
-include/deal.II/numerics/mesh_worker_info.h
-include/deal.II/numerics/mesh_worker_loop.h
-include/deal.II/numerics/mesh_worker_output.h
-include/deal.II/numerics/mesh_worker_vector_selector.h
-include/deal.II/numerics/newton.h
-include/deal.II/numerics/operator.h
-include/deal.II/numerics/point_value_history.h
-include/deal.II/numerics/solution_transfer.h
-include/deal.II/numerics/theta_timestepping.h
-include/deal.II/numerics/time_dependent.h
-include/deal.II/numerics/timestep_control.h
-include/deal.II/numerics/vector_tools.h
-include/deal.II/numerics/vector_tools.templates.h
+UWE include/deal.II/numerics/data_component_interpretation.h
+UWE include/deal.II/numerics/data_out_faces.h
+UWE include/deal.II/numerics/data_out.h
+UWE include/deal.II/numerics/data_out_rotation.h
+UWE include/deal.II/numerics/data_out_stack.h
+UWE include/deal.II/numerics/data_postprocessor.h
+UWE include/deal.II/numerics/derivative_approximation.h
+UWE include/deal.II/numerics/dof_output_operator.h
+UWE include/deal.II/numerics/dof_output_operator.templates.h
+UWE include/deal.II/numerics/dof_print_solver_step.h
+UWE include/deal.II/numerics/error_estimator.h
+UWE include/deal.II/numerics/fe_field_function.h
+UWE include/deal.II/numerics/fe_field_function.templates.h
+UWE include/deal.II/numerics/histogram.h
+UWE include/deal.II/numerics/matrix_tools.h
+UWE include/deal.II/numerics/mesh_worker_assembler.h
+UWE include/deal.II/numerics/mesh_worker.h
+UWE include/deal.II/numerics/mesh_worker_info.h
+UWE include/deal.II/numerics/mesh_worker_loop.h
+UWE include/deal.II/numerics/mesh_worker_output.h
+UWE include/deal.II/numerics/mesh_worker_vector_selector.h
+UWE include/deal.II/numerics/newton.h
+UWE include/deal.II/numerics/operator.h
+UWE include/deal.II/numerics/point_value_history.h
+UWE include/deal.II/numerics/solution_transfer.h
+UWE include/deal.II/numerics/theta_timestepping.h
+UWE include/deal.II/numerics/time_dependent.h
+UWE include/deal.II/numerics/timestep_control.h
+UWE include/deal.II/numerics/vectors.h
+UWE include/deal.II/numerics/vectors.templates.h
+UWE include/deal.II/numerics/vector_tools.h
+UWE include/deal.II/numerics/vector_tools.templates.h
index 8c5e354db414fa00ac86714ac4f7c2cfdad1c77b..b240a9634fd69b00eab968b18863467c1b067d8e 100644 (file)
@@ -407,7 +407,7 @@ class SolutionTransfer
                                       * and stores all dof indices
                                       * of the cells that'll be refined
                                       */
-    std::vector<std::vector<unsigned int> > indices_on_cell;
+    std::vector<std::vector<types::global_dof_index> > indices_on_cell;
 
                                      /**
                                       * All cell data (the dof indices and
index 048ad135e9be3715e460fa773355ee6e72b17b0c..0b962ce8039a3a04ddca85177ebf4db9d7a3814f 100644 (file)
@@ -747,7 +747,7 @@ namespace VectorTools
   interpolate_boundary_values (const Mapping<DH::dimension,DH::space_dimension>            &mapping,
                                const DH                 &dof,
                                const typename FunctionMap<DH::space_dimension>::type &function_map,
-                               std::map<unsigned int,double> &boundary_values,
+                               std::map<types::global_dof_index,double> &boundary_values,
                                const std::vector<bool>       &component_mask = std::vector<bool>());
 
                                    /**
@@ -769,7 +769,7 @@ namespace VectorTools
                                const DH                 &dof,
                                const types::boundary_id_t            boundary_component,
                                const Function<DH::space_dimension>           &boundary_function,
-                               std::map<unsigned int,double> &boundary_values,
+                               std::map<types::global_dof_index,double> &boundary_values,
                                const std::vector<bool>       &component_mask = std::vector<bool>());
 
                                    /**
@@ -783,7 +783,7 @@ namespace VectorTools
   interpolate_boundary_values (const DH        &dof,
                                const types::boundary_id_t            boundary_component,
                                const Function<DH::space_dimension>           &boundary_function,
-                               std::map<unsigned int,double> &boundary_values,
+                               std::map<types::global_dof_index,double> &boundary_values,
                                const std::vector<bool>       &component_mask = std::vector<bool>());
 
 
@@ -797,7 +797,7 @@ namespace VectorTools
   void
   interpolate_boundary_values (const DH                &dof,
                                const typename FunctionMap<DH::space_dimension>::type &function_map,
-                               std::map<unsigned int,double>         &boundary_values,
+                               std::map<types::global_dof_index,double>         &boundary_values,
                                const std::vector<bool>               &component_mask = std::vector<bool>());
 
 
@@ -995,7 +995,7 @@ namespace VectorTools
                                 const DoFHandler<dim,spacedim>    &dof,
                                 const typename FunctionMap<spacedim>::type &boundary_functions,
                                 const Quadrature<dim-1>  &q,
-                                std::map<unsigned int,double> &boundary_values,
+                                std::map<types::global_dof_index,double> &boundary_values,
                                 std::vector<unsigned int> component_mapping = std::vector<unsigned int>());
 
                                    /**
@@ -1007,7 +1007,7 @@ namespace VectorTools
   void project_boundary_values (const DoFHandler<dim,spacedim>    &dof,
                                 const typename FunctionMap<spacedim>::type &boundary_function,
                                 const Quadrature<dim-1>  &q,
-                                std::map<unsigned int,double> &boundary_values,
+                                std::map<types::global_dof_index,double> &boundary_values,
                                 std::vector<unsigned int> component_mapping = std::vector<unsigned int>());
 
                                    /**
index 190b8866e729277e07a4c5777ad8ece7212a2320..09c182635e25bc6b3cf7b7b17133b3b3b3400bec 100644 (file)
@@ -127,10 +127,10 @@ namespace VectorTools
                                      // the following vector collects all rep dofs.
                                      // the position of a rep dof within this vector
                                      // is called rep index.
-    std::vector<std::vector<unsigned int> > dofs_of_rep_points(fe.size());
+    std::vector<std::vector<types::global_dof_index> > dofs_of_rep_points(fe.size());
                                      // the following table converts a dof i
                                      // to the rep index.
-    std::vector<std::vector<unsigned int> > dof_to_rep_index_table(fe.size());
+    std::vector<std::vector<types::global_dof_index> > dof_to_rep_index_table(fe.size());
 
     std::vector<unsigned int> n_rep_points (fe.size(), 0);
 
@@ -172,7 +172,7 @@ namespace VectorTools
 
     const unsigned int max_rep_points = *std::max_element (n_rep_points.begin(),
                                                            n_rep_points.end());
-    std::vector<unsigned int> dofs_on_cell (fe.max_dofs_per_cell());
+    std::vector<types::global_dof_index> dofs_on_cell (fe.max_dofs_per_cell());
     std::vector<Point<DH::space_dimension> >  rep_points (max_rep_points);
 
                                      // get space for the values of the
@@ -286,8 +286,8 @@ namespace VectorTools
     Vector<double> cell_data_1(dof_1.get_fe().dofs_per_cell);
     Vector<double> cell_data_2(dof_2.get_fe().dofs_per_cell);
 
-    std::vector<short unsigned int> touch_count (dof_2.n_dofs(), 0);
-    std::vector<unsigned int>       local_dof_indices (dof_2.get_fe().dofs_per_cell);
+    std::vector<short unsigned int> touch_count (dof_2.n_dofs(), 0); //TODO: check on datatype... kinda strange (UK)
+    std::vector<types::global_dof_index>       local_dof_indices (dof_2.get_fe().dofs_per_cell);
 
     typename DoFHandler<dim,spacedim>::active_cell_iterator h = dof_1.begin_active();
     typename DoFHandler<dim,spacedim>::active_cell_iterator l = dof_2.begin_active();
@@ -330,7 +330,7 @@ namespace VectorTools
   {
     void
     interpolate_zero_boundary_values (const dealii::DoFHandler<1>   &dof_handler,
-                                      std::map<unsigned int,double> &boundary_values)
+                                      std::map<types::global_dof_index,double> &boundary_values)
     {
                                        // we only need to find the
                                        // left-most and right-most
@@ -353,7 +353,7 @@ namespace VectorTools
                                      // codimension 1
     void
     interpolate_zero_boundary_values (const dealii::DoFHandler<1,2> &dof_handler,
-                                      std::map<unsigned int,double> &boundary_values)
+                                      std::map<types::global_dof_index,double> &boundary_values)
     {
                                        // we only need to find the
                                        // left-most and right-most
@@ -376,7 +376,7 @@ namespace VectorTools
     template <int dim, int spacedim>
     void
     interpolate_zero_boundary_values (const dealii::DoFHandler<dim,spacedim>       &dof_handler,
-                                      std::map<unsigned int,double> &boundary_values)
+                                      std::map<types::global_dof_index,double> &boundary_values)
     {
       const FiniteElement<dim,spacedim> &fe = dof_handler.get_fe();
 
@@ -404,7 +404,7 @@ namespace VectorTools
       typename dealii::DoFHandler<dim,spacedim>::active_face_iterator
         face = dof_handler.begin_active_face(),
         endf = dof_handler.end_face();
-      std::vector<unsigned int> face_dof_indices (fe.dofs_per_face);
+      std::vector<types::global_dof_index> face_dof_indices (fe.dofs_per_face);
       for (; face!=endf; ++face)
         if (face->at_boundary())
           {
@@ -548,7 +548,7 @@ namespace VectorTools
             ExcDimensionMismatch (vec_result.size(), dof.n_dofs()));
 
                                      // make up boundary values
-    std::map<unsigned int,double> boundary_values;
+    std::map<types::global_dof_index,double> boundary_values;
 
     if (enforce_zero_boundary == true)
                                        // no need to project boundary
@@ -674,7 +674,7 @@ namespace VectorTools
                        n_q_points    = fe_values.n_quadrature_points,
                        n_components  = fe.n_components();
 
-    std::vector<unsigned int> dofs (dofs_per_cell);
+    std::vector<types::global_dof_index> dofs (dofs_per_cell);
     Vector<double> cell_vector (dofs_per_cell);
 
     typename DoFHandler<dim,spacedim>::active_cell_iterator
@@ -797,7 +797,7 @@ namespace VectorTools
 
     const unsigned int n_components  = fe.n_components();
 
-    std::vector<unsigned int> dofs (fe.max_dofs_per_cell());
+    std::vector<types::global_dof_index> dofs (fe.max_dofs_per_cell());
     Vector<double> cell_vector (fe.max_dofs_per_cell());
 
     typename hp::DoFHandler<dim,spacedim>::active_cell_iterator
@@ -941,7 +941,7 @@ namespace VectorTools
 
     const unsigned int dofs_per_cell = 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);
     cell_point.first->get_dof_indices (local_dof_indices);
 
     for(unsigned int i=0; i<dofs_per_cell; i++)
@@ -986,7 +986,7 @@ namespace VectorTools
 
     const unsigned int dofs_per_cell = cell_point.first->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);
     cell_point.first->get_dof_indices (local_dof_indices);
 
     for(unsigned int i=0; i<dofs_per_cell; i++)
@@ -1036,7 +1036,7 @@ namespace VectorTools
 
     const unsigned int dofs_per_cell = 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);
     cell_point.first->get_dof_indices (local_dof_indices);
 
     for(unsigned int i=0; i<dofs_per_cell; i++)
@@ -1084,7 +1084,7 @@ namespace VectorTools
 
     const unsigned int dofs_per_cell = cell_point.first->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);
     cell_point.first->get_dof_indices (local_dof_indices);
 
     for(unsigned int i=0; i<dofs_per_cell; i++)
@@ -1163,7 +1163,7 @@ namespace VectorTools
                        n_q_points    = fe_values.n_quadrature_points,
                        n_components  = fe.n_components();
 
-    std::vector<unsigned int> dofs (dofs_per_cell);
+    std::vector<types::global_dof_index> dofs (dofs_per_cell);
     Vector<double> cell_vector (dofs_per_cell);
 
     typename DoFHandler<dim,spacedim>::active_cell_iterator cell = dof_handler.begin_active(),
@@ -1332,7 +1332,7 @@ namespace VectorTools
 
     const unsigned int n_components  = fe.n_components();
 
-    std::vector<unsigned int> dofs (fe.max_dofs_per_cell());
+    std::vector<types::global_dof_index> dofs (fe.max_dofs_per_cell());
     Vector<double> cell_vector (fe.max_dofs_per_cell());
 
     typename hp::DoFHandler<dim,spacedim>::active_cell_iterator
@@ -1476,7 +1476,7 @@ namespace VectorTools
     void interpolate_boundary_values (const Mapping<DH::dimension, DH::space_dimension> &,
                                       const DH                 &dof,
                                       const typename FunctionMap<DH::space_dimension>::type &function_map,
-                                      std::map<unsigned int,double> &boundary_values,
+                                      std::map<types::global_dof_index,double> &boundary_values,
                                       const std::vector<bool>       &component_mask_,
                                       const dealii::internal::int2type<1>)
     {
@@ -1567,7 +1567,7 @@ namespace VectorTools
     interpolate_boundary_values (const Mapping<DH::dimension, DH::space_dimension> &mapping,
                                  const DH                 &dof,
                                  const typename FunctionMap<DH::space_dimension>::type &function_map,
-                                 std::map<unsigned int,double> &boundary_values,
+                                 std::map<types::global_dof_index,double> &boundary_values,
                                  const std::vector<bool>       &component_mask_,
                                  const dealii::internal::int2type<DH::dimension>)
     {
@@ -1608,7 +1608,7 @@ namespace VectorTools
               ExcNoComponentSelected());
 
                                        // field to store the indices
-      std::vector<unsigned int> face_dofs;
+      std::vector<types::global_dof_index> face_dofs;
       face_dofs.reserve (DoFTools::max_dofs_per_face(dof));
 
       std::vector<Point<spacedim> >  dof_locations;
@@ -1926,7 +1926,7 @@ namespace VectorTools
   interpolate_boundary_values (const Mapping<DH::dimension, DH::space_dimension>            &mapping,
                                const DH                 &dof,
                                const typename FunctionMap<DH::space_dimension>::type &function_map,
-                               std::map<unsigned int,double> &boundary_values,
+                               std::map<types::global_dof_index,double> &boundary_values,
                                const std::vector<bool>       &component_mask_)
   {
     internal::
@@ -1943,7 +1943,7 @@ namespace VectorTools
                                const DH                 &dof,
                                const types::boundary_id_t            boundary_component,
                                const Function<DH::space_dimension>           &boundary_function,
-                               std::map<unsigned int,double> &boundary_values,
+                               std::map<types::global_dof_index,double> &boundary_values,
                                const std::vector<bool>       &component_mask)
   {
     typename FunctionMap<DH::space_dimension>::type function_map;
@@ -1959,7 +1959,7 @@ namespace VectorTools
   interpolate_boundary_values (const DH                 &dof,
                                const types::boundary_id_t            boundary_component,
                                const Function<DH::space_dimension>           &boundary_function,
-                               std::map<unsigned int,double> &boundary_values,
+                               std::map<types::global_dof_index,double> &boundary_values,
                                const std::vector<bool>       &component_mask)
   {
     Assert (DEAL_II_COMPAT_MAPPING, ExcCompatibility("mapping"));
@@ -1974,7 +1974,7 @@ namespace VectorTools
   void
   interpolate_boundary_values (const DH                 &dof,
                                const typename FunctionMap<DH::space_dimension>::type &function_map,
-                               std::map<unsigned int,double> &boundary_values,
+                               std::map<types::global_dof_index,double> &boundary_values,
                                const std::vector<bool>       &component_mask)
   {
     Assert (DEAL_II_COMPAT_MAPPING, ExcCompatibility("mapping"));
@@ -1999,10 +1999,10 @@ namespace VectorTools
    ConstraintMatrix                                      &constraints,
    const std::vector<bool>                               &component_mask_)
   {
-    std::map<unsigned int,double> boundary_values;
+    std::map<types::global_dof_index,double> boundary_values;
     interpolate_boundary_values (mapping, dof, function_map,
                                  boundary_values, component_mask_);
-    std::map<unsigned int,double>::const_iterator boundary_value =
+    std::map<types::global_dof_index,double>::const_iterator boundary_value =
       boundary_values.begin();
     for ( ; boundary_value !=boundary_values.end(); ++boundary_value)
       {
@@ -2081,7 +2081,7 @@ namespace VectorTools
                            const DoFHandler<1,1>      &dof,
                            const FunctionMap<1>::type &boundary_functions,
                            const Quadrature<0>        &,
-                           std::map<unsigned int,double> &boundary_values,
+                           std::map<types::global_dof_index,double> &boundary_values,
                            std::vector<unsigned int>   component_mapping)
   {
     Assert (component_mapping.size() == 0, ExcNotImplemented());
@@ -2099,7 +2099,7 @@ namespace VectorTools
                            const DoFHandler<1,2>      &dof,
                            const FunctionMap<2>::type &boundary_functions,
                            const Quadrature<0>        &,
-                           std::map<unsigned int,double> &boundary_values,
+                           std::map<types::global_dof_index,double> &boundary_values,
                            std::vector<unsigned int>   component_mapping)
   {
     Assert (component_mapping.size() == 0, ExcNotImplemented());
@@ -2118,7 +2118,7 @@ namespace VectorTools
                            const DoFHandler<dim, spacedim>&dof,
                            const typename FunctionMap<spacedim>::type &boundary_functions,
                            const Quadrature<dim-1>        &q,
-                           std::map<unsigned int,double>  &boundary_values,
+                           std::map<types::global_dof_index,double>  &boundary_values,
                            std::vector<unsigned int>       component_mapping)
   {
 //TODO:[?] In project_boundary_values, no condensation of sparsity
@@ -2140,7 +2140,7 @@ namespace VectorTools
     else
       AssertDimension (dof.get_fe().n_components(), component_mapping.size());
 
-    std::vector<unsigned int> dof_to_boundary_mapping;
+    std::vector<types::global_dof_index> dof_to_boundary_mapping;
     std::set<types::boundary_id_t> selected_boundary_components;
     for (typename FunctionMap<spacedim>::type::const_iterator i=boundary_functions.begin();
          i!=boundary_functions.end(); ++i)
@@ -2283,7 +2283,7 @@ namespace VectorTools
   project_boundary_values (const DoFHandler<dim,spacedim>    &dof,
                            const typename FunctionMap<spacedim>::type &boundary_functions,
                            const Quadrature<dim-1>  &q,
-                           std::map<unsigned int,double> &boundary_values,
+                           std::map<types::global_dof_index,double> &boundary_values,
                            std::vector<unsigned int> component_mapping)
   {
     Assert (DEAL_II_COMPAT_MAPPING, ExcCompatibility("mapping"));
@@ -2306,10 +2306,10 @@ namespace VectorTools
                            ConstraintMatrix &constraints,
                            std::vector<unsigned int> component_mapping)
   {
-    std::map<unsigned int,double> boundary_values;
+    std::map<types::global_dof_index,double> boundary_values;
     project_boundary_values (mapping, dof, boundary_functions, q,
                              boundary_values, component_mapping);
-    std::map<unsigned int,double>::const_iterator boundary_value =
+    std::map<types::global_dof_index,double>::const_iterator boundary_value =
       boundary_values.begin();
     for ( ; boundary_value !=boundary_values.end(); ++boundary_value)
       {
@@ -2351,7 +2351,7 @@ namespace VectorTools
     template <int dim>
     struct VectorDoFTuple
     {
-        unsigned int dof_indices[dim];
+        types::global_dof_index dof_indices[dim];
 
         VectorDoFTuple ()
           {
@@ -2622,7 +2622,7 @@ namespace VectorTools
                                        // vector t is largest by
                                        // magnitude, then
                                        // x1=t[1]/t[0]*x_0, etc.
-      unsigned int largest_component = 0;
+      types::global_dof_index largest_component = 0;
       for (unsigned int d=1; d<dim; ++d)
        if (std::fabs(tangent_vector[d]) > std::fabs(tangent_vector[largest_component]) + 1e-10)
          largest_component = d;
@@ -3547,7 +3547,7 @@ namespace VectorTools
                                       update_quadrature_points |
                                       update_values);
     std::vector<double> dof_values;
-    std::vector<unsigned int> face_dof_indices;
+    std::vector<types::global_dof_index> face_dof_indices;
     typename hp::DoFHandler<dim>::active_cell_iterator cell = dof_handler.begin_active ();
 
     switch (dim)
@@ -3803,7 +3803,7 @@ namespace VectorTools
                                      * fe_values[vec].value (fe.face_to_cell_index (i, face), q_point));
         }
 
-      std::vector<unsigned int> face_dof_indices (fe.dofs_per_face);
+      std::vector<types::global_dof_index> face_dof_indices (fe.dofs_per_face);
 
       cell->face (face)->get_dof_indices (face_dof_indices, cell->active_fe_index ());
 
@@ -3850,7 +3850,7 @@ namespace VectorTools
                                             const Function<3>& boundary_function,
                                             const std::vector<DerivativeForm<1,3,3> >& jacobians,
                                             std::vector<double>& dof_values,
-                                            std::vector<unsigned int>& projected_dofs)
+                                            std::vector<types::global_dof_index>& projected_dofs)
     {
                                        // Compute the intergral over
                                        // the product of the normal
@@ -3906,7 +3906,7 @@ namespace VectorTools
                                            * fe_values[vec].value (fe.face_to_cell_index (i, face), q_point));
         }
 
-      std::vector<unsigned int> face_dof_indices (fe.dofs_per_face);
+      std::vector<types::global_dof_index> face_dof_indices (fe.dofs_per_face);
 
       cell->face (face)->get_dof_indices (face_dof_indices, cell->active_fe_index ());
 
@@ -4045,7 +4045,7 @@ namespace VectorTools
                                            // compute a second one.
           const unsigned int& n_dofs = dof_handler.n_dofs ();
           std::vector<double> dof_values (n_dofs);
-          std::vector<unsigned int> projected_dofs (n_dofs);
+          std::vector<types::global_dof_index> projected_dofs (n_dofs);
 
           for (unsigned int dof = 0; dof < n_dofs; ++dof)
             projected_dofs[dof] = 0;
@@ -4182,7 +4182,7 @@ namespace VectorTools
         {
           const unsigned int& n_dofs = dof_handler.n_dofs ();
           std::vector<double> dof_values (n_dofs);
-          std::vector<unsigned int> projected_dofs (n_dofs);
+          std::vector<types::global_dof_index> projected_dofs (n_dofs);
 
           for (unsigned int dof = 0; dof < n_dofs; ++dof)
             projected_dofs[dof] = 0;
@@ -4254,7 +4254,7 @@ namespace VectorTools
                         "to imposing Dirichlet values on the vector-valued "
                         "quantity."));
 
-    std::vector<unsigned int> face_dofs;
+    std::vector<types::global_dof_index> face_dofs;
 
                                      // create FE and mapping
                                      // collections for all elements in
index daab651e371958b5e0e2252b3869f8ba4e19e4d9..812b048bb832789d73f9bbf940275f44092fcbca 100644 (file)
@@ -268,7 +268,7 @@ void PointValueHistory<dim>
     }
 
 
-  std::vector<unsigned int>
+  std::vector<types::global_dof_index>
     local_dof_indices (dof_handler->get_fe ().dofs_per_cell);
   std::vector <int> new_solution_indices;
   current_cell->get_dof_indices (local_dof_indices);
index c449e9384b0c42630ac0ccf6f59fddf524a40cde..341dc3092f798dd887dcf58368d8866aa26f161c 100644 (file)
@@ -497,7 +497,7 @@ interpolate (const std::vector<VECTOR> &all_in,
                          " at the same time!"));
 
   Vector<typename VECTOR::value_type> local_values;
-  std::vector<unsigned int> dofs;
+  std::vector<types::global_dof_index> dofs;
 
   typename std::map<std::pair<unsigned int, unsigned int>, Pointerstruct>::const_iterator
     pointerstruct,

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.