Flow123d  JS_before_hm-1002-gafa1d04
Public Types | Public Member Functions | Private Member Functions | Private Attributes | Friends | List of all members
BdrConditionAssemblyDG< dim, Model > Class Template Reference

#include <assembly_dg.hh>

Inheritance diagram for BdrConditionAssemblyDG< dim, Model >:
Inheritance graph
[legend]
Collaboration diagram for BdrConditionAssemblyDG< dim, Model >:
Collaboration graph
[legend]

Public Types

typedef TransportDG< Model >::EqData EqDataDG
 

Public Member Functions

 BdrConditionAssemblyDG (EqDataDG *data)
 Constructor. More...
 
 ~BdrConditionAssemblyDG ()
 Destructor. More...
 
void initialize (TransportDG< Model > &model)
 Initialize auxiliary vectors and other data members. More...
 
void assemble_volume_integrals (DHCellAccessor cell) override
 Assemble integral over element. More...
 
void begin () override
 Implements AssemblyBase::begin. More...
 
void end () override
 Implements AssemblyBase::end. More...
 
- Public Member Functions inherited from AssemblyBase< dim >
virtual void fix_velocity (const DHCellAccessor &dh_cell)=0
 
virtual void assemble (const DHCellAccessor &dh_cell)=0
 
virtual void assemble_reconstruct (const DHCellAccessor &dh_cell)=0
 
virtual void update_water_content (const DHCellAccessor &dh_cell)=0
 Updates water content in Richards. More...
 
virtual ~AssemblyBase ()
 
 AssemblyBase (unsigned int quad_order)
 Constructor. More...
 
virtual ~AssemblyBase ()
 
virtual void assemble_volume_integrals (FMT_UNUSED DHCellAccessor cell)
 Assembles the volume integrals on cell. More...
 
virtual void assemble_fluxes_boundary (FMT_UNUSED DHCellSide cell_side)
 Assembles the fluxes on the boundary. More...
 
virtual void assemble_fluxes_element_element (FMT_UNUSED RangeConvert< DHEdgeSide, DHCellSide > edge_side_range)
 Assembles the fluxes between sides on the edge. More...
 
virtual void assemble_fluxes_element_side (FMT_UNUSED DHCellAccessor cell_lower_dim, FMT_UNUSED DHCellSide neighb_side)
 Assembles the fluxes between elements of different dimensions. More...
 
void create_integrals (std::shared_ptr< EvalPoints > eval_points, AssemblyIntegrals &integrals, int active_integrals)
 Create integrals according to dim of assembly object. More...
 

Private Member Functions

void calculate_velocity (const ElementAccessor< 3 > &cell, vector< arma::vec3 > &velocity, const Armor::array &point_list)
 Calculates the velocity field on a given cell. More...
 

Private Attributes

shared_ptr< FiniteElement< dim > > fe_
 Finite element for the solution of the advection-diffusion equation. More...
 
FiniteElement< dim > * fe_rt_
 Finite element for the water velocity field. More...
 
TransportDG< Model > * model_
 Pointer to model (we must use common ancestor of concentration and heat model) More...
 
EqDataDGdata_
 Data object shared with TransportDG. More...
 
unsigned int ndofs_
 Number of dofs. More...
 
unsigned int qsize_
 Size of quadrature of actual dim. More...
 
unsigned int qsize_lower_dim_
 Size of quadrature of dim-1. More...
 
FEValues< 3 > fe_values_side_
 FEValues of object (of P disc finite element type) More...
 
FEValues< 3 > fsv_rt_
 FEValues of object (of RT0 finite element type) More...
 
vector< LongIdxdof_indices_
 Vector of global DOF indices. More...
 
vector< PetscScalar > local_rhs_
 Auxiliary vector for set_sources method. More...
 
vector< PetscScalar > local_flux_balance_vector_
 Auxiliary vector for set_boundary_conditions method. More...
 
PetscScalar local_flux_balance_rhs_
 Auxiliary variable for set_boundary_conditions method. More...
 
vector< arma::vec3velocity_
 Auxiliary results. More...
 
