Reference documentation for deal.II version 9.6.0
|
#include <deal.II/fe/mapping_cartesian.h>
Public Member Functions | |
InternalData ()=default | |
InternalData (const Quadrature< dim > &quadrature) | |
virtual void | reinit (const UpdateFlags update_flags, const Quadrature< dim > &quadrature) override |
virtual std::size_t | memory_consumption () const override |
Public Attributes | |
Tensor< 1, dim > | cell_extents |
Tensor< 1, dim > | inverse_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 208 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 91 of file mapping_cartesian.cc.
|
overridevirtual |
This function initializes the data fields related to evaluation of the mapping on cells, implemented by (derived) classes. This function is used both when setting up a field of this class for the first time or when a new Quadrature formula should be considered without creating an entirely new object. This is used when the number of evaluation points is different on each cell, e.g. when using FEPointEvaluation for handling particles or with certain non-matching problem settings.
Reimplemented from Mapping< dim, spacedim >::InternalDataBase.
Definition at line 103 of file mapping_cartesian.cc.
|
overridevirtual |
Return an estimate (in bytes) for the memory consumption of this object.
Reimplemented from Mapping< dim, spacedim >::InternalDataBase.
Definition at line 117 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 236 of file mapping_cartesian.h.
|
mutable |
Reciprocal of the extents of the last cell we have seen in the coordinate directions, i.e., hx, hy, hz.
Definition at line 243 of file mapping_cartesian.h.
|
mutable |
The volume element
Definition at line 248 of file mapping_cartesian.h.
std::vector<Point<dim> > MappingCartesian< dim, spacedim >::InternalData::quadrature_points |
Location of quadrature points of faces or subfaces in 3d with all possible orientations. Can be accessed with the correct offset provided via QProjector::DataSetDescriptor. Not needed/used for cells.
Definition at line 255 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.)