Panzer
Version of the Day
|
#include <Panzer_IntegrationValues2.hpp>
Public Member Functions | |
IntegrationValues2 (const std::string &pre="", const bool allocArrays=false) | |
Base constructor. More... | |
void | setupArrays (const Teuchos::RCP< const panzer::IntegrationRule > &ir) |
Sizes/allocates memory for arrays. More... | |
void | evaluateValues (const PHX::MDField< Scalar, Cell, NODE, Dim > &cell_node_coordinates, const int num_cells=-1, const Teuchos::RCP< const SubcellConnectivity > &face_connectivity=Teuchos::null, const int num_virtual_cells=-1) |
Evaluate basis values. More... | |
void | evaluateValues (const PHX::MDField< Scalar, Cell, NODE, Dim > &cell_node_coordinates, const PHX::MDField< Scalar, Cell, IP, Dim > &other_ip_coordinates, const int num_cells=-1) |
Match IP. More... | |
void | setup (const Teuchos::RCP< const panzer::IntegrationRule > &ir, const PHX::MDField< Scalar, Cell, NODE, Dim > &cell_node_coordinates, const int num_cells=-1) |
Main setup call for the lazy evaluation interface. More... | |
void | setupPermutations (const Teuchos::RCP< const SubcellConnectivity > &face_connectivity, const int num_virtual_cells) |
Initialize the permutation arrays given a face connectivity. More... | |
void | setupPermutations (const PHX::MDField< Scalar, Cell, IP, Dim > &other_ip_coordinates) |
Initialize the permutation arrays given another IntegrationValues2<Scalar>::getCubaturePoints() array. More... | |
ConstArray_IPDim | getUniformCubaturePointsRef (const bool cache=true, const bool force=false, const bool apply_permutation=true) const |
Get the uniform cubature points. More... | |
ConstArray_IPDim | getUniformSideCubaturePointsRef (const bool cache=true, const bool force=false, const bool apply_permutation=true) const |
Get the uniform cubature points for a side. More... | |
ConstArray_IP | getUniformCubatureWeightsRef (const bool cache=true, const bool force=false, const bool apply_permutation=true) const |
Get the uniform cubature weights. More... | |
ConstArray_CellBASISDim | getNodeCoordinates () const |
Get the node coordinates describing the geometry of the mesh. More... | |
ConstArray_CellIPDimDim | getJacobian (const bool cache=true, const bool force=false) const |
Get the Jacobian matrix evaluated at the cubature points. More... | |
ConstArray_CellIPDimDim | getJacobianInverse (const bool cache=true, const bool force=false) const |
Get the inverse of the Jacobian matrix evaluated at the cubature points. More... | |
ConstArray_CellIP | getJacobianDeterminant (const bool cache=true, const bool force=false) const |
Get the determinant of the Jacobian matrix evaluated at the cubature points. More... | |
ConstArray_CellIP | getWeightedMeasure (const bool cache=true, const bool force=false) const |
Get the weighted measure (integration weights) More... | |
ConstArray_CellIPDim | getWeightedNormals (const bool cache=true, const bool force=false) const |
Get the weighted normals. More... | |
ConstArray_CellIPDim | getSurfaceNormals (const bool cache=true, const bool force=false) const |
Get the surface normals. More... | |
ConstArray_CellIPDimDim | getSurfaceRotationMatrices (const bool cache=true, const bool force=false) const |
Get the surface rotation matrices. More... | |
ConstArray_CellIPDimDim | getCovarientMatrix (const bool cache=true, const bool force=false) const |
Get the covarient matrix. More... | |
ConstArray_CellIPDimDim | getContravarientMatrix (const bool cache=true, const bool force=false) const |
Get the contravarient matrix. More... | |
ConstArray_CellIP | getNormContravarientMatrix (const bool cache=true, const bool force=false) const |
Get the contravarient matrix. More... | |
ConstArray_CellIPDim | getCubaturePoints (const bool cache=true, const bool force=false) const |
Get the cubature points in physical space. More... | |
ConstArray_CellIPDim | getCubaturePointsRef (const bool cache=true, const bool force=false) const |
Get the cubature points in the reference space. More... | |
Teuchos::RCP< const panzer::IntegrationRule > | getIntegrationRule () const |
Returns the IntegrationRule. More... | |
Public Attributes | |
Array_IPDim | cub_points |
Array_IPDim | side_cub_points |
Array_IP | cub_weights |
Array_CellBASISDim | node_coordinates |
Array_CellIPDimDim | jac |
Array_CellIPDimDim | jac_inv |
Array_CellIP | jac_det |
Array_CellIP | weighted_measure |
Array_CellIPDim | weighted_normals |
Array_CellIPDim | surface_normals |
Array_CellIPDimDim | surface_rotation_matrices |
Array_CellIPDimDim | covarient |
Array_CellIPDimDim | contravarient |
Array_CellIP | norm_contravarient |
Array_CellIPDim | ip_coordinates |
Array_CellIPDim | ref_ip_coordinates |
Teuchos::RCP< const panzer::IntegrationRule > | int_rule |
Teuchos::RCP < Intrepid2::Cubature < PHX::Device::execution_space, double, double > > | intrepid_cubature |
Protected Member Functions | |
void | resetArrays () |
void | evaluateEverything () |
Protected Attributes | |
int | num_cells_ |
int | num_evaluate_cells_ |
int | num_virtual_cells_ |
bool | requires_permutation_ |
PHX::MDField< const int, Cell, IP > | permutations_ |
Teuchos::RCP< const SubcellConnectivity > | side_connectivity_ |
bool | cub_points_evaluated_ |
bool | side_cub_points_evaluated_ |
bool | cub_weights_evaluated_ |
bool | node_coordinates_evaluated_ |
bool | jac_evaluated_ |
bool | jac_inv_evaluated_ |
bool | jac_det_evaluated_ |
bool | weighted_measure_evaluated_ |
bool | weighted_normals_evaluated_ |
bool | surface_normals_evaluated_ |
bool | surface_rotation_matrices_evaluated_ |
bool | covarient_evaluated_ |
bool | contravarient_evaluated_ |
bool | norm_contravarient_evaluated_ |
bool | ip_coordinates_evaluated_ |
bool | ref_ip_coordinates_evaluated_ |
Private Attributes | |
bool | alloc_arrays_ |
std::string | prefix_ |
std::vector< PHX::index_size_type > | ddims_ |
Definition at line 28 of file Panzer_IntegrationValues2.hpp.
typedef ArrayTraits<Scalar,PHX::MDField<Scalar> >::size_type panzer::IntegrationValues2< Scalar >::size_type |
Definition at line 30 of file Panzer_IntegrationValues2.hpp.
typedef PHX::MDField<Scalar> panzer::IntegrationValues2< Scalar >::ArrayDynamic |
Definition at line 32 of file Panzer_IntegrationValues2.hpp.
typedef PHX::MDField<double> panzer::IntegrationValues2< Scalar >::DblArrayDynamic |
Definition at line 33 of file Panzer_IntegrationValues2.hpp.
typedef PHX::MDField<Scalar,IP> panzer::IntegrationValues2< Scalar >::Array_IP |
Definition at line 35 of file Panzer_IntegrationValues2.hpp.
typedef PHX::MDField<Scalar,IP,Dim> panzer::IntegrationValues2< Scalar >::Array_IPDim |
Definition at line 36 of file Panzer_IntegrationValues2.hpp.
typedef PHX::MDField<Scalar,Point> panzer::IntegrationValues2< Scalar >::Array_Point |
Definition at line 37 of file Panzer_IntegrationValues2.hpp.
typedef PHX::MDField<Scalar,Cell,IP> panzer::IntegrationValues2< Scalar >::Array_CellIP |
Definition at line 38 of file Panzer_IntegrationValues2.hpp.
typedef PHX::MDField<Scalar,Cell,IP,Dim> panzer::IntegrationValues2< Scalar >::Array_CellIPDim |
Definition at line 39 of file Panzer_IntegrationValues2.hpp.
typedef PHX::MDField<Scalar,Cell,IP,Dim,Dim> panzer::IntegrationValues2< Scalar >::Array_CellIPDimDim |
Definition at line 40 of file Panzer_IntegrationValues2.hpp.
typedef PHX::MDField<Scalar,Cell,BASIS,Dim> panzer::IntegrationValues2< Scalar >::Array_CellBASISDim |
Definition at line 41 of file Panzer_IntegrationValues2.hpp.
typedef PHX::MDField<const Scalar,IP> panzer::IntegrationValues2< Scalar >::ConstArray_IP |
Definition at line 43 of file Panzer_IntegrationValues2.hpp.
typedef PHX::MDField<const Scalar,IP,Dim> panzer::IntegrationValues2< Scalar >::ConstArray_IPDim |
Definition at line 44 of file Panzer_IntegrationValues2.hpp.
typedef PHX::MDField<const Scalar,Point> panzer::IntegrationValues2< Scalar >::ConstArray_Point |
Definition at line 45 of file Panzer_IntegrationValues2.hpp.
typedef PHX::MDField<const Scalar,Cell,IP> panzer::IntegrationValues2< Scalar >::ConstArray_CellIP |
Definition at line 46 of file Panzer_IntegrationValues2.hpp.
typedef PHX::MDField<const Scalar,Cell,IP,Dim> panzer::IntegrationValues2< Scalar >::ConstArray_CellIPDim |
Definition at line 47 of file Panzer_IntegrationValues2.hpp.
typedef PHX::MDField<const Scalar,Cell,IP,Dim,Dim> panzer::IntegrationValues2< Scalar >::ConstArray_CellIPDimDim |
Definition at line 48 of file Panzer_IntegrationValues2.hpp.
typedef PHX::MDField<const Scalar,Cell,BASIS,Dim> panzer::IntegrationValues2< Scalar >::ConstArray_CellBASISDim |
Definition at line 49 of file Panzer_IntegrationValues2.hpp.
panzer::IntegrationValues2< Scalar >::IntegrationValues2 | ( | const std::string & | pre = "" , |
const bool | allocArrays = false |
||
) |
Base constructor.
[in] | pre | Prefix to apply to all internal field names |
[in] | allocArrays | (Classic Interface Only) Allocate array data in 'setupArrays' call |
Definition at line 555 of file Panzer_IntegrationValues2.cpp.
void panzer::IntegrationValues2< Scalar >::setupArrays | ( | const Teuchos::RCP< const panzer::IntegrationRule > & | ir | ) |
Sizes/allocates memory for arrays.
Definition at line 595 of file Panzer_IntegrationValues2.cpp.
void panzer::IntegrationValues2< Scalar >::evaluateValues | ( | const PHX::MDField< Scalar, Cell, NODE, Dim > & | cell_node_coordinates, |
const int | num_cells = -1 , |
||
const Teuchos::RCP< const SubcellConnectivity > & | face_connectivity = Teuchos::null , |
||
const int | num_virtual_cells = -1 |
||
) |
Evaluate basis values.
cell_node_coordinates | [in] Cell node coordinates, not basis coordinates. |
num_cells | [in] (optional) number of cells in the workset. This can be less than the workset size. If set to zero, extent(0) of the evaluated array is used which equates to the workset size. |
face_connectivity | [in] (optional) connectivity used to enforce quadrature alignment for surface integration. |
Definition at line 658 of file Panzer_IntegrationValues2.cpp.
void panzer::IntegrationValues2< Scalar >::evaluateValues | ( | const PHX::MDField< Scalar, Cell, NODE, Dim > & | cell_node_coordinates, |
const PHX::MDField< Scalar, Cell, IP, Dim > & | other_ip_coordinates, | ||
const int | num_cells = -1 |
||
) |
Match IP.
Optionally provide IP coordinates for an element 'other' that shares the same side. If provided, a permutation of the cubature points is calculated so that the integration values are ordered according to the other element's. This permutation is then applied so that all fields are ordered accordingly in their IP dimension.
num_cells | [in] (optional) number of cells in the workset. This can be less than the workset size. If set to zero, extent(0) of the evaluated array is used which equates to the workset size. |
Definition at line 679 of file Panzer_IntegrationValues2.cpp.
void panzer::IntegrationValues2< Scalar >::setup | ( | const Teuchos::RCP< const panzer::IntegrationRule > & | ir, |
const PHX::MDField< Scalar, Cell, NODE, Dim > & | cell_node_coordinates, | ||
const int | num_cells = -1 |
||
) |
Main setup call for the lazy evaluation interface.
The lazy evaluation construction path is designed such that you only allocate and fill arrays on demand, with an option of caching those generated fields. This is useful for when we are worried about a code's memory footprint.
The process for setting up one of these objects is to initialize the IntegrationValues2 class as follows:
IntegrationValues2<double> values; // Constructor values.setup(ir, cell_node_coordinates); // Required - must come before all other calls values.setupPermutations(...); // Optional - only needed for surface integration and some side integration rules - must come before get*() calls auto array = values.get*(); // Lazy evaluate whatever field you need
[in] | ir | Integration rule descripting integration scheme |
[in] | cell_node_coordinates | Node/Vertex <cell, node, dim> coordinates describing cell geometry |
[in] | num_cells | In case you need to only generate integration values for the first 'num_cells' of the node_coordinates - defaults to all cells |
Definition at line 732 of file Panzer_IntegrationValues2.cpp.
void panzer::IntegrationValues2< Scalar >::setupPermutations | ( | const Teuchos::RCP< const SubcellConnectivity > & | face_connectivity, |
const int | num_virtual_cells | ||
) |
Initialize the permutation arrays given a face connectivity.
[in] | face_connectivity | Connectivity describing how sides are connected to cells |
[in] | num_virtual_cells | Number of virtual cells included in the node coordinates (found at end of node coordinate array) |
Definition at line 697 of file Panzer_IntegrationValues2.cpp.
void panzer::IntegrationValues2< Scalar >::setupPermutations | ( | const PHX::MDField< Scalar, Cell, IP, Dim > & | other_ip_coordinates | ) |
Initialize the permutation arrays given another IntegrationValues2<Scalar>::getCubaturePoints() array.
[in] | other_ip_coordinates | Cubature points to align with |
Definition at line 719 of file Panzer_IntegrationValues2.cpp.
IntegrationValues2< Scalar >::ConstArray_IPDim panzer::IntegrationValues2< Scalar >::getUniformCubaturePointsRef | ( | const bool | cache = true , |
const bool | force = false , |
||
const bool | apply_permutation = true |
||
) | const |
Get the uniform cubature points.
[in] | cache | If true, the result will be stored in the IntegrationValues2 class |
[in] | force | Force the re-evaluation of the array |
[in] | apply_permutation | ADVANCED Do not change this unless you know what it does (it can break things) |
Definition at line 770 of file Panzer_IntegrationValues2.cpp.
IntegrationValues2< Scalar >::ConstArray_IPDim panzer::IntegrationValues2< Scalar >::getUniformSideCubaturePointsRef | ( | const bool | cache = true , |
const bool | force = false , |
||
const bool | apply_permutation = true |
||
) | const |
Get the uniform cubature points for a side.
[in] | cache | If true, the result will be stored in the IntegrationValues2 class |
[in] | force | Force the re-evaluation of the array |
[in] | apply_permutation | ADVANCED Do not change this unless you know what it does (it can break things) |
Definition at line 828 of file Panzer_IntegrationValues2.cpp.
IntegrationValues2< Scalar >::ConstArray_IP panzer::IntegrationValues2< Scalar >::getUniformCubatureWeightsRef | ( | const bool | cache = true , |
const bool | force = false , |
||
const bool | apply_permutation = true |
||
) | const |
Get the uniform cubature weights.
[in] | cache | If true, the result will be stored in the IntegrationValues2 class |
[in] | force | Force the re-evaluation of the array |
[in] | apply_permutation | ADVANCED Do not change this unless you know what it does (it can break things) |
Definition at line 880 of file Panzer_IntegrationValues2.cpp.
IntegrationValues2< Scalar >::ConstArray_CellBASISDim panzer::IntegrationValues2< Scalar >::getNodeCoordinates | ( | ) | const |
Get the node coordinates describing the geometry of the mesh.
Definition at line 930 of file Panzer_IntegrationValues2.cpp.
IntegrationValues2< Scalar >::ConstArray_CellIPDimDim panzer::IntegrationValues2< Scalar >::getJacobian | ( | const bool | cache = true , |
const bool | force = false |
||
) | const |
Get the Jacobian matrix evaluated at the cubature points.
[in] | cache | If true, the result will be stored in the IntegrationValues2 class |
[in] | force | Force the re-evaluation of the array |
Definition at line 938 of file Panzer_IntegrationValues2.cpp.
IntegrationValues2< Scalar >::ConstArray_CellIPDimDim panzer::IntegrationValues2< Scalar >::getJacobianInverse | ( | const bool | cache = true , |
const bool | force = false |
||
) | const |
Get the inverse of the Jacobian matrix evaluated at the cubature points.
[in] | cache | If true, the result will be stored in the IntegrationValues2 class |
[in] | force | Force the re-evaluation of the array |
Definition at line 1004 of file Panzer_IntegrationValues2.cpp.
IntegrationValues2< Scalar >::ConstArray_CellIP panzer::IntegrationValues2< Scalar >::getJacobianDeterminant | ( | const bool | cache = true , |
const bool | force = false |
||
) | const |
Get the determinant of the Jacobian matrix evaluated at the cubature points.
[in] | cache | If true, the result will be stored in the IntegrationValues2 class |
[in] | force | Force the re-evaluation of the array |
Definition at line 1041 of file Panzer_IntegrationValues2.cpp.
IntegrationValues2< Scalar >::ConstArray_CellIP panzer::IntegrationValues2< Scalar >::getWeightedMeasure | ( | const bool | cache = true , |
const bool | force = false |
||
) | const |
Get the weighted measure (integration weights)
[in] | cache | If true, the result will be stored in the IntegrationValues2 class |
[in] | force | Force the re-evaluation of the array |
Definition at line 1077 of file Panzer_IntegrationValues2.cpp.
IntegrationValues2< Scalar >::ConstArray_CellIPDim panzer::IntegrationValues2< Scalar >::getWeightedNormals | ( | const bool | cache = true , |
const bool | force = false |
||
) | const |
Get the weighted normals.
[in] | cache | If true, the result will be stored in the IntegrationValues2 class |
[in] | force | Force the re-evaluation of the array |
Definition at line 1245 of file Panzer_IntegrationValues2.cpp.
IntegrationValues2< Scalar >::ConstArray_CellIPDim panzer::IntegrationValues2< Scalar >::getSurfaceNormals | ( | const bool | cache = true , |
const bool | force = false |
||
) | const |
Get the surface normals.
[in] | cache | If true, the result will be stored in the IntegrationValues2 class |
[in] | force | Force the re-evaluation of the array |
Definition at line 1292 of file Panzer_IntegrationValues2.cpp.
IntegrationValues2< Scalar >::ConstArray_CellIPDimDim panzer::IntegrationValues2< Scalar >::getSurfaceRotationMatrices | ( | const bool | cache = true , |
const bool | force = false |
||
) | const |
Get the surface rotation matrices.
[in] | cache | If true, the result will be stored in the IntegrationValues2 class |
[in] | force | Force the re-evaluation of the array |
Definition at line 1410 of file Panzer_IntegrationValues2.cpp.
IntegrationValues2< Scalar >::ConstArray_CellIPDimDim panzer::IntegrationValues2< Scalar >::getCovarientMatrix | ( | const bool | cache = true , |
const bool | force = false |
||
) | const |
Get the covarient matrix.
cov(i,j) = jacobian(i,k) * jacobian(j,k)
[in] | cache | If true, the result will be stored in the IntegrationValues2 class |
[in] | force | Force the re-evaluation of the array |
Definition at line 1471 of file Panzer_IntegrationValues2.cpp.
IntegrationValues2< Scalar >::ConstArray_CellIPDimDim panzer::IntegrationValues2< Scalar >::getContravarientMatrix | ( | const bool | cache = true , |
const bool | force = false |
||
) | const |
Get the contravarient matrix.
contra = (getCovarientMatrix())^{-1}
[in] | cache | If true, the result will be stored in the IntegrationValues2 class |
[in] | force | Force the re-evaluation of the array |
Definition at line 1513 of file Panzer_IntegrationValues2.cpp.
IntegrationValues2< Scalar >::ConstArray_CellIP panzer::IntegrationValues2< Scalar >::getNormContravarientMatrix | ( | const bool | cache = true , |
const bool | force = false |
||
) | const |
Get the contravarient matrix.
norm = sqrt({ij} cov(i,j) * cov(i,j))
[in] | cache | If true, the result will be stored in the IntegrationValues2 class |
[in] | force | Force the re-evaluation of the array |
Definition at line 1548 of file Panzer_IntegrationValues2.cpp.
IntegrationValues2< Scalar >::ConstArray_CellIPDim panzer::IntegrationValues2< Scalar >::getCubaturePoints | ( | const bool | cache = true , |
const bool | force = false |
||
) | const |
Get the cubature points in physical space.
[in] | cache | If true, the result will be stored in the IntegrationValues2 class |
[in] | force | Force the re-evaluation of the array |
Definition at line 1589 of file Panzer_IntegrationValues2.cpp.
IntegrationValues2< Scalar >::ConstArray_CellIPDim panzer::IntegrationValues2< Scalar >::getCubaturePointsRef | ( | const bool | cache = true , |
const bool | force = false |
||
) | const |
Get the cubature points in the reference space.
[in] | cache | If true, the result will be stored in the IntegrationValues2 class |
[in] | force | Force the re-evaluation of the array |
Definition at line 1675 of file Panzer_IntegrationValues2.cpp.
|
inline |
Returns the IntegrationRule.
Definition at line 428 of file Panzer_IntegrationValues2.hpp.
|
protected |
Definition at line 571 of file Panzer_IntegrationValues2.cpp.
|
protected |
Definition at line 1797 of file Panzer_IntegrationValues2.cpp.
|
mutable |
Definition at line 102 of file Panzer_IntegrationValues2.hpp.
|
mutable |
Definition at line 103 of file Panzer_IntegrationValues2.hpp.
|
mutable |
Definition at line 104 of file Panzer_IntegrationValues2.hpp.
|
mutable |
Definition at line 107 of file Panzer_IntegrationValues2.hpp.
|
mutable |
Definition at line 108 of file Panzer_IntegrationValues2.hpp.
|
mutable |
Definition at line 109 of file Panzer_IntegrationValues2.hpp.
|
mutable |
Definition at line 110 of file Panzer_IntegrationValues2.hpp.
|
mutable |
Definition at line 111 of file Panzer_IntegrationValues2.hpp.
|
mutable |
Definition at line 112 of file Panzer_IntegrationValues2.hpp.
|
mutable |
Definition at line 113 of file Panzer_IntegrationValues2.hpp.
|
mutable |
Definition at line 114 of file Panzer_IntegrationValues2.hpp.
|
mutable |
Definition at line 119 of file Panzer_IntegrationValues2.hpp.
|
mutable |
Definition at line 120 of file Panzer_IntegrationValues2.hpp.
|
mutable |
Definition at line 121 of file Panzer_IntegrationValues2.hpp.
|
mutable |
Definition at line 124 of file Panzer_IntegrationValues2.hpp.
|
mutable |
Definition at line 125 of file Panzer_IntegrationValues2.hpp.
Teuchos::RCP<const panzer::IntegrationRule> panzer::IntegrationValues2< Scalar >::int_rule |
Definition at line 128 of file Panzer_IntegrationValues2.hpp.
Teuchos::RCP<Intrepid2::Cubature<PHX::Device::execution_space,double,double> > panzer::IntegrationValues2< Scalar >::intrepid_cubature |
Definition at line 130 of file Panzer_IntegrationValues2.hpp.
|
protected |
Definition at line 440 of file Panzer_IntegrationValues2.hpp.
|
protected |
Definition at line 443 of file Panzer_IntegrationValues2.hpp.
|
protected |
Definition at line 446 of file Panzer_IntegrationValues2.hpp.
|
protected |
Definition at line 449 of file Panzer_IntegrationValues2.hpp.
|
protected |
Definition at line 452 of file Panzer_IntegrationValues2.hpp.
|
protected |
Definition at line 456 of file Panzer_IntegrationValues2.hpp.
|
mutableprotected |
Definition at line 459 of file Panzer_IntegrationValues2.hpp.
|
mutableprotected |
Definition at line 460 of file Panzer_IntegrationValues2.hpp.
|
mutableprotected |
Definition at line 461 of file Panzer_IntegrationValues2.hpp.
|
mutableprotected |
Definition at line 462 of file Panzer_IntegrationValues2.hpp.
|
mutableprotected |
Definition at line 463 of file Panzer_IntegrationValues2.hpp.
|
mutableprotected |
Definition at line 464 of file Panzer_IntegrationValues2.hpp.
|
mutableprotected |
Definition at line 465 of file Panzer_IntegrationValues2.hpp.
|
mutableprotected |
Definition at line 466 of file Panzer_IntegrationValues2.hpp.
|
mutableprotected |
Definition at line 467 of file Panzer_IntegrationValues2.hpp.
|
mutableprotected |
Definition at line 468 of file Panzer_IntegrationValues2.hpp.
|
mutableprotected |
Definition at line 469 of file Panzer_IntegrationValues2.hpp.
|
mutableprotected |
Definition at line 470 of file Panzer_IntegrationValues2.hpp.
|
mutableprotected |
Definition at line 471 of file Panzer_IntegrationValues2.hpp.
|
mutableprotected |
Definition at line 472 of file Panzer_IntegrationValues2.hpp.
|
mutableprotected |
Definition at line 473 of file Panzer_IntegrationValues2.hpp.
|
mutableprotected |
Definition at line 474 of file Panzer_IntegrationValues2.hpp.
|
private |
Definition at line 482 of file Panzer_IntegrationValues2.hpp.
|
private |
Definition at line 483 of file Panzer_IntegrationValues2.hpp.
|
private |
Definition at line 484 of file Panzer_IntegrationValues2.hpp.