80 double l, x1, x2, z1, z2;
92 answer.
at(1, 1) = x1 - x2;
93 answer.
at(1, 2) = z1 - z2;
94 answer.
at(1, 3) = x2 - x1;
95 answer.
at(1, 4) = z2 - z1;
98 answer.
times(1.0 / l / l);
136 answer.
at(1, 1) = halfMass;
137 answer.
at(2, 2) = halfMass;
138 answer.
at(3, 3) = halfMass;
139 answer.
at(4, 4) = halfMass;
150 ksi = iLocCoord.
at(1);
151 n1 = ( 1. - ksi ) * 0.5;
152 n2 = ( 1. + ksi ) * 0.5;
156 answer.
at(1, 1) = n1;
157 answer.
at(1, 3) = n2;
158 answer.
at(2, 2) = n1;
159 answer.
at(2, 4) = n2;
173 n1 = ( 1. - ksi ) * 0.5;
174 n2 = ( 1. + ksi ) * 0.5;
209 length = sqrt(dx * dx + dz * dz);
219 double xA, xB, zA, zB;
225 if (
pitch == 10. ) {
232 pitch = atan2(zB - zA, xB - xA);
254 answer.
at(1, 1) = cosine;
255 answer.
at(1, 2) = sine;
256 answer.
at(2, 1) = -sine;
257 answer.
at(2, 2) = cosine;
258 answer.
at(3, 3) = 1.0;
378 answer.
at(1, 1) = cosine;
379 answer.
at(1, 2) = -sine;
380 answer.
at(2, 1) = sine;
381 answer.
at(2, 2) = cosine;
433 go = CreateLine3D(p);
434 EGWithMaskChangeAttributes(WIDTH_MASK | COLOR_MASK | LAYER_MASK, go);
435 EGAttachObject(go, ( EObjectP )
this);
436 EMAddGraphicsToModel(ESIModel(), go);
465 go = CreateLine3D(p);
466 EGWithMaskChangeAttributes(WIDTH_MASK | COLOR_MASK | LAYER_MASK, go);
467 EMAddGraphicsToModel(ESIModel(), go);
CrossSection * giveCrossSection()
int testElementGraphicActivity(Element *)
Test if particular element passed fulfills various filtering criteria for its graphics output...
virtual bool isActivated(TimeStep *tStep)
Truss2d(int n, Domain *d)
virtual FEInterpolation * giveInterpolation() const
Abstract base class for "structural" finite elements with geometrical nonlinearities.
virtual void computeBmatrixAt(GaussPoint *gp, FloatMatrix &, int=1, int=ALL_STRAINS)
Computes the geometrical matrix of receiver in given integration point.
virtual void computeConstitutiveMatrixAt(FloatMatrix &answer, MatResponseMode rMode, GaussPoint *gp, TimeStep *tStep)
Computes constitutive matrix of receiver.
double & at(int i)
Coefficient access function.
#define OOFEG_RAW_GEOMETRY_LAYER
oofem::oofegGraphicContext gc[OOFEG_LAST_LAYER]
virtual IRResultType initializeFrom(InputRecord *ir)
Initializes receiver according to object description stored in input record.
virtual int computeLoadLEToLRotationMatrix(FloatMatrix &, int, GaussPoint *gp)
Returns transformation matrix from local edge c.s to element local coordinate system of load vector c...
void resolveCoordIndices(int &c1, int &c2)
virtual double computeEdgeVolumeAround(GaussPoint *gp, int)
Computes volume related to integration point on local edge.
virtual double giveCoordinate(int i)
Class implementing an array of integers.
int & at(int i)
Coefficient access function.
MatResponseMode
Describes the character of characteristic material matrix.
#define OOFEG_DEFORMED_GEOMETRY_LAYER
static FEI2dLineLin interp[3]
EPixel getDeformedElementColor()
Class representing a general abstraction for finite element interpolation class.
virtual double computeLength()
Computes the length (zero for all but 1D geometries)
virtual void drawRawGeometry(oofegGraphicContext &gc, TimeStep *tStep)
#define OOFEG_RAW_GEOMETRY_WIDTH
virtual double giveWeight()
Returns integration weight of receiver.
UnknownType
Type representing particular unknown (its physical meaning).
StructuralCrossSection * giveStructuralCrossSection()
Helper function which returns the structural cross-section for the element.
void times(double f)
Multiplies receiver by factor f.
virtual void computeBHmatrixAt(GaussPoint *gp, FloatMatrix &)
Computes a matrix which, multiplied by the column matrix of nodal displacements, gives the displaceme...
virtual double giveUpdatedCoordinate(int ic, TimeStep *tStep, double scale=1.)
Returns updated ic-th coordinate of receiver.
double at(int i, int j) const
Coefficient access function.
void resize(int n)
Checks size of receiver towards requested bounds.
virtual void giveEdgeDofMapping(IntArray &answer, int) const
Assembles edge dof mapping mask, which provides mapping between edge local DOFs and "global" element ...
virtual int setupIntegrationPoints(IntegrationRule &irule, int npoints, Element *element)
Sets up integration rule for the given element.
virtual void computeGaussPoints()
Initializes the array of integration rules member variable.
Class representing vector of real numbers.
Implementation of matrix containing floating point numbers.
IRResultType
Type defining the return values of InputRecord reading operations.
virtual double give(CrossSectionProperty a, GaussPoint *gp)
Returns the value of cross section property at given point.
void resize(int rows, int cols)
Checks size of receiver towards requested bounds.
virtual void giveRealStress_1d(FloatArray &answer, GaussPoint *gp, const FloatArray &reducedStrain, TimeStep *tStep)=0
void zero()
Zeroes all coefficients of receiver.
virtual double computeVolumeAround(GaussPoint *gp)
Returns volume related to given integration point.
#define OOFEG_DEFORMED_GEOMETRY_WIDTH
std::vector< std::unique_ptr< IntegrationRule > > integrationRulesArray
List of integration rules of receiver (each integration rule contains associated integration points a...
virtual IRResultType initializeFrom(InputRecord *ir)
Initializes receiver according to object description stored in input record.
virtual int computeGlobalCoordinates(FloatArray &answer, const FloatArray &lcoords)
Computes the global coordinates from given element's local coordinates.
void zero()
Zeroes all coefficient of receiver.
virtual void giveStiffnessMatrix_1d(FloatMatrix &answer, MatResponseMode mode, GaussPoint *gp, TimeStep *tStep)=0
virtual void giveDofManDofIDMask(int inode, IntArray &answer) const
Returns dofmanager dof mask for node.
the oofem namespace is to define a context or scope in which all oofem names are defined.
virtual void drawDeformedGeometry(oofegGraphicContext &gc, TimeStep *tStep, UnknownType)
Class implementing node in finite element mesh.
Node * giveNode(int i) const
Returns reference to the i-th node of element.
virtual void computeStressVector(FloatArray &answer, const FloatArray &strain, GaussPoint *gp, TimeStep *tStep)
Computes the stress vector of receiver at given integration point, at time step tStep.
Class representing integration point in finite element program.
#define OOFEM_WARNING(...)
virtual void computeNmatrixAt(const FloatArray &iLocCoord, FloatMatrix &)
Computes interpolation matrix for element unknowns.
Class representing solution step.
virtual void computeLumpedMassMatrix(FloatMatrix &answer, TimeStep *tStep)
Computes lumped mass matrix of receiver.
int numberOfDofMans
Number of dofmanagers.
Class representing Gaussian-quadrature integration rule.
void resize(int s)
Resizes receiver towards requested size.
virtual int giveLocalCoordinateSystem(FloatMatrix &answer)
Returns local coordinate system of receiver Required by material models with ortho- and anisotrophy...