]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Convert the type returned by the various memory_consumption functions to std::size_t.
authorWolfgang Bangerth <bangerth@math.tamu.edu>
Sun, 23 Jan 2011 06:03:57 +0000 (06:03 +0000)
committerWolfgang Bangerth <bangerth@math.tamu.edu>
Sun, 23 Jan 2011 06:03:57 +0000 (06:03 +0000)
git-svn-id: https://svn.dealii.org/trunk@23248 0785d39b-7218-0410-832d-ea1e28bc413d

187 files changed:
deal.II/doc/news/changes.h
deal.II/include/deal.II/base/data_out_base.h
deal.II/include/deal.II/base/flow_function.h
deal.II/include/deal.II/base/function.h
deal.II/include/deal.II/base/function_derivative.h
deal.II/include/deal.II/base/function_lib.h
deal.II/include/deal.II/base/geometry_info.h
deal.II/include/deal.II/base/index_set.h
deal.II/include/deal.II/base/logstream.h
deal.II/include/deal.II/base/memory_consumption.h
deal.II/include/deal.II/base/mg_level_object.h
deal.II/include/deal.II/base/multithread_info.h
deal.II/include/deal.II/base/parameter_handler.h
deal.II/include/deal.II/base/quadrature.h
deal.II/include/deal.II/base/smartpointer.h
deal.II/include/deal.II/base/symmetric_tensor.h
deal.II/include/deal.II/base/table.h
deal.II/include/deal.II/base/tensor.h
deal.II/include/deal.II/base/tensor_base.h
deal.II/include/deal.II/distributed/tria.h
deal.II/include/deal.II/dofs/block_info.h
deal.II/include/deal.II/dofs/dof_faces.h
deal.II/include/deal.II/dofs/dof_handler.h
deal.II/include/deal.II/dofs/dof_levels.h
deal.II/include/deal.II/dofs/dof_objects.h
deal.II/include/deal.II/dofs/number_cache.h
deal.II/include/deal.II/fe/fe.h
deal.II/include/deal.II/fe/fe_abf.h
deal.II/include/deal.II/fe/fe_dg_vector.h
deal.II/include/deal.II/fe/fe_dg_vector.templates.h
deal.II/include/deal.II/fe/fe_dgp.h
deal.II/include/deal.II/fe/fe_dgp_monomial.h
deal.II/include/deal.II/fe/fe_dgp_nonparametric.h
deal.II/include/deal.II/fe/fe_dgq.h
deal.II/include/deal.II/fe/fe_nedelec.h
deal.II/include/deal.II/fe/fe_q.h
deal.II/include/deal.II/fe/fe_q_hierarchical.h
deal.II/include/deal.II/fe/fe_raviart_thomas.h
deal.II/include/deal.II/fe/fe_system.h
deal.II/include/deal.II/fe/fe_values.h
deal.II/include/deal.II/fe/mapping.h
deal.II/include/deal.II/fe/mapping_cartesian.h
deal.II/include/deal.II/fe/mapping_q.h
deal.II/include/deal.II/fe/mapping_q1.h
deal.II/include/deal.II/grid/grid_out.h
deal.II/include/deal.II/grid/intergrid_map.h
deal.II/include/deal.II/grid/persistent_tria.h
deal.II/include/deal.II/grid/tria.h
deal.II/include/deal.II/grid/tria_faces.h
deal.II/include/deal.II/grid/tria_iterator.h
deal.II/include/deal.II/grid/tria_levels.h
deal.II/include/deal.II/grid/tria_object.h
deal.II/include/deal.II/grid/tria_objects.h
deal.II/include/deal.II/hp/dof_faces.h
deal.II/include/deal.II/hp/dof_handler.h
deal.II/include/deal.II/hp/dof_levels.h
deal.II/include/deal.II/hp/dof_objects.h
deal.II/include/deal.II/hp/fe_collection.h
deal.II/include/deal.II/hp/mapping_collection.h
deal.II/include/deal.II/hp/q_collection.h
deal.II/include/deal.II/lac/block_indices.h
deal.II/include/deal.II/lac/block_matrix_base.h
deal.II/include/deal.II/lac/block_sparse_matrix.h
deal.II/include/deal.II/lac/block_sparse_matrix.templates.h
deal.II/include/deal.II/lac/block_sparse_matrix_ez.templates.h
deal.II/include/deal.II/lac/block_sparsity_pattern.h
deal.II/include/deal.II/lac/block_vector_base.h
deal.II/include/deal.II/lac/chunk_sparse_matrix.h
deal.II/include/deal.II/lac/chunk_sparse_matrix.templates.h
deal.II/include/deal.II/lac/chunk_sparsity_pattern.h
deal.II/include/deal.II/lac/compressed_simple_sparsity_pattern.h
deal.II/include/deal.II/lac/constraint_matrix.h
deal.II/include/deal.II/lac/filtered_matrix.h
deal.II/include/deal.II/lac/full_matrix.h
deal.II/include/deal.II/lac/full_matrix.templates.h
deal.II/include/deal.II/lac/matrix_block.h
deal.II/include/deal.II/lac/petsc_matrix_base.h
deal.II/include/deal.II/lac/petsc_vector_base.h
deal.II/include/deal.II/lac/precondition_block.h
deal.II/include/deal.II/lac/precondition_block.templates.h
deal.II/include/deal.II/lac/precondition_block_base.h
deal.II/include/deal.II/lac/sparse_decomposition.h
deal.II/include/deal.II/lac/sparse_decomposition.templates.h
deal.II/include/deal.II/lac/sparse_direct.h
deal.II/include/deal.II/lac/sparse_ilu.h
deal.II/include/deal.II/lac/sparse_ilu.templates.h
deal.II/include/deal.II/lac/sparse_matrix_ez.h
deal.II/include/deal.II/lac/sparse_matrix_ez.templates.h
deal.II/include/deal.II/lac/sparse_mic.h
deal.II/include/deal.II/lac/sparse_mic.templates.h
deal.II/include/deal.II/lac/sparse_vanka.h
deal.II/include/deal.II/lac/sparse_vanka.templates.h
deal.II/include/deal.II/lac/swappable_vector.h
deal.II/include/deal.II/lac/swappable_vector.templates.h
deal.II/include/deal.II/lac/tridiagonal_matrix.h
deal.II/include/deal.II/lac/trilinos_precondition.h
deal.II/include/deal.II/lac/trilinos_sparse_matrix.h
deal.II/include/deal.II/lac/trilinos_sparsity_pattern.h
deal.II/include/deal.II/lac/trilinos_vector_base.h
deal.II/include/deal.II/lac/vector.h
deal.II/include/deal.II/lac/vector.templates.h
deal.II/include/deal.II/lac/vector_memory.h
deal.II/include/deal.II/multigrid/mg_dof_handler.h
deal.II/include/deal.II/multigrid/mg_matrix.h
deal.II/include/deal.II/multigrid/mg_smoother.h
deal.II/include/deal.II/multigrid/mg_transfer.h
deal.II/include/deal.II/multigrid/mg_transfer.templates.h
deal.II/include/deal.II/multigrid/mg_transfer_block.h
deal.II/include/deal.II/multigrid/mg_transfer_block.templates.h
deal.II/include/deal.II/multigrid/mg_transfer_component.h
deal.II/include/deal.II/multigrid/mg_transfer_component.templates.h
deal.II/include/deal.II/numerics/data_out.h
deal.II/include/deal.II/numerics/data_out_stack.h
deal.II/include/deal.II/numerics/histogram.h
deal.II/include/deal.II/numerics/mesh_worker.h
deal.II/include/deal.II/numerics/mesh_worker_info.h
deal.II/include/deal.II/numerics/mesh_worker_info.templates.h
deal.II/include/deal.II/numerics/mesh_worker_vector_selector.h
deal.II/include/deal.II/numerics/mesh_worker_vector_selector.templates.h
deal.II/include/deal.II/numerics/solution_transfer.h
deal.II/include/deal.II/numerics/time_dependent.h
deal.II/source/base/data_out_base.cc
deal.II/source/base/flow_function.cc
deal.II/source/base/function.cc
deal.II/source/base/function_derivative.cc
deal.II/source/base/function_lib.cc
deal.II/source/base/index_set.cc
deal.II/source/base/logstream.cc
deal.II/source/base/memory_consumption.cc
deal.II/source/base/multithread_info.cc
deal.II/source/base/parameter_handler.cc
deal.II/source/base/quadrature.cc
deal.II/source/distributed/tria.cc
deal.II/source/dofs/dof_faces.cc
deal.II/source/dofs/dof_handler.cc
deal.II/source/dofs/dof_levels.cc
deal.II/source/dofs/dof_objects.cc
deal.II/source/dofs/number_cache.cc
deal.II/source/fe/fe.cc
deal.II/source/fe/fe_abf.cc
deal.II/source/fe/fe_dgp.cc
deal.II/source/fe/fe_dgp_monomial.cc
deal.II/source/fe/fe_dgp_nonparametric.cc
deal.II/source/fe/fe_dgq.cc
deal.II/source/fe/fe_nedelec.cc
deal.II/source/fe/fe_q.cc
deal.II/source/fe/fe_q_hierarchical.cc
deal.II/source/fe/fe_raviart_thomas.cc
deal.II/source/fe/fe_system.cc
deal.II/source/fe/fe_values.cc
deal.II/source/fe/mapping.cc
deal.II/source/fe/mapping_cartesian.cc
deal.II/source/fe/mapping_q.cc
deal.II/source/fe/mapping_q1.cc
deal.II/source/grid/grid_out.cc
deal.II/source/grid/intergrid_map.cc
deal.II/source/grid/persistent_tria.cc
deal.II/source/grid/tria.cc
deal.II/source/grid/tria_faces.cc
deal.II/source/grid/tria_levels.cc
deal.II/source/grid/tria_objects.cc
deal.II/source/hp/dof_faces.cc
deal.II/source/hp/dof_handler.cc
deal.II/source/hp/dof_levels.cc
deal.II/source/hp/dof_objects.cc
deal.II/source/hp/fe_collection.cc
deal.II/source/hp/mapping_collection.cc
deal.II/source/lac/block_sparsity_pattern.cc
deal.II/source/lac/chunk_sparsity_pattern.cc
deal.II/source/lac/compressed_simple_sparsity_pattern.cc
deal.II/source/lac/constraint_matrix.cc
deal.II/source/lac/petsc_matrix_base.cc
deal.II/source/lac/petsc_vector_base.cc
deal.II/source/lac/sparse_direct.cc
deal.II/source/lac/sparsity_pattern.cc
deal.II/source/lac/trilinos_precondition.cc
deal.II/source/lac/trilinos_sparse_matrix.cc
deal.II/source/lac/trilinos_vector_base.cc
deal.II/source/lac/vector_memory.cc
deal.II/source/multigrid/mg_dof_handler.cc
deal.II/source/multigrid/multigrid.cc
deal.II/source/numerics/data_out.cc
deal.II/source/numerics/data_out_stack.cc
deal.II/source/numerics/histogram.cc
deal.II/source/numerics/mesh_worker.cc
deal.II/source/numerics/solution_transfer.cc
deal.II/source/numerics/time_dependent.cc

index 80b942b22f4d382b3782d4afe982dbbe086cb598..5c65bce5de1555bef77b9e4e97200f83f9f5c5d1 100644 (file)
@@ -29,6 +29,17 @@ inconvenience this causes.
 <h3>General</h3>
 
 <ol>
+<li> Changed: Most classes in deal.II have a member function
+<code>memory_consumption</code> that used to return an unsigned int.
+However, on most 64-bit systems, unsigned int is still only 32-bit
+wide, and consequently the return type does not provide enough
+precision to return the size of very large objects. The return types
+of all of these functions has been changed to std::size_t, which is
+defined to be a type that can hold the sizes of all objects possible
+on any system.
+<br>
+(Wolfgang Bangerth, 2011/01/22)
+
 <li> Fixed: When using the <code>--enable-mpi</code> to 
 <code>./configure</code>, the script only tried <code>mpiCC</code>
 as the MPI C++ compiler. However, on some systems, it is called
index 30e3987af7cede3075b7230eac5b8b5ea4f88bd9..6daf55ce8f02a1800700df8b3ab2544fc76331ed 100644 (file)
@@ -398,7 +398,7 @@ class DataOutBase
                                          * quite close to the true
                                          * value.
                                          */
-       unsigned int memory_consumption () const;
+       std::size_t memory_consumption () const;
 
                                         /**
                                          * Value to be used if this
@@ -497,7 +497,7 @@ class DataOutBase
                                          * bytes) of this
                                          * object.
                                          */
-       unsigned int memory_consumption () const;
+       std::size_t memory_consumption () const;
     };
 
                                     /**
@@ -568,7 +568,7 @@ class DataOutBase
                                          * quite close to the true
                                          * value.
                                          */
-       unsigned int memory_consumption () const;
+       std::size_t memory_consumption () const;
     };
 
                                     /**
@@ -631,7 +631,7 @@ class DataOutBase
                                          * quite close to the true
                                          * value.
                                          */
-       unsigned int memory_consumption () const;
+       std::size_t memory_consumption () const;
     };
 
                                     /**
@@ -712,7 +712,7 @@ class DataOutBase
                                          * quite close to the true
                                          * value.
                                          */
-       unsigned int memory_consumption () const;
+       std::size_t memory_consumption () const;
     };
 
 
@@ -1043,7 +1043,7 @@ class DataOutBase
                                          * quite close to the true
                                          * value.
                                          */
-       unsigned int memory_consumption () const;
+       std::size_t memory_consumption () const;
     };
 
                                     /**
@@ -1107,7 +1107,7 @@ class DataOutBase
                                          * quite close to the true
                                          * value.
                                          */
-       unsigned int memory_consumption () const;
+       std::size_t memory_consumption () const;
     };
 
                                     /**
@@ -1180,7 +1180,7 @@ class DataOutBase
                                          * quite close to the true
                                          * value.
                                          */
-       unsigned int memory_consumption () const;
+       std::size_t memory_consumption () const;
     };
 
                                     /**
@@ -1244,7 +1244,7 @@ class DataOutBase
                                          * quite close to the true
                                          * value.
                                          */
-       unsigned int memory_consumption () const;
+       std::size_t memory_consumption () const;
     };
                                     /**
                                      * Flags controlling the details
@@ -1322,7 +1322,7 @@ class DataOutBase
                                          * quite close to the true
                                          * value.
                                          */
-       unsigned int memory_consumption () const;
+       std::size_t memory_consumption () const;
     };
 
                                     /**
@@ -1867,7 +1867,7 @@ class DataOutBase
                                      * quite close to the true
                                      * value.
                                      */
-    static unsigned int memory_consumption ();
+    static std::size_t memory_consumption ();
 
                                     /** @addtogroup Exceptions
                                      * @{ */
@@ -2457,7 +2457,7 @@ class DataOutInterface : private DataOutBase
                                      * quite close to the true
                                      * value.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 
   protected:
                                     /**
index 7919746a914352317c1332cc703a2b64349554ef..5d40aab9532539afbafca6c15a4642c02c5ecba9 100644 (file)
@@ -115,7 +115,7 @@ namespace Functions
       virtual void vector_laplacian_list (const std::vector<Point<dim> > &points,
                                          std::vector<Vector<double> >   &values) const;
 
-      unsigned int memory_consumption () const;
+      std::size_t memory_consumption () const;
 
     protected:
                                       /**
index 56259c135703d963f35fb29d17bf4241d5af5866..baee75ab75aa3097cb78f86869472c4ca906dd15 100644 (file)
@@ -371,7 +371,7 @@ class Function : public FunctionTime,
                                      * quite close to the true
                                      * value.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 };
 
 
@@ -592,7 +592,7 @@ class ConstantFunction : public ZeroFunction<dim>
                                      * quite close to the true
                                      * value.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 
   protected:
                                     /**
@@ -695,7 +695,7 @@ class ComponentSelectFunction : public ConstantFunction<dim>
                                      * quite close to the true
                                      * value.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 
   protected:
                                     /**
index 6a253ba4256214d0b075edbc6213194554d2defd..56fb8d24636167ac0c219c7486df439a96859eac 100644 (file)
@@ -124,7 +124,7 @@ class FunctionDerivative : public AutoDerivativeFunction<dim>
                                      * quite close to the true
                                      * value.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
     
                                     /** @addtogroup Exceptions
                                      * @{ */
index 9d49aeee99e7a9404023297fd85e640db0c47470..17fd848d0f6f3aaf97028862dac46bd947b8b066 100644 (file)
@@ -599,7 +599,7 @@ namespace Functions
                                        * quite close to the true
                                        * value.
                                        */
-      unsigned int memory_consumption () const;
+      std::size_t memory_consumption () const;
       
     protected:
                                       /**
index 8e821eba228d109b00817df9ef4778a1aec1b20c..e7c0ae928811422496fab06baf154551b669a97b 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009 by the deal.II authors
+//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -379,7 +379,7 @@ class RefinementCase : public RefinementPossibilities<dim>
                                      * occupied by an object of this
                                      * type.
                                      */
-    static unsigned int memory_consumption ();
+    static std::size_t memory_consumption ();
 
                                     /**
                                      * Exception.
@@ -726,7 +726,7 @@ namespace internal
                                        * occupied by an object of this
                                        * type.
                                        */
-      static unsigned int memory_consumption ();
+      static std::size_t memory_consumption ();
 
                                       /**
                                        * Exception.
@@ -2441,7 +2441,7 @@ RefinementCase<dim>::operator ~ () const
 
 template <int dim>
 inline
-unsigned int
+std::size_t
 RefinementCase<dim>::memory_consumption ()
 {
   return sizeof(RefinementCase<dim>);
index 0c0b59213cc32a1c7c0f44d85967062746de9dde..7ad043fa158b6d86fddf1bef2e0660f7d3a168c9 100644 (file)
@@ -358,7 +358,7 @@ class IndexSet
                                       * consumption (in bytes) of this
                                       * object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 
     DeclException1 (ExcIndexNotPresent, int,
                    << "The global index " << arg1
@@ -429,7 +429,7 @@ class IndexSet
                    (range_1.begin == range_2.begin));
          }
 
-       unsigned int memory_consumption () const
+       std::size_t memory_consumption () const
          {
            return sizeof(Range);
          }
index 131b02f0190b8336d78752cd778f3cec88e93b7f..5c3a261e571075f10b8611f4fd947d865cf4d5fd 100644 (file)
@@ -298,7 +298,7 @@ class LogStream
                                      * quite close to the true
                                      * value.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 
                                     /**
                                      * Exception.
index 970deacc8c70b9a16f97394e2a2e92b897592842..cc39babd1292c5612da9144545e2021dcc296e8a 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2009, 2010 by the deal.II authors
+//    Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -20,7 +20,7 @@
 #include <string>
 #include <complex>
 #include <vector>
-#include <utility>
+#include <cstddef>
 
 DEAL_II_NAMESPACE_OPEN
 
@@ -103,7 +103,7 @@ namespace MemoryConsumption
                                    */
   template <typename T>
   inline
-  unsigned int memory_consumption (const T &t);
+  std::size_t memory_consumption (const T &t);
 
                                   /**
                                    * Determine the amount of memory
@@ -111,7 +111,7 @@ namespace MemoryConsumption
                                    * variable.
                                    */
   inline
-  unsigned int memory_consumption (const bool);
+  std::size_t memory_consumption (const bool);
 
                                   /**
                                    * Determine the amount of memory
@@ -119,7 +119,7 @@ namespace MemoryConsumption
                                    * variable.
                                    */
   inline
-  unsigned int memory_consumption (const char);
+  std::size_t memory_consumption (const char);
 
                                   /**
                                    * Determine the amount of memory
@@ -127,7 +127,7 @@ namespace MemoryConsumption
                                    * <tt>short int</tt> variable.
                                    */
   inline
-  unsigned int memory_consumption (const short int);
+  std::size_t memory_consumption (const short int);
 
                                   /**
                                    * Determine the amount of memory
@@ -135,7 +135,7 @@ namespace MemoryConsumption
                                    * <tt>short unsigned int</tt> variable.
                                    */
   inline
-  unsigned int memory_consumption (const short unsigned int);
+  std::size_t memory_consumption (const short unsigned int);
 
                                   /**
                                    * Determine the amount of memory
@@ -143,7 +143,7 @@ namespace MemoryConsumption
                                    * variable.
                                    */
   inline
-  unsigned int memory_consumption (const int);
+  std::size_t memory_consumption (const int);
 
                                   /**
                                    * Determine the amount of memory
@@ -151,7 +151,7 @@ namespace MemoryConsumption
                                    * variable.
                                    */
   inline
-  unsigned int memory_consumption (const unsigned int);
+  std::size_t memory_consumption (const unsigned int);
 
                                   /**
                                    * Determine the amount of memory
@@ -159,7 +159,7 @@ namespace MemoryConsumption
                                    * variable.
                                    */
   inline
