<h3>General</h3>
<ol>
+<li> Changed: Most classes in deal.II have a member function
+<code>memory_consumption</code> that used to return an unsigned int.
+However, on most 64-bit systems, unsigned int is still only 32-bit
+wide, and consequently the return type does not provide enough
+precision to return the size of very large objects. The return types
+of all of these functions has been changed to std::size_t, which is
+defined to be a type that can hold the sizes of all objects possible
+on any system.
+<br>
+(Wolfgang Bangerth, 2011/01/22)
+
<li> Fixed: When using the <code>--enable-mpi</code> to
<code>./configure</code>, the script only tried <code>mpiCC</code>
as the MPI C++ compiler. However, on some systems, it is called
* quite close to the true
* value.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
/**
* Value to be used if this
* bytes) of this
* object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
};
/**
* quite close to the true
* value.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
};
/**
* quite close to the true
* value.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
};
/**
* quite close to the true
* value.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
};
* quite close to the true
* value.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
};
/**
* quite close to the true
* value.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
};
/**
* quite close to the true
* value.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
};
/**
* quite close to the true
* value.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
};
/**
* Flags controlling the details
* quite close to the true
* value.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
};
/**
* quite close to the true
* value.
*/
- static unsigned int memory_consumption ();
+ static std::size_t memory_consumption ();
/** @addtogroup Exceptions
* @{ */
* quite close to the true
* value.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
protected:
/**
virtual void vector_laplacian_list (const std::vector<Point<dim> > &points,
std::vector<Vector<double> > &values) const;
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
protected:
/**
* quite close to the true
* value.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
};
* quite close to the true
* value.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
protected:
/**
* quite close to the true
* value.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
protected:
/**
* quite close to the true
* value.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
/** @addtogroup Exceptions
* @{ */
* quite close to the true
* value.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
protected:
/**
// $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
* occupied by an object of this
* type.
*/
- static unsigned int memory_consumption ();
+ static std::size_t memory_consumption ();
/**
* Exception.
* occupied by an object of this
* type.
*/
- static unsigned int memory_consumption ();
+ static std::size_t memory_consumption ();
/**
* Exception.
template <int dim>
inline
-unsigned int
+std::size_t
RefinementCase<dim>::memory_consumption ()
{
return sizeof(RefinementCase<dim>);
* consumption (in bytes) of this
* object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
DeclException1 (ExcIndexNotPresent, int,
<< "The global index " << arg1
(range_1.begin == range_2.begin));
}
- unsigned int memory_consumption () const
+ std::size_t memory_consumption () const
{
return sizeof(Range);
}
* quite close to the true
* value.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
/**
* Exception.
// $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
#include <string>
#include <complex>
#include <vector>
-#include <utility>
+#include <cstddef>
DEAL_II_NAMESPACE_OPEN
*/
template <typename T>
inline
- unsigned int memory_consumption (const T &t);
+ std::size_t memory_consumption (const T &t);
/**
* Determine the amount of memory
* variable.
*/
inline
- unsigned int memory_consumption (const bool);
+ std::size_t memory_consumption (const bool);
/**
* Determine the amount of memory
* variable.
*/
inline
- unsigned int memory_consumption (const char);
+ std::size_t memory_consumption (const char);
/**
* Determine the amount of memory
* <tt>short int</tt> variable.
*/
inline
- unsigned int memory_consumption (const short int);
+ std::size_t memory_consumption (const short int);
/**
* Determine the amount of memory
* <tt>short unsigned int</tt> variable.
*/
inline
- unsigned int memory_consumption (const short unsigned int);
+ std::size_t memory_consumption (const short unsigned int);
/**
* Determine the amount of memory
* variable.
*/
inline
- unsigned int memory_consumption (const int);
+ std::size_t memory_consumption (const int);
/**
* Determine the amount of memory
* variable.
*/
inline
- unsigned int memory_consumption (const unsigned int);
+ std::size_t memory_consumption (const unsigned int);
/**
* Determine the amount of memory
* variable.
*/
inline
- unsigned int memory_consumption (const float);
+ std::size_t memory_consumption (const float);
/**
* Determine the amount of memory
* variable.
*/
inline
- unsigned int memory_consumption (const double);
+ std::size_t memory_consumption (const double);
/**
* Determine the amount of memory
* variable.
*/
inline
- unsigned int memory_consumption (const long double);
+ std::size_t memory_consumption (const long double);
/**
* Determine the amount of memory
*/
template <typename T>
inline
- unsigned int memory_consumption (const std::complex<T> &);
+ std::size_t memory_consumption (const std::complex<T> &);
/**
* Determine an estimate of the
* variable.
*/
inline
- unsigned int memory_consumption (const std::string &s);
+ std::size_t memory_consumption (const std::string &s);
/**
* Determine the amount of memory
*/
template <typename T>
inline
- unsigned int memory_consumption (const std::vector<T> &v);
+ std::size_t memory_consumption (const std::vector<T> &v);
/**
* Estimate the amount of memory
*/
template <typename T, int N>
inline
- unsigned int memory_consumption (const T (&v)[N]);
+ std::size_t memory_consumption (const T (&v)[N]);
/**
* Specialization of the
* field.
*/
inline
- unsigned int memory_consumption (const std::vector<bool> &v);
+ std::size_t memory_consumption (const std::vector<bool> &v);
/**
* Specialization of the
* for a vector of <tt>int</tt>s.
*/
inline
- unsigned int memory_consumption (const std::vector<int> &v);
+ std::size_t memory_consumption (const std::vector<int> &v);
/**
* Specialization of the
* for a vector of <tt>double</tt>s.
*/
inline
- unsigned int memory_consumption (const std::vector<double> &v);
+ std::size_t memory_consumption (const std::vector<double> &v);
/**
* Specialization of the
* for a vector of <tt>float</tt>s.
*/
inline
- unsigned int memory_consumption (const std::vector<float> &v);
+ std::size_t memory_consumption (const std::vector<float> &v);
/**
* Specialization of the
* for a vector of <tt>char</tt>s.
*/
inline
- unsigned int memory_consumption (const std::vector<char> &v);
+ std::size_t memory_consumption (const std::vector<char> &v);
/**
* Specialization of the
* for a vector of <tt>unsigned char</tt>s.
*/
inline
- unsigned int memory_consumption (const std::vector<unsigned char> &v);
+ std::size_t memory_consumption (const std::vector<unsigned char> &v);
/**
* Specialization of the
*/
template <typename T>
inline
- unsigned int memory_consumption (const std::vector<T *> &v);
+ std::size_t memory_consumption (const std::vector<T *> &v);
/**
* Specialization of the
* doesn't harm for other compilers
* as well.
*/
- unsigned int memory_consumption (const std::vector<std::string> &v);
+ std::size_t memory_consumption (const std::vector<std::string> &v);
/**
*/
template <typename A, typename B>
inline
- unsigned int memory_consumption (const std::pair<A,B> &p);
+ std::size_t memory_consumption (const std::pair<A,B> &p);
/**
* Return the amount of memory
*/
template <typename T>
inline
- unsigned int memory_consumption (const T * const);
+ std::size_t memory_consumption (const T * const);
/**
* Return the amount of memory
*/
template <typename T>
inline
- unsigned int memory_consumption (T * const);
+ std::size_t memory_consumption (T * const);
/**
* Return the amount of memory
* pointed to.
*/
inline
- unsigned int memory_consumption (void * const);
+ std::size_t memory_consumption (void * const);
/**
* Return the amount of memory used
*/
template <typename T>
inline
- unsigned int memory_consumption (const std_cxx1x::shared_ptr<T> &);
+ std::size_t memory_consumption (const std_cxx1x::shared_ptr<T> &);
}
namespace MemoryConsumption
{
inline
- unsigned int memory_consumption (const bool)
+ std::size_t memory_consumption (const bool)
{
return sizeof(bool);
}
inline
- unsigned int memory_consumption (const char)
+ std::size_t memory_consumption (const char)
{
return sizeof(char);
}
inline
- unsigned int memory_consumption (const short int)
+ std::size_t memory_consumption (const short int)
{
return sizeof(short int);
}
inline
- unsigned int memory_consumption (const short unsigned int)
+ std::size_t memory_consumption (const short unsigned int)
{
return sizeof(short unsigned int);
}
inline
- unsigned int memory_consumption (const int)
+ std::size_t memory_consumption (const int)
{
return sizeof(int);
}
inline
- unsigned int memory_consumption (const unsigned int)
+ std::size_t memory_consumption (const unsigned int)
{
return sizeof(unsigned int);
}
inline
- unsigned int memory_consumption (const float)
+ std::size_t memory_consumption (const float)
{
return sizeof(float);
}
inline
- unsigned int memory_consumption (const double)
+ std::size_t memory_consumption (const double)
{
return sizeof(double);
}
inline
- unsigned int memory_consumption (const long double)
+ std::size_t memory_consumption (const long double)
{
return sizeof(long double);
}
template <typename T>
inline
- unsigned int memory_consumption (const std::complex<T> &)
+ std::size_t memory_consumption (const std::complex<T> &)
{
return sizeof(std::complex<T>);
}
inline
- unsigned int memory_consumption (const std::string &s)
+ std::size_t memory_consumption (const std::string &s)
{
return sizeof(s) + s.length();
}
template <typename T>
- unsigned int memory_consumption (const std::vector<T> &v)
+ std::size_t memory_consumption (const std::vector<T> &v)
{
unsigned int mem = sizeof(std::vector<T>);
const unsigned int n = v.size();
template <typename T, int N>
- unsigned int memory_consumption (const T (&v)[N])
+ std::size_t memory_consumption (const T (&v)[N])
{
unsigned int mem = 0;
for (unsigned int i=0; i<N; ++i)
inline
- unsigned int memory_consumption (const std::vector<bool> &v)
+ std::size_t memory_consumption (const std::vector<bool> &v)
{
return v.capacity() / 8 + sizeof(v);
}
inline
- unsigned int memory_consumption (const std::vector<int> &v)
+ std::size_t memory_consumption (const std::vector<int> &v)
{
return (v.capacity() * sizeof(int) +
sizeof(v));
inline
- unsigned int memory_consumption (const std::vector<double> &v)
+ std::size_t memory_consumption (const std::vector<double> &v)
{
return (v.capacity() * sizeof(double) +
sizeof(v));
inline
- unsigned int memory_consumption (const std::vector<float> &v)
+ std::size_t memory_consumption (const std::vector<float> &v)
{
return (v.capacity() * sizeof(float) +
sizeof(v));
inline
- unsigned int memory_consumption (const std::vector<char> &v)
+ std::size_t memory_consumption (const std::vector<char> &v)
{
return (v.capacity() * sizeof(char) +
sizeof(v));
inline
- unsigned int memory_consumption (const std::vector<unsigned char> &v)
+ std::size_t memory_consumption (const std::vector<unsigned char> &v)
{
return (v.capacity() * sizeof(unsigned char) +
sizeof(v));
template <typename T>
inline
- unsigned int memory_consumption (const std::vector<T *> &v)
+ std::size_t memory_consumption (const std::vector<T *> &v)
{
return (v.capacity() * sizeof(T *) +
sizeof(v));
template <typename A, typename B>
inline
- unsigned int memory_consumption (const std::pair<A,B> &p)
+ std::size_t memory_consumption (const std::pair<A,B> &p)
{
return (memory_consumption(p.first) +
memory_consumption(p.second));
template <typename T>
inline
- unsigned int
+ std::size_t
memory_consumption (const T * const)
{
return sizeof(T*);
template <typename T>
inline
- unsigned int
+ std::size_t
memory_consumption (T * const)
{
return sizeof(T*);
inline
- unsigned int
+ std::size_t
memory_consumption (void * const)
{
return sizeof(void*);
template <typename T>
inline
- unsigned int
+ std::size_t
memory_consumption (const std_cxx1x::shared_ptr<T> &)
{
return sizeof(std_cxx1x::shared_ptr<T>);
template <typename T>
inline
- unsigned int
+ std::size_t
memory_consumption (const T &t)
{
return t.memory_consumption();
// $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
/**
* Memory used by this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
private:
/**
template<class Object>
-unsigned int
+std::size_t
MGLevelObject<Object>::memory_consumption () const
{
- unsigned int result = sizeof(*this);
+ std::size_t result = sizeof(*this);
typedef typename std::vector<std_cxx1x::shared_ptr<Object> >::const_iterator Iter;
const Iter end = objects.end();
for (Iter o=objects.begin(); o!=end; ++o)
* quite close to the true
* value.
*/
- static unsigned int memory_consumption ();
+ static std::size_t memory_consumption ();
/**
* Exception
* you can still overload
* this function.
*/
- virtual unsigned int memory_consumption () const;
+ virtual std::size_t memory_consumption () const;
};
/**
* 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
* the memory consumption (in
* bytes) of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
/** @addtogroup Exceptions
* @{ */
* the memory consumption (in
* bytes) of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
/** @addtogroup Exceptions
* @{ */
* bytes) of this
* object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
/**
* Write the data of this object to
* bytes) of this
* object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
private:
* bytes) of this
* object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
};
/**
* 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
//---------------------------------------------------------------------------
// $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
* used by <b>this</b> object, not
* by the object pointed to.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
private:
/**
template <typename T, typename P>
inline
-unsigned int SmartPointer<T,P>::memory_consumption () const
+std::size_t
+SmartPointer<T,P>::memory_consumption () const
{
return sizeof(SmartPointer<T,P>);
}
// $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
* 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
template <int rank, int dim>
inline
-unsigned int
+std::size_t
SymmetricTensor<rank,dim>::memory_consumption ()
{
return
// $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
* 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
template <int N, typename T>
inline
-unsigned int
+std::size_t
TableBase<N,T>::memory_consumption () const
{
return sizeof(*this) + MemoryConsumption::memory_consumption(values);
* memory consumption (in bytes)
* of this object.
*/
- static unsigned int memory_consumption ();
+ static std::size_t memory_consumption ();
/**
* Exception.
template <int rank_, int dim>
inline
-unsigned int
+std::size_t
Tensor<rank_,dim>::memory_consumption ()
{
return sizeof(Tensor<rank_,dim>);
// $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
* bytes) of this
* object.
*/
- static unsigned int memory_consumption ();
+ static std::size_t memory_consumption ();
/**
* Only tensors with a positive
template <int dim>
inline
-unsigned int
+std::size_t
Tensor<1,dim>::memory_consumption ()
{
return sizeof(Tensor<1,dim>);
// $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
* Return the local memory
* consumption in bytes.
*/
- virtual unsigned int memory_consumption () const;
+ virtual std::size_t memory_consumption () const;
/**
* Return the local memory
* 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
* notify_ready_to_unpack().
*/
unsigned int
- register_data_attach (const size_t size,
+ register_data_attach (const std::size_t size,
const std_cxx1x::function<void (const cell_iterator &,
const CellStatus,
void*)> & pack_callback);
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
private:
/**
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));
}
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
};
/**
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
};
/**
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
};
}
* 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.
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
};
/**
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
};
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
};
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
};
}
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
/**
* Make the DoFHandler and
* memory consumption (in bytes) of
* this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
/**
* Total number of dofs,
* pointers to their base class,
* rather than the class itself.
*/
- virtual unsigned int memory_consumption () const;
+ virtual std::size_t memory_consumption () const;
/**
* Exception
*
virtual void interpolate(
std::vector<double>& local_dofs,
const VectorSlice<const std::vector<std::vector<double> > >& values) const;
- virtual unsigned int memory_consumption () const;
+ virtual std::size_t memory_consumption () const;
virtual FiniteElement<dim> * clone() const;
private:
virtual void interpolate(
std::vector<double>& local_dofs,
const VectorSlice<const std::vector<std::vector<double> > >& values) const;
- virtual unsigned int memory_consumption () const;
+ virtual std::size_t memory_consumption () const;
private:
/**
//---------------------------------------------------------------------------
// $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
template <class POLY, int dim, int spacedim>
-unsigned int
+std::size_t
FE_DGVector<POLY,dim,spacedim>::memory_consumption() const
{
Assert(false, ExcNotImplemented());
* pointers to their base class,
* rather than the class itself.
*/
- virtual unsigned int memory_consumption () const;
+ virtual std::size_t memory_consumption () const;
/**
* pointers to their base class,
* rather than the class itself.
*/
- virtual unsigned int memory_consumption () const;
+ virtual std::size_t memory_consumption () const;
protected:
* pointers to their base class,
* rather than the class itself.
*/
- virtual unsigned int memory_consumption () const;
+ virtual std::size_t memory_consumption () const;
private:
* pointers to their base class,
* rather than the class itself.
*/
- virtual unsigned int memory_consumption () const;
+ virtual std::size_t memory_consumption () const;
protected:
virtual void interpolate (std::vector<double>& local_dofs,
const VectorSlice<const std::vector<std::vector<double> > >& values)
const;
- virtual unsigned int memory_consumption () const;
+ virtual std::size_t memory_consumption () const;
virtual FiniteElement<dim> * clone() const;
private:
* pointers to their base class,
* rather than the class itself.
*/
- virtual unsigned int memory_consumption () const;
+ virtual std::size_t memory_consumption () const;
protected:
/**
* 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
virtual void interpolate(
std::vector<double>& local_dofs,
const VectorSlice<const std::vector<std::vector<double> > >& values) const;
- virtual unsigned int memory_consumption () const;
+ virtual std::size_t memory_consumption () const;
virtual FiniteElement<dim> * clone() const;
private:
* pointers to their base class,
* rather than the class itself.
*/
- virtual unsigned int memory_consumption () const;
+ virtual std::size_t memory_consumption () const;
protected:
/**
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
//@}
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
/**
* Return a reference to this
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
protected:
* consumption of this
* object.
*/
- virtual unsigned int memory_consumption () const;
+ virtual std::size_t memory_consumption () const;
/**
* The determinant of the
* consumption of this
* object.
*/
- virtual unsigned int memory_consumption () const;
+ virtual std::size_t memory_consumption () const;
/**
* Length of the cell in
* consumption of this
* object.
*/
- virtual unsigned int memory_consumption () const;
+ virtual std::size_t memory_consumption () const;
/**
* Unit normal vectors. Used
* consumption of this
* object.
*/
- virtual unsigned int memory_consumption () const;
+ virtual std::size_t memory_consumption () const;
/**
* Values of shape
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
/**
* Exception
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
/**
* Exception
* memory consumption (in bytes)
* of this object.
*/
- virtual unsigned int memory_consumption () const;
+ virtual std::size_t memory_consumption () const;
/**
* Exception.
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
};
* 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
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
};
}
}
* even if the actual object is a
* derived class.
*/
- virtual unsigned int memory_consumption () const;
+ virtual std::size_t memory_consumption () const;
/**
* of this object.
* Of course this returns 0.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
};
/**
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
};
/**
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
};
}
}
// $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
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
/**@name Exceptions*/
template <typename Accessor>
inline
-unsigned int
+std::size_t
TriaRawIterator<Accessor>::memory_consumption () const
{
return sizeof(TriaRawIterator<Accessor>);
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
/**
* Exception
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
// $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
* memory consumption (in bytes)
* of this object.
*/
- static unsigned int memory_consumption ();
+ static std::size_t memory_consumption ();
protected:
/**
template <int structdim>
inline
- unsigned int
+ std::size_t
TriaObject<structdim>::memory_consumption ()
{
return sizeof(TriaObject<structdim>);
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
/**
* Exception
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
};
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
};
//----------------------------------------------------------------------//
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
};
/**
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
};
/**
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
};
} // 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
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
};
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
};
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
};
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
};
} // namespace hp
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
};
* Return an estimate for the memory
* allocated for this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
/**
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
private:
/**
// $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
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
/**
* Exception
template <int dim>
inline
- unsigned int
+ std::size_t
QCollection<dim>::memory_consumption () const
{
return (sizeof(*this) +
// $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
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
private:
/**
inline
-unsigned int
+std::size_t
BlockIndices::memory_consumption () const
{
return (sizeof(*this) +
// $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
typedef const value_type *const_pointer;
typedef value_type &reference;
typedef const value_type &const_reference;
- typedef size_t size_type;
+ typedef std::size_t size_type;
typedef
MatrixIterator<BlockMatrixIterators::Accessor<BlockMatrixBase, false> >
* returned in case this is called in
* an MPI-based program.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
/** @addtogroup Exceptions
* @{ */
template <class MatrixType>
-unsigned int
+std::size_t
BlockMatrixBase<MatrixType>::memory_consumption () const
{
- unsigned int mem =
+ std::size_t mem =
MemoryConsumption::memory_consumption(row_block_indices)+
MemoryConsumption::memory_consumption(column_block_indices)+
MemoryConsumption::memory_consumption(sub_objects)+
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
/** @addtogroup Exceptions
* @{ */
// $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
template <typename number>
-unsigned int
+std::size_t
BlockSparseMatrix<number>::memory_consumption () const
{
- unsigned int mem = sizeof(*this);
+ std::size_t mem = sizeof(*this);
mem += MemoryConsumption::memory_consumption (this->sub_objects);
for (unsigned int r=0; r<this->n_block_rows(); ++r)
for (unsigned int c=0; c<this->n_block_cols(); ++c)
// $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
// template <typename number>
-// unsigned int
+// std::size_t
// BlockSparseMatrixEZ<number>::memory_consumption () const
// {
-// unsigned int mem = sizeof(*this);
+// std::size_t mem = sizeof(*this);
// mem += MemoryConsumption::memory_consumption (sub_objects);
// for (unsigned int r=0; r<rows; ++r)
// for (unsigned int c=0; c<columns; ++c)
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
/**
* Copy data from an object of
// $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
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
protected:
/**
template <class VectorType>
-unsigned int BlockVectorBase<VectorType>::memory_consumption () const
+std::size_t
+BlockVectorBase<VectorType>::memory_consumption () const
{
- unsigned int mem = sizeof(this->n_blocks());
+ std::size_t mem = sizeof(this->n_blocks());
for (unsigned int i=0; i<this->components.size(); ++i)
mem += MemoryConsumption::memory_consumption (this->components[i]);
mem += MemoryConsumption::memory_consumption (this->block_indices);
* of this object. See
* MemoryConsumption.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
//@}
/**
// $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
template <typename number>
-unsigned int
+std::size_t
ChunkSparseMatrix<number>::memory_consumption () const
{
return sizeof(*this) + max_len*sizeof(number);
* of this object. See
* MemoryConsumption.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
/** @addtogroup Exceptions
* @{ */
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
private:
/**
/**
* estimates memory consumption.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
};
* consumption (in bytes) of this
* object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
/**
* @}
* memory consumption (in bytes) of
* this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
};
/**
* referenced, its memory
* consumption is not included.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
private:
/**
template <class VECTOR>
inline
-unsigned int
+std::size_t
FilteredMatrix<VECTOR>::memory_consumption () const
{
- return (MemoryConsumption::memory_consumption (matrix) +
- MemoryConsumption::memory_consumption (constraints));
+ return (MemoryConsumption::memory_consumption (matrix) +
+ MemoryConsumption::memory_consumption (constraints));
}
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
//@}
///@name Iterator functions
// $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
template <typename number>
-unsigned int
+std::size_t
FullMatrix<number>::memory_consumption () const
{
- return sizeof(*this) - sizeof (Table<2,number>)
- + Table<2,number>::memory_consumption();
+ return (sizeof(*this) - sizeof (Table<2,number>)
+ +
+ Table<2,number>::memory_consumption());
}
// $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
/**
* The memory used by this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
/**
* The block number computed from
/**
* The memory used by this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
/**
* Access a constant reference to
/**
* The memory used by this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
private:
/// Clear one of the matrix objects
void clear_object(NamedData<MGLevelObject<MatrixBlock<MATRIX> > >&);
template <class MATRIX>
inline
-unsigned int
+std::size_t
MatrixBlock<MATRIX>::memory_consumption () const
{
- unsigned int mem = sizeof(*this)
- + MemoryConsumption::memory_consumption(matrix)
- - sizeof(matrix);
- return mem;
+ return (sizeof(*this)
+ + MemoryConsumption::memory_consumption(matrix)
+ - sizeof(matrix));
}
//----------------------------------------------------------------------//
* Returns the number bytes consumed
* by this matrix on this CPU.
*/
- unsigned int memory_consumption() const;
+ std::size_t memory_consumption() const;
/**
* Exception
// $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
*/
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;
* consumption (not implemented
* for this class).
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
protected:
/**
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
/** @addtogroup Exceptions
* @{ */
// $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
template <class MATRIX, typename inverse_type>
-unsigned int
+std::size_t
PreconditionBlock<MATRIX,inverse_type>::memory_consumption () const
{
- unsigned int mem = sizeof(*this) - sizeof(PreconditionBlockBase<inverse_type>);
- mem += PreconditionBlockBase<inverse_type>::memory_consumption();
- return mem;
+ return (sizeof(*this)
+ - sizeof(PreconditionBlockBase<inverse_type>)
+ + PreconditionBlockBase<inverse_type>::memory_consumption());
}
// $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
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
/**
* You are trying to access a
template <typename number>
inline
-unsigned int
+std::size_t
PreconditionBlockBase<number>::memory_consumption () const
{
- unsigned int mem = sizeof(*this);
+ std::size_t mem = sizeof(*this);
for (unsigned int i=0; i<var_inverse_full.size(); ++i)
mem += MemoryConsumption::memory_consumption(var_inverse_full[i]);
for (unsigned int i=0; i<var_diagonal.size(); ++i)
* memory consumption (in bytes)
* of this object.
*/
- virtual unsigned int memory_consumption () const;
+ virtual std::size_t memory_consumption () const;
/** @addtogroup Exceptions
* @{ */
//---------------------------------------------------------------------------
-// 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
template <typename number>
-unsigned int
+std::size_t
SparseLUDecomposition<number>::memory_consumption () const
{
- unsigned int
- res = (SparseMatrix<number>::memory_consumption () +
- MemoryConsumption::memory_consumption(prebuilt_lower_bound));
- return res;
+ return (SparseMatrix<number>::memory_consumption () +
+ MemoryConsumption::memory_consumption(prebuilt_lower_bound));
}
* 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
* 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
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
/** @addtogroup Exceptions
* @{ */
//---------------------------------------------------------------------------
-// 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
template <typename number>
-unsigned int
+std::size_t
SparseILU<number>::memory_consumption () const
{
return SparseLUDecomposition<number>::memory_consumption ();
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
/**
* Print statistics. If @p full
// $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
template <typename number>
-unsigned int
+std::size_t
SparseMatrixEZ<number>::memory_consumption() const
{
return
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
/** @addtogroup Exceptions
* @{ */
//---------------------------------------------------------------------------
-// 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
template <typename number>
-unsigned int
+std::size_t
SparseMIC<number>::memory_consumption () const
{
return (SparseLUDecomposition<number>::memory_consumption () +
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
private:
/**
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
private:
/**
// $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
template <typename number>
-unsigned int
+std::size_t
SparseVanka<number>::memory_consumption () const
{
- unsigned int mem = (sizeof(*this) +
- MemoryConsumption::memory_consumption (selected));
+ std::size_t mem = (sizeof(*this) +
+ MemoryConsumption::memory_consumption (selected));
for (unsigned int i=0; i<inverses.size(); ++i)
mem += MemoryConsumption::memory_consumption (*inverses[i]);
template <typename number>
-unsigned int
+std::size_t
SparseBlockVanka<number>::memory_consumption () const
{
- unsigned int mem = SparseVanka<number>::memory_consumption();
+ std::size_t mem = SparseVanka<number>::memory_consumption();
for (unsigned int i=0; i<dof_masks.size(); ++i)
mem += MemoryConsumption::memory_consumption (dof_masks[i]);
return mem;
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
/** @addtogroup Exceptions
* @{ */
// $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
template <typename number>
-unsigned int
+std::size_t
SwappableVector<number>::memory_consumption () const
{
return (MemoryConsumption::memory_consumption (filename) +
// $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
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
-//@}
+ std::size_t memory_consumption () const;
+ //@}
private:
/**
* Prints an estimate of the memory
* consumption of this class.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
private:
/**
* returned in case this is called in
* an MPI-based program.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
//@}
/**
* of this object. Currently not
* implemented for this class.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
//@}
/**
// $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
*/
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;
* Estimate for the memory
* consumption in bytes.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
//@}
/**
// $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
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
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
//@}
/**
// $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
template <typename Number>
-unsigned int
+std::size_t
Vector<Number>::memory_consumption () const
{
return sizeof(*this) + (max_vec_size * sizeof(Number));
* and all currently allocated
* vectors.
*/
- virtual unsigned int memory_consumption() const;
+ virtual std::size_t memory_consumption() const;
private:
/**
* although the actual object
* might be a derived class.
*/
- virtual unsigned int memory_consumption () const;
+ virtual std::size_t memory_consumption () const;
/**
// $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
/**
* Memory used by this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
private:
MGLevelObject<std_cxx1x::shared_ptr<PointerMatrixBase<VECTOR> > > matrices;
};
/**
* Memory used by this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
private:
template <class VECTOR>
inline
- unsigned int
+ std::size_t
Matrix<VECTOR>::memory_consumption () const
{
return sizeof(*this) + matrices->memory_consumption();
template <class MATRIX, class VECTOR>
-unsigned int
+std::size_t
MGMatrix<MATRIX, VECTOR>::memory_consumption () const
{
return sizeof(*this) + matrix->memory_consumption();
// $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
/**
* Memory used by this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
+
private:
/**
* Object containing relaxation
/**
* Memory used by this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
private:
/**
* Memory used by this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
private:
template <class RELAX, class VECTOR>
- inline unsigned int
+ inline
+ std::size_t
SmootherRelaxation<RELAX, VECTOR>::
memory_consumption () const
{
template <class MATRIX, class RELAX, class VECTOR>
-inline unsigned int
+inline
+std::size_t
MGSmootherRelaxation<MATRIX, RELAX, VECTOR>::
memory_consumption () const
{
template <class MATRIX, class PRECONDITIONER, class VECTOR>
-inline unsigned int
+inline
+std::size_t
MGSmootherPrecondition<MATRIX, PRECONDITIONER, VECTOR>::
memory_consumption () const
{
/**
* Memory used by this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
private:
// $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
}
template <class VECTOR>
-unsigned int
+std::size_t
MGTransferPrebuilt<VECTOR>::memory_consumption () const
{
- unsigned int result = sizeof(*this);
+ std::size_t result = sizeof(*this);
result += sizeof(unsigned int) * sizes.size();
#ifdef DEAL_PREFER_MATRIX_EZ
std::vector<std_cxx1x::shared_ptr<SparseMatrixEZ<double> > >::const_iterator m;
// $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
/**
* Memory used by this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
protected:
/**
BlockVector<number2>& dst,
const MGLevelObject<BlockVector<number> > &src) const;
- MGTransferBlockBase::memory_consumption;
+ using MGTransferBlockBase::memory_consumption;
private:
/**
/**
* Memory used by this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
private:
/**
// 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
template <typename number>
-unsigned int
+std::size_t
MGTransferBlockSelect<number>::memory_consumption () const
{
return sizeof(int) + MGTransferBlockBase::memory_consumption();
/**
* Memory used by this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
protected:
/**
* Memory used by this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
private:
/**
// 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
template <typename number>
-unsigned int
+std::size_t
MGTransferSelect<number>::memory_consumption () const
{
return sizeof(int) + MGTransferComponentBase::memory_consumption();
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
/**
* Exception
* 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
* the memory consumption (in
* bytes) of this object.
*/
- virtual unsigned int memory_consumption () const;
+ virtual std::size_t memory_consumption () const;
private:
/**
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
/**
* Exception
* the memory consumption (in
* bytes) of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
};
/**
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
/**
* Exception.
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
/**
* Left bound of the interval.
/**
* The memory used by this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
private:
/**
/**
* The memory used by this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
/**
/**
* The memory used by this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
private:
/**
/**
* The memory used by this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
/**
* The set of update flags
// $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
template<int dim, int sdim>
- unsigned int
+ std::size_t
IntegrationInfo<dim,sdim>::memory_consumption () const
{
- unsigned int mem = sizeof(*this)
- + MemoryConsumption::memory_consumption(fevalv)
- - sizeof (fevalv)
- ;
+ std::size_t mem = sizeof(*this)
+ + MemoryConsumption::memory_consumption(fevalv)
+ - sizeof (fevalv);
for (unsigned int i=0;i<fevalv.size();++i)
mem += fevalv[i]->memory_consumption();
return mem;
template<int dim, int sdim>
- unsigned int
+ std::size_t
IntegrationInfoBox<dim,sdim>::memory_consumption () const
{
- unsigned int mem = sizeof(*this)
- + MemoryConsumption::memory_consumption(cell_quadrature)
- - sizeof (cell_quadrature)
- + MemoryConsumption::memory_consumption(boundary_quadrature)
- - sizeof (boundary_quadrature)
- + MemoryConsumption::memory_consumption(face_quadrature)
- - sizeof (face_quadrature)
- + MemoryConsumption::memory_consumption(cell_selector)
- -sizeof (cell_selector)
- + MemoryConsumption::memory_consumption(boundary_selector)
- -sizeof (boundary_selector)
- + MemoryConsumption::memory_consumption(face_selector)
- -sizeof (face_selector)
- + MemoryConsumption::memory_consumption(cell)
- - sizeof(cell)
- + MemoryConsumption::memory_consumption(boundary)
- - sizeof(boundary)
- + MemoryConsumption::memory_consumption(face)
- - sizeof(face)
- + MemoryConsumption::memory_consumption(subface)
- - sizeof(subface)
- + MemoryConsumption::memory_consumption(neighbor)
- - sizeof(neighbor)
- ;
+ std::size_t mem = sizeof(*this)
+ + MemoryConsumption::memory_consumption(cell_quadrature)
+ - sizeof (cell_quadrature)
+ + MemoryConsumption::memory_consumption(boundary_quadrature)
+ - sizeof (boundary_quadrature)
+ + MemoryConsumption::memory_consumption(face_quadrature)
+ - sizeof (face_quadrature)
+ + MemoryConsumption::memory_consumption(cell_selector)
+ -sizeof (cell_selector)
+ + MemoryConsumption::memory_consumption(boundary_selector)
+ -sizeof (boundary_selector)
+ + MemoryConsumption::memory_consumption(face_selector)
+ -sizeof (face_selector)
+ + MemoryConsumption::memory_consumption(cell)
+ - sizeof(cell)
+ + MemoryConsumption::memory_consumption(boundary)
+ - sizeof(boundary)
+ + MemoryConsumption::memory_consumption(face)
+ - sizeof(face)
+ + MemoryConsumption::memory_consumption(subface)
+ - sizeof(subface)
+ + MemoryConsumption::memory_consumption(neighbor)
+ - sizeof(neighbor);
// if (cell_data != 0)
// mem += MemoryConsumption::memory_consumption(*cell_data);
// if (boundary_data != 0)
// $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
/**
* The memory used by this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
protected:
/**
/**
* The memory used by this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
};
/**
* The memory used by this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
private:
NamedData<SmartPointer<const VECTOR,VectorData<VECTOR,dim,spacedim> > > data;
/**
* The memory used by this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
private:
NamedData<SmartPointer<const MGLevelObject<VECTOR>,MGVectorData<VECTOR,dim,spacedim> > > data;
}
- inline unsigned int
+ inline
+ std::size_t
VectorSelector::memory_consumption () const
{
- unsigned int mem = sizeof(*this);
- return mem;
- }
-
+ return sizeof(*this);
+ }
}
// $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
template <class VECTOR, int dim, int spacedim>
- unsigned int
+ std::size_t
VectorData<VECTOR, dim, spacedim>::memory_consumption () const
{
- unsigned int mem = VectorSelector::memory_consumption();
+ std::size_t mem = VectorSelector::memory_consumption();
mem += sizeof (data);
return mem;
}
template <class VECTOR, int dim, int spacedim>
- unsigned int
+ std::size_t
MGVectorData<VECTOR, dim, spacedim>::memory_consumption () const
{
- unsigned int mem = VectorSelector::memory_consumption();
+ std::size_t mem = VectorSelector::memory_consumption();
mem += sizeof (data);
return mem;
}
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
/**
* Exception
*/
struct Pointerstruct {
Pointerstruct();
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
std::vector<unsigned int> *indices_ptr;
std::vector<Vector<typename VECTOR::value_type> > *dof_values_ptr;
* memory consumption (in bytes)
* of this object.
*/
- unsigned int memory_consumption () const;
+ std::size_t memory_consumption () const;
/**
* Exception.
* result of this function to
* your result.
*/
- virtual unsigned int memory_consumption () const;
+ virtual std::size_t memory_consumption () const;
/**
* Exception
* result of this function to
* your result.
*/
- virtual unsigned int memory_consumption () const;
+ virtual std::size_t memory_consumption () const;
/**
* Exception
// $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
template <int dim, int spacedim>
-unsigned int
+std::size_t
DataOutBase::Patch<dim,spacedim>::memory_consumption () const
{
return (sizeof(vertices) / sizeof(vertices[0]) *
-unsigned int
+std::size_t
DataOutBase::DXFlags::memory_consumption () const
{
// only simple data elements, so
}
-unsigned int
+std::size_t
DataOutBase::UcdFlags::memory_consumption () const
{
// only simple data elements, so
-unsigned int
+size_t
DataOutBase::GnuplotFlags::memory_consumption () const
{
// only simple data elements, so
-unsigned int
+std::size_t
DataOutBase::PovrayFlags::memory_consumption () const
{
// only simple data elements, so
-unsigned int
+std::size_t
DataOutBase::EpsFlags::memory_consumption () const
{
// only simple data elements, so
{}
-unsigned int
+std::size_t
DataOutBase::GmvFlags::memory_consumption () const
{
// only simple data elements, so
{}
-unsigned int
+std::size_t
DataOutBase::TecplotFlags::memory_consumption () const
{
// only simple data elements, so
-unsigned int
+std::size_t
DataOutBase::VtkFlags::memory_consumption () const
{
// only simple data elements, so
{}
-unsigned int
+std::size_t
DataOutBase::Deal_II_IntermediateFlags::memory_consumption () const
{
// only simple data elements, so
-unsigned int DataOutBase::memory_consumption ()
+std::size_t
+DataOutBase::memory_consumption ()
{
return 0;
}
template <int dim, int spacedim>
-unsigned int
+std::size_t
DataOutInterface<dim,spacedim>::memory_consumption () const
{
return (sizeof (default_fmt) +
// $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
template<int dim>
- unsigned int FlowFunction<dim>::memory_consumption () const
+ std::size_t
+ FlowFunction<dim>::memory_consumption () const
{
Assert(false, ExcNotImplemented());
return 0;
// $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
template <int dim>
-unsigned int
+std::size_t
Function<dim>::memory_consumption () const
{
// only simple data elements, so
template <int dim>
-unsigned int
+std::size_t
ConstantFunction<dim>::memory_consumption () const
{
// only simple data elements, so
template <int dim>
-unsigned int
+std::size_t
ComponentSelectFunction<dim>::memory_consumption () const
{
// only simple data elements, so
// $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
template <int dim>
-unsigned int
+std::size_t
FunctionDerivative<dim>::memory_consumption () const
{
// only simple data elements, so
//---------------------------------------------------------------------------
// $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
template <int dim>
- unsigned int
+ std::size_t
JumpFunction<dim>::memory_consumption () const
{
// only simple data elements, so
// $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
#endif
-unsigned int
+std::size_t
IndexSet::memory_consumption () const
{
return MemoryConsumption::memory_consumption (ranges) +
// $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
}
-unsigned int
+std::size_t
LogStream::memory_consumption () const
{
- unsigned int mem = sizeof(*this);
+ std::size_t mem = sizeof(*this);
// to determine size of stack
// elements, we have to copy the
// stack since we can't access
// elements from further below
- std::stack<std::string> tmp;
+ std::stack<std::string> tmp = prefixes;
while (tmp.empty() == false)
{
mem += MemoryConsumption::memory_consumption (tmp.top());
// $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
namespace MemoryConsumption
{
- unsigned int memory_consumption (const std::vector<std::string> &v)
+ std::size_t
+ memory_consumption (const std::vector<std::string> &v)
{
- unsigned int mem = sizeof(v);
+ std::size_t mem = sizeof(v);
for (unsigned int i=0; i<v.size(); ++i)
mem += memory_consumption(v[i]);
return mem;
// $Id$
// Version: $Name$
//
-// Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors
+// Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2011 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
-unsigned int
+std::size_t
MultithreadInfo::memory_consumption ()
{
// only simple data elements, so
// $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
{}
- unsigned int
+ std::size_t
PatternBase::memory_consumption () const
{
if (dynamic_cast<const Integer*>(this) != 0)
}
- unsigned int
+ std::size_t
Selection::memory_consumption () const
{
return (sizeof(PatternBase) +
}
- unsigned int
+ std::size_t
List::memory_consumption () const
{
return (sizeof(PatternBase) +
}
- unsigned int
+ std::size_t
MultipleSelection::memory_consumption () const
{
return (sizeof(PatternBase) +
-unsigned int
+std::size_t
ParameterHandler::memory_consumption () const
{
//TODO: add to this an estimate of the memory in the property_tree
-unsigned int
+std::size_t
MultipleParameterLoop::memory_consumption () const
{
- unsigned int mem = ParameterHandler::memory_consumption ();
+ std::size_t mem = ParameterHandler::memory_consumption ();
for (unsigned int i=0; i<multiple_choices.size(); ++i)
mem += multiple_choices[i].memory_consumption ();
}
-unsigned int
+std::size_t
MultipleParameterLoop::Entry::memory_consumption () const
{
return (MemoryConsumption::memory_consumption (subsection_path) +
// $Id$
// Version: $Name$
//
-// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2005, 2006, 2007, 2008, 2009, 2010 by the deal.II authors
+// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2005, 2006, 2007, 2008, 2009, 2010, 2011 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
template <int dim>
-unsigned int
+std::size_t
Quadrature<dim>::memory_consumption () const
{
return (MemoryConsumption::memory_consumption (quadrature_points) +
// $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
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);
template <int dim, int spacedim>
unsigned int
Triangulation<dim,spacedim>::
- register_data_attach (const size_t size,
+ register_data_attach (const std::size_t size,
const std_cxx1x::function<void(const cell_iterator&,
const CellStatus,
void*)> & pack_callback)
template <int dim, int spacedim>
- unsigned int
+ std::size_t
Triangulation<dim,spacedim>::memory_consumption () const
{
- unsigned int mem=
+ std::size_t mem=
this->dealii::Triangulation<dim,spacedim>::memory_consumption()
+ MemoryConsumption::memory_consumption(mpi_communicator)
+ MemoryConsumption::memory_consumption(my_subdomain)
// + 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;
}
template <int dim, int spacedim>
- unsigned int
+ std::size_t
Triangulation<dim,spacedim>::memory_consumption_p4est () const
{
return internal::p4est::functions<dim>::forest_memory_used(parallel_forest)
// $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
{
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) +
// $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
template<int dim, int spacedim>
-unsigned int
+std::size_t
DoFHandler<dim,spacedim>::memory_consumption () const
{
- unsigned int mem = (MemoryConsumption::memory_consumption (tria) +
- MemoryConsumption::memory_consumption (selected_fe) +
- MemoryConsumption::memory_consumption (block_info_object) +
- MemoryConsumption::memory_consumption (levels) +
- MemoryConsumption::memory_consumption (*faces) +
- MemoryConsumption::memory_consumption (faces) +
- sizeof (number_cache) +
- MemoryConsumption::memory_consumption (vertex_dofs));
+ std::size_t mem = (MemoryConsumption::memory_consumption (tria) +
+ MemoryConsumption::memory_consumption (selected_fe) +
+ MemoryConsumption::memory_consumption (block_info_object) +
+ MemoryConsumption::memory_consumption (levels) +
+ MemoryConsumption::memory_consumption (*faces) +
+ MemoryConsumption::memory_consumption (faces) +
+ sizeof (number_cache) +
+ MemoryConsumption::memory_consumption (vertex_dofs));
for (unsigned int i=0; i<levels.size(); ++i)
mem += MemoryConsumption::memory_consumption (*levels[i]);
// $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
namespace DoFHandler
{
- unsigned int
+ std::size_t
DoFLevel<0>::memory_consumption () const
{
return MemoryConsumption::memory_consumption (cell_dof_indices_cache);
- unsigned int
+ std::size_t
DoFLevel<1>::memory_consumption () const
{
return (DoFLevel<0>::memory_consumption () +
- unsigned int
+ std::size_t
DoFLevel<2>::memory_consumption () const
{
return (DoFLevel<0>::memory_consumption () +
- unsigned int
+ std::size_t
DoFLevel<3>::memory_consumption () const
{
return (DoFLevel<0>::memory_consumption () +
// $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
namespace DoFHandler
{
template <int dim>
- unsigned int
+ std::size_t
DoFObjects<dim>::memory_consumption () const
{
return (MemoryConsumption::memory_consumption (dofs));
// $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
- unsigned int
+ std::size_t
NumberCache::memory_consumption () const
{
return
// $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
template <int dim, int spacedim>
-unsigned int
+std::size_t
FiniteElement<dim,spacedim>::memory_consumption () const
{
return (sizeof(FiniteElementData<dim>) +
// $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
template <int dim>
-unsigned int
+std::size_t
FE_ABF<dim>::memory_consumption () const
{
Assert (false, ExcNotImplemented ());
// $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
template <int dim, int spacedim>
-unsigned int
+std::size_t
FE_DGP<dim,spacedim>::memory_consumption () const
{
Assert (false, ExcNotImplemented ());
// $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
template <int dim>
-unsigned int
+std::size_t
FE_DGPMonomial<dim>::memory_consumption () const
{
Assert (false, ExcNotImplemented ());
// $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
template <int dim, int spacedim>
-unsigned int
+std::size_t
FE_DGPNonparametric<dim,spacedim>::memory_consumption () const
{
Assert (false, ExcNotImplemented ());
// $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
template <int dim, int spacedim>
-unsigned int
+std::size_t
FE_DGQ<dim, spacedim>::memory_consumption () const
{
Assert (false, ExcNotImplemented ());
template <int dim>
-unsigned int
+std::size_t
FE_Nedelec<dim>::memory_consumption () const
{
Assert (false, ExcNotImplemented ());
// $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
template <int dim, int spacedim>
-unsigned int
+std::size_t
FE_Q<dim,spacedim>::memory_consumption () const
{
Assert (false, ExcNotImplemented ());
// $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
template <int dim>
-unsigned int
+std::size_t
FE_Q_Hierarchical<dim>::memory_consumption () const
{
Assert (false, ExcNotImplemented ());
// $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
template <int dim>
-unsigned int
+std::size_t
FE_RaviartThomas<dim>::memory_consumption () const
{
Assert (false, ExcNotImplemented ());
// $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
template <int dim, int spacedim>
-unsigned int
+std::size_t
FESystem<dim,spacedim>::memory_consumption () const
{
// neglect size of data stored in
// compiler. should be neglectable
// after all, considering the size
// of the data of the subelements
- unsigned int mem = (FiniteElement<dim,spacedim>::memory_consumption () +
- sizeof (base_elements));
+ std::size_t mem = (FiniteElement<dim,spacedim>::memory_consumption () +
+ sizeof (base_elements));
for (unsigned int i=0; i<base_elements.size(); ++i)
mem += MemoryConsumption::memory_consumption (*base_elements[i].first);
return mem;
// $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
template <int dim, int spacedim>
-unsigned int
+std::size_t
FEValuesBase<dim,spacedim>::memory_consumption () const
{
return (MemoryConsumption::memory_consumption (this->shape_values) +
template <int dim, int spacedim>
-unsigned int
+std::size_t
FEValues<dim,spacedim>::memory_consumption () const
{
return (FEValuesBase<dim,spacedim>::memory_consumption () +
template <int dim, int spacedim>
-unsigned int
+std::size_t
FEFaceValuesBase<dim,spacedim>::memory_consumption () const
{
return (FEValuesBase<dim,spacedim>::memory_consumption () +
// $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
template <int dim, int spacedim>
-unsigned int
+std::size_t
Mapping<dim, spacedim>::InternalDataBase::memory_consumption () const
{
return sizeof(*this);
// $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
template<int dim, int spacedim>
-unsigned int
+std::size_t
MappingCartesian<dim, spacedim>::InternalData::memory_consumption () const
{
return (Mapping<dim, spacedim>::InternalDataBase::memory_consumption() +
// $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
template<int dim, int spacedim>
-unsigned int
+std::size_t
MappingQ<dim,spacedim>::InternalData::memory_consumption () const
{
return (MappingQ1<dim,spacedim>::InternalData::memory_consumption () +
// $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
template<int dim, int spacedim>
-unsigned int
+std::size_t
MappingQ1<dim,spacedim>::InternalData::memory_consumption () const
{
return (Mapping<dim,spacedim>::InternalDataBase::memory_consumption() +
// $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
-unsigned int
+std::size_t
GridOut::memory_consumption () const
{
return (sizeof(dx_flags) +
// $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
template <class GridClass>
-unsigned int
+std::size_t
InterGridMap<GridClass>::memory_consumption () const
{
return (MemoryConsumption::memory_consumption (mapping) +
// $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
template <int dim>
-unsigned int
+std::size_t
PersistentTriangulation<dim>::memory_consumption () const
{
return (Triangulation<dim>::memory_consumption () +
- unsigned int
+ std::size_t
NumberCache<1>::memory_consumption () const
{
return (MemoryConsumption::memory_consumption (n_levels) +
- unsigned int
+ std::size_t
NumberCache<2>::memory_consumption () const
{
return (NumberCache<1>::memory_consumption () +
- unsigned int
+ std::size_t
NumberCache<3>::memory_consumption () const
{
return (NumberCache<2>::memory_consumption () +
template <int dim, int spacedim>
-unsigned int
+std::size_t
Triangulation<dim, spacedim>::memory_consumption () const
{
- unsigned int mem = 0;
+ std::size_t mem = 0;
mem += MemoryConsumption::memory_consumption(levels);
for (unsigned int i=0; i<levels.size(); ++i)
mem += MemoryConsumption::memory_consumption (*levels[i]);
// $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
namespace Triangulation
{
- unsigned int
+ std::size_t
TriaFaces<1>::memory_consumption () const
{
return 0;
}
- unsigned int
+ std::size_t
TriaFaces<2>::memory_consumption () const
{
return MemoryConsumption::memory_consumption (lines);
}
- unsigned int
+ std::size_t
TriaFaces<3>::memory_consumption () const
{
return (MemoryConsumption::memory_consumption (quads) +
// $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
template <int dim>
- unsigned int
+ std::size_t
TriaLevel<dim>::memory_consumption () const
{
return (MemoryConsumption::memory_consumption (refine_flags) +
}
- unsigned int
+ std::size_t
TriaLevel<3>::memory_consumption () const
{
return (MemoryConsumption::memory_consumption (refine_flags) +
// $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
template<typename G>
- unsigned int
+ std::size_t
TriaObjects<G>::memory_consumption () const
{
return (MemoryConsumption::memory_consumption (cells) +
}
- unsigned int
+ std::size_t
TriaObjectsHex::memory_consumption () const
{
return (MemoryConsumption::memory_consumption (face_orientations) +
}
- unsigned int
+ std::size_t
TriaObjectsQuad3D::memory_consumption () const
{
return (MemoryConsumption::memory_consumption (line_orientations) +
// $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
namespace hp
{
- 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) +
// $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
template<int dim, int spacedim>
- unsigned int
+ std::size_t
DoFHandler<dim,spacedim>::memory_consumption () const
{
- unsigned int mem = (MemoryConsumption::memory_consumption (tria) +
- MemoryConsumption::memory_consumption (finite_elements) +
- MemoryConsumption::memory_consumption (tria) +
- MemoryConsumption::memory_consumption (levels) +
- MemoryConsumption::memory_consumption (*faces) +
- MemoryConsumption::memory_consumption (number_cache) +
- MemoryConsumption::memory_consumption (vertex_dofs) +
- MemoryConsumption::memory_consumption (vertex_dofs_offsets) +
- MemoryConsumption::memory_consumption (has_children));
+ std::size_t mem = (MemoryConsumption::memory_consumption (tria) +
+ MemoryConsumption::memory_consumption (finite_elements) +
+ MemoryConsumption::memory_consumption (tria) +
+ MemoryConsumption::memory_consumption (levels) +
+ MemoryConsumption::memory_consumption (*faces) +
+ MemoryConsumption::memory_consumption (number_cache) +
+ MemoryConsumption::memory_consumption (vertex_dofs) +
+ MemoryConsumption::memory_consumption (vertex_dofs_offsets) +
+ MemoryConsumption::memory_consumption (has_children));
for (unsigned int i=0; i<levels.size(); ++i)
mem += MemoryConsumption::memory_consumption (*levels[i]);
mem += MemoryConsumption::memory_consumption (*faces);
// $Id$
// Version: $Name$
//
-// Copyright (C) 2003, 2006 by the deal.II authors
+// Copyright (C) 2003, 2006, 2011 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
namespace hp
{
- unsigned int
+ std::size_t
DoFLevel<1>::memory_consumption () const
{
return (DoFLevel<0>::memory_consumption() +
- unsigned int
+ std::size_t
DoFLevel<2>::memory_consumption () const
{
return (DoFLevel<0>::memory_consumption () +
- unsigned int
+ std::size_t
DoFLevel<3>::memory_consumption () const
{
return (DoFLevel<0>::memory_consumption () +
- unsigned int
+ std::size_t
DoFLevel<0>::memory_consumption () const
{
return MemoryConsumption::memory_consumption (active_fe_indices);
// $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
namespace hp
{
template <int structdim>
- unsigned int
+ std::size_t
DoFObjects<structdim>::memory_consumption () const
{
return (MemoryConsumption::memory_consumption (dofs) +
// 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;
}
}
// $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
template <int dim, int spacedim>
- unsigned int
+ std::size_t
FECollection<dim,spacedim>::memory_consumption () const
{
- unsigned int mem
+ std::size_t mem
= (sizeof(*this) +
MemoryConsumption::memory_consumption (finite_elements));
for (unsigned int i=0; i<finite_elements.size(); ++i)
// $Id$
// Version: $Name$
//
-// Copyright (C) 2003, 2006 by the deal.II authors
+// Copyright (C) 2003, 2006, 2011 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
template<int dim, int spacedim>
- unsigned int
+ std::size_t
MappingCollection<dim,spacedim>::memory_consumption () const
{
return (sizeof(*this) +
// $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
}
-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) +
// $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
-unsigned int
+std::size_t
ChunkSparsityPattern::memory_consumption () const
{
return (sizeof(*this) +
// $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
}
-unsigned int
+std::size_t
CompressedSimpleSparsityPattern::Line::memory_consumption () const
{
return entries.capacity()*sizeof(unsigned int)+sizeof(Line);
}
-unsigned int
+std::size_t
CompressedSimpleSparsityPattern::memory_consumption () const
{
//TODO: IndexSet...
- unsigned int mem = sizeof(CompressedSimpleSparsityPattern);
+ std::size_t mem = sizeof(CompressedSimpleSparsityPattern);
for (unsigned int i=0; i<lines.size(); ++i)
mem += MemoryConsumption::memory_consumption (lines[i]);
// $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
-unsigned int
+std::size_t
ConstraintMatrix::ConstraintLine::memory_consumption () const
{
return (MemoryConsumption::memory_consumption (line) +
for (std::vector<ConstraintLine>::const_iterator i=lines.begin();
i!=lines.end(); ++i)
// use static cast, since
- // typeof(size)==size_t, which is
- // != unsigned int on AIX
+ // typeof(size)==std::size_t, which is !=
+ // unsigned int on AIX
return_value = std::max(return_value,
static_cast<unsigned int>(i->entries.size()));
-unsigned int
+std::size_t
ConstraintMatrix::memory_consumption () const
{
return (MemoryConsumption::memory_consumption (lines) +
// $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
- unsigned int
+ std::size_t
MatrixBase::memory_consumption() const
{
- MatInfo info;
- MatGetInfo(matrix, MAT_LOCAL, &info);
+ MatInfo info;
+ MatGetInfo(matrix, MAT_LOCAL, &info);
- return sizeof(*this) + static_cast<unsigned int>(info.memory);
+ return sizeof(*this) + static_cast<unsigned int>(info.memory);
}
}
// $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
}
- 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
// $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
*/
template <typename T>
void put (const T *t,
- const size_t N,
+ const std::size_t N,
const char * /*debug_info*/) const
{
unsigned int count = 0;
*/
template <typename T>
void get (T *t,
- const size_t N,
+ const std::size_t N,
const char * /*debug_info*/) const
{
unsigned int count = 0;
-unsigned int
+std::size_t
SparseDirectMA27::memory_consumption () const
{
return (sizeof(*this) +
-unsigned int
+std::size_t
SparseDirectMA47::memory_consumption () const
{
return (sizeof(*this) +
// $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
std::size_t
SparsityPattern::memory_consumption () const
{
- return (max_dim * static_cast<size_t>(sizeof(unsigned int)) +
+ return (max_dim * sizeof(unsigned int) +
sizeof(*this) +
max_vec_len * sizeof(unsigned int));
}
// $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
- unsigned int PreconditionAMG::memory_consumption() const
+ std::size_t
+ PreconditionAMG::memory_consumption() const
{
unsigned int memory = sizeof(this);
// $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
- unsigned int
+ std::size_t
SparseMatrix::memory_consumption () const
{
unsigned int static_memory = sizeof(this) + sizeof (*matrix)
// $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
- unsigned int
+ std::size_t
VectorBase::memory_consumption () const
{
//TODO[TH]: No accurate memory
// $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
template<typename VECTOR>
inline
-unsigned int
+std::size_t
GrowingVectorMemory<VECTOR>::memory_consumption () const
{
Threads::ThreadMutex::ScopedLock lock(mutex);
- unsigned int result = sizeof (*this);
+ std::size_t result = sizeof (*this);
const typename std::vector<entry_type>::const_iterator
end = pool.data->end();
for (typename std::vector<entry_type>::const_iterator
// $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
template <int dim, int spacedim>
-unsigned int
+std::size_t
MGDoFHandler<dim,spacedim>::memory_consumption() const
{
- unsigned int mem = DoFHandler<dim,spacedim>::memory_consumption();
+ std::size_t mem = DoFHandler<dim,spacedim>::memory_consumption();
for (unsigned int l=0;l<mg_levels.size();++l)
mem += mg_levels[l]->memory_consumption();
// $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
-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)
//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);
template <class DH,
int patch_dim, int patch_space_dim>
template <typename VectorType>
-unsigned int
+std::size_t
DataOut_DoFData<DH,patch_dim,patch_space_dim>::
DataEntry<VectorType>::memory_consumption () const
{
template <class DH,
int patch_dim, int patch_space_dim>
-unsigned int
+std::size_t
DataOut_DoFData<DH,patch_dim,patch_space_dim>::memory_consumption () const
{
return (DataOutInterface<patch_dim,patch_space_dim>::memory_consumption () +
// $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
template <int dim, int spacedim, class DH>
-unsigned int
+std::size_t
DataOutStack<dim,spacedim,DH>::DataVector::memory_consumption () const
{
return (MemoryConsumption::memory_consumption (data) +
template <int dim, int spacedim, class DH>
-unsigned int
+std::size_t
DataOutStack<dim,spacedim,DH>::memory_consumption () const
{
return (DataOutInterface<dim+1>::memory_consumption () +
// $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
-unsigned int
+std::size_t
Histogram::Interval::memory_consumption () const
{
return sizeof(*this);
-unsigned int
+std::size_t
Histogram::memory_consumption () const
{
return (MemoryConsumption::memory_consumption (intervals) +
//---------------------------------------------------------------------------
// $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
template <typename number>
- unsigned int
+ std::size_t
LocalResults<number>::memory_consumption () const
{
- unsigned int mem = sizeof(*this)
+ std::size_t mem = sizeof(*this)
+ MemoryConsumption::memory_consumption(J)
+ MemoryConsumption::memory_consumption(R)
+ MemoryConsumption::memory_consumption(M1)
// $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
template<int dim, typename VECTOR, class DH>
-unsigned int
+std::size_t
SolutionTransfer<dim, VECTOR, DH>::memory_consumption () const
{
// at the moment we do not include the memory
template<int dim, typename VECTOR, class DH>
-unsigned int
+std::size_t
SolutionTransfer<dim, VECTOR, DH>::Pointerstruct::memory_consumption () const
{
return sizeof(*this);
// $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
-unsigned int TimeDependent::memory_consumption () const
+std::size_t
+TimeDependent::memory_consumption () const
{
- unsigned int mem = (MemoryConsumption::memory_consumption (timesteps) +
- MemoryConsumption::memory_consumption (sweep_no) +
- sizeof(timestepping_data_primal) +
- sizeof(timestepping_data_dual) +
- sizeof(timestepping_data_postprocess));
+ std::size_t mem = (MemoryConsumption::memory_consumption (timesteps) +
+ MemoryConsumption::memory_consumption (sweep_no) +
+ sizeof(timestepping_data_primal) +
+ sizeof(timestepping_data_dual) +
+ sizeof(timestepping_data_postprocess));
for (unsigned int i=0; i<timesteps.size(); ++i)
mem += MemoryConsumption::memory_consumption (*timesteps[i]);
-unsigned int
+std::size_t
TimeStepBase::memory_consumption () const
{
// only simple data types
template <int dim>
-unsigned int
+std::size_t
TimeStepBase_Tria<dim>::memory_consumption () const
{
return (TimeStepBase::memory_consumption () +