version 3.9.0
Loading...
Searching...
No Matches
Dumux::Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average > Class Template Reference

Manages the coupling between bulk elements and lower dimensional elements Point sources on each integration point are computed by an AABB tree. More...

#include <dumux/multidomain/embedded/couplingmanager1d3d_average.hh>

Inheritance diagram for Dumux::Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >:

Description

template<class MDTraits>
class Dumux::Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >
Note
Specialization for coupling method using line sources with 3d quantities averaged on the cylinder surface

Public Types

enum  { bulkDim = GridView<bulkIdx>::dimension , lowDimDim = GridView<lowDimIdx>::dimension , dimWorld = GridView<bulkIdx>::dimensionworld }
 
using MultiDomainTraits
 export traits
 
using PointSourceTraits
 export the point source traits
 
using CouplingStencils
 export stencil types
 
using CouplingStencilType
 default type used for coupling element stencils
 

Public Member Functions

void init (std::shared_ptr< Problem< bulkIdx > > bulkProblem, std::shared_ptr< Problem< lowDimIdx > > lowDimProblem, const SolutionVector &curSol)
 
template<std::size_t id, class JacobianPattern >
void extendJacobianPattern (Dune::index_constant< id > domainI, JacobianPattern &pattern) const
 extend the jacobian pattern of the diagonal block of domain i by those entries that are not already in the uncoupled pattern
 
template<std::size_t i, class LocalAssemblerI , class JacobianMatrixDiagBlock , class GridVariables >
void evalAdditionalDomainDerivatives (Dune::index_constant< i > domainI, const LocalAssemblerI &localAssemblerI, const typename LocalAssemblerI::LocalResidual::ElementResidualVector &, JacobianMatrixDiagBlock &A, GridVariables &gridVariables)
 evaluate additional derivatives of the element residual of a domain with respect to dofs in the same domain that are not in the regular stencil (per default this is not the case)
 
void computePointSourceData (std::size_t order=1, bool verbose=false)
 
void computeLowDimVolumeFractions ()
 Compute the low dim volume fraction in the bulk domain cells.
 
Scalar radius (std::size_t id) const
 Methods to be accessed by the subproblems.
 
Scalar lowDimVolume (const Element< bulkIdx > &element) const
 The volume the lower dimensional domain occupies in the bulk domain element.
 
Scalar lowDimVolumeFraction (const Element< bulkIdx > &element) const
 The volume fraction the lower dimensional domain occupies in the bulk domain element.
 
const ParentType::template CouplingStencils< bulkIdx >::mapped_type & extendedSourceStencil (std::size_t eIdx) const
 Extended source stencil (for the bulk domain)
 
void updateAfterGridAdaption (std::shared_ptr< const GridGeometry< bulkIdx > > bulkGridGeometry, std::shared_ptr< const GridGeometry< lowDimIdx > > lowDimGridGeometry)
 call this after grid adaption
 
const CouplingStencil< j > & couplingStencil (Dune::index_constant< i > domainI, const Element< i > &element, Dune::index_constant< j > domainJ) const
 Methods to be accessed by the assembly.
 
decltype(auto) evalCouplingResidual (Dune::index_constant< i > domainI, const LocalAssemblerI &localAssemblerI, Dune::index_constant< j > domainJ, std::size_t dofIdxGlobalJ)
 evaluates the element residual of a coupled element of domain i which depends on the variables at the degree of freedom with index dofIdxGlobalJ of domain j
 
const PointSourceData & pointSourceData (std::size_t id) const
 Methods to be accessed by the subproblems.
 
const std::vector< PointSourceData > & pointSourceData () const
 Return reference to point source data vector member.
 
const GridView< id > & gridView (Dune::index_constant< id > domainIdx) const
 Return a reference to the bulk problem.
 
PrimaryVariables< bulkIdx > bulkPriVars (std::size_t id) const
 Return data for a bulk point source with the identifier id.
 
