]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Fix some conversion warnings.
authorBruno Turcksin <bruno.turcksin@gmail.com>
Tue, 16 Apr 2013 18:35:01 +0000 (18:35 +0000)
committerBruno Turcksin <bruno.turcksin@gmail.com>
Tue, 16 Apr 2013 18:35:01 +0000 (18:35 +0000)
git-svn-id: https://svn.dealii.org/branches/branch_bigger_global_dof_indices_4@29312 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/include/deal.II/dofs/dof_accessor.templates.h
deal.II/include/deal.II/lac/block_sparse_matrix_ez.h
deal.II/include/deal.II/lac/matrix_block.h
deal.II/include/deal.II/numerics/point_value_history.h
deal.II/source/numerics/matrix_tools.cc
deal.II/source/numerics/point_value_history.cc

index f08bd965a892cb64db2a875a15c8e1a0ed98319d..23d3f7379115ba376009d2351da0254501d91b7f 100644 (file)
@@ -2613,9 +2613,6 @@ namespace internal
           for (unsigned int d=0; d<dofs_per_vertex; ++d, ++index)
             accessor.set_vertex_dof_index(vertex,d,
                                           local_dof_indices[index]);
-        //TODO[bt] the function dof_index expects two unsigned int (I am not
-        //sure what should be the type of fe_index) but the following loop
-        //seems to do nothing but incrementing index.
         for (unsigned int d=0; d<dofs_per_line; ++d, ++index)
           accessor.dof_index(d, local_dof_indices[index]);
 
index 79db7b54b1e65c85928d5bf0170dbcd3e6ffd9f4..e077eb3e1554c214d3cca601cb3e07dc6bb52314 100644 (file)
@@ -471,8 +471,8 @@ BlockSparseMatrixEZ<Number>::vmult (BlockVector<somenumber>       &dst,
 
   dst = 0.;
 
-  for (size_type row=0; row<n_block_rows(); ++row)
-    for (size_type col=0; col<n_block_cols(); ++col)
+  for (unsigned int row=0; row<n_block_rows(); ++row)
+    for (unsigned int col=0; col<n_block_cols(); ++col)
       block(row,col).vmult_add (dst.block(row),
                                 src.block(col));
 }
@@ -491,8 +491,8 @@ vmult_add (BlockVector<somenumber>       &dst,
   Assert (src.n_blocks() == n_block_cols(),
           ExcDimensionMismatch(src.n_blocks(), n_block_cols()));
 
-  for (size_type row=0; row<n_block_rows(); ++row)
-    for (size_type col=0; col<n_block_cols(); ++col)
+  for (unsigned int row=0; row<n_block_rows(); ++row)
+    for (unsigned int col=0; col<n_block_cols(); ++col)
       block(row,col).vmult_add (dst.block(row),
                                 src.block(col));
 }
index c26ece3303f59b408daa997dbcc7e78464c8c591..946cccca20a663ca228f31da1540d99e9bfe458a 100644 (file)
@@ -48,7 +48,7 @@ namespace internal
  * system. Using the add() functions of this class, it is possible to
  * use the standard assembling functions used for block matrices, but
  * only enter in one of the blocks and still avoiding the index
- * computations innvolved.
+ * computations involved.
 
  * The reason for this class is, that we may need a different number
  * of matrices for different blocks in a block system. For example, a
@@ -128,7 +128,7 @@ public:
   /**
    * Reinitialize the matrix for a
    * new BlockSparsityPattern. This
-   * adujusts the #matrix as well
+   * adjusts the #matrix as well
    * as the #row_indices and
    * #column_indices.
    *
@@ -351,14 +351,14 @@ public:
    * position of the data member
    * matrix on the global matrix.
    */
-  unsigned int row;
+  size_type row;
   /**
    * Column coordinate.  This is
    * the position of the data
    * member matrix on the global
    * matrix.
    */
-  unsigned int column;
+  size_type column;
 
   /**
    * The matrix itself
@@ -707,8 +707,8 @@ template <class MATRIX>
 inline
 MatrixBlock<MATRIX>::MatrixBlock()
   :
-  row(deal_II_numbers::invalid_unsigned_int),
-  column(deal_II_numbers::invalid_unsigned_int)
+  row(deal_II_numbers::invalid_size_type),
+  column(deal_II_numbers::invalid_size_type)
 {}
 
 
index 0e7877caf16e8149fc1376131976881d0c5dfd3b..460d403c4b20771df2573a2dc593e6005f1a0cec 100644 (file)
@@ -62,10 +62,10 @@ namespace internal
     {
     public:
       PointGeometryData(const Point <dim> &new_requested_location, const std::vector <Point <dim> > &new_locations,
-                        const std::vector <int> &new_sol_indices);
+                        const std::vector <types::global_dof_index> &new_sol_indices);
       Point <dim> requested_location;
       std::vector <Point <dim> > support_point_locations;
-      std::vector <int> solution_indices;
+      std::vector <types::global_dof_index> solution_indices;
     };
   }
 }
index 4d95a80303bee0bafdc14fb31d125382b7ac4e9f..e20a1334c4d8ae698f0e0d226dc785a311251d88 100644 (file)
@@ -1236,7 +1236,7 @@ namespace MatrixCreator
 #ifdef DEBUG
       if (true)
         {
-          types::global_dof_index max_element = 0;
+          types::global_dof_index max_element = static_cast<types::global_dof_index>(0);
           for (std::vector<types::global_dof_index>::const_iterator i=dof_to_boundary_mapping.begin();
                i!=dof_to_boundary_mapping.end(); ++i)
             if ((*i != hp::DoFHandler<dim,spacedim>::invalid_dof_index) &&
@@ -2177,7 +2177,7 @@ namespace MatrixTools
         // in the block in which this
         // dof is located
         const types::global_dof_index dof_number = dof->first;
-        const std::pair<types::global_dof_index,unsigned int>
+        const std::pair<unsigned int,types::global_dof_index>
         block_index = index_mapping.global_to_local (dof_number);
 
         // for each boundary dof:
index 03859e48e1a03a266a2fa33b727cd218087e0d5c..a616907a0afb76bac85d89da4040706fdc242cca 100644 (file)
@@ -39,7 +39,7 @@ namespace internal
     PointGeometryData<dim>
     ::PointGeometryData (const Point <dim> &new_requested_location,
                          const std::vector <Point <dim> > &new_locations,
-                         const std::vector <int> &new_sol_indices)
+                         const std::vector <types::global_dof_index> &new_sol_indices)
     {
       requested_location = new_requested_location;
       support_point_locations = new_locations;
@@ -270,7 +270,7 @@ void PointValueHistory<dim>
 
   std::vector<types::global_dof_index>
   local_dof_indices (dof_handler->get_fe ().dofs_per_cell);
-  std::vector <int> new_solution_indices;
+  std::vector <types::global_dof_index> new_solution_indices;
   current_cell->get_dof_indices (local_dof_indices);
   // there is an implicit assumption here
   // that all the closest support point to
@@ -415,7 +415,7 @@ void PointValueHistory<dim>
   for (unsigned int point = 0; point < locations.size (); point++)
     {
       current_cell[point]->get_dof_indices (local_dof_indices);
-      std::vector <int> new_solution_indices;
+      std::vector<types::global_dof_index> new_solution_indices;
 
       for (unsigned int component = 0; component < dof_handler->get_fe ().n_components (); component++)
         {

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.