-  unsigned int memory_consumption (const float);
+  std::size_t memory_consumption (const float);
 
                                   /**
                                    * Determine the amount of memory
@@ -167,7 +167,7 @@ namespace MemoryConsumption
                                    * variable.
                                    */
   inline
-  unsigned int memory_consumption (const double);
+  std::size_t memory_consumption (const double);
 
                                   /**
                                    * Determine the amount of memory
@@ -175,7 +175,7 @@ namespace MemoryConsumption
                                    * variable.
                                    */
   inline
-  unsigned int memory_consumption (const long double);
+  std::size_t memory_consumption (const long double);
 
                                   /**
                                    * Determine the amount of memory
@@ -184,7 +184,7 @@ namespace MemoryConsumption
                                    */
   template <typename T>
   inline
-  unsigned int memory_consumption (const std::complex<T> &);
+  std::size_t memory_consumption (const std::complex<T> &);
 
                                   /**
                                    * Determine an estimate of the
@@ -193,7 +193,7 @@ namespace MemoryConsumption
                                    * variable.
                                    */
   inline
-  unsigned int memory_consumption (const std::string &s);
+  std::size_t memory_consumption (const std::string &s);
 
                                   /**
                                    * Determine the amount of memory
@@ -247,7 +247,7 @@ namespace MemoryConsumption
                                    */
   template <typename T>
   inline
-  unsigned int memory_consumption (const std::vector<T> &v);
+  std::size_t memory_consumption (const std::vector<T> &v);
 
                                   /**
                                    * Estimate the amount of memory
@@ -266,7 +266,7 @@ namespace MemoryConsumption
                                    */
   template <typename T, int N>
   inline
-  unsigned int memory_consumption (const T (&v)[N]);
+  std::size_t memory_consumption (const T (&v)[N]);
 
                                   /**
                                    * Specialization of the
@@ -280,7 +280,7 @@ namespace MemoryConsumption
                                    * field.
                                    */
   inline
-  unsigned int memory_consumption (const std::vector<bool> &v);
+  std::size_t memory_consumption (const std::vector<bool> &v);
 
                                   /**
                                    * Specialization of the
@@ -289,7 +289,7 @@ namespace MemoryConsumption
                                    * for a vector of <tt>int</tt>s.
                                    */
   inline
-  unsigned int memory_consumption (const std::vector<int> &v);
+  std::size_t memory_consumption (const std::vector<int> &v);
 
                                   /**
                                    * Specialization of the
@@ -298,7 +298,7 @@ namespace MemoryConsumption
                                    * for a vector of <tt>double</tt>s.
                                    */
   inline
-  unsigned int memory_consumption (const std::vector<double> &v);
+  std::size_t memory_consumption (const std::vector<double> &v);
 
                                   /**
                                    * Specialization of the
@@ -307,7 +307,7 @@ namespace MemoryConsumption
                                    * for a vector of <tt>float</tt>s.
                                    */
   inline
-  unsigned int memory_consumption (const std::vector<float> &v);
+  std::size_t memory_consumption (const std::vector<float> &v);
 
                                   /**
                                    * Specialization of the
@@ -316,7 +316,7 @@ namespace MemoryConsumption
                                    * for a vector of <tt>char</tt>s.
                                    */
   inline
-  unsigned int memory_consumption (const std::vector<char> &v);
+  std::size_t memory_consumption (const std::vector<char> &v);
 
                                   /**
                                    * Specialization of the
@@ -325,7 +325,7 @@ namespace MemoryConsumption
                                    * for a vector of <tt>unsigned char</tt>s.
                                    */
   inline
-  unsigned int memory_consumption (const std::vector<unsigned char> &v);
+  std::size_t memory_consumption (const std::vector<unsigned char> &v);
 
                                   /**
                                    * Specialization of the
@@ -335,7 +335,7 @@ namespace MemoryConsumption
                                    */
   template <typename T>
   inline
-  unsigned int memory_consumption (const std::vector<T *> &v);
+  std::size_t memory_consumption (const std::vector<T *> &v);
 
                                   /**
                                    * Specialization of the
@@ -350,7 +350,7 @@ namespace MemoryConsumption
                                    * doesn't harm for other compilers
                                    * as well.
                                    */
-  unsigned int memory_consumption (const std::vector<std::string> &v);
+  std::size_t memory_consumption (const std::vector<std::string> &v);
 
 
                                   /**
@@ -360,7 +360,7 @@ namespace MemoryConsumption
                                    */
   template <typename A, typename B>
   inline
-  unsigned int memory_consumption (const std::pair<A,B> &p);
+  std::size_t memory_consumption (const std::pair<A,B> &p);
 
                                   /**
                                    * Return the amount of memory
@@ -372,7 +372,7 @@ namespace MemoryConsumption
                                    */
   template <typename T>
   inline
-  unsigned int memory_consumption (const T * const);
+  std::size_t memory_consumption (const T * const);
 
                                   /**
                                    * Return the amount of memory
@@ -384,7 +384,7 @@ namespace MemoryConsumption
                                    */
   template <typename T>
   inline
-  unsigned int memory_consumption (T * const);
+  std::size_t memory_consumption (T * const);
 
                                   /**
                                    * Return the amount of memory
@@ -402,7 +402,7 @@ namespace MemoryConsumption
                                    * pointed to.
                                    */
   inline
-  unsigned int memory_consumption (void * const);
+  std::size_t memory_consumption (void * const);
 
                                   /**
                                    * Return the amount of memory used
@@ -414,7 +414,7 @@ namespace MemoryConsumption
                                    */
   template <typename T>
   inline
-  unsigned int memory_consumption (const std_cxx1x::shared_ptr<T> &);
+  std::size_t memory_consumption (const std_cxx1x::shared_ptr<T> &);
 }
 
 
