From 118f5cd00c4ee702cdd88cd320f4460ef1a649ae Mon Sep 17 00:00:00 2001 From: Wolfgang Bangerth Date: Sun, 23 Jan 2011 06:03:57 +0000 Subject: [PATCH] Convert the type returned by the various memory_consumption functions to std::size_t. git-svn-id: https://svn.dealii.org/trunk@23248 0785d39b-7218-0410-832d-ea1e28bc413d --- deal.II/doc/news/changes.h | 11 ++ deal.II/include/deal.II/base/data_out_base.h | 24 ++-- deal.II/include/deal.II/base/flow_function.h | 2 +- deal.II/include/deal.II/base/function.h | 6 +- .../deal.II/base/function_derivative.h | 2 +- deal.II/include/deal.II/base/function_lib.h | 2 +- deal.II/include/deal.II/base/geometry_info.h | 8 +- deal.II/include/deal.II/base/index_set.h | 4 +- deal.II/include/deal.II/base/logstream.h | 2 +- .../include/deal.II/base/memory_consumption.h | 110 +++++++++--------- .../include/deal.II/base/mg_level_object.h | 8 +- .../include/deal.II/base/multithread_info.h | 2 +- .../include/deal.II/base/parameter_handler.h | 14 +-- deal.II/include/deal.II/base/quadrature.h | 2 +- deal.II/include/deal.II/base/smartpointer.h | 7 +- .../include/deal.II/base/symmetric_tensor.h | 6 +- deal.II/include/deal.II/base/table.h | 6 +- deal.II/include/deal.II/base/tensor.h | 4 +- deal.II/include/deal.II/base/tensor_base.h | 6 +- deal.II/include/deal.II/distributed/tria.h | 8 +- deal.II/include/deal.II/dofs/block_info.h | 15 +-- deal.II/include/deal.II/dofs/dof_faces.h | 6 +- deal.II/include/deal.II/dofs/dof_handler.h | 2 +- deal.II/include/deal.II/dofs/dof_levels.h | 8 +- deal.II/include/deal.II/dofs/dof_objects.h | 2 +- deal.II/include/deal.II/dofs/number_cache.h | 2 +- deal.II/include/deal.II/fe/fe.h | 2 +- deal.II/include/deal.II/fe/fe_abf.h | 2 +- deal.II/include/deal.II/fe/fe_dg_vector.h | 2 +- .../deal.II/fe/fe_dg_vector.templates.h | 4 +- deal.II/include/deal.II/fe/fe_dgp.h | 2 +- deal.II/include/deal.II/fe/fe_dgp_monomial.h | 2 +- .../include/deal.II/fe/fe_dgp_nonparametric.h | 2 +- deal.II/include/deal.II/fe/fe_dgq.h | 2 +- deal.II/include/deal.II/fe/fe_nedelec.h | 2 +- deal.II/include/deal.II/fe/fe_q.h | 2 +- .../include/deal.II/fe/fe_q_hierarchical.h | 2 +- .../include/deal.II/fe/fe_raviart_thomas.h | 2 +- deal.II/include/deal.II/fe/fe_system.h | 2 +- deal.II/include/deal.II/fe/fe_values.h | 6 +- deal.II/include/deal.II/fe/mapping.h | 2 +- .../include/deal.II/fe/mapping_cartesian.h | 2 +- deal.II/include/deal.II/fe/mapping_q.h | 2 +- deal.II/include/deal.II/fe/mapping_q1.h | 2 +- deal.II/include/deal.II/grid/grid_out.h | 2 +- deal.II/include/deal.II/grid/intergrid_map.h | 2 +- .../include/deal.II/grid/persistent_tria.h | 2 +- deal.II/include/deal.II/grid/tria.h | 8 +- deal.II/include/deal.II/grid/tria_faces.h | 6 +- deal.II/include/deal.II/grid/tria_iterator.h | 6 +- deal.II/include/deal.II/grid/tria_levels.h | 4 +- deal.II/include/deal.II/grid/tria_object.h | 6 +- deal.II/include/deal.II/grid/tria_objects.h | 6 +- deal.II/include/deal.II/hp/dof_faces.h | 6 +- deal.II/include/deal.II/hp/dof_handler.h | 2 +- deal.II/include/deal.II/hp/dof_levels.h | 8 +- deal.II/include/deal.II/hp/dof_objects.h | 2 +- deal.II/include/deal.II/hp/fe_collection.h | 2 +- .../include/deal.II/hp/mapping_collection.h | 2 +- deal.II/include/deal.II/hp/q_collection.h | 6 +- deal.II/include/deal.II/lac/block_indices.h | 6 +- .../include/deal.II/lac/block_matrix_base.h | 10 +- .../include/deal.II/lac/block_sparse_matrix.h | 2 +- .../lac/block_sparse_matrix.templates.h | 6 +- .../lac/block_sparse_matrix_ez.templates.h | 6 +- .../deal.II/lac/block_sparsity_pattern.h | 2 +- .../include/deal.II/lac/block_vector_base.h | 9 +- .../include/deal.II/lac/chunk_sparse_matrix.h | 2 +- .../lac/chunk_sparse_matrix.templates.h | 4 +- .../deal.II/lac/chunk_sparsity_pattern.h | 2 +- .../lac/compressed_simple_sparsity_pattern.h | 4 +- .../include/deal.II/lac/constraint_matrix.h | 4 +- deal.II/include/deal.II/lac/filtered_matrix.h | 8 +- deal.II/include/deal.II/lac/full_matrix.h | 2 +- .../deal.II/lac/full_matrix.templates.h | 9 +- deal.II/include/deal.II/lac/matrix_block.h | 17 ++- .../include/deal.II/lac/petsc_matrix_base.h | 2 +- .../include/deal.II/lac/petsc_vector_base.h | 6 +- .../include/deal.II/lac/precondition_block.h | 2 +- .../lac/precondition_block.templates.h | 10 +- .../deal.II/lac/precondition_block_base.h | 8 +- .../deal.II/lac/sparse_decomposition.h | 2 +- .../lac/sparse_decomposition.templates.h | 10 +- deal.II/include/deal.II/lac/sparse_direct.h | 4 +- deal.II/include/deal.II/lac/sparse_ilu.h | 2 +- .../deal.II/lac/sparse_ilu.templates.h | 4 +- .../include/deal.II/lac/sparse_matrix_ez.h | 2 +- .../deal.II/lac/sparse_matrix_ez.templates.h | 4 +- deal.II/include/deal.II/lac/sparse_mic.h | 2 +- .../deal.II/lac/sparse_mic.templates.h | 4 +- deal.II/include/deal.II/lac/sparse_vanka.h | 4 +- .../deal.II/lac/sparse_vanka.templates.h | 12 +- .../include/deal.II/lac/swappable_vector.h | 2 +- .../deal.II/lac/swappable_vector.templates.h | 4 +- .../include/deal.II/lac/tridiagonal_matrix.h | 6 +- .../deal.II/lac/trilinos_precondition.h | 2 +- .../deal.II/lac/trilinos_sparse_matrix.h | 2 +- .../deal.II/lac/trilinos_sparsity_pattern.h | 2 +- .../deal.II/lac/trilinos_vector_base.h | 6 +- deal.II/include/deal.II/lac/vector.h | 6 +- .../include/deal.II/lac/vector.templates.h | 4 +- deal.II/include/deal.II/lac/vector_memory.h | 2 +- .../deal.II/multigrid/mg_dof_handler.h | 2 +- deal.II/include/deal.II/multigrid/mg_matrix.h | 10 +- .../include/deal.II/multigrid/mg_smoother.h | 18 +-- .../include/deal.II/multigrid/mg_transfer.h | 2 +- .../deal.II/multigrid/mg_transfer.templates.h | 6 +- .../deal.II/multigrid/mg_transfer_block.h | 8 +- .../multigrid/mg_transfer_block.templates.h | 4 +- .../deal.II/multigrid/mg_transfer_component.h | 4 +- .../mg_transfer_component.templates.h | 4 +- deal.II/include/deal.II/numerics/data_out.h | 6 +- .../include/deal.II/numerics/data_out_stack.h | 4 +- deal.II/include/deal.II/numerics/histogram.h | 4 +- .../include/deal.II/numerics/mesh_worker.h | 2 +- .../deal.II/numerics/mesh_worker_info.h | 6 +- .../numerics/mesh_worker_info.templates.h | 60 +++++----- .../numerics/mesh_worker_vector_selector.h | 19 ++- .../mesh_worker_vector_selector.templates.h | 10 +- .../deal.II/numerics/solution_transfer.h | 4 +- .../include/deal.II/numerics/time_dependent.h | 6 +- deal.II/source/base/data_out_base.cc | 27 ++--- deal.II/source/base/flow_function.cc | 5 +- deal.II/source/base/function.cc | 8 +- deal.II/source/base/function_derivative.cc | 4 +- deal.II/source/base/function_lib.cc | 4 +- deal.II/source/base/index_set.cc | 4 +- deal.II/source/base/logstream.cc | 8 +- deal.II/source/base/memory_consumption.cc | 7 +- deal.II/source/base/multithread_info.cc | 4 +- deal.II/source/base/parameter_handler.cc | 18 +-- deal.II/source/base/quadrature.cc | 4 +- deal.II/source/distributed/tria.cc | 15 ++- deal.II/source/dofs/dof_faces.cc | 8 +- deal.II/source/dofs/dof_handler.cc | 20 ++-- deal.II/source/dofs/dof_levels.cc | 10 +- deal.II/source/dofs/dof_objects.cc | 4 +- deal.II/source/dofs/number_cache.cc | 4 +- deal.II/source/fe/fe.cc | 4 +- deal.II/source/fe/fe_abf.cc | 4 +- deal.II/source/fe/fe_dgp.cc | 4 +- deal.II/source/fe/fe_dgp_monomial.cc | 4 +- deal.II/source/fe/fe_dgp_nonparametric.cc | 4 +- deal.II/source/fe/fe_dgq.cc | 4 +- deal.II/source/fe/fe_nedelec.cc | 2 +- deal.II/source/fe/fe_q.cc | 4 +- deal.II/source/fe/fe_q_hierarchical.cc | 4 +- deal.II/source/fe/fe_raviart_thomas.cc | 4 +- deal.II/source/fe/fe_system.cc | 8 +- deal.II/source/fe/fe_values.cc | 8 +- deal.II/source/fe/mapping.cc | 4 +- deal.II/source/fe/mapping_cartesian.cc | 4 +- deal.II/source/fe/mapping_q.cc | 4 +- deal.II/source/fe/mapping_q1.cc | 4 +- deal.II/source/grid/grid_out.cc | 4 +- deal.II/source/grid/intergrid_map.cc | 4 +- deal.II/source/grid/persistent_tria.cc | 4 +- deal.II/source/grid/tria.cc | 10 +- deal.II/source/grid/tria_faces.cc | 8 +- deal.II/source/grid/tria_levels.cc | 6 +- deal.II/source/grid/tria_objects.cc | 8 +- deal.II/source/hp/dof_faces.cc | 8 +- deal.II/source/hp/dof_handler.cc | 22 ++-- deal.II/source/hp/dof_levels.cc | 10 +- deal.II/source/hp/dof_objects.cc | 19 ++- deal.II/source/hp/fe_collection.cc | 6 +- deal.II/source/hp/mapping_collection.cc | 4 +- deal.II/source/lac/block_sparsity_pattern.cc | 6 +- deal.II/source/lac/chunk_sparsity_pattern.cc | 4 +- .../lac/compressed_simple_sparsity_pattern.cc | 8 +- deal.II/source/lac/constraint_matrix.cc | 10 +- deal.II/source/lac/petsc_matrix_base.cc | 10 +- deal.II/source/lac/petsc_vector_base.cc | 8 +- deal.II/source/lac/sparse_direct.cc | 10 +- deal.II/source/lac/sparsity_pattern.cc | 4 +- deal.II/source/lac/trilinos_precondition.cc | 5 +- deal.II/source/lac/trilinos_sparse_matrix.cc | 4 +- deal.II/source/lac/trilinos_vector_base.cc | 4 +- deal.II/source/lac/vector_memory.cc | 6 +- deal.II/source/multigrid/mg_dof_handler.cc | 6 +- deal.II/source/multigrid/multigrid.cc | 10 +- deal.II/source/numerics/data_out.cc | 4 +- deal.II/source/numerics/data_out_stack.cc | 6 +- deal.II/source/numerics/histogram.cc | 6 +- deal.II/source/numerics/mesh_worker.cc | 6 +- deal.II/source/numerics/solution_transfer.cc | 6 +- deal.II/source/numerics/time_dependent.cc | 19 +-- 187 files changed, 628 insertions(+), 618 deletions(-) diff --git a/deal.II/doc/news/changes.h b/deal.II/doc/news/changes.h index 80b942b22f..5c65bce5de 100644 --- a/deal.II/doc/news/changes.h +++ b/deal.II/doc/news/changes.h @@ -29,6 +29,17 @@ inconvenience this causes.