PrimaryVariables< lowDimIdx > lowDimPriVars (std::size_t id) const
 Return data for a low dim point source with the identifier id.
 
Scalar averageDistance (std::size_t id) const
 return the average distance to the coupled bulk cell center
 
const std::vector< PointSource< bulkIdx > > & bulkPointSources () const
 Return reference to bulk point sources.
 
const std::vector< PointSource< lowDimIdx > > & lowDimPointSources () const
 Return reference to low dim point sources.
 
const std::vector< PointSource< i > > & pointSources (Dune::index_constant< i > dom) const
 Return the point source if domain i.
 
const CouplingStencils< i > & couplingStencils (Dune::index_constant< i > dom) const
 Return reference to bulk coupling stencil member of domain i.
 
const CouplingStencil< i > & emptyStencil (Dune::index_constant< i > dom) const
 Return a reference to an empty stencil.
 
auto & curSol (Dune::index_constant< i > domainIdx)
 the solution vector of the subproblem
 
const auto & curSol (Dune::index_constant< i > domainIdx) const
 the solution vector of the subproblem
 
void computeColorsForAssembly ()
 Compute colors for multithreaded assembly.
 
void assembleMultithreaded (Dune::index_constant< i > domainId, AssembleElementFunc &&assembleElement) const
 Execute assembly kernel in parallel.
 

Static Public Attributes

static constexpr Embedded1d3dCouplingMode::Average couplingMode {}
 

Protected Types

using SolutionVectorStorage
 the type in which the solution vector is stored in the manager
 

Protected Member Functions

std::vector< PointSourceData > & pointSourceData ()
 Return reference to point source data vector member.
 
std::vector< PointSource< i > > & pointSources (Dune::index_constant< i > dom)
 Return the point source if domain i.
 
CouplingStencils< i > & couplingStencils (Dune::index_constant< i > dom)
 Return reference to bulk coupling stencil member of domain i.
 
void precomputeVertexIndices (Dune::index_constant< id > domainIdx)
 computes the vertex indices per element for the box method
 
void getShapeValues (Dune::index_constant< i > domainI, const FVGG &gridGeometry, const Geometry &geo, const GlobalPosition &globalPos, ShapeValues &shapeValues)
 compute the shape function for a given point and geometry
 
void clear ()
 Clear all internal data members.
 
void glueGrids ()
 compute the intersections between the two grids
 
std::vector< Scalar > & averageDistanceToBulkCell ()
 Return reference to average distances to bulk cell.
 
std::vector< GridIndex< i > > & vertexIndices (Dune::index_constant< i > dom, GridIndex< i > eIdx)
 Return a reference to the vertex indices.
 
std::vector< std::vector< GridIndex< i > > > & vertexIndices (Dune::index_constant< i > dom)
 Return a reference to the vertex indices container.
 
const GlueTypeglue () const
 
Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average > & asImp_ ()
 Returns the implementation of the problem (i.e. static polymorphism)
 
const Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average > & asImp_ () const
 Returns the implementation of the problem (i.e. static polymorphism)
 

Protected Attributes

std::size_t idCounter_
 id generator for point sources
 

member functions concerning variable caching for element residual evaluations

decltype(auto) evalCouplingResidual (Dune::index_constant< i > domainI, const LocalAssemblerI &localAssemblerI, Dune::index_constant< j > domainJ, std::size_t dofIdxGlobalJ) const
 evaluates the element residual of a coupled element of domain i which depends on the variables at the degree of freedom with index dofIdxGlobalJ of domain j
 
void bindCouplingContext (Dune::index_constant< i > domainI, const Element< i > &elementI, const Assembler &assembler)
 prepares all data and variables that are necessary to evaluate the residual of the element of domain i
 
void updateCouplingContext (Dune::index_constant< i > domainI, const LocalAssemblerI &localAssemblerI, Dune::index_constant< j > domainJ, std::size_t dofIdxGlobalJ, const PrimaryVariables< j > &priVarsJ, int pvIdxJ)
 updates all data and variables that are necessary to evaluate the residual of the element of domain i this is called whenever one of the primary variables that the element residual depends on changes in domain j
 
void updateCoupledVariables (Dune::index_constant< i > domainI, const LocalAssemblerI &localAssemblerI, UpdatableElementVolVars &elemVolVars, UpdatableFluxVarCache &elemFluxVarsCache)
 update variables of domain i that depend on variables in domain j after the coupling context has been updated
 
void updateSolution (const SolutionVector &curSol)
 Updates the entire solution vector, e.g. before assembly or after grid adaption Overload might want to overload function if the solution vector is stored outside this class to make sure updates don't happen more than once.
 
decltype(auto) numericEpsilon (Dune::index_constant< i >, const std::string &paramGroup) const
 return the numeric epsilon used for deflecting primary variables of coupled domain i
 
void setSubProblems (const std::tuple< std::shared_ptr< SubProblems >... > &problems)
 set the pointers to the sub problems
 
void setSubProblem (std::shared_ptr< SubProblem > problem, Dune::index_constant< i > domainIdx)
 set a pointer to one of the sub problems
 
const Problem< i > & problem (Dune::index_constant< i > domainIdx) const
 Return a reference to the sub problem.
 
void attachSolution (SolutionVectorStorage &curSol)
 Attach a solution vector stored outside of this class.
 

Member Typedef Documentation

◆ CouplingStencils

◆ CouplingStencilType

using Dumux::CouplingManager< MDTraits >::CouplingStencilType
inherited

◆ MultiDomainTraits

◆ PointSourceTraits

◆ SolutionVectorStorage

using Dumux::CouplingManager< MDTraits >::SolutionVectorStorage
protectedinherited

Member Enumeration Documentation

◆ anonymous enum

template<class MDTraits >
anonymous enum
Enumerator
bulkDim 
lowDimDim 
dimWorld 

Member Function Documentation

◆ asImp_() [1/2]

◆ asImp_() [2/2]

◆ assembleMultithreaded()

void Dumux::EmbeddedCouplingManagerBase< MDTraits, Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >, CircleAveragePointSourceTraits< MDTraits > >::assembleMultithreaded ( Dune::index_constant< i > domainId,
AssembleElementFunc && assembleElement ) const
inlineinherited
Parameters
domainIdthe domain index of domain i
assembleElementkernel function to execute for one element

◆ attachSolution()

void Dumux::CouplingManager< MDTraits >::attachSolution ( SolutionVectorStorage & curSol)
inlineprotectedinherited
Note
The caller has to make sure that curSol stays alive for the lifetime of the coupling manager. Otherwise we have a dangling reference here. Use with care.

◆ averageDistance()

Scalar Dumux::EmbeddedCouplingManagerBase< MDTraits, Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >, CircleAveragePointSourceTraits< MDTraits > >::averageDistance ( std::size_t id) const
inlineinherited

◆ averageDistanceToBulkCell()

std::vector< Scalar > & Dumux::EmbeddedCouplingManagerBase< MDTraits, Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >, CircleAveragePointSourceTraits< MDTraits > >::averageDistanceToBulkCell ( )
inlineprotectedinherited

◆ bindCouplingContext()

void Dumux::CouplingManager< MDTraits >::bindCouplingContext ( Dune::index_constant< i > domainI,
const Element< i > & elementI,
const Assembler & assembler )
inlineinherited
Parameters
domainIthe domain index of domain i
elementIthe element whose residual we are assemling next
assemblerthe multidomain assembler for access to all data necessary for the assembly of all domains
Note
this concerns all data that is used in the evaluation of the element residual and depends on one of the degrees of freedom returned by CouplingManager::couplingStencil
every coupled element residual depends at least on the solution of another domain, that why we always store a copy of the solution vector in the coupling manager, hence, in case the element residual only depends on primary variables of the other domain this function does nothing
overload this function in case the element residual depends on more than the primary variables of domain j

◆ bulkPointSources()

const std::vector< PointSource< bulkIdx > > & Dumux::EmbeddedCouplingManagerBase< MDTraits, Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >, CircleAveragePointSourceTraits< MDTraits > >::bulkPointSources ( ) const
inlineinherited

◆ bulkPriVars()

PrimaryVariables< bulkIdx > Dumux::EmbeddedCouplingManagerBase< MDTraits, Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >, CircleAveragePointSourceTraits< MDTraits > >::bulkPriVars ( std::size_t id) const
inlineinherited

◆ clear()

void Dumux::EmbeddedCouplingManagerBase< MDTraits, Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >, CircleAveragePointSourceTraits< MDTraits > >::clear ( )
inlineprotectedinherited

◆ computeColorsForAssembly()

void Dumux::EmbeddedCouplingManagerBase< MDTraits, Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >, CircleAveragePointSourceTraits< MDTraits > >::computeColorsForAssembly ( )
inlineinherited

◆ computeLowDimVolumeFractions()

template<class MDTraits >
void Dumux::Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >::computeLowDimVolumeFractions ( )
inline

◆ computePointSourceData()

template<class MDTraits >
void Dumux::Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >::computePointSourceData ( std::size_t order = 1,
bool verbose = false )
inline

◆ couplingStencil()

const CouplingStencil< j > & Dumux::EmbeddedCouplingManagerBase< MDTraits, Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >, CircleAveragePointSourceTraits< MDTraits > >::couplingStencil ( Dune::index_constant< i > domainI,
const Element< i > & element,
Dune::index_constant< j > domainJ ) const
inlineinherited

returns an iterable container of all indices of degrees of freedom of domain j that couple with / influence the element residual of the given element of domain i

Parameters
domainIthe domain index of domain i
elementthe coupled element of domain í
domainJthe domain index of domain j
Note
The element residual definition depends on the discretization scheme of domain i box: a container of the residuals of all sub control volumes cc : the residual of the (sub) control volume fem: the residual of the element
This function has to be implemented by all coupling managers for all combinations of i and j

◆ couplingStencils() [1/2]

CouplingStencils< i > & Dumux::EmbeddedCouplingManagerBase< MDTraits, Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >, CircleAveragePointSourceTraits< MDTraits > >::couplingStencils ( Dune::index_constant< i > dom)
inlineprotectedinherited

◆ couplingStencils() [2/2]

const CouplingStencils< i > & Dumux::EmbeddedCouplingManagerBase< MDTraits, Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >, CircleAveragePointSourceTraits< MDTraits > >::couplingStencils ( Dune::index_constant< i > dom) const
inlineinherited

◆ curSol() [1/2]

auto & Dumux::EmbeddedCouplingManagerBase< MDTraits, Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >, CircleAveragePointSourceTraits< MDTraits > >::curSol ( Dune::index_constant< i > domainIdx)
inlineinherited
Parameters
domainIdxThe domain index
Note
in case of numeric differentiation the solution vector always carries the deflected solution

◆ curSol() [2/2]

const auto & Dumux::EmbeddedCouplingManagerBase< MDTraits, Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >, CircleAveragePointSourceTraits< MDTraits > >::curSol ( Dune::index_constant< i > domainIdx) const
inlineinherited
Parameters
domainIdxThe domain index
Note
in case of numeric differentiation the solution vector always carries the deflected solution

◆ emptyStencil()

const CouplingStencil< i > & Dumux::EmbeddedCouplingManagerBase< MDTraits, Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >, CircleAveragePointSourceTraits< MDTraits > >::emptyStencil ( Dune::index_constant< i > dom) const
inlineinherited

◆ evalAdditionalDomainDerivatives()

template<class MDTraits >
template<std::size_t i, class LocalAssemblerI , class JacobianMatrixDiagBlock , class GridVariables >
void Dumux::Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >::evalAdditionalDomainDerivatives ( Dune::index_constant< i > domainI,
const LocalAssemblerI & localAssemblerI,
const typename LocalAssemblerI::LocalResidual::ElementResidualVector & ,
JacobianMatrixDiagBlock & A,
GridVariables & gridVariables )
inline
Note
Such additional dependencies can arise from the coupling, e.g. if a coupling source term depends on a non-local average of a quantity of the same domain
This is the same for box and cc

◆ evalCouplingResidual() [1/2]

decltype(auto) Dumux::CouplingManager< MDTraits >::evalCouplingResidual ( Dune::index_constant< i > domainI,
const LocalAssemblerI & localAssemblerI,
Dune::index_constant< j > domainJ,
std::size_t dofIdxGlobalJ ) const
inlineinherited
Parameters
domainIthe domain index of domain i
localAssemblerIthe local assembler assembling the element residual of an element of domain i
domainJthe domain index of domain j
dofIdxGlobalJthe index of the degree of freedom of domain j which has an influence on the element residual of domain i
Note
the element whose residual is to be evaluated can be retrieved from the local assembler as localAssemblerI.element() as well as all up-to-date variables and caches.
the default implementation evaluates the complete element residual if only parts (i.e. only certain scvs, or only certain terms of the residual) of the residual are coupled to dof with index dofIdxGlobalJ the function can be overloaded in the coupling manager
Returns
the element residual

◆ evalCouplingResidual() [2/2]

decltype(auto) Dumux::EmbeddedCouplingManagerBase< MDTraits, Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >, CircleAveragePointSourceTraits< MDTraits > >::evalCouplingResidual ( Dune::index_constant< i > domainI,
const LocalAssemblerI & localAssemblerI,
Dune::index_constant< j > domainJ,
std::size_t dofIdxGlobalJ )
inlineinherited
Parameters
domainIthe domain index of domain i
localAssemblerIthe local assembler assembling the element residual of an element of domain i
domainJthe domain index of domain j
dofIdxGlobalJthe index of the degree of freedom of domain j which has an influence on the element residual of domain i
Note
we only need to evaluate the source contribution to the residual here as the coupling term is the source
Returns
the element residual

◆ extendedSourceStencil()

template<class MDTraits >
const ParentType::template CouplingStencils< bulkIdx >::mapped_type & Dumux::Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >::extendedSourceStencil ( std::size_t eIdx) const
inline

◆ extendJacobianPattern()

template<class MDTraits >
template<std::size_t id, class JacobianPattern >
void Dumux::Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >::extendJacobianPattern ( Dune::index_constant< id > domainI,
JacobianPattern & pattern ) const
inline
Note
Such additional dependencies can arise from the coupling, e.g. if a coupling source term depends on a non-local average of a quantity of the same domain

◆ getShapeValues()

void Dumux::EmbeddedCouplingManagerBase< MDTraits, Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >, CircleAveragePointSourceTraits< MDTraits > >::getShapeValues ( Dune::index_constant< i > domainI,
const FVGG & gridGeometry,
const Geometry & geo,
const GlobalPosition & globalPos,
ShapeValues & shapeValues )
inlineprotectedinherited

◆ glue()

const GlueType & Dumux::EmbeddedCouplingManagerBase< MDTraits, Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >, CircleAveragePointSourceTraits< MDTraits > >::glue ( ) const
inlineprotectedinherited

◆ glueGrids()

void Dumux::EmbeddedCouplingManagerBase< MDTraits, Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >, CircleAveragePointSourceTraits< MDTraits > >::glueGrids ( )
inlineprotectedinherited

◆ gridView()

const GridView< id > & Dumux::EmbeddedCouplingManagerBase< MDTraits, Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >, CircleAveragePointSourceTraits< MDTraits > >::gridView ( Dune::index_constant< id > domainIdx) const
inlineinherited