@@ -424,7 +424,7 @@ namespace MemoryConsumption
 namespace MemoryConsumption
 {
   inline
-  unsigned int memory_consumption (const bool)
+  std::size_t memory_consumption (const bool)
   {
     return sizeof(bool);
   }
@@ -432,7 +432,7 @@ namespace MemoryConsumption
 
 
   inline
-  unsigned int memory_consumption (const char)
+  std::size_t memory_consumption (const char)
   {
     return sizeof(char);
   }
@@ -440,7 +440,7 @@ namespace MemoryConsumption
 
 
   inline
-  unsigned int memory_consumption (const short int)
+  std::size_t memory_consumption (const short int)
   {
     return sizeof(short int);
   }
@@ -448,7 +448,7 @@ namespace MemoryConsumption
 
 
   inline
-  unsigned int memory_consumption (const short unsigned int)
+  std::size_t memory_consumption (const short unsigned int)
   {
     return sizeof(short unsigned int);
   }
@@ -456,7 +456,7 @@ namespace MemoryConsumption
 
 
   inline
-  unsigned int memory_consumption (const int)
+  std::size_t memory_consumption (const int)
   {
     return sizeof(int);
   }
@@ -464,7 +464,7 @@ namespace MemoryConsumption
 
 
   inline
-  unsigned int memory_consumption (const unsigned int)
+  std::size_t memory_consumption (const unsigned int)
   {
     return sizeof(unsigned int);
   }
@@ -472,7 +472,7 @@ namespace MemoryConsumption
 
 
   inline
-  unsigned int memory_consumption (const float)
+  std::size_t memory_consumption (const float)
   {
     return sizeof(float);
   }
@@ -480,7 +480,7 @@ namespace MemoryConsumption
 
 
   inline
-  unsigned int memory_consumption (const double)
+  std::size_t memory_consumption (const double)
   {
     return sizeof(double);
   }
@@ -488,7 +488,7 @@ namespace MemoryConsumption
 
 
   inline
-  unsigned int memory_consumption (const long double)
+  std::size_t memory_consumption (const long double)
   {
     return sizeof(long double);
   }
@@ -496,7 +496,7 @@ namespace MemoryConsumption
 
   template <typename T>
   inline
-  unsigned int memory_consumption (const std::complex<T> &)
+  std::size_t memory_consumption (const std::complex<T> &)
   {
     return sizeof(std::complex<T>);
   }
@@ -504,7 +504,7 @@ namespace MemoryConsumption
 
 
   inline
-  unsigned int memory_consumption (const std::string &s)
+  std::size_t memory_consumption (const std::string &s)
   {
     return sizeof(s) + s.length();
   }
@@ -512,7 +512,7 @@ namespace MemoryConsumption
 
 
   template <typename T>
-  unsigned int memory_consumption (const std::vector<T> &v)
+  std::size_t memory_consumption (const std::vector<T> &v)
   {
     unsigned int mem = sizeof(std::vector<T>);
     const unsigned int n = v.size();
@@ -525,7 +525,7 @@ namespace MemoryConsumption
 
 
   template <typename T, int N>
-  unsigned int memory_consumption (const T (&v)[N])
+  std::size_t memory_consumption (const T (&v)[N])
   {
     unsigned int mem = 0;
     for (unsigned int i=0; i<N; ++i)
@@ -536,7 +536,7 @@ namespace MemoryConsumption
 
 
   inline
-  unsigned int memory_consumption (const std::vector<bool> &v)
+  std::size_t memory_consumption (const std::vector<bool> &v)
   {
     return v.capacity() / 8 + sizeof(v);
   }
@@ -544,7 +544,7 @@ namespace MemoryConsumption
 
 
   inline
-  unsigned int memory_consumption (const std::vector<int> &v)
+  std::size_t memory_consumption (const std::vector<int> &v)
   {
     return (v.capacity() * sizeof(int) +
            sizeof(v));
@@ -553,7 +553,7 @@ namespace MemoryConsumption
 
 
   inline
-  unsigned int memory_consumption (const std::vector<double> &v)
+  std::size_t memory_consumption (const std::vector<double> &v)
   {
     return (v.capacity() * sizeof(double) +
            sizeof(v));
@@ -562,7 +562,7 @@ namespace MemoryConsumption
 
 
   inline
-  unsigned int memory_consumption (const std::vector<float> &v)
+  std::size_t memory_consumption (const std::vector<float> &v)
   {
     return (v.capacity() * sizeof(float) +
            sizeof(v));
@@ -571,7 +571,7 @@ namespace MemoryConsumption
 
 
   inline
-  unsigned int memory_consumption (const std::vector<char> &v)
+  std::size_t memory_consumption (const std::vector<char> &v)
   {
     return (v.capacity() * sizeof(char) +
            sizeof(v));
@@ -580,7 +580,7 @@ namespace MemoryConsumption
 
 
   inline
-  unsigned int memory_consumption (const std::vector<unsigned char> &v)
+  std::size_t memory_consumption (const std::vector<unsigned char> &v)
   {
     return (v.capacity() * sizeof(unsigned char) +
            sizeof(v));
@@ -590,7 +590,7 @@ namespace MemoryConsumption
 
   template <typename T>
   inline
-  unsigned int memory_consumption (const std::vector<T *> &v)
+  std::size_t memory_consumption (const std::vector<T *> &v)
   {
     return (v.capacity() * sizeof(T *) +
            sizeof(v));
@@ -600,7 +600,7 @@ namespace MemoryConsumption
 
   template <typename A, typename B>
   inline
-  unsigned int memory_consumption (const std::pair<A,B> &p)
+  std::size_t memory_consumption (const std::pair<A,B> &p)
   {
     return (memory_consumption(p.first) +
            memory_consumption(p.second));
@@ -610,7 +610,7 @@ namespace MemoryConsumption
 
   template <typename T>
   inline
-  unsigned int
+  std::size_t
   memory_consumption (const T * const)
   {
     return sizeof(T*);
@@ -620,7 +620,7 @@ namespace MemoryConsumption
 
   template <typename T>
   inline
-  unsigned int
+  std::size_t
   memory_consumption (T * const)
   {
     return sizeof(T*);
@@ -629,7 +629,7 @@ namespace MemoryConsumption
 
 
   inline
-  unsigned int
+  std::size_t
   memory_consumption (void * const)
   {
     return sizeof(void*);
@@ -639,7 +639,7 @@ namespace MemoryConsumption
 
   template <typename T>
   inline
-  unsigned int
+  std::size_t
   memory_consumption (const std_cxx1x::shared_ptr<T> &)
   {
     return sizeof(std_cxx1x::shared_ptr<T>);
@@ -649,7 +649,7 @@ namespace MemoryConsumption
 
   template <typename T>
   inline
-  unsigned int
+  std::size_t
   memory_consumption (const T &t)
   {
     return t.memory_consumption();
index 6cebc0c8014308e5475c6316174f7f6aefafc44e..15a3317d02ae4b6e199c3440a4e80cdd3e724945 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2003, 2004, 2005, 2006, 2010 by the deal.II authors
+//    Copyright (C) 2003, 2004, 2005, 2006, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -111,7 +111,7 @@ class MGLevelObject : public Subscriptor
                                     /**
                                      * Memory used by this object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
     
   private:
                                     /**
@@ -231,10 +231,10 @@ MGLevelObject<Object>::max_level () const
 
 
 template<class Object>
-unsigned int
+std::size_t
 MGLevelObject<Object>::memory_consumption () const
 {
-  unsigned int result = sizeof(*this);
+  std::size_t result = sizeof(*this);
   typedef typename std::vector<std_cxx1x::shared_ptr<Object> >::const_iterator Iter;
   const Iter end = objects.end();
   for (Iter o=objects.begin(); o!=end; ++o)
index ace22c2036ad27ebfbf55eb1256915e73236fb2f..da5bb2da50d6e8ba2e5ce2a78832ada9ec84d2bf 100644 (file)
@@ -96,7 +96,7 @@ class MultithreadInfo
                                      * quite close to the true
                                      * value.
                                      */
-    static unsigned int memory_consumption ();
+    static std::size_t memory_consumption ();
 
                                     /**
                                      * Exception
index 2558aa0973c9fc75bdec09a145aa2add7badae4a..df9fdb954630370c3ce9cb528f8bd314eb8fabd7 100644 (file)
@@ -144,7 +144,7 @@ namespace Patterns
                                        * you can still overload
                                        * this function.
                                        */
-      virtual unsigned int memory_consumption () const;
+      virtual std::size_t memory_consumption () const;
   };
 
                        /**
@@ -507,7 +507,7 @@ namespace Patterns
                                        * the memory consumption (in
                                        * bytes) of this object.
                                        */
-      unsigned int memory_consumption () const;
+      std::size_t memory_consumption () const;
 
                                       /**
                                        * Creates new object if the start of
@@ -623,7 +623,7 @@ namespace Patterns
                                        * the memory consumption (in
                                        * bytes) of this object.
                                        */
-      unsigned int memory_consumption () const;
+      std::size_t memory_consumption () const;
 
                                       /** @addtogroup Exceptions
                                        * @{ */
@@ -738,7 +738,7 @@ namespace Patterns
                                        * the memory consumption (in
                                        * bytes) of this object.
                                        */
-      unsigned int memory_consumption () const;
+      std::size_t memory_consumption () const;
 
                                       /** @addtogroup Exceptions
                                        * @{ */
@@ -2080,7 +2080,7 @@ class ParameterHandler : public Subscriptor
                                      * bytes) of this
                                      * object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 
                          /**
                       * Write the data of this object to
@@ -2530,7 +2530,7 @@ class MultipleParameterLoop : public ParameterHandler
                                      * bytes) of this
                                      * object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 
   private:
 
@@ -2608,7 +2608,7 @@ class MultipleParameterLoop : public ParameterHandler
                                          * bytes) of this
                                          * object.
                                          */
-       unsigned int memory_consumption () const;
+       std::size_t memory_consumption () const;
     };
 
                                     /**
index 5907346f813d8f923c9c6725b41e82fa3339ba6f..6be3dbdec86142a3f1d68b5e83e0509144c20910 100644 (file)
@@ -245,7 +245,7 @@ class Quadrature : public Subscriptor
                                      * bytes) of this
                                      * object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 
                          /**
                       * Write or read the data of this object to or 
index 36621b14ec7f94bf2887fc1d9a0e193ae70ddc29..df5e5e30606724573604764a8ee86d7d6bfc7526 100644 (file)
@@ -1,7 +1,7 @@
 //---------------------------------------------------------------------------
 //    $Id$
 //
-//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2009, 2010 by the deal.II authors
+//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -229,7 +229,7 @@ class SmartPointer
                                      * used by <b>this</b> object, not
                                      * by the object pointed to.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
     
   private:
                                     /**
@@ -459,7 +459,8 @@ void SmartPointer<T,P>::swap (T *&tt)
 
 template <typename T, typename P>
 inline
-unsigned int SmartPointer<T,P>::memory_consumption () const
+std::size_t
+SmartPointer<T,P>::memory_consumption () const
 {
   return sizeof(SmartPointer<T,P>);
 }
index 5196f2698d3ab75f9a68b26d5d91f78554d618fb..85cbed02c557ae4cec9d1276f88d7181ba43befe 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2005, 2006, 2008, 2009, 2010 by the deal.II authors
+//    Copyright (C) 2005, 2006, 2008, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -966,7 +966,7 @@ class SymmetricTensor
                                      * bytes) of this
                                      * object.
                                      */
-    static unsigned int memory_consumption ();
+    static std::size_t memory_consumption ();
 
                      /**
                       * Read or write the data of this object to or 
@@ -1300,7 +1300,7 @@ SymmetricTensor<rank,dim>::clear ()
 
 template <int rank, int dim>
 inline
-unsigned int
+std::size_t
 SymmetricTensor<rank,dim>::memory_consumption ()
 {
   return
index bb63d483bab7d067adef88581c66c8a8c9ade078..31ad01aa6bb8158f8ad7889dca1c23b97ca5c608 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors
+//    Copyright (C) 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -649,7 +649,7 @@ class TableBase : public Subscriptor
                                       * memory consumption (in bytes)
                                       * of this object.
                                       */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 
                                      /**
                                       * Write or read the data of this object to or 
@@ -2089,7 +2089,7 @@ TableBase<N,T>::fill (const T2* entries)
 
 template <int N, typename T>
 inline
-unsigned int
+std::size_t
 TableBase<N,T>::memory_consumption () const
 {
   return sizeof(*this) + MemoryConsumption::memory_consumption(values);
index e7f9a3d09bccea851b7a772ed106d5ca4cf23af9..448d7c823ce9477897be450e1042462802a4eb29 100644 (file)
@@ -234,7 +234,7 @@ class Tensor
                                      * memory consumption (in bytes)
                                      * of this object.
                                      */
-    static unsigned int memory_consumption ();
+    static std::size_t memory_consumption ();
 
                                      /**
                                       * Exception.
@@ -483,7 +483,7 @@ void Tensor<rank_,dim>::clear ()
 
 template <int rank_, int dim>
 inline
-unsigned int
+std::size_t
 Tensor<rank_,dim>::memory_consumption ()
 {
   return sizeof(Tensor<rank_,dim>);
index 82addaafae4b54c64b4d80095dcb298c43628ddb..0a9f3c23c29e8a5ecd1e34a07216ddbb3883438c 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2009, 2010 by the deal.II authors
+//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -540,7 +540,7 @@ class Tensor<1,dim>
                                      * bytes) of this
                                      * object.
                                      */
-    static unsigned int memory_consumption ();
+    static std::size_t memory_consumption ();
 
                                      /**
                                       * Only tensors with a positive
@@ -1199,7 +1199,7 @@ void Tensor<1,dim>::clear ()
 
 template <int dim>
 inline
-unsigned int
+std::size_t
 Tensor<1,dim>::memory_consumption ()
 {
   return sizeof(Tensor<1,dim>);
index 9a75162a737fb9a31d5a04c5c4a6c8855a5ace3f..60ef7bd114475dc82306eba7682b5547e01dbc45 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2008, 2009, 2010 by the deal.II authors
+//    Copyright (C) 2008, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -378,7 +378,7 @@ namespace parallel
                                          * Return the local memory
                                          * consumption in bytes.
                                          */
-       virtual unsigned int memory_consumption () const;
+       virtual std::size_t memory_consumption () const;
 
                                         /**
                                          * Return the local memory
@@ -389,7 +389,7 @@ namespace parallel
                                          * available separately for debugging
                                          * purposes.
                                          */
-       virtual unsigned int memory_consumption_p4est () const;
+       virtual std::size_t memory_consumption_p4est () const;
 
                                         /**
                                          * A collective operation that produces
@@ -458,7 +458,7 @@ namespace parallel
                                          * notify_ready_to_unpack().
                                          */
        unsigned int
-       register_data_attach (const size_t size,
+       register_data_attach (const std::size_t size,
                              const std_cxx1x::function<void (const cell_iterator &,
                                                              const CellStatus,
                                                              void*)> & pack_callback);
index 78b916ed0f4fd31692e3ef5f223e139d892f9928..b297b03b73168b0af71f41ae10786e51363e1f88 100644 (file)
@@ -187,7 +187,7 @@ class BlockInfo : public Subscriptor
                                      * memory consumption (in bytes)
                                      * of this object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 
   private:
                                     /**
@@ -313,16 +313,13 @@ BlockInfo::print (OS& os) const
 
 
 inline
-unsigned int
+std::size_t
 BlockInfo::memory_consumption () const
 {
-  unsigned int mem = (MemoryConsumption::memory_consumption (bi_global) +
-                     MemoryConsumption::memory_consumption (levels) +
-                     MemoryConsumption::memory_consumption (bi_local) +
-                     MemoryConsumption::memory_consumption (base_elements)
-  );
-
-  return mem;
+  return (MemoryConsumption::memory_consumption (bi_global) +
+         MemoryConsumption::memory_consumption (levels) +
+         MemoryConsumption::memory_consumption (bi_local) +
+         MemoryConsumption::memory_consumption (base_elements));
 }
 
 
index ce1ca18ff1fec608e1ea628cb83e8f77a2453816..306207cce4499cd337b03609961113fbc54b156b 100644 (file)
@@ -86,7 +86,7 @@ namespace internal
                                           * memory consumption (in bytes)
                                           * of this object.
                                           */
-        unsigned int memory_consumption () const;
+        std::size_t memory_consumption () const;
     };
 
 /**
@@ -109,7 +109,7 @@ namespace internal
                                           * memory consumption (in bytes)
                                           * of this object.
                                           */
-        unsigned int memory_consumption () const;
+        std::size_t memory_consumption () const;
     };
 
 /**
@@ -138,7 +138,7 @@ namespace internal
                                           * memory consumption (in bytes)
                                           * of this object.
                                           */
-        unsigned int memory_consumption () const;
+        std::size_t memory_consumption () const;
     };
 
   }
index facad4496b4d7d0f4378b5196295f09958450ae5..3a57c8bd4b9655828246f4c2cb75407d4d1c2451 100644 (file)
@@ -1191,7 +1191,7 @@ class DoFHandler  :  public Subscriptor
                                      * although the actual object
                                      * might be a derived class.
                                      */
-    virtual unsigned int memory_consumption () const;
+    virtual std::size_t memory_consumption () const;
 
                                     /**
                                      * @todo Replace by ExcInternalError.
index 331feb1ba05d61e93b0800e0797dcecb56adc35d..652345466e438b4f08e8d45bb744f2b229aa74aa 100644 (file)
@@ -116,7 +116,7 @@ namespace internal
                                           * memory consumption (in bytes)
                                           * of this object.
                                           */
-        unsigned int memory_consumption () const;
+        std::size_t memory_consumption () const;
     };
     
 /**
@@ -140,7 +140,7 @@ namespace internal
                                           * memory consumption (in bytes)
                                           * of this object.
                                           */
-        unsigned int memory_consumption () const;
+        std::size_t memory_consumption () const;
     };
 
 
@@ -165,7 +165,7 @@ namespace internal
                                           * memory consumption (in bytes)
                                           * of this object.
                                           */
-        unsigned int memory_consumption () const;
+        std::size_t memory_consumption () const;
     };
 
 
@@ -190,7 +190,7 @@ namespace internal
                                           * memory consumption (in bytes)
                                           * of this object.
                                           */
-        unsigned int memory_consumption () const;
+        std::size_t memory_consumption () const;
     };
 
   }
index 918f0dd38f28f6e7bef676f3381a34e24e6a55bb..65457702105b969d236bcbc9d66a3c34bb1bbb1d 100644 (file)
@@ -164,7 +164,7 @@ namespace internal
                                           * memory consumption (in bytes)
                                           * of this object.
                                           */
-        unsigned int memory_consumption () const;
+        std::size_t memory_consumption () const;
        
                                          /**
                                           * Make the DoFHandler and
index e6bacba8f856bdb6a43b6edd31e5c124a02b67f4..a7ee3903ca4f7b8acab53c49b53e1c70303aa14e 100644 (file)
@@ -40,7 +40,7 @@ namespace internal
                                          * memory consumption (in bytes) of
                                          * this object.
                                          */
-       unsigned int memory_consumption () const;
+       std::size_t memory_consumption () const;
 
                                         /**
                                          * Total number of dofs,
index 0c89f0ab561d253c6346730c253848081ddadf06..cf714376b45fa16f946c5c011503d4871084c978 100644 (file)
@@ -1844,7 +1844,7 @@ class FiniteElement : public Subscriptor,
                                      * pointers to their base class,
                                      * rather than the class itself.
                                      */
-    virtual unsigned int memory_consumption () const;
+    virtual std::size_t memory_consumption () const;
                                     /**
                                      * Exception
                                      *
index 24c6fb817c285262674b80c5ef77d74e5fd1feef..21f6d0bd3c645b60d865a6a10fa883d8427f037d 100644 (file)
@@ -163,7 +163,7 @@ class FE_ABF : public FE_PolyTensor<PolynomialsABF<dim>, dim>
     virtual void interpolate(
       std::vector<double>& local_dofs,
       const VectorSlice<const std::vector<std::vector<double> > >& values) const;
-    virtual unsigned int memory_consumption () const;
+    virtual std::size_t memory_consumption () const;
     virtual FiniteElement<dim> * clone() const;
     
   private:
index 7ad6d58165ccdcd0d3cee48b0a62ef48548cbdb3..d1fffac32c09b8c5e250adbdc8ee607efb8cb9ff 100644 (file)
@@ -91,7 +91,7 @@ class FE_DGVector
     virtual void interpolate(
       std::vector<double>& local_dofs,
       const VectorSlice<const std::vector<std::vector<double> > >& values) const;
-    virtual unsigned int memory_consumption () const;
+    virtual std::size_t memory_consumption () const;
     
   private:
                                     /**
index b77d1cf67f719189e89c3c8258b77918c423c45b..950426bf5569699f34f247e0d631f241eafe468b 100644 (file)
@@ -1,7 +1,7 @@
 //---------------------------------------------------------------------------
 //    $Id$
 //
-//    Copyright (C) 2006, 2007, 2008, 2009, 2010 by the deal.II authors
+//    Copyright (C) 2006, 2007, 2008, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -114,7 +114,7 @@ FE_DGVector<POLY,dim,spacedim>::interpolate(
 
 
 template <class POLY, int dim, int spacedim>
-unsigned int
+std::size_t
 FE_DGVector<POLY,dim,spacedim>::memory_consumption() const
 {
   Assert(false, ExcNotImplemented());
index fb1b378d2d00edd334c9e8bf68da26dd28c688f1..de515ee27a3833e0bea505e5a5b2a87684e3beef 100644 (file)
@@ -296,7 +296,7 @@ class FE_DGP : public FE_Poly<PolynomialSpace<dim>,dim,spacedim>
                                      * pointers to their base class,
                                      * rather than the class itself.
                                      */
-    virtual unsigned int memory_consumption () const;
+    virtual std::size_t memory_consumption () const;
 
 
                                     /**
index c5a160207566c9e7fa38065328f4d37d7d03abe9..b65ff77eccb038ad30b30262765e8b85c40dcaac 100644 (file)
@@ -314,7 +314,7 @@ class FE_DGPMonomial : public FE_Poly<PolynomialsP<dim>,dim>
                                      * pointers to their base class,
                                      * rather than the class itself.
                                      */
-    virtual unsigned int memory_consumption () const;
+    virtual std::size_t memory_consumption () const;
 
   protected:
 
index 6321574b9438b26cbaf1ab29cb297f4314e1516f..1e8a1988c1e37c61a9b2666d8ee18fa5b1a414a8 100644 (file)
@@ -399,7 +399,7 @@ class FE_DGPNonparametric : public FiniteElement<dim,spacedim>
                                      * pointers to their base class,
                                      * rather than the class itself.
                                      */
-    virtual unsigned int memory_consumption () const;
+    virtual std::size_t memory_consumption () const;
 
 
   private:
index 7689596797bfd04d89aecf9873c343f5ba33067a..0aafb6b1618192d1cc98286e8610401e2c72cee2 100644 (file)
@@ -312,7 +312,7 @@ class FE_DGQ : public FE_Poly<TensorProductPolynomials<dim>, dim, spacedim>
                                      * pointers to their base class,
                                      * rather than the class itself.
                                      */
-    virtual unsigned int memory_consumption () const;
+    virtual std::size_t memory_consumption () const;
 
 
   protected:
index 756f6139fe731f854f1925136b4fae969b88ad51..3f9f18552bccf3bbd6444e0f6bd7c7cc83df0c7d 100644 (file)
@@ -231,7 +231,7 @@ class FE_Nedelec : public FE_PolyTensor<PolynomialsNedelec<dim>, dim> {
     virtual void interpolate (std::vector<double>& local_dofs,
                               const VectorSlice<const std::vector<std::vector<double> > >& values)
     const;
-    virtual unsigned int memory_consumption () const;
+    virtual std::size_t memory_consumption () const;
     virtual FiniteElement<dim> * clone() const;
 
   private:
index e88f9682ac566511048443090e01c2de976e524e..3972f328de63d8d07ccfe169109f3a5d9fb44601 100644 (file)
@@ -448,7 +448,7 @@ class FE_Q : public FE_Poly<TensorProductPolynomials<dim>,dim,spacedim>
                                      * pointers to their base class,
                                      * rather than the class itself.
                                      */
-    virtual unsigned int memory_consumption () const;
+    virtual std::size_t memory_consumption () const;
 
   protected:
                                     /**
index e61ff7c49a3f0d25d8641adfab68d00a6d3582cb..a4daa1f28f7ed57f80b64249756e78990e55a6f2 100644 (file)
@@ -363,7 +363,7 @@ class FE_Q_Hierarchical : public FE_Poly<TensorProductPolynomials<dim>,dim>
                                      * pointers to their base class,
                                      * rather than the class itself.
                                      */
-    virtual unsigned int memory_consumption () const;
+    virtual std::size_t memory_consumption () const;
 
                                      /**
                                      * For a finite element of degree
index 1e94f4949c1568d93ca4eb7e286fb0e3f900581c..4de21ce266ccd2596b13a417771bb288d7e7b50f 100644 (file)
@@ -141,7 +141,7 @@ class FE_RaviartThomas
     virtual void interpolate(
       std::vector<double>& local_dofs,
       const VectorSlice<const std::vector<std::vector<double> > >& values) const;
-    virtual unsigned int memory_consumption () const;
+    virtual std::size_t memory_consumption () const;
     virtual FiniteElement<dim> * clone() const;
     
   private:
index 326e7342778d00c53458d0ab482d12a2d26789f4..0db03036b2d4599722c7a5dddb3c86ea5594c361 100644 (file)
@@ -654,7 +654,7 @@ class FESystem : public FiniteElement<dim,spacedim>
                                      * pointers to their base class,
                                      * rather than the class itself.
                                      */
-    virtual unsigned int memory_consumption () const;
+    virtual std::size_t memory_consumption () const;
 
   protected:
                                     /**
index 7f357705b6256c052d5aa499ef980a853fdf1384..4b6c9f8cb1c041e3870d1a5cb522e22c9a608092 100644 (file)
@@ -2777,7 +2777,7 @@ class FEValuesBase : protected FEValuesData<dim,spacedim>,
                                      * memory consumption (in bytes)
                                      * of this object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
                                     //@}
 
 
@@ -3135,7 +3135,7 @@ class FEValues : public FEValuesBase<dim,spacedim>
                                      * memory consumption (in bytes)
                                      * of this object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 
                                      /**
                                       * Return a reference to this
@@ -3273,7 +3273,7 @@ class FEFaceValuesBase : public FEValuesBase<dim,spacedim>
                                      * memory consumption (in bytes)
                                      * of this object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 
   protected:
 
index 11736bcd3f81141bd1fcccd962a4ce8427561912..493e8c4ea68bac0bd7c6b8bcc398d1f35f6a3b1e 100644 (file)
@@ -378,7 +378,7 @@ class Mapping : public Subscriptor
                                          * consumption of this
                                          * object.
                                          */
-       virtual unsigned int memory_consumption () const;
+       virtual std::size_t memory_consumption () const;
 
                                         /**
                                          * The determinant of the
index 24f010c08b3985e30e8c83704e58f2cf83a897f3..f7875ae6e4538dd82329787f69376be3ed51691a 100644 (file)
@@ -157,7 +157,7 @@ class MappingCartesian : public Mapping<dim,spacedim>
                                          * consumption of this
                                          * object.
                                          */
-       virtual unsigned int memory_consumption () const;
+       virtual std::size_t memory_consumption () const;
 
                                         /**
                                          * Length of the cell in
index 75538439c1f9d976296a7ffc5c6eecb76026df71..08c2c81ace800a2ee9f9f246866e61037faab01f 100644 (file)
@@ -161,7 +161,7 @@ class MappingQ : public MappingQ1<dim,spacedim>
                                          * consumption of this
                                          * object.
                                          */
-       virtual unsigned int memory_consumption () const;
+       virtual std::size_t memory_consumption () const;
 
                                         /**
                                          * Unit normal vectors. Used
index 74e2871984055153803bc2bc751fff734cbad45e..75071f081aa73dfcc506cfcf56c3bc70fcad0837 100644 (file)
@@ -164,7 +164,7 @@ class MappingQ1 : public Mapping<dim,spacedim>
                                          * consumption of this
                                          * object.
                                          */
-       virtual unsigned int memory_consumption () const;
+       virtual std::size_t memory_consumption () const;
 
                                         /**
                                          * Values of shape
index 80579eb6255abc033d67e683a173e7ee4cc98344..8a1fb328f791fb151ae9ce73ef66e7077d4adceb 100644 (file)
@@ -1225,7 +1225,7 @@ class GridOut
                                      * memory consumption (in bytes)
                                      * of this object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 
                                     /**
                                      * Exception
index 1ac1ed72edb98c5593911780ada5be9c63195f59..d06560cf78f721809202b69a89f2c9b05832182b 100644 (file)
@@ -171,7 +171,7 @@ class InterGridMap
                                      * memory consumption (in bytes)
                                      * of this object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
     
                                     /**
                                      * Exception
index da68425a75ec6a339e44b3bfac335f7dfc7e5545..fa9cada2640041fa7ac11000b3d61b481012a1a0 100644 (file)
@@ -266,7 +266,7 @@ class PersistentTriangulation : public Triangulation<dim>
                                      * memory consumption (in bytes)
                                      * of this object.
                                      */
-    virtual unsigned int memory_consumption () const;
+    virtual std::size_t memory_consumption () const;
 
                                     /**
                                      * Exception.
index 57011a9c89926f9cfcb608e05758dc3c7db69bd9..039fffc918ca81b1743c838ee96b7e810611d729 100644 (file)
@@ -253,7 +253,7 @@ namespace internal
                                           * memory consumption (in bytes)
                                           * of this object.
                                           */
-        unsigned int memory_consumption () const;
+        std::size_t memory_consumption () const;
     };
 
 
@@ -310,7 +310,7 @@ namespace internal
                                           * memory consumption (in bytes)
                                           * of this object.
                                           */
-        unsigned int memory_consumption () const;
+        std::size_t memory_consumption () const;
     };
 
 //TODO: Replace boundary[255] by a std::vector so we can use constructor of SmartPointer
@@ -368,7 +368,7 @@ namespace internal
                                           * memory consumption (in bytes)
                                           * of this object.
                                           */
-        unsigned int memory_consumption () const;
+        std::size_t memory_consumption () const;
     };
   }
 }
@@ -3130,7 +3130,7 @@ class Triangulation : public Subscriptor
                                      * even if the actual object is a
                                      * derived class.
                                      */
-    virtual unsigned int memory_consumption () const;
+    virtual std::size_t memory_consumption () const;
 
 
                                     /**
index 561fd2e920fe54aa30649da2d4cf6a5ad09b3cc9..964c81a0349f5ab93d338ad45bc159ac5b8fba83 100644 (file)
@@ -68,7 +68,7 @@ namespace internal
                                           * of this object.
                                          * Of course this returns 0.
                                           */
-        unsigned int memory_consumption () const;
+        std::size_t memory_consumption () const;
     };
 
 /**
@@ -89,7 +89,7 @@ namespace internal
                                           * memory consumption (in bytes)
                                           * of this object.
                                           */
-        unsigned int memory_consumption () const;
+        std::size_t memory_consumption () const;
     };
     
 /**
@@ -117,7 +117,7 @@ namespace internal
                                           * memory consumption (in bytes)
                                           * of this object.
                                           */
-        unsigned int memory_consumption () const;
+        std::size_t memory_consumption () const;
     };
   }
 }
index 5b59ddb5508bf3ee900dc630ce0f016e629d81cc..28c999537b626e4899d236670b060015c58e0bd1 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2010 by the deal.II authors
+//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -525,7 +525,7 @@ class TriaRawIterator :
                                      * memory consumption (in bytes)
                                      * of this object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 
 
                                     /**@name Exceptions*/
@@ -1177,7 +1177,7 @@ TriaRawIterator<Accessor>::print (std::ostream &out) const
 
 template <typename Accessor>
 inline
-unsigned int
+std::size_t
 TriaRawIterator<Accessor>::memory_consumption () const
 {
   return sizeof(TriaRawIterator<Accessor>);
index edb82f3d04f3a3636e29a67a502bd3195cfe0443..40d92add01b0e26fc4b6008a19f881f08652b5f3 100644 (file)
@@ -200,7 +200,7 @@ namespace internal
                                           * memory consumption (in bytes)
                                           * of this object.
                                           */
-        unsigned int memory_consumption () const;
+        std::size_t memory_consumption () const;
 
                                          /**
                                           *  Exception
@@ -250,7 +250,7 @@ namespace internal
                             const unsigned int dimension,
                            const unsigned int space_dimension);
         void monitor_memory (const unsigned int true_dimension) const;
-        unsigned int memory_consumption () const;
+        std::size_t memory_consumption () const;
 
                                          /**
                                           *  Exception
index 355fe2653d83ec39d50696673cc0dd410b568a52..4527c4454c062744776abc86deca83fb774d22fa 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007 by the deal.II authors
+//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -98,7 +98,7 @@ namespace internal
                                           * memory consumption (in bytes)
                                           * of this object.
                                           */
-        static unsigned int memory_consumption ();
+        static std::size_t memory_consumption ();
        
       protected:
                                          /**
@@ -191,7 +191,7 @@ namespace internal
     
     template <int structdim>
     inline
-    unsigned int
+    std::size_t
     TriaObject<structdim>::memory_consumption ()
     {
       return sizeof(TriaObject<structdim>);
index ae63441ae73d5bfdd74b438b188939bbedb38332..21a27c28a38e17774a669e32f21221f6d6409551 100644 (file)
@@ -316,7 +316,7 @@ namespace internal
                                           * memory consumption (in bytes)
                                           * of this object.
                                           */
-        unsigned int memory_consumption () const;
+        std::size_t memory_consumption () const;
 
                                          /**
                                           *  Exception
@@ -536,7 +536,7 @@ namespace internal
                                           * memory consumption (in bytes)
                                           * of this object.
                                           */
-        unsigned int memory_consumption () const;          
+        std::size_t memory_consumption () const;           
     };
 
 
@@ -613,7 +613,7 @@ namespace internal
                                           * memory consumption (in bytes)
                                           * of this object.
                                           */
-        unsigned int memory_consumption () const;          
+        std::size_t memory_consumption () const;           
     };
     
 //----------------------------------------------------------------------//
index e034570df78cf4e222b72765f32d14404def9b5d..5be36ff019c90473057436e9daa70e97481c3ba7 100644 (file)
@@ -96,7 +96,7 @@ namespace internal
                                           * memory consumption (in bytes)
                                           * of this object.
                                           */
-        unsigned int memory_consumption () const;
+        std::size_t memory_consumption () const;
     };
 
 /**
@@ -116,7 +116,7 @@ namespace internal
                                           * memory consumption (in bytes)
                                           * of this object.
                                           */
-        unsigned int memory_consumption () const;
+        std::size_t memory_consumption () const;
     };
 
 /**
@@ -138,7 +138,7 @@ namespace internal
                                           * memory consumption (in bytes)
                                           * of this object.
                                           */
-        unsigned int memory_consumption () const;
+        std::size_t memory_consumption () const;
     };
     
   } // namespace hp
index 8cbb832750f57259368f385b3040d0a4b22b3a08..225fe63489ef5e70bed182c6afb9d95ac20ffe96 100644 (file)
@@ -984,7 +984,7 @@ namespace hp
                                         * although the actual object
                                         * might be a derived class.
                                         */
-      virtual unsigned int memory_consumption () const;
+      virtual std::size_t memory_consumption () const;
 
                                        /**
                                         * Exception
index 57f03fc37ba0324781e4a4a41d73ab57856ec067..4a66f4df189216d807e2022fcca945844b2c072b 100644 (file)
@@ -146,7 +146,7 @@ namespace internal
                                           * memory consumption (in bytes)
                                           * of this object.
                                           */