General

    +
  1. Changed: Most classes in deal.II have a member function +memory_consumption 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. +
    +(Wolfgang Bangerth, 2011/01/22) +
  2. Fixed: When using the --enable-mpi to ./configure, the script only tried mpiCC as the MPI C++ compiler. However, on some systems, it is called diff --git a/deal.II/include/deal.II/base/data_out_base.h b/deal.II/include/deal.II/base/data_out_base.h index 30e3987af7..6daf55ce8f 100644 --- a/deal.II/include/deal.II/base/data_out_base.h +++ b/deal.II/include/deal.II/base/data_out_base.h @@ -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: /** diff --git a/deal.II/include/deal.II/base/flow_function.h b/deal.II/include/deal.II/base/flow_function.h index 7919746a91..5d40aab953 100644 --- a/deal.II/include/deal.II/base/flow_function.h +++ b/deal.II/include/deal.II/base/flow_function.h @@ -115,7 +115,7 @@ namespace Functions virtual void vector_laplacian_list (const std::vector > &points, std::vector > &values) const; - unsigned int memory_consumption () const; + std::size_t memory_consumption () const; protected: /** diff --git a/deal.II/include/deal.II/base/function.h b/deal.II/include/deal.II/base/function.h index 56259c1357..baee75ab75 100644 --- a/deal.II/include/deal.II/base/function.h +++ b/deal.II/include/deal.II/base/function.h @@ -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 * 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 * quite close to the true * value. */ - unsigned int memory_consumption () const; + std::size_t memory_consumption () const; protected: /** diff --git a/deal.II/include/deal.II/base/function_derivative.h b/deal.II/include/deal.II/base/function_derivative.h index 6a253ba425..56fb8d2463 100644 --- a/deal.II/include/deal.II/base/function_derivative.h +++ b/deal.II/include/deal.II/base/function_derivative.h @@ -124,7 +124,7 @@ class FunctionDerivative : public AutoDerivativeFunction * quite close to the true * value. */ - unsigned int memory_consumption () const; + std::size_t memory_consumption () const; /** @addtogroup Exceptions * @{ */ diff --git a/deal.II/include/deal.II/base/function_lib.h b/deal.II/include/deal.II/base/function_lib.h index 9d49aeee99..17fd848d0f 100644 --- a/deal.II/include/deal.II/base/function_lib.h +++ b/deal.II/include/deal.II/base/function_lib.h @@ -599,7 +599,7 @@ namespace Functions * quite close to the true * value. */ - unsigned int memory_consumption () const; + std::size_t memory_consumption () const; protected: /** diff --git a/deal.II/include/deal.II/base/geometry_info.h b/deal.II/include/deal.II/base/geometry_info.h index 8e821eba22..e7c0ae9288 100644 --- a/deal.II/include/deal.II/base/geometry_info.h +++ b/deal.II/include/deal.II/base/geometry_info.h @@ -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 * 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::operator ~ () const template inline -unsigned int +std::size_t RefinementCase::memory_consumption () { return sizeof(RefinementCase); diff --git a/deal.II/include/deal.II/base/index_set.h b/deal.II/include/deal.II/base/index_set.h index 0c0b59213c..7ad043fa15 100644 --- a/deal.II/include/deal.II/base/index_set.h +++ b/deal.II/include/deal.II/base/index_set.h @@ -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); } diff --git a/deal.II/include/deal.II/base/logstream.h b/deal.II/include/deal.II/base/logstream.h index 131b02f019..5c3a261e57 100644 --- a/deal.II/include/deal.II/base/logstream.h +++ b/deal.II/include/deal.II/base/logstream.h @@ -298,7 +298,7 @@ class LogStream * quite close to the true * value. */ - unsigned int memory_consumption () const; + std::size_t memory_consumption () const; /** * Exception. diff --git a/deal.II/include/deal.II/base/memory_consumption.h b/deal.II/include/deal.II/base/memory_consumption.h index 970deacc8c..cc39babd12 100644 --- a/deal.II/include/deal.II/base/memory_consumption.h +++ b/deal.II/include/deal.II/base/memory_consumption.h @@ -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 #include #include -#include +#include DEAL_II_NAMESPACE_OPEN @@ -103,7 +103,7 @@ namespace MemoryConsumption */ template 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 * short int 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 * short unsigned int 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 inline - unsigned int memory_consumption (const std::complex &); + std::size_t memory_consumption (const std::complex &); /** * 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 inline - unsigned int memory_consumption (const std::vector &v); + std::size_t memory_consumption (const std::vector &v); /** * Estimate the amount of memory @@ -266,7 +266,7 @@ namespace MemoryConsumption */ template 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 &v); + std::size_t memory_consumption (const std::vector &v); /** * Specialization of the @@ -289,7 +289,7 @@ namespace MemoryConsumption * for a vector of ints. */ inline - unsigned int memory_consumption (const std::vector &v); + std::size_t memory_consumption (const std::vector &v); /** * Specialization of the @@ -298,7 +298,7 @@ namespace MemoryConsumption * for a vector of doubles. */ inline - unsigned int memory_consumption (const std::vector &v); + std::size_t memory_consumption (const std::vector &v); /** * Specialization of the @@ -307,7 +307,7 @@ namespace MemoryConsumption * for a vector of floats. */ inline - unsigned int memory_consumption (const std::vector &v); + std::size_t memory_consumption (const std::vector &v); /** * Specialization of the @@ -316,7 +316,7 @@ namespace MemoryConsumption * for a vector of chars. */ inline - unsigned int memory_consumption (const std::vector &v); + std::size_t memory_consumption (const std::vector &v); /** * Specialization of the @@ -325,7 +325,7 @@ namespace MemoryConsumption * for a vector of unsigned chars. */ inline - unsigned int memory_consumption (const std::vector &v); + std::size_t memory_consumption (const std::vector &v); /** * Specialization of the @@ -335,7 +335,7 @@ namespace MemoryConsumption */ template inline - unsigned int memory_consumption (const std::vector &v); + std::size_t memory_consumption (const std::vector &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 &v); + std::size_t memory_consumption (const std::vector &v); /** @@ -360,7 +360,7 @@ namespace MemoryConsumption */ template inline - unsigned int memory_consumption (const std::pair &p); + std::size_t memory_consumption (const std::pair &p); /** * Return the amount of memory @@ -372,7 +372,7 @@ namespace MemoryConsumption */ template 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 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 inline - unsigned int memory_consumption (const std_cxx1x::shared_ptr &); + std::size_t memory_consumption (const std_cxx1x::shared_ptr &); } @@ -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 inline - unsigned int memory_consumption (const std::complex &) + std::size_t memory_consumption (const std::complex &) { return sizeof(std::complex); } @@ -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 - unsigned int memory_consumption (const std::vector &v) + std::size_t memory_consumption (const std::vector &v) { unsigned int mem = sizeof(std::vector); const unsigned int n = v.size(); @@ -525,7 +525,7 @@ namespace MemoryConsumption template - 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 &v) + std::size_t memory_consumption (const std::vector &v) { return v.capacity() / 8 + sizeof(v); } @@ -544,7 +544,7 @@ namespace MemoryConsumption inline - unsigned int memory_consumption (const std::vector &v) + std::size_t memory_consumption (const std::vector &v) { return (v.capacity() * sizeof(int) + sizeof(v)); @@ -553,7 +553,7 @@ namespace MemoryConsumption inline - unsigned int memory_consumption (const std::vector &v) + std::size_t memory_consumption (const std::vector &v) { return (v.capacity() * sizeof(double) + sizeof(v)); @@ -562,7 +562,7 @@ namespace MemoryConsumption inline - unsigned int memory_consumption (const std::vector &v) + std::size_t memory_consumption (const std::vector &v) { return (v.capacity() * sizeof(float) + sizeof(v)); @@ -571,7 +571,7 @@ namespace MemoryConsumption inline - unsigned int memory_consumption (const std::vector &v) + std::size_t memory_consumption (const std::vector &v) { return (v.capacity() * sizeof(char) + sizeof(v)); @@ -580,7 +580,7 @@ namespace MemoryConsumption inline - unsigned int memory_consumption (const std::vector &v) + std::size_t memory_consumption (const std::vector &v) { return (v.capacity() * sizeof(unsigned char) + sizeof(v)); @@ -590,7 +590,7 @@ namespace MemoryConsumption template inline - unsigned int memory_consumption (const std::vector &v) + std::size_t memory_consumption (const std::vector &v) { return (v.capacity() * sizeof(T *) + sizeof(v)); @@ -600,7 +600,7 @@ namespace MemoryConsumption template inline - unsigned int memory_consumption (const std::pair &p) + std::size_t memory_consumption (const std::pair &p) { return (memory_consumption(p.first) + memory_consumption(p.second)); @@ -610,7 +610,7 @@ namespace MemoryConsumption template inline - unsigned int + std::size_t memory_consumption (const T * const) { return sizeof(T*); @@ -620,7 +620,7 @@ namespace MemoryConsumption template 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 inline - unsigned int + std::size_t memory_consumption (const std_cxx1x::shared_ptr &) { return sizeof(std_cxx1x::shared_ptr); @@ -649,7 +649,7 @@ namespace MemoryConsumption template inline - unsigned int + std::size_t memory_consumption (const T &t) { return t.memory_consumption(); diff --git a/deal.II/include/deal.II/base/mg_level_object.h b/deal.II/include/deal.II/base/mg_level_object.h index 6cebc0c801..15a3317d02 100644 --- a/deal.II/include/deal.II/base/mg_level_object.h +++ b/deal.II/include/deal.II/base/mg_level_object.h @@ -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::max_level () const template -unsigned int +std::size_t MGLevelObject::memory_consumption () const { - unsigned int result = sizeof(*this); + std::size_t result = sizeof(*this); typedef typename std::vector >::const_iterator Iter; const Iter end = objects.end(); for (Iter o=objects.begin(); o!=end; ++o) diff --git a/deal.II/include/deal.II/base/multithread_info.h b/deal.II/include/deal.II/base/multithread_info.h index ace22c2036..da5bb2da50 100644 --- a/deal.II/include/deal.II/base/multithread_info.h +++ b/deal.II/include/deal.II/base/multithread_info.h @@ -96,7 +96,7 @@ class MultithreadInfo * quite close to the true * value. */ - static unsigned int memory_consumption (); + static std::size_t memory_consumption (); /** * Exception diff --git a/deal.II/include/deal.II/base/parameter_handler.h b/deal.II/include/deal.II/base/parameter_handler.h index 2558aa0973..df9fdb9546 100644 --- a/deal.II/include/deal.II/base/parameter_handler.h +++ b/deal.II/include/deal.II/base/parameter_handler.h @@ -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; }; /** diff --git a/deal.II/include/deal.II/base/quadrature.h b/deal.II/include/deal.II/base/quadrature.h index 5907346f81..6be3dbdec8 100644 --- a/deal.II/include/deal.II/base/quadrature.h +++ b/deal.II/include/deal.II/base/quadrature.h @@ -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 diff --git a/deal.II/include/deal.II/base/smartpointer.h b/deal.II/include/deal.II/base/smartpointer.h index 36621b14ec..df5e5e3060 100644 --- a/deal.II/include/deal.II/base/smartpointer.h +++ b/deal.II/include/deal.II/base/smartpointer.h @@ -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 this 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::swap (T *&tt) template inline -unsigned int SmartPointer::memory_consumption () const +std::size_t +SmartPointer::memory_consumption () const { return sizeof(SmartPointer); } diff --git a/deal.II/include/deal.II/base/symmetric_tensor.h b/deal.II/include/deal.II/base/symmetric_tensor.h index 5196f2698d..85cbed02c5 100644 --- a/deal.II/include/deal.II/base/symmetric_tensor.h +++ b/deal.II/include/deal.II/base/symmetric_tensor.h @@ -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::clear () template inline -unsigned int +std::size_t SymmetricTensor::memory_consumption () { return diff --git a/deal.II/include/deal.II/base/table.h b/deal.II/include/deal.II/base/table.h index bb63d483ba..31ad01aa6b 100644 --- a/deal.II/include/deal.II/base/table.h +++ b/deal.II/include/deal.II/base/table.h @@ -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::fill (const T2* entries) template inline -unsigned int +std::size_t TableBase::memory_consumption () const { return sizeof(*this) + MemoryConsumption::memory_consumption(values); diff --git a/deal.II/include/deal.II/base/tensor.h b/deal.II/include/deal.II/base/tensor.h index e7f9a3d09b..448d7c823c 100644 --- a/deal.II/include/deal.II/base/tensor.h +++ b/deal.II/include/deal.II/base/tensor.h @@ -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::clear () template inline -unsigned int +std::size_t Tensor::memory_consumption () { return sizeof(Tensor); diff --git a/deal.II/include/deal.II/base/tensor_base.h b/deal.II/include/deal.II/base/tensor_base.h index 82addaafae..0a9f3c23c2 100644 --- a/deal.II/include/deal.II/base/tensor_base.h +++ b/deal.II/include/deal.II/base/tensor_base.h @@ -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 inline -unsigned int +std::size_t Tensor<1,dim>::memory_consumption () { return sizeof(Tensor<1,dim>); diff --git a/deal.II/include/deal.II/distributed/tria.h b/deal.II/include/deal.II/distributed/tria.h index 9a75162a73..60ef7bd114 100644 --- a/deal.II/include/deal.II/distributed/tria.h +++ b/deal.II/include/deal.II/distributed/tria.h @@ -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 & pack_callback); diff --git a/deal.II/include/deal.II/dofs/block_info.h b/deal.II/include/deal.II/dofs/block_info.h index 78b916ed0f..b297b03b73 100644 --- a/deal.II/include/deal.II/dofs/block_info.h +++ b/deal.II/include/deal.II/dofs/block_info.h @@ -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)); } diff --git a/deal.II/include/deal.II/dofs/dof_faces.h b/deal.II/include/deal.II/dofs/dof_faces.h index ce1ca18ff1..306207cce4 100644 --- a/deal.II/include/deal.II/dofs/dof_faces.h +++ b/deal.II/include/deal.II/dofs/dof_faces.h @@ -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; }; } diff --git a/deal.II/include/deal.II/dofs/dof_handler.h b/deal.II/include/deal.II/dofs/dof_handler.h index facad4496b..3a57c8bd4b 100644 --- a/deal.II/include/deal.II/dofs/dof_handler.h +++ b/deal.II/include/deal.II/dofs/dof_handler.h @@ -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. diff --git a/deal.II/include/deal.II/dofs/dof_levels.h b/deal.II/include/deal.II/dofs/dof_levels.h index 331feb1ba0..652345466e 100644 --- a/deal.II/include/deal.II/dofs/dof_levels.h +++ b/deal.II/include/deal.II/dofs/dof_levels.h @@ -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; }; } diff --git a/deal.II/include/deal.II/dofs/dof_objects.h b/deal.II/include/deal.II/dofs/dof_objects.h index 918f0dd38f..6545770210 100644 --- a/deal.II/include/deal.II/dofs/dof_objects.h +++ b/deal.II/include/deal.II/dofs/dof_objects.h @@ -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 diff --git a/deal.II/include/deal.II/dofs/number_cache.h b/deal.II/include/deal.II/dofs/number_cache.h index e6bacba8f8..a7ee3903ca 100644 --- a/deal.II/include/deal.II/dofs/number_cache.h +++ b/deal.II/include/deal.II/dofs/number_cache.h @@ -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, diff --git a/deal.II/include/deal.II/fe/fe.h b/deal.II/include/deal.II/fe/fe.h index 0c89f0ab56..cf714376b4 100644 --- a/deal.II/include/deal.II/fe/fe.h +++ b/deal.II/include/deal.II/fe/fe.h @@ -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 * diff --git a/deal.II/include/deal.II/fe/fe_abf.h b/deal.II/include/deal.II/fe/fe_abf.h index 24c6fb817c..21f6d0bd3c 100644 --- a/deal.II/include/deal.II/fe/fe_abf.h +++ b/deal.II/include/deal.II/fe/fe_abf.h @@ -163,7 +163,7 @@ class FE_ABF : public FE_PolyTensor, dim> virtual void interpolate( std::vector& local_dofs, const VectorSlice > >& values) const; - virtual unsigned int memory_consumption () const; + virtual std::size_t memory_consumption () const; virtual FiniteElement * clone() const; private: diff --git a/deal.II/include/deal.II/fe/fe_dg_vector.h b/deal.II/include/deal.II/fe/fe_dg_vector.h index 7ad6d58165..d1fffac32c 100644 --- a/deal.II/include/deal.II/fe/fe_dg_vector.h +++ b/deal.II/include/deal.II/fe/fe_dg_vector.h @@ -91,7 +91,7 @@ class FE_DGVector virtual void interpolate( std::vector& local_dofs, const VectorSlice > >& values) const; - virtual unsigned int memory_consumption () const; + virtual std::size_t memory_consumption () const; private: /** diff --git a/deal.II/include/deal.II/fe/fe_dg_vector.templates.h b/deal.II/include/deal.II/fe/fe_dg_vector.templates.h index b77d1cf67f..950426bf55 100644 --- a/deal.II/include/deal.II/fe/fe_dg_vector.templates.h +++ b/deal.II/include/deal.II/fe/fe_dg_vector.templates.h @@ -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::interpolate( template -unsigned int +std::size_t FE_DGVector::memory_consumption() const { Assert(false, ExcNotImplemented()); diff --git a/deal.II/include/deal.II/fe/fe_dgp.h b/deal.II/include/deal.II/fe/fe_dgp.h index fb1b378d2d..de515ee27a 100644 --- a/deal.II/include/deal.II/fe/fe_dgp.h +++ b/deal.II/include/deal.II/fe/fe_dgp.h @@ -296,7 +296,7 @@ class FE_DGP : public FE_Poly,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; /** diff --git a/deal.II/include/deal.II/fe/fe_dgp_monomial.h b/deal.II/include/deal.II/fe/fe_dgp_monomial.h index c5a1602075..b65ff77ecc 100644 --- a/deal.II/include/deal.II/fe/fe_dgp_monomial.h +++ b/deal.II/include/deal.II/fe/fe_dgp_monomial.h @@ -314,7 +314,7 @@ class FE_DGPMonomial : public FE_Poly,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: diff --git a/deal.II/include/deal.II/fe/fe_dgp_nonparametric.h b/deal.II/include/deal.II/fe/fe_dgp_nonparametric.h index 6321574b94..1e8a1988c1 100644 --- a/deal.II/include/deal.II/fe/fe_dgp_nonparametric.h +++ b/deal.II/include/deal.II/fe/fe_dgp_nonparametric.h @@ -399,7 +399,7 @@ class FE_DGPNonparametric : public FiniteElement * pointers to their base class, * rather than the class itself. */ - virtual unsigned int memory_consumption () const; + virtual std::size_t memory_consumption () const; private: diff --git a/deal.II/include/deal.II/fe/fe_dgq.h b/deal.II/include/deal.II/fe/fe_dgq.h index 7689596797..0aafb6b161 100644 --- a/deal.II/include/deal.II/fe/fe_dgq.h +++ b/deal.II/include/deal.II/fe/fe_dgq.h @@ -312,7 +312,7 @@ class FE_DGQ : public FE_Poly, 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: diff --git a/deal.II/include/deal.II/fe/fe_nedelec.h b/deal.II/include/deal.II/fe/fe_nedelec.h index 756f6139fe..3f9f18552b 100644 --- a/deal.II/include/deal.II/fe/fe_nedelec.h +++ b/deal.II/include/deal.II/fe/fe_nedelec.h @@ -231,7 +231,7 @@ class FE_Nedelec : public FE_PolyTensor, dim> { virtual void interpolate (std::vector& local_dofs, const VectorSlice > >& values) const; - virtual unsigned int memory_consumption () const; + virtual std::size_t memory_consumption () const; virtual FiniteElement * clone() const; private: diff --git a/deal.II/include/deal.II/fe/fe_q.h b/deal.II/include/deal.II/fe/fe_q.h index e88f9682ac..3972f328de 100644 --- a/deal.II/include/deal.II/fe/fe_q.h +++ b/deal.II/include/deal.II/fe/fe_q.h @@ -448,7 +448,7 @@ class FE_Q : public FE_Poly,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: /** diff --git a/deal.II/include/deal.II/fe/fe_q_hierarchical.h b/deal.II/include/deal.II/fe/fe_q_hierarchical.h index e61ff7c49a..a4daa1f28f 100644 --- a/deal.II/include/deal.II/fe/fe_q_hierarchical.h +++ b/deal.II/include/deal.II/fe/fe_q_hierarchical.h @@ -363,7 +363,7 @@ class FE_Q_Hierarchical : public FE_Poly,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 diff --git a/deal.II/include/deal.II/fe/fe_raviart_thomas.h b/deal.II/include/deal.II/fe/fe_raviart_thomas.h index 1e94f4949c..4de21ce266 100644 --- a/deal.II/include/deal.II/fe/fe_raviart_thomas.h +++ b/deal.II/include/deal.II/fe/fe_raviart_thomas.h @@ -141,7 +141,7 @@ class FE_RaviartThomas virtual void interpolate( std::vector& local_dofs, const VectorSlice > >& values) const; - virtual unsigned int memory_consumption () const; + virtual std::size_t memory_consumption () const; virtual FiniteElement * clone() const; private: diff --git a/deal.II/include/deal.II/fe/fe_system.h b/deal.II/include/deal.II/fe/fe_system.h index 326e734277..0db03036b2 100644 --- a/deal.II/include/deal.II/fe/fe_system.h +++ b/deal.II/include/deal.II/fe/fe_system.h @@ -654,7 +654,7 @@ class FESystem : public FiniteElement * pointers to their base class, * rather than the class itself. */ - virtual unsigned int memory_consumption () const; + virtual std::size_t memory_consumption () const; protected: /** diff --git a/deal.II/include/deal.II/fe/fe_values.h b/deal.II/include/deal.II/fe/fe_values.h index 7f357705b6..4b6c9f8cb1 100644 --- a/deal.II/include/deal.II/fe/fe_values.h +++ b/deal.II/include/deal.II/fe/fe_values.h @@ -2777,7 +2777,7 @@ class FEValuesBase : protected FEValuesData, * 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 * 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 * memory consumption (in bytes) * of this object. */ - unsigned int memory_consumption () const; + std::size_t memory_consumption () const; protected: diff --git a/deal.II/include/deal.II/fe/mapping.h b/deal.II/include/deal.II/fe/mapping.h index 11736bcd3f..493e8c4ea6 100644 --- a/deal.II/include/deal.II/fe/mapping.h +++ b/deal.II/include/deal.II/fe/mapping.h @@ -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 diff --git a/deal.II/include/deal.II/fe/mapping_cartesian.h b/deal.II/include/deal.II/fe/mapping_cartesian.h index 24f010c08b..f7875ae6e4 100644 --- a/deal.II/include/deal.II/fe/mapping_cartesian.h +++ b/deal.II/include/deal.II/fe/mapping_cartesian.h @@ -157,7 +157,7 @@ class MappingCartesian : public Mapping * consumption of this * object. */ - virtual unsigned int memory_consumption () const; + virtual std::size_t memory_consumption () const; /** * Length of the cell in diff --git a/deal.II/include/deal.II/fe/mapping_q.h b/deal.II/include/deal.II/fe/mapping_q.h index 75538439c1..08c2c81ace 100644 --- a/deal.II/include/deal.II/fe/mapping_q.h +++ b/deal.II/include/deal.II/fe/mapping_q.h @@ -161,7 +161,7 @@ class MappingQ : public MappingQ1 * consumption of this * object. */ - virtual unsigned int memory_consumption () const; + virtual std::size_t memory_consumption () const; /** * Unit normal vectors. Used diff --git a/deal.II/include/deal.II/fe/mapping_q1.h b/deal.II/include/deal.II/fe/mapping_q1.h index 74e2871984..75071f081a 100644 --- a/deal.II/include/deal.II/fe/mapping_q1.h +++ b/deal.II/include/deal.II/fe/mapping_q1.h @@ -164,7 +164,7 @@ class MappingQ1 : public Mapping * consumption of this * object. */ - virtual unsigned int memory_consumption () const; + virtual std::size_t memory_consumption () const; /** * Values of shape diff --git a/deal.II/include/deal.II/grid/grid_out.h b/deal.II/include/deal.II/grid/grid_out.h index 80579eb625..8a1fb328f7 100644 --- a/deal.II/include/deal.II/grid/grid_out.h +++ b/deal.II/include/deal.II/grid/grid_out.h @@ -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 diff --git a/deal.II/include/deal.II/grid/intergrid_map.h b/deal.II/include/deal.II/grid/intergrid_map.h index 1ac1ed72ed..d06560cf78 100644 --- a/deal.II/include/deal.II/grid/intergrid_map.h +++ b/deal.II/include/deal.II/grid/intergrid_map.h @@ -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 diff --git a/deal.II/include/deal.II/grid/persistent_tria.h b/deal.II/include/deal.II/grid/persistent_tria.h index da68425a75..fa9cada264 100644 --- a/deal.II/include/deal.II/grid/persistent_tria.h +++ b/deal.II/include/deal.II/grid/persistent_tria.h @@ -266,7 +266,7 @@ class PersistentTriangulation : public Triangulation * memory consumption (in bytes) * of this object. */ - virtual unsigned int memory_consumption () const; + virtual std::size_t memory_consumption () const; /** * Exception. diff --git a/deal.II/include/deal.II/grid/tria.h b/deal.II/include/deal.II/grid/tria.h index 57011a9c89..039fffc918 100644 --- a/deal.II/include/deal.II/grid/tria.h +++ b/deal.II/include/deal.II/grid/tria.h @@ -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; /** diff --git a/deal.II/include/deal.II/grid/tria_faces.h b/deal.II/include/deal.II/grid/tria_faces.h index 561fd2e920..964c81a034 100644 --- a/deal.II/include/deal.II/grid/tria_faces.h +++ b/deal.II/include/deal.II/grid/tria_faces.h @@ -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; }; } } diff --git a/deal.II/include/deal.II/grid/tria_iterator.h b/deal.II/include/deal.II/grid/tria_iterator.h index 5b59ddb550..28c999537b 100644 --- a/deal.II/include/deal.II/grid/tria_iterator.h +++ b/deal.II/include/deal.II/grid/tria_iterator.h @@ -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::print (std::ostream &out) const template inline -unsigned int +std::size_t TriaRawIterator::memory_consumption () const { return sizeof(TriaRawIterator); diff --git a/deal.II/include/deal.II/grid/tria_levels.h b/deal.II/include/deal.II/grid/tria_levels.h index edb82f3d04..40d92add01 100644 --- a/deal.II/include/deal.II/grid/tria_levels.h +++ b/deal.II/include/deal.II/grid/tria_levels.h @@ -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 diff --git a/deal.II/include/deal.II/grid/tria_object.h b/deal.II/include/deal.II/grid/tria_object.h index 355fe2653d..4527c4454c 100644 --- a/deal.II/include/deal.II/grid/tria_object.h +++ b/deal.II/include/deal.II/grid/tria_object.h @@ -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 inline - unsigned int + std::size_t TriaObject::memory_consumption () { return sizeof(TriaObject); diff --git a/deal.II/include/deal.II/grid/tria_objects.h b/deal.II/include/deal.II/grid/tria_objects.h index ae63441ae7..21a27c28a3 100644 --- a/deal.II/include/deal.II/grid/tria_objects.h +++ b/deal.II/include/deal.II/grid/tria_objects.h @@ -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; }; //----------------------------------------------------------------------// diff --git a/deal.II/include/deal.II/hp/dof_faces.h b/deal.II/include/deal.II/hp/dof_faces.h index e034570df7..5be36ff019 100644 --- a/deal.II/include/deal.II/hp/dof_faces.h +++ b/deal.II/include/deal.II/hp/dof_faces.h @@ -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 diff --git a/deal.II/include/deal.II/hp/dof_handler.h b/deal.II/include/deal.II/hp/dof_handler.h index 8cbb832750..225fe63489 100644 --- a/deal.II/include/deal.II/hp/dof_handler.h +++ b/deal.II/include/deal.II/hp/dof_handler.h @@ -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 diff --git a/deal.II/include/deal.II/hp/dof_levels.h b/deal.II/include/deal.II/hp/dof_levels.h index 57f03fc37b..4a66f4df18 100644 --- a/deal.II/include/deal.II/hp/dof_levels.h +++ b/deal.II/include/deal.II/hp/dof_levels.h @@ -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 diff --git a/deal.II/include/deal.II/hp/dof_objects.h b/deal.II/include/deal.II/hp/dof_objects.h index 88c8af7dfb..2650aba1fd 100644 --- a/deal.II/include/deal.II/hp/dof_objects.h +++ b/deal.II/include/deal.II/hp/dof_objects.h @@ -235,7 +235,7 @@ namespace internal * memory consumption (in bytes) * of this object. */ - unsigned int memory_consumption () const; + std::size_t memory_consumption () const; }; diff --git a/deal.II/include/deal.II/hp/fe_collection.h b/deal.II/include/deal.II/hp/fe_collection.h index f172d599b0..d30772a976 100644 --- a/deal.II/include/deal.II/hp/fe_collection.h +++ b/deal.II/include/deal.II/hp/fe_collection.h @@ -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; /** diff --git a/deal.II/include/deal.II/hp/mapping_collection.h b/deal.II/include/deal.II/hp/mapping_collection.h index 0ef4dedd3c..b768e9d546 100644 --- a/deal.II/include/deal.II/hp/mapping_collection.h +++ b/deal.II/include/deal.II/hp/mapping_collection.h @@ -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: /** diff --git a/deal.II/include/deal.II/hp/q_collection.h b/deal.II/include/deal.II/hp/q_collection.h index 923bea2d4c..e38eae4acb 100644 --- a/deal.II/include/deal.II/hp/q_collection.h +++ b/deal.II/include/deal.II/hp/q_collection.h @@ -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 inline - unsigned int + std::size_t QCollection::memory_consumption () const { return (sizeof(*this) + diff --git a/deal.II/include/deal.II/lac/block_indices.h b/deal.II/include/deal.II/lac/block_indices.h index 85a2c1c0b3..ac4cc36e80 100644 --- a/deal.II/include/deal.II/lac/block_indices.h +++ b/deal.II/include/deal.II/lac/block_indices.h @@ -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) + diff --git a/deal.II/include/deal.II/lac/block_matrix_base.h b/deal.II/include/deal.II/lac/block_matrix_base.h index 4da101c56a..2a2894b008 100644 --- a/deal.II/include/deal.II/lac/block_matrix_base.h +++ b/deal.II/include/deal.II/lac/block_matrix_base.h @@ -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 > @@ -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 -unsigned int +std::size_t BlockMatrixBase::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)+ diff --git a/deal.II/include/deal.II/lac/block_sparse_matrix.h b/deal.II/include/deal.II/lac/block_sparse_matrix.h index e6b48e9773..a51df16d76 100644 --- a/deal.II/include/deal.II/lac/block_sparse_matrix.h +++ b/deal.II/include/deal.II/lac/block_sparse_matrix.h @@ -403,7 +403,7 @@ class BlockSparseMatrix : public BlockMatrixBase > * memory consumption (in bytes) * of this object. */ - unsigned int memory_consumption () const; + std::size_t memory_consumption () const; /** @addtogroup Exceptions * @{ */ diff --git a/deal.II/include/deal.II/lac/block_sparse_matrix.templates.h b/deal.II/include/deal.II/lac/block_sparse_matrix.templates.h index 078a7c1052..4da7ebb4d0 100644 --- a/deal.II/include/deal.II/lac/block_sparse_matrix.templates.h +++ b/deal.II/include/deal.II/lac/block_sparse_matrix.templates.h @@ -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 -unsigned int +std::size_t BlockSparseMatrix::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; rn_block_rows(); ++r) for (unsigned int c=0; cn_block_cols(); ++c) diff --git a/deal.II/include/deal.II/lac/block_sparse_matrix_ez.templates.h b/deal.II/include/deal.II/lac/block_sparse_matrix_ez.templates.h index 56eb25c325..20723f74b2 100644 --- a/deal.II/include/deal.II/lac/block_sparse_matrix_ez.templates.h +++ b/deal.II/include/deal.II/lac/block_sparse_matrix_ez.templates.h @@ -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::collect_sizes () // template -// unsigned int +// std::size_t // BlockSparseMatrixEZ::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 * memory consumption (in bytes) * of this object. */ - unsigned int memory_consumption () const; + std::size_t memory_consumption () const; /** * Copy data from an object of diff --git a/deal.II/include/deal.II/lac/block_vector_base.h b/deal.II/include/deal.II/lac/block_vector_base.h index ba33570fcd..aff7adfdea 100644 --- a/deal.II/include/deal.II/lac/block_vector_base.h +++ b/deal.II/include/deal.II/lac/block_vector_base.h @@ -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::equ (const value_type a, template -unsigned int BlockVectorBase::memory_consumption () const +std::size_t +BlockVectorBase::memory_consumption () const { - unsigned int mem = sizeof(this->n_blocks()); + std::size_t mem = sizeof(this->n_blocks()); for (unsigned int i=0; icomponents.size(); ++i) mem += MemoryConsumption::memory_consumption (this->components[i]); mem += MemoryConsumption::memory_consumption (this->block_indices); diff --git a/deal.II/include/deal.II/lac/chunk_sparse_matrix.h b/deal.II/include/deal.II/lac/chunk_sparse_matrix.h index cb86464fd6..cae41161c2 100644 --- a/deal.II/include/deal.II/lac/chunk_sparse_matrix.h +++ b/deal.II/include/deal.II/lac/chunk_sparse_matrix.h @@ -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; //@} /** diff --git a/deal.II/include/deal.II/lac/chunk_sparse_matrix.templates.h b/deal.II/include/deal.II/lac/chunk_sparse_matrix.templates.h index 4c7c9d5b11..14d8f1f909 100644 --- a/deal.II/include/deal.II/lac/chunk_sparse_matrix.templates.h +++ b/deal.II/include/deal.II/lac/chunk_sparse_matrix.templates.h @@ -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::block_read (std::istream &in) template -unsigned int +std::size_t ChunkSparseMatrix::memory_consumption () const { return sizeof(*this) + max_len*sizeof(number); diff --git a/deal.II/include/deal.II/lac/chunk_sparsity_pattern.h b/deal.II/include/deal.II/lac/chunk_sparsity_pattern.h index 3defa0f90f..32ed5e5443 100644 --- a/deal.II/include/deal.II/lac/chunk_sparsity_pattern.h +++ b/deal.II/include/deal.II/lac/chunk_sparsity_pattern.h @@ -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 * @{ */ diff --git a/deal.II/include/deal.II/lac/compressed_simple_sparsity_pattern.h b/deal.II/include/deal.II/lac/compressed_simple_sparsity_pattern.h index 678ababbc3..add4374314 100644 --- a/deal.II/include/deal.II/lac/compressed_simple_sparsity_pattern.h +++ b/deal.II/include/deal.II/lac/compressed_simple_sparsity_pattern.h @@ -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; }; diff --git a/deal.II/include/deal.II/lac/constraint_matrix.h b/deal.II/include/deal.II/lac/constraint_matrix.h index 4a272f2a63..ed50171782 100644 --- a/deal.II/include/deal.II/lac/constraint_matrix.h +++ b/deal.II/include/deal.II/lac/constraint_matrix.h @@ -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; }; /** diff --git a/deal.II/include/deal.II/lac/filtered_matrix.h b/deal.II/include/deal.II/lac/filtered_matrix.h index 189955b9f3..3bfd7aa1f5 100644 --- a/deal.II/include/deal.II/lac/filtered_matrix.h +++ b/deal.II/include/deal.II/lac/filtered_matrix.h @@ -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::Tvmult_add (VECTOR& dst, const VECTOR& src) const template inline -unsigned int +std::size_t FilteredMatrix::memory_consumption () const { - return (MemoryConsumption::memory_consumption (matrix) + - MemoryConsumption::memory_consumption (constraints)); + return (MemoryConsumption::memory_consumption (matrix) + + MemoryConsumption::memory_consumption (constraints)); } diff --git a/deal.II/include/deal.II/lac/full_matrix.h b/deal.II/include/deal.II/lac/full_matrix.h index 5195577946..9c1331106f 100644 --- a/deal.II/include/deal.II/lac/full_matrix.h +++ b/deal.II/include/deal.II/lac/full_matrix.h @@ -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 diff --git a/deal.II/include/deal.II/lac/full_matrix.templates.h b/deal.II/include/deal.II/lac/full_matrix.templates.h index 4095da4826..f5f0d2ecc8 100644 --- a/deal.II/include/deal.II/lac/full_matrix.templates.h +++ b/deal.II/include/deal.II/lac/full_matrix.templates.h @@ -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::gauss_jordan () template -unsigned int +std::size_t FullMatrix::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()); } diff --git a/deal.II/include/deal.II/lac/matrix_block.h b/deal.II/include/deal.II/lac/matrix_block.h index 6616f6d2ff..33d167d528 100644 --- a/deal.II/include/deal.II/lac/matrix_block.h +++ b/deal.II/include/deal.II/lac/matrix_block.h @@ -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 > >&); @@ -906,13 +906,12 @@ MatrixBlock::Tvmult_add (VECTOR& w, const VECTOR& v) const template inline -unsigned int +std::size_t MatrixBlock::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)); } //----------------------------------------------------------------------// diff --git a/deal.II/include/deal.II/lac/petsc_matrix_base.h b/deal.II/include/deal.II/lac/petsc_matrix_base.h index 8d0eb2f914..b72fd8752e 100644 --- a/deal.II/include/deal.II/lac/petsc_matrix_base.h +++ b/deal.II/include/deal.II/lac/petsc_matrix_base.h @@ -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 diff --git a/deal.II/include/deal.II/lac/petsc_vector_base.h b/deal.II/include/deal.II/lac/petsc_vector_base.h index a74c5b0a53..41cfed6ab0 100644 --- a/deal.II/include/deal.II/lac/petsc_vector_base.h +++ b/deal.II/include/deal.II/lac/petsc_vector_base.h @@ -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: /** diff --git a/deal.II/include/deal.II/lac/precondition_block.h b/deal.II/include/deal.II/lac/precondition_block.h index dfb125d5d2..1acad5739e 100644 --- a/deal.II/include/deal.II/lac/precondition_block.h +++ b/deal.II/include/deal.II/lac/precondition_block.h @@ -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 * @{ */ diff --git a/deal.II/include/deal.II/lac/precondition_block.templates.h b/deal.II/include/deal.II/lac/precondition_block.templates.h index 67b0ab6087..09d6170505 100644 --- a/deal.II/include/deal.II/lac/precondition_block.templates.h +++ b/deal.II/include/deal.II/lac/precondition_block.templates.h @@ -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::set_permutation ( template -unsigned int +std::size_t PreconditionBlock::memory_consumption () const { - unsigned int mem = sizeof(*this) - sizeof(PreconditionBlockBase); - mem += PreconditionBlockBase::memory_consumption(); - return mem; + return (sizeof(*this) + - sizeof(PreconditionBlockBase) + + PreconditionBlockBase::memory_consumption()); } diff --git a/deal.II/include/deal.II/lac/precondition_block_base.h b/deal.II/include/deal.II/lac/precondition_block_base.h index 1777a92322..4558c6dd9b 100644 --- a/deal.II/include/deal.II/lac/precondition_block_base.h +++ b/deal.II/include/deal.II/lac/precondition_block_base.h @@ -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::inverses_ready() const template inline -unsigned int +std::size_t PreconditionBlockBase::memory_consumption () const { - unsigned int mem = sizeof(*this); + std::size_t mem = sizeof(*this); for (unsigned int i=0; i, * memory consumption (in bytes) * of this object. */ - virtual unsigned int memory_consumption () const; + virtual std::size_t memory_consumption () const; /** @addtogroup Exceptions * @{ */ diff --git a/deal.II/include/deal.II/lac/sparse_decomposition.templates.h b/deal.II/include/deal.II/lac/sparse_decomposition.templates.h index 1084fb9727..43b9fe12bd 100644 --- a/deal.II/include/deal.II/lac/sparse_decomposition.templates.h +++ b/deal.II/include/deal.II/lac/sparse_decomposition.templates.h @@ -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::strengthen_diagonal_impl () template -unsigned int +std::size_t SparseLUDecomposition::memory_consumption () const { - unsigned int - res = (SparseMatrix::memory_consumption () + - MemoryConsumption::memory_consumption(prebuilt_lower_bound)); - return res; + return (SparseMatrix::memory_consumption () + + MemoryConsumption::memory_consumption(prebuilt_lower_bound)); } diff --git a/deal.II/include/deal.II/lac/sparse_direct.h b/deal.II/include/deal.II/lac/sparse_direct.h index 2f307e8fcd..22f5060d62 100644 --- a/deal.II/include/deal.II/lac/sparse_direct.h +++ b/deal.II/include/deal.II/lac/sparse_direct.h @@ -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 diff --git a/deal.II/include/deal.II/lac/sparse_ilu.h b/deal.II/include/deal.II/lac/sparse_ilu.h index 8c4f2ceaf3..053cef4c74 100644 --- a/deal.II/include/deal.II/lac/sparse_ilu.h +++ b/deal.II/include/deal.II/lac/sparse_ilu.h @@ -166,7 +166,7 @@ class SparseILU : public SparseLUDecomposition * memory consumption (in bytes) * of this object. */ - unsigned int memory_consumption () const; + std::size_t memory_consumption () const; /** @addtogroup Exceptions * @{ */ diff --git a/deal.II/include/deal.II/lac/sparse_ilu.templates.h b/deal.II/include/deal.II/lac/sparse_ilu.templates.h index f9fb3797ff..190c1f9cc1 100644 --- a/deal.II/include/deal.II/lac/sparse_ilu.templates.h +++ b/deal.II/include/deal.II/lac/sparse_ilu.templates.h @@ -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::Tvmult (Vector &dst, template -unsigned int +std::size_t SparseILU::memory_consumption () const { return SparseLUDecomposition::memory_consumption (); diff --git a/deal.II/include/deal.II/lac/sparse_matrix_ez.h b/deal.II/include/deal.II/lac/sparse_matrix_ez.h index df53a78310..aec09a947a 100644 --- a/deal.II/include/deal.II/lac/sparse_matrix_ez.h +++ b/deal.II/include/deal.II/lac/sparse_matrix_ez.h @@ -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 diff --git a/deal.II/include/deal.II/lac/sparse_matrix_ez.templates.h b/deal.II/include/deal.II/lac/sparse_matrix_ez.templates.h index da15f1528b..7f03da83fd 100644 --- a/deal.II/include/deal.II/lac/sparse_matrix_ez.templates.h +++ b/deal.II/include/deal.II/lac/sparse_matrix_ez.templates.h @@ -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::precondition_SSOR (Vector &dst, template -unsigned int +std::size_t SparseMatrixEZ::memory_consumption() const { return diff --git a/deal.II/include/deal.II/lac/sparse_mic.h b/deal.II/include/deal.II/lac/sparse_mic.h index 6bdad53371..f5f38e1f41 100644 --- a/deal.II/include/deal.II/lac/sparse_mic.h +++ b/deal.II/include/deal.II/lac/sparse_mic.h @@ -121,7 +121,7 @@ class SparseMIC : public SparseLUDecomposition * memory consumption (in bytes) * of this object. */ - unsigned int memory_consumption () const; + std::size_t memory_consumption () const; /** @addtogroup Exceptions * @{ */ diff --git a/deal.II/include/deal.II/lac/sparse_mic.templates.h b/deal.II/include/deal.II/lac/sparse_mic.templates.h index 00de1e1790..2c2ed1ea7a 100644 --- a/deal.II/include/deal.II/lac/sparse_mic.templates.h +++ b/deal.II/include/deal.II/lac/sparse_mic.templates.h @@ -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::vmult (Vector &dst, template -unsigned int +std::size_t SparseMIC::memory_consumption () const { return (SparseLUDecomposition::memory_consumption () + diff --git a/deal.II/include/deal.II/lac/sparse_vanka.h b/deal.II/include/deal.II/lac/sparse_vanka.h index 2f9175fddc..af77663674 100644 --- a/deal.II/include/deal.II/lac/sparse_vanka.h +++ b/deal.II/include/deal.II/lac/sparse_vanka.h @@ -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 * memory consumption (in bytes) * of this object. */ - unsigned int memory_consumption () const; + std::size_t memory_consumption () const; private: /** diff --git a/deal.II/include/deal.II/lac/sparse_vanka.templates.h b/deal.II/include/deal.II/lac/sparse_vanka.templates.h index c27f44f51d..79ac3f86d7 100644 --- a/deal.II/include/deal.II/lac/sparse_vanka.templates.h +++ b/deal.II/include/deal.II/lac/sparse_vanka.templates.h @@ -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::apply_preconditioner (Vector &dst, template -unsigned int +std::size_t SparseVanka::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::vmult (Vector &dst, template -unsigned int +std::size_t SparseBlockVanka::memory_consumption () const { - unsigned int mem = SparseVanka::memory_consumption(); + std::size_t mem = SparseVanka::memory_consumption(); for (unsigned int i=0; i * memory consumption (in bytes) * of this object. */ - unsigned int memory_consumption () const; + std::size_t memory_consumption () const; /** @addtogroup Exceptions * @{ */ diff --git a/deal.II/include/deal.II/lac/swappable_vector.templates.h b/deal.II/include/deal.II/lac/swappable_vector.templates.h index 87ed650c4a..8def965e68 100644 --- a/deal.II/include/deal.II/lac/swappable_vector.templates.h +++ b/deal.II/include/deal.II/lac/swappable_vector.templates.h @@ -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::get_filename () const template -unsigned int +std::size_t SwappableVector::memory_consumption () const { return (MemoryConsumption::memory_consumption (filename) + diff --git a/deal.II/include/deal.II/lac/tridiagonal_matrix.h b/deal.II/include/deal.II/lac/tridiagonal_matrix.h index de1eee5905..b1d1e49f68 100644 --- a/deal.II/include/deal.II/lac/tridiagonal_matrix.h +++ b/deal.II/include/deal.II/lac/tridiagonal_matrix.h @@ -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: /** diff --git a/deal.II/include/deal.II/lac/trilinos_precondition.h b/deal.II/include/deal.II/lac/trilinos_precondition.h index b359254261..00dcd92936 100644 --- a/deal.II/include/deal.II/lac/trilinos_precondition.h +++ b/deal.II/include/deal.II/lac/trilinos_precondition.h @@ -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: /** diff --git a/deal.II/include/deal.II/lac/trilinos_sparse_matrix.h b/deal.II/include/deal.II/lac/trilinos_sparse_matrix.h index 8cab8ef9cf..7da9982b4a 100644 --- a/deal.II/include/deal.II/lac/trilinos_sparse_matrix.h +++ b/deal.II/include/deal.II/lac/trilinos_sparse_matrix.h @@ -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; //@} /** diff --git a/deal.II/include/deal.II/lac/trilinos_sparsity_pattern.h b/deal.II/include/deal.II/lac/trilinos_sparsity_pattern.h index 5edd6858a5..4bd9b41c67 100644 --- a/deal.II/include/deal.II/lac/trilinos_sparsity_pattern.h +++ b/deal.II/include/deal.II/lac/trilinos_sparsity_pattern.h @@ -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; //@} /** diff --git a/deal.II/include/deal.II/lac/trilinos_vector_base.h b/deal.II/include/deal.II/lac/trilinos_vector_base.h index 071cb6e4cf..02f758e06e 100644 --- a/deal.II/include/deal.II/lac/trilinos_vector_base.h +++ b/deal.II/include/deal.II/lac/trilinos_vector_base.h @@ -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; //@} /** diff --git a/deal.II/include/deal.II/lac/vector.h b/deal.II/include/deal.II/lac/vector.h index a8b10919f4..2dd5b2746f 100644 --- a/deal.II/include/deal.II/lac/vector.h +++ b/deal.II/include/deal.II/lac/vector.h @@ -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; //@} /** diff --git a/deal.II/include/deal.II/lac/vector.templates.h b/deal.II/include/deal.II/lac/vector.templates.h index 7d0985e74d..158a6418ba 100644 --- a/deal.II/include/deal.II/lac/vector.templates.h +++ b/deal.II/include/deal.II/lac/vector.templates.h @@ -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::block_read (std::istream &in) template -unsigned int +std::size_t Vector::memory_consumption () const { return sizeof(*this) + (max_vec_size * sizeof(Number)); diff --git a/deal.II/include/deal.II/lac/vector_memory.h b/deal.II/include/deal.II/lac/vector_memory.h index 0e3619d906..8cb0434d70 100644 --- a/deal.II/include/deal.II/lac/vector_memory.h +++ b/deal.II/include/deal.II/lac/vector_memory.h @@ -314,7 +314,7 @@ class GrowingVectorMemory : public VectorMemory * and all currently allocated * vectors. */ - virtual unsigned int memory_consumption() const; + virtual std::size_t memory_consumption() const; private: /** diff --git a/deal.II/include/deal.II/multigrid/mg_dof_handler.h b/deal.II/include/deal.II/multigrid/mg_dof_handler.h index f3422762d8..c97d782ac4 100644 --- a/deal.II/include/deal.II/multigrid/mg_dof_handler.h +++ b/deal.II/include/deal.II/multigrid/mg_dof_handler.h @@ -751,7 +751,7 @@ class MGDoFHandler : public DoFHandler * although the actual object * might be a derived class. */ - virtual unsigned int memory_consumption () const; + virtual std::size_t memory_consumption () const; /** diff --git a/deal.II/include/deal.II/multigrid/mg_matrix.h b/deal.II/include/deal.II/multigrid/mg_matrix.h index 4750b7b1e7..6fc9a322cc 100644 --- a/deal.II/include/deal.II/multigrid/mg_matrix.h +++ b/deal.II/include/deal.II/multigrid/mg_matrix.h @@ -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 > > matrices; }; @@ -154,7 +154,7 @@ class MGMatrix : public MGMatrixBase /** * Memory used by this object. */ - unsigned int memory_consumption () const; + std::size_t memory_consumption () const; private: @@ -343,7 +343,7 @@ namespace mg template inline - unsigned int + std::size_t Matrix::memory_consumption () const { return sizeof(*this) + matrices->memory_consumption(); @@ -420,7 +420,7 @@ MGMatrix::Tvmult_add (const unsigned int level, template -unsigned int +std::size_t MGMatrix::memory_consumption () const { return sizeof(*this) + matrix->memory_consumption(); diff --git a/deal.II/include/deal.II/multigrid/mg_smoother.h b/deal.II/include/deal.II/multigrid/mg_smoother.h index 96d660ef49..03274e26b1 100644 --- a/deal.II/include/deal.II/multigrid/mg_smoother.h +++ b/deal.II/include/deal.II/multigrid/mg_smoother.h @@ -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 /** * 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 /** * 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 /** * Memory used by this object. */ - unsigned int memory_consumption () const; + std::size_t memory_consumption () const; private: @@ -839,7 +840,8 @@ namespace mg template - inline unsigned int + inline + std::size_t SmootherRelaxation:: memory_consumption () const { @@ -1066,7 +1068,8 @@ MGSmootherRelaxation::smooth( template -inline unsigned int +inline +std::size_t MGSmootherRelaxation:: memory_consumption () const { @@ -1269,7 +1272,8 @@ MGSmootherPrecondition::smooth( template -inline unsigned int +inline +std::size_t MGSmootherPrecondition:: memory_consumption () const { diff --git a/deal.II/include/deal.II/multigrid/mg_transfer.h b/deal.II/include/deal.II/multigrid/mg_transfer.h index c00f2a3aaa..1c4bf076cd 100644 --- a/deal.II/include/deal.II/multigrid/mg_transfer.h +++ b/deal.II/include/deal.II/multigrid/mg_transfer.h @@ -189,7 +189,7 @@ class MGTransferPrebuilt : public MGTransferBase /** * Memory used by this object. */ - unsigned int memory_consumption () const; + std::size_t memory_consumption () const; private: diff --git a/deal.II/include/deal.II/multigrid/mg_transfer.templates.h b/deal.II/include/deal.II/multigrid/mg_transfer.templates.h index 5e82091662..a77cba694f 100644 --- a/deal.II/include/deal.II/multigrid/mg_transfer.templates.h +++ b/deal.II/include/deal.II/multigrid/mg_transfer.templates.h @@ -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 &map) } template -unsigned int +std::size_t MGTransferPrebuilt::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 > >::const_iterator m; diff --git a/deal.II/include/deal.II/multigrid/mg_transfer_block.h b/deal.II/include/deal.II/multigrid/mg_transfer_block.h index a9f7451ef2..7edde42edb 100644 --- a/deal.II/include/deal.II/multigrid/mg_transfer_block.h +++ b/deal.II/include/deal.II/multigrid/mg_transfer_block.h @@ -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& dst, const MGLevelObject > &src) const; - MGTransferBlockBase::memory_consumption; + using MGTransferBlockBase::memory_consumption; private: /** @@ -443,7 +443,7 @@ class MGTransferBlockSelect : public MGTransferBase >, /** * Memory used by this object. */ - unsigned int memory_consumption () const; + std::size_t memory_consumption () const; private: /** diff --git a/deal.II/include/deal.II/multigrid/mg_transfer_block.templates.h b/deal.II/include/deal.II/multigrid/mg_transfer_block.templates.h index 95028b8220..165f494e28 100644 --- a/deal.II/include/deal.II/multigrid/mg_transfer_block.templates.h +++ b/deal.II/include/deal.II/multigrid/mg_transfer_block.templates.h @@ -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::copy_from_mg_add ( template -unsigned int +std::size_t MGTransferBlockSelect::memory_consumption () const { return sizeof(int) + MGTransferBlockBase::memory_consumption(); diff --git a/deal.II/include/deal.II/multigrid/mg_transfer_component.h b/deal.II/include/deal.II/multigrid/mg_transfer_component.h index 3a209635f4..643c66a01d 100644 --- a/deal.II/include/deal.II/multigrid/mg_transfer_component.h +++ b/deal.II/include/deal.II/multigrid/mg_transfer_component.h @@ -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 >, /** * Memory used by this object. */ - unsigned int memory_consumption () const; + std::size_t memory_consumption () const; private: /** diff --git a/deal.II/include/deal.II/multigrid/mg_transfer_component.templates.h b/deal.II/include/deal.II/multigrid/mg_transfer_component.templates.h index ab31dd6b98..d662590f96 100644 --- a/deal.II/include/deal.II/multigrid/mg_transfer_component.templates.h +++ b/deal.II/include/deal.II/multigrid/mg_transfer_component.templates.h @@ -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::do_copy_from_mg_add ( template -unsigned int +std::size_t MGTransferSelect::memory_consumption () const { return sizeof(int) + MGTransferComponentBase::memory_consumption(); diff --git a/deal.II/include/deal.II/numerics/data_out.h b/deal.II/include/deal.II/numerics/data_out.h index 0cd4978a32..058a75f99d 100644 --- a/deal.II/include/deal.II/numerics/data_out.h +++ b/deal.II/include/deal.II/numerics/data_out.h @@ -654,7 +654,7 @@ class DataOut_DoFData : public DataOutInterface * 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 * 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 * the memory consumption (in * bytes) of this object. */ - virtual unsigned int memory_consumption () const; + virtual std::size_t memory_consumption () const; private: /** diff --git a/deal.II/include/deal.II/numerics/data_out_stack.h b/deal.II/include/deal.II/numerics/data_out_stack.h index 184edbf154..ccda46cc6b 100644 --- a/deal.II/include/deal.II/numerics/data_out_stack.h +++ b/deal.II/include/deal.II/numerics/data_out_stack.h @@ -290,7 +290,7 @@ class DataOutStack : public DataOutInterface * 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 * the memory consumption (in * bytes) of this object. */ - unsigned int memory_consumption () const; + std::size_t memory_consumption () const; }; /** diff --git a/deal.II/include/deal.II/numerics/histogram.h b/deal.II/include/deal.II/numerics/histogram.h index c28b285f94..4a06b88b71 100644 --- a/deal.II/include/deal.II/numerics/histogram.h +++ b/deal.II/include/deal.II/numerics/histogram.h @@ -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. diff --git a/deal.II/include/deal.II/numerics/mesh_worker.h b/deal.II/include/deal.II/numerics/mesh_worker.h index ad307a87fe..a461fde2ae 100644 --- a/deal.II/include/deal.II/numerics/mesh_worker.h +++ b/deal.II/include/deal.II/numerics/mesh_worker.h @@ -399,7 +399,7 @@ namespace MeshWorker /** * The memory used by this object. */ - unsigned int memory_consumption () const; + std::size_t memory_consumption () const; private: /** diff --git a/deal.II/include/deal.II/numerics/mesh_worker_info.h b/deal.II/include/deal.II/numerics/mesh_worker_info.h index f70e244997..c19a5ba290 100644 --- a/deal.II/include/deal.II/numerics/mesh_worker_info.h +++ b/deal.II/include/deal.II/numerics/mesh_worker_info.h @@ -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 diff --git a/deal.II/include/deal.II/numerics/mesh_worker_info.templates.h b/deal.II/include/deal.II/numerics/mesh_worker_info.templates.h index 67b414bf1d..8506ec0d06 100644 --- a/deal.II/include/deal.II/numerics/mesh_worker_info.templates.h +++ b/deal.II/include/deal.II/numerics/mesh_worker_info.templates.h @@ -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 - unsigned int + std::size_t IntegrationInfo::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;imemory_consumption(); return mem; @@ -248,33 +247,32 @@ namespace MeshWorker template - unsigned int + std::size_t IntegrationInfoBox::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) diff --git a/deal.II/include/deal.II/numerics/mesh_worker_vector_selector.h b/deal.II/include/deal.II/numerics/mesh_worker_vector_selector.h index 8af1bf4de1..77fcafcc63 100644 --- a/deal.II/include/deal.II/numerics/mesh_worker_vector_selector.h +++ b/deal.II/include/deal.II/numerics/mesh_worker_vector_selector.h @@ -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 > > 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,MGVectorData > > 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); + } } diff --git a/deal.II/include/deal.II/numerics/mesh_worker_vector_selector.templates.h b/deal.II/include/deal.II/numerics/mesh_worker_vector_selector.templates.h index 346e111eff..793786519f 100644 --- a/deal.II/include/deal.II/numerics/mesh_worker_vector_selector.templates.h +++ b/deal.II/include/deal.II/numerics/mesh_worker_vector_selector.templates.h @@ -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 - unsigned int + std::size_t VectorData::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 - unsigned int + std::size_t MGVectorData::memory_consumption () const { - unsigned int mem = VectorSelector::memory_consumption(); + std::size_t mem = VectorSelector::memory_consumption(); mem += sizeof (data); return mem; } diff --git a/deal.II/include/deal.II/numerics/solution_transfer.h b/deal.II/include/deal.II/numerics/solution_transfer.h index 60520bd6ed..8bc148d2e3 100644 --- a/deal.II/include/deal.II/numerics/solution_transfer.h +++ b/deal.II/include/deal.II/numerics/solution_transfer.h @@ -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 *indices_ptr; std::vector > *dof_values_ptr; diff --git a/deal.II/include/deal.II/numerics/time_dependent.h b/deal.II/include/deal.II/numerics/time_dependent.h index 2dd19f618a..1f11f2c7ea 100644 --- a/deal.II/include/deal.II/numerics/time_dependent.h +++ b/deal.II/include/deal.II/numerics/time_dependent.h @@ -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 diff --git a/deal.II/source/base/data_out_base.cc b/deal.II/source/base/data_out_base.cc index aefae526a6..b00153cb08 100644 --- a/deal.II/source/base/data_out_base.cc +++ b/deal.II/source/base/data_out_base.cc @@ -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::operator == (const Patch &patch) const template -unsigned int +std::size_t DataOutBase::Patch::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::parse_parameters (ParameterHandler &prm) template -unsigned int +std::size_t DataOutInterface::memory_consumption () const { return (sizeof (default_fmt) + diff --git a/deal.II/source/base/flow_function.cc b/deal.II/source/base/flow_function.cc index 12cf8a8209..3363d7140c 100644 --- a/deal.II/source/base/flow_function.cc +++ b/deal.II/source/base/flow_function.cc @@ -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 - unsigned int FlowFunction::memory_consumption () const + std::size_t + FlowFunction::memory_consumption () const { Assert(false, ExcNotImplemented()); return 0; diff --git a/deal.II/source/base/function.cc b/deal.II/source/base/function.cc index 3705d7545c..f302502718 100644 --- a/deal.II/source/base/function.cc +++ b/deal.II/source/base/function.cc @@ -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::vector_laplacian_list (const std::vector > &point template -unsigned int +std::size_t Function::memory_consumption () const { // only simple data elements, so @@ -423,7 +423,7 @@ void ConstantFunction::vector_value_list (const std::vector > &p template -unsigned int +std::size_t ConstantFunction::memory_consumption () const { // only simple data elements, so @@ -504,7 +504,7 @@ void ComponentSelectFunction::vector_value_list (const std::vector -unsigned int +std::size_t ComponentSelectFunction::memory_consumption () const { // only simple data elements, so diff --git a/deal.II/source/base/function_derivative.cc b/deal.II/source/base/function_derivative.cc index 0c9fe0ae84..ff2bd3f626 100644 --- a/deal.II/source/base/function_derivative.cc +++ b/deal.II/source/base/function_derivative.cc @@ -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::value_list (const std::vector > &points, template -unsigned int +std::size_t FunctionDerivative::memory_consumption () const { // only simple data elements, so diff --git a/deal.II/source/base/function_lib.cc b/deal.II/source/base/function_lib.cc index 6081795600..f8f3c7159d 100644 --- a/deal.II/source/base/function_lib.cc +++ b/deal.II/source/base/function_lib.cc @@ -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 - unsigned int + std::size_t JumpFunction::memory_consumption () const { // only simple data elements, so diff --git a/deal.II/source/base/index_set.cc b/deal.II/source/base/index_set.cc index 1278a2feac..41df9e9c57 100644 --- a/deal.II/source/base/index_set.cc +++ b/deal.II/source/base/index_set.cc @@ -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) + diff --git a/deal.II/source/base/logstream.cc b/deal.II/source/base/logstream.cc index b6c18fbfb2..dc71f4f6d6 100644 --- a/deal.II/source/base/logstream.cc +++ b/deal.II/source/base/logstream.cc @@ -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 tmp; + std::stack tmp = prefixes; while (tmp.empty() == false) { mem += MemoryConsumption::memory_consumption (tmp.top()); diff --git a/deal.II/source/base/memory_consumption.cc b/deal.II/source/base/memory_consumption.cc index 27afd9ae73..a49f697032 100644 --- a/deal.II/source/base/memory_consumption.cc +++ b/deal.II/source/base/memory_consumption.cc @@ -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 &v) + std::size_t + memory_consumption (const std::vector &v) { - unsigned int mem = sizeof(v); + std::size_t mem = sizeof(v); for (unsigned int i=0; i(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::~Quadrature () template -unsigned int +std::size_t Quadrature::memory_consumption () const { return (MemoryConsumption::memory_consumption (quadrature_points) + diff --git a/deal.II/source/distributed/tria.cc b/deal.II/source/distributed/tria.cc index d6a6f2ce13..c5963ef05c 100644 --- a/deal.II/source/distributed/tria.cc +++ b/deal.II/source/distributed/tria.cc @@ -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 unsigned int Triangulation:: - register_data_attach (const size_t size, + register_data_attach (const std::size_t size, const std_cxx1x::function & pack_callback) @@ -2813,10 +2813,10 @@ namespace parallel template - unsigned int + std::size_t Triangulation::memory_consumption () const { - unsigned int mem= + std::size_t mem= this->dealii::Triangulation::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 - unsigned int + std::size_t Triangulation::memory_consumption_p4est () const { return internal::p4est::functions::forest_memory_used(parallel_forest) diff --git a/deal.II/source/dofs/dof_faces.cc b/deal.II/source/dofs/dof_faces.cc index aae782c96b..b3ca8bd6cb 100644 --- a/deal.II/source/dofs/dof_faces.cc +++ b/deal.II/source/dofs/dof_faces.cc @@ -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) + diff --git a/deal.II/source/dofs/dof_handler.cc b/deal.II/source/dofs/dof_handler.cc index 615f877e15..75c38f2113 100644 --- a/deal.II/source/dofs/dof_handler.cc +++ b/deal.II/source/dofs/dof_handler.cc @@ -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::n_boundary_dofs (const std::set &bounda template -unsigned int +std::size_t DoFHandler::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::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 () + diff --git a/deal.II/source/dofs/dof_objects.cc b/deal.II/source/dofs/dof_objects.cc index 6a6cd0a734..0b1593c568 100644 --- a/deal.II/source/dofs/dof_objects.cc +++ b/deal.II/source/dofs/dof_objects.cc @@ -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 - unsigned int + std::size_t DoFObjects::memory_consumption () const { return (MemoryConsumption::memory_consumption (dofs)); diff --git a/deal.II/source/dofs/number_cache.cc b/deal.II/source/dofs/number_cache.cc index bff02e10d4..55330acdc9 100644 --- a/deal.II/source/dofs/number_cache.cc +++ b/deal.II/source/dofs/number_cache.cc @@ -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 diff --git a/deal.II/source/fe/fe.cc b/deal.II/source/fe/fe.cc index a89db5320a..56418afb14 100644 --- a/deal.II/source/fe/fe.cc +++ b/deal.II/source/fe/fe.cc @@ -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::interpolate( template -unsigned int +std::size_t FiniteElement::memory_consumption () const { return (sizeof(FiniteElementData) + diff --git a/deal.II/source/fe/fe_abf.cc b/deal.II/source/fe/fe_abf.cc index b3aadd6e0a..ed935493cd 100644 --- a/deal.II/source/fe/fe_abf.cc +++ b/deal.II/source/fe/fe_abf.cc @@ -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::interpolate( template -unsigned int +std::size_t FE_ABF::memory_consumption () const { Assert (false, ExcNotImplemented ()); diff --git a/deal.II/source/fe/fe_dgp.cc b/deal.II/source/fe/fe_dgp.cc index 802c3cd3c6..3e6fe2c836 100644 --- a/deal.II/source/fe/fe_dgp.cc +++ b/deal.II/source/fe/fe_dgp.cc @@ -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::has_support_on_face (const unsigned int, template -unsigned int +std::size_t FE_DGP::memory_consumption () const { Assert (false, ExcNotImplemented ()); diff --git a/deal.II/source/fe/fe_dgp_monomial.cc b/deal.II/source/fe/fe_dgp_monomial.cc index d7af3c4a8d..ad2f656cea 100644 --- a/deal.II/source/fe/fe_dgp_monomial.cc +++ b/deal.II/source/fe/fe_dgp_monomial.cc @@ -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 -unsigned int +std::size_t FE_DGPMonomial::memory_consumption () const { Assert (false, ExcNotImplemented ()); diff --git a/deal.II/source/fe/fe_dgp_nonparametric.cc b/deal.II/source/fe/fe_dgp_nonparametric.cc index 1c2a80173a..36fbeb0c26 100644 --- a/deal.II/source/fe/fe_dgp_nonparametric.cc +++ b/deal.II/source/fe/fe_dgp_nonparametric.cc @@ -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::has_support_on_face (const unsigned int, template -unsigned int +std::size_t FE_DGPNonparametric::memory_consumption () const { Assert (false, ExcNotImplemented ()); diff --git a/deal.II/source/fe/fe_dgq.cc b/deal.II/source/fe/fe_dgq.cc index 4a5c3192ef..3577c85c56 100644 --- a/deal.II/source/fe/fe_dgq.cc +++ b/deal.II/source/fe/fe_dgq.cc @@ -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::has_support_on_face (const unsigned int shape_index, template -unsigned int +std::size_t FE_DGQ::memory_consumption () const { Assert (false, ExcNotImplemented ()); diff --git a/deal.II/source/fe/fe_nedelec.cc b/deal.II/source/fe/fe_nedelec.cc index 323ead2db4..dc5bf1f1b5 100644 --- a/deal.II/source/fe/fe_nedelec.cc +++ b/deal.II/source/fe/fe_nedelec.cc @@ -5430,7 +5430,7 @@ const template -unsigned int +std::size_t FE_Nedelec::memory_consumption () const { Assert (false, ExcNotImplemented ()); diff --git a/deal.II/source/fe/fe_q.cc b/deal.II/source/fe/fe_q.cc index 8bdede7b51..59546964e0 100644 --- a/deal.II/source/fe/fe_q.cc +++ b/deal.II/source/fe/fe_q.cc @@ -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::has_support_on_face (const unsigned int shape_index, template -unsigned int +std::size_t FE_Q::memory_consumption () const { Assert (false, ExcNotImplemented ()); diff --git a/deal.II/source/fe/fe_q_hierarchical.cc b/deal.II/source/fe/fe_q_hierarchical.cc index 64cebd601b..6f6a888ac6 100644 --- a/deal.II/source/fe/fe_q_hierarchical.cc +++ b/deal.II/source/fe/fe_q_hierarchical.cc @@ -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::get_embedding_dofs (const unsigned int sub_degree) const template -unsigned int +std::size_t FE_Q_Hierarchical::memory_consumption () const { Assert (false, ExcNotImplemented ()); diff --git a/deal.II/source/fe/fe_raviart_thomas.cc b/deal.II/source/fe/fe_raviart_thomas.cc index 71162802a8..8f760f4cb4 100644 --- a/deal.II/source/fe/fe_raviart_thomas.cc +++ b/deal.II/source/fe/fe_raviart_thomas.cc @@ -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::interpolate( template -unsigned int +std::size_t FE_RaviartThomas::memory_consumption () const { Assert (false, ExcNotImplemented ()); diff --git a/deal.II/source/fe/fe_system.cc b/deal.II/source/fe/fe_system.cc index 098a75e02f..6a05213091 100644 --- a/deal.II/source/fe/fe_system.cc +++ b/deal.II/source/fe/fe_system.cc @@ -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::unit_face_support_point (const unsigned index) const template -unsigned int +std::size_t FESystem::memory_consumption () const { // neglect size of data stored in @@ -3373,8 +3373,8 @@ FESystem::memory_consumption () const // compiler. should be neglectable // after all, considering the size // of the data of the subelements - unsigned int mem = (FiniteElement::memory_consumption () + - sizeof (base_elements)); + std::size_t mem = (FiniteElement::memory_consumption () + + sizeof (base_elements)); for (unsigned int i=0; i::transform ( template -unsigned int +std::size_t FEValuesBase::memory_consumption () const { return (MemoryConsumption::memory_consumption (this->shape_values) + @@ -3525,7 +3525,7 @@ void FEValues::do_reinit () template -unsigned int +std::size_t FEValues::memory_consumption () const { return (FEValuesBase::memory_consumption () + @@ -3567,7 +3567,7 @@ FEFaceValuesBase::get_boundary_forms () const template -unsigned int +std::size_t FEFaceValuesBase::memory_consumption () const { return (FEValuesBase::memory_consumption () + diff --git a/deal.II/source/fe/mapping.cc b/deal.II/source/fe/mapping.cc index 97b1fba103..14b1b88b3a 100644 --- a/deal.II/source/fe/mapping.cc +++ b/deal.II/source/fe/mapping.cc @@ -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::InternalDataBase::~InternalDataBase () template -unsigned int +std::size_t Mapping::InternalDataBase::memory_consumption () const { return sizeof(*this); diff --git a/deal.II/source/fe/mapping_cartesian.cc b/deal.II/source/fe/mapping_cartesian.cc index 0a5c34bc68..f28c77af0a 100644 --- a/deal.II/source/fe/mapping_cartesian.cc +++ b/deal.II/source/fe/mapping_cartesian.cc @@ -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::InternalData::InternalData (const Quadrature -unsigned int +std::size_t MappingCartesian::InternalData::memory_consumption () const { return (Mapping::InternalDataBase::memory_consumption() + diff --git a/deal.II/source/fe/mapping_q.cc b/deal.II/source/fe/mapping_q.cc index e4e54d0288..a6a9dc75e8 100644 --- a/deal.II/source/fe/mapping_q.cc +++ b/deal.II/source/fe/mapping_q.cc @@ -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::InternalData::InternalData (const unsigned int n_shape_f template -unsigned int +std::size_t MappingQ::InternalData::memory_consumption () const { return (MappingQ1::InternalData::memory_consumption () + diff --git a/deal.II/source/fe/mapping_q1.cc b/deal.II/source/fe/mapping_q1.cc index 4f2d1af00b..d101aaa48a 100644 --- a/deal.II/source/fe/mapping_q1.cc +++ b/deal.II/source/fe/mapping_q1.cc @@ -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::InternalData::InternalData (const unsigned int n_shape_ template -unsigned int +std::size_t MappingQ1::InternalData::memory_consumption () const { return (Mapping::InternalDataBase::memory_consumption() + diff --git a/deal.II/source/grid/grid_out.cc b/deal.II/source/grid/grid_out.cc index e16e4fef8a..fc28bff523 100644 --- a/deal.II/source/grid/grid_out.cc +++ b/deal.II/source/grid/grid_out.cc @@ -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) + diff --git a/deal.II/source/grid/intergrid_map.cc b/deal.II/source/grid/intergrid_map.cc index 5bee2929b1..f5521ef33f 100644 --- a/deal.II/source/grid/intergrid_map.cc +++ b/deal.II/source/grid/intergrid_map.cc @@ -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::get_destination_grid () const template -unsigned int +std::size_t InterGridMap::memory_consumption () const { return (MemoryConsumption::memory_consumption (mapping) + diff --git a/deal.II/source/grid/persistent_tria.cc b/deal.II/source/grid/persistent_tria.cc index c9544f9131..987b844323 100644 --- a/deal.II/source/grid/persistent_tria.cc +++ b/deal.II/source/grid/persistent_tria.cc @@ -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::clear_flags() template -unsigned int +std::size_t PersistentTriangulation::memory_consumption () const { return (Triangulation::memory_consumption () + diff --git a/deal.II/source/grid/tria.cc b/deal.II/source/grid/tria.cc index 177f8aa2cc..c780ee03f4 100644 --- a/deal.II/source/grid/tria.cc +++ b/deal.II/source/grid/tria.cc @@ -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::read_bool_vector (const unsigned int magic_n template -unsigned int +std::size_t Triangulation::memory_consumption () const { - unsigned int mem = 0; + std::size_t mem = 0; mem += MemoryConsumption::memory_consumption(levels); for (unsigned int i=0; i::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) + diff --git a/deal.II/source/grid/tria_levels.cc b/deal.II/source/grid/tria_levels.cc index d110365599..79e1ce3efb 100644 --- a/deal.II/source/grid/tria_levels.cc +++ b/deal.II/source/grid/tria_levels.cc @@ -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 - unsigned int + std::size_t TriaLevel::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) + diff --git a/deal.II/source/grid/tria_objects.cc b/deal.II/source/grid/tria_objects.cc index a1301d281f..1aa1a50495 100644 --- a/deal.II/source/grid/tria_objects.cc +++ b/deal.II/source/grid/tria_objects.cc @@ -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 - unsigned int + std::size_t TriaObjects::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) + diff --git a/deal.II/source/hp/dof_faces.cc b/deal.II/source/hp/dof_faces.cc index 2b35e74d11..929195cc0b 100644 --- a/deal.II/source/hp/dof_faces.cc +++ b/deal.II/source/hp/dof_faces.cc @@ -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) + diff --git a/deal.II/source/hp/dof_handler.cc b/deal.II/source/hp/dof_handler.cc index 6136a59aef..5d2ff3c96a 100644 --- a/deal.II/source/hp/dof_handler.cc +++ b/deal.II/source/hp/dof_handler.cc @@ -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 - unsigned int + std::size_t DoFHandler::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::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); diff --git a/deal.II/source/hp/dof_objects.cc b/deal.II/source/hp/dof_objects.cc index 1f93a567bb..e40832981a 100644 --- a/deal.II/source/hp/dof_objects.cc +++ b/deal.II/source/hp/dof_objects.cc @@ -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 - unsigned int + std::size_t DoFObjects::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; } } diff --git a/deal.II/source/hp/fe_collection.cc b/deal.II/source/hp/fe_collection.cc index 3d79d64c2d..453c7062ea 100644 --- a/deal.II/source/hp/fe_collection.cc +++ b/deal.II/source/hp/fe_collection.cc @@ -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 - unsigned int + std::size_t FECollection::memory_consumption () const { - unsigned int mem + std::size_t mem = (sizeof(*this) + MemoryConsumption::memory_consumption (finite_elements)); for (unsigned int i=0; i - unsigned int + std::size_t MappingCollection::memory_consumption () const { return (sizeof(*this) + diff --git a/deal.II/source/lac/block_sparsity_pattern.cc b/deal.II/source/lac/block_sparsity_pattern.cc index 55eeb571a9..f7bf92adc9 100644 --- a/deal.II/source/lac/block_sparsity_pattern.cc +++ b/deal.II/source/lac/block_sparsity_pattern.cc @@ -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) + diff --git a/deal.II/source/lac/chunk_sparsity_pattern.cc b/deal.II/source/lac/chunk_sparsity_pattern.cc index e5e135391d..2ed16560d8 100644 --- a/deal.II/source/lac/chunk_sparsity_pattern.cc +++ b/deal.II/source/lac/chunk_sparsity_pattern.cc @@ -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) + diff --git a/deal.II/source/lac/compressed_simple_sparsity_pattern.cc b/deal.II/source/lac/compressed_simple_sparsity_pattern.cc index ede39e6b38..10d541c6ef 100644 --- a/deal.II/source/lac/compressed_simple_sparsity_pattern.cc +++ b/deal.II/source/lac/compressed_simple_sparsity_pattern.cc @@ -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::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(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) + diff --git a/deal.II/source/lac/petsc_matrix_base.cc b/deal.II/source/lac/petsc_matrix_base.cc index f26c818b18..0583b71bb9 100644 --- a/deal.II/source/lac/petsc_matrix_base.cc +++ b/deal.II/source/lac/petsc_matrix_base.cc @@ -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(info.memory); + return sizeof(*this) + static_cast(info.memory); } } diff --git a/deal.II/source/lac/petsc_vector_base.cc b/deal.II/source/lac/petsc_vector_base.cc index 68cc7b28ee..5b39a8318b 100644 --- a/deal.II/source/lac/petsc_vector_base.cc +++ b/deal.II/source/lac/petsc_vector_base.cc @@ -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 diff --git a/deal.II/source/lac/sparse_direct.cc b/deal.II/source/lac/sparse_direct.cc index 89f579355e..a1e9b2111a 100644 --- a/deal.II/source/lac/sparse_direct.cc +++ b/deal.II/source/lac/sparse_direct.cc @@ -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 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 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 &matrix, -unsigned int +std::size_t SparseDirectMA27::memory_consumption () const { return (sizeof(*this) + @@ -1346,7 +1346,7 @@ SparseDirectMA47::solve (const SparseMatrix &matrix, -unsigned int +std::size_t SparseDirectMA47::memory_consumption () const { return (sizeof(*this) + diff --git a/deal.II/source/lac/sparsity_pattern.cc b/deal.II/source/lac/sparsity_pattern.cc index 2756701c50..f5afbb4848 100644 --- a/deal.II/source/lac/sparsity_pattern.cc +++ b/deal.II/source/lac/sparsity_pattern.cc @@ -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(sizeof(unsigned int)) + + return (max_dim * sizeof(unsigned int) + sizeof(*this) + max_vec_len * sizeof(unsigned int)); } diff --git a/deal.II/source/lac/trilinos_precondition.cc b/deal.II/source/lac/trilinos_precondition.cc index 34190d979a..fdf798dac6 100644 --- a/deal.II/source/lac/trilinos_precondition.cc +++ b/deal.II/source/lac/trilinos_precondition.cc @@ -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); diff --git a/deal.II/source/lac/trilinos_sparse_matrix.cc b/deal.II/source/lac/trilinos_sparse_matrix.cc index d1856fd101..c4457d22a2 100644 --- a/deal.II/source/lac/trilinos_sparse_matrix.cc +++ b/deal.II/source/lac/trilinos_sparse_matrix.cc @@ -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) diff --git a/deal.II/source/lac/trilinos_vector_base.cc b/deal.II/source/lac/trilinos_vector_base.cc index da2469e31b..92826b6a8d 100644 --- a/deal.II/source/lac/trilinos_vector_base.cc +++ b/deal.II/source/lac/trilinos_vector_base.cc @@ -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 diff --git a/deal.II/source/lac/vector_memory.cc b/deal.II/source/lac/vector_memory.cc index c04554bc12..b963bcdf8c 100644 --- a/deal.II/source/lac/vector_memory.cc +++ b/deal.II/source/lac/vector_memory.cc @@ -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::release_unused_memory () template inline -unsigned int +std::size_t GrowingVectorMemory::memory_consumption () const { Threads::ThreadMutex::ScopedLock lock(mutex); - unsigned int result = sizeof (*this); + std::size_t result = sizeof (*this); const typename std::vector::const_iterator end = pool.data->end(); for (typename std::vector::const_iterator diff --git a/deal.II/source/multigrid/mg_dof_handler.cc b/deal.II/source/multigrid/mg_dof_handler.cc index d69d45da81..c2aeb25417 100644 --- a/deal.II/source/multigrid/mg_dof_handler.cc +++ b/deal.II/source/multigrid/mg_dof_handler.cc @@ -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::~MGDoFHandler () template -unsigned int +std::size_t MGDoFHandler::memory_consumption() const { - unsigned int mem = DoFHandler::memory_consumption(); + std::size_t mem = DoFHandler::memory_consumption(); for (unsigned int l=0;lmemory_consumption(); diff --git a/deal.II/source/multigrid/multigrid.cc b/deal.II/source/multigrid/multigrid.cc index ce06736b3c..16c7379141 100644 --- a/deal.II/source/multigrid/multigrid.cc +++ b/deal.II/source/multigrid/multigrid.cc @@ -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::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); diff --git a/deal.II/source/numerics/data_out.cc b/deal.II/source/numerics/data_out.cc index 90d85c1af2..9eef1653fa 100644 --- a/deal.II/source/numerics/data_out.cc +++ b/deal.II/source/numerics/data_out.cc @@ -286,7 +286,7 @@ get_function_hessians (const FEValuesBase &fe template template -unsigned int +std::size_t DataOut_DoFData:: DataEntry::memory_consumption () const { @@ -660,7 +660,7 @@ DataOut_DoFData::get_patches () const template -unsigned int +std::size_t DataOut_DoFData::memory_consumption () const { return (DataOutInterface::memory_consumption () + diff --git a/deal.II/source/numerics/data_out_stack.cc b/deal.II/source/numerics/data_out_stack.cc index 235c4841ab..624c774c32 100644 --- a/deal.II/source/numerics/data_out_stack.cc +++ b/deal.II/source/numerics/data_out_stack.cc @@ -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 -unsigned int +std::size_t DataOutStack::DataVector::memory_consumption () const { return (MemoryConsumption::memory_consumption (data) + @@ -430,7 +430,7 @@ void DataOutStack::finish_parameter_value () template -unsigned int +std::size_t DataOutStack::memory_consumption () const { return (DataOutInterface::memory_consumption () + diff --git a/deal.II/source/numerics/histogram.cc b/deal.II/source/numerics/histogram.cc index e0aab40a28..4655b9d64c 100644 --- a/deal.II/source/numerics/histogram.cc +++ b/deal.II/source/numerics/histogram.cc @@ -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) + diff --git a/deal.II/source/numerics/mesh_worker.cc b/deal.II/source/numerics/mesh_worker.cc index 233b7b7573..7c7f856847 100644 --- a/deal.II/source/numerics/mesh_worker.cc +++ b/deal.II/source/numerics/mesh_worker.cc @@ -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 - unsigned int + std::size_t LocalResults::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) diff --git a/deal.II/source/numerics/solution_transfer.cc b/deal.II/source/numerics/solution_transfer.cc index 0186b349e0..70ccfaeaf9 100644 --- a/deal.II/source/numerics/solution_transfer.cc +++ b/deal.II/source/numerics/solution_transfer.cc @@ -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::interpolate(const VECTOR &in, template -unsigned int +std::size_t SolutionTransfer::memory_consumption () const { // at the moment we do not include the memory @@ -433,7 +433,7 @@ SolutionTransfer::memory_consumption () const template -unsigned int +std::size_t SolutionTransfer::Pointerstruct::memory_consumption () const { return sizeof(*this); diff --git a/deal.II/source/numerics/time_dependent.cc b/deal.II/source/numerics/time_dependent.cc index baa908189e..206a24c55e 100644 --- a/deal.II/source/numerics/time_dependent.cc +++ b/deal.II/source/numerics/time_dependent.cc @@ -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::init_for_refinement () template -unsigned int +std::size_t TimeStepBase_Tria::memory_consumption () const { return (TimeStepBase::memory_consumption () + -- 2.39.5