|
OOFEM 3.0
|
#include <mitc4.h>
Public Member Functions | |
| MITC4Shell (int n, Domain *d) | |
| FEInterpolation * | giveInterpolation () const override |
| FEInterpolation * | giveInterpolation (DofIDItem id) const override |
| int | testElementExtension (ElementExtension ext) override |
| Interface * | giveInterface (InterfaceType interface) override |
| const char * | giveClassName () const override |
| const char * | giveInputRecordName () const override |
| integrationDomain | giveIntegrationDomain () const override |
| MaterialMode | giveMaterialMode () override |
| void | initializeFrom (InputRecord &ir, int priority) override |
| void | postInitialize () override |
| Performs post initialization steps. | |
| int | computeNumberOfDofs () override |
| int | computeNumberOfGlobalDofs () override |
| Element_Geometry_Type | giveGeometryType () const 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 |
| void | giveInternalForcesVector (FloatArray &answer, TimeStep *tStep, int useUpdatedGpRecord) override |
| bool | computeGtoLRotationMatrix (FloatMatrix &answer) override |
| int | computeLoadGToLRotationMtrx (FloatMatrix &answer) override |
| std::array< FloatMatrixF< 3, 3 >, 4 > | computeLToDirectorRotationMatrix () |
| int | computeLoadLEToLRotationMatrix (FloatMatrix &answer, int iEdge, GaussPoint *gp) override |
| void | drawRawGeometry (oofegGraphicContext &gc, TimeStep *tStep) override |
| void | drawDeformedGeometry (oofegGraphicContext &gc, TimeStep *tStep, UnknownType type) override |
| void | drawScalar (oofegGraphicContext &gc, TimeStep *tStep) 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 | computeInitialStressMatrix (FloatMatrix &answer, TimeStep *tStep) |
| virtual void | computeLumpedInitialStressMatrix (FloatMatrix &answer, TimeStep *tStep) |
| void | computeField (ValueModeType mode, TimeStep *tStep, const FloatArray &lcoords, FloatArray &answer) override |
| virtual void | giveInternalForcesVector_withIRulesAsSubcells (FloatArray &answer, TimeStep *tStep, int useUpdatedGpRecord=0) |
| 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) |
| 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 |
| 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) |
| int | computeNumberOfPrimaryMasterDofs () |
| 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 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 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) |
| 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 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 | 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 | saveContext (DataStream &stream, ContextMode mode) override |
| void | restoreContext (DataStream &stream, ContextMode mode) 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::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::Interface | |
| Interface () | |
| Constructor. | |
| virtual | ~Interface () |
| Public Member Functions inherited from oofem::SPRNodalRecoveryModelInterface | |
| SPRNodalRecoveryModelInterface () | |
| Constructor. | |
| 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) |
Protected Member Functions | |
| void | computeGaussPoints () override |
| void | computeStiffnessMatrix (FloatMatrix &answer, MatResponseMode rMode, TimeStep *tStep) override |
| void | computeBmatrixAt (GaussPoint *gp, FloatMatrix &answer, int=1, int=ALL_STRAINS) override |
| void | computeNmatrixAt (const FloatArray &iLocCoord, FloatMatrix &answer) override |
| void | computeConstitutiveMatrixAt (FloatMatrix &answer, MatResponseMode rMode, GaussPoint *gp, TimeStep *tStep) override |
| void | computeStressVector (FloatArray &answer, const FloatArray &strain, GaussPoint *gp, TimeStep *tStep) override |
| virtual void | computePointLoadVectorAt (FloatArray &answer, Load *load, TimeStep *tStep, ValueModeType mode, bool global=true) |
| virtual int | computeLoadLSToLRotationMatrix (FloatMatrix &answer, int iSurf, GaussPoint *gp) |
| virtual int | giveNumberOfIPForMassMtrxIntegration () |
| void | condense (FloatMatrix *stiff, FloatMatrix *mass, FloatArray *load, IntArray *what) |
| virtual void | computeBodyLoadVectorAt (FloatArray &answer, Load *load, TimeStep *tStep, ValueModeType mode) |
Protected Attributes | |
| FloatMatrixF< 3, 3 > | GtoLRotationMatrix |
| int | nPointsXY = 0 |
| int | nPointsZ = 0 |
| int | directorType = 0 |
| double | drillCoeff = 0. |
| 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. | |
Static Protected Attributes | |
| static FEI2dQuadLin | interp_lin |
| Element geometry approximation. | |
| static ParamKey | IPK_MITC4Shell_nipZ |
| static ParamKey | IPK_MITC4Shell_directorType |
Private Member Functions | |
| std::array< FloatArrayF< 3 >, 4 > | giveNodeCoordinates () |
| std::array< FloatArrayF< 3 >, 4 > | giveDirectorVectors () |
| std::array< FloatArrayF< 3 >, 4 > | giveLocalDirectorVectors () |
| std::array< double, 4 > | giveThickness () |
| FloatMatrixF< 3, 3 > | giveJacobian (const FloatArrayF< 3 > &lcoords) |
| FloatArrayF< 3 > | giveLocalCoordinates (const FloatArrayF< 3 > &global) |
| int | giveIPValue (FloatArray &answer, GaussPoint *gp, InternalStateType type, TimeStep *tStep) override |
| FloatMatrix | giveCharacteristicTensor (CharTensor type, GaussPoint *gp, TimeStep *tStep) |
| void | printOutputAt (FILE *file, TimeStep *tStep) override |
| int | computeGlobalCoordinates (FloatArray &answer, const FloatArray &lcoords) override |
| bool | computeLocalCoordinates (FloatArray &answer, const FloatArray &coords) override |
| double | computeVolumeAround (GaussPoint *gp) override |
| std::array< FloatArrayF< 3 >, 3 > | computeLocalBaseVectors () |
| std::array< FloatArrayF< 4 >, 2 > | givedNdx (const FloatArrayF< 3 > &coords) |
| FloatArray | giveMidplaneIPValue (int gpXY, InternalStateType type, TimeStep *tStep) |
| double | computeEdgeVolumeAround (GaussPoint *gp, int iEdge) override |
| void | giveEdgeDofMapping (IntArray &answer, int iEdge) const override |
| void | giveDofManDofIDMask (int inode, IntArray &) const override |
| double | computeSurfaceVolumeAround (GaussPoint *gp, int iSurf) override |
| void | computeSurfaceNMatrixAt (FloatMatrix &answer, int iSurf, GaussPoint *sgp) |
| void | giveSurfaceDofMapping (IntArray &answer, int iSurf) const override |
| void | computeSurfaceNMatrix (FloatMatrix &answer, int boundaryID, const FloatArray &lcoords) override |
| void | computeEdgeNMatrix (FloatMatrix &answer, int boundaryID, const FloatArray &lcoords) override |
| computes edge interpolation matrix | |
| void | setupIRForMassMtrxIntegration (IntegrationRule &iRule) override |
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 |
This class implements an quad element based on Mixed Interpolation of Tensorial Components (MITC). This element is a shell element suitable for both thin and thick shells. The element has 24 DOFs (u,v,w-displacements and three rotations) in each node
Tasks:
| oofem::MITC4Shell::MITC4Shell | ( | int | n, |
| Domain * | d ) |
Definition at line 74 of file mitc4.C.
References directorType, nPointsXY, nPointsZ, oofem::Element::numberOfDofMans, oofem::Element::numberOfGaussPoints, oofem::SpatialLocalizerInterface::SpatialLocalizerInterface(), oofem::SPRNodalRecoveryModelInterface::SPRNodalRecoveryModelInterface(), oofem::StructuralElement::StructuralElement(), and oofem::ZZNodalRecoveryModelInterface::ZZNodalRecoveryModelInterface().
Referenced by giveDirectorVectors().
|
overrideprotectedvirtual |
Computes the geometrical matrix of receiver in given integration point. The product of this matrix (assembled at given integration point) and element displacement vector is element strain vector. If lowerIndx and upperIndx parameters are specified, answer is formed only for strains within this interval. This will affects the size of answer.
| gp | Integration point for which answer is computed. |
| answer | Geometric matrix of receiver. |
| lowerIndx | If specified, answer is formed only for strain with index equal and greater than lowerIndx. This parameter has default value 1 (answer is formed from first strain). |
| upperIndx | If specified, answer is formed only for strain with index less and equal than upperIndx. This parameter has default value ALL_STRAINS (answer is formed for all strains). |
Implements oofem::StructuralElement.
Definition at line 471 of file mitc4.C.
References oofem::FloatMatrix::at(), oofem::cross(), oofem::dot(), givedNdx(), giveJacobian(), giveLocalDirectorVectors(), oofem::GaussPoint::giveNaturalCoordinate(), giveNodeCoordinates(), giveThickness(), oofem::inv(), oofem::normalize(), oofem::FloatMatrix::resize(), and oofem::FloatMatrix::zero().
|
overrideprotectedvirtual |
Computes constitutive matrix of receiver. Default implementation uses element cross section giveCharMaterialStiffnessMatrix service.
| answer | Constitutive matrix. |
| rMode | Material response mode of answer. |
| gp | Integration point for which constitutive matrix is computed. |
| tStep | Time step. |
Implements oofem::StructuralElement.
Definition at line 260 of file mitc4.C.
References oofem::Element::giveCrossSection().
|
overrideprivatevirtual |
computes edge interpolation matrix
Reimplemented from oofem::StructuralElement.
Definition at line 1179 of file mitc4.C.
References oofem::FloatMatrix::beNMatrixOf(), oofem::FEInterpolation::boundaryEdgeEvalN(), and giveInterpolation().
|
overrideprivatevirtual |
Computes volume related to integration point on local edge.
| gp | edge integration point |
| iEdge | edge number |
Reimplemented from oofem::StructuralElement.
Definition at line 1076 of file mitc4.C.
References oofem::GaussPoint::giveNaturalCoordinates(), giveNodeCoordinates(), oofem::GaussPoint::giveWeight(), and interp_lin.
|
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::Element.
Definition at line 159 of file mitc4.C.
References oofem::Element::giveCrossSection(), oofem::Element::integrationRulesArray, nPointsXY, nPointsZ, and oofem::CrossSection::setupIntegrationPoints().
|
overrideprivatevirtual |
Computes the global coordinates from given element's local coordinates.
| answer | Requested global coordinates. |
| lcoords | Local coordinates. |
Reimplemented from oofem::Element.
Definition at line 947 of file mitc4.C.
References oofem::FloatArray::at(), computeNmatrixAt(), oofem::DofManager::giveCoordinate(), oofem::Element::giveNode(), N, and oofem::FloatArray::resize().
|
overridevirtual |
Returns transformation matrix from global c.s. to local element c.s., i.e. \( r_l =T r_g \). If no transformation is necessary then answer is empty matrix and zero value is returned.
| answer | Computed rotation matrix. |
Reimplemented from oofem::Element.
Definition at line 718 of file mitc4.C.
References computeLToDirectorRotationMatrix(), oofem::dot(), GtoLRotationMatrix, oofem::FloatMatrix::resize(), oofem::FloatMatrix::setSubMatrix(), and oofem::FloatMatrix::zero().
|
overridevirtual |
Returns transformation matrix from global coordinate system to local element coordinate system for element load vector components. If no transformation is necessary, answer is empty matrix (default);
| answer | Transformation matrix. |
Reimplemented from oofem::StructuralElement.
Definition at line 961 of file mitc4.C.
References oofem::FloatMatrix::at(), GtoLRotationMatrix, oofem::FloatMatrix::resize(), and oofem::FloatMatrix::zero().
|
overridevirtual |
Returns transformation matrix from local edge c.s to element local coordinate system of load vector components. Necessary, because integration must be done in local coordinate system of entity (edge or surface). If no transformation is necessary, answer is empty matrix (default);
| answer | Computed rotation matrix. |
| iEdge | Edge number. |
| gp | Integration point (point, where transformation is computed, useful for curved edges). |
Reimplemented from oofem::StructuralElement.
Definition at line 1105 of file mitc4.C.
References oofem::FloatMatrix::at(), computeLocalBaseVectors(), oofem::cross(), oofem::dot(), oofem::DofManager::giveCoordinates(), oofem::Element::giveNode(), interp_lin, oofem::normalize(), oofem::FloatMatrix::resize(), and oofem::FloatMatrix::zero().
|
private |
Definition at line 655 of file mitc4.C.
References oofem::cross(), oofem::Element::giveNode(), and oofem::normalize().
Referenced by computeLoadLEToLRotationMatrix(), computeLToDirectorRotationMatrix(), giveDirectorVectors(), and postInitialize().
|
overrideprivatevirtual |
Computes the element local coordinates from given global coordinates. Should compute local coordinates even if point is outside element (for mapping purposes in adaptivity)
| answer | Local coordinates. |
| gcoords | Global coordinates. |
Reimplemented from oofem::Element.
Definition at line 921 of file mitc4.C.
References oofem::FloatArray::at(), oofem::CS_Thickness, oofem::CrossSection::give(), oofem::Element::giveCrossSection(), giveLocalCoordinates(), oofem::Element::giveNode(), interp_lin, and oofem::FloatArray::resize().
| std::array< FloatMatrixF< 3, 3 >, 4 > oofem::MITC4Shell::computeLToDirectorRotationMatrix | ( | ) |
Definition at line 679 of file mitc4.C.
References computeLocalBaseVectors(), oofem::cross(), oofem::dot(), giveDirectorVectors(), and oofem::normalize().
Referenced by computeGtoLRotationMatrix().
|
overrideprotectedvirtual |
Computes interpolation matrix for element unknowns. The order and meaning of unknowns is element dependent.
| iLocCoord | Local coordinates. |
| answer | Interpolation matrix evaluated at gp. |
Reimplemented from oofem::StructuralElement.
Definition at line 232 of file mitc4.C.
References oofem::FloatArray::at(), oofem::FloatMatrix::at(), oofem::cross(), giveLocalDirectorVectors(), giveThickness(), interp_lin, oofem::normalize(), oofem::FloatMatrix::resize(), and oofem::FloatMatrix::zero().
Referenced by computeGlobalCoordinates(), and computeSurfaceNMatrixAt().
|
inlineoverridevirtual |
Computes or simply returns total number of element's local DOFs. Must be defined by particular element.
Reimplemented from oofem::Element.
|
inlineoverridevirtual |
Computes the total number of element's global dofs. The transitions from global c.s. to nodal c.s. should NOT be included.
Reimplemented from oofem::Element.
|
overrideprotectedvirtual |
Computes numerically stiffness matrix of receiver. Default implementation computes element stiffness using \( K=\int_v B^{\mathrm{T}} D B \mathrm{d}V \) formulae, where \( B \) is element geometric matrix and \( D \) is material stiffness matrix. No geometrical nonlinearity is taken into account. NUmerical integration procedure uses integrationRulesArray for numerical integration. Support for reduced or selected integration is implemented. The individual integration rules are assumed to correspond to different terms from which the overall matrix is assembled.
If there is one integration rule, the full integration of all coefficients is performed. Otherwise, integration is performed using following rules. Each integration rule can specify start and end strain index of strain vector components for which is valid. It is necessary to ensure that these start and end indexes, dividing geometrical matrix into blocks, are not overlapping and that each strain component is included.
Then stiffness matrix is obtained as summation of integrals \( I_{ij}=\int_v B^{\mathrm{T}}_i D_{ij} B_j \mathrm{d}V \) where \( B_i \) is i-th block of geometrical matrix and \( D_{ij} \) is corresponding constitutive sub-matrix. The geometrical matrix is obtained using computeBmatrixAt service and the constitutive matrix is obtained using computeConstitutiveMatrixAt service. The \( I_{ij} \) integral is evaluated using such integration rule, which is valid for i-th or j-th block and has smaller number of integration points.
For higher numerical performance, only one half of stiffness matrix is computed and answer is then symmetrized. Therefore, if element matrix will be generally nonsymmetric, one must specialize this method. Finally, the result is transformed into global coordinate system (or nodal coordinate system, if it is defined).
| answer | Computed stiffness matrix (symmetric). |
| rMode | Response mode. |
| tStep | Time step. |
Reimplemented from oofem::StructuralElement.
Definition at line 372 of file mitc4.C.
References oofem::FloatMatrix::assemble(), oofem::FloatMatrix::at(), oofem::StructuralElement::computeStiffnessMatrix(), computeVolumeAround(), oofem::CS_DrillingStiffness, oofem::CS_DrillingType, oofem::CS_RelDrillingStiffness, drillCoeff, oofem::eye(), oofem::CrossSection::give(), oofem::Element::giveDefaultIntegrationRulePtr(), oofem::StructuralElement::giveStructuralCrossSection(), oofem::Element::integrationRulesArray, interp_lin, oofem::FloatMatrix::plusDyadSymmUpper(), and oofem::FloatMatrix::symmetrized().
|
overrideprotectedvirtual |
Computes the stress vector of receiver at given integration point, at time step tStep. The nature of these stresses depends on the element's type.
| answer | Stress vector. |
| strain | Strain vector. |
| gp | Integration point. |
| tStep | Time step. |
Implements oofem::StructuralElement.
Definition at line 739 of file mitc4.C.
References oofem::StructuralCrossSection::giveRealStress_3dDegeneratedShell(), and oofem::StructuralElement::giveStructuralCrossSection().
Referenced by giveCharacteristicTensor(), and giveMidplaneIPValue().
|
overrideprivatevirtual |
Computes surface interpolation matrix. Interpolation matrix provide way, how to compute local surface unknowns (nonzero element unknowns on surface) at any integration point of surface, based on local unknowns in surface nodes. Local coordinate system of surface edge and element surface numbering is element dependent. The integration point is specified using two-dimensional iso coordinates, or using area coordinates for triangular surface.
| answer | Interpolation matrix of surface. |
| boundaryID | Surface number. |
| local | coordinates |
Reimplemented from oofem::StructuralElement.
Definition at line 1188 of file mitc4.C.
References oofem::FloatMatrix::beNMatrixOf(), oofem::FEInterpolation::boundarySurfaceEvalN(), and giveInterpolation().
|
private |
Definition at line 1136 of file mitc4.C.
References computeNmatrixAt(), oofem::GaussPoint::giveNaturalCoordinates(), and oofem::Vec3().
|
overrideprivatevirtual |
Computes volume related to integration point on local surface.
| gp | Surface integration point. |
| iSurf | Surface number. |
Reimplemented from oofem::StructuralElement.
Definition at line 1154 of file mitc4.C.
References oofem::det(), oofem::GaussPoint::giveNaturalCoordinate(), giveNodeCoordinates(), oofem::GaussPoint::giveWeight(), and interp_lin.
|
overrideprivatevirtual |
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::Element.
Definition at line 305 of file mitc4.C.
References oofem::det(), giveJacobian(), oofem::GaussPoint::giveNaturalCoordinate(), and oofem::GaussPoint::giveWeight().
Referenced by computeStiffnessMatrix(), and giveInternalForcesVector().
|
overridevirtual |
Reimplemented from oofem::Element.
Definition at line 1231 of file mitc4.C.
References gc, oofem::Element::giveNode(), oofem::Element::isActivated(), OOFEG_DEFORMED_GEOMETRY_LAYER, and OOFEG_DEFORMED_GEOMETRY_WIDTH.
|
overridevirtual |
Reimplemented from oofem::Element.
Definition at line 1202 of file mitc4.C.
References gc, oofem::Element::giveNode(), oofem::Element::isActivated(), OOFEG_RAW_GEOMETRY_LAYER, and OOFEG_RAW_GEOMETRY_WIDTH.
|
overridevirtual |
Reimplemented from oofem::Element.
Definition at line 1260 of file mitc4.C.
References oofem::FloatArray::add(), oofem::FloatArray::at(), gc, oofem::Element::giveDefaultIntegrationRulePtr(), oofem::StructuralElement::giveInternalStateAtNode(), giveIPValue(), oofem::Element::giveNode(), oofem::GaussPoint::giveWeight(), oofem::Element::isActivated(), oofem::ISM_local, oofem::ISM_recovered, OOFEG_VARPLOT_PATTERN_LAYER, oofem::SA_ISO_SURF, and oofem::FloatArray::times().
|
private |
Definition at line 746 of file mitc4.C.
References oofem::StructuralElement::computeStrainVector(), computeStressVector(), oofem::from_voigt_strain_6(), oofem::from_voigt_stress_6(), oofem::StructuralCrossSection::giveMaterial(), oofem::StructuralElement::giveStructuralCrossSection(), oofem::GlobalForceTensor, oofem::GlobalStrainTensor, and GtoLRotationMatrix.
Referenced by giveIPValue().
|
inlineoverridevirtual |
Reimplemented from oofem::Element.
|
private |
Definition at line 170 of file mitc4.C.
References oofem::IntArray::at(), computeLocalBaseVectors(), oofem::CS_DirectorVectorX, oofem::CS_DirectorVectorY, oofem::CS_DirectorVectorZ, directorType, oofem::CrossSection::give(), oofem::Domain::giveConnectivityTable(), oofem::DofManager::giveCoordinates(), oofem::Element::giveCrossSection(), oofem::FEMComponent::giveDomain(), oofem::Domain::giveElement(), oofem::Element::giveNode(), oofem::ConnectivityTable::giveNodeNeighbourList(), oofem::FEMComponent::giveNumber(), oofem::IntArray::giveSize(), MITC4Shell(), and oofem::normalize().
Referenced by computeLToDirectorRotationMatrix(), and giveLocalDirectorVectors().
|
private |
Definition at line 879 of file mitc4.C.
References oofem::dot(), giveJacobian(), interp_lin, and oofem::inv().
Referenced by computeBmatrixAt(), and giveMidplaneIPValue().
|
overrideprivatevirtual |
Returns dofmanager dof mask for node. This mask defines the dofs which are used by element in node. Mask influences the code number ordering for particular node. Code numbers are ordered according to node order and dofs belonging to particular node are ordered according to this mask. If element requests dofs using node mask which are not in node then error is generated. This masking allows node to be shared by different elements with different dofs in same node. Elements local code numbers are extracted from node using this mask. Must be defined by particular element.
| inode | Mask is computed for local dofmanager with inode number. |
| answer | Mask for node. |
Reimplemented from oofem::Element.
|
overrideprivatevirtual |
Assembles edge dof mapping mask, which provides mapping between edge local DOFs and "global" element DOFs. Mask can be imagined as local edge code numbers used to localize local edge DOFs to element DOFs.
| answer | Edge DOF mapping. |
| iEdge | Edge number. |
Reimplemented from oofem::StructuralElement.
Definition at line 1051 of file mitc4.C.
References OOFEM_ERROR.
|
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 101 of file mitc4.h.
References _IFT_MITC4Shell_Name.
|
inlineoverridevirtual |
Returns integration domain for receiver, used to initialize integration point over receiver volume. Default behavior is taken from the default interpolation.
Reimplemented from oofem::Element.
Definition at line 102 of file mitc4.h.
References oofem::_3dDegShell.
|
overridevirtual |
Interface requesting service.
Reimplemented from oofem::FEMComponent.
Definition at line 98 of file mitc4.C.
References oofem::NodalAveragingRecoveryModelInterface::NodalAveragingRecoveryModelInterface(), oofem::NodalAveragingRecoveryModelInterfaceType, oofem::SpatialLocalizerInterface::SpatialLocalizerInterface(), oofem::SpatialLocalizerInterfaceType, oofem::SPRNodalRecoveryModelInterface::SPRNodalRecoveryModelInterface(), oofem::SPRNodalRecoveryModelInterfaceType, oofem::ZZNodalRecoveryModelInterface::ZZNodalRecoveryModelInterface(), and oofem::ZZNodalRecoveryModelInterfaceType.
|
overridevirtual |
Returns equivalent nodal forces vectors. Useful for nonlinear analysis. Default implementation computes result as \( F=\int_v B^{\mathrm{T}} \sigma \mathrm{d}V \), where \( \sigma \) is the real element stress vector obtained using computeStressVector service (if useUpdatedGpRecord=0) or (if useUpdatedGpRecord=1) from integration point status. The geometric matrix is obtained using computeBmatrixAt service. Integration is performed using default integration rule, which should produce always valid results, assuming that strains used for computation of stresses are valid.
| answer | Internal nodal forces vector. |
| tStep | Time step. |
| useUpdatedGpRecord | If equal to zero, the stresses in integration points are computed (slow but safe), else if nonzero the stresses are taken directly from integration point status (should be derived from StructuralMaterialStatus) (fast, but engineering model must ensure valid status data in each integration point). |
Reimplemented from oofem::StructuralElement.
Definition at line 423 of file mitc4.C.
References oofem::FloatArray::add(), oofem::FloatArray::assemble(), oofem::FloatMatrix::at(), oofem::FloatArray::beProductOf(), oofem::FloatArray::beSubArrayOf(), oofem::Element::computeVectorOf(), computeVolumeAround(), oofem::CS_DrillingStiffness, oofem::CS_DrillingType, oofem::FloatArray::dotProduct(), drillCoeff, oofem::CrossSection::give(), oofem::Element::giveDefaultIntegrationRulePtr(), oofem::StructuralElement::giveInternalForcesVector(), oofem::StructuralElement::giveStructuralCrossSection(), oofem::Element::integrationRulesArray, interp_lin, oofem::FloatMatrix::resize(), and oofem::FloatMatrix::zero().
|
overridevirtual |
Reimplemented from oofem::Element.
Definition at line 87 of file mitc4.C.
References interp_lin.
Referenced by computeEdgeNMatrix(), and computeSurfaceNMatrix().
|
overridevirtual |
Returns the interpolation for the specific dof id. Special elements which uses a mixed interpolation should reimplement this method.
| id | ID of the dof for the for the requested interpolation. |
Reimplemented from oofem::Element.
Definition at line 91 of file mitc4.C.
References interp_lin.
|
overrideprivatevirtual |
Returns the integration point corresponding value in full form.
| answer | Contain corresponding integration point value, zero sized if not available. |
| gp | Integration point to check. |
| type | Determines the type of internal variable. |
| tStep | Time step. |
Reimplemented from oofem::Element.
Definition at line 899 of file mitc4.C.
References giveCharacteristicTensor(), oofem::StructuralElement::giveIPValue(), giveMidplaneIPValue(), oofem::GaussPoint::giveNumber(), oofem::GlobalForceTensor, oofem::GlobalStrainTensor, oofem::to_voigt_strain_33(), and oofem::to_voigt_stress_33().
Referenced by drawScalar(), giveMidplaneIPValue(), NodalAveragingRecoveryMI_computeNodalValue(), and printOutputAt().
|
private |
Definition at line 319 of file mitc4.C.
References oofem::FloatArrayF< N >::at(), oofem::FloatMatrixF< N, M >::at(), giveLocalDirectorVectors(), giveNodeCoordinates(), giveThickness(), and interp_lin.
Referenced by computeBmatrixAt(), computeVolumeAround(), and givedNdx().
|
private |
Definition at line 279 of file mitc4.C.
References oofem::dot(), oofem::Element::giveNode(), and GtoLRotationMatrix.
Referenced by computeLocalCoordinates(), and giveNodeCoordinates().
|
private |
Definition at line 219 of file mitc4.C.
References oofem::dot(), giveDirectorVectors(), and GtoLRotationMatrix.
Referenced by computeBmatrixAt(), computeNmatrixAt(), and giveJacobian().
|
inlineoverridevirtual |
Returns material mode for receiver integration points. Should be specialized.
Reimplemented from oofem::Element.
Definition at line 103 of file mitc4.h.
Referenced by giveMidplaneIPValue().
|
private |
Definition at line 817 of file mitc4.C.
References oofem::FloatArray::at(), oofem::FloatArrayF< N >::at(), oofem::StructuralElement::computeStrainVector(), computeStressVector(), oofem::Element::computeVectorOf(), oofem::CS_Thickness, oofem::dot(), oofem::CrossSection::give(), oofem::Element::giveCrossSection(), givedNdx(), giveIPValue(), giveMaterialMode(), GtoLRotationMatrix, oofem::Element::integrationRulesArray, nPointsZ, oofem::StructuralMaterial::transformStrainVectorTo(), and oofem::StructuralMaterial::transformStressVectorTo().
Referenced by giveIPValue(), and printOutputAt().
|
private |
Definition at line 269 of file mitc4.C.
References giveLocalCoordinates(), and oofem::Element::giveNode().
Referenced by computeBmatrixAt(), computeEdgeVolumeAround(), computeSurfaceVolumeAround(), and giveJacobian().
|
overrideprivatevirtual |
Reimplemented from oofem::StructuralElement.
Definition at line 1144 of file mitc4.C.
References oofem::IntArray::enumerate(), and OOFEM_ERROR.
|
private |
Definition at line 624 of file mitc4.C.
References oofem::CS_Thickness, oofem::CrossSection::give(), oofem::DofManager::giveCoordinates(), oofem::Element::giveCrossSection(), and oofem::Element::giveNode().
Referenced by computeBmatrixAt(), computeNmatrixAt(), and giveJacobian().
|
overridevirtual |
Reimplemented from oofem::Element.
Definition at line 286 of file mitc4.C.
References directorType, oofem::Domain::elementPPM, oofem::FEMComponent::giveDomain(), oofem::Element::initializeFrom(), oofem::Element::IPK_Element_nip, IPK_MITC4Shell_directorType, IPK_MITC4Shell_nipZ, nPointsXY, nPointsZ, oofem::FEMComponent::number, and PM_UPDATE_PARAMETER.
|
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 979 of file mitc4.C.
References oofem::FloatArray::at(), oofem::FloatMatrixF< N, M >::at(), oofem::dot(), giveIPValue(), oofem::FloatArray::giveSize(), oofem::Element::integrationRulesArray, oofem::inv(), OOFEM_ERROR, and oofem::FloatArray::resize().
|
overridevirtual |
Performs post initialization steps.
Reimplemented from oofem::Element.
Definition at line 641 of file mitc4.C.
References computeLocalBaseVectors(), GtoLRotationMatrix, and oofem::Element::postInitialize().
|
overrideprivatevirtual |
Prints output of receiver to stream, for given time step. This is used for output into the standard output file.
| file | File pointer to print to. |
| tStep | Time step to write for. |
Reimplemented from oofem::Element.
Definition at line 767 of file mitc4.C.
References giveIPValue(), oofem::Element::giveLabel(), giveMidplaneIPValue(), oofem::Element::integrationRulesArray, nPointsXY, nPointsZ, and oofem::FEMComponent::number.
|
overrideprivatevirtual |
Setup Integration Rule Gauss Points for Mass Matrix integration
Reimplemented from oofem::StructuralElement.
Definition at line 893 of file mitc4.C.
References oofem::Element::giveCrossSection(), nPointsXY, nPointsZ, and oofem::CrossSection::setupIntegrationPoints().
|
overridevirtual |
Implements oofem::SPRNodalRecoveryModelInterface.
Definition at line 125 of file mitc4.C.
References oofem::IntArray::at(), oofem::Element::giveNode(), oofem::FEMComponent::giveNumber(), oofem::Element::numberOfDofMans, OOFEM_ERROR, and oofem::IntArray::resize().
|
overridevirtual |
Implements oofem::SPRNodalRecoveryModelInterface.
Definition at line 145 of file mitc4.C.
References oofem::Element::giveDefaultIntegrationRulePtr(), and oofem::IntegrationRule::giveNumberOfIntegrationPoints().
|
overridevirtual |
Implements oofem::SPRNodalRecoveryModelInterface.
Definition at line 152 of file mitc4.C.
References oofem::SPRPatchType_3dBiLin.
|
overridevirtual |
Implements oofem::SPRNodalRecoveryModelInterface.
Definition at line 115 of file mitc4.C.
References oofem::IntArray::at(), oofem::Element::giveNode(), oofem::FEMComponent::giveNumber(), oofem::Element::numberOfDofMans, 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 96 of file mitc4.h.
References oofem::Element_EdgeLoadSupport, and oofem::Element_SurfaceLoadSupport.
|
protected |
Definition at line 85 of file mitc4.h.
Referenced by giveDirectorVectors(), initializeFrom(), and MITC4Shell().
|
protected |
Definition at line 86 of file mitc4.h.
Referenced by computeStiffnessMatrix(), and giveInternalForcesVector().
|
protected |
Transformation Matrix form GtoL(3,3) is stored at the element level for computation efficiency.
Definition at line 84 of file mitc4.h.
Referenced by computeGtoLRotationMatrix(), computeLoadGToLRotationMtrx(), giveCharacteristicTensor(), giveLocalCoordinates(), giveLocalDirectorVectors(), giveMidplaneIPValue(), and postInitialize().
|
staticprotected |
Element geometry approximation.
Definition at line 79 of file mitc4.h.
Referenced by computeEdgeVolumeAround(), computeLoadLEToLRotationMatrix(), computeLocalCoordinates(), computeNmatrixAt(), computeStiffnessMatrix(), computeSurfaceVolumeAround(), givedNdx(), giveInternalForcesVector(), giveInterpolation(), giveInterpolation(), and giveJacobian().
|
staticprotected |
Definition at line 89 of file mitc4.h.
Referenced by initializeFrom().
|
staticprotected |
Definition at line 88 of file mitc4.h.
Referenced by initializeFrom().
|
protected |
Definition at line 85 of file mitc4.h.
Referenced by computeGaussPoints(), initializeFrom(), MITC4Shell(), printOutputAt(), and setupIRForMassMtrxIntegration().
|
protected |
Definition at line 85 of file mitc4.h.
Referenced by computeGaussPoints(), giveMidplaneIPValue(), initializeFrom(), MITC4Shell(), printOutputAt(), and setupIRForMassMtrxIntegration().