Panzer
Version of the Day
|
Data for determining cell topology and dimensionality. More...
#include <Panzer_CellData.hpp>
Public Member Functions | |
CellData () | |
CellData (std::size_t num_cells, const Teuchos::RCP< const shards::CellTopology > &ct) | |
CellData (std::size_t num_cells, int local_side_id, const Teuchos::RCP< const shards::CellTopology > &ct) | |
bool | isSide () const |
int | side () const |
std::size_t | numCells () const |
int | baseCellDimension () const |
Dimension of the base cell. NOT the dimension of the local side, even if the side() method returns true. More... | |
Teuchos::RCP< const shards::CellTopology > | getCellTopology () const |
Get CellTopology for the base cell. More... | |
Private Attributes | |
std::size_t | m_num_cells |
bool | m_is_side |
int | m_side |
Teuchos::RCP< const shards::CellTopology > | m_cell_topo |
Data for determining cell topology and dimensionality.
This class provides information about the finite elements/cells and allows us to reuse all the evaluation machinery for both volume and surface integrations. When performing neumann conditions, we integrate over a side but must still use all basis points from the volume if we need a gradient that contains a normal component to the surface being integrated over.
Definition at line 33 of file Panzer_CellData.hpp.
|
inlineexplicit |
for testing purposes only
Definition at line 38 of file Panzer_CellData.hpp.
|
inlineexplicit |
Build cell data that uses volume data. CellTopology is on the volume cells!
Definition at line 44 of file Panzer_CellData.hpp.
|
inlineexplicit |
Build cell data that uses side cells. CellTopology is on the volume cells!
Definition at line 55 of file Panzer_CellData.hpp.
|
inline |
Definition at line 63 of file Panzer_CellData.hpp.
|
inline |
Definition at line 66 of file Panzer_CellData.hpp.
|
inline |
Definition at line 73 of file Panzer_CellData.hpp.
|
inline |
Dimension of the base cell. NOT the dimension of the local side, even if the side() method returns true.
Definition at line 77 of file Panzer_CellData.hpp.
|
inline |
Get CellTopology for the base cell.
Definition at line 82 of file Panzer_CellData.hpp.
|
private |
Definition at line 86 of file Panzer_CellData.hpp.
|
private |
Definition at line 87 of file Panzer_CellData.hpp.
|
private |
Definition at line 88 of file Panzer_CellData.hpp.
|
private |
Definition at line 91 of file Panzer_CellData.hpp.