|
OOFEM 3.0
|
#include <tr1_2d_supg_axi.h>
Public Member Functions | |
| TR1_2D_SUPG_AXI (int n, Domain *d) | |
| void | computeAccelerationTerm_MB (FloatMatrix &answer, TimeStep *tStep) override |
| void | computeAdvectionTerm_MB (FloatArray &answer, TimeStep *tStep) override |
| void | computeAdvectionDerivativeTerm_MB (FloatMatrix &answer, TimeStep *tStep) override |
| void | computeDiffusionTerm_MB (FloatArray &answer, TimeStep *tStep) override |
| void | computeDiffusionDerivativeTerm_MB (FloatMatrix &answer, MatResponseMode mode, TimeStep *tStep) override |
| void | computePressureTerm_MB (FloatMatrix &answer, TimeStep *tStep) override |
| void | computeLSICStabilizationTerm_MB (FloatMatrix &answer, TimeStep *tStep) override |
| void | computeLinearAdvectionTerm_MC (FloatMatrix &answer, TimeStep *tStep) override |
| void | computeAdvectionTerm_MC (FloatArray &answer, TimeStep *tStep) override |
| void | computeAdvectionDerivativeTerm_MC (FloatMatrix &answer, TimeStep *tStep) override |
| void | computeDiffusionDerivativeTerm_MC (FloatMatrix &answer, TimeStep *tStep) override |
| void | computeDiffusionTerm_MC (FloatArray &answer, TimeStep *tStep) override |
| void | computeAccelerationTerm_MC (FloatMatrix &answer, TimeStep *tStep) override |
| void | computePressureTerm_MC (FloatMatrix &answer, TimeStep *tStep) override |
| void | updateStabilizationCoeffs (TimeStep *tStep) override |
| void | computeBCRhsTerm_MB (FloatArray &answer, TimeStep *tStep) override |
| void | computeBCRhsTerm_MC (FloatArray &answer, TimeStep *tStep) override |
| void | computeLoadVector (FloatArray &answer, BodyLoad *load, CharType type, ValueModeType mode, TimeStep *tStep) override |
| void | computeSlipWithFrictionBCTerm_MB (FloatMatrix &answer, Load *load, int side, TimeStep *tStep) override |
| void | computePenetrationWithResistanceBCTerm_MB (FloatMatrix &answer, Load *load, int side, TimeStep *tStep) override |
| void | computeOutFlowBCTerm_MB (FloatMatrix &answer, int side, TimeStep *tStep) override |
| void | computeBCLhsTerm_MB (FloatMatrix &answer, TimeStep *tStep) override |
| void | computeBCLhsPressureTerm_MB (FloatMatrix &answer, TimeStep *tStep) override |
| double | computeVolumeAround (GaussPoint *gp) override |
| void | LS_PCS_computeVOFFractions (FloatArray &answer, FloatArray &fi) override |
| const char * | giveClassName () const override |
| const char * | giveInputRecordName () const override |
| MaterialMode | giveMaterialMode () override |
| Public Member Functions inherited from oofem::TR1_2D_SUPG | |
| TR1_2D_SUPG (int n, Domain *d) | |
| FEInterpolation * | giveInterpolation () const override |
| void | computeHomogenizedReinforceTerm_MB (FloatMatrix &answer, Load *load, TimeStep *tStep) override |
| void | computeHomogenizedReinforceTerm_MC (FloatMatrix &answer, Load *load, TimeStep *tStep) override |
| double | computeCriticalTimeStep (TimeStep *tStep) override |
| Computes the critical time increment. | |
| Element_Geometry_Type | giveGeometryType () const override |
| void | giveDofManDofIDMask (int inode, IntArray &answer) const override |
| int | computeNumberOfDofs () override |
| void | initializeFrom (InputRecord &ir, int priority) override |
| void | giveInputRecord (DynamicInputRecord &input) override |
| void | updateYourself (TimeStep *tStep) override |
| int | checkConsistency () override |
| Used to check consistency and initialize some element geometry data (area,b,c). | |
| void | saveContext (DataStream &stream, ContextMode mode) override |
| void | restoreContext (DataStream &stream, ContextMode mode) override |
| Interface * | giveInterface (InterfaceType) override |
| int | EIPrimaryFieldI_evaluateFieldVectorAt (FloatArray &answer, PrimaryField &pf, const FloatArray &coords, IntArray &dofId, ValueModeType mode, TimeStep *tStep) override |
| double | computeLEPLICVolumeFraction (const FloatArray &n, const double p, LEPlic *matInterface, bool updFlag) override |
| Computes corresponding volume fraction to given interface position. | |
| void | formMaterialVolumePoly (Polygon &matvolpoly, LEPlic *matInterface, const FloatArray &normal, const double p, bool updFlag) override |
| Assembles the true element material polygon (takes receiver vof into accout). | |
| void | formVolumeInterfacePoly (Polygon &matvolpoly, LEPlic *matInterface, const FloatArray &normal, const double p, bool updFlag) override |
| Assembles receiver material polygon based solely on given interface line. | |
| double | truncateMatVolume (const Polygon &matvolpoly, double &volume) override |
| Truncates given material polygon to receiver. | |
| void | giveElementCenter (LEPlic *mat_interface, FloatArray ¢er, bool updFlag) override |
| Computes the receiver center (in updated Lagrangian configuration). | |
| void | formMyVolumePoly (Polygon &myPoly, LEPlic *mat_interface, bool updFlag) override |
| Assembles receiver volume. | |
| Element * | giveElement () override |
| Return number of receiver's element. | |
| double | computeMyVolume (LEPlic *matInterface, bool updFlag) override |
| Computes the volume of receiver. | |
| double | computeCriticalLEPlicTimeStep (TimeStep *tStep) override |
| Computes critical time step. | |
| void | NodalAveragingRecoveryMI_computeNodalValue (FloatArray &answer, int node, InternalStateType type, TimeStep *tStep) override |
| void | SPRNodalRecoveryMI_giveSPRAssemblyPoints (IntArray &pap) override |
| void | SPRNodalRecoveryMI_giveDofMansDeterminedByPatch (IntArray &answer, int pap) override |
| int | SPRNodalRecoveryMI_giveNumberOfIP () override |
| SPRPatchType | SPRNodalRecoveryMI_givePatchType () override |
| double | LS_PCS_computeF (LevelSetPCS *ls, TimeStep *tStep) override |
| void | LS_PCS_computedN (FloatMatrix &answer) override |
| double | LS_PCS_computeVolume () override |
| Returns receiver's volume. | |
| double | LS_PCS_computeS (LevelSetPCS *ls, TimeStep *tStep) override |
| int | giveIPValue (FloatArray &answer, GaussPoint *gp, InternalStateType type, TimeStep *tStep) override |
| int | giveInternalStateAtNode (FloatArray &answer, InternalStateType type, InternalStateMode mode, int node, TimeStep *tStep) override |
| void | drawRawGeometry (oofegGraphicContext &gc, TimeStep *tStep) override |
| void | drawScalar (oofegGraphicContext &gc, TimeStep *tStep) override |
| void | printOutputAt (FILE *file, TimeStep *tStep) override |
| Public Member Functions inherited from oofem::SUPGElement | |
| SUPGElement (int n, Domain *aDomain) | |
| void | giveCharacteristicMatrix (FloatMatrix &answer, CharType type, TimeStep *tStep) override |
| void | giveCharacteristicVector (FloatArray &answer, CharType type, ValueModeType mode, TimeStep *tStep) override |
| virtual void | updateElementForNewInterfacePosition (TimeStep *tStep) |
| virtual void | computeBCLhsPressureTerm_MC (FloatMatrix &answer, TimeStep *tStep) |
| void | updateInternalState (TimeStep *tStep) override |
| Public Member Functions inherited from oofem::FMElement | |
| FMElement (int n, Domain *aDomain) | |
| void | computeVectorOfVelocities (ValueModeType mode, TimeStep *tStep, FloatArray &velocities) |
| void | computeVectorOfPressures (ValueModeType mode, TimeStep *tStep, FloatArray &pressures) |
| FloatArray | computeVectorOfVelocities (ValueModeType mode, TimeStep *tStep) |
| FloatArray | computeVectorOfPressures (ValueModeType mode, TimeStep *tStep) |
| Public Member Functions inherited from oofem::Element | |
| Element (int n, Domain *aDomain) | |
| Element (const Element &src)=delete | |
| Element & | operator= (const Element &src)=delete |
| virtual | ~Element () |
| Virtual destructor. | |
| void | giveLocationArray (IntArray &locationArray, const UnknownNumberingScheme &s, IntArray *dofIds=NULL) const |
| void | giveLocationArray (IntArray &locationArray, const IntArray &dofIDMask, const UnknownNumberingScheme &s, IntArray *dofIds=NULL) const |
| virtual void | giveBoundaryLocationArray (IntArray &locationArray, const IntArray &bNodes, const UnknownNumberingScheme &s, IntArray *dofIds=NULL) |
| virtual void | giveBoundaryLocationArray (IntArray &locationArray, const IntArray &bNodes, const IntArray &dofIDMask, const UnknownNumberingScheme &s, IntArray *dofIds=NULL) |
| virtual int | giveNumberOfDofs () |
| virtual int | giveNumberOfInternalDofManagers () const |
| virtual DofManager * | giveInternalDofManager (int i) const |
| virtual void | setInternalDofManager (int num, std::unique_ptr< DofManager > dm) |
| virtual double | giveCharacteristicValue (CharType type, TimeStep *tStep) |
| virtual void | computeBoundarySurfaceLoadVector (FloatArray &answer, BoundaryLoad *load, int boundary, CharType type, ValueModeType mode, TimeStep *tStep, bool global=true) |
| virtual void | computeTangentFromSurfaceLoad (FloatMatrix &answer, BoundaryLoad *load, int boundary, MatResponseMode rmode, TimeStep *tStep) |
| virtual void | computeTangentFromEdgeLoad (FloatMatrix &answer, BoundaryLoad *load, int boundary, MatResponseMode rmode, TimeStep *tStep) |
| virtual void | computeBoundaryEdgeLoadVector (FloatArray &answer, BoundaryLoad *load, int edge, CharType type, ValueModeType mode, TimeStep *tStep, bool global=true) |
| const IntArray & | giveBodyLoadList () const |
| const IntArray & | giveBoundaryLoadList () const |
| void | computeVectorOf (ValueModeType u, TimeStep *tStep, FloatArray &answer) |
| void | computeVectorOf (const IntArray &dofIDMask, ValueModeType u, TimeStep *tStep, FloatArray &answer, bool padding=false) |
| void | computeBoundaryVectorOf (const IntArray &bNodes, const IntArray &dofIDMask, ValueModeType u, TimeStep *tStep, FloatArray &answer, bool padding=false) |
| void | computeVectorOf (PrimaryField &field, const IntArray &dofIDMask, ValueModeType u, TimeStep *tStep, FloatArray &answer, bool padding=false) |
| void | computeVectorOfPrescribed (ValueModeType u, TimeStep *tStep, FloatArray &answer) |
| void | computeVectorOfPrescribed (const IntArray &dofIDMask, ValueModeType type, TimeStep *tStep, FloatArray &answer) |
| virtual int | computeNumberOfGlobalDofs () |
| int | computeNumberOfPrimaryMasterDofs () |
| virtual bool | computeGtoLRotationMatrix (FloatMatrix &answer) |
| virtual bool | giveRotationMatrix (FloatMatrix &answer) |
| virtual bool | computeDofTransformationMatrix (FloatMatrix &answer, const IntArray &nodes, bool includeInternal) |
| virtual void | giveInternalDofManDofIDMask (int inode, IntArray &answer) const |
| virtual void | giveElementDofIDMask (IntArray &answer) const |
| virtual void | computeField (ValueModeType mode, TimeStep *tStep, const FloatArray &lcoords, FloatArray &answer) |
| virtual double | computeVolumeAreaOrLength () |
| Computes the volume, area or length of the element depending on its spatial dimension. | |
| double | computeMeanSize () |
| virtual double | computeVolume () |
| virtual double | computeArea () |
| virtual double | computeLength () |
| virtual IntArray | giveBoundaryEdgeNodes (int boundary, bool includeHierarchical=false) const |
| virtual IntArray | giveBoundarySurfaceNodes (int boundary, bool includeHierarchical=false) const |
| virtual IntArray | giveBoundaryNodes (int boundary) const |
| virtual std::unique_ptr< IntegrationRule > | giveBoundaryEdgeIntegrationRule (int order, int boundary) |
| virtual std::unique_ptr< IntegrationRule > | giveBoundarySurfaceIntegrationRule (int order, int boundary) |
| int | giveDofManagerNumber (int i) const |
| const IntArray & | giveDofManArray () const |
| void | addDofManager (DofManager *dMan) |
| DofManager * | giveDofManager (int i) const |
| Node * | giveNode (int i) const |
| virtual ElementSide * | giveSide (int i) const |
| virtual FEInterpolation * | giveInterpolation (DofIDItem id) const |
| virtual const FEInterpolation * | getGeometryInterpolation () const |
| virtual Material * | giveMaterial () |
| int | giveMaterialNumber () const |
| CrossSection * | giveCrossSection () |
| int | getActivityTimeFunctionNumber () |
| void | setActivityTimeFunctionNumber (int funcIndx) |
| void | setMaterial (int matIndx) |
| virtual void | setCrossSection (int csIndx) |
| virtual int | giveNumberOfDofManagers () const |
| void | setNumberOfDofManagers (int i) |
| Sets number of element dof managers. | |
| virtual int | giveNumberOfNodes () const |
| void | setDofManagers (const IntArray &dmans) |
| void | setDofManager (int id, int dm) |
| void | setBodyLoads (const IntArray &bodyLoads) |
| void | setIntegrationRules (std ::vector< std ::unique_ptr< IntegrationRule > > irlist) |
| virtual integrationDomain | giveIntegrationDomain () const |
| virtual int | giveIntegrationRuleLocalCodeNumbers (IntArray &answer, IntegrationRule &ie) |
| int | giveRegionNumber () |
| virtual void | initializeYourself (TimeStep *timeStepWhenICApply) |
| virtual bool | isActivated (TimeStep *tStep) |
| virtual bool | isCast (TimeStep *tStep) |
| virtual void | initForNewStep () |
| virtual Element_Geometry_Type | giveEdgeGeometryType (int id) const |
| Returns the receiver edge geometry type. | |
| virtual Element_Geometry_Type | giveSurfaceGeometryType (int id) const |
| Returns the receiver surface geometry type. | |
| virtual int | giveSpatialDimension () |
| virtual int | giveNumberOfBoundarySides () |
| Returns number of boundaries (entities of element_dimension-1: points, edges, surfaces). | |
| virtual int | giveNumberOfEdges () const |
| virtual int | giveNumberOfSurfaces () const |
| virtual int | giveDefaultIntegrationRule () const |
| virtual IntegrationRule * | giveDefaultIntegrationRulePtr () |
| int | giveNumberOfIntegrationRules () |
| virtual IntegrationRule * | giveIntegrationRule (int i) |
| std::vector< std ::unique_ptr< IntegrationRule > > & | giveIntegrationRulesArray () |
| virtual int | testElementExtension (ElementExtension ext) |
| int | giveGlobalIPValue (FloatArray &answer, GaussPoint *gp, InternalStateType type, TimeStep *tStep) |
| virtual double | giveLengthInDir (const FloatArray &normalToCrackPlane) |
| virtual double | giveCharacteristicLength (const FloatArray &normalToCrackPlane) |
| double | giveCharacteristicLengthForPlaneElements (const FloatArray &normalToCrackPlane) |
| double | giveCharacteristicLengthForAxisymmElements (const FloatArray &normalToCrackPlane) |
| virtual double | giveCharacteristicSize (GaussPoint *gp, FloatArray &normalToCrackPlane, ElementCharSizeMethod method) |
| virtual double | giveParentElSize () const |
| virtual void | updateBeforeNonlocalAverage (TimeStep *tStep) |
| virtual int | computeGlobalCoordinates (FloatArray &answer, const FloatArray &lcoords) |
| virtual bool | computeLocalCoordinates (FloatArray &answer, const FloatArray &gcoords) |
| virtual int | giveLocalCoordinateSystem (FloatMatrix &answer) |
| virtual void | giveLocalCoordinateSystemVector (InternalStateType isttype, FloatArray &answer) |
| virtual void | computeMidPlaneNormal (FloatArray &answer, const GaussPoint *gp) |
| virtual int | adaptiveMap (Domain *oldd, TimeStep *tStep) |
| virtual int | mapStateVariables (Domain &iOldDom, const TimeStep &iTStep) |
| virtual int | adaptiveUpdate (TimeStep *tStep) |
| virtual int | adaptiveFinish (TimeStep *tStep) |
| void | updateLocalNumbering (EntityRenumberingFunctor &f) override |
| template<class T> | |
| void | ipEvaluator (T *src, void(T ::*f)(GaussPoint *gp)) |
| Integration point evaluator, loops over receiver IP's and calls given function (passed as f parameter) on them. The IP is parameter to function f. | |
| template<class T, class S> | |
| void | ipEvaluator (T *src, void(T ::*f)(GaussPoint *, S &), S &_val) |
| Integration point evaluator, loops over receiver IP's and calls given function (passed as f parameter) on them. The IP is parameter to function f as well as additional array. | |
| virtual void | drawYourself (oofegGraphicContext &gc, TimeStep *tStep) |
| virtual void | drawAnnotation (oofegGraphicContext &gc, TimeStep *tStep) |
| virtual void | drawDeformedGeometry (oofegGraphicContext &gc, TimeStep *tStep, UnknownType) |
| virtual void | drawSpecial (oofegGraphicContext &gc, TimeStep *tStep) |
| virtual void | giveLocalIntVarMaxMin (oofegGraphicContext &gc, TimeStep *tStep, double &emin, double &emax) |
| virtual int | giveInternalStateAtSide (FloatArray &answer, InternalStateType type, InternalStateMode mode, int side, TimeStep *tStep) |
| virtual void | showSparseMtrxStructure (CharType mtrx, oofegGraphicContext &gc, TimeStep *tStep) |
| Shows sparse structure. | |
| virtual void | showExtendedSparseMtrxStructure (CharType mtrx, oofegGraphicContext &gc, TimeStep *tStep) |
| Shows extended sparse structure (for example, due to nonlocal interactions for tangent stiffness). | |
| int | giveLabel () const |
| int | giveGlobalNumber () const |
| void | setGlobalNumber (int num) |
| elementParallelMode | giveParallelMode () const |
| void | setParallelMode (elementParallelMode _mode) |
| Sets parallel mode of element. | |
| virtual elementParallelMode | giveKnotSpanParallelMode (int) const |
| int | packUnknowns (DataStream &buff, TimeStep *tStep) |
| int | unpackAndUpdateUnknowns (DataStream &buff, TimeStep *tStep) |
| int | estimatePackSize (DataStream &buff) |
| const IntArray * | givePartitionList () const |
| void | setPartitionList (IntArray &pl) |
| virtual double | predictRelativeComputationalCost () |
| virtual double | giveRelativeSelfComputationalCost () |
| virtual double | predictRelativeRedistributionCost () |
| IntArray * | giveBodyLoadArray () |
| Returns array containing load numbers of loads acting on element. | |
| IntArray * | giveBoundaryLoadArray () |
| Returns array containing load numbers of boundary loads acting on element. | |
| void | initializeFinish () override |
| void | postInitialize () override |
| Performs post initialization steps. | |
| virtual const IntArray | giveLocation () |
| virtual void | recalculateCoordinates (int nodeNumber, FloatArray &coords) |
| void | setSharedEdgeID (int iedge, int globalID) |
| void | setSharedSurfaceID (int isurf, int globalID) |
| const IntArray * | giveSharedEdgeIDs () const |
| const IntArray * | giveSharedSurfaceIDs () const |
| Public Member Functions inherited from oofem::FEMComponent | |
| FEMComponent (int n, Domain *d) | |
| virtual | ~FEMComponent ()=default |
| Virtual destructor. | |
| Domain * | giveDomain () const |
| virtual void | setDomain (Domain *d) |
| int | giveNumber () const |
| void | setNumber (int num) |
| virtual void | initializeFrom (InputRecord &ir) |
| virtual void | printYourself () |
| Prints receiver state on stdout. Useful for debugging. | |
| std::string | errorInfo (const char *func) const |
| Returns string for prepending output (used by error reporting macros). | |
| Public Member Functions inherited from oofem::SpatialLocalizerInterface | |
| SpatialLocalizerInterface (Element *element) | |
| virtual int | SpatialLocalizerI_containsPoint (const FloatArray &coords) |
| int | SpatialLocalizerI_BBoxContainsPoint (const FloatArray &coords) |
| virtual void | SpatialLocalizerI_giveBBox (FloatArray &bb0, FloatArray &bb1) |
| virtual double | SpatialLocalizerI_giveClosestPoint (FloatArray &lcoords, FloatArray &closest, const FloatArray &gcoords) |
| Public Member Functions inherited from oofem::Interface | |
| Interface () | |
| Constructor. | |
| virtual | ~Interface () |
| Public Member Functions inherited from oofem::EIPrimaryFieldInterface | |
| EIPrimaryFieldInterface () | |
| Public Member Functions inherited from oofem::ZZNodalRecoveryModelInterface | |
| ZZNodalRecoveryModelInterface (Element *element) | |
| Constructor. | |
| virtual bool | ZZNodalRecoveryMI_computeNValProduct (FloatMatrix &answer, InternalStateType type, TimeStep *tStep) |
| virtual void | ZZNodalRecoveryMI_computeNNMatrix (FloatArray &answer, InternalStateType type) |
| Public Member Functions inherited from oofem::NodalAveragingRecoveryModelInterface | |
| NodalAveragingRecoveryModelInterface () | |
| Constructor. | |
| Public Member Functions inherited from oofem::SPRNodalRecoveryModelInterface | |
| SPRNodalRecoveryModelInterface () | |
| Constructor. | |
| Public Member Functions inherited from oofem::LEPlicElementInterface | |
| LEPlicElementInterface () | |
| bool | isBoundary () |
| Returns true if cell is boundary. | |
| void | setTempLineConstant (double tp) |
| void | setTempInterfaceNormal (FloatArray tg) |
| void | setTempVolumeFraction (double v) |
| void | setPermanentVolumeFraction (double v) |
| void | addTempVolumeFraction (double v) |
| double | giveVolumeFraction () |
| double | giveTempVolumeFraction () |
| void | giveTempInterfaceNormal (FloatArray &n) |
| double | giveTempLineConstant () |
| void | updateYourself (TimeStep *tStep) |
| void | saveContext (DataStream &stream, ContextMode mode) |
| void | restoreContext (DataStream &stream, ContextMode mode) |
| Public Member Functions inherited from oofem::LevelSetPCSElementInterface | |
| LevelSetPCSElementInterface () | |
Protected Member Functions | |
| void | computeGaussPoints () override |
| void | computeDeviatoricStrain (FloatArray &answer, GaussPoint *gp, TimeStep *tStep) override |
| void | computeDeviatoricStress (FloatArray &answer, const FloatArray &eps, GaussPoint *gp, TimeStep *tStep) override |
| void | computeTangent (FloatMatrix &answer, MatResponseMode mode, GaussPoint *gp, TimeStep *tStep) override |
| void | initGeometry () override |
| virtual double | computeRadiusAt (GaussPoint *gp) |
| virtual void | computeBMtrx (FloatMatrix &answer, GaussPoint *gp) |
| void | computeNVector (FloatArray &answer, GaussPoint *gp) |
| Protected Member Functions inherited from oofem::TR1_2D_SUPG | |
| void | giveLocalVelocityDofMap (IntArray &map) override |
| void | giveLocalPressureDofMap (IntArray &map) override |
| void | computeNMtrx (FloatArray &answer, GaussPoint *gp) |
Protected Attributes | |
| double | rc |
| Radius at element center. | |
| Protected Attributes inherited from oofem::TR1_2D_SUPG | |
| double | b [3] |
| double | c [3] |
| double | area = 0. |
| Protected Attributes inherited from oofem::SUPGElement | |
| IntArray | boundarySides |
| Array of boundary sides. | |
| IntArray | boundaryCodes |
| Boundary sides codes. | |
| double | t_supg = 0. |
| double | t_pspg = 0. |
| double | t_lsic = 0. |
| Protected Attributes inherited from oofem::Element | |
| int | numberOfDofMans |
| Number of dofmanagers. | |
| IntArray | dofManArray |
| Array containing dofmanager numbers. | |
| int | material |
| Number of associated material. | |
| int | crossSection |
| Number of associated cross section. | |
| IntArray | bodyLoadArray |
| IntArray | boundaryLoadArray |
| std::vector< std ::unique_ptr< IntegrationRule > > | integrationRulesArray |
| FloatMatrix | elemLocalCS |
| Transformation material matrix, used in orthotropic and anisotropic materials, global->local transformation. | |
| int | activityTimeFunction |
| Element activity time function. If defined, nonzero value indicates active receiver, zero value inactive element. | |
| int | globalNumber |
| int | numberOfGaussPoints |
| elementParallelMode | parallel_mode |
| Determines the parallel mode of the element. | |
| IntArray | partitions |
| IntArray | globalEdgeIDs |
| IntArray | globalSurfaceIDs |
| Protected Attributes inherited from oofem::FEMComponent | |
| int | number |
| Component number. | |
| Domain * | domain |
| Link to domain object, useful for communicating with other FEM components. | |
| Protected Attributes inherited from oofem::LEPlicElementInterface | |
| bool | permanentVofFlag |
| double | vof |
| Volume fraction of reference fluid in element. | |
| double | temp_vof |
| double | p |
| Line constant of line segment representing interface. | |
| double | temp_p |
| FloatArray | normal |
| Interface segment normal. | |
| FloatArray | temp_normal |
Additional Inherited Members | |
| Static Public Attributes inherited from oofem::Element | |
| static ParamKey | IPK_Element_mat |
| static ParamKey | IPK_Element_crosssect |
| static ParamKey | IPK_Element_nodes |
| static ParamKey | IPK_Element_bodyload |
| static ParamKey | IPK_Element_boundaryload |
| static ParamKey | IPK_Element_lcs |
| static ParamKey | IPK_Element_partitions |
| static ParamKey | IPK_Element_remote |
| static ParamKey | IPK_Element_activityTimeFunction |
| static ParamKey | IPK_Element_nip |
| Static Protected Attributes inherited from oofem::TR1_2D_SUPG | |
| static FEI2dTrLin | interp |
| static ParamKey | IPK_TR1_2D_SUPG_vof |
| static ParamKey | IPK_TR1_2D_SUPG_pvof |
| static ParamKey | IPK_TR1_2D_SUPG_mat0 |
| static ParamKey | IPK_TR1_2D_SUPG_mat1 |
| Static Protected Attributes inherited from oofem::SUPGElement | |
| static ParamKey | IPK_SUPGElement_bsides |
| static ParamKey | IPK_SUPGElement_bcodes |
Class representing 2d linear axisymmetric triangular element for solving incompressible fluid with SUPG solver
This class is similar to TR1_2D_SUPG2_AXI, but difference is in handling multiple fluids. This class uses rule of mixture which interpolates the properties using VOF value, requiring the use of twofluidmaterial class as material model for this situation.
Definition at line 52 of file tr1_2d_supg_axi.h.
| oofem::TR1_2D_SUPG_AXI::TR1_2D_SUPG_AXI | ( | int | n, |
| Domain * | d ) |
Definition at line 63 of file tr1_2d_supg_axi.C.
References oofem::TR1_2D_SUPG::TR1_2D_SUPG().
|
overridevirtual |
Computes acceleration terms (generalized mass matrix with stabilization terms) for momentum balance equations(s).
Reimplemented from oofem::TR1_2D_SUPG.
Definition at line 80 of file tr1_2d_supg_axi.C.
References oofem::FloatArray::at(), oofem::FloatMatrix::at(), oofem::TR1_2D_SUPG::b, oofem::TR1_2D_SUPG::c, computeNVector(), oofem::FMElement::computeVectorOfVelocities(), computeVolumeAround(), oofem::Element::giveCrossSection(), oofem::TimeStep::givePreviousStep(), oofem::Element::integrationRulesArray, oofem::FloatMatrix::resize(), oofem::SUPGElement::t_supg, and oofem::FloatMatrix::zero().
|
overridevirtual |
Computes acceleration terms for mass conservation equation.
Reimplemented from oofem::TR1_2D_SUPG.
Definition at line 519 of file tr1_2d_supg_axi.C.
References oofem::FloatArray::at(), oofem::FloatMatrix::at(), oofem::TR1_2D_SUPG::b, oofem::TR1_2D_SUPG::c, computeNVector(), computeVolumeAround(), oofem::Element::integrationRulesArray, oofem::FloatMatrix::resize(), oofem::SUPGElement::t_pspg, and oofem::FloatMatrix::zero().
|
overridevirtual |
Computes the derivative of advection terms for momentum balance equations(s) with respect to nodal velocities.
Reimplemented from oofem::TR1_2D_SUPG.
Definition at line 150 of file tr1_2d_supg_axi.C.
References oofem::FloatArray::at(), oofem::FloatMatrix::at(), oofem::TR1_2D_SUPG::b, oofem::TR1_2D_SUPG::c, computeNVector(), oofem::FMElement::computeVectorOfVelocities(), computeVolumeAround(), oofem::Element::giveCrossSection(), oofem::TimeStep::givePreviousStep(), oofem::Element::integrationRulesArray, oofem::FloatMatrix::resize(), oofem::SUPGElement::t_supg, and oofem::FloatMatrix::zero().
|
overridevirtual |
Computes the derivative of advection terms for mass conservation equation with respect to nodal velocities.
Reimplemented from oofem::TR1_2D_SUPG.
Definition at line 420 of file tr1_2d_supg_axi.C.
References oofem::FloatArray::at(), oofem::FloatMatrix::at(), oofem::TR1_2D_SUPG::b, oofem::TR1_2D_SUPG::c, computeNVector(), oofem::FMElement::computeVectorOfVelocities(), computeVolumeAround(), oofem::TimeStep::givePreviousStep(), oofem::Element::integrationRulesArray, oofem::FloatMatrix::resize(), oofem::SUPGElement::t_pspg, and oofem::FloatMatrix::zero().
|
overridevirtual |
Computes nonlinear advection terms for momentum balance equations(s).
Reimplemented from oofem::TR1_2D_SUPG.
Definition at line 111 of file tr1_2d_supg_axi.C.
References oofem::FloatArray::at(), oofem::TR1_2D_SUPG::b, oofem::TR1_2D_SUPG::c, computeNVector(), oofem::FMElement::computeVectorOfVelocities(), computeVolumeAround(), oofem::Element::giveCrossSection(), oofem::TimeStep::givePreviousStep(), oofem::Element::integrationRulesArray, oofem::FloatArray::resize(), oofem::SUPGElement::t_supg, and oofem::FloatArray::zero().
|
overridevirtual |
Computes advection terms for mass conservation equation.
Reimplemented from oofem::TR1_2D_SUPG.
Definition at line 389 of file tr1_2d_supg_axi.C.
References oofem::FloatArray::at(), oofem::TR1_2D_SUPG::b, oofem::TR1_2D_SUPG::c, computeNVector(), oofem::FMElement::computeVectorOfVelocities(), computeVolumeAround(), oofem::TimeStep::givePreviousStep(), oofem::Element::integrationRulesArray, oofem::FloatArray::resize(), oofem::SUPGElement::t_pspg, and oofem::FloatArray::zero().
|
overridevirtual |
Computes Lhs terms due to boundary conditions - pressure.
Reimplemented from oofem::SUPGElement.
Definition at line 896 of file tr1_2d_supg_axi.C.
References oofem::FloatMatrix::add(), oofem::Element::boundaryLoadArray, oofem::FloatMatrix::clear(), computeOutFlowBCTerm_MB(), oofem::FEMComponent::domain, oofem::Element::giveBoundaryLoadArray(), oofem::GeneralBoundaryCondition::giveType(), and oofem::OutFlowBC.
|
overridevirtual |
Computes Lhs terms due to boundary conditions - velocity.
Reimplemented from oofem::SUPGElement.
Definition at line 752 of file tr1_2d_supg_axi.C.
References oofem::FloatMatrix::add(), oofem::Element::boundaryLoadArray, oofem::FloatMatrix::clear(), computePenetrationWithResistanceBCTerm_MB(), computeSlipWithFrictionBCTerm_MB(), oofem::FEMComponent::domain, oofem::Element::giveBoundaryLoadArray(), oofem::GeneralBoundaryCondition::giveType(), oofem::PenetrationWithResistance, and oofem::SlipWithFriction.
|
overridevirtual |
Computes Rhs terms due to boundary conditions.
Reimplemented from oofem::TR1_2D_SUPG.
Definition at line 587 of file tr1_2d_supg_axi.C.
References oofem::FloatArray::at(), oofem::TR1_2D_SUPG::b, oofem::Element::bodyLoadArray, oofem::BodyLoadBGT, oofem::SUPGElement::boundaryCodes, oofem::Element::boundaryLoadArray, oofem::SUPGElement::boundarySides, oofem::TR1_2D_SUPG::c, oofem::Load::computeComponentArrayAt(), computeNVector(), oofem::FMElement::computeVectorOfVelocities(), computeVolumeAround(), oofem::FEMComponent::domain, FMElement_PrescribedTractionBC, oofem::ForceLoadBVT, oofem::GeneralBoundaryCondition::giveBCGeoType(), oofem::GeneralBoundaryCondition::giveBCValType(), oofem::Element::giveBodyLoadArray(), oofem::Element::giveBoundaryLoadArray(), oofem::Element::giveCrossSection(), oofem::Element::giveNode(), oofem::TimeStep::givePreviousStep(), oofem::FloatArray::giveSize(), oofem::Element::integrationRulesArray, oofem::FloatArray::resize(), oofem::SUPGElement::t_supg, and oofem::FloatArray::zero().
|
overridevirtual |
Computes Rhs terms due to boundary conditions.
Reimplemented from oofem::TR1_2D_SUPG.
Definition at line 680 of file tr1_2d_supg_axi.C.
References oofem::FloatArray::at(), oofem::TR1_2D_SUPG::b, oofem::Element::bodyLoadArray, oofem::BodyLoadBGT, oofem::TR1_2D_SUPG::c, oofem::Load::computeComponentArrayAt(), computeVolumeAround(), oofem::FEMComponent::domain, oofem::ForceLoadBVT, oofem::GeneralBoundaryCondition::giveBCGeoType(), oofem::GeneralBoundaryCondition::giveBCValType(), oofem::Element::giveBodyLoadArray(), oofem::FloatArray::giveSize(), oofem::Element::integrationRulesArray, oofem::FloatArray::resize(), oofem::SUPGElement::t_pspg, and oofem::FloatArray::zero().
|
protectedvirtual |
Definition at line 934 of file tr1_2d_supg_axi.C.
References oofem::FloatMatrix::at(), oofem::TR1_2D_SUPG::b, oofem::TR1_2D_SUPG::c, computeRadiusAt(), and oofem::FloatMatrix::resize().
Referenced by computeDeviatoricStrain(), computeDiffusionDerivativeTerm_MB(), computeDiffusionDerivativeTerm_MC(), computeDiffusionTerm_MB(), and computeDiffusionTerm_MC().
|
overrideprotectedvirtual |
Reimplemented from oofem::TR1_2D_SUPG.
Definition at line 560 of file tr1_2d_supg_axi.C.
References oofem::FloatArray::beProductOf(), computeBMtrx(), and oofem::FMElement::computeVectorOfVelocities().
|
overrideprotectedvirtual |
Reimplemented from oofem::TR1_2D_SUPG.
Definition at line 573 of file tr1_2d_supg_axi.C.
References oofem::Element::giveCrossSection().
|
overridevirtual |
Computes the derivative of diffusion terms for momentum balance equations(s) with respect to nodal velocities.
Reimplemented from oofem::TR1_2D_SUPG.
Definition at line 254 of file tr1_2d_supg_axi.C.
References oofem::FloatArray::at(), oofem::FloatMatrix::at(), oofem::TR1_2D_SUPG::b, oofem::FloatArray::beProductOf(), oofem::FloatMatrix::beProductOf(), oofem::TR1_2D_SUPG::c, computeBMtrx(), oofem::FluidDynamicMaterial::computeDeviatoricStressAxi(), computeNVector(), computeRadiusAt(), oofem::FluidDynamicMaterial::computeTangentAxi(), oofem::FMElement::computeVectorOfVelocities(), computeVolumeAround(), oofem::FEMComponent::domain, oofem::Element::giveCrossSection(), oofem::TimeStep::givePreviousStep(), oofem::FluidModel::giveReynoldsNumber(), oofem::Element::integrationRulesArray, oofem::FloatMatrix::plusProductUnsym(), oofem::FloatMatrix::resize(), oofem::SUPGElement::t_supg, oofem::FloatMatrix::times(), and oofem::FloatMatrix::zero().
|
overridevirtual |
Computes diffusion derivative terms for mass conservation equation.
Reimplemented from oofem::TR1_2D_SUPG.
Definition at line 483 of file tr1_2d_supg_axi.C.
References oofem::FloatMatrix::at(), oofem::TR1_2D_SUPG::b, oofem::FloatMatrix::beProductOf(), oofem::TR1_2D_SUPG::c, computeBMtrx(), computeRadiusAt(), oofem::FluidDynamicMaterial::computeTangentAxi(), computeVolumeAround(), oofem::FEMComponent::domain, oofem::Material::give(), oofem::Element::giveCrossSection(), oofem::FluidModel::giveReynoldsNumber(), oofem::Element::integrationRulesArray, oofem::FloatMatrix::resize(), oofem::SUPGElement::t_pspg, oofem::FloatMatrix::times(), and oofem::FloatMatrix::zero().
|
overridevirtual |
Computes diffusion terms for momentum balance equations(s).
Reimplemented from oofem::TR1_2D_SUPG.
Definition at line 213 of file tr1_2d_supg_axi.C.
References oofem::FloatArray::at(), oofem::TR1_2D_SUPG::b, oofem::FloatArray::beProductOf(), oofem::TR1_2D_SUPG::c, computeBMtrx(), oofem::FluidDynamicMaterial::computeDeviatoricStressAxi(), computeNVector(), computeRadiusAt(), oofem::FMElement::computeVectorOfVelocities(), computeVolumeAround(), oofem::FEMComponent::domain, oofem::Element::giveCrossSection(), oofem::TimeStep::givePreviousStep(), oofem::FluidModel::giveReynoldsNumber(), oofem::Element::integrationRulesArray, oofem::FloatArray::plusProduct(), oofem::FloatArray::resize(), oofem::SUPGElement::t_supg, and oofem::FloatArray::zero().
|
overridevirtual |
Computes diffusion terms for mass conservation equation.
Reimplemented from oofem::TR1_2D_SUPG.
Definition at line 454 of file tr1_2d_supg_axi.C.
References oofem::FloatArray::at(), oofem::TR1_2D_SUPG::b, oofem::FloatArray::beProductOf(), oofem::TR1_2D_SUPG::c, computeBMtrx(), oofem::FluidDynamicMaterial::computeDeviatoricStressAxi(), computeRadiusAt(), oofem::FMElement::computeVectorOfVelocities(), computeVolumeAround(), oofem::FEMComponent::domain, oofem::Element::giveCrossSection(), oofem::FluidModel::giveReynoldsNumber(), oofem::Element::integrationRulesArray, oofem::FloatArray::resize(), oofem::SUPGElement::t_pspg, and oofem::FloatArray::zero().
|
overrideprotectedvirtual |
Initializes the array of integration rules member variable. Element can have multiple integration rules for different tasks. For example structural element family class uses this feature to implement transparent support for reduced and selective integration of some strain components. Must be defined by terminator classes.
Reimplemented from oofem::TR1_2D_SUPG.
Definition at line 68 of file tr1_2d_supg_axi.C.
References oofem::Element::giveCrossSection(), and oofem::Element::integrationRulesArray.
|
overridevirtual |
Computes the linear advection term for mass conservation equation.
Reimplemented from oofem::TR1_2D_SUPG.
Definition at line 367 of file tr1_2d_supg_axi.C.
References oofem::FloatArray::at(), oofem::FloatMatrix::at(), oofem::TR1_2D_SUPG::b, oofem::TR1_2D_SUPG::c, computeNVector(), computeRadiusAt(), computeVolumeAround(), oofem::Element::integrationRulesArray, oofem::FloatMatrix::resize(), and oofem::FloatMatrix::zero().
|
overridevirtual |
Computes the contribution of the given body load (volumetric).
| answer | Requested contribution of load. |
| load | Load to compute contribution from. |
| type | Type of the contribution. |
| mode | Determines mode of answer. |
| tStep | Time step when answer is computed. |
Reimplemented from oofem::TR1_2D_SUPG.
Definition at line 709 of file tr1_2d_supg_axi.C.
References oofem::FloatArray::at(), oofem::TR1_2D_SUPG::b, oofem::TR1_2D_SUPG::c, oofem::FloatArray::clear(), oofem::Load::computeComponentArrayAt(), computeNVector(), oofem::FMElement::computeVectorOfVelocities(), computeVolumeAround(), oofem::ForceLoadBVT, oofem::GeneralBoundaryCondition::giveBCValType(), oofem::Element::giveCrossSection(), oofem::TimeStep::givePreviousStep(), oofem::Element::integrationRulesArray, oofem::FloatArray::resize(), oofem::SUPGElement::t_pspg, and oofem::SUPGElement::t_supg.
|
overridevirtual |
Computes SLIC stabilization term for momentum balance equation(s).
Reimplemented from oofem::TR1_2D_SUPG.
Definition at line 344 of file tr1_2d_supg_axi.C.
References oofem::FloatMatrix::at(), oofem::TR1_2D_SUPG::b, oofem::TR1_2D_SUPG::c, computeVolumeAround(), oofem::Element::giveCrossSection(), oofem::Element::integrationRulesArray, oofem::FloatMatrix::resize(), oofem::SUPGElement::t_lsic, and oofem::FloatMatrix::zero().
|
protected |
Definition at line 967 of file tr1_2d_supg_axi.C.
References oofem::GaussPoint::giveSubPatchCoordinates(), and oofem::TR1_2D_SUPG::interp.
Referenced by computeAccelerationTerm_MB(), computeAccelerationTerm_MC(), computeAdvectionDerivativeTerm_MB(), computeAdvectionDerivativeTerm_MC(), computeAdvectionTerm_MB(), computeAdvectionTerm_MC(), computeBCRhsTerm_MB(), computeDiffusionDerivativeTerm_MB(), computeDiffusionTerm_MB(), computeLinearAdvectionTerm_MC(), computeLoadVector(), computeOutFlowBCTerm_MB(), computePenetrationWithResistanceBCTerm_MB(), computePressureTerm_MB(), computeRadiusAt(), and computeSlipWithFrictionBCTerm_MB().
|
overridevirtual |
Computes Lhs contribution due to outflow BC.
Reimplemented from oofem::TR1_2D_SUPG.
Definition at line 857 of file tr1_2d_supg_axi.C.
References oofem::FloatArray::at(), oofem::FloatMatrix::clear(), computeNVector(), computeVolumeAround(), oofem::Element::giveNode(), oofem::Element::integrationRulesArray, oofem::FloatMatrix::negated(), and oofem::FloatMatrix::plusDyadUnsym().
Referenced by computeBCLhsPressureTerm_MB().
|
overridevirtual |
Computes Lhs contribution due to applied Penetration bc.
Reimplemented from oofem::TR1_2D_SUPG.
Definition at line 818 of file tr1_2d_supg_axi.C.
References oofem::FloatArray::at(), oofem::FloatMatrix::clear(), computeNVector(), computeVolumeAround(), oofem::Element::giveNode(), oofem::BoundaryLoad::giveProperty(), oofem::Element::integrationRulesArray, oofem::FloatMatrix::plusDyadSymmUpper(), and oofem::FloatMatrix::symmetrized().
Referenced by computeBCLhsTerm_MB().
|
overridevirtual |
Computes pressure terms for momentum balance equations(s).
Reimplemented from oofem::TR1_2D_SUPG.
Definition at line 308 of file tr1_2d_supg_axi.C.
References oofem::FloatArray::at(), oofem::FloatMatrix::at(), oofem::TR1_2D_SUPG::b, oofem::TR1_2D_SUPG::c, computeNVector(), computeRadiusAt(), oofem::FMElement::computeVectorOfVelocities(), computeVolumeAround(), oofem::TimeStep::givePreviousStep(), oofem::Element::integrationRulesArray, oofem::FloatMatrix::resize(), oofem::SUPGElement::t_supg, and oofem::FloatMatrix::zero().
|
overridevirtual |
Computes pressure terms for mass conservation equation.
Reimplemented from oofem::TR1_2D_SUPG.
Definition at line 541 of file tr1_2d_supg_axi.C.
References oofem::FloatMatrix::at(), oofem::TR1_2D_SUPG::b, oofem::TR1_2D_SUPG::c, computeVolumeAround(), oofem::Element::giveCrossSection(), oofem::Element::integrationRulesArray, oofem::FloatMatrix::resize(), oofem::SUPGElement::t_pspg, and oofem::FloatMatrix::zero().
|
protectedvirtual |
Definition at line 924 of file tr1_2d_supg_axi.C.
References oofem::FloatArray::at(), computeNVector(), and oofem::Element::giveNode().
Referenced by computeBMtrx(), computeDiffusionDerivativeTerm_MB(), computeDiffusionDerivativeTerm_MC(), computeDiffusionTerm_MB(), computeDiffusionTerm_MC(), computeLinearAdvectionTerm_MC(), computePressureTerm_MB(), and computeVolumeAround().
|
overridevirtual |
Computes Lhs term due to applied slip with friction bc.
Reimplemented from oofem::TR1_2D_SUPG.
Definition at line 781 of file tr1_2d_supg_axi.C.
References oofem::FloatArray::at(), oofem::FloatMatrix::clear(), computeNVector(), computeVolumeAround(), oofem::Element::giveNode(), oofem::BoundaryLoad::giveProperty(), oofem::Element::integrationRulesArray, oofem::FloatMatrix::plusDyadSymmUpper(), and oofem::FloatMatrix::symmetrized().
Referenced by computeBCLhsTerm_MB().
|
overrideprotectedvirtual |
Reimplemented from oofem::TR1_2D_SUPG.
Definition at line 580 of file tr1_2d_supg_axi.C.
References oofem::Element::giveCrossSection().
|
overridevirtual |
Returns volume related to given integration point. Used typically in subroutines, that perform integration over element volume. Should be implemented by particular elements.
| gp | Integration point for which volume is computed. |
Reimplemented from oofem::TR1_2D_SUPG.
Definition at line 973 of file tr1_2d_supg_axi.C.
References computeRadiusAt(), oofem::GaussPoint::giveSubPatchCoordinates(), oofem::GaussPoint::giveWeight(), and oofem::TR1_2D_SUPG::interp.
Referenced by computeAccelerationTerm_MB(), computeAccelerationTerm_MC(), computeAdvectionDerivativeTerm_MB(), computeAdvectionDerivativeTerm_MC(), computeAdvectionTerm_MB(), computeAdvectionTerm_MC(), computeBCRhsTerm_MB(), computeBCRhsTerm_MC(), computeDiffusionDerivativeTerm_MB(), computeDiffusionDerivativeTerm_MC(), computeDiffusionTerm_MB(), computeDiffusionTerm_MC(), computeLinearAdvectionTerm_MC(), computeLoadVector(), computeLSICStabilizationTerm_MB(), computeOutFlowBCTerm_MB(), computePenetrationWithResistanceBCTerm_MB(), computePressureTerm_MB(), computePressureTerm_MC(), and computeSlipWithFrictionBCTerm_MB().
|
inlineoverridevirtual |
Reimplemented from oofem::TR1_2D_SUPG.
Definition at line 91 of file tr1_2d_supg_axi.h.
|
inlineoverridevirtual |
Reimplemented from oofem::TR1_2D_SUPG.
Definition at line 92 of file tr1_2d_supg_axi.h.
References _IFT_TR1_2D_SUPG_AXI_Name.
|
inlineoverridevirtual |
Returns material mode for receiver integration points. Should be specialized.
Reimplemented from oofem::TR1_2D_SUPG.
Definition at line 93 of file tr1_2d_supg_axi.h.
|
overrideprotectedvirtual |
Reimplemented from oofem::TR1_2D_SUPG.
Definition at line 985 of file tr1_2d_supg_axi.C.
References oofem::Element::giveNode(), and rc.
|
overridevirtual |
Returns VOF fractions for each material on element according to nodal values of level set function (passed as parameter)
Reimplemented from oofem::TR1_2D_SUPG.
Definition at line 1075 of file tr1_2d_supg_axi.C.
References oofem::TR1_2D_SUPG::area, oofem::FloatArray::at(), oofem::Element::giveNode(), OOFEM_ERROR, oofem::FloatArray::resize(), oofem::sgn(), and oofem::zero().
|
overridevirtual |
Updates the stabilization coefficients used for CBS and SUPG algorithms.
| tStep | Active time step. |
Reimplemented from oofem::TR1_2D_SUPG.
Definition at line 998 of file tr1_2d_supg_axi.C.
References oofem::FloatArray::at(), oofem::TR1_2D_SUPG::b, oofem::TR1_2D_SUPG::c, oofem::FMElement::computeVectorOfVelocities(), oofem::FEMComponent::domain, oofem::Element::giveCrossSection(), oofem::TimeStep::givePreviousStep(), oofem::TimeStep::giveTimeIncrement(), oofem::Element::integrationRulesArray, oofem::max(), oofem::sum(), oofem::SUPGElement::t_lsic, oofem::SUPGElement::t_pspg, oofem::SUPGElement::t_supg, oofem::FloatArray::times(), oofem::VST_Density, oofem::VST_Length, oofem::VST_Time, oofem::VST_Velocity, and oofem::VST_Viscosity.
|
protected |
Radius at element center.
Definition at line 56 of file tr1_2d_supg_axi.h.
Referenced by initGeometry().