Panzer  Version of the Day
All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
Public Member Functions | Public Attributes | List of all members
panzer::Workset Struct Reference

#include <Panzer_Workset.hpp>

Inheritance diagram for panzer::Workset:
Inheritance graph
[legend]

Public Member Functions

 Workset ()
 
WorksetDetailsoperator() (const int i)
 op(0) return *this; op(1) returns *other. More...
 
const WorksetDetailsoperator() (const int i) const
 const accessor. More...
 
WorksetDetailsdetails (const int i)
 Convenience wrapper to operator() for pointer access. More...
 
const WorksetDetailsdetails (const int i) const
 
size_t numDetails () const
 Return the number of WorksetDetails this Workset holds. More...
 
- Public Member Functions inherited from panzer::WorksetDetails
void setup (const panzer::LocalMeshPartition< int, int > &partition, const panzer::WorksetNeeds &needs)
 Constructs the workset details from a given chunk of the mesh. More...
 
void setupNeeds (Teuchos::RCP< const shards::CellTopology > cell_topology, const Kokkos::View< double ***, PHX::Device > &cell_vertices, const panzer::WorksetNeeds &needs)
 
const panzer::SubcellConnectivitygetFaceConnectivity () const
 Grab the face connectivity for this workset. More...
 
const
panzer::IntegrationValues2
< double > & 
getIntegrationValues (const panzer::IntegrationDescriptor &description) const
 Grab the integration values for a given integration description (throws error if integration doesn't exist) More...
 
const panzer::IntegrationRulegetIntegrationRule (const panzer::IntegrationDescriptor &description) const
 Grab the integration rule (contains data layouts) for a given integration description (throws error if integration doesn't exist) More...
 
const panzer::BasisValues2
< double > & 
getBasisValues (const panzer::BasisDescriptor &basis_description, const panzer::IntegrationDescriptor &integration_description) const
 Grab the basis values for a given basis description and integration description (throws error if it doesn't exist) More...
 
const panzer::PureBasisgetBasis (const panzer::BasisDescriptor &description) const
 Grab the pure basis (contains data layouts) for a given basis description (throws error if integration doesn't exist) More...
 
int num_owned_cells () const
 Number of cells owned by this workset. More...
 
int num_ghost_cells () const
 Number of cells owned by a different workset. More...
 
int num_virtual_cells () const
 Number of cells not owned by any workset - these are used for boundary conditions. More...
 

Public Attributes

index_t num_cells
 
int subcell_dim
 
double alpha
 If workset corresponds to a sub cell, what is the dimension? More...
 
double beta
 
double time
 
double step_size
 
double stage_number
 
std::vector< double > gather_seeds
 
bool evaluate_transient_terms
 
Teuchos::RCP< WorksetDetailsother
 
- Public Attributes inherited from panzer::WorksetDetails
Kokkos::View< const int
*, PHX::Device > 
cell_local_ids_k
 
std::vector< GOcell_local_ids
 
CellCoordArray cell_vertex_coordinates
 
std::string block_id
 
int subcell_index
 
Teuchos::RCP< std::vector< int > > ir_degrees
 If workset corresponds to a sub cell, what is the index? More...
 
std::vector< Teuchos::RCP
< panzer::IntegrationValues2
< double > > > 
int_rules
 
Teuchos::RCP< std::vector
< std::string > > 
basis_names
 Value corresponds to basis type. Use the offest for indexing. More...
 
std::vector< Teuchos::RCP
< panzer::BasisValues2< double > > > 
bases
 Static basis function data, key is basis name, value is index in the static_bases vector. More...
 

Additional Inherited Members

- Public Types inherited from panzer::WorksetDetails
typedef PHX::MDField< double,
Cell, NODE, Dim > 
CellCoordArray
 
typedef std::size_t GO
 
typedef int LO
 
- Protected Attributes inherited from panzer::WorksetDetails
int _num_owned_cells
 
int _num_ghost_cells
 
int _num_virtual_cells
 
std::map< size_t, Teuchos::RCP
< const
panzer::IntegrationRule > > 
_integration_rule_map
 
std::map< size_t, Teuchos::RCP
< const
panzer::IntegrationValues2
< double > > > 
_integrator_map
 
std::map< size_t, Teuchos::RCP
< const panzer::PureBasis > > 
_pure_basis_map
 
std::map< size_t, std::map
< size_t, Teuchos::RCP< const
panzer::BasisValues2< double > > > > 
_basis_map
 
Teuchos::RCP
< panzer::SubcellConnectivity
_face_connectivity
 

Detailed Description

This is the main workset object. Not that it inherits from WorksetDetails, this is to maintain backwards compatibility in the use of the workset object. The addition of a details vector supports things like DG based assembly.

Definition at line 155 of file Panzer_Workset.hpp.

Constructor & Destructor Documentation

panzer::Workset::Workset ( )
inline

Definition at line 156 of file Panzer_Workset.hpp.

Member Function Documentation

WorksetDetails& panzer::Workset::operator() ( const int  i)
inline

op(0) return *this; op(1) returns *other.

Definition at line 175 of file Panzer_Workset.hpp.

const WorksetDetails& panzer::Workset::operator() ( const int  i) const
inline

const accessor.

Definition at line 180 of file Panzer_Workset.hpp.

WorksetDetails& panzer::Workset::details ( const int  i)
inline

Convenience wrapper to operator() for pointer access.

Definition at line 185 of file Panzer_Workset.hpp.

const WorksetDetails& panzer::Workset::details ( const int  i) const
inline

Definition at line 186 of file Panzer_Workset.hpp.

size_t panzer::Workset::numDetails ( ) const
inline

Return the number of WorksetDetails this Workset holds.

Definition at line 188 of file Panzer_Workset.hpp.

Member Data Documentation

index_t panzer::Workset::num_cells

Definition at line 158 of file Panzer_Workset.hpp.

int panzer::Workset::subcell_dim

Definition at line 159 of file Panzer_Workset.hpp.

double panzer::Workset::alpha

If workset corresponds to a sub cell, what is the dimension?

Definition at line 161 of file Panzer_Workset.hpp.

double panzer::Workset::beta

Definition at line 162 of file Panzer_Workset.hpp.

double panzer::Workset::time

Definition at line 163 of file Panzer_Workset.hpp.

double panzer::Workset::step_size

Definition at line 164 of file Panzer_Workset.hpp.

double panzer::Workset::stage_number

Definition at line 165 of file Panzer_Workset.hpp.

std::vector<double> panzer::Workset::gather_seeds

Definition at line 166 of file Panzer_Workset.hpp.

bool panzer::Workset::evaluate_transient_terms

Definition at line 167 of file Panzer_Workset.hpp.

Teuchos::RCP<WorksetDetails> panzer::Workset::other

other contains details about the side-sharing elements on the other side of the interface. If Teuchos::nonnull(other), then Workset contains two WorksetDetails: itself, and other.

Definition at line 172 of file Panzer_Workset.hpp.


The documentation for this struct was generated from the following file: