Chaste Commit::f2ff7ee04e70ac9d06c57344df8d017dbb12b97b
UniformSourceParabolicPde< DIM > Class Template Reference

#include <UniformSourceParabolicPde.hpp>

+ Inheritance diagram for UniformSourceParabolicPde< DIM >:
+ Collaboration diagram for UniformSourceParabolicPde< DIM >:

Public Member Functions

 UniformSourceParabolicPde (double sourceCoefficient=0.0)
 
double GetCoefficient () const
 
double ComputeSourceTerm (const ChastePoint< DIM > &rX, double u, Element< DIM, DIM > *pElement=NULL)
 
c_matrix< double, DIM, DIM > ComputeDiffusionTerm (const ChastePoint< DIM > &rX, Element< DIM, DIM > *pElement=NULL)
 
double ComputeDuDtCoefficientFunction (const ChastePoint< DIM > &rX)
 
- Public Member Functions inherited from AbstractLinearParabolicPde< DIM, DIM >
 AbstractLinearParabolicPde ()
 
virtual ~AbstractLinearParabolicPde ()
 
virtual double ComputeDuDtCoefficientFunction (const ChastePoint< SPACE_DIM > &rX)=0
 
virtual double ComputeSourceTerm (const ChastePoint< SPACE_DIM > &rX, double u, Element< ELEMENT_DIM, SPACE_DIM > *pElement=nullptr)=0
 
virtual double ComputeSourceTermAtNode (const Node< SPACE_DIM > &rNode, double u)
 
virtual c_matrix< double, SPACE_DIM, SPACE_DIM > ComputeDiffusionTerm (const ChastePoint< SPACE_DIM > &rX, Element< ELEMENT_DIM, SPACE_DIM > *pElement=NULL)=0
 
- Public Member Functions inherited from AbstractLinearPde< ELEMENT_DIM, SPACE_DIM >
 AbstractLinearPde ()
 
virtual ~AbstractLinearPde ()
 

Private Member Functions

template<class Archive >
void serialize (Archive &archive, const unsigned int version)
 

Private Attributes

double mSourceCoefficient
 

Friends

class TestCellBasedParabolicPdes
 
class boost::serialization::access
 

Detailed Description

template<unsigned DIM>
class UniformSourceParabolicPde< DIM >

A parabolic PDE to be solved numerically using the finite element method, for coupling to a cell-based simulation.

The PDE takes the form

du/dt = Grad.(Grad(u)) + k,

where the scalar k is specified by the member mSourceCoefficient, whose value must be set in the constructor.

Thus, there is no direct coupling between the cell-based simulation and the terms of the PDE; here, the cell population just defines the spatial domain on which to solve the PDE.

Definition at line 60 of file UniformSourceParabolicPde.hpp.

Constructor & Destructor Documentation

◆ UniformSourceParabolicPde()

template<unsigned DIM>
UniformSourceParabolicPde< DIM >::UniformSourceParabolicPde ( double  sourceCoefficient = 0.0)

Constructor.

Parameters
sourceCoefficientthe source term coefficient (defaults to 0.0)

Definition at line 39 of file UniformSourceParabolicPde.cpp.

Member Function Documentation

◆ ComputeDiffusionTerm()

template<unsigned DIM>
c_matrix< double, DIM, DIM > UniformSourceParabolicPde< DIM >::ComputeDiffusionTerm ( const ChastePoint< DIM > &  rX,
Element< DIM, DIM > *  pElement = NULL 
)

Overridden ComputeDiffusionTerm() method.

Parameters
rXthe point in space at which the diffusion term is computed
pElementthe mesh element that x is contained in (optional; defaults to NULL).
Returns
a matrix.

Definition at line 57 of file UniformSourceParabolicPde.cpp.

◆ ComputeDuDtCoefficientFunction()

template<unsigned DIM>
double UniformSourceParabolicPde< DIM >::ComputeDuDtCoefficientFunction ( const ChastePoint< DIM > &  rX)

Overridden ComputeDuDtCoefficientFunction() method.

Returns
the function c(x) in "c(x) du/dt = Grad.(DiffusionTerm(x)*Grad(u))+LinearSourceTerm(x)+NonlinearSourceTerm(x, u)"
Parameters
rXthe point in space at which the function c is computed

Definition at line 63 of file UniformSourceParabolicPde.cpp.

◆ ComputeSourceTerm()

template<unsigned DIM>
double UniformSourceParabolicPde< DIM >::ComputeSourceTerm ( const ChastePoint< DIM > &  rX,
double  u,
Element< DIM, DIM > *  pElement = NULL 
)

Overridden ComputeSourceTerm() method.

Parameters
rXthe point in space at which the nonlinear source term is computed
uthe value of the dependent variable at the point
pElementThe element
Returns
the the source term.

Definition at line 51 of file UniformSourceParabolicPde.cpp.

◆ GetCoefficient()

template<unsigned DIM>
double UniformSourceParabolicPde< DIM >::GetCoefficient ( ) const
Returns
mSourceCoefficient

Definition at line 45 of file UniformSourceParabolicPde.cpp.

◆ serialize()

template<unsigned DIM>
template<class Archive >
void UniformSourceParabolicPde< DIM >::serialize ( Archive &  archive,
const unsigned int  version 
)
inlineprivate

Serialize the PDE and its member variables.

Parameters
archivethe archive
versionthe current version of this class

Definition at line 75 of file UniformSourceParabolicPde.hpp.

References UniformSourceParabolicPde< DIM >::mSourceCoefficient.

Friends And Related Symbol Documentation

◆ boost::serialization::access

template<unsigned DIM>
friend class boost::serialization::access
friend

Needed for serialization.

Definition at line 67 of file UniformSourceParabolicPde.hpp.

◆ TestCellBasedParabolicPdes

template<unsigned DIM>
friend class TestCellBasedParabolicPdes
friend

Definition at line 62 of file UniformSourceParabolicPde.hpp.

Member Data Documentation

◆ mSourceCoefficient

template<unsigned DIM>
double UniformSourceParabolicPde< DIM >::mSourceCoefficient
private

Constant source term (rate of production) of the dependent variable.

Definition at line 82 of file UniformSourceParabolicPde.hpp.

Referenced by UniformSourceParabolicPde< DIM >::serialize().


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