◆ init()

template<class MDTraits >
void Dumux::Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >::init ( std::shared_ptr< Problem< bulkIdx > > bulkProblem,
std::shared_ptr< Problem< lowDimIdx > > lowDimProblem,
const SolutionVector & curSol )
inline

◆ lowDimPointSources()

const std::vector< PointSource< lowDimIdx > > & Dumux::EmbeddedCouplingManagerBase< MDTraits, Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >, CircleAveragePointSourceTraits< MDTraits > >::lowDimPointSources ( ) const
inlineinherited

◆ lowDimPriVars()

PrimaryVariables< lowDimIdx > Dumux::EmbeddedCouplingManagerBase< MDTraits, Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >, CircleAveragePointSourceTraits< MDTraits > >::lowDimPriVars ( std::size_t id) const
inlineinherited

◆ lowDimVolume()

template<class MDTraits >
Scalar Dumux::Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >::lowDimVolume ( const Element< bulkIdx > & element) const
inline

◆ lowDimVolumeFraction()

template<class MDTraits >
Scalar Dumux::Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >::lowDimVolumeFraction ( const Element< bulkIdx > & element) const
inline

◆ numericEpsilon()

decltype(auto) Dumux::CouplingManager< MDTraits >::numericEpsilon ( Dune::index_constant< i > ,
const std::string & paramGroup ) const
inlineinherited

◆ pointSourceData() [1/3]

std::vector< PointSourceData > & Dumux::EmbeddedCouplingManagerBase< MDTraits, Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >, CircleAveragePointSourceTraits< MDTraits > >::pointSourceData ( )
inlineprotectedinherited

◆ pointSourceData() [2/3]

const std::vector< PointSourceData > & Dumux::EmbeddedCouplingManagerBase< MDTraits, Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >, CircleAveragePointSourceTraits< MDTraits > >::pointSourceData ( ) const
inlineinherited

◆ pointSourceData() [3/3]

const PointSourceData & Dumux::EmbeddedCouplingManagerBase< MDTraits, Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >, CircleAveragePointSourceTraits< MDTraits > >::pointSourceData ( std::size_t id) const
inlineinherited

Return a reference to the pointSource data

◆ pointSources() [1/2]

std::vector< PointSource< i > > & Dumux::EmbeddedCouplingManagerBase< MDTraits, Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >, CircleAveragePointSourceTraits< MDTraits > >::pointSources ( Dune::index_constant< i > dom)
inlineprotectedinherited

◆ pointSources() [2/2]

const std::vector< PointSource< i > > & Dumux::EmbeddedCouplingManagerBase< MDTraits, Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >, CircleAveragePointSourceTraits< MDTraits > >::pointSources ( Dune::index_constant< i > dom) const
inlineinherited

◆ precomputeVertexIndices()

void Dumux::EmbeddedCouplingManagerBase< MDTraits, Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >, CircleAveragePointSourceTraits< MDTraits > >::precomputeVertexIndices ( Dune::index_constant< id > domainIdx)
inlineprotectedinherited

◆ problem()

const Problem< i > & Dumux::CouplingManager< MDTraits >::problem ( Dune::index_constant< i > domainIdx) const
inlineinherited
Parameters
domainIdxThe domain index We avoid exception handling here because the performance of this function is critical

◆ radius()

template<class MDTraits >
Scalar Dumux::Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >::radius ( std::size_t id) const
inline

Return a reference to the bulk problem

◆ setSubProblem()

void Dumux::CouplingManager< MDTraits >::setSubProblem ( std::shared_ptr< SubProblem > problem,
Dune::index_constant< i > domainIdx )
inlineinherited
Parameters
problema pointer to the sub problem
domainIdxthe domain index of the sub problem

◆ setSubProblems()

