Reference documentation for deal.II version 9.5.0
|
#include <deal.II/fe/mapping_cartesian.h>
Public Member Functions | |
InternalData ()=default | |
InternalData (const Quadrature< dim > &quadrature) | |
virtual std::size_t | memory_consumption () const override |
Public Attributes | |
Tensor< 1, dim > | cell_extents |
double | volume_element |
std::vector< Point< dim > > | quadrature_points |
UpdateFlags | update_each |
Storage for internal data of the mapping. See Mapping::InternalDataBase for an extensive description.
This includes data that is computed once when the object is created (in get_data()) as well as data the class wants to store from between the call to fill_fe_values(), fill_fe_face_values(), or fill_fe_subface_values() until possible later calls from the finite element to functions such as transform(). The latter class of member variables are marked as 'mutable'.
Definition at line 202 of file mapping_cartesian.h.
|
default |
Default constructor.
MappingCartesian< dim, spacedim >::InternalData::InternalData | ( | const Quadrature< dim > & | quadrature | ) |
Constructor that initializes the object with a quadrature.
Definition at line 92 of file mapping_cartesian.cc.
|
overridevirtual |
Return an estimate (in bytes) for the memory consumption of this object.
Definition at line 103 of file mapping_cartesian.cc.
|
mutable |
Extents of the last cell we have seen in the coordinate directions, i.e., hx, hy, hz.
Definition at line 225 of file mapping_cartesian.h.
|
mutable |
The volume element
Definition at line 230 of file mapping_cartesian.h.
std::vector<Point<dim> > MappingCartesian< dim, spacedim >::InternalData::quadrature_points |
Vector of all quadrature points. Especially, all points on all faces.
Definition at line 235 of file mapping_cartesian.h.
|
inherited |
A set of update flags specifying the kind of information that an implementation of the Mapping interface needs to compute on each cell or face, i.e., in Mapping::fill_fe_values() and friends.
This set of flags is stored here by implementations of Mapping::get_data(), Mapping::get_face_data(), or Mapping::get_subface_data(), and is that subset of the update flags passed to those functions that require re-computation on every cell. (The subset of the flags corresponding to information that can be computed once and for all already at the time of the call to Mapping::get_data() – or an implementation of that interface – need not be stored here because it has already been taken care of.)