-        unsigned int memory_consumption () const;
+        std::size_t memory_consumption () const;
     };
 
 
@@ -172,7 +172,7 @@ namespace internal
                                           * memory consumption (in bytes)
                                           * of this object.
                                           */
-        unsigned int memory_consumption () const;
+        std::size_t memory_consumption () const;
     };
 
 
@@ -198,7 +198,7 @@ namespace internal
                                           * memory consumption (in bytes)
                                           * of this object.
                                           */
-        unsigned int memory_consumption () const;
+        std::size_t memory_consumption () const;
     };
 
 
@@ -225,7 +225,7 @@ namespace internal
                                           * memory consumption (in bytes)
                                           * of this object.
                                           */
-        unsigned int memory_consumption () const;
+        std::size_t memory_consumption () const;
     };
 
   } // namespace hp
index 88c8af7dfb3b467abe8a8de3358ed0c42d66168b..2650aba1fd6a29f55829e06481865265d0e8e5f6 100644 (file)
@@ -235,7 +235,7 @@ namespace internal
                                           * memory consumption (in bytes)
                                           * of this object.
                                           */
-        unsigned int memory_consumption () const;
+        std::size_t memory_consumption () const;
     };
 
 
index f172d599b08113ca5762e9400518a37bfa3186c0..d30772a976c9918dbbb9ae93a32ec230bb231178 100644 (file)
@@ -166,7 +166,7 @@ namespace hp
                                         * Return an estimate for the memory
                                         * allocated for this object.
                                         */
-      unsigned int memory_consumption () const;
+      std::size_t memory_consumption () const;
 
 
                                        /**
index 0ef4dedd3c51ac10d9e4d149e5e35596051f3deb..b768e9d5467dbb6e9e403bfeeb00315829e74d63 100644 (file)
@@ -120,7 +120,7 @@ namespace hp
                                         * memory consumption (in bytes)
                                         * of this object.
                                         */
-      unsigned int memory_consumption () const;
+      std::size_t memory_consumption () const;
 
     private:
                                        /**
index 923bea2d4c142bf76a438920ee6dfc5911b0a6eb..e38eae4acb49f9058c52fa180210b8ae201f4ae3 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2005, 2006, 2007, 2008, 2009 by the deal.II authors
+//    Copyright (C) 2005, 2006, 2007, 2008, 2009, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -132,7 +132,7 @@ namespace hp
                                         * memory consumption (in bytes)
                                         * of this object.
                                         */
-      unsigned int memory_consumption () const;
+      std::size_t memory_consumption () const;
 
                                        /**
                                         * Exception
@@ -233,7 +233,7 @@ namespace hp
 
   template <int dim>
   inline
-  unsigned int
+  std::size_t
   QCollection<dim>::memory_consumption () const
   {
     return (sizeof(*this) +
index 85a2c1c0b33b401b332651b4e03c083d784ca700..ac4cc36e807b0c8d073f8b94c0e9afa58636e99e 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2010 by the deal.II authors
+//    Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -140,7 +140,7 @@ class BlockIndices : public Subscriptor
                                      * memory consumption (in bytes)
                                      * of this object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
     
   private:
                                     /**
@@ -405,7 +405,7 @@ BlockIndices::swap (BlockIndices &b)
 
 
 inline
-unsigned int
+std::size_t
 BlockIndices::memory_consumption () const 
 {
   return (sizeof(*this) + 
index 4da101c56ab3d522322ffc9214b9bf538f22bff7..2a2894b00860a26472b4882cd71db745f73e650c 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors
+//    Copyright (C) 2004, 2005, 2006, 2007, 2008, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -371,7 +371,7 @@ class BlockMatrixBase : public Subscriptor
     typedef const value_type       *const_pointer;
     typedef value_type             &reference;
     typedef const value_type       &const_reference;
-    typedef size_t                  size_type;
+    typedef std::size_t             size_type;
 
     typedef
     MatrixIterator<BlockMatrixIterators::Accessor<BlockMatrixBase, false> >
@@ -907,7 +907,7 @@ class BlockMatrixBase : public Subscriptor
                                        * returned in case this is called in
                                        * an MPI-based program.
                                        */
-      unsigned int memory_consumption () const;
+      std::size_t memory_consumption () const;
     
                                     /** @addtogroup Exceptions
                                      * @{ */
@@ -1722,10 +1722,10 @@ copy_from (const BlockMatrixType &source)
 
 
 template <class MatrixType>
-unsigned int
+std::size_t
 BlockMatrixBase<MatrixType>::memory_consumption () const
 {
-  unsigned int mem =
+  std::size_t mem =
     MemoryConsumption::memory_consumption(row_block_indices)+
     MemoryConsumption::memory_consumption(column_block_indices)+
     MemoryConsumption::memory_consumption(sub_objects)+
index e6b48e9773461a20a8aa703e029e4326b45050ee..a51df16d76f1a3ace27784299d54430c8f17c6c3 100644 (file)
@@ -403,7 +403,7 @@ class BlockSparseMatrix : public BlockMatrixBase<SparseMatrix<number> >
                                      * memory consumption (in bytes)
                                      * of this object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 
                                     /** @addtogroup Exceptions
                                      * @{ */
index 078a7c10523564cfa5a3ff20af057660f90ad614..4da7ebb4d0c870073c2a882e7d00a9cad01d9a14 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2008, 2009 by the deal.II authors
+//    Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2008, 2009, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -181,10 +181,10 @@ print_formatted (std::ostream       &out,
 
 
 template <typename number>
-unsigned int
+std::size_t
 BlockSparseMatrix<number>::memory_consumption () const
 {
-  unsigned int mem = sizeof(*this);
+  std::size_t mem = sizeof(*this);
   mem += MemoryConsumption::memory_consumption (this->sub_objects);
   for (unsigned int r=0; r<this->n_block_rows(); ++r)
     for (unsigned int c=0; c<this->n_block_cols(); ++c)
index 56eb25c3256dd4218fa02f743b79208c6a3f990b..20723f74b2153607681a45ff8c805ebbbf140a8a 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2002, 2003, 2004, 2005, 2006, 2008 by the deal.II authors
+//    Copyright (C) 2002, 2003, 2004, 2005, 2006, 2008, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -200,10 +200,10 @@ BlockSparseMatrixEZ<number>::collect_sizes ()
 
 
 //  template <typename number>
-//  unsigned int
+//  std::size_t
 //  BlockSparseMatrixEZ<number>::memory_consumption () const
 //  {
-//    unsigned int mem = sizeof(*this);
+//    std::size_t mem = sizeof(*this);
 //    mem += MemoryConsumption::memory_consumption (sub_objects);
 //    for (unsigned int r=0; r<rows; ++r)
 //      for (unsigned int c=0; c<columns; ++c)
index 3a4612e954a1d063db7a5d1254d789a708c3dc2a..08858a9b09ebd4b2c40497327636d351c24fae0e 100644 (file)
@@ -552,7 +552,7 @@ class BlockSparsityPattern : public BlockSparsityPatternBase<SparsityPattern>
                                      * memory consumption (in bytes)
                                      * of this object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 
                                     /**
                                      * Copy data from an object of
index ba33570fcd0141b9b7a41805dc36afcab8f4844b..aff7adfdeaa539f12c04556de6cd6c68f190773a 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2004, 2005, 2006, 2007, 2010 by the deal.II authors
+//    Copyright (C) 2004, 2005, 2006, 2007, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -1109,7 +1109,7 @@ class BlockVectorBase : public Subscriptor
                                      * memory consumption (in bytes)
                                      * of this object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 
   protected:
                                     /**
@@ -2212,9 +2212,10 @@ void BlockVectorBase<VectorType>::equ (const value_type a,
 
 
 template <class VectorType>
-unsigned int BlockVectorBase<VectorType>::memory_consumption () const
+std::size_t
+BlockVectorBase<VectorType>::memory_consumption () const
 {
-  unsigned int mem = sizeof(this->n_blocks());
+  std::size_t mem = sizeof(this->n_blocks());
   for (unsigned int i=0; i<this->components.size(); ++i)
     mem += MemoryConsumption::memory_consumption (this->components[i]);
   mem += MemoryConsumption::memory_consumption (this->block_indices);
index cb86464fd68ecb00aea025f5de8b3264b3044624..cae41161c28bec868f1fc8f5f19c0be908159582 100644 (file)
@@ -346,7 +346,7 @@ class ChunkSparseMatrix : public virtual Subscriptor
                                      * of this object. See
                                      * MemoryConsumption.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
     
 //@}
 /**
index 4c7c9d5b11c6c3bebd1af419b319d0c2c011f0a6..14d8f1f90940d5b0b997863daf7d5af5b4d196ea 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2008, 2009 by the deal.II authors
+//    Copyright (C) 2008, 2009, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -1577,7 +1577,7 @@ ChunkSparseMatrix<number>::block_read (std::istream &in)
 
 
 template <typename number>
-unsigned int
+std::size_t
 ChunkSparseMatrix<number>::memory_consumption () const
 {
   return sizeof(*this) + max_len*sizeof(number);
index 3defa0f90f5b44f091f9e36e7fc6b8c7ebbd9b34..32ed5e54434aeedc971d4653f9170c288c95011d 100644 (file)
@@ -729,7 +729,7 @@ class ChunkSparsityPattern : public Subscriptor
                                      * of this object. See
                                      * MemoryConsumption.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 
                                     /** @addtogroup Exceptions
                                      * @{ */
index 678ababbc38b94e5dd184379b4841abf2f60cef1..add437431406922d9d6dfe3d827d3185562753f2 100644 (file)
@@ -370,7 +370,7 @@ class CompressedSimpleSparsityPattern : public Subscriptor
                                      * memory consumption (in bytes)
                                      * of this object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 
   private:
                                     /**
@@ -434,7 +434,7 @@ class CompressedSimpleSparsityPattern : public Subscriptor
                                         /**
                                          * estimates memory consumption.
                                          */
-       unsigned int memory_consumption () const;
+       std::size_t memory_consumption () const;
     };
 
 
index 4a272f2a6307dc46bc5cc94caf79436baaf541c3..ed50171782e0a0324ce2d19acb85a6a0980d4866 100644 (file)
@@ -604,7 +604,7 @@ class ConstraintMatrix : public Subscriptor
                                      * consumption (in bytes) of this
                                      * object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 
                                     /**
                                      * @}
@@ -1525,7 +1525,7 @@ class ConstraintMatrix : public Subscriptor
                                          * memory consumption (in bytes) of
                                          * this object.
                                          */
-       unsigned int memory_consumption () const;
+       std::size_t memory_consumption () const;
     };
 
                                     /**
index 189955b9f35326a0c427075806b197a937cca17b..3bfd7aa1f5a58260bee2807d2602b7586f00a192 100644 (file)
@@ -552,7 +552,7 @@ class FilteredMatrix : public Subscriptor
                                      * referenced, its memory
                                      * consumption is not included.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
     
   private:
                                     /**
@@ -1099,11 +1099,11 @@ FilteredMatrix<VECTOR>::Tvmult_add (VECTOR& dst, const VECTOR& src) const
 
 template <class VECTOR>
 inline
-unsigned int
+std::size_t
 FilteredMatrix<VECTOR>::memory_consumption () const
 {
-    return (MemoryConsumption::memory_consumption (matrix) +
-           MemoryConsumption::memory_consumption (constraints));
+  return (MemoryConsumption::memory_consumption (matrix) +
+         MemoryConsumption::memory_consumption (constraints));
 }
 
 
index 5195577946cfd381c88642e4b11995779b1f9e84..9c1331106f41fb2ef9eef46d2d2ea26c38e974c1 100644 (file)
@@ -634,7 +634,7 @@ class FullMatrix : public Table<2,number>
                                      * memory consumption (in bytes)
                                      * of this object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 
 //@}
 ///@name Iterator functions
index 4095da48260b7635a4d4660a264bfa2a7e6806fc..f5f0d2ecc82b3f1351151f71ccfb46ab3c10a027 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors
+//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -1838,11 +1838,12 @@ FullMatrix<number>::gauss_jordan ()
 
 
 template <typename number>
-unsigned int
+std::size_t
 FullMatrix<number>::memory_consumption () const
 {
-  return sizeof(*this) - sizeof (Table<2,number>)
-    + Table<2,number>::memory_consumption();
+  return (sizeof(*this) - sizeof (Table<2,number>)
+         +
+         Table<2,number>::memory_consumption());
 }
 
 
index 6616f6d2ff9772648766053ef78e78d3f3cec33c..33d167d5288298b60918181e58d5f608a42ea574 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2007, 2008, 2009, 2010 by the deal.II authors
+//    Copyright (C) 2007, 2008, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -330,7 +330,7 @@ class MatrixBlock
                                     /**
                                      * The memory used by this object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 
                                     /**
                                      * The block number computed from
@@ -441,7 +441,7 @@ class MatrixBlockVector
                                     /**
                                      * The memory used by this object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 
                                     /**
                                      * Access a constant reference to
@@ -639,7 +639,7 @@ class MGMatrixBlockVector
                                     /**
                                      * The memory used by this object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
   private:
                                     /// Clear one of the matrix objects
     void clear_object(NamedData<MGLevelObject<MatrixBlock<MATRIX> > >&);
@@ -906,13 +906,12 @@ MatrixBlock<MATRIX>::Tvmult_add (VECTOR& w, const VECTOR& v) const
 
 template <class MATRIX>
 inline
-unsigned int
+std::size_t
 MatrixBlock<MATRIX>::memory_consumption () const
 {
-  unsigned int mem = sizeof(*this)
-                    + MemoryConsumption::memory_consumption(matrix)
-                    - sizeof(matrix);
-  return mem;
+  return (sizeof(*this)
+         + MemoryConsumption::memory_consumption(matrix)
+         - sizeof(matrix));
 }
 
 //----------------------------------------------------------------------//
index 8d0eb2f914a0396f1c49626c3d5d229cb66a2895..b72fd8752eaafc8f4728d83c769112f8ed8578be 100644 (file)
@@ -1136,7 +1136,7 @@ namespace PETScWrappers
                                        *  Returns the number bytes consumed
                                        *  by this matrix on this CPU.
                                        */
-      unsigned int memory_consumption() const;
+      std::size_t memory_consumption() const;
 
                                        /**
                                         * Exception
index a74c5b0a53b3849cf177e8ea36887fbcfdb99efc..41cfed6ab0954197d3896537015d4cfbc25e01f1 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2004, 2005, 2006, 2007, 2009, 2010 by the deal.II authors
+//    Copyright (C) 2004, 2005, 2006, 2007, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -236,7 +236,7 @@ namespace PETScWrappers
                                         */
       typedef PetscScalar               value_type;
       typedef PetscReal                 real_type;
-      typedef size_t                    size_type;
+      typedef std::size_t               size_type;
       typedef internal::VectorReference reference;
       typedef const internal::VectorReference const_reference;
 
@@ -742,7 +742,7 @@ namespace PETScWrappers
                                        * consumption (not implemented
                                        * for this class).
                                        */
-      unsigned int memory_consumption () const;
+      std::size_t memory_consumption () const;
 
     protected:
                                        /**
index dfb125d5d2040097dd2d857420ecec3f586ec0aa..1acad5739e96e5210a23f988bf5ae3840514e88c 100644 (file)
@@ -338,7 +338,7 @@ class PreconditionBlock
                                      * memory consumption (in bytes)
                                      * of this object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 
                                     /** @addtogroup Exceptions
                                      * @{ */
index 67b0ab6087bdab4ab5531bb40a7a07731c84dc10..09d6170505f118fb7fc3cf8bfd087d866bb0edcd 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2009, 2010 by the deal.II authors
+//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -532,12 +532,12 @@ void PreconditionBlock<MATRIX,inverse_type>::set_permutation (
 
 
 template <class MATRIX, typename inverse_type>
-unsigned int
+std::size_t
 PreconditionBlock<MATRIX,inverse_type>::memory_consumption () const
 {
-  unsigned int mem = sizeof(*this) - sizeof(PreconditionBlockBase<inverse_type>);
-  mem += PreconditionBlockBase<inverse_type>::memory_consumption();
-  return mem;
+  return (sizeof(*this)
+         - sizeof(PreconditionBlockBase<inverse_type>)
+         + PreconditionBlockBase<inverse_type>::memory_consumption());
 }
 
 
index 1777a923226466e1133ae76c6bd333e57c1c2de7..4558c6dd9b7e8648972d041902d06ca6682ead38 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors
+//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -234,7 +234,7 @@ class PreconditionBlockBase
                                      * memory consumption (in bytes)
                                      * of this object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
     
                                     /**
                                      * You are trying to access a
@@ -663,10 +663,10 @@ PreconditionBlockBase<number>::inverses_ready() const
 
 template <typename number>
 inline
-unsigned int
+std::size_t
 PreconditionBlockBase<number>::memory_consumption () const
 {
-  unsigned int mem = sizeof(*this);
+  std::size_t mem = sizeof(*this);
   for (unsigned int i=0; i<var_inverse_full.size(); ++i)
     mem += MemoryConsumption::memory_consumption(var_inverse_full[i]);
   for (unsigned int i=0; i<var_diagonal.size(); ++i)
index a946d17481d668c8237a238491cd83454c1a259c..db7beb98da6494c03aeb997235e81a5a4106b1d5 100644 (file)
@@ -343,7 +343,7 @@ class SparseLUDecomposition : protected SparseMatrix<number>,
                                      * memory consumption (in bytes)
                                      * of this object.
                                      */
-    virtual unsigned int memory_consumption () const;
+    virtual std::size_t memory_consumption () const;
 
                                     /** @addtogroup Exceptions
                                      * @{ */
index 1084fb9727077ec4f7e334d3d2c2a1e6bb51cdb6..43b9fe12bd82ab312ca17eee8ce55faa88671b92 100644 (file)
@@ -1,5 +1,5 @@
 //---------------------------------------------------------------------------
-//    Copyright (C) 2002, 2003, 2004, 2005, 2006, 2009 by the deal.II authors
+//    Copyright (C) 2002, 2003, 2004, 2005, 2006, 2009, 2011 by the deal.II authors
 //    by the deal.II authors and Stephen "Cheffo" Kolaroff
 //
 //    This file is subject to QPL and may not be  distributed
@@ -266,13 +266,11 @@ SparseLUDecomposition<number>::strengthen_diagonal_impl ()
 
 
 template <typename number>
-unsigned int
+std::size_t
 SparseLUDecomposition<number>::memory_consumption () const
 {
-  unsigned int
-    res = (SparseMatrix<number>::memory_consumption () +
-           MemoryConsumption::memory_consumption(prebuilt_lower_bound));
-  return res;
+  return (SparseMatrix<number>::memory_consumption () +
+         MemoryConsumption::memory_consumption(prebuilt_lower_bound));
 }
 
 
index 2f307e8fcdcad01d22eb69db71c366cf4d5f83e1..22f5060d62be4e96aa997412247f93529540fbcd 100644 (file)
@@ -321,7 +321,7 @@ class SparseDirectMA27 : public Subscriptor
                                      * Return an estimate of the
                                      * memory used by this class.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
     
                                     /**
                                      * Get a reference to the
@@ -791,7 +791,7 @@ class SparseDirectMA47 : public Subscriptor
                                      * Return an estimate of the
                                      * memory used by this class.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 
                                     /**
                                      * Get a reference to the
index 8c4f2ceaf39d3dfc6d9f35e47501212bfcb6161c..053cef4c740e7fe69b1935011755b1a9f791b445 100644 (file)
@@ -166,7 +166,7 @@ class SparseILU : public SparseLUDecomposition<number>
                                      * memory consumption (in bytes)
                                      * of this object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 
                                     /** @addtogroup Exceptions
                                      * @{ */
index f9fb3797ff4eab2b6a0d4102840d2189d207a0de..190c1f9cc1f46f6e2342eae518289f44810f0599 100644 (file)
@@ -1,5 +1,5 @@
 //---------------------------------------------------------------------------
-//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2008, 2009 by the deal.II authors
+//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2008, 2009, 2011 by the deal.II authors
 //    by the deal.II authors and Stephen "Cheffo" Kolaroff
 //
 //    This file is subject to QPL and may not be  distributed