vector< double > sigma_
 Auxiliary vector for assemble boundary fluxes (robin sigma), element-side fluxes (frac sigma) and set boundary conditions method. More...
 
vector< double > csection_
 Auxiliary vector for assemble boundary fluxes, element-side fluxes and set boundary conditions. More...
 
vector< double > bc_values_
 Auxiliary vector for set boundary conditions method. More...
 
vector< double > bc_fluxes_
 Same as previous. More...
 
vector< double > bc_ref_values_
 Same as previous. More...
 

Friends

class TransportDG< Model >
 
template<template< IntDim... > class DimAssembly>
class GenericAssembly
 

Additional Inherited Members

- Static Public Member Functions inherited from AssemblyBase< dim >
template<template< int dim > class Impl, class Data >
static MultidimAssembly create (Data data)
 
- Protected Attributes inherited from AssemblyBase< dim >
Quadraturequad_
 Quadrature used in assembling methods. More...
 
Quadraturequad_low_
 Quadrature used in assembling methods (dim-1). More...
 

Detailed Description

template<unsigned int dim, class Model>
class BdrConditionAssemblyDG< dim, Model >

Assembles the r.h.s. components corresponding to the Dirichlet boundary conditions..

Definition at line 1195 of file assembly_dg.hh.

Member Typedef Documentation

template<unsigned int dim, class Model >
typedef TransportDG<Model>::EqData BdrConditionAssemblyDG< dim, Model >::EqDataDG

Definition at line 1198 of file assembly_dg.hh.

Constructor & Destructor Documentation

template<unsigned int dim, class Model >
BdrConditionAssemblyDG< dim, Model >::BdrConditionAssemblyDG ( EqDataDG data)
inline

Constructor.

Definition at line 1201 of file assembly_dg.hh.

template<unsigned int dim, class Model >
BdrConditionAssemblyDG< dim, Model >::~BdrConditionAssemblyDG ( )
inline

Destructor.

Definition at line 1205 of file assembly_dg.hh.

Member Function Documentation

template<unsigned int dim, class Model >
void BdrConditionAssemblyDG< dim, Model >::assemble_volume_integrals ( DHCellAccessor  cell)
inlineoverride

Assemble integral over element.

Definition at line 1235 of file assembly_dg.hh.

template<unsigned int dim, class Model >
void BdrConditionAssemblyDG< dim, Model >::begin ( )
inlineoverridevirtual

Implements AssemblyBase::begin.

Reimplemented from AssemblyBase< dim >.

Definition at line 1363 of file assembly_dg.hh.

template<unsigned int dim, class Model >
void BdrConditionAssemblyDG< dim, Model >::calculate_velocity ( const ElementAccessor< 3 > &  cell,
vector< arma::vec3 > &  velocity,
const Armor::array point_list 
)
inlineprivate

Calculates the velocity field on a given cell.

Parameters
cellThe cell.
velocityThe computed velocity field (at quadrature points).
point_listThe quadrature points.

Definition at line 1383 of file assembly_dg.hh.

template<unsigned int dim, class Model >
void BdrConditionAssemblyDG< dim, Model >::end ( )
inlineoverridevirtual

Implements AssemblyBase::end.

Reimplemented from AssemblyBase< dim >.

Definition at line 1369 of file assembly_dg.hh.

template<unsigned int dim, class Model >
void BdrConditionAssemblyDG< dim, Model >::initialize ( TransportDG< Model > &  model)
inline

Initialize auxiliary vectors and other data members.

Definition at line 1212 of file assembly_dg.hh.

Friends And Related Function Documentation

template<unsigned int dim, class Model >
template<template< IntDim... > class DimAssembly>
friend class GenericAssembly
friend

Definition at line 1418 of file assembly_dg.hh.

template<unsigned int dim, class Model >
friend class TransportDG< Model >
friend

Definition at line 1416 of file assembly_dg.hh.

Member Data Documentation

template<unsigned int dim, class Model >
vector<double> BdrConditionAssemblyDG< dim, Model >::bc_fluxes_
private

Same as previous.

Definition at line 1413 of file assembly_dg.hh.

template<unsigned int dim, class Model >
vector<double> BdrConditionAssemblyDG< dim, Model >::bc_ref_values_
private