void Dumux::CouplingManager< MDTraits >::setSubProblems ( const std::tuple< std::shared_ptr< SubProblems >... > & problems)
inlineinherited
Parameters
problemsA tuple of shared pointers to the sub problems

◆ updateAfterGridAdaption()

void Dumux::EmbeddedCouplingManagerBase< MDTraits, Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >, CircleAveragePointSourceTraits< MDTraits > >::updateAfterGridAdaption ( std::shared_ptr< const GridGeometry< bulkIdx > > bulkGridGeometry,
std::shared_ptr< const GridGeometry< lowDimIdx > > lowDimGridGeometry )
inlineinherited

◆ updateCoupledVariables()

void Dumux::CouplingManager< MDTraits >::updateCoupledVariables ( Dune::index_constant< i > domainI,
const LocalAssemblerI & localAssemblerI,
UpdatableElementVolVars & elemVolVars,
UpdatableFluxVarCache & elemFluxVarsCache )
inlineinherited
Parameters
domainIthe index of domain i
localAssemblerIthe local assembler assembling the element residual of an element of domain i
elemVolVarsthe element volume variables (all volume variables in the element local stencil) to be updated
elemFluxVarsCachethe element flux variable cache (all flux variables in the element local stencil) to be updated
Note
Such variables do not necessarily exist and then this function does nothing (default)
some examples from geomechanics: the porosity of (physical) domain i (porous medium flow) depends on the displacement vector of physical domain j (mechanics) from domaindecomposition: the transmissibilities for fluxes of domain i to domain j depend on the permeability in domain j (which might depend in turn on the primary variables of domain i)

◆ updateCouplingContext()

void Dumux::CouplingManager< MDTraits >::updateCouplingContext ( Dune::index_constant< i > domainI,
const LocalAssemblerI & localAssemblerI,
Dune::index_constant< j > domainJ,
std::size_t dofIdxGlobalJ,
const PrimaryVariables< j > & priVarsJ,
int pvIdxJ )
inlineinherited
Parameters
domainIthe domain index of domain i
localAssemblerIthe local assembler assembling the element residual of an element of domain i
domainJthe domain index of domain j
dofIdxGlobalJthe index of the degree of freedom of domain j whose solution changed
priVarsJthe new solution at the degree of freedom of domain j with index dofIdxGlobalJ
pvIdxJthe index of the primary variable of domain j which has been updated
Note
this concerns all data that is used in the evaluation of the element residual and depends on the primary variables at the degree of freedom location with index dofIdxGlobalJ
the element whose residual is to be evaluated can be retrieved from the local assembler as localAssemblerI.element()
per default, we update the solution vector, if the element residual of domain i depends on more than the primary variables of domain j update the other dependent data here by overloading this function

◆ updateSolution()

void Dumux::CouplingManager< MDTraits >::updateSolution ( const SolutionVector & curSol)
inlineinherited

◆ vertexIndices() [1/2]

std::vector< std::vector< GridIndex< i > > > & Dumux::EmbeddedCouplingManagerBase< MDTraits, Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >, CircleAveragePointSourceTraits< MDTraits > >::vertexIndices ( Dune::index_constant< i > dom)
inlineprotectedinherited

◆ vertexIndices() [2/2]

std::vector< GridIndex< i > > & Dumux::EmbeddedCouplingManagerBase< MDTraits, Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >, CircleAveragePointSourceTraits< MDTraits > >::vertexIndices ( Dune::index_constant< i > dom,
GridIndex< i > eIdx )
inlineprotectedinherited

Member Data Documentation

◆ couplingMode

template<class MDTraits >
Embedded1d3dCouplingMode::Average Dumux::Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >::couplingMode {}
staticconstexpr

◆ idCounter_

std::size_t Dumux::EmbeddedCouplingManagerBase< MDTraits, Embedded1d3dCouplingManager< MDTraits, Embedded1d3dCouplingMode::Average >, CircleAveragePointSourceTraits< MDTraits > >::idCounter_
protectedinherited

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