@@ -322,7 +322,7 @@ void SparseILU<number>::Tvmult (Vector<somenumber>       &dst,
 
 
 template <typename number>
-unsigned int
+std::size_t
 SparseILU<number>::memory_consumption () const
 {
   return SparseLUDecomposition<number>::memory_consumption ();
index df53a78310ce9824934b67aea5bcb2260f727c8a..aec09a947a1caf09f0e592caad4c7746836d8b06 100644 (file)
@@ -871,7 +871,7 @@ class SparseMatrixEZ : public Subscriptor
                                      * memory consumption (in bytes)
                                      * of this object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 
                                     /**
                                      * Print statistics. If @p full
index da15f1528b0245397fab4a155cc0983e79159fc1..7f03da83fd94c9f6f6f55dc4090039c1f828a425 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2002, 2003, 2004, 2005, 2006, 2007, 2010 by the deal.II authors
+//    Copyright (C) 2002, 2003, 2004, 2005, 2006, 2007, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -375,7 +375,7 @@ SparseMatrixEZ<number>::precondition_SSOR (Vector<somenumber>       &dst,
 
 
 template <typename number>
-unsigned int
+std::size_t
 SparseMatrixEZ<number>::memory_consumption() const
 {
   return
index 6bdad533717ee07647a66739f715c3b7f3a206d7..f5f38e1f41ee3bf15009d53bff4507258e73f49e 100644 (file)
@@ -121,7 +121,7 @@ class SparseMIC : public SparseLUDecomposition<number>
                                      * memory consumption (in bytes)
                                      * of this object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 
                                     /** @addtogroup Exceptions
                                      * @{ */
index 00de1e17909c18c2f3bbce54ab969fd77bffd12d..2c2ed1ea7a6c45be4553b203b9a559720e7e0d5b 100644 (file)
@@ -1,5 +1,5 @@
 //---------------------------------------------------------------------------
-//    Copyright (C) 2002, 2003, 2004, 2005, 2006 by the deal.II authors
+//    Copyright (C) 2002, 2003, 2004, 2005, 2006, 2011 by the deal.II authors
 //    by the deal.II authors and Stephen "Cheffo" Kolaroff
 //
 //    This file is subject to QPL and may not be  distributed
@@ -241,7 +241,7 @@ SparseMIC<number>::vmult (Vector<somenumber>       &dst,
 
 
 template <typename number>
-unsigned int
+std::size_t
 SparseMIC<number>::memory_consumption () const
 {
   return (SparseLUDecomposition<number>::memory_consumption () +
index 2f9175fddc432cbb41a73457c67c8fcb60314d96..af77663674a2fd9de8ce1e3b26786b49ed1c44d9 100644 (file)
@@ -258,7 +258,7 @@ class SparseVanka
                                      * memory consumption (in bytes)
                                      * of this object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
     
   private:
                                     /**
@@ -545,7 +545,7 @@ class SparseBlockVanka : public SparseVanka<number>
                                      * memory consumption (in bytes)
                                      * of this object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 
   private:
                                     /**
index c27f44f51d465bac2d91eaee11691549fa415469..79ac3f86d7ee1fa2a40ea8d6700033b5560a2e3d 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009 by the deal.II authors
+//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -374,11 +374,11 @@ SparseVanka<number>::apply_preconditioner (Vector<number2>         &dst,
 
 
 template <typename number>
-unsigned int
+std::size_t
 SparseVanka<number>::memory_consumption () const
 {
-  unsigned int mem = (sizeof(*this) +
-                     MemoryConsumption::memory_consumption (selected));
+  std::size_t mem = (sizeof(*this) +
+                    MemoryConsumption::memory_consumption (selected));
   for (unsigned int i=0; i<inverses.size(); ++i)
     mem += MemoryConsumption::memory_consumption (*inverses[i]);
   
@@ -620,10 +620,10 @@ void SparseBlockVanka<number>::vmult (Vector<number2>       &dst,
 
 
 template <typename number>
-unsigned int
+std::size_t
 SparseBlockVanka<number>::memory_consumption () const
 {
-  unsigned int mem = SparseVanka<number>::memory_consumption();
+  std::size_t mem = SparseVanka<number>::memory_consumption();
   for (unsigned int i=0; i<dof_masks.size(); ++i)
     mem += MemoryConsumption::memory_consumption (dof_masks[i]);
   return mem;
index 069daa3f3ee0ae76ce9622373ff3116fc8bd801c..c387dbfae04b6df71f9e7ae279ee747945d0c6c4 100644 (file)
@@ -204,7 +204,7 @@ class SwappableVector : public Vector<number>
                                      * memory consumption (in bytes)
                                      * of this object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 
                                     /** @addtogroup Exceptions
                                      * @{ */
index 87ed650c4ad6797554dc5e6649cba0d8e1be31c2..8def965e68cf0b900aff1e1004ca2abd72dfaf17 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2008 by the deal.II authors
+//    Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2008, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -236,7 +236,7 @@ SwappableVector<number>::get_filename () const
 
 
 template <typename number>
-unsigned int
+std::size_t
 SwappableVector<number>::memory_consumption () const
 {
   return (MemoryConsumption::memory_consumption (filename) +
index de1eee59059088e25c0c48c9ad52fe75426d25af..b1d1e49f68bb03fb49f0804366c3195c61faa57f 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2005, 2006, 2007, 2009 by the deal.II authors
+//    Copyright (C) 2005, 2006, 2007, 2009, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -313,8 +313,8 @@ class TridiagonalMatrix
                                      * memory consumption (in bytes)
                                      * of this object.
                                      */
-    unsigned int memory_consumption () const;
-//@}
+    std::size_t memory_consumption () const;
+                                    //@}
     
   private:
                                     /**
index b359254261da0c5063270968b4a5400b72d038c8..00dcd9293688b503454f9ec8ce21f12c912d1109 100644 (file)
@@ -1447,7 +1447,7 @@ namespace TrilinosWrappers
                                        * Prints an estimate of the memory
                                        * consumption of this class.
                                        */
-      unsigned int memory_consumption () const;
+      std::size_t memory_consumption () const;
 
     private:
                                       /**
index 8cab8ef9cf2800e2c6e01f1792da914755fc788e..7da9982b4a5ad34d64a8475de6730e6eb4b7c0bb 100644 (file)
@@ -1080,7 +1080,7 @@ namespace TrilinosWrappers
                                        * returned in case this is called in
                                        * an MPI-based program.
                                        */
-      unsigned int memory_consumption () const;
+      std::size_t memory_consumption () const;
 
 //@}
 /**
index 5edd6858a50ae3bfeff8d5806f2a6747b994630b..4bd9b41c67874d81495b4c07ddb76699b0dab957 100644 (file)
@@ -1092,7 +1092,7 @@ namespace TrilinosWrappers
                                        * of this object. Currently not
                                        * implemented for this class.
                                        */
-      unsigned int memory_consumption () const;
+      std::size_t memory_consumption () const;
 
 //@}
 /**
index 071cb6e4cf0120d465eceedcffe6fbb21c4c2cc2..02f758e06e02d34cad2807b0f5969e1d7d435012 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2008, 2009, 2010 by the deal.II authors
+//    Copyright (C) 2008, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -259,7 +259,7 @@ namespace TrilinosWrappers
                                         */
       typedef TrilinosScalar            value_type;
       typedef TrilinosScalar            real_type;
-      typedef size_t                    size_type;
+      typedef std::size_t               size_type;
       typedef internal::VectorReference reference;
       typedef const internal::VectorReference const_reference;
 
@@ -898,7 +898,7 @@ namespace TrilinosWrappers
                                        * Estimate for the memory
                                        * consumption in bytes.
                                        */
-      unsigned int memory_consumption () const;
+      std::size_t memory_consumption () const;
                                       //@}
 
                                       /**
index a8b10919f4df3db9068f90d26d43c328a97548cd..2dd5b2746ff79a6c6c4288da5a4dfd7d6c15454c 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors
+//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -103,7 +103,7 @@ class Vector : public Subscriptor
     typedef const value_type                                 *const_iterator;
     typedef value_type                                       &reference;
     typedef const value_type                                 &const_reference;
-    typedef size_t                                            size_type;
+    typedef std::size_t                                       size_type;
 
                                     /**
                                      * Declare a type that has holds
@@ -939,7 +939,7 @@ class Vector : public Subscriptor
                                      * memory consumption (in bytes)
                                      * of this object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
                                     //@}
        
                      /**
index 7d0985e74d8d94c6a7a32bfab2c19cf27ffd8e8a..158a6418baac38a5ad93d5429d47a2985652f2d8 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors
+//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -1225,7 +1225,7 @@ void Vector<Number>::block_read (std::istream &in)
 
 
 template <typename Number>
-unsigned int
+std::size_t
 Vector<Number>::memory_consumption () const
 {
   return sizeof(*this) + (max_vec_size * sizeof(Number));
index 0e3619d90623f763186c63f7c0d9361b3bab0701..8cb0434d70f4e6da2c208878b6eef4f50598c69c 100644 (file)
@@ -314,7 +314,7 @@ class GrowingVectorMemory : public VectorMemory<VECTOR>
                                      * and all currently allocated
                                      * vectors.
                                      */
-    virtual unsigned int memory_consumption() const;
+    virtual std::size_t memory_consumption() const;
 
   private:
                                     /**
index f3422762d8bdf0b2de08daf8f8856a5f1137fad8..c97d782ac4fa4255edafb014dc6a1e4e2337c2a1 100644 (file)
@@ -751,7 +751,7 @@ class MGDoFHandler : public DoFHandler<dim,spacedim>
                                      * although the actual object
                                      * might be a derived class.
                                      */
-    virtual unsigned int memory_consumption () const;
+    virtual std::size_t memory_consumption () const;
 
 
                                     /**
index 4750b7b1e754cfee53a29ab45c0f7e99d1237e4e..6fc9a322cc217a7a5ea7ca69b3b77d7e26e73992 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2003, 2004, 2005, 2006, 2009, 2010 by the deal.II authors
+//    Copyright (C) 2003, 2004, 2005, 2006, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -77,7 +77,7 @@ namespace mg
                                       /**
                                        * Memory used by this object.
                                        */
-      unsigned int memory_consumption () const;
+      std::size_t memory_consumption () const;
     private:
       MGLevelObject<std_cxx1x::shared_ptr<PointerMatrixBase<VECTOR> > > matrices;
   };
@@ -154,7 +154,7 @@ class MGMatrix : public MGMatrixBase<VECTOR>
                                     /**
                                      * Memory used by this object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 
 
   private:
@@ -343,7 +343,7 @@ namespace mg
 
   template <class VECTOR>
   inline
-  unsigned int
+  std::size_t
   Matrix<VECTOR>::memory_consumption () const
   {
     return sizeof(*this) + matrices->memory_consumption();
@@ -420,7 +420,7 @@ MGMatrix<MATRIX, VECTOR>::Tvmult_add  (const unsigned int level,
 
 
 template <class MATRIX, class VECTOR>
-unsigned int
+std::size_t
 MGMatrix<MATRIX, VECTOR>::memory_consumption () const
 {
   return sizeof(*this) + matrix->memory_consumption();
index 96d660ef49fb59cebc39c924527b8c6f096d3e0b..03274e26b1d72ebabeff8c874f4470d3662a7809 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2009, 2010 by the deal.II authors
+//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -295,7 +295,8 @@ class SmootherRelaxation : public MGSmoother<VECTOR>
                                     /**
                                      * Memory used by this object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
+
   private:
                                     /**
                                      * Object containing relaxation
@@ -471,7 +472,7 @@ class MGSmootherRelaxation : public MGSmoother<VECTOR>
                                     /**
                                      * Memory used by this object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 
 
  private:
@@ -640,7 +641,7 @@ class MGSmootherPrecondition : public MGSmoother<VECTOR>
                                     /**
                                      * Memory used by this object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 
 
  private:
@@ -839,7 +840,8 @@ namespace mg
 
 
   template <class RELAX, class VECTOR>
-  inline unsigned int
+  inline
+  std::size_t
   SmootherRelaxation<RELAX, VECTOR>::
   memory_consumption () const
   {
@@ -1066,7 +1068,8 @@ MGSmootherRelaxation<MATRIX, RELAX, VECTOR>::smooth(
 
 
 template <class MATRIX, class RELAX, class VECTOR>
-inline unsigned int
+inline
+std::size_t
 MGSmootherRelaxation<MATRIX, RELAX, VECTOR>::
 memory_consumption () const
 {
@@ -1269,7 +1272,8 @@ MGSmootherPrecondition<MATRIX, PRECONDITIONER, VECTOR>::smooth(
 
 
 template <class MATRIX, class PRECONDITIONER, class VECTOR>
-inline unsigned int
+inline
+std::size_t
 MGSmootherPrecondition<MATRIX, PRECONDITIONER, VECTOR>::
 memory_consumption () const
 {
index c00f2a3aaa2bbe3ab51008749c44c213450ad707..1c4bf076cd33ccf22d700c708ec94acc00a0d1cf 100644 (file)
@@ -189,7 +189,7 @@ class MGTransferPrebuilt : public MGTransferBase<VECTOR>
                                     /**
                                      * Memory used by this object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 
 
   private:
index 5e8209166260d6eec2019b96c95c8e8b541713ce..a77cba694f0b1e74e6866c3b900d3d5cceae6157 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2003, 2004, 2005, 2006, 2007, 2009, 2010 by the deal.II authors
+//    Copyright (C) 2003, 2004, 2005, 2006, 2007, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -96,10 +96,10 @@ set_component_to_block_map (const std::vector<unsigned int> &map)
 }
 
 template <class VECTOR>
-unsigned int
+std::size_t
 MGTransferPrebuilt<VECTOR>::memory_consumption () const
 {
-  unsigned int result = sizeof(*this);
+  std::size_t result = sizeof(*this);
   result += sizeof(unsigned int) * sizes.size();
 #ifdef DEAL_PREFER_MATRIX_EZ
   std::vector<std_cxx1x::shared_ptr<SparseMatrixEZ<double> > >::const_iterator m;
index a9f7451ef21396692205bcd67fc6f3589b497f1a..7edde42edb936f4f5c1c640d1d36e16702dad0c2 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2009, 2010 by the deal.II authors
+//    Copyright (C) 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -64,7 +64,7 @@ class MGTransferBlockBase
                                     /**
                                      * Memory used by this object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
     
   protected:  
                                     /**
@@ -277,7 +277,7 @@ class MGTransferBlock : public MGTransferBase<BlockVector<number> >,
                      BlockVector<number2>& dst,
                      const MGLevelObject<BlockVector<number> > &src) const;
 
-    MGTransferBlockBase::memory_consumption;
+    using MGTransferBlockBase::memory_consumption;
     
   private:
                                     /**
@@ -443,7 +443,7 @@ class MGTransferBlockSelect : public MGTransferBase<Vector<number> >,
                                     /**
                                      * Memory used by this object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
     
   private:
                                     /**
index 95028b8220e0b2264ef6c82fa60f4c7d201e7d1f..165f494e28f186826632ad661472716056e11dec 100644 (file)
@@ -2,7 +2,7 @@
 //    mg_transfer.templates.h,v 1.22 2006/01/29 15:03:55 guido Exp
 //    Version:
 //
-//    Copyright (C) 2003, 2004, 2005, 2006, 2007, 2009, 2010 by the deal.II authors
+//    Copyright (C) 2003, 2004, 2005, 2006, 2007, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -99,7 +99,7 @@ MGTransferBlockSelect<number>::copy_from_mg_add (
 
 
 template <typename number>
-unsigned int
+std::size_t
 MGTransferBlockSelect<number>::memory_consumption () const
 {
   return sizeof(int) + MGTransferBlockBase::memory_consumption();
index 3a209635f4d310982a3b87e66806b5be52374606..643c66a01d4ee93ac3caceef803332d3cc7b9962 100644 (file)
@@ -63,7 +63,7 @@ class MGTransferComponentBase
                                     /**
                                      * Memory used by this object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 
 
   protected:
@@ -374,7 +374,7 @@ class MGTransferSelect : public MGTransferBase<Vector<number> >,
                                     /**
                                      * Memory used by this object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 
   private:
                                     /**
index ab31dd6b9840a77bfffb54cd974269cfb0e25db0..d662590f96b81a462cce3afa303599b191ddda01 100644 (file)
@@ -2,7 +2,7 @@
 //    mg_transfer.templates.h,v 1.22 2006/01/29 15:03:55 guido Exp
 //    Version:
 //
-//    Copyright (C) 2003, 2004, 2005, 2006, 2007, 2009, 2010 by the deal.II authors
+//    Copyright (C) 2003, 2004, 2005, 2006, 2007, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -215,7 +215,7 @@ MGTransferSelect<number>::do_copy_from_mg_add (
 
 
 template <typename number>
-unsigned int
+std::size_t
 MGTransferSelect<number>::memory_consumption () const
 {
   return sizeof(int) + MGTransferComponentBase::memory_consumption();
index 0cd4978a329c8a803500b42c957a102e17026427..058a75f99d0c705e7a96e72d0ef2d856750cf41e 100644 (file)
@@ -654,7 +654,7 @@ class DataOut_DoFData : public DataOutInterface<patch_dim,patch_space_dim>
                                      * memory consumption (in bytes)
                                      * of this object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 
                                     /**
                                      * Exception
@@ -864,7 +864,7 @@ class DataOut_DoFData : public DataOutInterface<patch_dim,patch_space_dim>
                                          * the memory consumption (in
                                          * bytes) of this object.
                                          */
-       virtual unsigned int memory_consumption () const = 0;
+       virtual std::size_t memory_consumption () const = 0;
 
                                         /**
                                          * Names of the components of this
@@ -1031,7 +1031,7 @@ class DataOut_DoFData : public DataOutInterface<patch_dim,patch_space_dim>
                                          * the memory consumption (in
                                          * bytes) of this object.
                                          */
-       virtual unsigned int memory_consumption () const;
+       virtual std::size_t memory_consumption () const;
 
       private:
                                          /**
index 184edbf15451175d668b01e2646b64073b513f77..ccda46cc6b80e0cc2e5508bc36ee6ef2391e7165 100644 (file)
@@ -290,7 +290,7 @@ class DataOutStack : public DataOutInterface<dim+1>
                                      * memory consumption (in bytes)
                                      * of this object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 
                                     /**
                                      * Exception
@@ -403,7 +403,7 @@ class DataOutStack : public DataOutInterface<dim+1>
                                          * the memory consumption (in
                                          * bytes) of this object.
                                          */
-       unsigned int memory_consumption () const;
+       std::size_t memory_consumption () const;
     };
 
                                     /**
index c28b285f9414ceffe2149830dbd443a380d262e9..4a06b88b714ff5c112333522d35d69a170000581 100644 (file)
@@ -158,7 +158,7 @@ class Histogram
                                      * memory consumption (in bytes)
                                      * of this object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 
                                     /**
                                      * Exception.
@@ -207,7 +207,7 @@ class Histogram
                                          * memory consumption (in bytes)
                                          * of this object.
                                          */
-       unsigned int memory_consumption () const;
+       std::size_t memory_consumption () const;
 
                                         /**
                                          * Left bound of the interval.
index ad307a87fe65cac679fa8f3e44a5767dc4837576..a461fde2ae435b70a466f6fc2e9e62a9a96ecea3 100644 (file)
@@ -399,7 +399,7 @@ namespace MeshWorker
                                       /**
                                        * The memory used by this object.
                                        */
-      unsigned int memory_consumption () const;
+      std::size_t memory_consumption () const;
       
     private:
                                       /**
index f70e2449972365e0b80a177ee07751be16e9ab2e..c19a5ba2900248512a41f4db8f7f98a04a54db9c 100644 (file)
@@ -229,7 +229,7 @@ namespace MeshWorker
                                       /**
                                        * The memory used by this object.
                                        */
-      unsigned int memory_consumption () const;
+      std::size_t memory_consumption () const;
       
 
                                       /**
@@ -486,7 +486,7 @@ namespace MeshWorker
                                       /**
                                        * The memory used by this object.
                                        */
-      unsigned int memory_consumption () const;
+      std::size_t memory_consumption () const;
       
     private:
                                       /**
@@ -710,7 +710,7 @@ namespace MeshWorker
                                       /**
                                        * The memory used by this object.
                                        */
-      unsigned int memory_consumption () const;
+      std::size_t memory_consumption () const;
       
                                       /**
                                        * The set of update flags
index 67b414bf1d7a8f68b0a03d6a811ce6afdfb9e09e..8506ec0d0607ef87ccf0a0637a1598b0f59e5ffe 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2009, 2010 by the deal.II authors
+//    Copyright (C) 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -180,13 +180,12 @@ namespace MeshWorker
 
 
   template<int dim, int sdim>
-  unsigned int
+  std::size_t
   IntegrationInfo<dim,sdim>::memory_consumption () const
   {
-    unsigned int mem = sizeof(*this)
-                      + MemoryConsumption::memory_consumption(fevalv)
-                      - sizeof (fevalv)
-                      ;
+    std::size_t mem = sizeof(*this)
+                     + MemoryConsumption::memory_consumption(fevalv)
+                     - sizeof (fevalv);
     for (unsigned int i=0;i<fevalv.size();++i)
       mem += fevalv[i]->memory_consumption();
     return mem;
@@ -248,33 +247,32 @@ namespace MeshWorker
 
   
   template<int dim, int sdim>
-  unsigned int
+  std::size_t
   IntegrationInfoBox<dim,sdim>::memory_consumption () const
   {
-    unsigned int mem = sizeof(*this)
-                      + MemoryConsumption::memory_consumption(cell_quadrature)
-                      - sizeof (cell_quadrature)
-                      + MemoryConsumption::memory_consumption(boundary_quadrature)
-                      - sizeof (boundary_quadrature)
-                      + MemoryConsumption::memory_consumption(face_quadrature)
-                      - sizeof (face_quadrature)
-                      + MemoryConsumption::memory_consumption(cell_selector)
-                      -sizeof (cell_selector)
-                      + MemoryConsumption::memory_consumption(boundary_selector)
-                      -sizeof (boundary_selector)
-                      + MemoryConsumption::memory_consumption(face_selector)
-                      -sizeof (face_selector)
-                      + MemoryConsumption::memory_consumption(cell)
-                      - sizeof(cell)
-                      + MemoryConsumption::memory_consumption(boundary)
-                      - sizeof(boundary)
-                      + MemoryConsumption::memory_consumption(face)
-                      - sizeof(face)
-                      + MemoryConsumption::memory_consumption(subface)
-                      - sizeof(subface)
-                      + MemoryConsumption::memory_consumption(neighbor)
-                      - sizeof(neighbor)
-                      ;
+    std::size_t mem = sizeof(*this)
+                     + MemoryConsumption::memory_consumption(cell_quadrature)
+                     - sizeof (cell_quadrature)
+                     + MemoryConsumption::memory_consumption(boundary_quadrature)
+                     - sizeof (boundary_quadrature)
+                     + MemoryConsumption::memory_consumption(face_quadrature)
+                     - sizeof (face_quadrature)
+                     + MemoryConsumption::memory_consumption(cell_selector)
+                     -sizeof (cell_selector)
+                     + MemoryConsumption::memory_consumption(boundary_selector)
+                     -sizeof (boundary_selector)
+                     + MemoryConsumption::memory_consumption(face_selector)
+                     -sizeof (face_selector)
+                     + MemoryConsumption::memory_consumption(cell)
+                     - sizeof(cell)
+                     + MemoryConsumption::memory_consumption(boundary)
+                     - sizeof(boundary)
+                     + MemoryConsumption::memory_consumption(face)
+                     - sizeof(face)
+                     + MemoryConsumption::memory_consumption(subface)
+                     - sizeof(subface)
+                     + MemoryConsumption::memory_consumption(neighbor)
+                     - sizeof(neighbor);
 //   if (cell_data != 0)
 //     mem += MemoryConsumption::memory_consumption(*cell_data);
 //   if (boundary_data != 0)
index 8af1bf4de129f3c394f7efdf52b060d461471921..77fcafcc63eea5f565bdd1cedd787de41a00f01e 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2009, 2010 by the deal.II authors
+//    Copyright (C) 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -169,7 +169,7 @@ namespace MeshWorker
                                       /**
                                        * The memory used by this object.
                                        */
-      unsigned int memory_consumption () const;
+      std::size_t memory_consumption () const;
       
     protected:
                                       /**
@@ -323,7 +323,7 @@ namespace MeshWorker
                                       /**
                                        * The memory used by this object.
                                        */
-      unsigned int memory_consumption () const;
+      std::size_t memory_consumption () const;
   };
 
   
@@ -392,7 +392,7 @@ namespace MeshWorker
                                       /**
                                        * The memory used by this object.
                                        */
-      unsigned int memory_consumption () const;
+      std::size_t memory_consumption () const;
 
     private:
       NamedData<SmartPointer<const VECTOR,VectorData<VECTOR,dim,spacedim> > > data;
@@ -465,7 +465,7 @@ namespace MeshWorker
                                       /**
                                        * The memory used by this object.
                                        */
-      unsigned int memory_consumption () const;
+      std::size_t memory_consumption () const;
 
     private:
       NamedData<SmartPointer<const MGLevelObject<VECTOR>,MGVectorData<VECTOR,dim,spacedim> > > data;
@@ -603,13 +603,12 @@ namespace MeshWorker
   }
 
 
-  inline unsigned int
+  inline
+  std::size_t
   VectorSelector::memory_consumption () const
   {
-    unsigned int mem = sizeof(*this);
-    return mem;
-  }
-  
+    return sizeof(*this);
+  }  
 }
 
 
index 346e111efffa9865f8609d9cecf49d98c3d23355..793786519f21f75b6f32595d75b5cea571fdb689 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2009, 2010 by the deal.II authors
+//    Copyright (C) 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -145,10 +145,10 @@ namespace MeshWorker
 
 
   template <class VECTOR, int dim, int spacedim>
-  unsigned int
+  std::size_t
   VectorData<VECTOR, dim, spacedim>::memory_consumption () const
   {
-    unsigned int mem = VectorSelector::memory_consumption();
+    std::size_t mem = VectorSelector::memory_consumption();
     mem += sizeof (data);
     return mem;
   }
@@ -229,10 +229,10 @@ namespace MeshWorker
 
 
   template <class VECTOR, int dim, int spacedim>
-  unsigned int
+  std::size_t
   MGVectorData<VECTOR, dim, spacedim>::memory_consumption () const
   {
-    unsigned int mem = VectorSelector::memory_consumption();
+    std::size_t mem = VectorSelector::memory_consumption();
     mem += sizeof (data);
     return mem;
   }
index 60520bd6edb44601fea50cec309bc297483302ba..8bc148d2e3867bea1ded4cb625ef2d22c28c46ff 100644 (file)
@@ -330,7 +330,7 @@ class SolutionTransfer
                                      * memory consumption (in bytes)
                                      * of this object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 
                                     /**
                                      * Exception
@@ -432,7 +432,7 @@ class SolutionTransfer
                                      */
     struct Pointerstruct {
        Pointerstruct();
-       unsigned int memory_consumption () const;
+       std::size_t memory_consumption () const;
 
        std::vector<unsigned int>    *indices_ptr;
        std::vector<Vector<typename VECTOR::value_type> > *dof_values_ptr;
index 2dd19f618a2c0d0b8d90cf03be231ccecfa6ef44..1f11f2c7ea131386d94f32dbf42e5bca8fb15c0f 100644 (file)
@@ -683,7 +683,7 @@ class TimeDependent
                                      * memory consumption (in bytes)
                                      * of this object.
                                      */
-    unsigned int memory_consumption () const;
+    std::size_t memory_consumption () const;
 
                                     /**
                                      * Exception.
@@ -1001,7 +1001,7 @@ class TimeStepBase : public Subscriptor
                                      * result of this function to
                                      * your result.
                                      */
-    virtual unsigned int memory_consumption () const;
+    virtual std::size_t memory_consumption () const;
 
                                     /**
                                      * Exception
@@ -1772,7 +1772,7 @@ class TimeStepBase_Tria : public TimeStepBase
                                      * result of this function to
                                      * your result.
                                      */
-    virtual unsigned int memory_consumption () const;
+    virtual std::size_t memory_consumption () const;
 
                                     /**
                                      * Exception
index aefae526a6b3861dc0269d6582a9bcb062916404..b00153cb08eb5ece6af0cc1dc270e73f3d1d30ae 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors
+//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -1132,7 +1132,7 @@ DataOutBase::Patch<dim,spacedim>::operator == (const Patch &patch) const
 
 
 template <int dim, int spacedim>
-unsigned int
+std::size_t
 DataOutBase::Patch<dim,spacedim>::memory_consumption () const
 {
   return (sizeof(vertices) / sizeof(vertices[0]) *
@@ -1211,7 +1211,7 @@ void DataOutBase::DXFlags::parse_parameters (const ParameterHandler &prm)
 
 
 
-unsigned int
+std::size_t
 DataOutBase::DXFlags::memory_consumption () const
 {
                                   // only simple data elements, so
@@ -1240,7 +1240,7 @@ void DataOutBase::UcdFlags::parse_parameters (const ParameterHandler &prm)
 }
 
 
-unsigned int
+std::size_t
 DataOutBase::UcdFlags::memory_consumption () const
 {
                                   // only simple data elements, so
@@ -1267,7 +1267,7 @@ void DataOutBase::GnuplotFlags::parse_parameters (const ParameterHandler &/*prm*
 
 
 
-unsigned int
+size_t
 DataOutBase::GnuplotFlags::memory_consumption () const
 {
                                   // only simple data elements, so
@@ -1305,7 +1305,7 @@ void DataOutBase::PovrayFlags::parse_parameters (const ParameterHandler &prm)
 
 
 
-unsigned int
+std::size_t
 DataOutBase::PovrayFlags::memory_consumption () const
 {
                                   // only simple data elements, so
@@ -1551,7 +1551,7 @@ void DataOutBase::EpsFlags::parse_parameters (const ParameterHandler &prm)
 
 
 
-unsigned int
+std::size_t
 DataOutBase::EpsFlags::memory_consumption () const
 {
                                   // only simple data elements, so
@@ -1575,7 +1575,7 @@ void DataOutBase::GmvFlags::parse_parameters (const ParameterHandler &/*prm*/) c
 {}
 
 
-unsigned int
+std::size_t
 DataOutBase::GmvFlags::memory_consumption () const
 {
                                   // only simple data elements, so
@@ -1604,7 +1604,7 @@ void DataOutBase::TecplotFlags::parse_parameters (const ParameterHandler &/*prm*
 {}
 
 
-unsigned int
+std::size_t
 DataOutBase::TecplotFlags::memory_consumption () const
 {
                                   // only simple data elements, so
@@ -1629,7 +1629,7 @@ void DataOutBase::VtkFlags::parse_parameters (const ParameterHandler &/*prm*/) c
 
 
 
-unsigned int
+std::size_t
 DataOutBase::VtkFlags::memory_consumption () const
 {
                                   // only simple data elements, so
@@ -1655,7 +1655,7 @@ void DataOutBase::Deal_II_IntermediateFlags::parse_parameters (const ParameterHa
 {}
 
 
-unsigned int
+std::size_t
 DataOutBase::Deal_II_IntermediateFlags::memory_consumption () const
 {
                                   // only simple data elements, so
@@ -1665,7 +1665,8 @@ DataOutBase::Deal_II_IntermediateFlags::memory_consumption () const
 
 
 
-unsigned int DataOutBase::memory_consumption ()
+std::size_t
+DataOutBase::memory_consumption ()
 {
   return 0;
 }
@@ -5156,7 +5157,7 @@ DataOutInterface<dim,spacedim>::parse_parameters (ParameterHandler &prm)
 
 
 template <int dim, int spacedim>
-unsigned int
+std::size_t
 DataOutInterface<dim,spacedim>::memory_consumption () const
 {
   return (sizeof (default_fmt) +
index 12cf8a82093c870280e316c74094b58a70729019..3363d7140ca5d7a844068b7358d5fe973a60d0cd 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2007, 2008, 2010 by the deal.II authors
+//    Copyright (C) 2007, 2008, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -171,7 +171,8 @@ namespace Functions
 
 
   template<int dim>
-  unsigned int FlowFunction<dim>::memory_consumption () const
+  std::size_t
+  FlowFunction<dim>::memory_consumption () const
   {
     Assert(false, ExcNotImplemented());
     return 0;
index 3705d7545c9893fe2a4427a12aa7a1d4aa98a6cf..f302502718963f9118ec2b5c2c5150237b150d4a 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2009, 2010 by the deal.II authors
+//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -232,7 +232,7 @@ void Function<dim>::vector_laplacian_list (const std::vector<Point<dim> > &point
 
 
 template <int dim>
-unsigned int
+std::size_t
 Function<dim>::memory_consumption () const
 {
                                   // only simple data elements, so
@@ -423,7 +423,7 @@ void ConstantFunction<dim>::vector_value_list (const std::vector<Point<dim> > &p
 
 
 template <int dim>
-unsigned int
+std::size_t
 ConstantFunction<dim>::memory_consumption () const
 {
                                   // only simple data elements, so
@@ -504,7 +504,7 @@ void ComponentSelectFunction<dim>::vector_value_list (const std::vector<Point<di
 
 
 template <int dim>
-unsigned int
+std::size_t
 ComponentSelectFunction<dim>::memory_consumption () const
 {
                                   // only simple data elements, so
index 0c9fe0ae8455dade7bee56403fefaddc4ce7d172..ff2bd3f626455972287e5631c862218ec68532b0 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2000, 2001, 2002, 2003, 2005, 2006, 2007 by the deal.II authors
+//    Copyright (C) 2000, 2001, 2002, 2003, 2005, 2006, 2007, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -206,7 +206,7 @@ FunctionDerivative<dim>::value_list (const std::vector<Point<dim> > &points,
 
 
 template <int dim>
-unsigned int
+std::size_t
 FunctionDerivative<dim>::memory_consumption () const
 {
                                   // only simple data elements, so
index 608179560025764c4a9f8ecb84a1c07c056f66a2..f8f3c7159d9e7a0104d400b041f498a7b3600800 100644 (file)
@@ -1,7 +1,7 @@
 //---------------------------------------------------------------------------
 //    $Id$
 //
-//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2009, 2010 by the deal.II authors
+//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -1820,7 +1820,7 @@ namespace Functions
   
   
   template <int dim>
-  unsigned int
+  std::size_t
   JumpFunction<dim>::memory_consumption () const
   {
                                     // only simple data elements, so
index 1278a2feac365caf59a11f0f9f051a03d5c493b3..41df9e9c57e2d92c07b5960512fe4ce84599d106 100644 (file)
@@ -2,7 +2,7 @@
 //      $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2005, 2006, 2008, 2009, 2010 by the deal.II authors
+//    Copyright (C) 2005, 2006, 2008, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -415,7 +415,7 @@ IndexSet::make_trilinos_map (const MPI_Comm &communicator,
 #endif
 
 
-unsigned int
+std::size_t
 IndexSet::memory_consumption () const
 {
   return MemoryConsumption::memory_consumption (ranges) +
index b6c18fbfb28507866841b01b79e95ef37a10732a..dc71f4f6d68b14990d08ff20f155b657c1dc0afd 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2008, 2009, 2010 by the deal.II authors
+//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2008, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -374,15 +374,15 @@ LogStream::print_line_head()
 }
 
 
-unsigned int
+std::size_t
 LogStream::memory_consumption () const
 {
-  unsigned int mem = sizeof(*this);
+  std::size_t mem = sizeof(*this);
                                   // to determine size of stack
                                   // elements, we have to copy the
                                   // stack since we can't access
                                   // elements from further below
-  std::stack<std::string> tmp;
+  std::stack<std::string> tmp = prefixes;
   while (tmp.empty() == false)
     {
       mem += MemoryConsumption::memory_consumption (tmp.top());
index 27afd9ae7388dff8e37df3e64b4f1f474333afc4..a49f69703298a925f3d3a2272f8e3d0b02d6f751 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2000, 2001, 2002, 2003, 2005, 2006 by the deal.II authors
+//    Copyright (C) 2000, 2001, 2002, 2003, 2005, 2006, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -19,9 +19,10 @@ DEAL_II_NAMESPACE_OPEN
 
 namespace MemoryConsumption 
 {
-  unsigned int memory_consumption (const std::vector<std::string> &v)
+  std::size_t
+  memory_consumption (const std::vector<std::string> &v)
   {
-    unsigned int mem = sizeof(v);
+    std::size_t mem = sizeof(v);
     for (unsigned int i=0; i<v.size(); ++i)
       mem += memory_consumption(v[i]);
     return mem;
index 520d5cbdae0d5191a4dd5d3ded908a034e5e02c6..c75d3c83db1fca0da5b1dc2706d0a1d411dfa099 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors
+//    Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -156,7 +156,7 @@ MultithreadInfo::MultithreadInfo ()
 
 
 
-unsigned int
+std::size_t
 MultithreadInfo::memory_consumption ()
 {
                                   // only simple data elements, so
index 33ce681886466368f30dff39cb176af31fc4ed35..79148038ba21831d389b938b2d2a8202f575c55f 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2010 by the deal.II authors
+//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -122,7 +122,7 @@ namespace Patterns
   {}
 
 
-  unsigned int
+  std::size_t
   PatternBase::memory_consumption () const
   {
     if (dynamic_cast<const Integer*>(this) != 0)
@@ -420,7 +420,7 @@ namespace Patterns
   }
 
 
-  unsigned int
+  std::size_t
   Selection::memory_consumption () const
   {
     return (sizeof(PatternBase) +
@@ -547,7 +547,7 @@ namespace Patterns
   }
 
 
-  unsigned int
+  std::size_t
   List::memory_consumption () const
   {
     return (sizeof(PatternBase) +
@@ -688,7 +688,7 @@ namespace Patterns
   }
 
 
-  unsigned int
+  std::size_t
   MultipleSelection::memory_consumption () const
   {
     return (sizeof(PatternBase) +
@@ -2115,7 +2115,7 @@ ParameterHandler::scan_line (std::string        line,
 
 
 
-unsigned int
+std::size_t
 ParameterHandler::memory_consumption () const
 {
 //TODO: add to this an estimate of the memory in the property_tree
@@ -2342,10 +2342,10 @@ void MultipleParameterLoop::fill_entry_values (const unsigned int run_no)
 
 
 
-unsigned int
+std::size_t
 MultipleParameterLoop::memory_consumption () const
 {
-  unsigned int mem = ParameterHandler::memory_consumption ();
+  std::size_t mem = ParameterHandler::memory_consumption ();
   for (unsigned int i=0; i<multiple_choices.size(); ++i)
     mem += multiple_choices[i].memory_consumption ();
 
@@ -2410,7 +2410,7 @@ void MultipleParameterLoop::Entry::split_different_values ()
 }
 
 
-unsigned int
+std::size_t
 MultipleParameterLoop::Entry::memory_consumption () const
 {
   return (MemoryConsumption::memory_consumption (subsection_path) +
index ab855627d2bf8737563b0005165ce7bc209a8c7d..70b57ecc9836b19e97f7a1903128e899aec39bca 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors
+//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2005, 2006, 2007, 2008, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -290,7 +290,7 @@ Quadrature<dim>::~Quadrature ()
 
 
 template <int dim>
-unsigned int
+std::size_t
 Quadrature<dim>::memory_consumption () const
 {
   return (MemoryConsumption::memory_consumption (quadrature_points) +
index d6a6f2ce13f1b88155571d9b0d03db0110cd8973..c5963ef05c14d10bb26fb2a6ec842bbd71b85a08 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2008, 2009, 2010 by the deal.II authors
+//    Copyright (C) 2008, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -149,7 +149,7 @@ namespace internal
        static
        types<2>::forest * (&load) (const char *filename,
                                    MPI_Comm mpicomm,
-                                   std::size_t data_size,
+                                   size_t data_size,
                                    int load_data,
                                    void *user_pointer,
                                    types<2>::connectivity ** p4est);
@@ -2726,7 +2726,7 @@ namespace parallel
     template <int dim, int spacedim>
     unsigned int
     Triangulation<dim,spacedim>::
-    register_data_attach (const size_t size,
+    register_data_attach (const std::size_t size,
                          const std_cxx1x::function<void(const cell_iterator&,
                                                         const CellStatus,
                                                         void*)> & pack_callback)
@@ -2813,10 +2813,10 @@ namespace parallel
 
 
     template <int dim, int spacedim>
-    unsigned int
+    std::size_t
     Triangulation<dim,spacedim>::memory_consumption () const
     {
-      unsigned int mem=
+      std::size_t mem=
        this->dealii::Triangulation<dim,spacedim>::memory_consumption()
        + MemoryConsumption::memory_consumption(mpi_communicator)
        + MemoryConsumption::memory_consumption(my_subdomain)
@@ -2831,8 +2831,7 @@ namespace parallel
 //     + MemoryConsumption::memory_consumption(attached_data_pack_callbacks) //TODO[TH]: how?
        + MemoryConsumption::memory_consumption(coarse_cell_to_p4est_tree_permutation)
        + MemoryConsumption::memory_consumption(p4est_tree_to_coarse_cell_permutation)
-       + memory_consumption_p4est()
-       ;
+       + memory_consumption_p4est();
 
       return mem;
     }
@@ -2840,7 +2839,7 @@ namespace parallel
 
 
     template <int dim, int spacedim>
-    unsigned int
+    std::size_t
     Triangulation<dim,spacedim>::memory_consumption_p4est () const
     {
       return internal::p4est::functions<dim>::forest_memory_used(parallel_forest)
index aae782c96bfe91d95899c929bd59c96cc6734dcc..b3ca8bd6cb11f5052bc44e9f197c08158e6a5b52 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2006, 2010 by the deal.II authors
+//    Copyright (C) 2006, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -23,21 +23,21 @@ namespace internal
 {
   namespace DoFHandler
   {
-    unsigned int
+    std::size_t
     DoFFaces<1>::memory_consumption () const
     {
       return 0;
     }
 
 
-    unsigned int
+    std::size_t
     DoFFaces<2>::memory_consumption () const
     {
       return MemoryConsumption::memory_consumption (lines);
     }
 
 
-    unsigned int
+    std::size_t
     DoFFaces<3>::memory_consumption () const
     {
       return (MemoryConsumption::memory_consumption (quads) +
index 615f877e15d16de00006c8ed44e9fce693a64f68..75c38f211374f28f80401190f9af60b29787e261 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors
+//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -1630,17 +1630,17 @@ DoFHandler<dim,spacedim>::n_boundary_dofs (const std::set<unsigned char> &bounda
 
 
 template<int dim, int spacedim>
-unsigned int
+std::size_t
 DoFHandler<dim,spacedim>::memory_consumption () const
 {
-  unsigned int mem = (MemoryConsumption::memory_consumption (tria) +
-                     MemoryConsumption::memory_consumption (selected_fe) +
-                     MemoryConsumption::memory_consumption (block_info_object) +
-                     MemoryConsumption::memory_consumption (levels) +
-                     MemoryConsumption::memory_consumption (*faces) +
-                     MemoryConsumption::memory_consumption (faces) +
-                     sizeof (number_cache) +
-                     MemoryConsumption::memory_consumption (vertex_dofs));
+  std::size_t mem = (MemoryConsumption::memory_consumption (tria) +
+                    MemoryConsumption::memory_consumption (selected_fe) +
+                    MemoryConsumption::memory_consumption (block_info_object) +
+                    MemoryConsumption::memory_consumption (levels) +
+                    MemoryConsumption::memory_consumption (*faces) +
+                    MemoryConsumption::memory_consumption (faces) +
+                    sizeof (number_cache) +
+                    MemoryConsumption::memory_consumption (vertex_dofs));
   for (unsigned int i=0; i<levels.size(); ++i)
     mem += MemoryConsumption::memory_consumption (*levels[i]);
 
index 6f30abf737319e69b162eeb20e8ee88b54df517f..b260b31b198303e4c999e68ef4e1a5c8c8e867fa 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2000, 2001, 2002, 2003, 2005, 2006 by the deal.II authors
+//    Copyright (C) 2000, 2001, 2002, 2003, 2005, 2006, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -22,7 +22,7 @@ namespace internal
   namespace DoFHandler
   {
     
-    unsigned int
+    std::size_t
     DoFLevel<0>::memory_consumption () const
     {
       return MemoryConsumption::memory_consumption (cell_dof_indices_cache);
@@ -30,7 +30,7 @@ namespace internal
 
 
     
-    unsigned int
+    std::size_t
     DoFLevel<1>::memory_consumption () const
     {
       return (DoFLevel<0>::memory_consumption () +
@@ -39,7 +39,7 @@ namespace internal
 
     
     
-    unsigned int
+    std::size_t
     DoFLevel<2>::memory_consumption () const
     {
       return (DoFLevel<0>::memory_consumption () +
@@ -48,7 +48,7 @@ namespace internal
 
     
 
-    unsigned int
+    std::size_t
     DoFLevel<3>::memory_consumption () const
     {
       return (DoFLevel<0>::memory_consumption () +
index 6a6cd0a7348cd6f12515564954c35bbeaeea06b3..0b1593c568570be4b08415e6c2deca2fceb49e79 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2006, 2010 by the deal.II authors
+//    Copyright (C) 2006, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -25,7 +25,7 @@ namespace internal
   namespace DoFHandler
   {
     template <int dim>
-    unsigned int
+    std::size_t
     DoFObjects<dim>::memory_consumption () const
     {
       return (MemoryConsumption::memory_consumption (dofs));
index bff02e10d44d6428be1bdfa909a2c6e3d842f926..55330acdc945ef712f10b03c9732eba9a75c1ce4 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors
+//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -29,7 +29,7 @@ namespace internal
 
 
 
-    unsigned int
+    std::size_t
     NumberCache::memory_consumption () const
     {
       return
index a89db5320a9f75d60b757fe7aabd78d5922647f5..56418afb14c36a2fbebcfedb116c0f5922d6f1f1 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors
+//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -909,7 +909,7 @@ FiniteElement<dim,spacedim>::interpolate(
 
 
 template <int dim, int spacedim>
-unsigned int
+std::size_t
 FiniteElement<dim,spacedim>::memory_consumption () const
 {
   return (sizeof(FiniteElementData<dim>) +
index b3aadd6e0ab82504815a8cdb9b69f010fd1c9622..ed935493cd3760d9c56c061d8ee4cb406f9b3475 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2003, 2004, 2005, 2006, 2007, 2008, 2009 by the deal.II authors
+//    Copyright (C) 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -720,7 +720,7 @@ FE_ABF<dim>::interpolate(
 
 
 template <int dim>
-unsigned int
+std::size_t
 FE_ABF<dim>::memory_consumption () const
 {
   Assert (false, ExcNotImplemented ());
index 802c3cd3c69c6467b9670a94343817c2b6d11086..3e6fe2c836a6170226f3ac8a2f11416d11e4b66d 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2002, 2003, 2004, 2005, 2006, 2007, 2008 by the deal.II authors
+//    Copyright (C) 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -248,7 +248,7 @@ FE_DGP<dim,spacedim>::has_support_on_face (const unsigned int,
 
 
 template <int dim, int spacedim>
-unsigned int
+std::size_t
 FE_DGP<dim,spacedim>::memory_consumption () const
 {
   Assert (false, ExcNotImplemented ());
index d7af3c4a8d2eb3d19abb74defd3cfc0ac80ba6d6..ad2f656cea2139ca1aebc9c6f7c4010030a52ea1 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2004, 2005, 2006, 2007, 2008 by the deal.II authors
+//    Copyright (C) 2004, 2005, 2006, 2007, 2008, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -433,7 +433,7 @@ FE_DGPMonomial<3>::has_support_on_face (const unsigned int shape_index,
 
 
 template <int dim>
-unsigned int
+std::size_t
 FE_DGPMonomial<dim>::memory_consumption () const
 {
   Assert (false, ExcNotImplemented ());
index 1c2a80173a227f6b5d5c669edce3d947a76769cf..36fbeb0c26495fe690d660da61ff1b9e4d768a75 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009 by the deal.II authors
+//    Copyright (C) 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -596,7 +596,7 @@ FE_DGPNonparametric<dim,spacedim>::has_support_on_face (const unsigned int,
 
 
 template <int dim, int spacedim>
-unsigned int
+std::size_t
 FE_DGPNonparametric<dim,spacedim>::memory_consumption () const
 {
   Assert (false, ExcNotImplemented ());
index 4a5c3192ef369c50f42492271bbc08469d32663e..3577c85c5615284544f193e9a14c7f6e636bcb3c 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2010 by the deal.II authors
+//    Copyright (C) 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -649,7 +649,7 @@ FE_DGQ<dim, spacedim>::has_support_on_face (const unsigned int shape_index,
 
 
 template <int dim, int spacedim>
-unsigned int
+std::size_t
 FE_DGQ<dim, spacedim>::memory_consumption () const
 {
   Assert (false, ExcNotImplemented ());
index 323ead2db4b626cc779717e2a000232aef0234ab..dc5bf1f1b558e0349cc0a1e7e6f451c441f8d907 100644 (file)
@@ -5430,7 +5430,7 @@ const
 
 
 template <int dim>
-unsigned int
+std::size_t
 FE_Nedelec<dim>::memory_consumption () const
 {
   Assert (false, ExcNotImplemented ());
index 8bdede7b5183dd007027394ddbf66145686f23e6..59546964e0ca648d7b4fa29854f2454beba31ae1 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors
+//    Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -1981,7 +1981,7 @@ FE_Q<dim,spacedim>::has_support_on_face (const unsigned int shape_index,
 
 
 template <int dim, int spacedim>
-unsigned int
+std::size_t
 FE_Q<dim,spacedim>::memory_consumption () const
 {
   Assert (false, ExcNotImplemented ());
index 64cebd601b426a619d74d7036838ae7c7a93bb41..6f6a888ac635fc700c6aea381dbac4b2bcb8cc60 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2002, 2003, 2004, 2005, 2006, 2007, 2010 by the deal.II authors
+//    Copyright (C) 2002, 2003, 2004, 2005, 2006, 2007, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -1824,7 +1824,7 @@ FE_Q_Hierarchical<dim>::get_embedding_dofs (const unsigned int sub_degree) const
 
 
 template <int dim>
-unsigned int
+std::size_t
 FE_Q_Hierarchical<dim>::memory_consumption () const
 {
   Assert (false, ExcNotImplemented ());
index 71162802a8e06f277dac1f89d64bc42ffdb54ed3..8f760f4cb4229823a89ec6ec7490cccc473c99fe 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors
+//    Copyright (C) 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -529,7 +529,7 @@ FE_RaviartThomas<dim>::interpolate(
 
 
 template <int dim>
-unsigned int
+std::size_t
 FE_RaviartThomas<dim>::memory_consumption () const
 {
   Assert (false, ExcNotImplemented ());
index 098a75e02fb68bbe924daf199547119384f6af6a..6a05213091adb72c6f4c1559a9312e38b6518002 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors
+//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -3364,7 +3364,7 @@ FESystem<dim,spacedim>::unit_face_support_point (const unsigned index) const
 
 
 template <int dim, int spacedim>
-unsigned int
+std::size_t
 FESystem<dim,spacedim>::memory_consumption () const
 {
                                   // neglect size of data stored in
@@ -3373,8 +3373,8 @@ FESystem<dim,spacedim>::memory_consumption () const
                                   // compiler. should be neglectable
                                   // after all, considering the size
                                   // of the data of the subelements
-  unsigned int mem = (FiniteElement<dim,spacedim>::memory_consumption () +
-                     sizeof (base_elements));
+  std::size_t mem = (FiniteElement<dim,spacedim>::memory_consumption () +
+                    sizeof (base_elements));
   for (unsigned int i=0; i<base_elements.size(); ++i)
     mem += MemoryConsumption::memory_consumption (*base_elements[i].first);
   return mem;
index c5f3a2a6a9e578b25cdbbe8f333a1a5b1f49d769..62ee81ab3133127e9ed297457e0bebc75ddee58c 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors
+//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -3189,7 +3189,7 @@ FEValuesBase<dim,spacedim>::transform (
 
 
 template <int dim, int spacedim>
-unsigned int
+std::size_t
 FEValuesBase<dim,spacedim>::memory_consumption () const
 {
   return (MemoryConsumption::memory_consumption (this->shape_values) +
@@ -3525,7 +3525,7 @@ void FEValues<dim,spacedim>::do_reinit ()
 
 
 template <int dim, int spacedim>
-unsigned int
+std::size_t
 FEValues<dim,spacedim>::memory_consumption () const
 {
   return (FEValuesBase<dim,spacedim>::memory_consumption () +
@@ -3567,7 +3567,7 @@ FEFaceValuesBase<dim,spacedim>::get_boundary_forms () const
 
 
 template <int dim, int spacedim>
-unsigned int
+std::size_t
 FEFaceValuesBase<dim,spacedim>::memory_consumption () const
 {
   return (FEValuesBase<dim,spacedim>::memory_consumption () +
index 97b1fba103f71a090e3e98119afcf0785fd39aee..14b1b88b3a4563eea917ad07f1250dcd8566da08 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2001, 2002, 2003, 2005, 2006, 2009 by the deal.II authors
+//    Copyright (C) 2001, 2002, 2003, 2005, 2006, 2009, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -105,7 +105,7 @@ Mapping<dim, spacedim>::InternalDataBase::~InternalDataBase ()
 
 
 template <int dim, int spacedim>
-unsigned int
+std::size_t
 Mapping<dim, spacedim>::InternalDataBase::memory_consumption () const
 {
   return sizeof(*this);
index 0a5c34bc68a31193859676b892bd714bf41babfd..f28c77af0a4676d9d2976c9fcab9713741b350d2 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors
+//    Copyright (C) 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -43,7 +43,7 @@ MappingCartesian<dim, spacedim>::InternalData::InternalData (const Quadrature<di
 
 
 template<int dim, int spacedim>
-unsigned int
+std::size_t
 MappingCartesian<dim, spacedim>::InternalData::memory_consumption () const
 {
   return (Mapping<dim, spacedim>::InternalDataBase::memory_consumption() +
index e4e54d028817027a8170c5837460705b0a1f0ad8..a6a9dc75e88f0b32ac0f425ab79d33b578325cce 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors
+//    Copyright (C) 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -45,7 +45,7 @@ MappingQ<dim,spacedim>::InternalData::InternalData (const unsigned int n_shape_f
 
 
 template<int dim, int spacedim>
-unsigned int
+std::size_t
 MappingQ<dim,spacedim>::InternalData::memory_consumption () const
 {
   return (MappingQ1<dim,spacedim>::InternalData::memory_consumption () +
index 4f2d1af00ba6136d6c59396c5c5239f61ed7b303..d101aaa48afb19886b1dcd1888c9ffe7989cb6d9 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors
+//    Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -46,7 +46,7 @@ MappingQ1<dim,spacedim>::InternalData::InternalData (const unsigned int n_shape_
 
 
 template<int dim, int spacedim>
-unsigned int
+std::size_t
 MappingQ1<dim,spacedim>::InternalData::memory_consumption () const
 {
   return (Mapping<dim,spacedim>::InternalDataBase::memory_consumption() +
index e16e4fef8a87cea99ff03ee7d5ec6aebb3b0cdb7..fc28bff5239cbb1238eb5015ac0ccd0243c9a1dd 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2005, 2006, 2008, 2010 by the deal.II authors
+//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2005, 2006, 2008, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -549,7 +549,7 @@ GridOut::parse_parameters(ParameterHandler& param)
 
 
 
-unsigned int
+std::size_t
 GridOut::memory_consumption () const
 {
   return (sizeof(dx_flags) +
index 5bee2929b1dd3fea0bd5a797a36e9b06f7328e44..f5521ef33f06b07c2f96b7466289583a14bfb634 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2008 by the deal.II authors
+//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2008, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -228,7 +228,7 @@ InterGridMap<GridClass>::get_destination_grid () const
 
 
 template <class GridClass>
-unsigned int
+std::size_t
 InterGridMap<GridClass>::memory_consumption () const
 {
   return (MemoryConsumption::memory_consumption (mapping) +
index c9544f913122a85cc52539267ffad8e0c58e5732..987b84432381062fa3e771a837f69b32e5c9b0c3 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2005, 2006, 2007, 2009, 2010 by the deal.II authors
+//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2005, 2006, 2007, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -229,7 +229,7 @@ PersistentTriangulation<dim>::clear_flags()
 
 
 template <int dim>
-unsigned int
+std::size_t
 PersistentTriangulation<dim>::memory_consumption () const
 {
   return (Triangulation<dim>::memory_consumption () +
index 177f8aa2cc92cf4edc844fa205d583fa47c57e0d..c780ee03f4915788e0c31b608fafdcaa82bba235 100644 (file)
@@ -69,7 +69,7 @@ namespace internal
 
 
 
-    unsigned int
+    std::size_t
     NumberCache<1>::memory_consumption () const
     {
       return (MemoryConsumption::memory_consumption (n_levels) +
@@ -89,7 +89,7 @@ namespace internal
 
 
 
-    unsigned int
+    std::size_t
     NumberCache<2>::memory_consumption () const
     {
       return (NumberCache<1>::memory_consumption () +
@@ -110,7 +110,7 @@ namespace internal
 
 
 
-    unsigned int
+    std::size_t
     NumberCache<3>::memory_consumption () const
     {
       return (NumberCache<2>::memory_consumption () +
@@ -14394,10 +14394,10 @@ void Triangulation<dim, spacedim>::read_bool_vector (const unsigned int  magic_n
 
 
 template <int dim, int spacedim>
-unsigned int
+std::size_t
 Triangulation<dim, spacedim>::memory_consumption () const
 {
-  unsigned int mem = 0;
+  std::size_t mem = 0;
   mem += MemoryConsumption::memory_consumption(levels);
   for (unsigned int i=0; i<levels.size(); ++i)
     mem += MemoryConsumption::memory_consumption (*levels[i]);
index 45d7cc0108d1603146688e58f5144fc5abe05595..405f3536d8c6a1651ee3af96658887fe3bb7ef30 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2006, 2010 by the deal.II authors
+//    Copyright (C) 2006, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -22,21 +22,21 @@ namespace internal
   namespace Triangulation
   {
 
-    unsigned int
+    std::size_t
     TriaFaces<1>::memory_consumption () const
     {
       return 0;
     }
 
 
-    unsigned int
+    std::size_t
     TriaFaces<2>::memory_consumption () const
     {
       return MemoryConsumption::memory_consumption (lines);
     }
 
 
-    unsigned int
+    std::size_t
     TriaFaces<3>::memory_consumption () const
     {
       return (MemoryConsumption::memory_consumption (quads) +
index d110365599c6a34d8a4d883ed0661d92741bd22f..79e1ce3efbc69a3b57945da4c83ed03c78980abc 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2006, 2007, 2010 by the deal.II authors
+//    Copyright (C) 2006, 2007, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -115,7 +115,7 @@ namespace internal
 
 
     template <int dim>
-    unsigned int
+    std::size_t
     TriaLevel<dim>::memory_consumption () const
     {
       return (MemoryConsumption::memory_consumption (refine_flags) +
@@ -219,7 +219,7 @@ namespace internal
     }
 
 
-    unsigned int
+    std::size_t
     TriaLevel<3>::memory_consumption () const
     {
       return (MemoryConsumption::memory_consumption (refine_flags) +
index a1301d281fcece1f7d4e017402bcccd3f4b4d071..1aa1a50495aeeeaf46818cfb02caa27b82a32dee 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2006, 2007, 2010 by the deal.II authors
+//    Copyright (C) 2006, 2007, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -786,7 +786,7 @@ namespace internal
 
 
     template<typename G>
-    unsigned int
+    std::size_t
     TriaObjects<G>::memory_consumption () const
     {
       return (MemoryConsumption::memory_consumption (cells) +
@@ -799,7 +799,7 @@ namespace internal
     }
 
 
-    unsigned int
+    std::size_t
     TriaObjectsHex::memory_consumption () const
     {
       return (MemoryConsumption::memory_consumption (face_orientations) +
@@ -809,7 +809,7 @@ namespace internal
     }
 
 
-    unsigned int
+    std::size_t
     TriaObjectsQuad3D::memory_consumption () const
     {
       return (MemoryConsumption::memory_consumption (line_orientations) +
index 2b35e74d11e1eb0ce7838db951d5cb3e2efa159c..929195cc0b8a949a3686de5bd830b665ce564eff 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2006 by the deal.II authors
+//    Copyright (C) 2006, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -22,7 +22,7 @@ namespace internal
   namespace hp
   {
 
-    unsigned int
+    std::size_t
     DoFFaces<1>::memory_consumption () const
     {
       return 0;
@@ -30,7 +30,7 @@ namespace internal
 
 
 
-    unsigned int
+    std::size_t
     DoFFaces<2>::memory_consumption () const
     {
       return MemoryConsumption::memory_consumption (lines);
@@ -38,7 +38,7 @@ namespace internal
 
 
 
-    unsigned int
+    std::size_t
     DoFFaces<3>::memory_consumption () const
     {
       return (MemoryConsumption::memory_consumption (quads) +
index 6136a59aef08b44b9571dfe0aabb96ab344fced4..5d2ff3c96a15497e00ea316231441848afaa43e8 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2003, 2004, 2006, 2007, 2008, 2009, 2010 by the deal.II authors
+//    Copyright (C) 2003, 2004, 2006, 2007, 2008, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -2926,18 +2926,18 @@ namespace hp
 
 
   template<int dim, int spacedim>
-  unsigned int
+  std::size_t
   DoFHandler<dim,spacedim>::memory_consumption () const
   {
-    unsigned int mem = (MemoryConsumption::memory_consumption (tria) +
-                        MemoryConsumption::memory_consumption (finite_elements) +
-                        MemoryConsumption::memory_consumption (tria) +
-                        MemoryConsumption::memory_consumption (levels) +
-                        MemoryConsumption::memory_consumption (*faces) +
-                        MemoryConsumption::memory_consumption (number_cache) +
-                        MemoryConsumption::memory_consumption (vertex_dofs) +
-                        MemoryConsumption::memory_consumption (vertex_dofs_offsets) +
-                        MemoryConsumption::memory_consumption (has_children));
+    std::size_t mem = (MemoryConsumption::memory_consumption (tria) +
+                      MemoryConsumption::memory_consumption (finite_elements) +
+                      MemoryConsumption::memory_consumption (tria) +
+                      MemoryConsumption::memory_consumption (levels) +
+                      MemoryConsumption::memory_consumption (*faces) +
+                      MemoryConsumption::memory_consumption (number_cache) +
+                      MemoryConsumption::memory_consumption (vertex_dofs) +
+                      MemoryConsumption::memory_consumption (vertex_dofs_offsets) +
+                      MemoryConsumption::memory_consumption (has_children));
     for (unsigned int i=0; i<levels.size(); ++i)
       mem += MemoryConsumption::memory_consumption (*levels[i]);
     mem += MemoryConsumption::memory_consumption (*faces);
index 2f7a74cd12748c77c25449af36edde4e5930053b..c4c3ca2b4509be2d3d11ed030787e4b739d93c83 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2003, 2006 by the deal.II authors
+//    Copyright (C) 2003, 2006, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -22,7 +22,7 @@ namespace internal
   namespace hp
   {
 
-    unsigned int
+    std::size_t
     DoFLevel<1>::memory_consumption () const
     {
       return (DoFLevel<0>::memory_consumption() +
@@ -31,7 +31,7 @@ namespace internal
     
 
 
-    unsigned int
+    std::size_t
     DoFLevel<2>::memory_consumption () const
     {
       return (DoFLevel<0>::memory_consumption () +
@@ -40,7 +40,7 @@ namespace internal
 
 
 
-    unsigned int
+    std::size_t
     DoFLevel<3>::memory_consumption () const
     {
       return (DoFLevel<0>::memory_consumption () +
@@ -49,7 +49,7 @@ namespace internal
 
 
 
-    unsigned int
+    std::size_t
     DoFLevel<0>::memory_consumption () const
     {
       return MemoryConsumption::memory_consumption (active_fe_indices);
index 1f93a567bb3e1258f00d124cb64f4771451eeadd..e40832981a91629c84c3fd73c2faecfcebcc729c 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2006 by the deal.II authors
+//    Copyright (C) 2006, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -22,7 +22,7 @@ namespace internal
   namespace hp
   {
     template <int structdim>
-    unsigned int
+    std::size_t
     DoFObjects<structdim>::memory_consumption () const
     {
       return (MemoryConsumption::memory_consumption (dofs) +
@@ -32,19 +32,16 @@ namespace internal
 
                                     // explicit instantiations
     template
-    unsigned int
-    DoFObjects<1>::
-    memory_consumption () const;
+    std::size_t
+    DoFObjects<1>::memory_consumption () const;
     
     template
-    unsigned int
-    DoFObjects<2>::
-    memory_consumption () const;
+    std::size_t
+    DoFObjects<2>::memory_consumption () const;
     
     template
-    unsigned int
-    DoFObjects<3>::
-    memory_consumption () const;
+    std::size_t
+    DoFObjects<3>::memory_consumption () const;
   }
 }
 
index 3d79d64c2d943551153edc109fbf737b3629d382..453c7062ea98ce7c5e87c325096e550f57ff59b3 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2003, 2004, 2006 by the deal.II authors
+//    Copyright (C) 2003, 2004, 2006, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -73,10 +73,10 @@ namespace hp
 
 
   template <int dim, int spacedim>
-  unsigned int
+  std::size_t
   FECollection<dim,spacedim>::memory_consumption () const
   {
-    unsigned int mem
+    std::size_t mem
       = (sizeof(*this) +
          MemoryConsumption::memory_consumption (finite_elements));
     for (unsigned int i=0; i<finite_elements.size(); ++i)
index fde4d682b06b6415fc74feb21aba1d9a178fc988..5210d82037d55c4f2c1b796f583be6c0c95e0b2e 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2003, 2006 by the deal.II authors
+//    Copyright (C) 2003, 2006, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -58,7 +58,7 @@ namespace hp
 
 
   template<int dim, int spacedim>
-  unsigned int
+  std::size_t
   MappingCollection<dim,spacedim>::memory_consumption () const
   {
     return (sizeof(*this) +
index 55eeb571a900e7ac246a955d68486897fa0534cd..f7bf92adc9f1b4902f284b070d7397e10d36208f 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2009, 2010 by the deal.II authors
+//    Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -399,10 +399,10 @@ BlockSparsityPattern::is_compressed () const
 }
 
 
-unsigned int
+std::size_t
 BlockSparsityPattern::memory_consumption () const
 {
-  unsigned int mem = 0;
+  std::size_t mem = 0;
   mem += (MemoryConsumption::memory_consumption (rows) +
          MemoryConsumption::memory_consumption (columns) +
          MemoryConsumption::memory_consumption (sub_objects) +
index e5e135391d313a786adcc5a17c37fc0ec611cea2..2ed16560d8798edbcb2432f5ddc50d86ac30c4a5 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2008 by the deal.II authors
+//    Copyright (C) 2008, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -550,7 +550,7 @@ ChunkSparsityPattern::block_read (std::istream &in)
 
 
 
-unsigned int
+std::size_t
 ChunkSparsityPattern::memory_consumption () const
 {
   return (sizeof(*this) +
index ede39e6b3843353c527b4a4735ddc65b77efbf46..10d541c6ef1c67ebce2bc72ba81d8dbb0c499ecc 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2008, 2009 by the deal.II authors
+//    Copyright (C) 2008, 2009, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -201,7 +201,7 @@ CompressedSimpleSparsityPattern::Line::add_entries (ForwardIterator begin,
 }
 
 
-unsigned int
+std::size_t
 CompressedSimpleSparsityPattern::Line::memory_consumption () const
 {
   return entries.capacity()*sizeof(unsigned int)+sizeof(Line);
@@ -448,11 +448,11 @@ CompressedSimpleSparsityPattern::n_nonzero_elements () const
 }
 
 
-unsigned int
+std::size_t
 CompressedSimpleSparsityPattern::memory_consumption () const
 {
                                   //TODO: IndexSet...
-  unsigned int mem = sizeof(CompressedSimpleSparsityPattern);
+  std::size_t mem = sizeof(CompressedSimpleSparsityPattern);
   for (unsigned int i=0; i<lines.size(); ++i)
     mem += MemoryConsumption::memory_consumption (lines[i]);
 
index e4d31ef78ced9185dec6835db045d4c5e1c171ce..5628c3c3de63a09631ffa33ee33743bc67f2660c 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors
+//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -82,7 +82,7 @@ ConstraintMatrix::ConstraintLine::operator == (const ConstraintLine &a) const
 
 
 
-unsigned int
+std::size_t
 ConstraintMatrix::ConstraintLine::memory_consumption () const
 {
   return (MemoryConsumption::memory_consumption (line) +
@@ -2135,8 +2135,8 @@ unsigned int ConstraintMatrix::max_constraint_indirections () const
   for (std::vector<ConstraintLine>::const_iterator i=lines.begin();
        i!=lines.end(); ++i)
                                     // use static cast, since
-                                    // typeof(size)==size_t, which is
-                                    // != unsigned int on AIX
+                                    // typeof(size)==std::size_t, which is !=
+                                    // unsigned int on AIX
     return_value = std::max(return_value,
                            static_cast<unsigned int>(i->entries.size()));
 
@@ -2220,7 +2220,7 @@ ConstraintMatrix::write_dot (std::ostream &out) const
 
 
 
-unsigned int
+std::size_t
 ConstraintMatrix::memory_consumption () const
 {
   return (MemoryConsumption::memory_consumption (lines) +
index f26c818b18825eef321adbb5c24f0094782e1f29..0583b71bb9eabeff2c8e437189c7a2b5e419bb41 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2004, 2005, 2006, 2008, 2009, 2010 by the deal.II authors
+//    Copyright (C) 2004, 2005, 2006, 2008, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -616,13 +616,13 @@ namespace PETScWrappers
 
 
 
-  unsigned int
+  std::size_t
   MatrixBase::memory_consumption() const
   {
-      MatInfo info;
-      MatGetInfo(matrix, MAT_LOCAL, &info);
+    MatInfo info;
+    MatGetInfo(matrix, MAT_LOCAL, &info);
 
-      return sizeof(*this) + static_cast<unsigned int>(info.memory);
+    return sizeof(*this) + static_cast<unsigned int>(info.memory);
   }
 
 }
index 68cc7b28ee9e51aca9de7b17c4ec69cebeb2dce4..5b39a8318b28e6d27bbe1066879a497233f15e02 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors
+//    Copyright (C) 2004, 2005, 2006, 2007, 2008, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -1074,15 +1074,15 @@ namespace PETScWrappers
   }
 
 
-  unsigned int
+  std::size_t
   VectorBase::memory_consumption () const
   {    
-    unsigned int mem = sizeof(Vec)+sizeof(LastAction::Values)
+    std::size_t mem = sizeof(Vec)+sizeof(LastAction::Values)
       +MemoryConsumption::memory_consumption(ghosted)
       +MemoryConsumption::memory_consumption(ghost_indices);
 
                                     // TH: I am relatively sure that PETSc is
-                                    // storing the local data in a contigious
+                                    // storing the local data in a contiguous
                                     // block without indices:
     mem += local_size()*sizeof(PetscScalar);
                                     // assume that PETSc is storing one index
index 89f579355ee46e7ea140c5a7fcbb82d251d6d400..a1e9b2111a410799aa0ebdb65f135bdcea197d52 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2009, 2010 by the deal.II authors
+//    Copyright (C) 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -315,7 +315,7 @@ struct SparseDirectMA27::DetachedModeData
                                       */
     template <typename T>
     void put (const T *t,
-              const size_t N,
+              const std::size_t N,
              const char * /*debug_info*/) const
       {
         unsigned int count = 0;
@@ -349,7 +349,7 @@ struct SparseDirectMA27::DetachedModeData
                                       */
     template <typename T>
     void get (T *t,
-             const size_t N,
+             const std::size_t N,
              const char * /*debug_info*/) const
       {
         unsigned int count = 0;
@@ -823,7 +823,7 @@ SparseDirectMA27::solve (const SparseMatrix<number> &matrix,
 
 
 
-unsigned int
+std::size_t
 SparseDirectMA27::memory_consumption () const
 {
   return (sizeof(*this) +
@@ -1346,7 +1346,7 @@ SparseDirectMA47::solve (const SparseMatrix<double> &matrix,
 
 
 
-unsigned int
+std::size_t
 SparseDirectMA47::memory_consumption () const
 {
   return (sizeof(*this) +
index 2756701c506fba482425cc6798e6bf48a5aec843..f5afbb48485938c75c00e16964f4c9f13677f85a 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors
+//    Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -1030,7 +1030,7 @@ SparsityPattern::block_read (std::istream &in)
 std::size_t
 SparsityPattern::memory_consumption () const
 {
-  return (max_dim * static_cast<size_t>(sizeof(unsigned int)) +
+  return (max_dim * sizeof(unsigned int) +
          sizeof(*this) +
          max_vec_len * sizeof(unsigned int));
 }
index 34190d979ae6a8627ccfa633410aca009d1469b9..fdf798dac61023c887125f94977ee89d76054220 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2008, 2009, 2010 by the deal.II authors
+//    Copyright (C) 2008, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be distributed
 //    without copyright and license information. Please refer
@@ -684,7 +684,8 @@ namespace TrilinosWrappers
 
 
 
-  unsigned int PreconditionAMG::memory_consumption() const
+  std::size_t
+  PreconditionAMG::memory_consumption() const
   {
     unsigned int memory = sizeof(this);
 
index d1856fd101aab89cd6d6a05caec4584349b32e66..c4457d22a2fe4d52f9f3211f152cfd398455ef9b 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2008, 2009, 2010 by the deal.II authors
+//    Copyright (C) 2008, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -1340,7 +1340,7 @@ namespace TrilinosWrappers
 
 
 
-  unsigned int
+  std::size_t
   SparseMatrix::memory_consumption () const
   {
     unsigned int static_memory = sizeof(this) + sizeof (*matrix)
index da2469e31b2f7372cb151f20f51ef85ae871cc2e..92826b6a8d8e458a6881d5c26b31f620d60a6831 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2008, 2010 by the deal.II authors
+//    Copyright (C) 2008, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -395,7 +395,7 @@ namespace TrilinosWrappers
 
 
 
-  unsigned int
+  std::size_t
   VectorBase::memory_consumption () const
   {
                                     //TODO[TH]: No accurate memory
index c04554bc12e08b117a691bec3519f6a71b151c00..b963bcdf8c9d02c2d0b261c44fb345f4c09c7b44 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2007, 2008, 2010 by the deal.II authors
+//    Copyright (C) 2007, 2008, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -195,12 +195,12 @@ GrowingVectorMemory<VECTOR>::release_unused_memory ()
 
 template<typename VECTOR>
 inline
-unsigned int
+std::size_t
 GrowingVectorMemory<VECTOR>::memory_consumption () const
 {
   Threads::ThreadMutex::ScopedLock lock(mutex);
 
-  unsigned int result = sizeof (*this);
+  std::size_t result = sizeof (*this);
   const typename std::vector<entry_type>::const_iterator
     end = pool.data->end();
   for (typename std::vector<entry_type>::const_iterator
index d69d45da8111620e552194cbe0470a69dceef33e..c2aeb254179c7d5dbf03cbe16b9be5aeb416e88b 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2010 by the deal.II authors
+//    Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -868,10 +868,10 @@ MGDoFHandler<dim,spacedim>::~MGDoFHandler ()
 
 
 template <int dim, int spacedim>
-unsigned int
+std::size_t
 MGDoFHandler<dim,spacedim>::memory_consumption() const
 {
-  unsigned int mem = DoFHandler<dim,spacedim>::memory_consumption();
+  std::size_t mem = DoFHandler<dim,spacedim>::memory_consumption();
   for (unsigned int l=0;l<mg_levels.size();++l)
     mem += mg_levels[l]->memory_consumption();
 
index ce06736b3ca41a89cbbc07cd69dcc178069b51f7..16c7379141b8b6e73de2d039775ee62951e329f0 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009 by the deal.II authors
+//    Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -233,10 +233,10 @@ void MGTransferBlock<number>::restrict_and_add (
 
 
 
-unsigned int
+std::size_t
 MGTransferComponentBase::memory_consumption () const
 {
-  unsigned int result = sizeof(*this);
+  std::size_t result = sizeof(*this);
   result += MemoryConsumption::memory_consumption(selected)
            - sizeof(selected);
   result += MemoryConsumption::memory_consumption(target_component)
@@ -259,10 +259,10 @@ MGTransferComponentBase::memory_consumption () const
 
 
 //TODO:[GK] Add all those little vectors.
-unsigned int
+std::size_t
 MGTransferBlockBase::memory_consumption () const
 {
-  unsigned int result = sizeof(*this);
+  std::size_t result = sizeof(*this);
   result += sizeof(unsigned int) * sizes.size();
   result += MemoryConsumption::memory_consumption(selected)
            - sizeof(selected);
index 90d85c1af2d7d83e3e7deea602d27e9eeaba5e72..9eef1653fafa288eac85f7e61670cf411dd65a9b 100644 (file)
@@ -286,7 +286,7 @@ get_function_hessians (const FEValuesBase<DH::dimension,DH::space_dimension> &fe
 template <class DH,
          int patch_dim, int patch_space_dim>
 template <typename VectorType>
-unsigned int
+std::size_t
 DataOut_DoFData<DH,patch_dim,patch_space_dim>::
 DataEntry<VectorType>::memory_consumption () const
 {
@@ -660,7 +660,7 @@ DataOut_DoFData<DH,patch_dim,patch_space_dim>::get_patches () const
 
 template <class DH,
          int patch_dim, int patch_space_dim>
-unsigned int
+std::size_t
 DataOut_DoFData<DH,patch_dim,patch_space_dim>::memory_consumption () const
 {
   return (DataOutInterface<patch_dim,patch_space_dim>::memory_consumption () +
index 235c4841ab73d7873c70b18d41dc8c7303a4a3be..624c774c32fe8abec64f3325f1bd931a25d017fa 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2010 by the deal.II authors
+//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -31,7 +31,7 @@ DEAL_II_NAMESPACE_OPEN
 
 
 template <int dim, int spacedim, class DH>
-unsigned int
+std::size_t
 DataOutStack<dim,spacedim,DH>::DataVector::memory_consumption () const
 {
   return (MemoryConsumption::memory_consumption (data) +
@@ -430,7 +430,7 @@ void DataOutStack<dim,spacedim,DH>::finish_parameter_value ()
 
 
 template <int dim, int spacedim, class DH>
-unsigned int
+std::size_t
 DataOutStack<dim,spacedim,DH>::memory_consumption () const
 {
   return (DataOutInterface<dim+1>::memory_consumption () +
index e0aab40a28fa22a7df0dce565bbbbc77563928ff..4655b9d64c33c183ac588a61b110b4e1f8df6200 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2005, 2006, 2010 by the deal.II authors
+//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2005, 2006, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -42,7 +42,7 @@ Histogram::Interval::Interval (const double left_point,
 
 
 
-unsigned int
+std::size_t
 Histogram::Interval::memory_consumption () const
 {
   return sizeof(*this);
@@ -310,7 +310,7 @@ Histogram::parse_interval_spacing (const std::string &name)
 
 
 
-unsigned int
+std::size_t
 Histogram::memory_consumption () const
 {
   return (MemoryConsumption::memory_consumption (intervals) +
index 233b7b7573a54f9fd08ff18d0fda4707a1e05a89..7c7f856847ff5ec51a6b9d082cdabdd2450051ef 100644 (file)
@@ -1,7 +1,7 @@
 //---------------------------------------------------------------------------
 //    $Id$
 //
-//    Copyright (C) 2006, 2007, 2008, 2009, 2010 by the deal.II authors
+//    Copyright (C) 2006, 2007, 2008, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -38,10 +38,10 @@ namespace MeshWorker
 
 
   template <typename number>
-  unsigned int
+  std::size_t
   LocalResults<number>::memory_consumption () const
   {
-    unsigned int mem = sizeof(*this)
+    std::size_t mem = sizeof(*this)
                       + MemoryConsumption::memory_consumption(J)
                       + MemoryConsumption::memory_consumption(R)
                       + MemoryConsumption::memory_consumption(M1)
index 0186b349e06665a142b2f98bd5dbf8ee60bbbbb4..70ccfaeaf9fdceee631e4c97501b0c5cd6b8df94 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2008, 2009, 2010 by the deal.II authors
+//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2008, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -416,7 +416,7 @@ void SolutionTransfer<dim, VECTOR, DH>::interpolate(const VECTOR &in,
 
 
 template<int dim, typename VECTOR, class DH>
-unsigned int
+std::size_t
 SolutionTransfer<dim, VECTOR, DH>::memory_consumption () const
 {
                                   // at the moment we do not include the memory
@@ -433,7 +433,7 @@ SolutionTransfer<dim, VECTOR, DH>::memory_consumption () const
 
 
 template<int dim, typename VECTOR, class DH>
-unsigned int
+std::size_t
 SolutionTransfer<dim, VECTOR, DH>::Pointerstruct::memory_consumption () const
 {
   return sizeof(*this);
index baa908189edc06891a93304bcbbd07b2c2de5b26..206a24c55ed5170d97c179e02e398771abde7d5d 100644 (file)
@@ -2,7 +2,7 @@
 //    $Id$
 //    Version: $Name$
 //
-//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2005, 2006, 2008, 2009, 2010 by the deal.II authors
+//    Copyright (C) 1999, 2000, 2001, 2002, 2003, 2005, 2006, 2008, 2009, 2010, 2011 by the deal.II authors
 //
 //    This file is subject to QPL and may not be  distributed
 //    without copyright and license information. Please refer
@@ -234,13 +234,14 @@ void TimeDependent::end_sweep (const unsigned int begin,
 
 
 
-unsigned int TimeDependent::memory_consumption () const
+std::size_t
+TimeDependent::memory_consumption () const
 {
-  unsigned int mem = (MemoryConsumption::memory_consumption (timesteps) +
-                     MemoryConsumption::memory_consumption (sweep_no) +
-                     sizeof(timestepping_data_primal) +
-                     sizeof(timestepping_data_dual) +
-                     sizeof(timestepping_data_postprocess));
+  std::size_t mem = (MemoryConsumption::memory_consumption (timesteps) +
+                    MemoryConsumption::memory_consumption (sweep_no) +
+                    sizeof(timestepping_data_primal) +
+                    sizeof(timestepping_data_dual) +
+                    sizeof(timestepping_data_postprocess));
   for (unsigned int i=0; i<timesteps.size(); ++i)
     mem += MemoryConsumption::memory_consumption (*timesteps[i]);
 
@@ -397,7 +398,7 @@ TimeStepBase::set_sweep_no (const unsigned int sweep)
 
 
 
-unsigned int
+std::size_t
 TimeStepBase::memory_consumption () const
 {
                                   // only simple data types
@@ -1125,7 +1126,7 @@ void TimeStepBase_Tria<dim>::init_for_refinement ()
 
 
 template <int dim>
-unsigned int
+std::size_t
 TimeStepBase_Tria<dim>::memory_consumption () const
 {
   return (TimeStepBase::memory_consumption () +

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.