Same as previous.

Definition at line 1414 of file assembly_dg.hh.

template<unsigned int dim, class Model >
vector<double> BdrConditionAssemblyDG< dim, Model >::bc_values_
private

Auxiliary vector for set boundary conditions method.

Definition at line 1412 of file assembly_dg.hh.

template<unsigned int dim, class Model >
vector<double> BdrConditionAssemblyDG< dim, Model >::csection_
private

Auxiliary vector for assemble boundary fluxes, element-side fluxes and set boundary conditions.

Definition at line 1411 of file assembly_dg.hh.

template<unsigned int dim, class Model >
EqDataDG* BdrConditionAssemblyDG< dim, Model >::data_
private

Data object shared with TransportDG.

Definition at line 1397 of file assembly_dg.hh.

template<unsigned int dim, class Model >
vector<LongIdx> BdrConditionAssemblyDG< dim, Model >::dof_indices_
private

Vector of global DOF indices.

Definition at line 1405 of file assembly_dg.hh.

template<unsigned int dim, class Model >
shared_ptr<FiniteElement<dim> > BdrConditionAssemblyDG< dim, Model >::fe_
private

Finite element for the solution of the advection-diffusion equation.

Definition at line 1390 of file assembly_dg.hh.

template<unsigned int dim, class Model >
FiniteElement<dim>* BdrConditionAssemblyDG< dim, Model >::fe_rt_
private

Finite element for the water velocity field.

Definition at line 1391 of file assembly_dg.hh.

template<unsigned int dim, class Model >
FEValues<3> BdrConditionAssemblyDG< dim, Model >::fe_values_side_
private

FEValues of object (of P disc finite element type)

Definition at line 1402 of file assembly_dg.hh.

template<unsigned int dim, class Model >
FEValues<3> BdrConditionAssemblyDG< dim, Model >::fsv_rt_
private

FEValues of object (of RT0 finite element type)

Definition at line 1403 of file assembly_dg.hh.

template<unsigned int dim, class Model >
PetscScalar BdrConditionAssemblyDG< dim, Model >::local_flux_balance_rhs_
private

Auxiliary variable for set_boundary_conditions method.

Definition at line 1408 of file assembly_dg.hh.

template<unsigned int dim, class Model >
vector<PetscScalar> BdrConditionAssemblyDG< dim, Model >::local_flux_balance_vector_
private

Auxiliary vector for set_boundary_conditions method.

Definition at line 1407 of file assembly_dg.hh.

template<unsigned int dim, class Model >
vector<PetscScalar> BdrConditionAssemblyDG< dim, Model >::local_rhs_
private

Auxiliary vector for set_sources method.

Definition at line 1406 of file assembly_dg.hh.

template<unsigned int dim, class Model >
TransportDG<Model>* BdrConditionAssemblyDG< dim, Model >::model_
private

Pointer to model (we must use common ancestor of concentration and heat model)

Definition at line 1394 of file assembly_dg.hh.

template<unsigned int dim, class Model >
unsigned int BdrConditionAssemblyDG< dim, Model >::ndofs_
private

Number of dofs.

Definition at line 1399 of file assembly_dg.hh.

template<unsigned int dim, class Model >
unsigned int BdrConditionAssemblyDG< dim, Model >::qsize_
private

Size of quadrature of actual dim.

Definition at line 1400 of file assembly_dg.hh.

template<unsigned int dim, class Model >
unsigned int BdrConditionAssemblyDG< dim, Model >::qsize_lower_dim_
private

Size of quadrature of dim-1.

Definition at line 1401 of file assembly_dg.hh.

template<unsigned int dim, class Model >
vector<double> BdrConditionAssemblyDG< dim, Model >::sigma_
private

Auxiliary vector for assemble boundary fluxes (robin sigma), element-side fluxes (frac sigma) and set boundary conditions method.

Definition at line 1410 of file assembly_dg.hh.

template<unsigned int dim, class Model >
vector<arma::vec3> BdrConditionAssemblyDG< dim, Model >::velocity_
private

Auxiliary results.

Definition at line 1409 of file assembly_dg.hh.


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