|
OOFEM 3.0
|
#include <lwedge.h>
Public Member Functions | |
| LWedge (int, Domain *) | |
| virtual | ~LWedge () |
| FEInterpolation * | giveInterpolation () const override |
| void | initializeFrom (InputRecord &ir, int priority) override |
| Interface * | giveInterface (InterfaceType) override |
| int | testElementExtension (ElementExtension ext) override |
| int | giveNumberOfIPForMassMtrxIntegration () override |
| void | SPRNodalRecoveryMI_giveSPRAssemblyPoints (IntArray &pap) override |
| void | SPRNodalRecoveryMI_giveDofMansDeterminedByPatch (IntArray &answer, int pap) override |
| int | SPRNodalRecoveryMI_giveNumberOfIP () override |
| SPRPatchType | SPRNodalRecoveryMI_givePatchType () override |
| void | NodalAveragingRecoveryMI_computeNodalValue (FloatArray &answer, int node, InternalStateType type, TimeStep *tStep) override |
| const char * | giveInputRecordName () const override |
| const char * | giveClassName () const override |
| Element_Geometry_Type | giveGeometryType () const override |
| Public Member Functions inherited from oofem::Structural3DElement | |
| Structural3DElement (int n, Domain *d) | |
| virtual | ~Structural3DElement () |
| Destructor. | |
| void | initializeFrom (InputRecord &ir, int priority) override |
| MaterialMode | giveMaterialMode () override |
| int | computeNumberOfDofs () override |
| void | giveDofManDofIDMask (int inode, IntArray &answer) const override |
| double | computeVolumeAround (GaussPoint *gp) override |
| double | giveCharacteristicLength (const FloatArray &normalToCrackPlane) override |
| void | giveMaterialOrientationAt (FloatArray &x, FloatArray &y, FloatArray &z, const FloatArray &lcoords) |
| void | computeStressVector (FloatArray &answer, const FloatArray &strain, GaussPoint *gp, TimeStep *tStep) override |
| void | computeConstitutiveMatrixAt (FloatMatrix &answer, MatResponseMode rMode, GaussPoint *gp, TimeStep *tStep) override |
| void | computeConstitutiveMatrix_dPdF_At (FloatMatrix &answer, MatResponseMode rMode, GaussPoint *gp, TimeStep *tStep) override |
| void | computeInitialStressMatrix (FloatMatrix &answer, TimeStep *tStep) override |
| Public Member Functions inherited from oofem::NLStructuralElement | |
| NLStructuralElement (int n, Domain *d) | |
| virtual | ~NLStructuralElement () |
| Destructor. | |
| int | giveGeometryMode () |
| void | computeFirstPKStressVector (FloatArray &answer, GaussPoint *gp, TimeStep *tStep) |
| void | computeCauchyStressVector (FloatArray &answer, GaussPoint *gp, TimeStep *tStep) |
| void | computeStiffnessMatrix (FloatMatrix &answer, MatResponseMode rMode, TimeStep *tStep) override |
| void | computeStiffnessMatrix_withIRulesAsSubcells (FloatMatrix &answer, MatResponseMode rMode, TimeStep *tStep) |
| void | giveInternalForcesVector (FloatArray &answer, TimeStep *tStep, int useUpdatedGpRecord=0) override |
| void | giveInternalForcesVector_withIRulesAsSubcells (FloatArray &answer, TimeStep *tStep, int useUpdatedGpRecord=0) override |
| virtual void | computeDeformationGradientVector (FloatArray &answer, GaussPoint *gp, TimeStep *tStep) |
| double | computeCurrentVolume (TimeStep *tStep) |
| void | giveInputRecord (DynamicInputRecord &input) override |
| const char * | giveClassName () const override |
| Public Member Functions inherited from oofem::StructuralElement | |
| StructuralElement (int n, Domain *d) | |
| virtual | ~StructuralElement () |
| Destructor. | |
| void | giveCharacteristicMatrix (FloatMatrix &answer, CharType, TimeStep *tStep) override |
| void | giveCharacteristicVector (FloatArray &answer, CharType type, ValueModeType mode, TimeStep *tStep) override |
| virtual void | computeMassMatrix (FloatMatrix &answer, TimeStep *tStep) |
| virtual void | computeLumpedMassMatrix (FloatMatrix &answer, TimeStep *tStep) |
| virtual void | computeConsistentMassMatrix (FloatMatrix &answer, TimeStep *tStep, double &mass, const double *ipDensity=NULL) |
| virtual void | giveMassMtrxIntegrationgMask (IntArray &answer) |
| void | computeStiffnessMatrix_withIRulesAsSubcells (FloatMatrix &answer, MatResponseMode rMode, TimeStep *tStep) |
| virtual void | computeLumpedInitialStressMatrix (FloatMatrix &answer, TimeStep *tStep) |
| void | computeField (ValueModeType mode, TimeStep *tStep, const FloatArray &lcoords, FloatArray &answer) override |
| virtual void | computeStrainVector (FloatArray &answer, GaussPoint *gp, TimeStep *tStep) |
| int | giveIPValue (FloatArray &answer, GaussPoint *gp, InternalStateType type, TimeStep *tStep) override |
| virtual void | computeResultingIPTemperatureAt (FloatArray &answer, TimeStep *tStep, GaussPoint *gp, ValueModeType mode) |
| virtual void | computeResultingIPEigenstrainAt (FloatArray &answer, TimeStep *tStep, GaussPoint *gp, ValueModeType mode) |
| virtual void | computeNmatrixAt (const FloatArray &iLocCoord, FloatMatrix &answer) |
| void | updateBeforeNonlocalAverage (TimeStep *tStep) override |
| virtual void | giveNonlocalLocationArray (IntArray &locationArray, const UnknownNumberingScheme &us) |
| virtual void | addNonlocalStiffnessContributions (SparseMtrx &dest, const UnknownNumberingScheme &s, TimeStep *tStep) |
| int | adaptiveUpdate (TimeStep *tStep) override |
| void | updateInternalState (TimeStep *tStep) override |
| void | updateYourself (TimeStep *tStep) override |
| int | checkConsistency () override |
| void | giveInputRecord (DynamicInputRecord &input) override |
| const char * | giveClassName () const override |
| int | giveInternalStateAtNode (FloatArray &answer, InternalStateType type, InternalStateMode mode, int node, TimeStep *tStep) override |
| void | showSparseMtrxStructure (CharType mtrx, oofegGraphicContext &gc, TimeStep *tStep) override |
| Shows sparse structure. | |
| void | showExtendedSparseMtrxStructure (CharType mtrx, oofegGraphicContext &gc, TimeStep *tStep) override |
| Shows extended sparse structure (for example, due to nonlocal interactions for tangent stiffness). | |
| void | computeLoadVector (FloatArray &answer, BodyLoad *load, CharType type, ValueModeType mode, TimeStep *tStep) override |
| void | computeBoundarySurfaceLoadVector (FloatArray &answer, BoundaryLoad *load, int boundary, CharType type, ValueModeType mode, TimeStep *tStep, bool global=true) override |
| void | computeBoundaryEdgeLoadVector (FloatArray &answer, BoundaryLoad *load, int boundary, CharType type, ValueModeType mode, TimeStep *tStep, bool global=true) override |
| virtual void | computeEdgeNMatrix (FloatMatrix &answer, int boundaryID, const FloatArray &lcoords) |
| computes edge interpolation matrix | |
| virtual void | computeSurfaceNMatrix (FloatMatrix &answer, int boundaryID, const FloatArray &lcoords) |
| StructuralCrossSection * | giveStructuralCrossSection () |
| Helper function which returns the structural cross-section for the element. | |
| virtual void | createMaterialStatus () |
| 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 | computeTangentFromSurfaceLoad (FloatMatrix &answer, BoundaryLoad *load, int boundary, MatResponseMode rmode, TimeStep *tStep) |
| virtual void | computeTangentFromEdgeLoad (FloatMatrix &answer, BoundaryLoad *load, int boundary, MatResponseMode rmode, TimeStep *tStep) |
| 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 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 () |
| int | giveGlobalIPValue (FloatArray &answer, GaussPoint *gp, InternalStateType type, TimeStep *tStep) |
| virtual double | giveLengthInDir (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 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 | 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 | drawRawGeometry (oofegGraphicContext &gc, TimeStep *tStep) |
| virtual void | drawDeformedGeometry (oofegGraphicContext &gc, TimeStep *tStep, UnknownType) |
| virtual void | drawScalar (oofegGraphicContext &gc, TimeStep *tStep) |
| 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) |
| 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. | |
| void | saveContext (DataStream &stream, ContextMode mode) override |
| void | restoreContext (DataStream &stream, ContextMode mode) override |
| void | printOutputAt (FILE *file, TimeStep *tStep) override |
| 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::SPRNodalRecoveryModelInterface | |
| SPRNodalRecoveryModelInterface () | |
| Constructor. | |
| Public Member Functions inherited from oofem::Interface | |
| Interface () | |
| Constructor. | |
| virtual | ~Interface () |
| 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::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) |
Static Protected Attributes | |
| static FEI3dWedgeLin | interpolation |
| Static Protected Attributes inherited from oofem::Structural3DElement | |
| static ParamKey | IPK_Structural3DElement_materialCoordinateSystem |
| [optional] Material coordinate system (local) for the element. | |
| Static Protected Attributes inherited from oofem::NLStructuralElement | |
| static ParamKey | IPK_NLStructuralElement_nlgeoflag |
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 |
| Protected Member Functions inherited from oofem::Structural3DElement | |
| void | computeBmatrixAt (GaussPoint *gp, FloatMatrix &answer, int lowerIndx=1, int upperIndx=ALL_STRAINS) override |
| void | computeBHmatrixAt (GaussPoint *gp, FloatMatrix &answer) override |
| void | computeGaussPoints () override |
| void | giveEdgeDofMapping (IntArray &answer, int iEdge) const override |
| double | computeEdgeVolumeAround (GaussPoint *gp, int iEdge) override |
| int | computeLoadLEToLRotationMatrix (FloatMatrix &answer, int iEdge, GaussPoint *gp) override |
| int | testElementExtension (ElementExtension ext) override |
| void | computeSurfaceNMatrixAt (FloatMatrix &answer, int iSurf, GaussPoint *gp) |
| void | giveSurfaceDofMapping (IntArray &answer, int) const override |
| double | computeSurfaceVolumeAround (GaussPoint *gp, int) override |
| int | computeLoadLSToLRotationMatrix (FloatMatrix &answer, int, GaussPoint *gp) override |
| Protected Member Functions inherited from oofem::NLStructuralElement | |
| int | checkConsistency () override |
| virtual void | computePointLoadVectorAt (FloatArray &answer, Load *load, TimeStep *tStep, ValueModeType mode, bool global=true) |
| virtual int | computeLoadGToLRotationMtrx (FloatMatrix &answer) |
| void | condense (FloatMatrix *stiff, FloatMatrix *mass, FloatArray *load, IntArray *what) |
| virtual void | setupIRForMassMtrxIntegration (IntegrationRule &iRule) |
| virtual void | computeBodyLoadVectorAt (FloatArray &answer, Load *load, TimeStep *tStep, ValueModeType mode) |
| Protected Attributes inherited from oofem::Structural3DElement | |
| bool | matRotation |
| Protected Attributes inherited from oofem::NLStructuralElement | |
| int | nlGeometry =0 |
| Flag indicating if geometrical nonlinearities apply. | |
| Protected Attributes inherited from oofem::StructuralElement | |
| std::unique_ptr< FloatArray > | initialDisplacements |
| Initial displacement vector, describes the initial nodal displacements when element has been casted. | |
| 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. | |
This class implements a Linear 3d 6 - node elasticity finite element.
| oofem::LWedge::LWedge | ( | int | n, |
| Domain * | aDomain ) |
|
inlineoverridevirtual |
Reimplemented from oofem::Element.
|
inlineoverridevirtual |
Returns the element geometry type. This information is assumed to be of general interest, but it is required only for some specialized tasks.
Implements oofem::Element.
|
inlineoverridevirtual |
Implements oofem::FEMComponent.
Definition at line 79 of file lwedge.h.
References _IFT_LWedge_Name.
|
overridevirtual |
Interface requesting service.
Reimplemented from oofem::FEMComponent.
Definition at line 75 of file lwedge.C.
References oofem::NodalAveragingRecoveryModelInterface::NodalAveragingRecoveryModelInterface(), oofem::NodalAveragingRecoveryModelInterfaceType, OOFEM_LOG_INFO, oofem::SpatialLocalizerInterface::SpatialLocalizerInterface(), oofem::SpatialLocalizerInterfaceType, oofem::SPRNodalRecoveryModelInterface::SPRNodalRecoveryModelInterface(), oofem::SPRNodalRecoveryModelInterfaceType, oofem::ZZNodalRecoveryModelInterface::ZZNodalRecoveryModelInterface(), and oofem::ZZNodalRecoveryModelInterfaceType.
|
overridevirtual |
Reimplemented from oofem::Element.
Definition at line 71 of file lwedge.C.
References interpolation.
|
inlineoverridevirtual |
Return desired number of integration points for consistent mass matrix computation, if required.
TODO this is without the jacobian and density
Reimplemented from oofem::StructuralElement.
|
overridevirtual |
Reimplemented from oofem::Element.
|
overridevirtual |
Computes the element value in given node.
| answer | Contains the result. |
| node | Element node number. |
| type | Determines the type of internal variable to be recovered. |
| tStep | Time step. |
Implements oofem::NodalAveragingRecoveryModelInterface.
Definition at line 134 of file lwedge.C.
References oofem::FloatArray::clear(), and OOFEM_WARNING.
|
overridevirtual |
Implements oofem::SPRNodalRecoveryModelInterface.
Definition at line 101 of file lwedge.C.
References oofem::IntArray::at(), oofem::Element::giveNode(), oofem::FEMComponent::giveNumber(), OOFEM_ERROR, and oofem::IntArray::resize().
|
overridevirtual |
Implements oofem::SPRNodalRecoveryModelInterface.
Definition at line 120 of file lwedge.C.
References oofem::Element::numberOfGaussPoints.
|
overridevirtual |
Implements oofem::SPRNodalRecoveryModelInterface.
Definition at line 127 of file lwedge.C.
References oofem::SPRPatchType_3dBiLin.
|
overridevirtual |
Implements oofem::SPRNodalRecoveryModelInterface.
Definition at line 92 of file lwedge.C.
References oofem::IntArray::at(), oofem::Element::giveNode(), and oofem::IntArray::resize().
|
inlineoverridevirtual |
Tests if the element implements required extension. ElementExtension type defines the list of all available element extensions.
| ext | Extension to be tested. |
Reimplemented from oofem::Element.
Definition at line 68 of file lwedge.h.
References oofem::Element_SurfaceLoadSupport.
|
staticprotected |
Definition at line 57 of file lwedge.h.
Referenced by giveInterpolation().