libMesh
|
An implementation of FEMap for "XYZ" elements. More...
#include <fe_xyz_map.h>
Public Member Functions | |
FEXYZMap () | |
virtual | ~FEXYZMap () |
virtual void | compute_face_map (int dim, const std::vector< Real > &qw, const Elem *side) override |
Special implementation for XYZ finite elements. More... | |
template<unsigned int Dim> | |
void | init_reference_to_physical_map (const std::vector< Point > &qp, const Elem *elem) |
void | compute_single_point_map (const unsigned int dim, const std::vector< Real > &qw, const Elem *elem, unsigned int p, const std::vector< const Node * > &elem_nodes, bool compute_second_derivatives) |
Compute the jacobian and some other additional data fields at the single point with index p. More... | |
virtual void | compute_affine_map (const unsigned int dim, const std::vector< Real > &qw, const Elem *elem) |
Compute the jacobian and some other additional data fields. More... | |
virtual void | compute_null_map (const unsigned int dim, const std::vector< Real > &qw) |
Assign a fake jacobian and some other additional data fields. More... | |
virtual void | compute_map (const unsigned int dim, const std::vector< Real > &qw, const Elem *elem, bool calculate_d2phi) |
Compute the jacobian and some other additional data fields. More... | |
void | compute_edge_map (int dim, const std::vector< Real > &qw, const Elem *side) |
Same as before, but for an edge. More... | |
template<unsigned int Dim> | |
void | init_face_shape_functions (const std::vector< Point > &qp, const Elem *side) |
Initializes the reference to physical element map for a side. More... | |
template<unsigned int Dim> | |
void | init_edge_shape_functions (const std::vector< Point > &qp, const Elem *edge) |
Same as before, but for an edge. More... | |
const std::vector< Point > & | get_xyz () const |
const std::vector< Real > & | get_jacobian () const |
const std::vector< Real > & | get_JxW () const |
std::vector< Real > & | get_JxW () |
const std::vector< RealGradient > & | get_dxyzdxi () const |
const std::vector< RealGradient > & | get_dxyzdeta () const |
const std::vector< RealGradient > & | get_dxyzdzeta () const |
const std::vector< RealGradient > & | get_d2xyzdxi2 () const |
const std::vector< RealGradient > & | get_d2xyzdeta2 () const |
const std::vector< RealGradient > & | get_d2xyzdzeta2 () const |
const std::vector< RealGradient > & | get_d2xyzdxideta () const |
const std::vector< RealGradient > & | get_d2xyzdxidzeta () const |
const std::vector< RealGradient > & | get_d2xyzdetadzeta () const |
const std::vector< Real > & | get_dxidx () const |
const std::vector< Real > & | get_dxidy () const |
const std::vector< Real > & | get_dxidz () const |
const std::vector< Real > & | get_detadx () const |
const std::vector< Real > & | get_detady () const |
const std::vector< Real > & | get_detadz () const |
const std::vector< Real > & | get_dzetadx () const |
const std::vector< Real > & | get_dzetady () const |
const std::vector< Real > & | get_dzetadz () const |
const std::vector< std::vector< Real > > & | get_d2xidxyz2 () const |
Second derivatives of "xi" reference coordinate wrt physical coordinates. More... | |
const std::vector< std::vector< Real > > & | get_d2etadxyz2 () const |
Second derivatives of "eta" reference coordinate wrt physical coordinates. More... | |
const std::vector< std::vector< Real > > & | get_d2zetadxyz2 () const |
Second derivatives of "zeta" reference coordinate wrt physical coordinates. More... | |
const std::vector< std::vector< Real > > & | get_psi () const |
std::vector< std::vector< Real > > & | get_psi () |
const std::vector< std::vector< Real > > & | get_phi_map () const |
std::vector< std::vector< Real > > & | get_phi_map () |
const std::vector< std::vector< Real > > & | get_dphidxi_map () const |
std::vector< std::vector< Real > > & | get_dphidxi_map () |
const std::vector< std::vector< Real > > & | get_dphideta_map () const |
std::vector< std::vector< Real > > & | get_dphideta_map () |
const std::vector< std::vector< Real > > & | get_dphidzeta_map () const |
std::vector< std::vector< Real > > & | get_dphidzeta_map () |
const std::vector< std::vector< Point > > & | get_tangents () const |
const std::vector< Point > & | get_normals () const |
const std::vector< Real > & | get_curvatures () const |
void | print_JxW (std::ostream &os) const |
Prints the Jacobian times the weight for each quadrature point. More... | |
void | print_xyz (std::ostream &os) const |
Prints the spatial location of each quadrature point (on the physical element). More... | |
std::vector< std::vector< Real > > & | get_dpsidxi () |
const std::vector< std::vector< Real > > & | get_dpsidxi () const |
std::vector< std::vector< Real > > & | get_dpsideta () |
const std::vector< std::vector< Real > > & | get_dpsideta () const |
std::vector< std::vector< Real > > & | get_d2psidxi2 () |
const std::vector< std::vector< Real > > & | get_d2psidxi2 () const |
std::vector< std::vector< Real > > & | get_d2psidxideta () |
const std::vector< std::vector< Real > > & | get_d2psidxideta () const |
std::vector< std::vector< Real > > & | get_d2psideta2 () |
const std::vector< std::vector< Real > > & | get_d2psideta2 () const |
std::vector< std::vector< Real > > & | get_d2phidxi2_map () |
std::vector< std::vector< Real > > & | get_d2phidxideta_map () |
std::vector< std::vector< Real > > & | get_d2phidxidzeta_map () |
std::vector< std::vector< Real > > & | get_d2phideta2_map () |
std::vector< std::vector< Real > > & | get_d2phidetadzeta_map () |
std::vector< std::vector< Real > > & | get_d2phidzeta2_map () |
void | set_jacobian_tolerance (Real tol) |
Set the Jacobian tolerance used for determining when the mapping fails. More... | |
Static Public Member Functions | |
static std::unique_ptr< FEMap > | build (FEType fe_type) |
static FEFamily | map_fe_type (const Elem &elem) |
static Point | map (const unsigned int dim, const Elem *elem, const Point &reference_point) |
static Point | map_deriv (const unsigned int dim, const Elem *elem, const unsigned int j, const Point &reference_point) |
static Point | inverse_map (const unsigned int dim, const Elem *elem, const Point &p, const Real tolerance=TOLERANCE, const bool secure=true) |
static void | inverse_map (unsigned int dim, const Elem *elem, const std::vector< Point > &physical_points, std::vector< Point > &reference_points, const Real tolerance=TOLERANCE, const bool secure=true) |
Takes a number points in physical space (in the physical_points vector) and finds their location on the reference element for the input element elem . More... | |
Protected Member Functions | |
void | determine_calculations () |
Determine which values are to be calculated. More... | |
void | resize_quadrature_map_vectors (const unsigned int dim, unsigned int n_qp) |
A utility function for use by compute_*_map. More... | |
Real | dxdxi_map (const unsigned int p) const |
Used in FEMap::compute_map() , which should be be usable in derived classes, and therefore protected. More... | |
Real | dydxi_map (const unsigned int p) const |
Used in FEMap::compute_map() , which should be be usable in derived classes, and therefore protected. More... | |
Real | dzdxi_map (const unsigned int p) const |
Used in FEMap::compute_map() , which should be be usable in derived classes, and therefore protected. More... | |
Real | dxdeta_map (const unsigned int p) const |
Used in FEMap::compute_map() , which should be be usable in derived classes, and therefore protected. More... | |
Real | dydeta_map (const unsigned int p) const |
Used in FEMap::compute_map() , which should be be usable in derived classes, and therefore protected. More... | |
Real | dzdeta_map (const unsigned int p) const |
Used in FEMap::compute_map() , which should be be usable in derived classes, and therefore protected. More... | |
Real | dxdzeta_map (const unsigned int p) const |
Used in FEMap::compute_map() , which should be be usable in derived classes, and therefore protected. More... | |
Real | dydzeta_map (const unsigned int p) const |
Used in FEMap::compute_map() , which should be be usable in derived classes, and therefore protected. More... | |
Real | dzdzeta_map (const unsigned int p) const |
Used in FEMap::compute_map() , which should be be usable in derived classes, and therefore protected. More... | |
Protected Attributes | |
std::vector< Point > | xyz |
The spatial locations of the quadrature points. More... | |
std::vector< RealGradient > | dxyzdxi_map |
Vector of partial derivatives: d(x)/d(xi), d(y)/d(xi), d(z)/d(xi) More... | |
std::vector< RealGradient > | dxyzdeta_map |
Vector of partial derivatives: d(x)/d(eta), d(y)/d(eta), d(z)/d(eta) More... | |
std::vector< RealGradient > | dxyzdzeta_map |
Vector of partial derivatives: d(x)/d(zeta), d(y)/d(zeta), d(z)/d(zeta) More... | |
std::vector< RealGradient > | d2xyzdxi2_map |
Vector of second partial derivatives in xi: d^2(x)/d(xi)^2, d^2(y)/d(xi)^2, d^2(z)/d(xi)^2. More... | |
std::vector< RealGradient > | d2xyzdxideta_map |
Vector of mixed second partial derivatives in xi-eta: d^2(x)/d(xi)d(eta) d^2(y)/d(xi)d(eta) d^2(z)/d(xi)d(eta) More... | |
std::vector< RealGradient > | d2xyzdeta2_map |
Vector of second partial derivatives in eta: d^2(x)/d(eta)^2. More... | |
std::vector< RealGradient > | d2xyzdxidzeta_map |
Vector of second partial derivatives in xi-zeta: d^2(x)/d(xi)d(zeta), d^2(y)/d(xi)d(zeta), d^2(z)/d(xi)d(zeta) More... | |
std::vector< RealGradient > | d2xyzdetadzeta_map |
Vector of mixed second partial derivatives in eta-zeta: d^2(x)/d(eta)d(zeta) d^2(y)/d(eta)d(zeta) d^2(z)/d(eta)d(zeta) More... | |
std::vector< RealGradient > | d2xyzdzeta2_map |
Vector of second partial derivatives in zeta: d^2(x)/d(zeta)^2. More... | |
std::vector< Real > | dxidx_map |
Map for partial derivatives: d(xi)/d(x). More... | |
std::vector< Real > | dxidy_map |
Map for partial derivatives: d(xi)/d(y). More... | |
std::vector< Real > | dxidz_map |
Map for partial derivatives: d(xi)/d(z). More... | |
std::vector< Real > | detadx_map |
Map for partial derivatives: d(eta)/d(x). More... | |
std::vector< Real > | detady_map |
Map for partial derivatives: d(eta)/d(y). More... | |
std::vector< Real > | detadz_map |
Map for partial derivatives: d(eta)/d(z). More... | |
std::vector< Real > | dzetadx_map |
Map for partial derivatives: d(zeta)/d(x). More... | |
std::vector< Real > | dzetady_map |
Map for partial derivatives: d(zeta)/d(y). More... | |
std::vector< Real > | dzetadz_map |
Map for partial derivatives: d(zeta)/d(z). More... | |
std::vector< std::vector< Real > > | d2xidxyz2_map |
Second derivatives of "xi" reference coordinate wrt physical coordinates. More... | |
std::vector< std::vector< Real > > | d2etadxyz2_map |
Second derivatives of "eta" reference coordinate wrt physical coordinates. More... | |
std::vector< std::vector< Real > > | d2zetadxyz2_map |
Second derivatives of "zeta" reference coordinate wrt physical coordinates. More... | |
std::vector< std::vector< Real > > | phi_map |
Map for the shape function phi. More... | |
std::vector< std::vector< Real > > | dphidxi_map |
Map for the derivative, d(phi)/d(xi). More... | |
std::vector< std::vector< Real > > | dphideta_map |
Map for the derivative, d(phi)/d(eta). More... | |
std::vector< std::vector< Real > > | dphidzeta_map |
Map for the derivative, d(phi)/d(zeta). More... | |
std::vector< std::vector< Real > > | d2phidxi2_map |
Map for the second derivative, d^2(phi)/d(xi)^2. More... | |
std::vector< std::vector< Real > > | d2phidxideta_map |
Map for the second derivative, d^2(phi)/d(xi)d(eta). More... | |
std::vector< std::vector< Real > > | d2phidxidzeta_map |
Map for the second derivative, d^2(phi)/d(xi)d(zeta). More... | |
std::vector< std::vector< Real > > | d2phideta2_map |
Map for the second derivative, d^2(phi)/d(eta)^2. More... | |
std::vector< std::vector< Real > > | d2phidetadzeta_map |
Map for the second derivative, d^2(phi)/d(eta)d(zeta). More... | |
std::vector< std::vector< Real > > | d2phidzeta2_map |
Map for the second derivative, d^2(phi)/d(zeta)^2. More... | |
std::vector< std::vector< Real > > | psi_map |
Map for the side shape functions, psi. More... | |
std::vector< std::vector< Real > > | dpsidxi_map |
Map for the derivative of the side functions, d(psi)/d(xi). More... | |
std::vector< std::vector< Real > > | dpsideta_map |
Map for the derivative of the side function, d(psi)/d(eta). More... | |
std::vector< std::vector< Real > > | d2psidxi2_map |
Map for the second derivatives (in xi) of the side shape functions. More... | |
std::vector< std::vector< Real > > | d2psidxideta_map |
Map for the second (cross) derivatives in xi, eta of the side shape functions. More... | |
std::vector< std::vector< Real > > | d2psideta2_map |
Map for the second derivatives (in eta) of the side shape functions. More... | |
std::vector< std::vector< Point > > | tangents |
Tangent vectors on boundary at quadrature points. More... | |
std::vector< Point > | normals |
Normal vectors on boundary at quadrature points. More... | |
std::vector< Real > | curvatures |
The mean curvature (= one half the sum of the principal curvatures) on the boundary at the quadrature points. More... | |
std::vector< Real > | jac |
Jacobian values at quadrature points. More... | |
std::vector< Real > | JxW |
Jacobian*Weight values at quadrature points. More... | |
bool | calculations_started |
Have calculations with this object already been started? Then all get_* functions should already have been called. More... | |
bool | calculate_xyz |
Should we calculate physical point locations? More... | |
bool | calculate_dxyz |
Should we calculate mapping gradients? More... | |
bool | calculate_d2xyz |
Should we calculate mapping hessians? More... | |
Real | jacobian_tolerance |
The Jacobian tolerance used for determining when the mapping fails. More... | |
Private Member Functions | |
void | compute_inverse_map_second_derivs (unsigned p) |
A helper function used by FEMap::compute_single_point_map() to compute second derivatives of the inverse map. More... | |
Private Attributes | |
std::vector< const Node * > | _elem_nodes |
Work vector for compute_affine_map() More... | |
An implementation of FEMap for "XYZ" elements.
An implementation of FEMap for "XYZ" elements.
Definition at line 39 of file fe_xyz_map.h.
|
inline |
|
inlinevirtual |
Definition at line 50 of file fe_xyz_map.h.
|
virtualinherited |
Compute the jacobian and some other additional data fields.
Takes the integration weights as input, along with a pointer to the element. The element is assumed to have a constant Jacobian
Definition at line 1277 of file fe_map.C.
References libMesh::FEMap::_elem_nodes, libMesh::FEMap::calculate_d2xyz, libMesh::FEMap::calculate_dxyz, libMesh::FEMap::calculate_xyz, libMesh::FEMap::compute_single_point_map(), libMesh::FEMap::d2xyzdeta2_map, libMesh::FEMap::d2xyzdetadzeta_map, libMesh::FEMap::d2xyzdxi2_map, libMesh::FEMap::d2xyzdxideta_map, libMesh::FEMap::d2xyzdxidzeta_map, libMesh::FEMap::d2xyzdzeta2_map, libMesh::FEMap::detadx_map, libMesh::FEMap::detady_map, libMesh::FEMap::detadz_map, dim, libMesh::FEMap::dxidx_map, libMesh::FEMap::dxidy_map, libMesh::FEMap::dxidz_map, libMesh::FEMap::dxyzdeta_map, libMesh::FEMap::dxyzdxi_map, libMesh::FEMap::dxyzdzeta_map, libMesh::FEMap::dzetadx_map, libMesh::FEMap::dzetady_map, libMesh::FEMap::dzetadz_map, libMesh::index_range(), libMesh::FEMap::jac, libMesh::FEMap::JxW, libMesh::libmesh_assert(), n_nodes, libMesh::Elem::n_nodes(), libMesh::Elem::node_ptr(), libMesh::FEMap::phi_map, libMesh::FEMap::resize_quadrature_map_vectors(), and libMesh::FEMap::xyz.
Referenced by libMesh::FEMap::compute_map().
|
inherited |
Same as before, but for an edge.
Useful for some projections.
Definition at line 950 of file fe_boundary.C.
References libMesh::FEMap::calculate_d2xyz, libMesh::FEMap::calculate_dxyz, libMesh::FEMap::calculate_xyz, libMesh::FEMap::compute_face_map(), libMesh::FEMap::curvatures, libMesh::FEMap::d2psidxi2_map, libMesh::FEMap::d2xyzdeta2_map, libMesh::FEMap::d2xyzdxi2_map, libMesh::FEMap::d2xyzdxideta_map, libMesh::FEMap::determine_calculations(), dim, libMesh::FEMap::dpsidxi_map, libMesh::FEMap::dxdxi_map(), libMesh::FEMap::dxyzdeta_map, libMesh::FEMap::dxyzdxi_map, libMesh::FEMap::dydxi_map(), libMesh::FEMap::dzdxi_map(), libMesh::FEMap::JxW, libMesh::libmesh_assert(), libMesh::FEMap::normals, libMesh::Elem::point(), libMesh::FEMap::psi_map, libMesh::Real, std::sqrt(), libMesh::FEMap::tangents, and libMesh::FEMap::xyz.
|
overridevirtual |
Special implementation for XYZ finite elements.
Reimplemented from libMesh::FEMap.
Definition at line 25 of file fe_xyz_map.C.
References libMesh::TypeVector< T >::cross(), libMesh::FEMap::curvatures, libMesh::FEMap::d2psideta2_map, libMesh::FEMap::d2psidxi2_map, libMesh::FEMap::d2psidxideta_map, libMesh::FEMap::d2xyzdeta2_map, libMesh::FEMap::d2xyzdxi2_map, libMesh::FEMap::d2xyzdxideta_map, dim, libMesh::FEMap::dpsideta_map, libMesh::FEMap::dpsidxi_map, libMesh::FEMap::dxdeta_map(), libMesh::FEMap::dxdxi_map(), libMesh::FEMap::dxyzdeta_map, libMesh::FEMap::dxyzdxi_map, libMesh::FEMap::dydeta_map(), libMesh::FEMap::dydxi_map(), libMesh::FEMap::dzdeta_map(), libMesh::FEMap::dzdxi_map(), libMesh::FEMap::JxW, libMesh::libmesh_assert(), libMesh::FEMap::normals, libMesh::Elem::point(), libMesh::FEMap::psi_map, libMesh::Real, std::sqrt(), libMesh::FEMap::tangents, libMesh::TypeVector< T >::unit(), and libMesh::FEMap::xyz.
|
privateinherited |
A helper function used by FEMap::compute_single_point_map() to compute second derivatives of the inverse map.
Definition at line 1502 of file fe_map.C.
References A, libMesh::FEMap::d2etadxyz2_map, libMesh::FEMap::d2xidxyz2_map, libMesh::FEMap::d2xyzdeta2_map, libMesh::FEMap::d2xyzdetadzeta_map, libMesh::FEMap::d2xyzdxi2_map, libMesh::FEMap::d2xyzdxideta_map, libMesh::FEMap::d2xyzdxidzeta_map, libMesh::FEMap::d2xyzdzeta2_map, libMesh::FEMap::d2zetadxyz2_map, libMesh::FEMap::detadx_map, libMesh::FEMap::detady_map, libMesh::FEMap::detadz_map, libMesh::FEMap::dxidx_map, libMesh::FEMap::dxidy_map, libMesh::FEMap::dxidz_map, libMesh::FEMap::dzetadx_map, libMesh::FEMap::dzetady_map, libMesh::FEMap::dzetadz_map, and libMesh::libmesh_ignore().
Referenced by libMesh::FEMap::compute_single_point_map().
|
virtualinherited |
Compute the jacobian and some other additional data fields.
Takes the integration weights as input, along with a pointer to the element. Also takes a boolean parameter indicating whether second derivatives need to be calculated, allowing us to potentially skip unnecessary, expensive computations.
Definition at line 1433 of file fe_map.C.
References libMesh::FEMap::_elem_nodes, libMesh::FEMap::compute_affine_map(), libMesh::FEMap::compute_null_map(), libMesh::FEMap::compute_single_point_map(), dim, libMesh::MeshTools::Subdivision::find_one_ring(), libMesh::Elem::has_affine_map(), libMesh::libmesh_assert(), libMesh::Elem::n_nodes(), libMesh::Elem::node_index_range(), libMesh::Elem::node_ptr(), libMesh::FEMap::resize_quadrature_map_vectors(), libMesh::TRI3SUBDIVISION, and libMesh::Elem::type().
|
virtualinherited |
Assign a fake jacobian and some other additional data fields.
Takes the integration weights as input. For use on non-element evaluations.
Definition at line 1358 of file fe_map.C.
References libMesh::FEMap::calculate_d2xyz, libMesh::FEMap::calculate_dxyz, libMesh::FEMap::calculate_xyz, libMesh::FEMap::d2xyzdeta2_map, libMesh::FEMap::d2xyzdetadzeta_map, libMesh::FEMap::d2xyzdxi2_map, libMesh::FEMap::d2xyzdxideta_map, libMesh::FEMap::d2xyzdxidzeta_map, libMesh::FEMap::d2xyzdzeta2_map, libMesh::FEMap::detadx_map, libMesh::FEMap::detady_map, libMesh::FEMap::detadz_map, dim, libMesh::FEMap::dxidx_map, libMesh::FEMap::dxidy_map, libMesh::FEMap::dxidz_map, libMesh::FEMap::dxyzdeta_map, libMesh::FEMap::dxyzdxi_map, libMesh::FEMap::dxyzdzeta_map, libMesh::FEMap::dzetadx_map, libMesh::FEMap::dzetady_map, libMesh::FEMap::dzetadz_map, libMesh::FEMap::jac, libMesh::FEMap::JxW, libMesh::FEMap::resize_quadrature_map_vectors(), and libMesh::FEMap::xyz.
Referenced by libMesh::FEMap::compute_map().
|
inherited |
Compute the jacobian and some other additional data fields at the single point with index p.
Takes the integration weights as input, along with a pointer to the element and a list of points that contribute to the element. Also takes a boolean flag telling whether second derivatives should actually be computed.
Definition at line 446 of file fe_map.C.
References A, libMesh::FEMap::calculate_d2xyz, libMesh::FEMap::calculate_dxyz, libMesh::FEMap::calculate_xyz, libMesh::FEMap::calculations_started, libMesh::FEMap::compute_inverse_map_second_derivs(), libMesh::FEMap::d2etadxyz2_map, libMesh::FEMap::d2phideta2_map, libMesh::FEMap::d2phidetadzeta_map, libMesh::FEMap::d2phidxi2_map, libMesh::FEMap::d2phidxideta_map, libMesh::FEMap::d2phidxidzeta_map, libMesh::FEMap::d2phidzeta2_map, libMesh::FEMap::d2xidxyz2_map, libMesh::FEMap::d2xyzdeta2_map, libMesh::FEMap::d2xyzdetadzeta_map, libMesh::FEMap::d2xyzdxi2_map, libMesh::FEMap::d2xyzdxideta_map, libMesh::FEMap::d2xyzdxidzeta_map, libMesh::FEMap::d2xyzdzeta2_map, libMesh::FEMap::d2zetadxyz2_map, libMesh::FEMap::detadx_map, libMesh::FEMap::detady_map, libMesh::FEMap::detadz_map, dim, libMesh::FEMap::dphideta_map, libMesh::FEMap::dphidxi_map, libMesh::FEMap::dphidzeta_map, libMesh::FEMap::dxdeta_map(), libMesh::FEMap::dxdxi_map(), libMesh::FEMap::dxdzeta_map(), libMesh::FEMap::dxidx_map, libMesh::FEMap::dxidy_map, libMesh::FEMap::dxidz_map, libMesh::FEMap::dxyzdeta_map, libMesh::FEMap::dxyzdxi_map, libMesh::FEMap::dxyzdzeta_map, libMesh::FEMap::dydeta_map(), libMesh::FEMap::dydxi_map(), libMesh::FEMap::dydzeta_map(), libMesh::FEMap::dzdeta_map(), libMesh::FEMap::dzdxi_map(), libMesh::FEMap::dzdzeta_map(), libMesh::FEMap::dzetadx_map, libMesh::FEMap::dzetady_map, libMesh::FEMap::dzetadz_map, libMesh::err, libMesh::DofObject::id(), libMesh::index_range(), libMesh::FEMap::jac, libMesh::FEMap::jacobian_tolerance, libMesh::FEMap::JxW, libMesh::libmesh_assert(), libMesh::FEMap::phi_map, libMesh::Elem::print_info(), libMesh::Real, std::sqrt(), libMesh::DenseMatrix< T >::vector_mult(), and libMesh::FEMap::xyz.
Referenced by libMesh::FEMap::compute_affine_map(), and libMesh::FEMap::compute_map().
|
inlineprotectedinherited |
Determine which values are to be calculated.
Definition at line 621 of file fe_map.h.
References libMesh::FEMap::calculate_d2xyz, libMesh::FEMap::calculate_dxyz, and libMesh::FEMap::calculations_started.
Referenced by libMesh::FEMap::compute_edge_map(), libMesh::FEMap::compute_face_map(), libMesh::FEMap::init_edge_shape_functions(), libMesh::FEMap::init_face_shape_functions(), libMesh::FEMap::init_reference_to_physical_map(), and libMesh::FEMap::resize_quadrature_map_vectors().
Used in FEMap::compute_map()
, which should be be usable in derived classes, and therefore protected.
Definition at line 667 of file fe_map.h.
References libMesh::FEMap::dxyzdeta_map.
Referenced by compute_face_map(), libMesh::FEMap::compute_face_map(), and libMesh::FEMap::compute_single_point_map().
Used in FEMap::compute_map()
, which should be be usable in derived classes, and therefore protected.
Definition at line 643 of file fe_map.h.
References libMesh::FEMap::dxyzdxi_map.
Referenced by libMesh::FEMap::compute_edge_map(), compute_face_map(), libMesh::FEMap::compute_face_map(), and libMesh::FEMap::compute_single_point_map().
Used in FEMap::compute_map()
, which should be be usable in derived classes, and therefore protected.
Definition at line 691 of file fe_map.h.
References libMesh::FEMap::dxyzdzeta_map.
Referenced by libMesh::FEMap::compute_single_point_map().
Used in FEMap::compute_map()
, which should be be usable in derived classes, and therefore protected.
Definition at line 675 of file fe_map.h.
References libMesh::FEMap::dxyzdeta_map.
Referenced by compute_face_map(), libMesh::FEMap::compute_face_map(), and libMesh::FEMap::compute_single_point_map().
Used in FEMap::compute_map()
, which should be be usable in derived classes, and therefore protected.
Definition at line 651 of file fe_map.h.
References libMesh::FEMap::dxyzdxi_map.
Referenced by libMesh::FEMap::compute_edge_map(), compute_face_map(), libMesh::FEMap::compute_face_map(), and libMesh::FEMap::compute_single_point_map().
Used in FEMap::compute_map()
, which should be be usable in derived classes, and therefore protected.
Definition at line 699 of file fe_map.h.
References libMesh::FEMap::dxyzdzeta_map.
Referenced by libMesh::FEMap::compute_single_point_map().
Used in FEMap::compute_map()
, which should be be usable in derived classes, and therefore protected.
Definition at line 683 of file fe_map.h.
References libMesh::FEMap::dxyzdeta_map.
Referenced by compute_face_map(), libMesh::FEMap::compute_face_map(), and libMesh::FEMap::compute_single_point_map().
Used in FEMap::compute_map()
, which should be be usable in derived classes, and therefore protected.
Definition at line 659 of file fe_map.h.
References libMesh::FEMap::dxyzdxi_map.
Referenced by libMesh::FEMap::compute_edge_map(), compute_face_map(), libMesh::FEMap::compute_face_map(), and libMesh::FEMap::compute_single_point_map().
Used in FEMap::compute_map()
, which should be be usable in derived classes, and therefore protected.
Definition at line 707 of file fe_map.h.
References libMesh::FEMap::dxyzdzeta_map.
Referenced by libMesh::FEMap::compute_single_point_map().
|
inlineinherited |
Definition at line 432 of file fe_map.h.
References libMesh::FEMap::calculate_d2xyz, libMesh::FEMap::calculations_started, libMesh::FEMap::curvatures, and libMesh::libmesh_assert().
|
inlineinherited |
Second derivatives of "eta" reference coordinate wrt physical coordinates.
Definition at line 367 of file fe_map.h.
References libMesh::FEMap::calculate_d2xyz, libMesh::FEMap::calculations_started, libMesh::FEMap::d2etadxyz2_map, and libMesh::libmesh_assert().
Referenced by libMesh::H1FETransformation< OutputShape >::map_d2phi().
|
inlineinherited |
Definition at line 581 of file fe_map.h.
References libMesh::FEMap::calculate_d2xyz, libMesh::FEMap::calculations_started, libMesh::FEMap::d2phideta2_map, and libMesh::libmesh_assert().
|
inlineinherited |
Definition at line 588 of file fe_map.h.
References libMesh::FEMap::calculate_d2xyz, libMesh::FEMap::calculations_started, libMesh::FEMap::d2phidetadzeta_map, and libMesh::libmesh_assert().
|
inlineinherited |
Definition at line 560 of file fe_map.h.
References libMesh::FEMap::calculate_d2xyz, libMesh::FEMap::calculations_started, libMesh::FEMap::d2phidxi2_map, and libMesh::libmesh_assert().
|
inlineinherited |
Definition at line 567 of file fe_map.h.
References libMesh::FEMap::calculate_d2xyz, libMesh::FEMap::calculations_started, libMesh::FEMap::d2phidxideta_map, and libMesh::libmesh_assert().
|
inlineinherited |
Definition at line 574 of file fe_map.h.
References libMesh::FEMap::calculate_d2xyz, libMesh::FEMap::calculations_started, libMesh::FEMap::d2phidxidzeta_map, and libMesh::libmesh_assert().
|
inlineinherited |
Definition at line 595 of file fe_map.h.
References libMesh::FEMap::calculate_d2xyz, libMesh::FEMap::calculations_started, libMesh::FEMap::d2phidzeta2_map, and libMesh::libmesh_assert().
|
inlineinherited |
Definition at line 514 of file fe_map.h.
References libMesh::FEMap::calculate_d2xyz, libMesh::FEMap::calculations_started, libMesh::FEMap::d2psideta2_map, and libMesh::libmesh_assert().
|
inlineinherited |
Definition at line 522 of file fe_map.h.
References libMesh::FEMap::calculate_d2xyz, libMesh::FEMap::calculations_started, libMesh::FEMap::d2psideta2_map, and libMesh::libmesh_assert().
|
inlineinherited |
Definition at line 486 of file fe_map.h.
References libMesh::FEMap::calculate_d2xyz, libMesh::FEMap::calculations_started, libMesh::FEMap::d2psidxi2_map, and libMesh::libmesh_assert().
|
inlineinherited |
Definition at line 493 of file fe_map.h.
References libMesh::FEMap::calculate_d2xyz, libMesh::FEMap::calculations_started, libMesh::FEMap::d2psidxi2_map, and libMesh::libmesh_assert().
|
inlineinherited |
Definition at line 500 of file fe_map.h.
References libMesh::FEMap::calculate_d2xyz, libMesh::FEMap::calculations_started, libMesh::FEMap::d2psidxideta_map, and libMesh::libmesh_assert().
|
inlineinherited |
Definition at line 507 of file fe_map.h.
References libMesh::FEMap::calculate_d2xyz, libMesh::FEMap::calculations_started, libMesh::FEMap::d2psidxideta_map, and libMesh::libmesh_assert().
|
inlineinherited |
Second derivatives of "xi" reference coordinate wrt physical coordinates.
Definition at line 360 of file fe_map.h.
References libMesh::FEMap::calculate_d2xyz, libMesh::FEMap::calculations_started, libMesh::FEMap::d2xidxyz2_map, and libMesh::libmesh_assert().
Referenced by libMesh::HCurlFETransformation< OutputShape >::init_map_d2phi(), libMesh::H1FETransformation< OutputShape >::init_map_d2phi(), and libMesh::H1FETransformation< OutputShape >::map_d2phi().
|
inlineinherited |
Definition at line 250 of file fe_map.h.
References libMesh::FEMap::calculate_d2xyz, libMesh::FEMap::calculations_started, libMesh::FEMap::d2xyzdeta2_map, and libMesh::libmesh_assert().
|
inlineinherited |
Definition at line 278 of file fe_map.h.
References libMesh::FEMap::calculate_d2xyz, libMesh::FEMap::calculations_started, libMesh::FEMap::d2xyzdetadzeta_map, and libMesh::libmesh_assert().
|
inlineinherited |
Definition at line 243 of file fe_map.h.
References libMesh::FEMap::calculate_d2xyz, libMesh::FEMap::calculations_started, libMesh::FEMap::d2xyzdxi2_map, and libMesh::libmesh_assert().
|
inlineinherited |
Definition at line 264 of file fe_map.h.
References libMesh::FEMap::calculate_d2xyz, libMesh::FEMap::calculations_started, libMesh::FEMap::d2xyzdxideta_map, and libMesh::libmesh_assert().
|
inlineinherited |
Definition at line 271 of file fe_map.h.
References libMesh::FEMap::calculate_d2xyz, libMesh::FEMap::calculations_started, libMesh::FEMap::d2xyzdxidzeta_map, and libMesh::libmesh_assert().
|
inlineinherited |
Definition at line 257 of file fe_map.h.
References libMesh::FEMap::calculate_d2xyz, libMesh::FEMap::calculations_started, libMesh::FEMap::d2xyzdzeta2_map, and libMesh::libmesh_assert().
|
inlineinherited |
Second derivatives of "zeta" reference coordinate wrt physical coordinates.
Definition at line 374 of file fe_map.h.
References libMesh::FEMap::calculate_d2xyz, libMesh::FEMap::calculations_started, libMesh::FEMap::d2zetadxyz2_map, and libMesh::libmesh_assert().
Referenced by libMesh::H1FETransformation< OutputShape >::map_d2phi().
|
inlineinherited |
Definition at line 312 of file fe_map.h.
References libMesh::FEMap::calculate_dxyz, libMesh::FEMap::calculations_started, libMesh::FEMap::detadx_map, and libMesh::libmesh_assert().
Referenced by libMesh::H1FETransformation< OutputShape >::map_curl(), libMesh::H1FETransformation< OutputShape >::map_d2phi(), libMesh::H1FETransformation< OutputShape >::map_div(), libMesh::H1FETransformation< OutputShape >::map_dphi(), and libMesh::HCurlFETransformation< OutputShape >::map_phi().
|
inlineinherited |
Definition at line 320 of file fe_map.h.
References libMesh::FEMap::calculate_dxyz, libMesh::FEMap::calculations_started, libMesh::FEMap::detady_map, and libMesh::libmesh_assert().
Referenced by libMesh::H1FETransformation< OutputShape >::map_curl(), libMesh::H1FETransformation< OutputShape >::map_d2phi(), libMesh::H1FETransformation< OutputShape >::map_div(), libMesh::H1FETransformation< OutputShape >::map_dphi(), and libMesh::HCurlFETransformation< OutputShape >::map_phi().
|
inlineinherited |
Definition at line 328 of file fe_map.h.
References libMesh::FEMap::calculate_dxyz, libMesh::FEMap::calculations_started, libMesh::FEMap::detadz_map, and libMesh::libmesh_assert().
Referenced by libMesh::H1FETransformation< OutputShape >::map_curl(), libMesh::H1FETransformation< OutputShape >::map_d2phi(), libMesh::H1FETransformation< OutputShape >::map_div(), libMesh::H1FETransformation< OutputShape >::map_dphi(), and libMesh::HCurlFETransformation< OutputShape >::map_phi().
|
inlineinherited |
Definition at line 545 of file fe_map.h.
References libMesh::FEMap::calculate_dxyz, libMesh::FEMap::calculations_started, libMesh::FEMap::dphideta_map, and libMesh::libmesh_assert().
|
inlineinherited |
Definition at line 402 of file fe_map.h.
References libMesh::FEMap::calculate_dxyz, libMesh::FEMap::calculations_started, libMesh::FEMap::dphideta_map, and libMesh::libmesh_assert().
|
inlineinherited |
Definition at line 538 of file fe_map.h.
References libMesh::FEMap::calculate_dxyz, libMesh::FEMap::calculations_started, libMesh::FEMap::dphidxi_map, and libMesh::libmesh_assert().
|
inlineinherited |
Definition at line 395 of file fe_map.h.
References libMesh::FEMap::calculate_dxyz, libMesh::FEMap::calculations_started, libMesh::FEMap::dphidxi_map, and libMesh::libmesh_assert().
|
inlineinherited |
Definition at line 552 of file fe_map.h.
References libMesh::FEMap::calculate_dxyz, libMesh::FEMap::calculations_started, libMesh::FEMap::dphidzeta_map, and libMesh::libmesh_assert().
|
inlineinherited |
Definition at line 409 of file fe_map.h.
References libMesh::FEMap::calculate_dxyz, libMesh::FEMap::calculations_started, libMesh::FEMap::dphidzeta_map, and libMesh::libmesh_assert().
|
inlineinherited |
Definition at line 473 of file fe_map.h.
References libMesh::FEMap::calculate_dxyz, libMesh::FEMap::calculations_started, libMesh::FEMap::dpsideta_map, and libMesh::libmesh_assert().
|
inlineinherited |
Definition at line 477 of file fe_map.h.
References libMesh::FEMap::calculate_dxyz, libMesh::FEMap::calculations_started, libMesh::FEMap::dpsideta_map, and libMesh::libmesh_assert().
|
inlineinherited |
Definition at line 462 of file fe_map.h.
References libMesh::FEMap::calculate_dxyz, libMesh::FEMap::calculations_started, libMesh::FEMap::dpsidxi_map, and libMesh::libmesh_assert().
|
inlineinherited |
Definition at line 466 of file fe_map.h.
References libMesh::FEMap::calculate_dxyz, libMesh::FEMap::calculations_started, libMesh::FEMap::dpsidxi_map, and libMesh::libmesh_assert().
|
inlineinherited |
Definition at line 288 of file fe_map.h.
References libMesh::FEMap::calculate_dxyz, libMesh::FEMap::calculations_started, libMesh::FEMap::dxidx_map, and libMesh::libmesh_assert().
Referenced by libMesh::HCurlFETransformation< OutputShape >::init_map_d2phi(), libMesh::H1FETransformation< OutputShape >::init_map_d2phi(), libMesh::HCurlFETransformation< OutputShape >::init_map_dphi(), libMesh::H1FETransformation< OutputShape >::init_map_dphi(), libMesh::HCurlFETransformation< OutputShape >::init_map_phi(), libMesh::H1FETransformation< OutputShape >::map_curl(), libMesh::H1FETransformation< OutputShape >::map_d2phi(), libMesh::H1FETransformation< OutputShape >::map_div(), libMesh::H1FETransformation< OutputShape >::map_dphi(), and libMesh::HCurlFETransformation< OutputShape >::map_phi().
|
inlineinherited |
Definition at line 296 of file fe_map.h.
References libMesh::FEMap::calculate_dxyz, libMesh::FEMap::calculations_started, libMesh::FEMap::dxidy_map, and libMesh::libmesh_assert().
Referenced by libMesh::H1FETransformation< OutputShape >::map_curl(), libMesh::H1FETransformation< OutputShape >::map_d2phi(), libMesh::H1FETransformation< OutputShape >::map_div(), libMesh::H1FETransformation< OutputShape >::map_dphi(), and libMesh::HCurlFETransformation< OutputShape >::map_phi().
|
inlineinherited |
Definition at line 304 of file fe_map.h.
References libMesh::FEMap::calculate_dxyz, libMesh::FEMap::calculations_started, libMesh::FEMap::dxidz_map, and libMesh::libmesh_assert().
Referenced by libMesh::H1FETransformation< OutputShape >::map_curl(), libMesh::H1FETransformation< OutputShape >::map_d2phi(), libMesh::H1FETransformation< OutputShape >::map_div(), libMesh::H1FETransformation< OutputShape >::map_dphi(), and libMesh::HCurlFETransformation< OutputShape >::map_phi().
|
inlineinherited |
Definition at line 226 of file fe_map.h.
References libMesh::FEMap::calculate_dxyz, libMesh::FEMap::calculations_started, libMesh::FEMap::dxyzdeta_map, and libMesh::libmesh_assert().
Referenced by libMesh::HCurlFETransformation< OutputShape >::map_curl().
|
inlineinherited |
Definition at line 218 of file fe_map.h.
References libMesh::FEMap::calculate_dxyz, libMesh::FEMap::calculations_started, libMesh::FEMap::dxyzdxi_map, and libMesh::libmesh_assert().
Referenced by libMesh::HCurlFETransformation< OutputShape >::map_curl().
|
inlineinherited |
Definition at line 234 of file fe_map.h.
References libMesh::FEMap::calculate_dxyz, libMesh::FEMap::calculations_started, libMesh::FEMap::dxyzdzeta_map, and libMesh::libmesh_assert().
Referenced by libMesh::HCurlFETransformation< OutputShape >::map_curl().
|
inlineinherited |
Definition at line 336 of file fe_map.h.
References libMesh::FEMap::calculate_dxyz, libMesh::FEMap::calculations_started, libMesh::FEMap::dzetadx_map, and libMesh::libmesh_assert().
Referenced by libMesh::H1FETransformation< OutputShape >::map_curl(), libMesh::H1FETransformation< OutputShape >::map_d2phi(), libMesh::H1FETransformation< OutputShape >::map_div(), libMesh::H1FETransformation< OutputShape >::map_dphi(), and libMesh::HCurlFETransformation< OutputShape >::map_phi().
|
inlineinherited |
Definition at line 344 of file fe_map.h.
References libMesh::FEMap::calculate_dxyz, libMesh::FEMap::calculations_started, libMesh::FEMap::dzetady_map, and libMesh::libmesh_assert().
Referenced by libMesh::H1FETransformation< OutputShape >::map_curl(), libMesh::H1FETransformation< OutputShape >::map_d2phi(), libMesh::H1FETransformation< OutputShape >::map_div(), libMesh::H1FETransformation< OutputShape >::map_dphi(), and libMesh::HCurlFETransformation< OutputShape >::map_phi().
|
inlineinherited |
Definition at line 352 of file fe_map.h.
References libMesh::FEMap::calculate_dxyz, libMesh::FEMap::calculations_started, libMesh::FEMap::dzetadz_map, and libMesh::libmesh_assert().
Referenced by libMesh::H1FETransformation< OutputShape >::map_curl(), libMesh::H1FETransformation< OutputShape >::map_d2phi(), libMesh::H1FETransformation< OutputShape >::map_div(), libMesh::H1FETransformation< OutputShape >::map_dphi(), and libMesh::HCurlFETransformation< OutputShape >::map_phi().
|
inlineinherited |
Definition at line 202 of file fe_map.h.
References libMesh::FEMap::calculate_dxyz, libMesh::FEMap::calculations_started, libMesh::FEMap::jac, and libMesh::libmesh_assert().
Referenced by libMesh::HCurlFETransformation< OutputShape >::map_curl().
|
inlineinherited |
Definition at line 606 of file fe_map.h.
References libMesh::FEMap::calculate_dxyz, libMesh::FEMap::calculations_started, libMesh::FEMap::JxW, and libMesh::libmesh_assert().
|
inlineinherited |
Definition at line 210 of file fe_map.h.
References libMesh::FEMap::calculate_dxyz, libMesh::FEMap::calculations_started, libMesh::FEMap::JxW, and libMesh::libmesh_assert().
|
inlineinherited |
Definition at line 423 of file fe_map.h.
References libMesh::FEMap::calculate_dxyz, libMesh::FEMap::calculations_started, libMesh::libmesh_assert(), and libMesh::FEMap::normals.
|
inlineinherited |
Definition at line 531 of file fe_map.h.
References libMesh::FEMap::calculate_xyz, libMesh::FEMap::calculations_started, libMesh::libmesh_assert(), and libMesh::FEMap::phi_map.
|
inlineinherited |
Definition at line 388 of file fe_map.h.
References libMesh::FEMap::calculate_xyz, libMesh::FEMap::calculations_started, libMesh::libmesh_assert(), and libMesh::FEMap::phi_map.
|
inlineinherited |
Definition at line 456 of file fe_map.h.
References libMesh::FEMap::psi_map.
|
inlineinherited |
Definition at line 382 of file fe_map.h.
References libMesh::FEMap::psi_map.
|
inlineinherited |
Definition at line 416 of file fe_map.h.
References libMesh::FEMap::calculate_dxyz, libMesh::FEMap::calculations_started, libMesh::libmesh_assert(), and libMesh::FEMap::tangents.
|
inlineinherited |
xyz
spatial locations of the quadrature points on the element. Definition at line 195 of file fe_map.h.
References libMesh::FEMap::calculate_xyz, libMesh::FEMap::calculations_started, libMesh::libmesh_assert(), and libMesh::FEMap::xyz.
|
inherited |
Same as before, but for an edge.
This is used for some projection operators.
Definition at line 510 of file fe_boundary.C.
References libMesh::FEMap::calculate_d2xyz, libMesh::FEMap::calculate_dxyz, libMesh::FEMap::calculate_xyz, libMesh::FEMap::d2psidxi2_map, libMesh::Elem::default_order(), libMesh::FEMap::determine_calculations(), libMesh::FEMap::dpsidxi_map, libMesh::libmesh_assert(), libMesh::FEMap::map_fe_type(), libMesh::FEInterface::n_shape_functions(), libMesh::FEMap::psi_map, libMesh::FEInterface::shape_deriv_function(), libMesh::FEInterface::shape_function(), libMesh::FEInterface::shape_second_deriv_function(), and libMesh::Elem::type().
|
inherited |
Initializes the reference to physical element map for a side.
This is used for boundary integration.
Definition at line 381 of file fe_boundary.C.
References libMesh::FEMap::calculate_d2xyz, libMesh::FEMap::calculate_dxyz, libMesh::FEMap::calculate_xyz, libMesh::FEMap::d2psideta2_map, libMesh::FEMap::d2psidxi2_map, libMesh::FEMap::d2psidxideta_map, libMesh::Elem::default_order(), libMesh::FEMap::determine_calculations(), libMesh::FEMap::dpsideta_map, libMesh::FEMap::dpsidxi_map, libMesh::libmesh_assert(), libMesh::FEMap::map_fe_type(), libMesh::FEInterface::n_shape_functions(), libMesh::FEMap::psi_map, libMesh::FEInterface::shape_deriv_function(), libMesh::FEInterface::shape_function(), libMesh::FEInterface::shape_second_deriv_function(), and libMesh::Elem::type().
|
inherited |
Definition at line 91 of file fe_map.C.
References libMesh::FEMap::calculate_d2xyz, libMesh::FEMap::calculate_dxyz, libMesh::FEMap::calculate_xyz, libMesh::FEMap::d2phideta2_map, libMesh::FEMap::d2phidetadzeta_map, libMesh::FEMap::d2phidxi2_map, libMesh::FEMap::d2phidxideta_map, libMesh::FEMap::d2phidxidzeta_map, libMesh::FEMap::d2phidzeta2_map, libMesh::Elem::default_order(), libMesh::FEMap::determine_calculations(), libMesh::FEMap::dphideta_map, libMesh::FEMap::dphidxi_map, libMesh::FEMap::dphidzeta_map, libMesh::Elem::infinite(), libMesh::Elem::is_linear(), libMesh::FEMap::map_fe_type(), libMesh::FEInterface::n_shape_functions(), libMesh::FEMap::phi_map, libMesh::FEInterface::shape_deriv_function(), libMesh::FEInterface::shape_function(), libMesh::FEInterface::shape_second_deriv_function(), and libMesh::Elem::type().
|
staticinherited |
p
located in physical space. This function requires inverting the (possibly nonlinear) transformation map, so it is not trivial. The optional parameter tolerance
defines how close is "good enough." The map inversion iteration computes the sequence \( \{ p_n \} \), and the iteration is terminated when \( \|p - p_n\| < \mbox{\texttt{tolerance}} \) The parameter secure (always assumed false in non-debug mode) switches on integrity-checks on the mapped points. Definition at line 1622 of file fe_map.C.
References libMesh::TypeVector< T >::add(), dim, libMesh::err, libMesh::DofObject::id(), libMesh::Elem::infinite(), libMesh::InfFEMap::inverse_map(), libMesh::libmesh_assert(), libMesh::FEMap::map(), libMesh::FEMap::map_deriv(), libMesh::TypeVector< T >::norm(), libMesh::FEAbstract::on_reference_element(), libMesh::Elem::print_info(), libMesh::Real, and libMesh::Elem::type().
Referenced by libMesh::HPCoarsenTest::add_projection(), assemble_ellipticdg(), assemble_poisson(), libMesh::FEMContext::build_new_fe(), libMesh::FEGenericBase< FEOutputType< T >::type >::coarsened_dof_values(), libMesh::FEMap::compute_face_map(), compute_jacobian(), libMesh::FEAbstract::compute_node_constraints(), libMesh::FEGenericBase< FEOutputType< T >::type >::compute_periodic_constraints(), libMesh::FEAbstract::compute_periodic_node_constraints(), libMesh::FEGenericBase< FEOutputType< T >::type >::compute_proj_constraints(), compute_residual(), libMesh::MeshFunction::discontinuous_gradient(), libMesh::MeshFunction::discontinuous_value(), libMesh::FE< Dim, LAGRANGE_VEC >::edge_reinit(), libMesh::DTKEvaluator::evaluate(), libMesh::MeshFunction::gradient(), libMesh::MeshFunction::hessian(), libMesh::InfFEMap::inverse_map(), libMesh::FEMap::inverse_map(), libMesh::FE< Dim, LAGRANGE_VEC >::inverse_map(), libMesh::DGFEMContext::neighbor_side_fe_reinit(), libMesh::MeshFunction::operator()(), libMesh::GenericProjector< FFunctor, GFunctor, FValue, ProjectionAction >::ProjectEdges::operator()(), libMesh::GenericProjector< FFunctor, GFunctor, FValue, ProjectionAction >::ProjectSides::operator()(), libMesh::GenericProjector< FFunctor, GFunctor, FValue, ProjectionAction >::ProjectInteriors::operator()(), libMesh::System::point_gradient(), libMesh::System::point_hessian(), libMesh::Elem::point_test(), libMesh::System::point_value(), libMesh::JumpErrorEstimator::reinit_sides(), libMesh::HPCoarsenTest::select_refinement(), NavierSystem::side_constraint(), FETest< order, family, elem_type >::testGradU(), FETest< order, family, elem_type >::testGradUComp(), and FETest< order, family, elem_type >::testU().
|
staticinherited |
Takes a number points in physical space (in the physical_points
vector) and finds their location on the reference element for the input element elem
.
The values on the reference element are returned in the vector reference_points
. The optional parameter tolerance
defines how close is "good enough." The map inversion iteration computes the sequence \( \{ p_n \} \), and the iteration is terminated when \( \|p - p_n\| < \mbox{\texttt{tolerance}} \) The parameter secure (always assumed false in non-debug mode) switches on integrity-checks on the mapped points.
Definition at line 2010 of file fe_map.C.
References dim, libMesh::Elem::infinite(), libMesh::InfFEMap::inverse_map(), and libMesh::FEMap::inverse_map().
|
staticinherited |
p
located on the reference element. Definition at line 2043 of file fe_map.C.
References libMesh::TypeVector< T >::add_scaled(), libMesh::Elem::default_order(), dim, libMesh::Elem::infinite(), libMesh::libmesh_assert(), libMesh::InfFEMap::map(), libMesh::FEMap::map_fe_type(), libMesh::FEInterface::n_shape_functions(), libMesh::Elem::point(), libMesh::FEInterface::shape_function(), and libMesh::Elem::type().
Referenced by libMesh::FEMap::inverse_map(), libMesh::InfFEMap::map(), libMesh::FE< Dim, LAGRANGE_VEC >::map(), and libMesh::Elem::point_test().
|
staticinherited |
j
of d(xyz)/d(xi eta zeta) (in physical space) of the point p
located on the reference element. Definition at line 2076 of file fe_map.C.
References libMesh::TypeVector< T >::add_scaled(), libMesh::Elem::default_order(), dim, libMesh::Elem::infinite(), libMesh::libmesh_assert(), libMesh::FEMap::map_fe_type(), libMesh::FEInterface::n_shape_functions(), libMesh::Elem::point(), libMesh::FEInterface::shape_deriv_function(), and libMesh::Elem::type().
Referenced by libMesh::FEMap::compute_face_map(), libMesh::FEMap::inverse_map(), libMesh::FE< Dim, LAGRANGE_VEC >::map_eta(), libMesh::FE< Dim, LAGRANGE_VEC >::map_xi(), and libMesh::FE< Dim, LAGRANGE_VEC >::map_zeta().
Definition at line 47 of file fe_map.C.
References libMesh::LAGRANGE, libMesh::LAGRANGE_MAP, libMesh::Elem::mapping_type(), libMesh::RATIONAL_BERNSTEIN, and libMesh::RATIONAL_BERNSTEIN_MAP.
Referenced by libMesh::FEMContext::_do_elem_position_set(), libMesh::FEMap::compute_face_map(), libMesh::FEAbstract::compute_node_constraints(), libMesh::FEAbstract::compute_periodic_node_constraints(), libMesh::FEMContext::elem_position_get(), libMesh::FEMap::init_edge_shape_functions(), libMesh::FEMap::init_face_shape_functions(), libMesh::FEMap::init_reference_to_physical_map(), libMesh::FEMap::map(), libMesh::FEMap::map_deriv(), and libMesh::Elem::volume().
|
inherited |
Prints the Jacobian times the weight for each quadrature point.
Definition at line 1486 of file fe_map.C.
References libMesh::index_range(), and libMesh::FEMap::JxW.
|
inherited |
Prints the spatial location of each quadrature point (on the physical element).
Definition at line 1494 of file fe_map.C.
References libMesh::index_range(), and libMesh::FEMap::xyz.
|
protectedinherited |
A utility function for use by compute_*_map.
Definition at line 1196 of file fe_map.C.
References libMesh::FEMap::calculate_d2xyz, libMesh::FEMap::calculate_dxyz, libMesh::FEMap::calculate_xyz, libMesh::FEMap::d2etadxyz2_map, libMesh::FEMap::d2xidxyz2_map, libMesh::FEMap::d2xyzdeta2_map, libMesh::FEMap::d2xyzdetadzeta_map, libMesh::FEMap::d2xyzdxi2_map, libMesh::FEMap::d2xyzdxideta_map, libMesh::FEMap::d2xyzdxidzeta_map, libMesh::FEMap::d2xyzdzeta2_map, libMesh::FEMap::d2zetadxyz2_map, libMesh::FEMap::detadx_map, libMesh::FEMap::detady_map, libMesh::FEMap::detadz_map, libMesh::FEMap::determine_calculations(), dim, libMesh::FEMap::dxidx_map, libMesh::FEMap::dxidy_map, libMesh::FEMap::dxidz_map, libMesh::FEMap::dxyzdeta_map, libMesh::FEMap::dxyzdxi_map, libMesh::FEMap::dxyzdzeta_map, libMesh::FEMap::dzetadx_map, libMesh::FEMap::dzetady_map, libMesh::FEMap::dzetadz_map, libMesh::index_range(), libMesh::FEMap::jac, libMesh::FEMap::JxW, and libMesh::FEMap::xyz.
Referenced by libMesh::FEMap::compute_affine_map(), libMesh::FEMap::compute_map(), and libMesh::FEMap::compute_null_map().
|
inlineinherited |
Set the Jacobian tolerance used for determining when the mapping fails.
The mapping is determined to fail if jac <= jacobian_tolerance.
Definition at line 614 of file fe_map.h.
References libMesh::FEMap::jacobian_tolerance.
|
privateinherited |
Work vector for compute_affine_map()
Definition at line 1023 of file fe_map.h.
Referenced by libMesh::FEMap::compute_affine_map(), and libMesh::FEMap::compute_map().
|
mutableprotectedinherited |
Should we calculate mapping hessians?
Definition at line 995 of file fe_map.h.
Referenced by libMesh::FEMap::compute_affine_map(), libMesh::FEMap::compute_edge_map(), libMesh::FEMap::compute_face_map(), libMesh::FEMap::compute_null_map(), libMesh::FEMap::compute_single_point_map(), libMesh::FEMap::determine_calculations(), libMesh::FEMap::get_curvatures(), libMesh::FEMap::get_d2etadxyz2(), libMesh::FEMap::get_d2phideta2_map(), libMesh::FEMap::get_d2phidetadzeta_map(), libMesh::FEMap::get_d2phidxi2_map(), libMesh::FEMap::get_d2phidxideta_map(), libMesh::FEMap::get_d2phidxidzeta_map(), libMesh::FEMap::get_d2phidzeta2_map(), libMesh::FEMap::get_d2psideta2(), libMesh::FEMap::get_d2psidxi2(), libMesh::FEMap::get_d2psidxideta(), libMesh::FEMap::get_d2xidxyz2(), libMesh::FEMap::get_d2xyzdeta2(), libMesh::FEMap::get_d2xyzdetadzeta(), libMesh::FEMap::get_d2xyzdxi2(), libMesh::FEMap::get_d2xyzdxideta(), libMesh::FEMap::get_d2xyzdxidzeta(), libMesh::FEMap::get_d2xyzdzeta2(), libMesh::FEMap::get_d2zetadxyz2(), libMesh::FEMap::init_edge_shape_functions(), libMesh::FEMap::init_face_shape_functions(), libMesh::FEMap::init_reference_to_physical_map(), and libMesh::FEMap::resize_quadrature_map_vectors().
|
mutableprotectedinherited |
Should we calculate mapping gradients?
Definition at line 988 of file fe_map.h.
Referenced by libMesh::FEMap::compute_affine_map(), libMesh::FEMap::compute_edge_map(), libMesh::FEMap::compute_face_map(), libMesh::FEMap::compute_null_map(), libMesh::FEMap::compute_single_point_map(), libMesh::FEMap::determine_calculations(), libMesh::FEMap::get_detadx(), libMesh::FEMap::get_detady(), libMesh::FEMap::get_detadz(), libMesh::FEMap::get_dphideta_map(), libMesh::FEMap::get_dphidxi_map(), libMesh::FEMap::get_dphidzeta_map(), libMesh::FEMap::get_dpsideta(), libMesh::FEMap::get_dpsidxi(), libMesh::FEMap::get_dxidx(), libMesh::FEMap::get_dxidy(), libMesh::FEMap::get_dxidz(), libMesh::FEMap::get_dxyzdeta(), libMesh::FEMap::get_dxyzdxi(), libMesh::FEMap::get_dxyzdzeta(), libMesh::FEMap::get_dzetadx(), libMesh::FEMap::get_dzetady(), libMesh::FEMap::get_dzetadz(), libMesh::FEMap::get_jacobian(), libMesh::FEMap::get_JxW(), libMesh::FEMap::get_normals(), libMesh::FEMap::get_tangents(), libMesh::FEMap::init_edge_shape_functions(), libMesh::FEMap::init_face_shape_functions(), libMesh::FEMap::init_reference_to_physical_map(), and libMesh::FEMap::resize_quadrature_map_vectors().
|
mutableprotectedinherited |
Should we calculate physical point locations?
Definition at line 983 of file fe_map.h.
Referenced by libMesh::FEMap::compute_affine_map(), libMesh::FEMap::compute_edge_map(), libMesh::FEMap::compute_face_map(), libMesh::FEMap::compute_null_map(), libMesh::FEMap::compute_single_point_map(), FEXYZMap(), libMesh::FEMap::get_phi_map(), libMesh::FEMap::get_xyz(), libMesh::FEMap::init_edge_shape_functions(), libMesh::FEMap::init_face_shape_functions(), libMesh::FEMap::init_reference_to_physical_map(), and libMesh::FEMap::resize_quadrature_map_vectors().
|
mutableprotectedinherited |
Have calculations with this object already been started? Then all get_* functions should already have been called.
Definition at line 978 of file fe_map.h.
Referenced by libMesh::FEMap::compute_single_point_map(), libMesh::FEMap::determine_calculations(), libMesh::FEMap::get_curvatures(), libMesh::FEMap::get_d2etadxyz2(), libMesh::FEMap::get_d2phideta2_map(), libMesh::FEMap::get_d2phidetadzeta_map(), libMesh::FEMap::get_d2phidxi2_map(), libMesh::FEMap::get_d2phidxideta_map(), libMesh::FEMap::get_d2phidxidzeta_map(), libMesh::FEMap::get_d2phidzeta2_map(), libMesh::FEMap::get_d2psideta2(), libMesh::FEMap::get_d2psidxi2(), libMesh::FEMap::get_d2psidxideta(), libMesh::FEMap::get_d2xidxyz2(), libMesh::FEMap::get_d2xyzdeta2(), libMesh::FEMap::get_d2xyzdetadzeta(), libMesh::FEMap::get_d2xyzdxi2(), libMesh::FEMap::get_d2xyzdxideta(), libMesh::FEMap::get_d2xyzdxidzeta(), libMesh::FEMap::get_d2xyzdzeta2(), libMesh::FEMap::get_d2zetadxyz2(), libMesh::FEMap::get_detadx(), libMesh::FEMap::get_detady(), libMesh::FEMap::get_detadz(), libMesh::FEMap::get_dphideta_map(), libMesh::FEMap::get_dphidxi_map(), libMesh::FEMap::get_dphidzeta_map(), libMesh::FEMap::get_dpsideta(), libMesh::FEMap::get_dpsidxi(), libMesh::FEMap::get_dxidx(), libMesh::FEMap::get_dxidy(), libMesh::FEMap::get_dxidz(), libMesh::FEMap::get_dxyzdeta(), libMesh::FEMap::get_dxyzdxi(), libMesh::FEMap::get_dxyzdzeta(), libMesh::FEMap::get_dzetadx(), libMesh::FEMap::get_dzetady(), libMesh::FEMap::get_dzetadz(), libMesh::FEMap::get_jacobian(), libMesh::FEMap::get_JxW(), libMesh::FEMap::get_normals(), libMesh::FEMap::get_phi_map(), libMesh::FEMap::get_tangents(), and libMesh::FEMap::get_xyz().
|
protectedinherited |
The mean curvature (= one half the sum of the principal curvatures) on the boundary at the quadrature points.
The mean curvature is a scalar value.
Definition at line 960 of file fe_map.h.
Referenced by libMesh::FEMap::compute_edge_map(), compute_face_map(), libMesh::FEMap::compute_face_map(), and libMesh::FEMap::get_curvatures().
|
protectedinherited |
Second derivatives of "eta" reference coordinate wrt physical coordinates.
At each qp: (eta_{xx}, eta_{xy}, eta_{xz}, eta_{yy}, eta_{yz}, eta_{zz})
Definition at line 839 of file fe_map.h.
Referenced by libMesh::FEMap::compute_inverse_map_second_derivs(), libMesh::FEMap::compute_single_point_map(), libMesh::FEMap::get_d2etadxyz2(), and libMesh::FEMap::resize_quadrature_map_vectors().
|
protectedinherited |
Map for the second derivative, d^2(phi)/d(eta)^2.
Definition at line 888 of file fe_map.h.
Referenced by libMesh::FEMap::compute_single_point_map(), libMesh::FEMap::get_d2phideta2_map(), and libMesh::FEMap::init_reference_to_physical_map().
|
protectedinherited |
Map for the second derivative, d^2(phi)/d(eta)d(zeta).
Definition at line 893 of file fe_map.h.
Referenced by libMesh::FEMap::compute_single_point_map(), libMesh::FEMap::get_d2phidetadzeta_map(), and libMesh::FEMap::init_reference_to_physical_map().
|
protectedinherited |
Map for the second derivative, d^2(phi)/d(xi)^2.
Definition at line 873 of file fe_map.h.
Referenced by libMesh::FEMap::compute_single_point_map(), libMesh::FEMap::get_d2phidxi2_map(), and libMesh::FEMap::init_reference_to_physical_map().
|
protectedinherited |
Map for the second derivative, d^2(phi)/d(xi)d(eta).
Definition at line 878 of file fe_map.h.
Referenced by libMesh::FEMap::compute_single_point_map(), libMesh::FEMap::get_d2phidxideta_map(), and libMesh::FEMap::init_reference_to_physical_map().
|
protectedinherited |
Map for the second derivative, d^2(phi)/d(xi)d(zeta).
Definition at line 883 of file fe_map.h.
Referenced by libMesh::FEMap::compute_single_point_map(), libMesh::FEMap::get_d2phidxidzeta_map(), and libMesh::FEMap::init_reference_to_physical_map().
|
protectedinherited |
Map for the second derivative, d^2(phi)/d(zeta)^2.
Definition at line 898 of file fe_map.h.
Referenced by libMesh::FEMap::compute_single_point_map(), libMesh::FEMap::get_d2phidzeta2_map(), and libMesh::FEMap::init_reference_to_physical_map().
|
protectedinherited |
Map for the second derivatives (in eta) of the side shape functions.
Useful for computing the curvature at the quadrature points.
Definition at line 940 of file fe_map.h.
Referenced by compute_face_map(), libMesh::FEMap::compute_face_map(), libMesh::FEMap::get_d2psideta2(), and libMesh::FEMap::init_face_shape_functions().
|
protectedinherited |
Map for the second derivatives (in xi) of the side shape functions.
Useful for computing the curvature at the quadrature points.
Definition at line 926 of file fe_map.h.
Referenced by libMesh::FEMap::compute_edge_map(), compute_face_map(), libMesh::FEMap::compute_face_map(), libMesh::FEMap::get_d2psidxi2(), libMesh::FEMap::init_edge_shape_functions(), and libMesh::FEMap::init_face_shape_functions().
|
protectedinherited |
Map for the second (cross) derivatives in xi, eta of the side shape functions.
Useful for computing the curvature at the quadrature points.
Definition at line 933 of file fe_map.h.
Referenced by compute_face_map(), libMesh::FEMap::compute_face_map(), libMesh::FEMap::get_d2psidxideta(), and libMesh::FEMap::init_face_shape_functions().
|
protectedinherited |
Second derivatives of "xi" reference coordinate wrt physical coordinates.
At each qp: (xi_{xx}, xi_{xy}, xi_{xz}, xi_{yy}, xi_{yz}, xi_{zz})
Definition at line 833 of file fe_map.h.
Referenced by libMesh::FEMap::compute_inverse_map_second_derivs(), libMesh::FEMap::compute_single_point_map(), libMesh::FEMap::get_d2xidxyz2(), and libMesh::FEMap::resize_quadrature_map_vectors().
|
protectedinherited |
Vector of second partial derivatives in eta: d^2(x)/d(eta)^2.
Definition at line 750 of file fe_map.h.
Referenced by libMesh::FEMap::compute_affine_map(), libMesh::FEMap::compute_edge_map(), compute_face_map(), libMesh::FEMap::compute_face_map(), libMesh::FEMap::compute_inverse_map_second_derivs(), libMesh::FEMap::compute_null_map(), libMesh::FEMap::compute_single_point_map(), libMesh::FEMap::get_d2xyzdeta2(), and libMesh::FEMap::resize_quadrature_map_vectors().
|
protectedinherited |
Vector of mixed second partial derivatives in eta-zeta: d^2(x)/d(eta)d(zeta) d^2(y)/d(eta)d(zeta) d^2(z)/d(eta)d(zeta)
Definition at line 762 of file fe_map.h.
Referenced by libMesh::FEMap::compute_affine_map(), libMesh::FEMap::compute_inverse_map_second_derivs(), libMesh::FEMap::compute_null_map(), libMesh::FEMap::compute_single_point_map(), libMesh::FEMap::get_d2xyzdetadzeta(), and libMesh::FEMap::resize_quadrature_map_vectors().
|
protectedinherited |
Vector of second partial derivatives in xi: d^2(x)/d(xi)^2, d^2(y)/d(xi)^2, d^2(z)/d(xi)^2.
Definition at line 738 of file fe_map.h.
Referenced by libMesh::FEMap::compute_affine_map(), libMesh::FEMap::compute_edge_map(), compute_face_map(), libMesh::FEMap::compute_face_map(), libMesh::FEMap::compute_inverse_map_second_derivs(), libMesh::FEMap::compute_null_map(), libMesh::FEMap::compute_single_point_map(), libMesh::FEMap::get_d2xyzdxi2(), and libMesh::FEMap::resize_quadrature_map_vectors().
|
protectedinherited |
Vector of mixed second partial derivatives in xi-eta: d^2(x)/d(xi)d(eta) d^2(y)/d(xi)d(eta) d^2(z)/d(xi)d(eta)
Definition at line 744 of file fe_map.h.
Referenced by libMesh::FEMap::compute_affine_map(), libMesh::FEMap::compute_edge_map(), compute_face_map(), libMesh::FEMap::compute_face_map(), libMesh::FEMap::compute_inverse_map_second_derivs(), libMesh::FEMap::compute_null_map(), libMesh::FEMap::compute_single_point_map(), libMesh::FEMap::get_d2xyzdxideta(), and libMesh::FEMap::resize_quadrature_map_vectors().
|
protectedinherited |
Vector of second partial derivatives in xi-zeta: d^2(x)/d(xi)d(zeta), d^2(y)/d(xi)d(zeta), d^2(z)/d(xi)d(zeta)
Definition at line 756 of file fe_map.h.
Referenced by libMesh::FEMap::compute_affine_map(), libMesh::FEMap::compute_inverse_map_second_derivs(), libMesh::FEMap::compute_null_map(), libMesh::FEMap::compute_single_point_map(), libMesh::FEMap::get_d2xyzdxidzeta(), and libMesh::FEMap::resize_quadrature_map_vectors().
|
protectedinherited |
Vector of second partial derivatives in zeta: d^2(x)/d(zeta)^2.
Definition at line 768 of file fe_map.h.
Referenced by libMesh::FEMap::compute_affine_map(), libMesh::FEMap::compute_inverse_map_second_derivs(), libMesh::FEMap::compute_null_map(), libMesh::FEMap::compute_single_point_map(), libMesh::FEMap::get_d2xyzdzeta2(), and libMesh::FEMap::resize_quadrature_map_vectors().
|
protectedinherited |
Second derivatives of "zeta" reference coordinate wrt physical coordinates.
At each qp: (zeta_{xx}, zeta_{xy}, zeta_{xz}, zeta_{yy}, zeta_{yz}, zeta_{zz})
Definition at line 845 of file fe_map.h.
Referenced by libMesh::FEMap::compute_inverse_map_second_derivs(), libMesh::FEMap::compute_single_point_map(), libMesh::FEMap::get_d2zetadxyz2(), and libMesh::FEMap::resize_quadrature_map_vectors().
|
protectedinherited |
Map for partial derivatives: d(eta)/d(x).
Needed for the Jacobian.
Definition at line 795 of file fe_map.h.
Referenced by libMesh::FEMap::compute_affine_map(), libMesh::FEMap::compute_inverse_map_second_derivs(), libMesh::FEMap::compute_null_map(), libMesh::FEMap::compute_single_point_map(), libMesh::FEMap::get_detadx(), and libMesh::FEMap::resize_quadrature_map_vectors().
|
protectedinherited |
Map for partial derivatives: d(eta)/d(y).
Needed for the Jacobian.
Definition at line 801 of file fe_map.h.
Referenced by libMesh::FEMap::compute_affine_map(), libMesh::FEMap::compute_inverse_map_second_derivs(), libMesh::FEMap::compute_null_map(), libMesh::FEMap::compute_single_point_map(), libMesh::FEMap::get_detady(), and libMesh::FEMap::resize_quadrature_map_vectors().
|
protectedinherited |
Map for partial derivatives: d(eta)/d(z).
Needed for the Jacobian.
Definition at line 807 of file fe_map.h.
Referenced by libMesh::FEMap::compute_affine_map(), libMesh::FEMap::compute_inverse_map_second_derivs(), libMesh::FEMap::compute_null_map(), libMesh::FEMap::compute_single_point_map(), libMesh::FEMap::get_detadz(), and libMesh::FEMap::resize_quadrature_map_vectors().
|
protectedinherited |
Map for the derivative, d(phi)/d(eta).
Definition at line 861 of file fe_map.h.
Referenced by libMesh::FEMap::compute_single_point_map(), libMesh::FEMap::get_dphideta_map(), and libMesh::FEMap::init_reference_to_physical_map().
|
protectedinherited |
Map for the derivative, d(phi)/d(xi).
Definition at line 856 of file fe_map.h.
Referenced by libMesh::FEMap::compute_single_point_map(), libMesh::FEMap::get_dphidxi_map(), and libMesh::FEMap::init_reference_to_physical_map().
|
protectedinherited |
Map for the derivative, d(phi)/d(zeta).
Definition at line 866 of file fe_map.h.
Referenced by libMesh::FEMap::compute_single_point_map(), libMesh::FEMap::get_dphidzeta_map(), and libMesh::FEMap::init_reference_to_physical_map().
|
protectedinherited |
Map for the derivative of the side function, d(psi)/d(eta).
Definition at line 917 of file fe_map.h.
Referenced by compute_face_map(), libMesh::FEMap::compute_face_map(), libMesh::FEMap::get_dpsideta(), and libMesh::FEMap::init_face_shape_functions().
|
protectedinherited |
Map for the derivative of the side functions, d(psi)/d(xi).
Definition at line 911 of file fe_map.h.
Referenced by libMesh::FEMap::compute_edge_map(), compute_face_map(), libMesh::FEMap::compute_face_map(), libMesh::FEMap::get_dpsidxi(), libMesh::FEMap::init_edge_shape_functions(), and libMesh::FEMap::init_face_shape_functions().
|
protectedinherited |
Map for partial derivatives: d(xi)/d(x).
Needed for the Jacobian.
Definition at line 776 of file fe_map.h.
Referenced by libMesh::FEMap::compute_affine_map(), libMesh::FEMap::compute_inverse_map_second_derivs(), libMesh::FEMap::compute_null_map(), libMesh::FEMap::compute_single_point_map(), libMesh::FEMap::get_dxidx(), and libMesh::FEMap::resize_quadrature_map_vectors().
|
protectedinherited |
Map for partial derivatives: d(xi)/d(y).
Needed for the Jacobian.
Definition at line 782 of file fe_map.h.
Referenced by libMesh::FEMap::compute_affine_map(), libMesh::FEMap::compute_inverse_map_second_derivs(), libMesh::FEMap::compute_null_map(), libMesh::FEMap::compute_single_point_map(), libMesh::FEMap::get_dxidy(), and libMesh::FEMap::resize_quadrature_map_vectors().
|
protectedinherited |
Map for partial derivatives: d(xi)/d(z).
Needed for the Jacobian.
Definition at line 788 of file fe_map.h.
Referenced by libMesh::FEMap::compute_affine_map(), libMesh::FEMap::compute_inverse_map_second_derivs(), libMesh::FEMap::compute_null_map(), libMesh::FEMap::compute_single_point_map(), libMesh::FEMap::get_dxidz(), and libMesh::FEMap::resize_quadrature_map_vectors().
|
protectedinherited |
Vector of partial derivatives: d(x)/d(eta), d(y)/d(eta), d(z)/d(eta)
Definition at line 724 of file fe_map.h.
Referenced by libMesh::FEMap::compute_affine_map(), libMesh::FEMap::compute_edge_map(), compute_face_map(), libMesh::FEMap::compute_face_map(), libMesh::FEMap::compute_null_map(), libMesh::FEMap::compute_single_point_map(), libMesh::FEMap::dxdeta_map(), libMesh::FEMap::dydeta_map(), libMesh::FEMap::dzdeta_map(), libMesh::FEMap::get_dxyzdeta(), and libMesh::FEMap::resize_quadrature_map_vectors().
|
protectedinherited |
Vector of partial derivatives: d(x)/d(xi), d(y)/d(xi), d(z)/d(xi)
Definition at line 718 of file fe_map.h.
Referenced by libMesh::FEMap::compute_affine_map(), libMesh::FEMap::compute_edge_map(), compute_face_map(), libMesh::FEMap::compute_face_map(), libMesh::FEMap::compute_null_map(), libMesh::FEMap::compute_single_point_map(), libMesh::FEMap::dxdxi_map(), libMesh::FEMap::dydxi_map(), libMesh::FEMap::dzdxi_map(), libMesh::FEMap::get_dxyzdxi(), and libMesh::FEMap::resize_quadrature_map_vectors().
|
protectedinherited |
Vector of partial derivatives: d(x)/d(zeta), d(y)/d(zeta), d(z)/d(zeta)
Definition at line 730 of file fe_map.h.
Referenced by libMesh::FEMap::compute_affine_map(), libMesh::FEMap::compute_null_map(), libMesh::FEMap::compute_single_point_map(), libMesh::FEMap::dxdzeta_map(), libMesh::FEMap::dydzeta_map(), libMesh::FEMap::dzdzeta_map(), libMesh::FEMap::get_dxyzdzeta(), and libMesh::FEMap::resize_quadrature_map_vectors().
|
protectedinherited |
Map for partial derivatives: d(zeta)/d(x).
Needed for the Jacobian.
Definition at line 814 of file fe_map.h.
Referenced by libMesh::FEMap::compute_affine_map(), libMesh::FEMap::compute_inverse_map_second_derivs(), libMesh::FEMap::compute_null_map(), libMesh::FEMap::compute_single_point_map(), libMesh::FEMap::get_dzetadx(), and libMesh::FEMap::resize_quadrature_map_vectors().
|
protectedinherited |
Map for partial derivatives: d(zeta)/d(y).
Needed for the Jacobian.
Definition at line 820 of file fe_map.h.
Referenced by libMesh::FEMap::compute_affine_map(), libMesh::FEMap::compute_inverse_map_second_derivs(), libMesh::FEMap::compute_null_map(), libMesh::FEMap::compute_single_point_map(), libMesh::FEMap::get_dzetady(), and libMesh::FEMap::resize_quadrature_map_vectors().
|
protectedinherited |
Map for partial derivatives: d(zeta)/d(z).
Needed for the Jacobian.
Definition at line 826 of file fe_map.h.
Referenced by libMesh::FEMap::compute_affine_map(), libMesh::FEMap::compute_inverse_map_second_derivs(), libMesh::FEMap::compute_null_map(), libMesh::FEMap::compute_single_point_map(), libMesh::FEMap::get_dzetadz(), and libMesh::FEMap::resize_quadrature_map_vectors().
|
protectedinherited |
Jacobian values at quadrature points.
Definition at line 967 of file fe_map.h.
Referenced by libMesh::FEMap::compute_affine_map(), libMesh::FEMap::compute_null_map(), libMesh::FEMap::compute_single_point_map(), libMesh::FEMap::get_jacobian(), and libMesh::FEMap::resize_quadrature_map_vectors().
|
protectedinherited |
The Jacobian tolerance used for determining when the mapping fails.
The mapping is determined to fail if jac <= jacobian_tolerance. If not set by the user, this number defaults to 0
Definition at line 1011 of file fe_map.h.
Referenced by libMesh::FEMap::compute_single_point_map(), and libMesh::FEMap::set_jacobian_tolerance().
|
protectedinherited |
Jacobian*Weight values at quadrature points.
Definition at line 972 of file fe_map.h.
Referenced by libMesh::FEMap::compute_affine_map(), libMesh::FEMap::compute_edge_map(), compute_face_map(), libMesh::FEMap::compute_face_map(), libMesh::FEMap::compute_null_map(), libMesh::FEMap::compute_single_point_map(), libMesh::FEMap::get_JxW(), libMesh::FEMap::print_JxW(), and libMesh::FEMap::resize_quadrature_map_vectors().
|
protectedinherited |
Normal vectors on boundary at quadrature points.
Definition at line 952 of file fe_map.h.
Referenced by libMesh::FEMap::compute_edge_map(), compute_face_map(), libMesh::FEMap::compute_face_map(), and libMesh::FEMap::get_normals().
|
protectedinherited |
Map for the shape function phi.
Definition at line 851 of file fe_map.h.
Referenced by libMesh::FEMap::compute_affine_map(), libMesh::FEMap::compute_single_point_map(), libMesh::FEMap::get_phi_map(), and libMesh::FEMap::init_reference_to_physical_map().
|
protectedinherited |
Map for the side shape functions, psi.
Definition at line 905 of file fe_map.h.
Referenced by libMesh::FEMap::compute_edge_map(), compute_face_map(), libMesh::FEMap::compute_face_map(), libMesh::FEMap::get_psi(), libMesh::FEMap::init_edge_shape_functions(), and libMesh::FEMap::init_face_shape_functions().
|
protectedinherited |
Tangent vectors on boundary at quadrature points.
Definition at line 947 of file fe_map.h.
Referenced by libMesh::FEMap::compute_edge_map(), compute_face_map(), libMesh::FEMap::compute_face_map(), and libMesh::FEMap::get_tangents().
|
protectedinherited |
The spatial locations of the quadrature points.
Definition at line 712 of file fe_map.h.
Referenced by libMesh::FEMap::compute_affine_map(), libMesh::FEMap::compute_edge_map(), compute_face_map(), libMesh::FEMap::compute_face_map(), libMesh::FEMap::compute_null_map(), libMesh::FEMap::compute_single_point_map(), libMesh::FEMap::get_xyz(), libMesh::FEMap::print_xyz(), and libMesh::FEMap::resize_quadrature_map_vectors().