CivilFEM Theory Manual
CivilFEM Theory Manual
Chapter 3 Solution.................................................................................................................... 19
5.5. Out-of-Plane Shear Load according to EC2 and ITER .......................................... 109
5.10.4. In-Plane Shear Checking for Slabs (Seismic Loads) .......................... 153
5.10.5. In-Plane Shear Design for Slabs (Seismic Loads) .............................. 154
5.12. Cracking Checking according to ACI 318-05 and ACI 318-14 .............................. 160
6.5. Axial Force and Biaxial Bending Calculation Codes ............................................. 179
6.6.7. Shear and Torsion according to ACI 349-01 and ACI349-06 ............ 262
7.1.11. Checking of Members under Bending Moment and Shear Force .... 408
7.1.12. Checking of Members under Bending Moment and Axial Force .... 410
7.1.13. Checking of Members under Bending, Shear and Axial Force ......... 415
7.2. Steel Structures According to AISC ASD/LRFD 13th Ed. ....................................... 433
7.3.8 Checking of Bending Moment and Shear Force (BS Article 4.2) ...... 472
7.3.9 Checking of Lateral Torsional Buckling Resistance (BS Article 4.3) .. 477
7.3.11 Checking of Members in Axial Compression (BS Article 4.7) ........... 485
7.3.12 Tension Members with Moments (BS Article 4.8.2) ........................ 487
7.3.13 Compression Members with Moments (BS Article 4.8.3) ................ 491
7.4. Steel Structures According to ASME BPVC III Sub. NF ......................................... 497
7.6.9 Checking of Members under Bending Moment and Shear Force .... 551
7.6.10 Checking of Members under Bending Moment + Axial Force and Bi-
axial Bending + Axial Force ............................................................... 553
The Theory Manual provides the theoretical basis of the algorithms included in the program.
With knowledge of the underlying theory, the user can perform analyses efficiently and
confidently on CivilFEM by using the capabilities to their full potential while being aware of
the limitations.
Reading the whole manual will not be necessary; it is recommended to read only the
paragraphs containing the specific algorithms being utilized.
1.1.1. References
MSC. Software Help Documentation
2.1. Introduction
Linear finite element analysis is characterized by a force-displacement relationship that only
contains linear terms. Linear system of equations always produces a unique solution while
in nonlinear analysis does not guarantee a unique solution. In fact, there may be multiple
solutions or no solution at all. The task of providing analysis directives (i.e. controls by which
the program will come to a solution) is far from simple. Solving nonlinear equations is an
incremental and iterative process.
A linear static structural analysis with a known external load can be performed in one step. If
nonlinearities are expected, it may be necessary to apply the load in increments and let each
load increment iterate to the equilibrium state, within a specified tolerance, using a
particular iteration scheme such as Newton-Raphson.
In this CivilFEM Theory Manual version only linear static loads are considered. In the figure
below there is an example of loading workflow covering all that civil engineering needs.
LOADS
Load group B:
- Punctual moment B Load case 1
- Linear load B
α·(Load group A) + γ·(Accelera on -Z) + B.C. group 1
- ...
Accelera on -Z
Load case 2
β·(Load group B) + δ·(Spectral X) + B.C. group 2
Spectral X
The word loads in CivilFEM terminology includes load groups, accelerations, spectra and
boundary conditions.
Chapter 3
Solution
Nonlinearities due to material, geometry, or boundary conditions are not included in this
type of analysis. The behavior of an isotropic, linear, elastic material can be defined by two
material constants: Young’s modulus, and Poisson’s ratio.
CivilFEM allows user to perform linear elastic analysis using any element type in the
program. Various kinematic constraints and loadings can be prescribed to the structure
being analyzed; the problem can include both isotropic and anisotropic elastic materials.
Linear analysis does not require storing as many quantities as does nonlinear analysis;
therefore, it uses the core memory more sparingly.
The force displacement relation for a linear static problem can be expressed as:
Ku = f
Where is the system stiffness matrix, is the nodal displacement, and is the force vector.
Assuming that the structure has prescribed boundary conditions both in displacements and
forces, the governing equation can be written as:
K K u1 f
[ 11 12 ] {u } = { 1 }
K 21 k 22 2 f2
u1 is the unknown displacement vector, f1 is the prescribed force vector,u2 is the prescribed
displacement vector, and f2 is the reaction force. After solving for the displacement vector,
the strains in each element can be calculated from the strain-displacement relation in terms
of element nodal displacement as:
εel = βuel
The stresses in the element are obtained from the stress-strain relations as:
σel = Lεel
Where 𝜎𝑒𝑙 and εel are stresses and strains in the elements, and uel is the displacement
vector associated with the element nodal points; 𝛽 and L are strain-displacement and stress-
strain relations, respectively.
In a dynamic problem, the effects of mass and damping must be included in the system. The
equation governing a linear dynamic system is:
Mü + Du̇ + Ku = f
Where M is the system mass matrix, D is the damping matrix, following equation is the
acceleration vector, and is the velocity vector. The equation governing an undamped
dynamic system is:
Mü + Ku = f
Mü + Ku = 0
Natural frequencies and modal shapes of the structural system are calculated using this
equation.
K∅ − ω2 M∅ = 0
1. Modal analysis.
2. Harmonic analysis.
3. Spectrum analysis.
4. Transient analysis.
Damping and nonlinear effects, including material nonlinearity, and boundary nonlinearity,
can be incorporated. All nonlinear problems should be analyzed using direct integration
methods.
(K − ω2 M)∅ = 0
Where K is the stiffness matrix, M is the mass matrix, 𝜔 are the eigenvalues (frecuencies)
and ∅ are the eigenvectors. In CivilFEM, if the extraction is performed after increment zero,
K is the tangent stiffness matrix, which can include material and geometrically nonlinear
contributions. The mass matrix is formed from both distributed mass and point masses.
The Lanczos algorithm converts the original eigenvalue problem into the determination of
the eigenvalues of a tri-diagonal matrix. The method can be used either for the
determination of all modes or for the calculation of a small number of modes. For the latter
case, the Lanczos method is the most efficient eigenvalue extraction algorithm. A simple
description of the algorithm is as follows. Consider the eigenvalue problem:
−ω2 M u + K u = 0
1
M u = M K −1 M u
ω2
Consider the transformation:
u=Qη
Substituting last equation into previous one and premultiplying by the matrix QT on both
sides of the equation, we have:
1 T
Q M Q η = QT M K −1 M Q η
ω2
The Lanczos algorithm results in a transformation matrix Q such that:
QT M Q = I
QT M K −1 MQ = T
α1 β2 0
β2 α2 β3
T=[ ]
βm
0 βm αm
Consequently, the original eigenvalue problem is reduced to the following new eigenvalue
problem:
1
η=Tη
ω2
The eigenvalues can be calculated by the standard QL-method.
Within CivilFEM it can be selected either the number of modes to be extracted, or a range of
modes to be extracted. The Sturm sequence check can be used to verify that all of the
required eigenvalues have been found.
In addition, user can select the lowest frequency to be extracted to be greater than zero.
Eigenvalue extraction is controlled by the maximum number of iterations for all modes in
the Lanczos iteration method in convergence controls.
The stresses are computed from the modal displacement vector φ ; the nodal reactions are
calculated from:
𝐹 = 𝐾𝜙 − 𝜔2 𝑀𝜙
𝑇 𝑇
𝑐𝑛𝑗 = ({Φ𝑛,𝑖 } [𝑀]{𝑇𝑖,𝑗 }) / (({Φ𝑛,𝑖 } [𝑀]) {Φ𝑛,𝑖 })
Where:
freedom i to impose rigid body motion in the jth direction and takes
1 0 0 0 (𝑍 − 𝑍0 ) −(𝑌 − 𝑌0 )
0 1 0 −(𝑍 − 𝑍0 ) 0 (𝑋 − 𝑋0 )
0 0 1 (𝑌 − 𝑌0 ) −(𝑋 − 𝑋0 ) 0 {𝑒𝑗 }
0 0 0 1 0 0
0 0 0 0 1 0
(0 0 0 0 0 1 )
Where:
𝑒𝑗 is the unit vector (carrying 1 for row j and the rest being zeros)
The effective modal masses are calculated as squares of the participation factors.
𝑒𝑓𝑓 2
𝑚𝑛,𝑗 = [𝑐𝑛,𝑗 ]
𝑒𝑓𝑓
Where 𝑚𝑛,𝑗 is the effective modal mass for mode n in the jth direction.
While the nodal vector of modal masses gives the significance of mass participation of the
node for the given mode in the given direction, the effective modal mass gives an idea about
the mass contribution of the whole structure (or model) for the mode in the given direction.
• Initial stress.
• Change of geometry.
• Influence on constitutive law.
The vibration problem can be solved as a linear problem using complex arithmetic.
1. CivilFEM calculates the response of the structure to a static preload (which can be
nonlinear) based on the constitutive equation for the material response. In this
portion of the analysis, the program ignores inertial effects.
3. You can apply different loads with different frequencies or change the static preload
at your discretion. All data relevant to the static response is stored during calculation
of the complex response.
̅
[K + iωD − ω2 M]u̅ = P
̅
P = Pre + iPim is the complex load vector,
i = √−1 ,
K= ∑ K el + ∑ K sp
Where:
M = ∑ Mel + ∑ Mmp
Where:
2γ
D = ∑ Del + ∑ Dd + ∑ (αM + (β + ) K)
ω
Where:
If all external loads and forced displacements are in phase and the system is undamped, this
equation reduces to:
(K − ω2 M)ure = Pre
The element damping matrix (Del ) can be obtained for any material with the use of a
material damping matrix which allows the user to input a real (elastic) and imaginary
σ = Bε + Cε̇
The global damping matrix is formed by the integrated triple product. The following
equation is used:
D = ∑ ∫ βT CdVel
el
The output of CivilFEM consists of stresses, strains, displacements and reaction forces, all of
which may be complex quantities. The strains are given by
ε̅ = β u̅
σ = Bε̅ + Cε̅̇
The printout of the nodal values consists of the real and imaginary parts of the complex
values, but you can request that the amplitude and phase angle be printed.
A harmonic analysis, by definition, assumes that any applied load varies harmonically
(sinusoidally) with time. To completely specify a harmonic load, three pieces of information
are usually required: the amplitude, the phase angle, and the forcing frequency range.
𝐹
𝛷 = 𝑡𝑎𝑛−1 ( 𝑖𝑚𝑎𝑔⁄𝐹 )
𝑟𝑒𝑎𝑙
The phase angle is a measure of the time by which the load lags (or leads) a frame of
reference. On the complex, it is the angle measured from the real axis. The phase angle is
required only if you have multiple loads that are out of phase with each other.
If linear:
𝑛 = (𝜔𝐻𝐼𝐺𝐻 − 𝜔𝐿𝑂𝑊 )/(Δ𝜔)
(𝜔𝐻𝐼𝐺𝐻 − 𝜔𝐿𝑂𝑊 )
Δ𝜔i = entered value of −1
𝑛
If logarithmic increments in frequency:
Δ𝜔i = fac ∗∗ (𝑖 − 1)
Enter the displacement response spectrum SD (ω) for a particular digitized value of damping
through the RESPONSE SPECTRUM model definition. CivilFEM performs the spectrum
analysis based on the latest set of modes extracted. The program lumps the mass matrix to
produce M ̅ . It hen obtains the projection of the inertia forces onto the mode ∅j
̅ ∅j
Pj = M
αj = SD (ωj )Pj
CivilFEM then calculates the square roots of the sum of the squares as
2 1⁄2
u = [∑j(αj ∅j ) ] DISPLACEMENT
2 1⁄2
v = [∑j(αj ωj ∅j ) ] VELOCITY
2 1⁄2
a = [∑𝑗(𝛼𝑗 𝜔𝑗2 ∅𝑗 ) ] ACCELERATION
2 1⁄2
̅ ∅j ) ]
f = [∑j(αj ω2j M FORCE
The internal forces given by Force equation are identified as reaction forces on the post file.
The force transmitted by the structure to the supporting medium (also referred to as base
shear) is only reported in the out file and is given by
The following sections discuss the seven aspects of transient analysis listed below.
1. Direct Integration
2. Time Step Definition
3. Initial Conditions
4. Time-Dependent Boundary Conditions
5. Mass Matrix
6. Damping
a) Newmark-beta Operator
b) Generalized-Alpha Operator
Ma + Cv + Ku = F
where M, C, and K are mass, damping, and stiffness matrices, respectively, and a, v, u, and F
are acceleration, velocity, displacement, and force vectors. Various direct integration
operators can be used to integrate the equations of motion to obtain the dynamic response
of the structural system. The technical background of the two direct integration operators
available in CivilFEM is described below.
where superscriptn denotes a value at the nth time step and u, v, and a take on their usual
meanings.
The particular form of the dynamic equations corresponding to the trapezoidal rule
Υ = 1⁄2, β = 1⁄4
results in
4 2 4
( 2 M + C + K) ∆u = F n+1 − Rn + M (an + v n ) + Cv n
∆t ∆t ∆t
R = ∫ βT σdv
v
un+1 = un + ∆u
Notice that the operator matrix includes K, the tangent stiffness matrix, Hence, any
nonlinearity results in a reformulation of the operator matrix. Additionally, if the time step
changes, this matrix must be recalculated because the operator matrix also depends on the
time step. It is possible to change the values of 𝛾 and 𝛽 through the global solution controls.
The equilibrium equations for the generalized alpha method can be expressed in the form
n+1+αm n+1+αf n+1+αf
Ma + Cv + Ku = F n+1αf
where
un+1+αf = (1 + αf )un+1 − αf un
v n+1+αf = (1 + αf )v n+1 − αf v n
an+1+αm = (1 + αm )an+1 − αm an
The displacement and velocity updates are identical to those of the Newmark algorithm
1
β= (1 + αm − αf )2
4
1
𝛾= + αm − αf
2
It is seen that the 𝛼𝑓 and 𝛼𝑚 parameters can be used to control the numerical dissipation of
the operator. A simpler measure is the spectral radius ρ. This is also a measure of the
numerical dissipation; a smaller spectral radius value corresponds to greater numerical
1 + 2ρ
αm = −
1+ρ
ρ varies between 0 and 1. Accordingly, the ranges for the αf and αm parameters are given by
It can also be noted that the case of ρ = 1 has no dissipation and corresponds to a mid-
increment Newmark-beta operator.
Enter parameters to specify the time step size and period of time for this set of boundary
conditions.
When using the Newmark-beta operator, decide which frequencies are important to the
response. The time step in this method should not exceed 10 percent of the period of the
highest relevant frequency in the structure. Otherwise, large phase errors will occur. The
phenomenon usually associated with too large a time step is strong oscillatory accelerations.
With even larger time steps, the velocities start oscillating. With still larger steps, the
displacement eventually oscillates. In nonlinear problems, instability usually follows
oscillation. When using adaptive dynamics, you should prescribe a maximum time step.
As in the Newmark-beta operator, the time step in Houbolt integration should not exceed 10
percent of the period of the highest frequency of interest. However, the Houbolt method
not only causes phase errors, it also causes strong artificial damping. Therefore, high
frequencies are damped out quickly and no obvious oscillations occur. It is, therefore,
completely up to the engineer to determine whether the time step was adequate.
For the Generalized-alpha operator, depending on the chosen parameters, the integration
scheme can vary between the Newmark-beta operator and the Single-step houbolt
operator. For spectral radii < 1, there is artificial damping in the system. Depending on the
type of problem, the Generalized-alpha parameters and the associated time step should be
carefully chosen to reduce phase errors and effects of artificial damping.
A nonlinear problem does not always have a unique solution. Sometimes a nonlinear
problem does not have any solution, although the problem can seem to be defined correctly.
Nonlinear analysis requires good judgment and uses considerable computing time. Several
runs are often required. The first run should extract the maximum information with the
minimum amount of computing time. Some design considerations for a preliminary analysis
are:
CivilFEM solves nonlinear static problems according to one of the following two methods:
tangent modulus or initial strain. Examples of the tangent modulus method are elastic-
plastic analysis, nonlinear springs, nonlinear foundations, large displacement analysis and
gaps. This method requires at least the following three controls:
A tolerance on convergence.
A limit to the maximum allowable number of iterations.
Specification of a minimum number of iterations.
When a fixed step fraction scheme is used, it is important to select an appropriate step
fraction size that captures the loading history and allows for convergence within a
reasonable number of recycles. For complex load histories, it is necessary to prescribe the
loading through time tables while setting up the run.
For fixed stepping, there is an option to have the load step automatically cut back in case of
failure to obtain convergence. When an increment diverges, the intermediate deformations
after each iteration can show large fluctuations and the final cause of program exit can be
any of the following: maximum number of iterations reached, elements going inside out or,
in a contact analysis and nodes sliding off a rigid contact body. If the cutback feature is
activated and one of these problems occur, the state of the analysis at the end of the
previous increment is restored and the increment is subdivided into a number of
subincrements. The step size is halved until convergence is obtained or the user-specified
number of cutbacks has been performed. Once a subincrement is converged, the analysis
continues to complete the remainder of the original increment. No results are written to the
post file during subincrementation. When the original increment is finished, the calculation
continues to the next increment with the original increment count and time step
maintained.
K(u)δu = F − R(u)
𝑅 = ∑ ∫ βT σdv
Elem v
𝐾(ui−1 i−1
n+1 )δu = F − R(un+1 )
This equation is solved for 𝛿𝑢𝑖 and the next appropriate solution is obtained by
Solution of this equation completes one iteration, and the process can be repeated. The
subscript n denotes the increment number representing the state t = n. Unless stated
otherwise, the subscript n+1 is dropped with al quantities referring to the current state.
The Newton-Raphson method provides good results for most nonlinear problems, but is
expensive for large, three-dimensional problems, when the direct solver is used. The
computational problem is less significant when the iterative solvers are used. Figure above
illustrates the graphical interpretation of the Newton-Raphson iteration technique in one
dimension to find the roots of the function 𝐹(u) − 1 = √u − 1 = 0 starting from
increment 1 where 𝐹(u0 ) = 0.2 to increment 2 where 𝐹(ulast ) = 1.0.
The iteration process stops when the convergence criteria are satisfied.
Mechanical loads, as shown above, are applied in a proportional manner and thermal loads
are applied instantaneously.
This means that any automatic load incrementation method is limited to mechanical input
histories that only have linear variations in load or displacement and thermal input histories
that have immediate change in temperature. For example, one may not use a rigid body with
a linearly changing velocity, since the resulting displacement of the rigid body would give
parabolically changing displacements. In this case, one would need to use a constant velocity
for the arc length method to work properly.
For the arc length method, care must be taken to appropriately define the loading history in
each loadcase. The load case should be defined between appropriate break points in the
load history curve. For example, in figure above, correct results would be obtained upon
defining three distinct loadcases between times 0-t1, t1-t2, and t2-t3 during the model
preparation. However, if only one load case is defined for the entire load history between
0-t3, the total applied load for the loadcase is zero.
The solution methods described above involve an iterative process to achieve equilibrium
for a fixed increment of load. Besides, none of them have the ability to deal with problems
The issue at hand is the existence of multiple displacement vectors, u , for a given applied
force vector, F . The arc-length methods provide the means to ensure that the correct
displacement vector is found by CivilFEM. If you have a load controlled problem, the solution
tends to jump from point 2 to 6 whenever the load increment after 2 is applied. If you have a
displacement controlled problem, the solution tends to jump from 3 to 5 whenever the
displacement increment after 3 is applied. Note that these problems appear essentially in
quasi-static analyses. In dynamic analyses, the inertia forces help determine equilibrium in a
snap-through problem.
λn+1 F − λn F = ∆λF
This is illustrated in previous figure where both the phenomenon of snap-through (going
from point 2 to 3) and snap-back (going from point 3 to 4) require a solution procedure
which can handle these problems without going back along the same equilibrium curve.
To achieve this end, the equilibrium equations are augmented with a constraint equation
expressed typically as the norm of incremental displacements. Hence, this allows the load
level to change from iteration to iteration until equilibrium is found.
‖Fresidual ‖∞
< TOL1
‖Freaction ‖∞
Where F is the force vector, and M is the moment vector, TOL1 and TOL2 are control
tolerances. ‖𝐹‖∞ indicates the component of F with the highest absolute value.
‖δu‖∞
< TOL1
‖∆u‖∞
‖δu‖∞ ‖δ∅‖∞
< TOL1 and < TOL2
‖∆u‖∞ ‖∆∅‖∞
Using the activation/deactivation time capability allows the manual deactivation of elements
during the course of an analysis, which can be useful to model ablation, excavation and
other problems. By default, after the elements are deactivated, they demonstrate zero
stresses and strains on the post file. However, internally, they retain the stress state in effect
at the time of deactivation and this state can be postprocessed or printed at any time. At the
later stage in the analysis, the elements can again be activated.
By default the activated elements will appear in their original position (will be reactivated in
their originally specified geometric configuration) unless the behaviour of the contruction
process is changed and then free motion of deactivated elements will be allowed. To achieve
this effect, the program does not actually remove deactivated elements. Instead, it
deactivates them by multiplying their stiffness by a severe reduction factor. This factor is set
to 1.0E-9 by default, but can be given other values.
Element loads associated with deactivated elements are zeroed out of the load vector, but
only if the construction process behaviour option is not checked. In this case, loading must
be set accordingly in the corresponding structural elements and timing. The mass and energy
of deactivated elements are not included in the summations over the model. An element's
strain is also set to zero as soon as that element is deactivated.
In like manner, when elements are activated they are not actually added to the model; they
are simply reactivated. User must create all elements, including those to be activated in later
stages of your analysis.
When an element is reactivated, its stiffness, mass, element loads, etc. return to their full
original values. Elements are reactivated with no record of strain history (or heat storage,
etc.); that is, a reactivated element is generally strain-free. Initial strain defined as a real
constant, however, is not be affected by birth and death operations.
Most analyses result in a system which is real, symmetric, and positive definite. While this is
true for linear structural problems, assuming adequate boundary conditions, it is not true for
all analyses.
Each iteration of the Newton-Raphson Method requires solving the system of equations.
This can be done with a Direct Solver or with an Iterative Solver.
With recent advances in solver technology, the time spent in assembly and recovery now
exceeds the time spent in the solver.
Which solution method to use depends very much on the problem. In some cases, one
method can be advantageous over another; in other cases, the converse might be true.
Whether a solution is obtainable or not with a given method, usually depends on the
character of the system of equations being solved, especially on the kind on nonlinearities
that are involved.
As an example in problems which are linear until buckling occurs, due to a sudden
development of nonlinearity, it is necessary to guide the arc-length algorithm by making sure
that the arc length remains sufficiently small prior to the occurrence of buckling.
Even if a solution is obtainable, there is always the issue of efficiency. The pros and cons of
each solution procedure, in terms of matrix operations and storage requirements have been
discussed in the previous sections. A very important variable regarding overall efficiency is
the size of the problem. The time required to assemble a stiffness matrix, as well as the time
required to recover stresses after a solution, vary roughly linearly with the number of
degrees of freedom of the problem. On the other hand, the time required to go through the
direct solver varies roughly quadratically with the bandwidth, as well as linearly with the
number of degrees of freedom.
In small problems, where the time spent in the solver is negligible, user can easily wipe out
any solver gains, or even of assembly gains, with solution procedures such as a line search
which requires a double stress recovery. Also, for problems with strong material or contact
nonlinearities, gains obtained in assembly in modified Newton-Raphson can be nullified by
increased number of iterations or nonconvergence.
Ku = F
K T ∆u = F – R = r
Where K is the elastic stiffness matrix, K T is the tangent stiffness matrix in a nonlinear
system, ∆u is the displacement vector, F is the applied load vector, and r is the residual.
𝛹(𝑢) = 1 ⁄ 2𝑢𝑇 𝐾𝑢 − 𝑢𝑇 𝐹
For linear structural problems, this process can be considered as the minimization of the
potential energy. The minimum is achieved when
𝑢 = 𝐾 −1 𝐹
The function ψ decreases most rapidly in the direction of the negative gradient,
∇𝜓(𝑢) = 𝐹 − 𝐾𝑢 = 𝑟
The objective of the iterative techniques is to minimize function, 𝜓, without inverting the
stiffness matrix. In the simplest methods,
𝑢𝑘+1 = 𝑢𝑘+ 𝛼𝑘 𝑟𝑘
Where
The problem is that the gradient directions are too close, which results in poor convergence.
𝑢𝐾+1 = 𝑢𝑘 +𝛼𝑘 𝑃𝑘
Certain problems which are ill-conditioned can lead to poor convergence. The introduction
of a preconditioner has been shown to improve convergence. The next key step is to choose
an appropriate preconditioner which is both effective as well as computationally efficient.
The easiest is to use the diagonal of the stiffness matrix. The incomplete Cholesky method
has been shown to be very effective in reducing the number of required iterations.
The solution of the linear equations may be solved using multi-processors using the
hardware provided solver, the multifrontal solver, the Pardiso solver. If a multiprocessor
machine is available, then Pardiso solver is recommended.
The types of machines supported are shared memory machines, which are single machines
with multiple processors and a memory which is shared between the processors and cluster
Only Pardiso solver supports shared memory machines and out-of-core solution in parallel
on a cluster of workstations. The main reason for running an analysis in parallel on a shared
memory machine is speed. Since all processes run on the same machine sharing the same
memory, the processes all compete for the same memory. There is an overhead in memory
usage so some parts of the analysis need more memory for a parallel run than a serial
analysis. The matrix solver, on the other hand, needs less memory in a parallel analysis. Less
memory is usually needed to store and solve several smaller systems than a single large one.
The amount of speed-up that can be achieved depends on a number of factors including the
type of analysis, the type of machine used, the size of the problem, and the performance of
communications. For instance, a shared memory machine usually has faster communication
than a cluster (for example, communicating over a standard Ethernet). On the other hand, a
shared memory machine may run slower if it is used near its memory capacity due to
memory access conflicts and cache misses etc.
The conjugate gradient iterative solver operates simultaneously on the whole model. It
works to a large extent like in a serial run. For each iteration cycle, there is a need to
synchronize the residuals from the different domains.
Then user is ready to solve the analysis, a prompt message is displayed in order to save a
backup copy of the model (a file name and directory path must be specified).
Load cases are solved independently following the sequence of specified Calculation Time
variables. Each load case one generates its corresponding results file (.RCF with the same
name as the load case).
Increments are points within a load case at which solutions are calculated. They are used for
different reasons:
In a nonlinear static or steady-state analysis, increments are used to apply the loads
gradually so that an accurate solution can be obtained.
In a linear or nonlinear transient analysis, increments are used to satisfy transient
time integration rules (which usually dictate a minimum integration time step for an
accurate solution).
In a linear static analysis increments have no meaning and a single increment is solved for
each load case.
In addition to these messages, exit messages indicate normal and abnormal exists from
solver. Following table shows the most common exit messages:
MARC EXIT 2004 Operator matrix (for example, stiffness matrix in stress analysis)
has become non-positive definite and the analysis terminated.
MARC EXIT 3002 Convergence has not occurred within the allowable number of
iterations.
EXIT 3015 If the minimum time step is reached and the analysis still fails
to converge.
Failure to satisfy user-defined physical criteria can occur due to two reasons: the maximum
number of cutbacks allowed by the user can be exceeded, or the minimum time step can be
reached. In this case, the analysis terminates with exit 3002 and exit 3015, respectively.
These premature terminations can be avoided by using the option to continue the analysis
even if physical criteria are not satisfied.
NODAL RESULTS
UT Displacements
UR Rotations
RF Reaction forces
RM Reaction moments
TRUSS/BEAM/SHELL/SOLID RESULTS
S Stresses
E Total strain
EE Elastic strain
PE Plastic strain
SF Forces (O.BS.)
SM Moments (O.BS.)
SK Curvatures (O.BS.)
The Initial State option is designed to read data from a Marc results file solver (t16) and to
use the data as initial conditions in the new analysis.
Typical analyses thay may need Initial State are construction or evolutive processes (tunnel,
retaining walls, etc.)
a) Run first stage analysis of the model to generate result files (for example solving a
single lload case with just gravity in a). It is important to use a different model name
to solve this stage. Make sure that Intermediate files are not deleted (uncheck
corresponding box in Configuration options) and output results for initial state is
activated:
There are some conditions to be taken into account to carry out an analysis with Initial State:
In all cases CivilFEM will compute the water pore pressure at the barycenter of each
element. Then the internal water pressure calculated is applied to the soil skeleton by a
distributed normal pressure on element edges (2D) or element faces(3D) in order to work
with the effective stresses.
If water conditions generates external water pressure (i.e. water load on soil boundaries)
user must introduce the hydrostatic pressure in a load group.
By default, suction (pore water pressure above phreatic level) is ignored. Pore water
pressures are applied only to solid structural elements.
Different initial water conditions can be specified to each structural load case by assigning
the different initial water table condition to each load case. This can be usefull to modelize
the variation of phreatic level. For example, during a construction procces, users can first
resolve the seepage problem for the different stages and then use this results files to define
the pore water pressure in the structural analysis.
4.1. Introduction
Once solution process is completed successfully it is time to analyze the results and verify
the criteria for acceptance. For each load case, the requested results are stored in a binary
file. The following three basic steps are needed to gain access to the results.
Each load case is saved in an independent file. After choosing the desired load case it must
be loaded (.RCF file) replacing any results previously displayed.
Data at nodes is a vector where the number of degrees of freedom of the quantity indicates
the number of components in the vector. Data from elements at integration points is either
scalar, vector, or tensor data.
The data from elements at integration points are not in a form that can be used directly in a
graphics program.
A node may be shared by several elements. Each element contributes a potentially different
value to that shared node. The values are summed and averaged by the number of
contributing elements.
If a node is shared by elements of different materials, the averaging process may not be
appropriate. To prevent the program from averaging values, do not use the AVERAGE
option.
Node Results.
End Results.
Element Results.
Nodal results are displayed or listed according to the global coordinate system. The
following quantities at each nodal point are available:
- Curvatures.
The system provides the element data for each node end (I,J for beams, I,J,K,L for shells).
The orientation of these physical components depends on the structural element coordinate
system.
The system provides the element data at each integration point. All quantities are total
values at the current state (at the end of the current load case), and the physical
components are printed for each tensor quantity (stress, strain). The orientation of these
physical components depends on the structural element coordinate system.
2
ε̅ = √ εij εij
3
CivilFEM uses these measures in the plasticity and creep constitutive theories. For example,
incompressible metal creep and plasticity are based on the equivalent von Mises stress. For
beam, truss, and plane stress elements, an incompressibility assumption is made regarding
the non calculated strain components.
Previous equation represents the negative hydrostatic pressure for stress quantities. For
strain quantities, the equation gives the dilatational magnitude. This measurement is
important in hydrostatically dependent theories (Mohr-Coulomb or extended von Mises
materials), and for materials susceptible to void growth.
The principal values are calculated from the physical components. The eigenvalue problem
is solved for the principal values using the Jacobi transformation method. Note that this is an
iterative procedure and may give slightly different results from those obtained by solving the
cubic equation exactly.
CivilFEM prints generalized stresses and generalized total strains for each integration point.
The generalized stresses printed out for shell elements are:
+t⁄2
∫ σij dz
−t⁄2
+t⁄2
∫ zσij dz
−t⁄2
Eαβ; α, β = 1,2
(Stretch)
K αβ; α, β = 1,2
(Curvature)
Physical stress values are output only for the extreme layers. In addition, thermal, plastic,
creep, and cracking strains are printed for values at the layers, if applicable.
Although the total strains are not output for the layers, they can be calculated using the
following equations:
ε22 = E22 + hk 22
Where h is the directed distance from the midsurface to the layer; are the stretches; and are
the curvatures as printed.
More information about shell results in chapter Forces and Moments Sign Criteria.
The printout for beam elements is similar to shell elements, except that the section values
are force, bending and torsion moment, and bimoment for open section beams. These
values are given relative to the section axes (X, Y, Z).
Before a beam member can be designed, it is necessary to understand the section forces
distribution along the axial direction of the beam. For example, if variations of shear force
and moment along axial direction are plotted, the graphs are termed shear diagram and
moment diagram, respectively.
Pressure
Bimoment
Sign criteria of Force and Moment are explained below using a single element (I, J ends):
Bicurvature
i-component of rotation
Contact results.
Contact Status
Normal stress
Shear stress
Normal force
Shear force
Contact status: useful to detect when two surfaces have contacted. This result applies to
nodes on contacting surfaces.
Contact normal stress: component along the normal of the contact surface of the traction
vector.
Contact shear stress: component along the tangent plane of the contact surface of the
traction vector.
Contact normal force: component along the normal of the contact surface of the equivalent
nodal force of traction vectors.
A load combination is a linear postprocess operation between load cases already solved. The
outcome of the operation creates a new results file, which permits user to display and list
the load case combination as with any other standard results file.
The resulting load cases are obtained by combining linearly the initial load cases, as defined
in the combination rules, with the desired coefficients.
The combination rules are defined in a new window (Automatic User Combination Tool) and
single load cases must exist beforehand.
Summable data are those that can "participate" in the database operations. All primary data
(DOF solutions) are considered summable. Among the derived data, component stresses,
elastic strains, thermal gradients and fluxes, magnetic flux density, etc. are considered
summable.
The utility ENVELOPE has been developed to create of other result files as envelope of
others previously obtained. Envelopes have to be homogeneous; specifically, they must be
obtained by the application of the same code and process to the same model. The new
results file will be homogeneous with the previous ones, with a similar identification and the
same utilities for reading, plotting and listing.
Displacements.
Stresses and strains.
Axial force.
Bending moment.
Torsional moment.
Shear force.
Reactions.
Rest of results (code check/design).
For example, a new envelope file from different homogeneous results files can store the
maximum displacements in absolute value and minimum values for rest of results types.
This results window is very user friendly and very easy to manage:
This results window is very user friendly and very easy to manage, user just need to select
the appropriate results file and multiply any available result by a coefficient.
After choosing the kind of checking or design option (Axial, bending, torsion, shear, etc),
CivilFEM will generate a new kind of file with the extension .crcf that can be loaded in the
Results tab. Opening this file will generate a whole new result list that will contain the
obtained checking/design results.
After solving the model we load the result file which is a .rcf file:
Then we select Concrete, Check Beams, Shear/Torsion and click Shear Qy and Torsion. The
user can choose the file name in the window:
After clicking OK, the Check .crcf is generated and it can be loaded in the Result tab. Note
that the extension needs to be changed to .crcf in the file window.
First, introduce the results files desired to be plotted. This results files can be sorted by load
case calculation time automatically.
Add results data to define results and locations to graph/list. One of this result data must be
identified as x-axis. Results data selected will be graphed versus the x-axis data.
The following figure illustrates the sign criteria for forces and moments. The direction shown
in the figure represents the positive direction of the force/moment.
Axial+Bending reinforcement.
Out of plane shear reinforcement.
In-plane shear reinforcement.
Note: Some design methods or codes consider in-plane shear together with axial+bending.
In these cases, a single group of reinforcement is provided that covers these actions.
The following diagrams show the different reinforcements along with the axis on which they
are defined.
A pivot is a strain limit associated with a material and its position in the shell vertex. If the
strain in a section’s pivot exceeds the limit for that pivot, the shell vertex is considered
cracked. Thus, pivots establish the positions of the strain plane. So, in an ultimate strength
state, the strain plane supports at least one pivot of the shell vertex.
In CivilFEM pivots are defined as material properties and these properties (pivots) are
extrapolated to all the points through the thickness of the shell vertex, accounting for the
particular material of each point (concrete or reinforcement). Therefore, for the section’s
strain plane determination, the following pivots and their corresponding material properties
will be considered:
A Pivot EPSmax. Maximum allowable strain in tension at any point of the shell
vertex (the largest value of the maximum strains allowable for each point of
the section in case there are different materials in the section).
Navier’s hypothesis is assumed for the determination of the strains plane. The strains plane
is defined according to the following equation:
where:
K Curvature.
CivilFEM uses the elements (g,K) to determine the strains plane (ultimate strength plane) of
the shell vertex. The process is composed of the following steps:
If there is no A pivot, (no reinforcement steel or if the ACI, AS3600 or BS8110 codes
are used) there is no tension limit, and this is considered as infinite.
2. Two extreme admissible strains (EPSmin and EPSmax) are defined (different strains
for different materials)
3. For each point of the shell vertex, the minimum ultimate strength curvature (K) is
calculated.
4. The K curvature adopted will be the minimum of all the curvatures of the shell
vertex points, according to the condition K 0.
5. From the obtained K curvature and g (strain imposed at the center of gravity) the
deformation corresponding to each of the shell vertex points (z), is determined
using EQN.1.
6. From the (z) strain, the stress corresponding to each point of the shell vertex (p)
is calculated. With this method, the stress distribution inside the shell vertex will
be determined.
7. The ultimate axial force and bending moment is obtained by integrating the
resulting stresses.
Note: For the design process, two components of forces and moments will be
calculated: the component relative to the fixed points (corresponding to the
concrete) and the component relative to the scalable points (corresponding to the
bending reinforcement). The final forces and moments will be equal to the sum of
the forces and moments of both components. The forces and moments due to the
component for scalable points will be multiplied by the reinforcement factor ().
Steps 1 to 7 are repeated, adjusting the g value and calculating the corresponding ultimate
axial force and bending moment. Therefore, each value of g represents a point in the
interaction diagram of the shell vertex.
1. Acting forces and moments on the shell vertex (F, M) are obtained from the CivilFEM
results file (file .RCF).
2. To construct the interaction diagram of the shell vertex, the ultimate strain state is
determined such that the ultimate forces and moments are homothetic to the acting
forces and moments with respect to the diagram center.
3. The strength criterion of the shell vertex is defined as the ratio between two distances.
As shown above, the distance to the “center” of the diagram (point A of the figure) from
the point representing the acting forces and moments (point P of the figure) is labeled
as d1 and the distance to the center from the point representing the homothetic
ultimate forces and moments (point B) is d2.
𝑑1
𝐶𝑟𝑖𝑡𝑒𝑟𝑖𝑜𝑛 =
𝑑2
If the criterion is less than 1.00, the forces and moments acting on the shell vertex will be
inferior to its ultimate strength, and the shell vertex will be safe. On the contrary, for
criterion higher than 1.00, the shell vertex will be considered as not valid.
Once the reinforcement design moments have been calculated, a design for flexure is
performed for each shell vertex.
CivilFEM provides the possibility of placing the reinforcement in two oblique directions: in
the X direction of the element or in a direction at an angle with the element Y direction.
Mxy − My ∙ tanα
Mx ∗ = Mx − 2Mxy ∙ tanα + My ∙ tan2 α + | |
cosα
My Mxy − My ∙ tanα
My ∗ = 2
+| |
cos α cosα
1. If Mx* < 0
𝑀𝑥 ∗ = 0
1 (Mxy − My ∙ tanα)2
My ∗ = (My + | |)
cos2 α Mx − 2Mxy ∙ tanα + My ∙ tan2 α
2. If My* < 0
(Mxy − My ∙ tanα)2
Mx ∗ = Mx − 2Mxy ∙ tanα + My ∙ tan2 α + | |
My
𝑀𝑦 ∗ = 0
Mxy − My ∙ tanα
Mx ∗ = Mx − 2Mxy ∙ tanα + My ∙ tan2 α + | |
cosα
My Mxy − My ∙ tanα
My ∗ = 2
+| |
cos α cosα
∗
1 (Mxy − My ∙ tanα)2
My = (My − | |)
cos2 α Mx − 2Mxy ∙ tanα + My ∙ tan2 α
4. If My* > 0
(Mxy − My ∙ tanα)2
Mx ∗ = Mx − 2Mxy ∙ tanα + My ∙ tan2 α + | |
My
𝑀𝑦 ∗ = 0
From these design moments, the required top and bottom reinforcement amounts will be
calculated with the same procedure as for beams under bending moments.
0.85·fcd
y
x
h
The steel reinforcement stress-strain diagram is taken as bilinear with the horizontal plastic
branch:
σs = Es ∙ εs ≤ fy
The center of gravity of the reinforcement will be placed at a point determined by the
mechanical cover defined in each shell vertex.
In the absence of compression reinforcement, the engineering criteria will be taken as the
maximum strength of the tensile reinforcement:
σs = fy
1. Obtaining material strength properties. These properties are obtained from the material
properties associated with each shell vertex, which should be previously defined in
CivilFEM database.
2. Obtaining shell thickness geometrical data. Shell geometrical data must be defined
within the CivilFEM shell structural element.
3. Obtaining reinforcement data. The only data concerning flexure design will be the
values for the mechanical cover; these must be defined within the CivilFEM shell
structural element.
4. Obtaining internal forces and moments.
5. Calculating the limit bending moment. Depending on the active code, the limit bending
moment is calculated as follows:
β
MLim = 0.85 ∙ fcd ∙ b ∙ β ∙ Xlim ∙ (d − Xlim )
2
Where:
d Effective depth: d = h – rc
cu Maximum strain of the extreme compression fiber of the concrete. Depends
on the selected code (material EPSmin property).
Eurocode 2 β = 0.8
EHE β = 0.8
EB-FIP β = 0.8
BS8110 β = 0.8 (values of the bellow figure do not apply for code
BS8110)
fcd − 4000
β = 0.85 − 0.05 > 0.65 𝑖𝑓 fcd > 400 𝑝𝑠𝑖
1000
GB50010 β = 0.8
NBR6118 β = 0.8
fcd − 4000
β = 0.85 − 0.05 > 0.65 𝑖𝑓 fcd > 4000 𝑝𝑠𝑖
1000
IS456 β = 0.8
S 52-101 β = 0.8
cu 0.85·fcd
b·x lim
xlim
h d
sy
6. Calculating the required reinforcement. If the design bending moment (Md) is greater
than the limit bending moment, both the tension and compression reinforcements will
be designed. Otherwise, only the tension reinforcement will be designed.
Md ≤ Mlim
β
Md = 0.85 ∙ fcd ∙ b ∙ β ∙ Xn (d − Xn )
2
Tensile reinforcement:
0.85fcd ∙ b ∙ β ∙ Xn
Asr =
fyd
Md >Mlim
d − rc
σsc = Es (−εsy + (εcu +εsy ) ) < fyd
d
Tensile reinforcement:
Mlim Md − Mlim
Ast = +
β (d − rc )fyd
(d − 2 Xn ) fyd
Compression reinforcement:
Md − Mlim
Asc =
(d − rc )σsc
7. Obtaining design results. Design results are stored in the CivilFEM results file:
1. The reinforcement design of shells under bending moment and in plane loading is
accomplished by Model Code CEB-FIP 1990.
2. Reinforcements are defined as an orthogonal net (directions of this net are taken
as element X and Y axes).
npSdy npSdx
Upper
Layer
Y VpSd
X Vy Vx
Intermediate
Layer
Vx
Vy
Lower
Layer
From the forces and moments per unit length (mSdx, mSdy, mSdxy, nSdx, nSdy and vSd) that are
calculated from the design and obtained from the CivilFEM results file, the following
equivalent forces per unit length are obtained:
zx − y mSdx
npSdx = nSdx ∙ ±
zx zx
zy − y mSdy
npSdy = nSdy ∙ ±
zy zy
zV − y mSdxy
VpSd = VSd ∙ ±
zV zV
Where:
zx, zy, zv Lever arms between the axial forces in the X and Y directions
respectively and the shear forces.
y Lever arm between the shear forces (Distance from the mean plane of
the slab to the selected force).
z−y 1
=
z 2
2h
z=
3
Where h is the overall thickness of the plate.
1 3
npSdx = nSdx ± mSdx
2 2h
1 3
npSdy = nSdy ± mSdy
2 2h
1 3
VpSd = VSd ± mSdxy
2 2h
npSdx
αx =
|vpSd |
npSdy
αy =
|vpSd |
-ctg y
II I
x
-tg
(-ctg, -tg)
IV
III
x . y = 1
Depending on position of the point (x, y), the applicable procedure is as follows (If vSd 0,
the program utilizes the sign of nSdx and nSdy, to place the point in the correct zone). The
internal system providing resistance to in-plane loading may be one of four cases:
According to the case, resistances for the ultimate limit states are the following:
I fytd fcd2
II fytd fcd2
IV fytd fcd1
Where:
It is assumed that the shell is reinforced with an orthogonal mesh with dimensions of a x and
ay.
a y = a x · tan
ax
The angle is defined between the X-axis and the direction of compression. It can be
defined by the user adhering to the condition of 1/3 tan 3 (By default, = 45º).
npx = ay . npSdx
npy = ax . npSdy
vpx = ax . vpSd
vpy = ay . vpSd
npx npx
vpy vpy
vpx
npy
1. CASE 1
The method of struts and ties will be applied to the following truss:
A
npx
vpy
B vpx
npy
A
Na1 npx
vpy
Nh
Na2 Nh
B vpx
npy
To check if these forces and moments are feasible, the strength of the concrete is checked.
Concrete area:
ay min(zx , zy )
Ac = cosθ ∙
2 2
Nh
FCMAX =
Ac
This stress is compared to fcd2 to obtain the concrete maximum compression criterion:
FCMAX
CRTFC =
fcd2
2. CASE II
A
npx
vpy
B vpx
npy
By equilibrium in node A:
Nh1
npx
vpy
Nh2
1 npx vpy
Nh = [ − ]
2 cosθ sinθ
1 npx vpy
Nh2 = [ − ]>0
2 cosθ sinθ
By equilibrium in node B:
Na2 Nh1
Nh2
vpx
npy
Max(Nh1, Nh2)
FCMAX =
Ac
This stress is compared to fcd2 to obtain the concrete maximum compression criterion:
FCMAX
CRTC =
fcd2
3. CASE III
A
npx
Vpy
B Vpx
npy
By equilibrium in node B:
Nh1
Nh2
vpx
npy
1 vpx npy
Nh1 = [ − ]
2 cosθ sinθ
1 vpx npy
Nh2 = [ − ]>0
2 cosθ sinθ
By equilibrium in node A:
Nh2
Na1 npx
Nh1 vpy
Max(Nh1, Nh2)
FCMAX =
Ac
This stress is compared to fcd2 to obtain the maximum compression of the concrete criterion:
FCMAX
CRTFC =
fcd2
In this situation, the struts and tie model will be the following:
A
npx
vpy
B vpx
npy
1 2
npx A
A
vpy
B B
vpx
npy
- Solution of Structure 1:
Node A:
Nh
A
Na1
npx
Nh
Node B:
/2 - Na2
Nh
Nh B
npy
Movements compatibility
Where:
Ah ∙ Eh
β1 =
Aa1 ∙ Ea
Ah ∙ Eh
β2 =
Aa2 ∙ Ea
The length of the concrete struts before deformation:
L = √a2 + b 2
sinθ = b/L
2a∆a + 2b∆b
∆L = = cosθ∆a + sinθ∆b
2L
Na1
∆a = ∙a
Aa1 ∙ Ea
Na2
∆b = ∙b
Aa2 ∙ Ea
Nh
∆a = ∙L
Eh ∙ Ah
Nh Na1 Na2
∙ L = cosθ ∙ ∙ a + sinθ ∙ ∙b
Eh ∙ Ah Aa1 ∙ Ea Aa2 ∙ Ea
Nh = β1 cos2 θ ∙ Na1 + β2 sin2 θ ∙ Na2
- Solution of Structure 2:
Due to non-symmetrical loads, the central bars (steel) are not applicable; therefore,
equation 2 is determinant, and the following expression is obtained:
Nh2
A
vpy
Nh1
Vpy
Nh(1 =
2sinθ)
Na1(1 = 0
Na2(1 = 0
Where:
β1 cos 2 θ
A=
1 + 2(β1 cos 3 θ + β2 sin3 θ)
β2 sin2 θ
B=
1 + 2(β1 cos 3 θ + β2 sin3 θ)
1
C=
2sinθ
With the assumption of braced bars, Na1 and Na2 signs correspond to compression for a +
sign and tension for a - sign.
For steel bars without braces, there are two possible determinant truss configurations.
Case 1
A
npx
vpy
B vpx
npy
By equilibrium in A node:
Nh1
npx
vpy
Nh2
1 npx vpy
Nh1 = [ + ]
2 cosθ sinθ
1 npx vpy
Nh2 = [ − ]>0
2 cosθ sinθ
By equilibrium in B node:
Na2
Nh1
Nh2
vpx
npy
Case 2
A npx
vpy
B vpx
npy
By equilibrium in B node:
Nh1
Nh2
vpx
npy
1 npy vpx
Nh1 = [ + ]
2 sinθ cosθ
1 npy vpx
Nh2 = [ − ]>0
2 sinθ cosθ
By equilibrium in A node:
Nh2
npx
Na1
vpy
Nh1
Discussion:
With this situation, CivilFEM will select whichever of the two cases satisfies:
If neither case results in appropriate signs, it will be impossible to equilibrate the force and
moment states without bracing the steel bars.
Max(Nh1, Nh2)
FCMAX =
Ac
This stress is compared with fcd1 to obtain the concrete maximum compression criterion:
FCMAX
CRTFC =
fcd1
For all the cases, steel reinforcement amounts per unit length of the shell are:
𝑁𝑎1
𝑉𝑎1 = 𝑐𝑜𝑡𝑎𝑛𝜃
𝑓𝑦𝑏𝑑
𝑁𝑎2
𝑉𝑎2 =
𝑓𝑦𝑏𝑑
Vy Vx
Vx Vy
V1 = √Vx 2 + Vy 2
Vy
ϕ = arctan
Vx
ρ = ρx cos 4 θ + ρy sin4 θ
200
ξ=1+√
d
Where d is the total depth without the mechanical cover (in mm), and x, y are the ratios
for the reinforcement closest to the face in tension, in the direction perpendicular to the
surface that V1 acts on.
2h
z=
3
z−y 1
=
z 2
The parameter that indicates whether the bars of the element are braced.
Angle between the reinforcement X axis (element X axis) and the direction of
compression. By default, = 45º (although any angle is valid if 1/3 tan 3).
a y = a x · tan
ax
T*x = Tx
T*y = Ty
M*x = Mx
M*y = My
If torsional moment (Mxy) and membrane shear force (Txy) are taken into account, then two
processes are performed depending on considering membrane (in-plane) shear as tension
and as compression.
T*x=Tx
T*y=Ty
Where X and Y represent the orthogonal directions of bending reinforcement of the shell.
The maximum strain allowed in tension is defined for the material (EPSMAX). It will
be used as pivot A in the interaction diagram. This condition is typically used for
Ultimate Limit States.
The maximum stress allowed is specified. This condition is typically used for
Serviceability Limit States in order to control cracking.
1) Obtaining material strength properties. These properties are obtained from the material
properties associated with each shell structural element, which should be previously
defined in CivilFEM model.
2) Obtaining shell vertex geometrical data. Vertex geometrical data must be defined
within the CivilFEM model.
3) Obtaining reinforcement data. The only data associated with the bending moment
design are the mechanical cover values for the reinforcement; these must be defined
within the CivilFEM shell structural elements.
4) Obtaining internal forces and moments. The acting bending moments and axial forces
are those obtained for the X and Y directions of each element (T*x, T*y, M*x, M*y).
5) Check and design. Depending on the active code, the checking or design is performed
using the pivot diagram described for the checking and design of concrete cross sections.
For checking, the criteria for axial force and bending moment are obtained as for the
pivot diagram for beams for each direction.
All reinforcements are considered as scalable for design. The obtained reinforcement
factor is therefore the value that must be used to multiply the upper and lower
reinforcement amount to fulfill the code requirements.
6) Checking results. Checking results are stored in the CivilFEM results file:
Criterion for X direction.
Criterion for Y direction.
7) Design results. Design results are stored in the CivilFEM results file:
Reinforcement amount for X direction, top surface.
Reinforcement amount for X direction, bottom surface.
Reinforcement amount for Y direction, top surface.
Reinforcement amount for Y direction, bottom surface.
Design criterion for X direction.
Design criterion for Y direction.
1) Materials strength properties. These properties are obtained from the material
properties associated with each one of the shell vertices and for the active time. Those
material properties should be previously defined. The required data are the following:
fck characteristic compressive strength of concrete.
fcd design strength of concrete.
fyk characteristic yield strength of reinforcement.
Assi
ρ1i = < 0.02
th − c
where:
Mean compressive stress (σcp > 0): cotan θ0 = 1.2 + 0.2 σcp ⁄fctm
Mean tensile stress (σcp < 0): cotan θ0 = 1.2 + 0.9 σcp ⁄fctm ≥ 1
4) Shell vertex reinforcement data. Required data are the following:
Ass area of reinforcement per unit area, (parameter ASS of shell structural
element).
The reinforcement ratio may also be obtained with the following data:
sx, sy spacing of the stirrups in each direction of the shell, (parameters SX and SY of
shell structural element).
φ diameter of bars (parameter PHI of shell structural element).
nx, ny number of stirrups per unit length in each direction of the shell (parameters
NX and NY of shell structural element).
5) Shell vertex internal forces. The shear force (VEd) acting on the vertex as well as the
concomitant axial force (NEd) are obtained from the CivilFEM results file (.RCF).
Ny
ϕv = arctan
Nx
The value taken for the design compression force ( TEd ) is the maximum considering all
directions:
1 2
TEd = (Tx + Ty − √(Tx + Ty ) − 4(Tx ∙ Ty − Txy2 ))
2
Design compression force takes into account axial force in x, y directions and in-plane
shear using Mohr’s circle stress transformation equations.
The total shear reinforcement 1 is computed from those in each direction, according
to equation LL.123 (Annex LL from EN 1992-2:2005):
ρ1 = ρx ∙ cos2 ϕv + ρy ∙ sin2 ϕv
VEd ≤ VRd,c
VRd,c = [CRd,c ∙ k ∙ (100ρI ∙ fck )1⁄3 + k1 ∙ σcp ] ∙ bw ∙ d
With the constraints:
Where:
CRd,c = 0.18yc
fck in MPa
200
k = 1+√ ≤ 2.0(d en mm)
d
k1 = 0.15
TEd
σcp = < 0.2fcd MPa
Ac
Ac in mm2
f
ck
0.6 (1 − 250 )Eurocode 2 (EN 1992-1-1:2004/AC:2008)
vRd,c = in N
If shear reinforcement is defined in the section, VEd must be less than the minimum between
the shear reinforcement force:
Asw
VRd,s = ∙ 0.9 ∙ d ∙ fywd ∙ (cotanθ + cotanα) ∙ sin α
s
and the maximum design shear force resisted without crushing of concrete compressive
struts:
(cotanθ + cotanα)
VRd,max = αcw ∙ bw ∙ 0.9 ∙ d ∙ ν ∙ fcd ∙
(1 + cotan2 θ)
cotanθ0 + cotanα
VRd,max = αcw ∙ ν ∙ fcd ∙ bw ∙ 0.9 ∙ d ∙ ( )
(1 + cotan2 θ0 )
where:
Asw,max fcd
= 0.5 ∙ αcw ∙ bw ∙ 𝛎 ∙
s fyd
Results are written for each end in the CivilFEM results file:
VRDC = VRd,c
VRDS = VRd,s
VRDMAX = VRd,max
VEd
TENS = cotθ
2
Tensile strength for the longitudinal reinforcement
VEd
CRT_1 = VRd,c
VEd
VRd,máx }},
A value of 2100 for this criterion indicates that VRd,c, VRd,s or VRd,max are null.
VEd ≤ VRd,c
VRd,c = [CRd,c ∙ k ∙ (100ρI ∙ fck )1/3 + k1 ∙ σcp ] ∙ bw ∙ d
with constraints:
VEd ≤ 0.5bw ∙ d ∙ ν ∙ fcd
VRd,c ≥ [Vmin + k1 ∙ σcp ] ∙ bw ∙ d
where:
CRd,c = 0.18 yc
fck in MPa
200
k = 1+√ ≤ 2.0 (d in mm)
d
k1 = 0.15
NEd
σcp = < 0.2 fcd MPa
Ac
AC in mm2
ck f
0.6 (1 − 250 ) Eurocode 2 (EN 1992-1-1:2004/AC:2008)
VRd,c in N
Results are written for each end in the CivilFEM results file as the following parameters:
VRDC = VRd,c
VEd
CRT_1 =
VRd,c
(cotanθ + cotanα)
VRd,max = αcw ∙ bw ∙ 0.9 ∙ d ∙ ν ∙ fcd ∙
(1 + cotan2 θ)
cotanθ + cotanα
VRd max = αcw ∙ ν ∙ fcd ∙ bw ∙ 0.9 ∙ d ∙ ( )
1 + cotan2 θ0
where:
Asw VRd,s
=
s 0.9 ∙ d ∙ fywd ∙ cotanθ
Asw fcd
≤ 0.5 ∙ αcw ∙ bw ∙ ν ∙ /sin α
s fywd
If design shear force is greater than the shear force due to crushing of concrete compressive
struts, the reinforcement design will not be feasible; therefore, the parameter containing
this datum will be marked with 2100. In this case, the element will be marked as not
designed.
ASST and ASSB parameters store the amount of top and bottom reinforcement required due
to the additional tensile force DFtd , in the longitudinal reinforcement due to shear VEd.
0,5VEd cotanθ
∆Asl =
fywd
Results are written for each element end in the CivilFEM results file as the parameters:
VRDS = VRd,s
Asw
ASSH =
s
DSG_CRT design criterion
1. Material strength properties. Material properties are assigned to each shell structural
element. These material properties must be defined prior to the check and design
process. The required properties are:
f’c specified compressive strength of concrete.
fy specified yield strength of reinforcement.
Ass the area of bending reinforcement per unit length. This parameter is used for
checking (parameters of shell structural element).
4. Shell vertex shear reinforcement data.
Ass area of shear reinforcement per unit of area. This parameter is used
for checking (parameter of shell structural element).
AssX, AssY area of shear reinforcement per unit of area in each direction of
the shell. (parameters of shell structural element)
5. Shell vertex internal forces. The shear force acting on the vertex as well as the
concomitant membrane force are obtained from the CivilFEM results file (.RCF). For
each direction of the shell vertex:
Force Description
Vc = 2 ∙ √fc′ ∙ bw ∙ (th − c)
(ACI 318-05 Eqn:11-3)
where:
bw = 1 (unit length)
√fc′ square root of specified compressive strength of concrete, in psi (always taken
as less than 100 psi).
For sections subject to a compressive axial force,
Nu
Vc = 2 ∙ (1 + ) ∙ √fc′ ∙ bw ∙ (th − c)
2000 ∙ bw ∙ th
(ACI 318-05 Eqn:11-4)
where:
Nu/(th·bw)expressed in psi.
If section is subjected to a tensile force so that the tensile stress is less than 500 psi:
Nu
Vc = 2 ∙ (1 + ) ∙ √fc′ ∙ bw ∙ (th − c)
500 ∙ bw ∙ th
(ACI 318-05 Eqn:11-8)
If the shell is subjected to a tensile force so that the tensile stress exceeds 500 psi, it is
assumed Vc=0.
The calculation result for all elements is stored in the CivilFEM results file as the parameter
VC (# is the direction of the shell, X or Y):
VC = Vc
Vs = Ass ∙ fy ∙ (th − c)
(ACI 318-05 Eqn.11-15)
The calculation result for all elements is stored in the CivilFEM results file as the parameter
VS (# is the direction of the shell, X or Y direction):
Vn = Vc + Vs
This nominal strength, is stored in the CivilFEM results file as the parameter VN (# is the
direction of the shell, X or Y):
bw
Assmin = 50
fy
Vu ≤ ϕVn = ϕ(Vc + Vs )
(ACI 318-05 Eqn.11-1 and 11-2)
Vu
Max { }
ϕVn
For each element, this value is stored in the CivilFEM results file as the parameter CRT_#.
If the strength provided by concrete is null and the shear reinforcement is not defined in the
shell vertex, and the criterion is equal to 2100.
The φ∙Vn value is stored in CivilFEM results file as the parameter VFI_#.
The total checking criterion is defined as:
VS_X + VS_Y Assmin
CRT_TOT = Max {CRT_X; CRT_Y; ; }
8 ∙ √fc′ ∙ bw ∙ (th − c) Ass
Vc = 2 ∙ √fc′ ∙ bw ∙ (th − c)
(ACI 318-05 Eqn.11-8)
where:
bw = 1 (unit length)
√fc′ square root of specified compressive strength of concrete, in psi (always taken
as less than 100 psi).
Nu
Vc = 2 ∙ (1 + ) ∙ √fc′ ∙ bw ∙ (th − c)
2000 ∙ bw ∙ th
(ACI 318-05 Eqn.11-4)
where:
If the section is subjected to a tensile force such that the tensile stress is less than 500 psi,
Nu
Vc = 2 ∙ (1 + ) ∙ √fc′ ∙ bw ∙ (th − c)
500 ∙ bw ∙ th
(ACI 318-05 Eqn.11-8)
If the shell is subjected to a tensile force such that the tensile stress exceeds 500 psi, it is
assumed that Vc=0.
The calculation result for all element ends is stored in the CivilFEM results file as the
parameter VC (# is the direction of the shell, X or Y):
Vu ≤ 𝜙Vn = ϕ(Vc + Vs )
Vu
Vs = − Vc
ϕ
Calculated results are stored in the CivilFEM results file for both element ends as the
parameter VS (# is the direction of the shell, X or Y):
If the required shear strength of the reinforcement does not satisfy the expression above,
the shell vertex cannot be designed; therefore, the reinforcement parameter will be set as
2100.
The area of the designed reinforcement per unit length is stored in the CivilFEM results file
as:
1. Material strength properties. Material properties are assigned to each shell structural
element. These material properties must be defined prior to the check and design
process. The required properties are:
f’c specified compressive strength of concrete.
fy specified yield strength of reinforcement.
λ modification factor for lightweight concrete (λ = 1.0 default value)
Ass the area of bending reinforcement per unit length. This parameter is used for
checking (parameters of shell structural element).
4. Shell vertex shear reinforcement data.
Ass area of shear reinforcement per unit of area. This parameter is used
for checking (parameter of shell structural element).
AssX, AssY area of shear reinforcement per unit of area in each direction of
the shell. (parameters of shell structural element)
Nx, Ny number of stirrups per unit length in each direction of the shell
(parameters of shell structural element).
5. Shell vertex internal forces. The shear force acting on the vertex as well as the
concomitant membrane force are obtained from the CivilFEM results file (.RCF). For
each direction of the shell vertex:
Force Description
Vc = 2 ∙ λ ∙ √fc′ ∙ bw ∙ (th − c)
(ACI 318-14 Eqn:11-3)
where:
bw = 1 (unit length)
√fc′ square root of specified compressive strength of concrete, in psi (always taken
as less than 100 psi).
For sections subject to a compressive axial force,
Nu
Vc = 2 ∙ (1 + ) ∙ λ ∙ √fc′ ∙ bw ∙ (th − c)
2000 ∙ bw ∙ th
(ACI 318-14 Eqn:11-4)
where:
Nu/(th·bw)expressed in psi.
If section is subjected to a tensile force so that the tensile stress is less than 500 psi:
Nu
Vc = 2 ∙ (1 + ) ∙ λ ∙ √fc′ ∙ bw ∙ (th − c)
500 ∙ bw ∙ th
(ACI 318-14 Eqn:11-8)
If the shell is subjected to a tensile force so that the tensile stress exceeds 500 psi, it is
assumed Vc=0.
The calculation result for all elements is stored in the CivilFEM results file as the parameter
VC (# is the direction of the shell, X or Y):
VC = Vc
Vs = Ass ∙ fy ∙ (th − c)
(ACI 318-14 Eqn.11-15)
The calculation result for all elements is stored in the CivilFEM results file as the parameter
VS (# is the direction of the shell, X or Y direction):
Vn = Vc + Vs
This nominal strength, is stored in the CivilFEM results file as the parameter VN (# is the
direction of the shell, X or Y):
bw
Assmin = 50
fy
Vu ≤ ϕVn = ϕ(Vc + Vs )
(ACI 318-14 Eqn.11-1 and 11-2)
Vu
Max { }
ϕVn
For each element, this value is stored in the CivilFEM results file as the parameter CRT_#.
If the strength provided by concrete is null and the shear reinforcement is not defined in the
shell vertex, and the criterion is equal to 2100.
The φ∙Vn value is stored in CivilFEM results file as the parameter VFI_#.
The total checking criterion is defined as:
VS_X + VS_Y Assmin
CRT_TOT = Max {CRT_X; CRT_Y; ; }
8 ∙ √fc′ ∙ bw ∙ (th − c) Ass
Vc = 2 ∙ λ ∙ √fc′ ∙ bw ∙ (th − c)
(ACI 318-14 Eqn.11-8)
where:
bw = 1 (unit length)
√fc′ square root of specified compressive strength of concrete, in psi (always taken
as less than 100 psi).
Nu
Vc = 2 ∙ (1 + ) ∙ λ ∙ √fc′ ∙ bw ∙ (th − c)
2000 ∙ bw ∙ th
(ACI 318-14 Eqn.11-4)
where:
If the section is subjected to a tensile force such that the tensile stress is less than 500 psi,
Nu
Vc = 2 ∙ (1 + ) ∙ λ ∙ √fc′ ∙ bw ∙ (th − c)
500 ∙ bw ∙ th
(ACI 318-14 Eqn.11-8)
If the shell is subjected to a tensile force such that the tensile stress exceeds 500 psi, it is
assumed that Vc=0.
The calculation result for all element ends is stored in the CivilFEM results file as the
parameter VC (# is the direction of the shell, X or Y):
Vu ≤ 𝜙Vn = ϕ(Vc + Vs )
Vu
Vs = − Vc
ϕ
Calculated results are stored in the CivilFEM results file for both element ends as the
parameter VS (# is the direction of the shell, X or Y):
If the required shear strength of the reinforcement does not satisfy the expression above,
the shell vertex cannot be designed; therefore, the reinforcement parameter will be set as
2100.
The area of the designed reinforcement per unit length is stored in the CivilFEM results file
as:
1. Material strength properties. Material properties are assigned to each active shell
vertex. These material properties must be defined prior to checking and design. The
required properties are:
f’c specified compressive strength of concrete.
fy specified yield strength of reinforcement.
2. Shell vertex data:
th thickness of the shell vertex.
Required properties are:
Ass the area of bending reinforcement per unit length. This parameter is used for
checking (parameters of shell structural element).
4. Shell vertex shear reinforcement data.
Ass area of shear reinforcement per unit of area. This parameter is used
for checking (parameters of shell structural element).
The shear reinforcement ratio may also be obtained from:
AssX, AssY area of shear reinforcement per unit of area in each direction of
the shell. Parameters of shell structural element.
Force Description
Vc = 2 ∙ √fc′ ∙ bw ∙ (th − c)
(ACI 349-01 Eqn:11-3)
where:
bw = 1 (unit length)
√fc′ square root of specified compressive strength of concrete, in psi (always taken
as less than 100 psi).
For sections subject to an axial compressive force,
Nu
Vc = 2 ∙ (1 + ) ∙ √fc′ ∙ bw ∙ (th − c)
2000 ∙ bw ∙ th
(ACI 349-01 Eqn:11-4)
where:
If the section is subjected to a tensile force such that the tensile stress is less than 500 psi
then,
Nu
Vc = 2 ∙ (1 + ) ∙ √fc′ ∙ bw ∙ (th − c)
500 ∙ bw ∙ th
(ACI 349-01 Eqn:11-8)
If the shell is subjected to a tensile force so that the tensile stress exceeds 500 psi, it is
assumed Vc=0.
The calculation result for all elements is stored in the CivilFEM results file as the parameter
VC (# is the direction of the shell, X or Y):
Vs = Ass ∙ fy ∙ (th − c)
(ACI 349-01 Eqn.11-15)
The calculated result for all elements is stored in the CivilFEM results file as the parameter
VS (# is the direction of the shell, X or Y):
Vn = Vc + Vs
This nominal strength is stored in the CivilFEM results file as the parameter VN (# is the
direction of the shell, X or Y):
bw
Assmin = 50
fy
(ACI 349-01 Eqn.11-13)
Vu ≤ ϕVn = ϕ(Vc + Vs )
(ACI 349-01 Eqn.11-1 and 11-2)
Vu
Max { }
ϕVn
For each element, this value is stored in the CivilFEM results file as the parameter CRT_#.
If the strength provided by concrete is null and the shear reinforcement is not defined in the
shell vertex, the criterion is set equal to 2100.
The φ·Vn value is stored in the CivilFEM results file as the parameter VFI_#.
The total checking criterion is defined as:
VS_X + VS_Y Assmin
CRT_TOT = Max {CRT_X; CRT_Y; ; }
8 ∙ √fc′ ∙ bw ∙ (th − c) Ass
Vc = 2 ∙ √fc′ ∙ bw ∙ (th − c)
(ACI 349-01 Eqn.11-3)
where:
bw = 1 (unit length)
√fc′ square root of specified compressive strength of concrete, in psi (it is always
taken as less than 100 psi).
For sections subject to a compressive axial force,
Nu
Vc = 2 ∙ (1 + ) ∙ √fc′ ∙ bw ∙ (th − c)
2000 ∙ bw ∙ th
(ACI 349-01 Eqn.11-4)
Where:
If the section is subjected to a tensile force such that the tensile stress is less than 500 psi:
Nu
Vc = 2 ∙ (1 + ) ∙ √fc′ ∙ bw ∙ (th − c)
500 ∙ bw ∙ th
If the shell is subjected to a tensile force such that the tensile stress exceeds 500 psi, it is
assumed that Vc=0.
The calculation result for all elements is stored in the CivilFEM results file as the parameter
VC (# is the direction of the shell, X or Y):
VC = Vc
Vu ≤ ϕVn = ϕ(Vc + Vs )
(ACI 349-01 Eqn.11-1 and 11-2)
Vu
Vs = − Vc
ϕ
Calculation results are stored in the CivilFEM results file for all elements as the parameter VS
(# is the direction of the shell, X or Y):
If the shear force the reinforcement must support does not satisfy the expression above, the
shell vertex cannot be designed, so the parameters where the reinforcement is stored are
set to 2100. Then:
Vs
Ass =
fy ∙ (th − c)
(ACI 349-01 Eqn.11-15)
The area of the designed reinforcement per unit of area is stored in the CivilFEM results file
as:
In this case, the element will be marked as designed (providing the design process is correct
for all element directions).
1) Materials strength properties. These properties are obtained from the material
properties associated with each one of shell structural element and for the active
time. Those material properties should be previously defined. The required data
are the following:
fck characteristic compressive strength of concrete.
fyk characteristic yield strength of reinforcement.
fct,m mean tensile strength of concrete.
γc partial safety factor for concrete.
γs partial safety factor for reinforcement.
2) Shell vertex geometrical data:
th thickness of the shell structural element.
φ diameter of bars.
nx, ny number of stirrups per unit length in each direction of the shell.
5) Shell vertex internal forces. The shear force acting on the vertex as well as the
concomitant axial force are obtained from the CivilFEM results file (.RCF).
Design shear force (Vrd) is obtained from the shear forces in the X and Y directions:
Vrd = √Nx2 + Ny 2
Ny
ϕv = arctan
Nx
The value taken for the design compression force ( TEd ) is the maximum considering all
directions:
1 2
TEd = (Tx + Ty − √(Tx + Ty ) − 4(Tx ∙ Ty − Txy2 ))
2
Design compression force takes into account axial force in x, y directions and in-plane
shear using Mohr’s circle stress transformation equations.
The total shear reinforcement 1 is computed from those in each direction, according
to equation LL.123 (Annex LL from EN 1992-2:2005):
ρ1 = ρx ∙ cos2 ϕv + ρy ∙ sin2 ϕv
The design shear force (Vrd) is compared to the oblique compression resistance of concrete
(Vu1):
Vrd ≤ Vu1
cot θ
Vu1 = K ∙ f1cd ∙ (th − c) ∙
1 + cot 2 θ
where:
’cd effective axial stress in concrete (compression positive) accounting for the
axial stress taken by reinforcement in compression.
For each element end, calculation results are written in the CivilFEM results file:
Vrd ≤ Vu2
Vu2 = Vsu + Vcu
Vsu contribution of transverse shear reinforcement in the web to the shear strength.
Vcu contribution of concrete to the shear strength.
T
σ′cd = Ad < 0.30 ∙ fcd ≤ 12 MPa (Compression positive)
c
200
ξ= 1+√ < 2, d in mm
d
0.15
Vcu = [ ξ(100 ρ1 fck )1/3 + 0.15σ′cd ] (th − c)β
γc
where:
2 cot θ−1
β = 2 cot θ if 0.5 ≤ cot θ < cot θe
e −1
cot θ−2
β = cot θ if cot θe ≤ cot θ ≤ 2.0
e −2
2
√fct,m − fct,m (σxd + σyd ) + σxd σyd
≥ 0.5
cot θe = {
fct,m − σyd ≤ 2.0
σxd, σyd design normal stresses, at the center of gravity, parallel to the longitudinal
axis of member and to the shear force Vd respectively (tension positive)
σ
Taking σyd = 0 → cot θe = √1 − f xd
ct,m
In addition, the increment in tensile force due to shear force is calculated with the following
equation:
Vsu
∆T = Vrd ∙ cot θ − ∙ cot θ
2
For each end, calculation results are written in the CivilFEM results file:
The increase in longitudinal reinforcement due to shear is stored in ASST and ASSB
parameters (for top and bottom surfaces of the shell respectively).
Vrd Vrd
CRT_TOT = Max ( , )≤1
Vu1 Vu2
For each end, this value is stored in the CivilFEM results file as the parameter CRT_TOT.
Vrd = Vu1
cot θ
Vu1 = K ∙ f1cd ∙ (th − c) ∙
1 + cot 2 θ
where:
1 σ′cd = 0
σ′cd
1+ 0 < σ′cd ≤ 0.25 ∙ fcd
fcd
K=
1.25 0.25 ∙ fcd < σ′cd ≤ 0.50 ∙ fcd
σ′cd
2.5 (1 − ) 0.50 ∙ fcd < σ′cd ≤ fcd
{ fcd
’cd effective axial stress in concrete (compression positive) accounting for the axial stress
taken by the reinforcement in compression.
For each element end, calculation results are written in the CivilFEM results file:
𝑉𝑟𝑑 = 𝑉𝑢2
0.18
Vu2 = Vcu = [ ξ(100 ρ1 fck )1/3 + 0.15σ′cd ] (th − c)
γc
0.075 3/2
Vu2 = [ ξ √fck + 0.15σ′cd ] (th − c)
γc
Where:
Td
σ′cd = < 30 ∙ fcd ≤ 12 MPa (Compression positive)
Ac
200
ξ= 1+√ < 2, d in mm
d
VCU = Vcu
VU2 Ultimate shear strength by tension.
VU2 = Vcu
VSU Contribution of the shear reinforcement to the shear strength.
VSU = 0
ASSH Required amount of shear reinforcement.
ASSH = Ass = 0
Vrd ≤ Vu2
0.15
Vcu = [ ξ(100ρ1 fck )1/3 + 0.15σ′cd ] (th − c)β
γc
where:
2 cot θ−1
β= if 0.5 ≤ cot θ < cot θe
2 cot θe −1
cot θ−2
β = cot θ if cot θe ≤ cot θ ≤ 2.0
e −2
2
√fct,m − fct,m (σxd + σyd ) + σxd σyd
≥ 0.5
cot θe = {
fct,m − σyd ≤ 2.0
σxd, σyd design normal stresses at the gravity center, parallel to the longitudinal axis of
the member and to the shear force Vd, respectively (tension positive)
σxd
Taking σyd = 0 → cotθe = √1 − f
ct,m
VCU = Vcu
VU2 Ultimate shear strength by tension.
VU2 = Vrd
VSU Contribution of the shear reinforcement to the shear strength.
VSU = Vsu
Vsu
Ass =
fyd ∙ 0.9 ∙ (th − c) ∙ (cot θ)
The area of designed reinforcement per unit of shell area is stored in the CivilFEM results file
as the parameter:
ASSH = Ass
In this case, the element will be labeled as designed (provided the design process is correct
for all element shell vertices).
If the design is not possible, the reinforcement will be marked as 2100 and the element will
not be designed.
ASST and ASSB parameters store the amount of top and bottom reinforcement required due
to the additional tensile force DFtd , in the longitudinal reinforcement due to shear VEd.
Vsu
∆𝐹𝑡𝑑 = Vrd cotanθ − cotg θ
2
Vsu
Vrd cotanθ −
∆Asl = 2 cotg θ
fyd
1. Material strength properties. This data is obtained from the material properties
assigned to each active shell vertex. These material properties must be defined prior to
check and design. The required properties are:
f’c specified compressive strength of concrete.
fy specified yield strength of reinforcement.
2. Shell vertex data:
th thickness of the shell vertex.
Required properties are:
Vc = 2 ∙ √fc′ ∙ d ∙ th
f 'c square root of specified compressive strength of concrete, in psi (always taken
less than 100 psi).
If the section is subjected to a tensile force such that the tensile stress is less than 500 psi
then,
Nu
Vc = 2 ∙ (1 + ) ∙ √fc′ ∙ d ∙ th
500 ∙ bw ∙ th
If the shell is subjected to a tensile force such that the tensile stress exceeds 500 psi, it is
assumed Vc=0.
The calculation result for all elements is stored in the CivilFEM results file as the parameter
VC (# is the direction of the shell, X or Y):
Assip ∙ fy ∙ d
Vs =
s
s = 1(unit length)
The calculated result for all elements is stored in the CivilFEM results file as the parameter
VS (# is the direction of the shell, X or Y):
Vn = Vc + Vs
The shell vertex will be valid for shear if the following conditions are satisfied:
Vu ≤ ϕVn = ϕ(Vc + Vs )
(ACI 349-01 Eqn: 11-1 and 11-2)
Vu ≤ ϕ10√fc′ ∙ d ∙ th
d = 0.8 ∙ Iw = 0.8 ∙ 1(unit length)
(ACI 349-01 11.10.3 and 11.10.4)
Assip
≥ 0.0025
th
(ACI 349-01 11.10.9.2)
Vu
CRT_1_# =
ϕVn
Vu
CRT_2_# =
ϕ10√fc′ ∙ 0.8 ∙ th
0.0025 ∙ th
CRT_3_# =
Assip
If the strength provided by concrete is null and the shear reinforcement is not defined in the
shell vertex, then Vn=0, and the criterion CRT_1 will be set equal to 2100.
If the shear reinforcement is not defined in the shell vertex, then the criterion CRT_3 is set
equal to 2100.
The φ∙Vn value is stored in the CivilFEM results file as the parameter VPHI_# (# is the
direction of the shell, X or Y).
Vn = Vc + Vs
But also limited by:
Vn = Acv 2√fc′ + Assip ∙ fy
(ACI 349-01 21.6.5.2)
Vu ≤ ϕVn = ϕ(Vc + Vs )
Vu ≤ ϕ(Acv 2√fc′ + Assip ∙ fy )
(ACI 349-01 21.6.5.2)
Vu ≤ ϕ8√fc′ ∙ th ∙ Iw
Iw = 1(unit length)
(ACI 349-01 21.6.5.6)
Assip
≥ 0.0025
th
(ACI 349-01 21.6.2.1)
Vu
CRT_1_# =
ϕmin(Vn , Acv 2√fc′ + Assip ∙ fy )
Vu
CRT_2_# =
ϕ8√fc′ ∙ th
0.0025 ∙ th
CRT_3_# =
Assip
These values are stored for all elements in the CivilFEM results file as the parameters
CRT_1_X, CRT_1_Y, CRT_2_X, CRT_2_Y, CRT_3_X, CRT_3_Y and CRT_TOT.
In case the strength provided by concrete is null and the shear reinforcement is not defined
in the shell vertex, then Vn=0, and the criterion CRT_1 is set equal to 2100.
If shear reinforcement is not defined in the shell vertex, then the criterion CRT_3 is set equal
to 2100.
The φ·Vn value is stored in the CivilFEM results file as the parameter VPHI_# (# is the
direction of the shell, X or Y).
Vc = 2 ∙ √fc′ ∙ d ∙ th
d = 0.8 ∙ Iw = 0.8 ∙ 1(unit length)
(ACI 349-01 11.10.4 and 11.10.5)
Where:
√fc′ square root of specified compressive strength of concrete, in psi (always taken
as less than 100 psi).
If the section is subjected to a tensile force such that the tensile stress is less than 500 psi:
Nu
Vc = 2 ∙ (1 + ) ∙ √fc′ ∙ d ∙ th
500 ∙ bw ∙ th
If the shell is subjected to a tensile force so that the tensile stress exceeds 500 psi, it is
assumed Vc=0.
The calculated result for each element is stored in the CivilFEM results file as the parameter
VC (# is the direction of the shell, X or Y):
VC = Vc
Vu ≤ ϕVn = ϕ(Vc + Vs )
(ACI 349-01 11-1 and 11-2)
Vu
Vs = − Vc
ϕ
The calculated result for each element is stored in the CivilFEM results file as the parameter
VS (# is the direction of the shell, X or Y):
VS = Vs
Aipss
≥ 0.0025
th
(ACI 349-01 11.10.9.2)
Therefore:
Vs
Assip = max {f , 0.0025 ∙ th} for each direction X and Y
y ∙0.8
The area of the designed reinforcement per unit length is stored in the CivilFEM results file
as:
Vu
CRT_2_# =
ϕ10√fc′ ∙ 0.8 ∙ th
(# is the direction of the shell, X or Y)
If CRT_2_# is greater than 1.0, the condition will not be satisfied, and therefore, the element
will not be designed. ASSIP_# will be set to 2100 and the element will be labeled as not
designed.
The criterion below compares the calculated reinforcement with the minimum
reinforcement requirement:
0.0025 ∙ th
CRT_3_# =
Assip
Vu ≤ ϕVn = ϕ(Vc + Vs )
With
Assip ∙ fy ∙ d
Vs =
s
d = 0.8 ∙ Iw = 0.8 ∙ 1(unit length)
s = 1(unit length)
(ACI 349-01 Eqn: 11-33)
and
Therefore the reinforcement amount is the minimum value that satisfies both expressions:
Therefore:
The area of the designed reinforcement per unit length is stored in the CivilFEM results file
as:
Vu
CRT_2_# =
ϕ8√fc′ ∙ th
(# is the direction of the shell, X or Y)
If CRT_2_# is greater than 1.0, the condition will not be satisfied, and therefore, the element
will not be designed. ASSIP_# will then be set to 2100 and the element will be labeled as not
designed.
The criterion below compares the calculated reinforcement with the minimum required
reinforcement:
0.0025 ∙ th
CRT_3_# =
Aipss
The shell vertex will be valid for shear if the following conditions are satisfied:
Vu ≤ ϕ8√fc′ ∙ Iw ∙ th
Iw = 1(unit length)
(ACI 349-01 21.6.5.6)
Assip
≥ 2 ∙ 0.0012 = 0.0024 (th < 48 𝑖𝑛. )
th
(ACI 349-01 21.6.2.1, 7.12.2)
Note: A minimum reinforcement amount is not calculated for a thickness greater or equal
than 48 in.
Vu
CRT_1_# =
ϕ(Acv 2√fc′ + Assip ∙ fy )
Vu
CRT_2_# =
ϕ8√fc′ ∙ th
0.0024 ∙ th
CRT_3_# = (th < 48𝑖𝑛. )
Assip
These values are stored for each element in the CivilFEM results file as the parameters
CRT_1_X, CRT_1_Y, CRT_2_X, CRT_2_Y, CRT_3_X, CRT_3_Y and CRT_TOT.
If the strength provided by concrete is null and shear reinforcement is not defined in the
shell vertex, then Vn=0, and the criterion CRT_1 is set equal to 2100.
If shear reinforcement is not defined in the shell vertex, then the criterion CRT_3 is set equal
to 2100.
The φ·Vn value is stored in the CivilFEM results file as the parameter VPHI_# (# is the
direction of the shell, X or Y).
Note: A minimum reinforcement amount is not calculated for a thickness greater or equal
than 48 in.
Therefore the reinforcement amount is the minimum value that satisfies the following
expressions for both X and Y directions:
Vu − ϕAcv 2√fc′
Assip = max { , 0.0024 ∙ th} (th < 48 𝑖𝑛. )
ϕfy
Vu − ϕAcv 2√fc′
Assip = max { } (th ≥ 48 in. )
ϕfy
The area of the designed reinforcement per unit length is stored in the CivilFEM results file
as:
Vu
CRT_2_# =
ϕ8√fc′ ∙ th
(# is the direction of the shell, X or Y)
If CRT_2_# is greater than 1.0, the condition above will not be satisfied and therefore the
element cannot be designed. ASSIP_# will be set to 2100 and the element will be labeled as
not designed.
To determine if a minimum reinforcement amount has been defined, the CRT_3_# criterion
is defined as:
0.0024 ∙ th
CRT_3_# = (th < 48𝑖𝑛. )
Assip
Wk ≤ Wmax
where:
Wk Design crack width.
The design crack width is obtained from the following expression (Art. 7.3.4):
ϕ
Sr,max = k 3 ∙ c + k1 ∙ k 2 ∙ k 4
ρp,eff
f
σs − k t ρct,eff (1 + αe ρp,eff )
p,eff σs
εsm − εcm = ≥ 0.6
Es Es
Reinforcement bar size in mm (cross section code property).
As +ξ 12 ∙Ap′
ρp,eff = Effective reinforcement ratio, where Ac,eff is the effective area of
Ac,eff
concrete in tension, As is the area of reinforcement contained within
the effective concrete area and Ap’ is the area of pre- or post-
tensioned tendons within Ac,eff CivilFEM calculates this value with
ℎ−𝑥
Ap′ = 0 and Ac,eff = min(2.5(ℎ − 𝑑), , ℎ/2)
3
k1 Coefficient accounting for the influence of the bond properties of the bonded
reinforcement (option in the Checking menu).
k2 Coefficient accounting for the influence of the form of the strain distribution:
ε1 + ε2
k2 =
2ε1
Where 1 is the larger tensile strain and 2 is the smaller tensile strain at the
boundary of a section subjected to eccentric tension.
kt Coefficient accounting for the influence of the duration of the loading (option in the
Checking menu).
The calculation of these stresses is an iterative process in which CivilFEM searches for the
deformation plane that causes a stress state that is in equilibrium with the external loads.
The reinforcement stress is obtained from this deformation plane and from the
reinforcement position.
The design loads are taken as external loads for the case of serviceability stress calculation.
For the stress calculation at the instant the crack appears, the external loads are taken as
homothetic to the design loads that cause a stress equivalent to the concrete tensile
strength in the fiber under the greatest amount of tension.
If the loads acting on the cross section cause collapse under axial plus bending checking, the
cross section and the associated element are labeled as non-checked.
1 Upper fiber.
-1 Lower fiber.
1 Upper fiber.
-1 Lower fiber.
For the cracking check (wmax > 0) the total criterion is defined as:
Wk
CRT_TOT =
Wmax
fcd + σmax
CRT_TOT =
fcd
where
σmax Maximum section stress (positive tension). It corresponds to the SIGMA result. (If
CRT_TOT is negative, it’s taken as zero)
Therefore, values for the total criterion larger than one indicate that the section does not
pass as valid for this code.
Sd ≤ S
Where:
Sd Reinforcement spacing closest to the fiber in tension (option in the Checking menu)
CivilFEM checks this condition by applying the general calculation method for the
reinforcement spacing (Art. 10.6.4):
40
S = 15 ( ) − 2.5 ∙ Cc
fs
40
S ≤ 12
fs
where:
fs Calculated stress in reinforcement at service loads (in ksi).
The calculation of the stresses is an iterative process in which the program searches for the
deformation plane that causes a stress state that is in equilibrium with the external loads.
The reinforcement stress is obtained from this deformation plane and from the
reinforcement position.
If the loads acting on the cross section cause collapse under axial plus bending checking, the
cross section and the element to which it belongs are marked as non checked.
1 Upper fiber.
-1 Lower fiber.
1 Upper fiber.
-1 Lower fiber.
For the cracking check (sd > 0) the total criterion is defined as:
Sd
CRT_TOT =
S
For decompression checking (sd = 0) the total criterion is defined as:
fc + σmax
CRT_TOT =
fc
where
σmax Maximum section stress (positive tension), corresponding to the SIGMA result. (If
CRT_TOT is negative, it is taken as zero)
Therefore, the values for the total criterion larger than one indicate that the section is not
considered valid for this code.
6.1. Introduction
Checking and reinforcement designing of reinforced concrete beams in CivilFEM is available
for structures formed by 2D and 3D beam elements under axial loading plus biaxial bending,
axial loading plus bending (particular case), shear, torsion and combined shear and torsion.
The check and design process of reinforced concrete beams under axial loading plus biaxial
bending is based on the 3D interaction diagram of the analysed transverse section. This 3D
interaction diagram contains forces and moments (FX, MY, MZ) corresponding to the
sections ultimate strength states. Using this diagram, the program is able to check and
design the section accounting for forces and moments previously obtained that act on the
section. This process considers both generic sections and sections formed by different
concretes and reinforcement steels.
The codes CivilFEM considers for the checking and design of reinforced beams subjected to
axial force and biaxial bending are: ACI 318, EHE, Eurocode 2, ITER Design code, British
Standard 8110, Australian Standard 3600, CEB-FIP 1990 model code, the Chinese code
GB50010, NBR6118, AASHTO Standard Specifications for Highway Bridges, Russian Code СП
52-101-03, Indian Standard IS 456 and ACI 349.
The “Pivot” concept is related to the limit behavior of the cross section with respect to steel
and concrete material characteristics.
A pivot is a strain limit associated with a material and its position in the section. If the strain
in a section’s pivot exceeds the limit for that pivot, the section will be considered as cracked.
Thus, pivots establish the positions of the strain plane. In an ultimate strength state, the
strain plane supports at least one pivot of the section.
In CivilFEM, pivots are defined as material properties and these properties (pivots) are
extrapolated to all the section’s points, taken into account the material of each point.
Therefore, for the section’s strain plane determination, the following pivots and their
corresponding material properties will be considered:
A Pivot EPSmax. Maximum allowable strain in tension at any point of the section
(largest value of the maximum strains allowable for each point of the
section if there are different materials in the section).
section (largest value of the maximum strains allowable for each point of
the section).
Navier’s hypothesis is assumed for the determination of the strains plane. The strain’s plane
is determined according to the following equation:
ε(y, z) = εg + K z y + K y z
where:
Kz Curvature in Z axis.
Ky Curvature in Y axis.
In CivilFEM, the three elements g, Kz, Ky are substituted by the elements εg , θ, K to
determine the strain plane. The relationship between (Kz, Ky) and (, K) is the following:
K y = K·cos()
K z = K·sin()
= Angle of the neutral axis with respect to the section’s Y axis
1. Values of εg and are chosen arbitrarily inside the extreme values allowed for these
variables, which are:
EPSmin (B pivot ) < εg <EPSmax (A pivot)
-180º +180º
If there is no A pivot, (if there is no reinforcement steel or if ACI, AS3600 or BS8110 codes
are used) the tension limit does not exist and is considered infinite.
2. From the angle , the program can identify which points are inside and outside the
nucleus of the section.
3. Once the interior and exterior points are known, the two extreme admissible strains,
EPSmin and EPSmax, are defined in each of the points (for each point based on its
material).
4. For each point of the section, the minimum ultimate strength curvature (K) is
calculated.
5. The K curvature will be adopted as the minimum of all the curvatures of all the
section points, according to the condition K 0.
6. From the obtained K curvature and g (strain imposed in the section’s center of
gravity), the deformation corresponding to each of the section points (x, y), is
determined using the equations shown previously.
7. From the (x, y) strain, the stress corresponding to each point of the section (p) is
calculated and entered into the stress-strain diagram for that point. Through this
method, the stress distribution inside the section is determined.
8. Thus, as the elements (εg, θ, K) are determined, the ultimate forces and moments
(FX, MY, MZ) corresponding to the g strain and the angle defined in step 1 are
obtained by the summation of stresses at each of the section’s points multiplied by
its corresponding weight.
NP
FX = ∑ WFxp ∙ σp
1
NP
MY = ∑ WMyp ∙ σp
1
NP
MZ = ∑ WMzp ∙ σp
1
Note: For the design process, two components of forces and moments will be calculated: the
component relating to the fixed points (corresponding to the reinforcement defined as fixed
and to the concrete) and the component relating to the scalable points (corresponding to
the part of the section reinforcement defined as scalable, see Chapter 4.6.). The final forces
and moments will be equal to the sum of the forces and moments of both components. The
forces and moments due to the component for scalable points will be multiplied by the
reinforcement factor ().
9. Steps 1 to 8 are repeated, adjusting the g and values and calculating the
corresponding ultimate force and moments (FX, MY, MZ). Each defined couple (g
and ) represents a point in the 3D interaction diagram of the section. The greater
the number of g and values used (inside the interval specified in step 1), the larger
of the number of points in the diagram, and therefore the accuracy of the diagram
will increase.
With all of the 2D points previously obtained, the program constructs the interaction
diagram by calculating the convex hull of these points. Once the convex hull is calculated,
the “convexity criterion” of the diagram is determined; this criterion is the minimum of the
criteria calculated for all the points of the diagram. The ideal value of the convexity criterion
of the diagram is 1. In CivilFEM, it is not recommended to perform the check and design
described above with interaction diagrams whose convexity criterion is less than 0.95.
It has been proven that the interaction diagram of sections composed by materials whose
stress-strain law (for sections analysis) presents a descending branch has a very low
convexity criterion. The check and design process with the diagram of these sections may
lead to unsafe solutions. Therefore, it is NOT RECOMMENDED to use materials with this
characteristic.
To avoid these situations, CivilFEM changes the axes, placing the origin of the coordinate
system inside the geometric center of the diagram. In this case, the calculation of the safety
criterion is executed according to the new coordinate’s origin instead of the real origin.
If these changes are not made, safety forces and moments (in the diagram interior) could
have a safety factor less than 1.00 and vice versa. If the coordinate’s origin is close to the
diagram’s surface (although still inside), it will also be necessary to change the origin
coordinates. In these cases, although the safety factors maintain values greater than 1.0 for
safe sections and less than 1.0 for unsafe ones, they may adopt arbitrary values not very
related to the section’s real safety factor.
Therefore, CivilFEM establishes a criterion to determine whether to use the real coordinate
system origin or a modified one as a reference. Thus, if the following condition is fulfilled,
the origin of the coordinates will be modified, moving the diagram’s real center to its
geometric center.
Diameter
Distance ≤ Delta ∙
2
Where:
Distance Minimum distance from any point of the diagram to the real
coordinate system origin.
Delta Variable parameter which may be defined inside the [0,1] range. By
default Delta=0.05.
Diameter Diagonal of the rectangle which involves the diagram surface points.
6.2.4. Considerations
- The selection of the strains values at the origin of the section (g) inside the interval
(EPSmin, EPSmax) for each adopted angle of the neutral axis () is made uniformly
spaced for sections with reinforcements below the center of gravity (bottom
reinforcement). Half of it is distributed in the tension zone and the other half in the
compression zone, avoiding a concentration of points in the ultimate tension zone and
obtaining an even distribution of points.
- If the section does not have bottom reinforcement for each or the reinforcement does
not have pivot (EPSmax) (as in the case of the ACI or BS8110 codes), the distribution of
the tension zone is hyperbolic. The compression zone will continue to have uniform
distribution. By default the number of the values adopted by g is 30. The number of
values must be a multiple of 2.
- At the same time, the selection of the values is also uniform, inside the interval (-180º,
+180º). The number of values must be a multiple of 4 in order to embrace the 4
quadrants of the section. By default, the number of values adopted by the program is
28.
- Although the number of the values of g and used for the construction of the diagram
can be defined by the user, it is recommended to choose numbers close to the default
values. These values have been chosen in consideration of the calculation time and
precision. If a number of values for either variable is a great deal higher than the default
value, the processing time increases significantly.
On the other hand, if the number of values of g and is reduced significantly, the precision
in the calculation of the diagram may be affected.
1. Obtaining the acting forces and moments of the section (FXd, MYd, MZd). The acting
forces and moments are obtained, following a calculation, directly from the CivilFEM
results file (file .RCF).
2. Constructing the interaction diagram of the section. The ultimate strain state is
determined such that the ultimate forces and moments are homothetic to the acting
forces and moments with respect to the diagram center.
Obtaining the strength criterion of the section. This criterion is defined as the ratio between
two distances. As shown above, the distance to the “center” of the diagram (point A of the
figure) from the point representing the acting forces and moments (point P of the figure) is
labeled as d1 and the distance to the center from the point representing the homothetic
ultimate forces and moments (point B) is d2.
d1
Criterion =
d2
If this criterion is less than 1.00, the forces and moments acting on the section will be
inferior to its ultimate strength, and the section will be safe. On the contrary, for
criterion larger than 1.00, the section will not be considered as valid.
Criterion > 1
NOT OK elements
Interaction Diagram, it includes all the necessary information for checking as well as
design. Effects of actions, ultimate strength, safety information, as well as strength
with and without reinforcement can be seen. The criterion provided is the ratio
between the distances of the center of the diagram to the design loads point and the
center of the diagram to the ultimate strength.
1. Obtaining the minimum and maximum reinforcement factors. The maximum and
minimum reinforcement factors (max ,min) are introduced by the user. The designed
reinforcement of the section will always be more than min times and less than max
times the initial distribution.
2. Obtaining the reinforcement data of the section. The reinforcements of the section to
be designed must be defined by the class (only reinforcements defined as scalable are
modified), type, position and initial amount (see Chapter 4.4). The designed
reinforcement will be homothetic to the one defined in the section, in such a way that it
complies with the strength requirements of the section. If the reinforcement amount is
null, the program will not perform the design.
3. Obtaining the forces and moments acting on the section. Forces and moments
(Fx , My , Mz ) acting on the section are obtained directly from the CivilFEM results file (file
.RCF).
4. Constructing the 2D interaction diagram. The diagram of the section is constructed for
reinforcement corresponding to min times the initial distribution to determine the
ultimate forces and moments of the section with this configuration.
(FX, MY, MZ)real = (FX, MY, MZ)fixed + ωmin∙ (FX, MY, MZ)scalable
5. From the interaction diagram of the previous step the ultimate strain state homothetic
to the acting forces and moments can be determined with respect to the diagram
center.
6. Obtaining the strength criterion of the section. This criterion is determined following the
same process as described in the checking section.
7. If the value of the criterion is less than 1.00 (the forces and moments acting on the
section are inferior to its ultimate strength), the section will be assigned reinforcement
equal to ωmin times the initial distribution and the calculation will be terminated.
8. Repetition of steps 4, 5 and 6 for a reinforcement corresponding to ωmax times the
initial reinforcement distribution.
(FX, MY, MZ)real = (FX, MY, MZ)stationary + ωmax∙ (FX, MY, MZ)scalable
9. If the value of the strength criterion of the section is more than 1.00 (acting forces are
larger than the ultimate strength of the section), the program will indicate it is not
possible to design the section and will not assign reinforcement nor will it continue
calculating.
10. Optimization of the section reinforcement through successive iterations. From the
forces and moments previously determined (FX, MY, MZ)fixed and (FX, MY, MZ)scalable, a
search is done to obtain a reinforcement factor that will produce a value of the
section criterion between 0.99 and 1.01. The program will then assign reinforcement
equal to times the initial distribution of the section.
Design Total Criterion, elements with values equal to unity means that those
elements were designed and a reinforcement factor was found within the provided
range of ωmin and ωmax.
Designed elements
Not
Designed elements
Reinforcement factor, depending on the range of ωmin and ωmax provided, different
results appear:
1) Obtained reinforcement factor is inside (ωmin ,ωmax), then REINFACT value times
the defined reinforcement amount gives the needed reinforcement.
2) ωmax is smaller than the reinforcement factor obtained, then REINFACT = 2100 for
those elements.
3) ωmin is greater than the reinforcement factor obtained, then REINFACT = ωmin for
those elements.
REINFACT = -1
REINFACT >1
Designed elements
REINFACT = -1
If CivilFEM is not able to design reinforcement with considered section, materials and initial
reinforcement amount, then 2100 values will appear.
Total scalable reinforcement (SCALAREA): This option gives the the product of the
REINFACT previously obtained and the total scalable area of all reinforcement groups
defined as scalable:
𝑆𝐶𝐴𝐿𝐴𝑅𝐸𝐴 = 𝑅𝐸𝐼𝑁𝐹𝐴𝐶𝑇 × 𝑇𝑜𝑡𝑎𝑙 𝑠𝑐𝑎𝑙𝑎𝑏𝑙𝑒 𝑟𝑒𝑖𝑛𝑓𝑜𝑟𝑚𝑒𝑛𝑡 𝑎𝑟𝑒𝑎
The user should note that reinforcement defined as Fixed will not be included in the
calculation. If REINFACT is 2100 , SCALAREA will also be assigned the value 2100 .
Codes provided by CivilFEM for the check and design of reinforced concrete beams under
axial load and biaxial bending include: Eurocode 2, ITER Design code, Spanish code EHE,
American codes ACI 318 and ACI 349, British Standard 8110, Australian Standard 3600, CEB-
FIP model code, Chinese code GB50010, Brazilian code NBR6118, AASHTO Standard
Specifications for Highway Bridges and ITER Structural Design Code for Buildings.
The strain limits defined hereafter are default values, but can be changed for each of the
materials defined in the model.
If concrete has fck > 50 𝑀𝑃𝑎 , the concrete strain limits are the following:
If concrete has fck > 50 MPa, the concrete strain limits are the following:
steel (EPSmax), considering the section does not fail due to reinforcement steel
deformation.
The theoretical values of the interaction diagram are affected by the strength reduction
factor according to Chapter 9.3 of Building Code Requirements for Structural Concrete
Structures (ACI 318-05) document:
Φ = Φc εt ≤ 0.002
1000
Φ = Φc + (εt − 0.002)(0.90 − Φc ) 0.002 < εt < 0.005
3
Φ = 0.90 εt ≥ 0.005
Where t is the maximum strain obtained at the reinforcement and c is the strength
reduction factor for compression controlled sections:
The theoretical values of the interaction diagram are affected by the strength reduction
factor according to Chapter 21.2.2 of Building Code Requirements for Structural Concrete
Structures (ACI 318-14) document
Φ = Φc εt ≤ 0.002
1000
Φ = Φc + (εt − 0.002)(0.90 − Φc ) 0.002 < εt < 0.005
3
Φ = 0.90 εt ≥ 0.005
Where t is the maximum strain obtained at the reinforcement and c is the strength
reduction factor for compression controlled sections:
The theoretical values of the interaction diagram are affected by the strength reduction
factor according to Chapter 9.3 of Code Requirements for Nuclear Safety Related Concrete
Structures (ACI 349-01) document:
Φ = 0.90 Pn > 0
Pn
Φ = 0.90 − (0.90 − Φc ) ∙ 0 ≤ Pn ≤ Pa
Pa
Φ = Φc Pn < Pa
Ag
Pa = −0.10 ∙ fc ′ ∙
Φc
Where Pn is the axial load (tension positive), Ag is the concrete gross area and Φc is the
strength reduction factor for compression controlled sections:
Furthermore, according to Chapter 10.3.5 of Code Requirements for Nuclear Safety Related
Concrete Structures (ACI 349-01) document, design axial strength φPn of compression
members must not be greater than:
The theoretical values of the interaction diagram are affected by the strength reduction
factor according to Chapter 9.3 of Code Requirements for Nuclear Safety-Related Concrete
Structures (ACI 349-06) document:
Φ = Φc εt ≤ 0.002
1000
Φ = Φc + (εt − 0.002)(0.90 − Φc ) 0.002 < εt < 0.005
3
Φ = 0.90 εt ≥ 0.005
Where t is the maximum strain obtained at the reinforcement and c is the strength
reduction factor for compression controlled sections:
Furthermore, according to Chapter 10.3.6 of Code Requirements for Nuclear Safety Related
Concrete Structures (ACI 349-06) document, design axial strength φPn of compression
members must not be greater than:
The theoretical values of the interaction diagram are affected by the strength reduction
factor according to Chapter 9.3.2 of Code Requirements for Nuclear Safety-Related
Concrete Structures (ACI 349-13) document:
Φ = Φc εt ≤ 0.002
1000
Φ = Φc + (εt − 0.002)(0.90 − Φc ) 0.002 < εt < 0.005
3
Φ = 0.90 εt ≥ 0.005
Where t is the maximum strain obtained at the reinforcement and c is the strength
reduction factor for compression controlled sections:
Furthermore, according to Chapter 10.3.6 of Code Requirements for Nuclear Safety Related
Concrete Structures (ACI 349-13) document, design axial strength φPn of compression
members must not be greater than:
6.5.8. CEB-FIP
If the active code is CEB-FIP, the strain states relative to concrete and reinforcement steel
are those defined in the following figure:
The theoretical values of the interaction diagram are affected by the strength reduction
factor . This value is taken from the member properties.
The theoretical values of the interaction diagram are affected by the strength reduction
factor .
ϕ = 0.70 εt ≤ 0.002
200
ϕ = 0.70 + (εt − 0.002) 0.002 < εt < 0.005
3
ϕ = 0.90 εt ≤ 0.005
For AASHTO (according to chapter 5.5.4.2 from AASHTO LRFD Bridge Design Specifications):
It can be noted that there is no pivot relative to steel (EPSmax), considering the section does
not fail due to reinforcement steel deformation.
T Yes No No
For each one of these sections and directions, a set of geometrical parameters in accordance
with the code is automatically defined. These parameters are required for the calculating
process. Later on, there is a detailed explanation on how to obtain these parameters for
each valid section.
BW_VY: Minimum width of the section over the effective depth for
shear in Y.
BW_VZ: Minimum width of the section over the effective depth for
shear in Z.
Asl
ρ1 = < 0.02
bw d
Where:
d Effective depth.
A
T=
u
Where:
BW_VY: Web width or diameter of circular section for shear in Y (Art. 11.1).
BW_VZ: Web width, or diameter of circular section for shear in Z (Art. 11.1).
ACP: Area enclosed by outside perimeter of concrete cross section (Art. 11.6.1).
BS 8110
X1: Minimum dimension of the rectangular torsion stirrups (Art.2.4.2 Part 2).
Y1: Maximum dimension of the rectangular torsion stirrups (Art.2.4.2 Part 2).
GB 50010
BW_VY: Minimum width of the section over the effective depth for shear in Y (Art.
7.5.1).
BW_VZ: Minimum width of the section over the effective depth for shear in Z (Art.
7.5.1).
Acor : Area enclosed within the hoop reinforcements for torsion A st1 (Art. 7.6.4).
Acor1 : Area enclosed within the hoop reinforcements for torsion Ast1 (Art. 7.6.4) of
branch 1(e. x. Flange).
Acor2 : Area enclosed within the hoop reinforcements for torsion Ast1 (Art. 7.6.4) of
branch 2(e. x. Flange).
ALF: Ratio of the web depth to the web width (Art. 7.6.1).
ALFh : Affected factor of the thickness of web for torsion (Art. 7.6.6).
BW_VY: Web width or diameter of circular section for shear in Y (Art. 8.15.5).
BW_VZ: Web width or diameter of circular section for shear in Z (Art. 8.15.5).
ACP: Area enclosed by outside perimeter of concrete cross section (taken from
ACI 318 Art. 11.6.1).
PCP: Outside perimeter of the concrete cross section (taken from ACI 318 Art.
11.6.1).
AO: Gross area enclosed by shear flow path (taken from ACI 318 Art. 11.6.3).
EHE
BW_VY: Width of element in VY direction equal to the total width in solid sections or
in case of box sections, the width equals the sum of the width of both webs.
BW_VZ: Width of element in VZ direction equal to the total width in solid sections or
in case of box sections, the width equals the sum of the width of both webs.
As
ρ1 = < 0.02
bw d
Where:
d Effective depth.
A
he =
u
Where:
This equivalent thickness cannot be greater than the real thickness of the
wall nor less than twice the cover.
AE: Area inside the center-line of the design effective hollow section (Art.
45.2.2).
UE: Perimeter of the center-line of the design effective hollow section (Art.
45.2.2).
KEYAST: Indicator of the position of the torsion reinforcement in the section (Art.
45.2.2.1):
=0 if closed stirrups are placed on both faces of each wall of the equivalent
hollow section or of the real hollow section (value by default for hollow
sections).
= 1 if there are only closed stirrups distributed around the periphery of the
member (value by default for solid sections).
THETA: Angle of the concrete compressive struts with the longitudinal axis of
member (Art. 44.2.3).
Y 2
1 3
Z
TKY
TKZ
AO = 0.85 AOH
BS 8110
REC = 0.05 m (by default)
BW_VY = Tkz BW_VZ = Tky
DY = Tky − REC DZ = Tkz − REC
AS = 0.002 ∙ Ac 1
Xw = [h2min ∙ (hmax − hmin /3)]
Ac = concrete gross area 2
hmin =MIN(Tky, Tkz)
hmax = MAX(Tky, Tkz)
EHE
REC = 0.04 m(by default)
BW_VY = Tkz BW_VZ = Tky
DY = Tky − REC DZ = Tkz − REC
RHO1 = 0.0028 Tky ∙ Tkz
HE = ≥ 2 ∙ REC
2(Tky + Tkz)
AE = (Tky − HE) ∙ (Tkz − HE) UK = 2[(Tky − HE) + (Tkz − HE)]
KEYAST = 1(outer reinforcement). THETA = 45O
GB50010
DZ DY ALFh = 1.0
ALF = max ( , )
Tky Tkz
AO = 0.85 AOH
TWY Y 2
1 5 8 3
Z
TKY
7
TWZ
6
TKZ
AO = 0.85 AOH
BS8110
REC = 0.05 m(by default)
BW_VY = 2 ∙ Twz BW_VZ = 2 ∙ Twy
DY = Tky − REC DZ = Tkz − REC
AS = 0.002 ∙ Ac Xw is considered solid rectangular if Twy >
Ac = gross concrete area 0.25Tky and Twz > 0.25Tkz. Otherwise: Xw =
2.MIN(Twy,Twz).(Tkay,Twy).(Tkz,Twz)
X1 = MIN(Tky,Tkz) – 2.REC Y1 = MAX(Tky,Tkz) – 2.REC
EHE
REC = 0.04 m(by default)
BW_VY = 2 ∙ Twz BW_VZ = 2 ∙ Twy
DY = Tky − REC DZ = Tkz − REC
RHO1 = 0.0028 Tky ∙ Tkz
HE =
2(Tky + Tkz)
GB50010
REC = 0.05 m (by default)
AO = 0.85 AOH
BS8110
REC = 0.05 m (by default)
BW_VY = Tkz BW_VZ = Tky
DY = Tky - REC DZ = Tkz - REC
AS = 0.002.Ac π ∙ OD3
Ww =
16
X1 = OD – 2.REC Y1 = OD – 2.REC
EHE
OD 2 OD + REC 2 OD 2 OD + REC 2
√
BW_VY = 2 ( ) − ( ) √
BW_VZ = 2 ( ) − ( )
2 4 2 4
DY = OD - REC DZ = OD - REC
RHO1 = 0.0028 OD
HE = ≥ 2 ∙ REC
4
π (OD−HE)2 UE = π(OD − HE)
AE = 4
KEYAST = 1 (outer reinforcement) THETA = 45º
GB50010
REC = 0.05 m (by default)
BW_VZ = 0.88·OD BW_VY = 0.88·OD
DY = 0.8·OD DZ = 0.8·OD
HW_VY = 0.8·OD HW_VZ = 0.8·OD
ALFh = 1.0
Z 2 TKWALL
(In both directions the distance from extreme compression fibre to centroid of reinforcement in the
opposite half of the section is used, assuming that this reinforcement is uniformly distributed and
considering the cover of REC.)
OD2 PCP = π ∙ OD
ACP = π ∙
4
(OD − 2 ∙ REC)2 PH = π(OD − 2 ∙ REC)
AOH = π ∙
4
AO = 0.85 AOH
BS 8110
REC = 0.04 m (by default)
BW_VY = 2 · TKWALL BW_VZ = 2 · TKWALL
DY = OD - REC DZ = OD - REC
.
AS = 0.002 Ac XW is considered a solid circular section if
(Tkwall > 0.25.OD)
Otherwise:
π[OD4 − (OD − TKwall)4 ]
Xw =
16 ∙ OD
X1 = OD - 2.REC Y1 = OD – 2.REC
EHE
OD 2 OD + REC 2
BW_VY = 2√( ) − ( ) < 2 ∙ 𝑇𝐾𝑊𝐴𝐿𝐿
2 4
OD 2 OD + REC 2
BW_VZ = 2√( ) − ( ) < 2 ∙ 𝑇𝐾𝑊𝐴𝐿𝐿
2 4
DY = OD - REC DZ = OD - REC
RHO1 = 0.0028 OD
HE =
4
HE ≥ 2 ∙ 0.04 m ; HE ≤ TKWALL
π (OD−HE)2 UE = π(OD − HE)
AE = 4
KEYAST = 0 (outer and inner reinforcement). THETA = 45º
GB50010
REC = 0. 05 m (by default)
BW_VY = 2 ·TKWALL BW_VZ = 2 ·TKWALL
DY = 0.8·OD DZ = 0.8·OD
HW_VY = not defined HW_VZ = not defined
TKWALL
ALFh =
OD
OD OD
OD 4 ( 2 + REC) OD 4 ( 2 + REC)
DY = + DZ = +
2 3π 2 3π
(In both directions the distance from extreme compression fibre to centroid of reinforcement
in the opposite half of the section is used, assuming that this reinforcement is uniformly
distributed and considering the cover of REC.)
OD2 PCP = π ∙ OD
ACP = π ∙
4
(OD − 2 ∙ REC)2 PH = π(OD − 2 ∙ REC)
AOH = π ∙
4
AO = 0.85 AOH
BFTOP
Z 1
TFTOP
TW DEPTH
TFBOT 2
BFBOT
BS 8110
REC = 0.04 m (by default)
BW_VY = Tkz BW_VZ = undefined
DY = Tky - REC DZ = Tkz - REC
AS = 0.002.Ac XW = undefined
Ac = concrete gross section
X1 = undefined Y1 = undefined
EHE
GB50010
REC = 0.04 m (by default)
Acor = (DEPTH − 2 ∙ REC) ∙ (TW − 2 ∙ REC) Acor1 = (TFTOP − 2 ∙ REC) ∙ (BFTOP − TW − 2 ∙ REC
BF
Z 1
TF
DEPTH
TW
2
EHE
BS 8110
REC = 0.05 m (by default)
BW_VY = Tkz BW_VZ = undefined
DY = Tky - REC DZ = Tkz - REC
.
AS = 0.002 Ac XW = undefined
Ac = concrete gross section
X1 = undefined Y1 = undefined
GB50010
REC = 0.05 m (by default)
BW_VY = TW BW_VZ = TF
Acor = (DEPTH − 2 ∙ REC) ∙ (TW − 2 ∙ REC) Acor1 = (TF − 2 ∙ REC) ∙ (BF − TW − 2 ∙ REC)
2) Obtaining geometrical data of the section. Required data for shear checking are the
following ones:
Ac total cross-sectional area of the concrete section.
Asl the area of the tension reinforcement extending not less than d + Ib,net
beyond the section considered.
angle of the compressive struts of concrete with the member’s longitudinal
axis, (parameter THETA):
1.0 ≤ cotan ≤ 2.5 Eurocode 2 (EN 1992-1-1:2004/AC:2008)
1.0 ≤ cotanθ ≤ cotanθ0 ITER Design Code
Compressive mean stress (σcp > 0): cotan θ0 = 1.2 + 0.2 σcp /fctm
Tensile mean stress (σcp < 0): cotan θ0 = 1.2 + 0.9 σcp /fctm ≥ 1
Section 6.6.1. provides detailed information on how to calculate the required data for
each code and valid section.
Asw total area of the reinforcement legs, (parameters ASY or ASZ, both Y and Z
directions are available).
s spacing of the stirrups.
or with the following ones:
Force Description
VEd ≤ VRd,c
VRd,c = [CRd,c ∙ k ∙ (100ρl ∙ fck )1/3 + k1 ∙ σcp ] ∙ bw ∙ d
where:
CRd,c = 0.18 γc
fck = in MPa
200
k = 1+√ ≤ 2 (d en mm)
d
k1 = 0.15
NEd
σcp = < 0.2fcd Mpa
Ac
Ac in mm2
f
𝜈 = 0.6 (1 − ck ) Eurocode 2 (EN 1992-1-1:2004/AC:2008)
250
VRd,c in N
If shear reinforcement has not been defined for the section, a check is made to ensure VEd is
less than the lowest value between the shear reinforcement resistance,
Asw
VRd,s = ∙ 0.9 ∙ d ∙ fywd ∙ (cotanθ + cotanα) ∙ sinα
s
and the maximum design shear reinforcement resistance:
(cotanθ + cotanα)
VRd,max = αcw ∙ bw ∙ 0.9 ∙ d ∙ ν ∙ fcd ∙
1 + cotan2 θ
(cotanθ0 + cotanα)
VRd,max = αcw ∙ ν ∙ fcd ∙ bw ∙ 0.9 ∙ d ∙
1 + cotan2 θ0
Where :
σcp
1+ , if 0 < σcp ≤ 0.25fcd
fcd
αcw = 1.25, if 0.25fcd < σcp ≤ 0.5fcd
σcp
2.5 (1 − ) , if 0.5fcd < σcp ≤ fcd
{ fcd
Asw,max fcd
= 0.5 ∙ αcw ∙ bw ∙ ν ∙ /sinα
S fywd
Results are written for each end in the CivilFEM results file as the following parameters:
VRDC = VRd,c
VRDS = VRd,s
VRDMAX = VRd,max
MEd VEd
TENS = + (cotθ − cotα)
0.9d 2
VEd
CRT_1 =
VRd,c
7) Obtaining shear criterion. The shear criterion indicates whether the section is valid
for the design forces (if it is less than 1, the section satisfies the code provisions;
whereas if it exceeds 1, the section will not be valid). Furthermore, it includes
information pertaining to how close the design force is to the ultimate section
strength. The shear criterion is defined as follows:
CRT_TOT = VEd If there is no shear reinforcement
,
VRd,c
V
min {V Ed , max {V Ed
V If there is shear reinforcement
Rd,c Rd,s
VEd
}},
VRd,max
A value of 2100 for this criterion indicates that VRd2,red or VRd3 are equal to zero.
1) Obtaining strength properties of the materials. These properties are obtained from
the material properties associated to the transverse cross section and for the active
time.
Tensile mean stress (σcp < 0): cotanθ0 = 1.2 + 0.9σcp /fctm ≥ 1
Section 6.6.1. provides detailed information on how to calculate the required data for
each code and valid section.
Transverse reinforcement
Asw /S area of transverse reinforcement per unit length.
The reinforcement ratio can alternatively be defined using the following data:
Longitudinal Reinforcement
Asl total area of the longitudinal reinforcement.
The reinforcement ratio can alternatively be defined using the following data:
4) Obtaining section internal forces and moments. The torsional moment that acts on
the section is obtained from the CivilFEM results file (.RCF).
Moment Description
Asw
tan2 θ = S
Asl
Uk
This angle must satisfy the following condition:
If the angle obtained does not satisfy this condition, the value of the nearest limit is
adopted.
When evaluating TRd,max , three reinforcement cases exist. For a section with no torsion
reinforcement, cotanis defined by the user within the previous limits. If the section
only contains transverse reinforcement, cotan =1.0, and if it contains only longitudinal
reinforcement, cotan = 2.5. Obviously, in these cases the section will not satisfy torsion
checking.
6) Calculating the maximum torsional moment that can be resisted by the concrete
compressive struts. The design torsional moment (Tsd ) must be less than or equal to
the maximum torsional moment that can be resisted by the concrete compressive
struts (TRd,max ); therefore, the following condition must be fulfilled:
TEd ≤ TRd,max
TRd,max = 2 ∙ ν ∙ αcw ∙ fcd ∙ t ∙ Ak ∙ sinθ ∙ cosθ
Where the values de of ν and αcw are the same as those used in shear checking,
Results are written in the CivilFEM results file for both element ends as the parameters:
TRDMAX = TRd,max
TEd
CRT_1 = T
Rd,max
TEd ≤ TRd
Asw
TRd = 2Ak (fyd ∙ ) cotanθ
S
Calculation results are written in the CivilFEM results file for both element ends as the
parameters:
TRD = TRd
TEd
CRT_2 =
TRd
If transverse reinforcement is not defined, TRd2 = 0 and the criterion will take the value
of 2100.
Uk
Asl,nec = TRd cotanθ
2Ak fyd
If longitudinal reinforcement is not defined, Asl = 0 and the criterion will be 2100.
ALT = Asl,nec
Asl,nec
CRTALT = Asl
9) Obtaining torsion criterion. The torsion criterion is defined as the ratio of the design
moment to the section ultimate resistance: if it is less than 1, the section is valid;
whereas if it exceeds 1, the section is not valid. The criterion pertaining to the validity
for torsion is defined as follows:
A value 2100 for this criterion indicates that any one of the torsion reinforcement groups
are undefined.
1) Torsion checking considering a null shear force. This check follows the same
procedure as for the check of elements subjected to pure torsion according to
Eurocode 2 (EN 1992-1-1:2004/AC:2008) and ITER Design Code.
2) Shear checking assuming a null torsional moment. . This check follows the same
steps as for the check of elements subjected to pure shear according to Eurocode 2
(EN 1992-1-1:2004/AC:2008) and ITER Design Code.
3) Checking the concrete ultimate strength condition. The design torsional moment
(TSd ) and the design shear force (VSd ) must satisfy the following condition:
TEd VEd
+ ≤1
TRd,max VRd,max
4) Obtaining the combined shear and torsion criterion. This criterion comprehends
pure shear, pure torsion and ultimate strength condition criteria of concrete. The
criterion determines whether the section is valid and is defined as follows:
VEd VEd TEd TEd Asl,nec TEd VEd
CRT_TOT = max { , , , , , + }≤1
VRd,s VRd,max TRd,max TRd Asl TRd VRd
A value 2100 for this criterion indicates that VRd1,red or VRd3 are equal to zero or that one
of the torsion reinforcement groups has not been defined.
2) Obtaining geometrical data of the section. Required data for shear design are the
following:
Ac total cross-sectional area of the concrete section.
Asl
ρ1 = < 0.02
bw d
where:
Asl the area of the tensile reinforcement extending not less than d + Ib,net beyond
the section considered.
angle of the compressive struts of concrete with the member’s longitudinal
axis:
Tensile mean stress (σcp < 0): cotan θ0 = 1.2 + 0.9 σcp /fctm ≥ 1
Section 6.6.1. provides detailed information on how to calculate the required data for
each code and valid section.
member can be indicated. This angle should be included in the reinforcement definition
of each element. If this angle is nu ° is used. Other reinforcement
data will be ignored.
5) Obtaining forces and moments acting on the section. The shear force that acts on the
section as well as the concomitant axial force and bending moment, are obtained from
the CivilFEM results file (.RCF).
Force Description
VEd Design shear force
NEd Design axial force (positive for compression)
MEd Design bending moment ( 0)
6) Checking whether the section requires shear reinforcement. First, the design shear
(VEd ) is compared to the design shear resistance (VRd,c ):
VEd ≤ VRd,c
VRd,c = [CRd,c ∙ k ∙ (100 ρ1 ∙ fck )1/3 + k1 ∙ σcp ] ∙ bw ∙ d
with the constraints:
VEd ≤ 0.5bw ∙ d ∙ ν ∙ fcd
VRd,c ≥ [Vmin + k1 ∙ σcp ] ∙ bw ∙ d
where:
CRd,c = 0.18 γc
fck in MPa
k = 1 + √200 (d in mm)
d
Asl
ρ1 = ≤ 0.02
bw d
k1 = 0.15
NEd
σcp = < 0.2fcd MPa
Ac
Ac in mm2
ckf
0.6 (1 − 250 ) Eurocode 2 (EN 1992-1-1:2004/AC:2008)
VRd,c in N
Results are written for each element end in the CivilFEM results file as the parameters:
VRDC = VRd,c
VEd
CRT_1 =
VRd,c
7) Calculating the maximum shear force that can be resisted by the concrete compressive
struts.
A check is made to ensure that VEd is less than VRd,max :
(cotanθ + cotanα)
VRd,max = αcw ∙ bw ∙ 0.9 ∙ d ∙ ν ∙ fcd ∙
(1 + cotan2 θ)
(cotanθ0 + cotanα)
VRd max = αcw ∙ ν ∙ fcd ∙ bw ∙ d ∙
(1 + cotan2 θ0 )
where:
Results are written for each element end in the CivilFEM results file as the parameters:
VRDMAX = VRd,max
VEd
CRT_3 =
VRd,max
If design shear force is greater than the force required to crush the concrete
compressive struts, the reinforcement design will not be feasible, so the parameter
containing this datum will be marked with 2100.
If the struts are not crushed by oblique compression, the calculating process continues.
Asw VRd,s
=
S 0.9 ∙ d ∙ fywd ∙ (cotanθ + cotanα) ∙ sinα
While also satisfying the following condition (Eurocode 2 only):
Asw fcd
≤ 0.5 ∙ αcw ∙ bw ∙ ν ∙ /sinα
S fywd
If the design is not possible, the reinforcement will be defined as 2 100 and labeled as not
designed.
The design criterion will be 1 (Ok) if the element was designed or 0 (Not Ok) if not.
For each element end, the results are included in the CivilFEM results file as the
following parameters:
VRDS = VRd,s
Asw
ASSH =
S
DSG_CRT = Design criterion
1) Obtaining strength properties of the materials. These properties are obtained from
the material properties associated to each transverse cross section and for the active
time. Those material properties should be previously defined. The Required data are
as follows:
fyd design strength of shear reinforcement. The same material will be considered
for transverse and longitudinal reinforcement.
Tensile mean stress (σcp < 0): cotan θ0 = 1.2 + 0.9 σcp /fctm
Section 6.6.1. provides detailed information on how to calculate the required data for
each code and valid section.
3) Obtaining forces and moments acting on the section. The torsional moment that
acts on the section is obtained from the CivilFEM results file.
Moment Description
TEd Design torsional moment in I-section.
TEd ≤ TRd,max
TRd,max = 2 ∙ ν ∙ αcw ∙ fcd ∙ t ∙ Acd ∙ sinθ ∙ cosθ
Where the values ν and αcw are the same as the used previously.
Calculation results are written in the CivilFEM results file for both element ends as the
parameters:
TRDMAX = TRd,max
TEd
CRT_1 =
TRd,max
If the design torsional moment is greater than the moment required to crush the
concrete compressive struts, the reinforcement design will not be feasible. As a result,
the parameter for the reinforcement will contain a value of 2100.
Ast
ASTT = = 2100 for transverse reinforcement
S
Asw TEd
= tan θ
S 2 Ak fyd
The area of the designed transverse reinforcement per unit length is stored in the
CivilFEM results file as the parameter:
Asw
ASTT =
S
TEd Uk
Asl =
2 Ak fyd
The area of the designed longitudinal reinforcement is stored in the CivilFEM results file
as the parameter:
ASLT = Asl
If both transverse and longitudinal reinforcements are designed for both element
sections, this element will be labeled as designed.
Design criterion (DSG_CRT) is 1 (Ok) if the element was designed, 0 (Not OK) if not.
1) Torsion design considering a null shear force. This design follows the same steps as
for the design of elements subjected to pure torsion according to Eurocode 2 (EN
1992-1-1:2004/AC:2008) and ITER Design Code.
2) Shear design considering a null torsion force. This design is accomplished with the
same steps as for the design of elements subjected to pure shear according to
Eurocode 2 (EN 1992-1-1:2004/AC:2008) and ITER Design Code.
3) Checking concrete ultimate strength condition. The design torsional moment (TEd )
and the design shear force (VEd ) must satisfy the following condition:
TEd VEd
+ ≤1
TRd,max VRd,max
4) Obtaining required shear and torsion reinforcement ratios. If the concrete ultimate
strength condition is fulfilled (i.e. the concrete can resist the combined shear and
torsion action) the reinforcements calculated in steps 1 and 2 are taken as the
designed reinforcements. The element is then labeled as designed.
If the concrete ultimate strength condition is not fulfilled, the parameters corresponding
to each type of reinforcement will take the value of 2100.
The design criterion is 1 (Ok) if the element has been designed, and 0 if not.
Section 6.6.1. provides detailed information on how to calculate the required data for
each code and valid section.
Vc = 2√f′c bw d
where:
√f′c square root of specified compressive strength of concrete, in psi (always taken
as less than 100 psi).
For sections subject to a compressive axial force,
Nu
Vc = 2 (1 + ) √f′c bw d
2000 Ag
If section is subjected to a tensile force so that the tensile stress is less than 500 psi,
Nu
Vc = 2 (1 + ) √f′c bw d
2000 Ag
If the section is subjected to a tensile force so that the tensile stress exceeds 500 psi, it
is assumed Vc = 0.
The calculation result for both element ends is stored in the CivilFEM results file as the
parameter VC:
7) Calculating the shear strength provided by shear reinforcement. The strength provided
by shear reinforcement (Vs ) is calculated with the following expression:
As
Vs = f (sinα + cosα)d ≤ 8√f′c bw d
S y
where:
fy yield strength of the shear reinforcement (not greater than 60000 psi).
The calculation result for both element ends is stored in the CivilFEM results file as the
parameter VS:
8) Calculating the nominal shear strength of section. The nominal shear strength (Vn ) is the
summation of the provided by concrete and by the shear reinforcement:
Vn = Vc + Vs
This nominal strength as well as its ratio to the design shear are stored in the CivilFEM
results file as the parameters:
9) Obtaining shear criterion. The section will be valid for shear if the following condition is
fulfilled:
Vu ≤ ϕVn = ϕ(Vc + Vs )
φ strength reduction factor of the section. φ = 0.75 for shear and torsion
according to Chapter 9.3 of Building Code Requirements for Structural
Concrete Structures (ACI 318-05) document.
Vu
CRT_TOT = ≤1
ϕVn
For each element, this value is stored in the CivilFEM results file as the parameter
CRT_TOT.
If the strength provided by concrete is null and the shear reinforcement is not defined in
the section, then Vn = 0, and the criterion is equal to 2100.
1) Obtaining strength properties of the materials. These properties are obtained from the
material properties associated with each transverse cross section at the active time:
f′c specified compressive strength of concrete.
fyk specified yield strength of reinforcement.
2) Obtaining geometrical parameters depending on specified code. The required data are
as follows:
bw web width or diameter of circular section.
d distance from the extreme compression fiber to the centroid of the
longitudinal tensile reinforcement in Y, (for circular sections this should not be
less than the distance from the extreme compression fiber to the centroid of
the tensile reinforcement in the opposite half of the member).
The reinforcement ratio can alternatively be defined using the following data:
Longitudinal Reinforcement
Asl total area of the longitudinal reinforcement.
The reinforcement ratio can alternatively be defined using the following data:
4) Obtaining section’s internal forces and moments. The torsional moment that acts on
the section is obtained from the CivilFEM results file (.RCF).
Moment Description
5) Checking if torsion effects will be considered. Torsion effects are only considered if the
design torsional moment (Tu ) satisfies the condition below:
A2cp
Tu > 𝜙 (√f′c )
Pcp
If the design torsional moment is less than this value, its effects can be neglected and it
will be considered as null for checking.
Checking section dimensions. Section dimensions must satisfy the following
requirements:
Tu Ph Vc
√
2 ≤ ϕ (b d + 8 f′c )
1.7 Aoh w
In hollow sections, if the section wall’s thickness is less than Aoh /Ph, this value will be
replaced by the minimum thickness of the section in the previous formula.
The ratio of the two coefficients is stored in the CivilFEM results file for both element
ends as the parameter:
Tu Ph
1.7 A2oh
CRTTC =
V
ϕ ( c + 8√f′c )
bw d
6) Calculating the nominal torsional moment strength of the section. The nominal
torsional moment strength (Tn ) is evaluated with the following expression:
Ast
Tn = 2 Ac f
S y
where:
Ast
(Al )nec = P
S h
Calculation results are stored in the CivilFEM results file for both element ends as the
parameters:
7) Obtaining torsion criterion. The section will be valid for torsion if the following condition
is fulfilled:
Tu ≤ ΦTn
Asl ≥ (Al )nec
Tu Ph Vc
2 ≤ ϕ (b + 8√f′c )
1.7 Ach w d
φ strength reduction factor of the section, (0.75 for shear and torsion).
Tu Ph
Tu (Al )nec 1.7 A2oh
CRT_TOT = Max ( ; ; )≤1
ϕ Tn Asl V
( c + 8√f′c )
bw d
For each element end, this value is stored in the CivilFEM results file as CRT_TOT.
If the strength provided by concrete is null and the torsion reinforcement is not defined
in the section, the criterion will be 2100.
The ϕ ∙ Tn value is stored in the CivilFEM results file for both element ends as the
parameter TFI.
1) Checking if torsion effects will be considered. Torsion effects are only considered if the
design torsional moment (Tu ) satisfies the condition below:
A2cp
Tu > 𝜙 (√f′c )
Pcp
If the design torsional moment is less than this value, its effects can be neglected and it
is considered as null for checking.
2) Checking section dimensions. For shear force and the associated torsional moment,
section dimensions must satisfy the following requirements:
a) Solid sections:
2
Vu 2 Tu Ph Vc
√( ) +( 2 ) ≤ ϕ( + 8√f′c )
bw d 1.7 Aoh bw d
b) Hollow sections:
Vu Tu Ph Vc
( )+( 2 ) ≤ ϕ( + 8√f′c )
bw d 1.7Aoh bw d
In hollow sections, if the section wall’s thickness is less than Aoh /Ph , this value is
replaced in the expression above by the section’s minimum thickness.
The ratio between these two factors is stored in the CivilFEM results file for both
element ends.
a) Solid sections:
2 2
√( Vu ) + (Tu2Pn )
bw d Aoh
CRTTC =
Vc
ф( + 8√f′c )
bw d
b) Hollow sections:
Vu TP
+ u n
bw d 1.7 A2oh
CRTTC =
V
ф ( c + 8√f′c )
bw d
3) Checking for shear force with concomitant torsional moment. This check is
accomplished with the same steps as the check of elements subjected to pure shear
force according to ACI 318-05. The same results as for shear checking will be calculated.
Except for this check, the CRT_TOT criterion is stored in the CivilFEM results file as
CRTSHR for each element end.
4) Checking for torsion with shear force. This check follows the same steps considered for
the check of elements subjected to pure torsion according to ACI 318-05. The same
results as in torsion checking will be calculated.
Except for this check, the CRT_TOT criterion is stored in the CivilFEM results file as
CRTTRS for each element end.
5) Obtaining the combined shear and torsion criterion. This criterion determines whether
the section is valid or not. It is defined as follows:
Vu Tu (Al )nec
CRT_TOT = Max [ ; ; ; CRTTC] ≤ 1
ф Vn ф Tn Asl
For each end, this value is stored in the CivilFEM results file.
the shear strength provided by concrete is equal to zero and the shear
reinforcement has not been defined.
the shear strength provided by concrete is equal to zero and the transverse
torsion reinforcement has not been defined.
the longitudinal torsion reinforcement has not been defined.
Section 6.6.1. provides detailed information on how to calculate the required data for
each code and valid section.
6) Calculating the shear strength provided by concrete. The shear strength provided by
concrete (Vc ) is calculated with the following expression:
Vc = 2√f′c bw d
where:
√f′c square root of specified compressive strength of concrete, in psi (always taken
as less than 100 psi).
For sections subject to a compressive axial force,
Nu
Vc = 2 (1 + ) √f′c bw d
2000 Ag
If the section is subjected to a tensile force so that the tensile stress is less than 500 psi,
Nu
Vc = 2 (1 + ) √f′c bw d
500 Ag
If the section is subjected to a tensile force so that the tensile stress exceeds 500 psi, it
is assumed Vc = 0.
The calculation result is stored in the CivilFEM results file for both element ends as the
parameter:
Vu ≤ ϕ Vn = ϕ(Vc + Vs )
Therefore, the reinforcement shear resistance must satisfy:
Vu
Vs = − Vc ≤ 8√f′c bw d
ϕ
If the shear resistance of the reinforcement does not satisfy the expression above, the
section cannot be designed. As a result, the parameters for the reinforcement ratio will
be equal to 2100.
As
ASSH = = 2100
S
For this case, the element will be labeled as not designed.
Calculation results are stored in the CivilFEM results file for both element ends as the
parameter:
VS = Vs ≤ 8√f′c bw d
8) Calculating the required reinforcement ratio. Once the shear resistance of the
reinforcement has been obtained, the reinforcement can be calculated with the
following expression:
As Vs
=
S fy (sinα + cosα)d
Where:
As
ASSH =
S
In this case, the element will be labeled as designed (providing the design process is
correct for both element sections).
1) Obtaining strength properties of the materials. These properties are obtained from
the material properties associated with each transverse cross section at the active
time.
f′c specified compressive strength of concrete.
fyk specified yield strength of reinforcement.
2) Obtaining geometrical parameters depending on specified code. The required data
are as follows:
3) Obtaining forces and moments acting on the section. The torsional moment that
acts on the section is obtained from the CivilFEM results file (.RCF).
Moment Description
4) Checking if torsion effects will be considered. Torsion effects are only considered if
the design torsional moment (Tu ) satisfies the condition below:
A2cp
Tu > ф (√f′c )
Pcp
If the design torsional moment is less than this value, its effects can be neglected and it
is consider as null for the design.
For hollow sections, if the thickness of the section walls is less than Aoh /Ph, this value
will be replaced by the minimum thickness of the section in the equation above.
The torsion reinforcement will not be designed if the previous expression is not fulfilled;
consequently, the parameters for the reinforcement will be equal to 2100.
Ast
ASTT = = 2100 for transverse reinforcement
S
The ratio of the two coefficients is stored in the CivilFEM results file for both element
ends:
Tu Ph
1.7 A2oh
CRTTC =
V
ϕ ( c + 8√f′c )
bw b
At
Tu ≤ ϕ Tn = ϕ (2A0 f )
S y
At cross-sectional area of one leg of a closed stirrup resisting torsion.
s spacing of the stirrups.
At Tu
=
S ϕ 2 A0 fy
The area of designed transverse reinforcement per unit length is stored in the CivilFEM
results file for both element ends:
At
ASTT =
S
7) Calculating the required longitudinal reinforcement. The longitudinal reinforcement
area is given by the following expression:
At
Al = P
S h
The area of the designed longitudinal reinforcement is stored in the CivilFEM results file
for both element ends:
ASLT = Al
If transverse and longitudinal reinforcements are designed for both element ends, this
element will be labeled as designed.
1) Checking if torsion effects will be considered. Torsion effects are only considered if
the design torsional moment (Tu ) satisfies the condition below:
A2cp
Tu > 𝜙 (√f′c )
Pcp
If the design torsional moment is less than this value, its effects can be neglected and it
is considered as null for the design.
2) Checking section dimensions. For shear force and concomitant torsional moment,
section dimensions must satisfy the following requirements:
a) Solid sections:
2
V 2 TP V
√( u ) + ( u h2 ) ≤ ϕ ( c + 8√f′c )
bw d 1.7 Aoh bw d
b) Hollow sections:
Vu Tu Ph Vc
( )+( 2 ) ≤ ϕ( + 8√f′c )
bw d 1.7 Aoh bw d
For hollow sections, if the section wall’s thickness is less than Aoh /Ph, this value will be
replaced by the minimum thickness of the section in the expression above.
The torsion reinforcement will not be designed if the expression above is not fulfilled;
consequently, the parameters for the reinforcement will be equal to 2100.
Ast
ASTT = = 2100 for transverse reinforcement
S
The ratio of the two coefficients is stored in the CivilFEM results file for both element
ends.
a) Solid sections:
2 2
√( Vu ) + ( Tu Ph2 )
bw d 1.7 Aoh
CRTTC =
Vc
ϕ( + 8√f′c )
bw d
b) Hollow sections:
2 2
Vu TP
( ) + ( u h2 )
bw d 1.7 Aoh
CRTTC =
V
ϕ ( c + 8√f′c )
bw d
3) Shear design assuming a null torsional moment. This design follows the same
procedure as for the design of elements subjected to pure shear force according to
ACI 318-05.
4) Torsion design considering a null shear force. This design is accomplished with the
same steps as for the design of elements subjected to pure torsion according to ACI
318-05.
2) Obtaining geometrical data of the section. Required data for shear checking:
Ag area of concrete section.
Section 6.6.1. provides detailed information on how to calculate the required data for
each code and valid section.
Vc = 2λ√f′c bw d
where:
√f′c square root of specified compressive strength of concrete, in psi (always taken
as less than 100 psi).
For sections subject to a compressive axial force,
Nu
Vc = 2 (1 + ) 𝜆√f′c bw d
2000 Ag
If section is subjected to significant tensile force,
Nu
Vc = 2 (1 + ) 𝜆√f′c bw d
500 Ag
The calculation result for both element ends is stored in the CivilFEM results file as the
parameter VC:
As Vu
Vs = fy (sinα + cosα)d ≤ 8√f ′ c bw d and ≥ Vs = − V𝑐
S 𝜙
where:
fy yield strength of the shear reinforcement (not greater than 60000 psi).
The calculation result for both element ends is stored in the CivilFEM results file as the
parameter VS:
8) Calculating the nominal shear strength of section. The nominal shear strength (Vn ) is the
summation of the provided by concrete and by the shear reinforcement:
Vn = Vc + Vs
This nominal strength as well as its ratio to the design shear are stored in the CivilFEM
results file as the parameters:
9) Obtaining shear criterion. The section will be valid for shear if the following condition is
fulfilled:
Vu ≤ ϕVn = ϕ(Vc + Vs )
φ strength reduction factor of the section (0.75 for shear and torsion).
Vu
CRT_TOT = ≤1
ϕVn
For each element, this value is stored in the CivilFEM results file as the parameter
CRT_TOT.
If the strength provided by concrete is null and the shear reinforcement is not defined in
the section, then Vn = 0, and the criterion is equal to 2100.
1) Obtaining strength properties of the materials. These properties are obtained from the
material properties associated with each transverse cross section at the active time:
f′c specified compressive strength of concrete.
fyk specified yield strength of reinforcement.
λ modification factor for lightweight concrete.
2) Obtaining geometrical parameters depending on specified code. The required data are
as follows:
bw web width or diameter of circular section.
d distance from the extreme compression fiber to the centroid of the
longitudinal tensile reinforcement in Y, (for circular sections this should not be
less than the distance from the extreme compression fiber to the centroid of
the tensile reinforcement in the opposite half of the member).
The reinforcement ratio can alternatively be defined using the following data:
Longitudinal Reinforcement
Asl total area of the longitudinal reinforcement.
The reinforcement ratio can alternatively be defined using the following data:
4) Obtaining section’s internal forces and moments. The torsional moment that acts on
the section is obtained from the CivilFEM results file (.RCF).
Moment Description
5) Checking if torsion effects will be considered. Torsion effects are only considered if the
design torsional moment (Tu ) satisfies the condition below:
A2cp
Tu > 𝜙 (𝜆√f′c )
Pcp
If the design torsional moment is less than this value, its effects can be neglected and it
will be considered as null for checking.
Checking section dimensions. Section dimensions must satisfy the following
requirements for solid sections:
2
Vu 2 Tu Ph Vc
√( ) +( 2 ) ≤ ϕ( + 8√f′c )
bw d 1.7 Aoh bw d
Hollow sections:
Vu Tu Ph Vc
( )+( 2 ) ≤ ϕ( + 8√f′c )
bw d 1.7Aoh bw d
The ratio of the two coefficients is stored in the CivilFEM results file for both element
ends as the parameter (solid sections):
2 2
√( Vu ) + ( Tu Ph2 )
bw d 1.7 Aoh
CRTTC =
Vc
ϕ( + 8√f′c )
bw d
Hollow sections:
Vu TP
+ u n
bw d 1.7 A2oh
CRTTC =
V
ф ( c + 8√f′c )
bw d
6) Calculating the nominal torsional moment strength of the section. The nominal
torsional moment strength (Tn ) is evaluated with the following expression:
Ast
Tn = 2 Ac f
S y
where:
Ast
(Al )nec = P
S h
Calculation results are stored in the CivilFEM results file for both element ends as the
parameters:
7) Obtaining torsion criterion. The section will be valid for torsion if the following condition
is fulfilled:
Tu ≤ ΦTn
Asl ≥ (Al )nec
2
V 2 TP V
√( u ) + ( u h2 ) ≤ ϕ ( c + 8√f′c )
bw d 1.7 Aoh bw d
φ strength reduction factor of the section, (0.75 for shear and torsion).
2 2
√( Vu ) + ( Tu Ph2 )
Tu (Al )nec bw d 1.7 Aoh
CRT_TOT = Max ; ; ≤1
ϕ Tn Asl Vc
( + 8√f′c )
bw d
( )
For each element end, this value is stored in the CivilFEM results file as CRT_TOT.
If the strength provided by concrete is null and the torsion reinforcement is not defined
in the section, the criterion will be 2100.
The ϕ ∙ Tn value is stored in the CivilFEM results file for both element ends as the
parameter TFI.
6) Checking if torsion effects will be considered. Torsion effects are only considered if the
design torsional moment (Tu ) satisfies the condition below:
A2cp
Tu > 𝜙 (√f′c )
Pcp
If the design torsional moment is less than this value, its effects can be neglected and it
is considered as null for checking.
7) Checking section dimensions. For shear force and the associated torsional moment,
section dimensions must satisfy the following requirements:
a) Solid sections:
2
V 2 TP V
√( u ) + ( u h2 ) ≤ ϕ ( c + 8√f′c )
bw d 1.7 Aoh bw d
b) Hollow sections:
Vu Tu Ph Vc
( )+( ) ≤ ϕ ( + 8√f′c )
bw d 1.7A2oh bw d
In hollow sections, if the section wall’s thickness is less than Aoh /Ph , this value is
replaced in the expression above by the section’s minimum thickness.
The ratio between these two factors is stored in the CivilFEM results file for both
element ends.
a) Solid sections:
2 2
√( Vu ) + (Tu2Pn )
bw d Aoh
CRTTC =
Vc
ф( + 8√f′c )
bw d
b) Hollow sections:
Vu TP
+ u n
bw d 1.7 A2oh
CRTTC =
V
ф ( c + 8√f′c )
bw d
8) Checking for shear force with concomitant torsional moment. This check is
accomplished with the same steps as the check of elements subjected to pure shear
force according to ACI 318-14. The same results as for shear checking will be calculated.
Except for this check, the CRT_TOT criterion is stored in the CivilFEM results file as
CRTSHR for each element end.
9) Checking for torsion with shear force. This check follows the same steps considered for
the check of elements subjected to pure torsion according to ACI 318-05. The same
results as in torsion checking will be calculated.
Except for this check, the CRT_TOT criterion is stored in the CivilFEM results file as
CRTTRS for each element end.
10) Obtaining the combined shear and torsion criterion. This criterion determines whether
the section is valid or not. It is defined as follows:
Vu Tu (Al )nec
CRT_TOT = Max [ ; ; ; CRTTC] ≤ 1
ф Vn ф Tn Asl
For each end, this value is stored in the CivilFEM results file.
the shear strength provided by concrete is equal to zero and the shear
reinforcement has not been defined.
the shear strength provided by concrete is equal to zero and the transverse
torsion reinforcement has not been defined.
the longitudinal torsion reinforcement has not been defined.
Section 6.6.1.. provides detailed information on how to calculate the required data for
each code and valid section.
6) Calculating the shear strength provided by concrete. The shear strength provided by
concrete (Vc ) is calculated with the following expression:
Vc = 2λ√f′c bw d
where:
√f′c square root of specified compressive strength of concrete, in psi (always taken
as less than 100 psi).
Nu
Vc = 2 (1 + ) 𝜆√f′c bw d
2000 Ag
If the section is subjected to a significant tensile force,
Nu
Vc = 2 (1 + ) 𝜆√f′c bw d
500 Ag
The calculation result is stored in the CivilFEM results file for both element ends as the
parameter:
Vu ≤ ϕ Vn = ϕ(Vc + Vs )
Therefore, the reinforcement shear resistance must satisfy:
Vu
Vs = − Vc ≤ 8√f′c bw d
ϕ
If the shear resistance of the reinforcement does not satisfy the expression above, the
section cannot be designed. As a result, the parameters for the reinforcement ratio will
be equal to 2100.
As
ASSH = = 2100
S
For this case, the element will be labeled as not designed.
Calculation results are stored in the CivilFEM results file for both element ends as the
parameter:
VS = Vs ≤ 8√f′c bw d
8) Calculating the required reinforcement ratio. Once the shear resistance of the
reinforcement has been obtained, the reinforcement can be calculated with the
following expression:
As Vs
=
S fy (sinα + cosα)d
Where:
As
ASSH =
S
In this case, the element will be labeled as designed (providing the design process is
correct for both element sections).
1) Obtaining strength properties of the materials. These properties are obtained from
the material properties associated with each transverse cross section at the active
time.
f′c specified compressive strength of concrete.
fyk specified yield strength of reinforcement.
λ modification factor for lightweight concrete.
2) Obtaining geometrical parameters depending on specified code. The required data
are as follows:
3) Obtaining forces and moments acting on the section. The torsional moment that
acts on the section is obtained from the CivilFEM results file (.RCF).
Moment Description
4) Checking if torsion effects will be considered. Torsion effects are only considered if
the design torsional moment (Tu ) satisfies the condition below:
A2cp
Tu > ф (𝜆√f′c )
Pcp
If the design torsional moment is less than this value, its effects can be neglected and it
is consider as null for the design.
2
Vu 2 Tu Ph Vc
√( ) +( ) ≤ ϕ ( + 8√f′c )
bw d 1.7 A2oh bw d
Hollow sections:
Vu T P
u h Vc
(b ) + (1.7A 2 ) ≤ ϕ (b + 8√f′c )
w d oh w d
For hollow sections, if the thickness of the section walls is less than Aoh /Ph, this value
will be replaced by the minimum thickness of the section in the equation above.
The torsion reinforcement will not be designed if the previous expression is not fulfilled;
consequently, the parameters for the reinforcement will be equal to 2100.
Ast
ASTT = = 2100 for transverse reinforcement
S
The ratio of the two coefficients is stored in the CivilFEM results file for both element
ends:
a) Solid sections:
2
2
√( Vu ) +(Tu2Pn )
bw d Aoh
CRTTC = Vc
ф( +8√f′c )
bw d
b) Hollow sections:
Vu T P
+ u n
bw d 1.7 A2
oh
CRTTC = V
ф( c +8√f′c )
bw d
At
Tu ≤ ϕ Tn = ϕ (2A0 f )
S y
At cross-sectional area of one leg of a closed stirrup resisting torsion.
s spacing of the stirrups.
At Tu
=
S ϕ 2 A0 fy
The area of designed transverse reinforcement per unit length is stored in the CivilFEM
results file for both element ends:
At
ASTT =
S
6) Calculating the required longitudinal reinforcement. The longitudinal reinforcement
area is given by the following expression:
At
Al = P
S h
The area of the designed longitudinal reinforcement is stored in the CivilFEM results file
for both element ends:
ASLT = Al
If transverse and longitudinal reinforcements are designed for both element ends, this
element will be labeled as designed.
5) Checking if torsion effects will be considered. Torsion effects are only considered if
the design torsional moment (Tu ) satisfies the condition below:
A2cp
Tu > 𝜙 (√f′c )
Pcp
If the design torsional moment is less than this value, its effects can be neglected and it
is considered as null for the design.
6) Checking section dimensions. For shear force and concomitant torsional moment,
section dimensions must satisfy the following requirements:
a) Solid sections:
2
V 2 TP V
√( u ) + ( u h2 ) ≤ ϕ ( c + 8√f′c )
bw d 1.7 Aoh bw d
b) Hollow sections:
Vu Tu Ph Vc
( )+( 2 ) ≤ ϕ( + 8√f′c )
bw d 1.7 Aoh bw d
For hollow sections, if the section wall’s thickness is less than Aoh /Ph, this value will be
replaced by the minimum thickness of the section in the expression above.
The torsion reinforcement will not be designed if the expression above is not fulfilled;
consequently, the parameters for the reinforcement will be equal to 2100.
Ast
ASTT = = 2100 for transverse reinforcement
S
The ratio of the two coefficients is stored in the CivilFEM results file for both element
ends.
a) Solid sections:
2 2
√( Vu ) + ( Tu Ph2 )
bw d 1.7 Aoh
CRTTC =
Vc
ϕ( + 8√f′c )
bw d
b) Hollow sections:
2 2
Vu TP
( ) + ( u h2 )
bw d 1.7 Aoh
CRTTC =
V
ϕ ( c + 8√f′c )
bw d
7) Shear design assuming a null torsional moment. This design follows the same
procedure as for the design of elements subjected to pure shear force according to
ACI 318-14.
8) Torsion design considering a null shear force. This design is accomplished with the
same steps as for the design of elements subjected to pure torsion according to ACI
318-14.
Vc = 2√fc′ bw d
where:
√fc′ square root of specified compressive strength of concrete, in psi (always taken
as less than 100 psi).
For sections subject to a compressive axial force:
Nu
Vc = 2 (1 + ) √fc′ bw d
2000Ag
If the section is subjected to a tensile force such that the tensile stress is less than 500
psi:
Nu
Vc = 2 (1 + ) √fc′ bw d
500Ag
If the section is subjected to a tensile force such that the tensile stress exceeds 500 psi,
it is assumed that Vc = 0.
The calculated result at both element ends is stored in the CivilFEM results file as the
parameter VC:
fy yield strength of the shear reinforcement (not greater than 60,000 psi).
The calculated result at both element ends is stored in the CivilFEM results file as the
parameter VS:
CRTVN Ratio of the design shear force (Vu) to the resistance Vn.
Vu
CRTVN =
Vn
If the shear strength provided by the concrete is null and shear
reinforcement is not defined in the section, then Vn = 0, and the criterion
is set equal to –1.
9) Obtaining shear criterion. The section will be valid for shear if the following condition is
satisfied
Vu ≤ ϕVn = ϕ(Vc + Vs )
φ strength reduction factor of the section, (0.85 for shear and torsion).
Vu
CRT_TOT = ≤1
ϕ Vn
For each element, this shear utilization value is stored in the CivilFEM results file as the
parameter CRT_TOT.
In cases where the strength provided by the concrete is null and the shear
reinforcement is not defined in the section, the shear strength Vn = 0, and the criterion
is set equal to 2100.
The ϕ ∙ Vn value is stored in the CivilFEM results file as the parameter VFI.
1) Obtaining material strength properties. These properties are obtained from the material
properties associated with each transverse cross section at the active time are:
fc′ specified compressive strength of concrete.
fyk specified yield strength of reinforcement.
2) Obtaining geometrical parameters depending on specified code. Geometrical
parameters used for torsion calculations must be defined. The required data are as
follows:
bw web width or diameter of circular section.
The reinforcement ratio can alternatively be defined using the following data:
Longitudinal Reinforcement
Asl total area of the longitudinal reinforcement.
The reinforcement ratio can also be defined using the following data:
4) Obtaining section internal forces and moments. The torsional moment that acts on the
section is obtained from the CivilFEM results file (.RCF).
Moment Description
5) Checking whether torsion effects will be considered. Torsion effects are only considered
if the design torsional moment (Tu) satisfies the following equation:
A2cp
Tu > 𝜙 (√fc′ )
Pcp
If the design torsional moment is less than this value, its effects can be neglected and it
is considered as null for checking.
In hollow sections, if the section wall thickness is less than Aoh/Ph, this value must be
substituted with the minimum thickness of the section in the expression above.
The ratio of the two coefficients is stored in the CivilFEM results file at both element
ends as the parameter:
Tu Pu
1.7 A20h
CRTTC =
V
ϕ ( c + 8√fc′ )
bw d
7) Calculating the nominal torsional moment strength of the section. The nominal
torsional moment strength (Tn) is evaluated with the following expression:
Ast
Tn = 2A0 f
S y
where:
CRTTN Ratio of the design torsional moment (Tu) to the torsional moment
strength Tn .
Tu
CRTTN =
Tn
The needed longitudinal reinforcement area is given by:
Ast
(Al )nec = P
S h
The calculated results are stored in the CivilFEM results file at both element ends as the
parameters:
8) Obtaining torsion criterion. The section will be valid for torsion if the following condition
is satisfied:
Tu ≤ ϕTn
Asl ≥ (Al )nec
Tu Ph Vc
≤ ϕ ( + 8√fc′ )
1.7A20h bw d
φ strength reduction factor of the section, (=0.85 for shear and torsion).
Tu Ph
Tu (Al )nec 1.7A20h
CRT_TOT = Max ( ; ; )≤1
ϕ Tn Asl Vc ′
+ 8√fc
bw d
For each element end, this value is stored in the CivilFEM results file.
In cases where the strength provided by concrete is null and the torsion reinforcement
is not defined in the section, the criterion will be set to 2100.
The ϕ ∙ Tn value is stored in the CivilFEM results file at both element ends as the
parameter TFI.
1) Checking if torsion effects must be considered. Torsion effects are only considered if the
design torsional moment (Tu) satisfies the condition below:
A2cp
Tu > 𝜙 (√fc′ )
Pcp
If the design torsional moment is less than this value its effects can be neglected and it is
considered as null for checking.
2) Checking section dimensions. For shear force and associated torsional moment, section
dimensions must satisfy the following requirements:
a) Solid sections:
2
Vu 2 Tu Ph Vc
√( ) +( 2 ) ≤ ϕ( + 8√fc′ )
bw d 1.7 A0h bw d
b) Hollow sections:
Vu Tu Ph Vc
( )+( ) ≤ ϕ ( + 8√fc′ )
bw d 1.7A20h bw d
In hollow sections if the section wall thickness is lower than A0h /Ph, this value is
changed in the previous expression by the section minimum thickness.
The ratio between these two factors is stored in the CivilFEM results file at both element
ends.
a) Solid sections:
2 2
√( Vu ) + ( Tu Ph2 )
bw d 1.7 A0h
CRTTC =
Vc
ϕ( + 8√fc′ )
bw d
b) Hollow sections:
Vu TP
+ u h
bw d 1.7 A20h
CRTTC =
V
ϕ ( c + 8√fc′ )
bw d
3) Checking for shear force with associated torsional moment. This checking is
accomplished following the same steps considered for the checking of elements
subjected only to shear force according to ACI 349. The same results as defined in the
shear check are calculated.
4) Checking for torsion with shear force. This checking is accomplished following the same
steps considered for the checking of elements subjected only to torsion according to ACI
349. The same results as defined in the torsion check are calculated.
5) Obtaining the combined shear and torsion criterion. This criterion determines whether
the section is valid or not. The utilization is defined as follows:
Vu Tu (Al )nec
CRT_TOT = Max [ ; ; ; CRTTC] ≤ 1
ϕ Vn ϕ Tn Asl
For each end, this value is stored in the CivilFEM results file.
A value equals to 2100 for this criterion would indicate one of the following:
6) Calculating the shear strength provided by concrete for nonprestressed members. First,
the shear strength provided by the concrete (Vc) is calculated with the following
expression:
Vc = 2√fc′ bw d
where:
√fc′ square root of specified compressive strength of concrete, in psi (always taken
as less than 100 psi).
For sections subject to a compressive axial force:
Nu
Vc = 2 (1 + ) √fc′ bw d
2000 Ag
If section is subjected to a tensile force so that the tensile stress is less than 500 psi:
Nu
Vc = 2 (1 + ) √fc′ bw d
500 Ag
If the section is subjected to a tensile force such that the tensile stress exceeds 500 psi,
it is assumed that Vc=0.
The calculated result is stored in the CivilFEM results file at both element ends as the
parameter:
Vu ≤ ϕVn = ϕ(Vc + Vs )
Therefore, the required shear strength of the reinforcement must be:
Vu
Vs = − Vc ≤ 8√fc′ bw d
ϕ
If the required shear strength of the reinforcement does not satisfy the expression
above, the section cannot be designed; consequently, the reinforcement parameter will
be defined as 2100. Then:
As
ASSH = = 2100
S
In this case, the element will be labeled as not designed, the program then advances to
the following element.
The calculated result at both element ends is stored in the CivilFEM results file as the
parameter VS:
VS = Vs ≤ 8√fc′ bw d
8) Calculating the required reinforcement ratio. Once the shear force that the shear
reinforcement must support has been obtained, the reinforcement is obtained from the
following expression:
As Vs
=
S fy (sin α + cos α)d
Where:
As
ASSH =
S
In this case, the element will be labeled as designed (providing the design process is
correct at both element ends).
1) Obtaining material resistant properties. These properties are obtained from the
material properties associated with each transverse cross section and for the active
time:
3) Obtaining forces and moments acting on the section. The torsional moment that acts
on the section is obtained from the CivilFEM results file (.RCF).
Moment Description
4) Checking whether torsion effects will be considered. Torsion effects are only
considered if the design torsional moment (Tu) satisfies the condition below:
A2cp
Tu > 𝜙 (√fc′ )
Pcp
If the design torsional moment is less than this value, its effects can be neglected and it
is consider as null for the design.
Tu Ph Vc ′
2 ≤ ϕ (b d + 8√fc )
1.7 A0h w
In hollow sections, if the section’s wall thickness is less than Aoh/Ph, this value will be
equal to the minimum thickness of the section in the formula above.
The torsion reinforcement will not be designed if the previous expression is not
satisfied, so the parameters where the reinforcement is stored would be marked with
2100. Then:
Ast
ASTT = = 2100 for transverse reinforcement
S
The ratio of the two coefficients is stored in the CivilFEM results file at both element
ends:
Tu Ph
1.7 A20h
CRTTC =
V
ϕ ( c + 8√fc′ )
bw d
Ast
Tu ≤ ϕ Tn = ϕ (2 AO f )
S y
Ast cross-sectional area of one leg of a closed stirrup of the transverse
reinforcement.
s spacing of the stirrups.
Ast Tu
=
S ϕ 2 AO fy
The area of the designed transverse reinforcement per unit length is stored in the
CivilFEM results file at both element ends:
Ast
ASTT =
S
7) Determining the longitudinal reinforcement requirement. The longitudinal
reinforcement area is given by the following expression:
Ast
Al = P
S h
The area of the designed longitudinal reinforcement is stored in the CivilFEM results file
at both element ends:
ASLT = Al
If both transverse and longitudinal reinforcements are designed at both element ends,
this element will be labeled as designed.
1) Checking whether torsion effects will be considered. Torsion effects are only
considered if the design torsional moment (Tu) satisfies the condition below:
A2cp
Tu > 𝜙 (√fc′ )
Pcp
If the design torsional moment is less than this value, its effects can be neglected and it
will be considered as null for designing.
2) Checking section dimensions. For shear force and associated torsional moment, section
dimensions must satisfy the following requirements:
a) Solid sections:
2
V 2 TP V
√( u ) + ( u h2 ) ≤ ϕ ( c + 8√fc′ )
bw d 1.7 A0h bw d
b) Hollow sections:
Vu Tu Ph Vc
( )+( 2 ) ≤ ϕ( + 8√fc′ )
bw d 1.7 A0h bw d
In hollow sections, if the section wall thickness is less than Aoh/Ph, this last value will be
equal to the minimum thickness of the section in the equation above.
If the expression above is not satisfied, the torsion reinforcement will not be designed;
as a result, the reinforcement parameters will be defined as:
Ast
ASTT = = 2100 for transverse reinforcement
S
The ratio of the two coefficients is stored in the CivilFEM results file at both element
ends.
a) Solid sections:
2 2
√( Vu ) + ( Tu Ph2 )
bw d 1.7 A0h
CRTTC =
Vc
ϕ( + 8√fc′ )
bw d
b) Hollow sections:
Vu TP
+ u h2
bw d 1.7 A0h
CRTTC =
V
ϕ ( c + 8√fc′ )
bw d
3) Shear design assuming a null torsional moment. This design is accomplished with the
same procedure as for the design of elements subjected to pure shear force according
to ACI 349-01 and 349-06.
4) Torsion design considering a null shear force. This design is follows the same procedure
as for the design of elements subjected to pure torsion according to ACI 349-01 and
349-06.
4) Obtaining reinforcement data of the section. Required data are the following:
angle between shear reinforcement and the longitudinal axis of the member.
For this code, = 90º.
As /S area of reinforcement per unit length.
The reinforcement ratio may also be obtained with the following data:
diameter of bars.
5) Obtaining forces and moments acting on the section. The shear force that acts on
the section as well as the concomitant axial force and bending moment are obtained
from the CivilFEM results file (.RCF).
Force Description
Asb Area of the longitudinal tension reinforcement that extends at least a distance
d beyond the considered section.
Considering the following restrictions:
Asb
100 =3
bw d
400
=1
d
f 1/3
If fcu > 25 𝑁/mm2 , the results are multiplied by ( 25
cu
)
If the section is subjected to an axial force, then the following expression will be used:
NVh
Vc ′ = Vc + 0.6 ∙b ∙d
Ac M w
Where:
For each element end, calculated results are written in the CivilFEM results file as the
following parameters:
Vu2 = Vc + Vs
For each element end, calculated results are written in the CivilFEM results file in the
following parameters:
10) Calculating the shear criterion. The shear criterion indicates the validity of the
section (if less than 1, the section conforms to code specifications, and if greater than
1, the section is not valid). Moreover, it provides information with regards to how
much more additional load the section can resist. The shear criterion is defined as
follows:
Vd Vd
CRT_TOT = Max ( ; )≤1
Vu1 Vu2
For each element end, calculated results are written in the CivilFEM results file in the
parameter CRT_TOT.
A value of 2100 for this criterion indicates that the shear resistance (Vu2 ) has a value of
zero, as indicated in the previous step.
1) Obtaining material strength properties. These properties are obtained from the
material properties associated to each transverse cross section and for the active
time.
The reinforcement ratio can also be obtained with the following data:
Longitudinal Reinforcement
Asl total area of the longitudinal reinforcement.
The reinforcement ratio can also be obtained with the following data:
Moment Description
Td ≤ Tu1
Tu1 = Vtu ∙ Xw
y1
If y1< 550 mm Tu1 = Vtu ∙ Xw ∙ 550
where:
Td ≤ Tu2
Ast
Tu2 = ∙ 0.8 ∙ x1 y1 ∙ 0.87 ∙ fyv
S
where:
Ast /S area of transverse reinforcement per unit length
For each element end, calculated results are written in the CivilFEM results file in the
following parameters:
Ast
(Asl )nec = ∙ (x1 + y1 )
S
Where:
Asl defined longitudinal reinforcement
(Asl )nec necessary longitudinal reinforcement
As area of transverse reinforcement
For each element end, calculated results are written in the CivilFEM results file in the
following parameters:
9) Obtaining torsion criterion. The torsion criterion identifies the ratio of the design
moment to the section’s ultimate strength (if it is less than 1, the section is valid;
whereas if it exceeds 1, the section is not valid). The criterion concerning the validity
for torsion is defined as follows:
Td Td (Asl )nec
CRT_TOT = Max ( ; ; )≤1
Tu1 Tu2 Asl
For each element end, this value is stored in the CivilFEM results file as CRT_TOT.
A value 2100 for this criterion indicates that any one of the torsion reinforcements are
not defined.
1) Shear checking disregarding the torsional moment. This check follows the same
procedure as the check of elements subjected to shear.
In this case, the total shear criterion CRT_TOT is named as CRTSHR.
2) Torsion checking disregarding the shear force. This check will be accomplished with the
same procedure as the check of elements subjected to torsion, considering the torsional
force due to shear in the calculation of concrete failure.
Td ≤ Tu1
Vd
Tu1 = Vtu ∙ χw −
bw d
In this case, the total torsion criterion CRT_TOT is named as CRTTRS.
3) Obtaining the criterion of combined shear and torsion. This criterion contains both
shear and torsion criteria:
Vd Vd Td Td (Asl )nec
CRT_TOT = Max [ ; ; ; ; ]
Vu1 Vu2 Tu1 Tu2 Asl
For each element end, calculated results are written in the CivilFEM results file in the
parameter CRT_TOT.
1) Obtaining material strength properties. These properties are obtained from the
material properties associated to each transverse cross section and for the active
time.
4) Obtaining reinforcement data of the section. Required data are the following ones:
angle between shear reinforcement and the longitudinal axis of the member.
For this code, = 90º.
5) Obtaining forces and moments acting on the section. The shear force that acts on
the section as well as the concomitant axial force and bending moment are obtained
from the CivilFEM results file (.RCF).
Force Description
Vd ≤ Vu1
Vu1 = MIN {0.8√fcu, 5 N/mm2 } ∗ bw ∗ d
For each element end, calculated results are written in the CivilFEM results file in the
following parameters:
VU1 Ultimate shear strength due to oblique compression of the concrete in
web.
VU1 = Vu1
CRTVU1 Ratio of the design shear (Vd ) to the resistance Vu1 .
Vd
CRTVU1 =
Vu1
If the design shear force is greater than the shear force that causes failure in the web,
the section will not be designed. Therefore, the parameter for the reinforcement data
will be defined as 2100.
As
ASSH = = 2100
S
For this case, the element will be labeled as not designed.
7) Calculating the concrete shear resistance. The shear resistance of concrete (Vc) is
checked using the following expression:
Asb Area of the longitudinal tension reinforcement that extends at least a distance
d beyond the considered section.
Taking into account the following restrictions:
Asb
100 ≤3
bw d
400
≥1
d
f 1/3
If fcu > 25 𝑁/mm2 , the results are multiplied by ( 25
cu
)
If the section is subjected to an axial force, then the following expression will be used:
NVh
Vc ′ = Vc + 0.6 ∙b ∙d
Ac M w
Where:
Vd ∙ h⁄
Taking into account that M≤1
For each element end, calculated results are written in the CivilFEM results file in the
following parameters:
Vd ≤ Vu2
Vu2 = Vc + Vs
Vs is the reinforcement contribution.
Vc is the concrete contribution.
Vs = Vu2 − Vc = Vd − Vc
For each element end, calculated results are written in the CivilFEM results file in the
following parameter:
As Vs
=
S 0.95 ∙ fyv ∙ d
where:
1) Obtaining material strength properties. These properties are obtained from the
material properties associated to each transverse cross section and for the active
time.
3) Obtaining section internal forces and moments. The torsional moment that acts on
the section is obtained from the CivilFEM results file (.RCF).
Moment Description
Td ≤ Tu1
Tu1 = Vtu ∙ Xw
y1
If y1< 550mm Tu1 = Vtu ∙ Xw ∙ 550
Where:
Td ≤ Tu2
Ast
Tu2 = ∙ 0.8 ∙ x1 y1 ∙ 0.87 ∙ fyv
S
Where:
Ast/S area of transverse reinforcement per unit length
fy characteristic yield strength of reinforcement fyv ≤ 460 N/mm2
Ast Td
=
S 0.8 ∙ x1 y1 ∙ 0.87 ∙ fyv
The area per unit length of the designed transverse reinforcement is stored in the
CivilFEM results file for both element ends as:
At
ASTT =
S
7) Calculating the longitudinal reinforcement required. The longitudinal reinforcement
is calculated as a function of the transverse reinforcement using the expression:
Ast
(Asl )nec = ∙ (x1 + y1 )
S
Where:
(Asl )nec required longitudinal reinforcement.
Ast /s area per unit length of transverse reinforcement.
For each element end, calculated results are written in the CivilFEM results file in the
following parameter:
1) Shear design assuming a null torsional moment. This design follows the same steps
as for the design of elements subjected to pure shear according to BS8110.
2) Torsion design assuming a null shear force. This design is accomplished with the
same procedure as for the designing of elements subjected to torsion force according
to BS8110. However, this design considers the stress due to shear in the calculation
of concrete failure.
Td ≤ Tu1
Vd
Tu1 = Vtu ∙ Xw −
bw d
Where:
Vtu maximum combined shear stress (shear plus torsion).
Xw torsion modulus for torsion check and design.
1) Obtaining materials strength properties. The required data are the following:
2) Obtaining geometrical data of the section. Required data for shear checking are the
following:
Ac total cross-sectional area of the concrete section.
3) Obtaining geometrical parameters depending on specified code. Required data are the
following:
b minimum width of the section over the effective depth.
h0 effective height of the section.
5) Obtaining the section internal forces and moments. The shear force that acts on the
section as well as the concomitant axial force and bending moment are obtained from
the CivilFEM results file (.RCF).
Force Description
1) Checking whether the section dimensions meet the requirement. First, a check is made
to ensure the design shear (V) is less than or equal to maximum shear resistance of the
section (VRd1 ):
V ≤ VRd1
If hw ⁄b ≤ 4 , VRd1 = 0.25βc fc bh0
If hw ⁄b ≥ 6 , VRd1 = 0.2βc fc bh0
where βc is a coefficient depending on the concrete strength:
V ≤ VRd2
Where
VRd2 = 0.7βh ft bh0
800 1
βh = ( h )4 is the section height factor,
0
If reinforcement has been defined, axial forces are not present (N=0), and the shear force
from the concentrated load for an independent beam is less than 75%:
VRd2 = 0.7ft bh0
If N is compressive (N < 0)
1.75
VRd2 = f bh − 0.07N
λ+1 t 0
If N is tensile (N > 0)
1.75
VRd2 = f bh − 0.02N
λ+1 t 0
V ≤ VRd3
where
VRd3 = VRd2 + Vs
Vs design shear load capacity of reinforcement.
Asv
Vs = αcf fyv h
S 0
αcf = 1
As v cross-sectional area of the shear reinforcement.
s spacing of the stirrups measured along the longitudinal axis.
Results obtained are written for each end in the CivilFEM results file as the following
parameters:
4) Obtaining the shear criterion. The shear criterion indicates the validity of the section (if
less than 1, the section will be valid; if greater than 1 the section, is not good). Moreover,
it provides information with regards to how much more load the section can resist. The
shear criterion is defined as follows:
CRT_TOT = Max(CRVRD1; CRVRD3) ≤ 1
For each element end, calculated results are written in the CivilFEM results file in the
parameter CRT_TOT.
A value of 2100 in this criterion will indicate that shear resistance (VRd2 ) is not been
considered, as indicated in the previous step.
1) Determining the factor for seismic fortification, used to adjust the shear capacity and
performing the check for shear. Firstly, this checking method differs from the other
typical checking methods:
V ≤ VR /YRe
V Design shear force
VR/ γRE Design shear resistance
γRE factor for seismic fortification, used to adjust the shear capacity. If the
combination of the cases does not include the horizontal seismic action,
γRE=1.
Otherwise, it is selected as illustrated in the following table.
TABLE 9-2 FACTORS FOR SEISMIC FORTIFICATION
N 0.8
Eccentric compression and f ≤ 0.15
cA
2) Checking whether section dimensions meet requirements under the actions of seismic
loads. First, a check is made to ensure the design shear (V) is less than or equal to
sectional maximum possible resistance (VRd1 ) under the seismic loads:
V ≤ VRd1
For beam:
1
VRd1 = 0.2βc fc bh0 for l/h0 > 2.5
γRE
1
VRd1 = 0.15βc fc bh0 for l/h0 ≤ 2.5
γRE
Where:
𝒉𝟎 effective height of the section
For column:
1
VRd1 = 0.20βc fc bh0 for λ > 2
γRE
1
VRd1 = 0.15βc fc bh0 for λ ≤ 2
γRE
λ = M⁄(Vh0 )
VRD1 Maximum possible shear resistance.
VRD1 = VRd1
CRVRD1 Ratio of the design shear force V to the resistance VRd1 .
V
CRVRD1 =
VRd1
3) Checking whether shear reinforcement will be required for the section under actions of
seismic loads.
If the member is a beam, axial forces are not present (N=0), and the shear force from the
concentrated load is less than 75%:
1
VRd2 = 0.42ft bh0
γRE
If the member is an independent beam and the shear force from concentrated load is more
than 75%:
1 1.05
VRd2 = f bh
γRE λ + 1 t 0
If the member is a column and N is compressive (N < 0)
1 1.05
VRd2 = [ f bh − 0.056N]
γRE λ + 1 t 0
If N is tensile (N > 0)
1 1.05
VRd2 = [ f bh − 0.2N]
γRE λ + 1 t 0
VRd2 ≥ 0
4) Checking of elements that will require shear reinforcement under the actions of
seismic loads. The calculated of the shear resistance of a section with reinforcement
(VRd3 ) differs according to whether the concentrated load exists.
The following condition is checked:
V ≤ VRd3
where
VRd3 = VRd2 + Vs
Vs is the design shear load capacity of reinforcement.
Asv
Vs = αcf fyv ( ) hc
S
αcf = 1
As v is the cross-sectional area of the shear reinforcement.
s is the spacing of the stirrups measured along the longitudinal axis.
fyv is the design tensile strength of shear reinforcement.
Results obtained are written for each end in the CivilFEM results file as the following
parameters:
5) Obtaining the shear criterion. The shear criterion indicates the validity of the section (if
less than 1, the section conforms to code specifications; if greater than 1, the section is
not valid). Moreover, it provides information with regards to how much more load
section can resist. The shear criterion is defined as follows:
A value of 2100 for this criterion indicates that shear resistance (VRd2 ) is not considered,
as indicated in the previous step.
1) Obtaining material strength properties. These properties are obtained from the material
properties associated to the transverse cross section and for the active time.
The required data are the following:
fc design compressive strength of concrete.
ft design tensile strength of concrete.
fy design tensile strength for torsion reinforcement.
2) Obtaining section geometrical data. Required data for shear checking are the following
ones:
Ac total cross-sectional area of the concrete section.
3) Obtaining geometrical parameters depending on specified code. The required data are
the following:
b minimum width of the section over the effective depth or section inner
diameter for circular section.
h0 height of the section or section outer diameter for circular section.
Wt1 Plastic resistance of torsion moment for branch 1 for T and double T section/I-
section.
Wt2 Plastic resistance of torsion moment for branch 2 for T and double T section/I-
section.
Moment Description
Results are written in the CivilFEM results file for both element ends as the parameters:
N
TRd2 = 0.35ft Wt − 0.07 W
Ac t
N (< 0) is the compressive axial force, if|N| > 0.3fc A, assume|N| = 0.3fc A.
TRd2 = 0.35αh ft Wt
αh is the influence coefficient of the wall thickness of the box section.
TRD2 Maximum design torsional moment resisted by the section without crushing
the concrete compressive struts.
TRD2 = TRd2
CRTRD2 Ratio of the design torsional moment T to the resistance TRd2.
T
CRTRD2 =
TRd2
8) Calculating the maximum torsional moment resisted by the reinforcement. The design
torsional moment T must be less than or equal to the maximum design torsional
moment resisted by concrete and the reinforcement (TRd2 ); as a result, the following
condition must be satisfied:
T ≤ TRd3 = TRd2 + Ts
where
Ast1 Acor
Ts = 1.2√ξfy
S
Astl S
ζ= the ratio between longitudinal reinforcement and hoop
Ast1 Ucor
Calculated results are written in the CivilFEM results file for both element ends as the
parameters:
TRD3 Maximum design torsional moment resisted by concrete and the torsion
reinforcement.
TRD3 = TRd3
CRTRD3 Ratio of the design torsional moment T to the resistance TRd3 .
T
CRTRD3 =
TRd3
If transverse reinforcement is not defined, TRd3 = TRd2 .
V ≤ VRd1
T ≤ TRd1
Where
Results are written in the CivilFEM results file for both element ends as the parameters:
Results are written in the CivilFEM results file for both element ends as the parameters:
VRD2 = VRd2
CRVRD2 Ratio of the design shear force V to the resistance VRd1.
V
CRVRD2 =
VRd2
For sections subjected to an axial tensile force so that VRd2=0, CRVRD1 is
taken as 2100.
Tc = 0.35αh βt ft Wt
and torsion.
1.75 Asv
Vc = (1.5 − βt )(λ+1 ft bh0 − 0.07N) Vs = fyv h0
S
N
Tc = βt (0.35ft − 0.07 )Wt
A
Results obtained are written for each end in the CivilFEM results file as the following
parameters:
VRD2 = VC
Tc Torsion strength of concrete.
VRd3 = Vc + Vs TRd3 = Tc + Ts
Asv
Vs = 1.25fyv h0
S
fy Ast1 Acor
Ts = 1.2√ζ S
Results obtained are written for each end in the CivilFEM results file as the following
parameters:
1) Obtaining materials strength properties. The required data are the following:
fc design compressive strength of concrete.
ft design tensile strength of concrete.
fyv design tensile strength for of shear reinforcement.
2) Obtaining geometrical data of the section. Required data for shear checking are the
following:
Ac total cross-sectional area of the concrete section.
3) Obtaining geometrical parameters depending on specified code. Required data are the
following:
b minimum width of the section over the effective depth.
h0 effective height of the section.
V ≤ VRd2
Where:
VRd2 = 0.7βh ft bh0
800
βh = ( h )1/4 is the section height factor,
0
If reinforcement has been defined, axial forces are not present (N=0), and the shear force
from the concentrated load for an independent beam is less than 75%,
VRd2 = 0.7ft bh0
If design shear force is greater than the shear force required to crush the concrete
compressive struts, the reinforcement design will not be feasible; as a result, the
parameter pertaining to the reinforcement data will be defined as 2 100:
Asv
ASSH = = 2100
s
In this case, the element will be labeled as not designed, and the program will advance
to the next element.
VRD3 = Vs
4) Calculating the required transverse reinforcement ratio. Once the required shear
strength of the reinforcement has been obtained, the reinforcement can be calculated
from the equation below:
Asv V − VRd2
=
S αcf fyv h0
where:
αcf = 1
Asv cross-sectional area of the shear reinforcement.
s spacing of the stirrups measured along the longitudinal axis.
The area of designed reinforcement per unit length is stored in the CivilFEM results file
as the parameter:
Asv
ASSH =
S
In this case, the element will be labeled as designed (provided that design process is
correct for both element sections).
If the section is labeled as not designed, the reinforcement will be defined as 2 100.
1) Determining the factor for seismic fortification, used to adjust the shear capacity and
performing the check for shear. Firstly, this checking method differs from the other
typical checking methods:
V ≤ VR /YRe
V Design shear force
VR/ γRE Design shear resistance
γRE factor for seismic fortification, used to adjust the shear capacity. If the
combination of the cases does not include the horizontal seismic action,
γRE=1.
Otherwise, it is selected as illustrated in the following table.
TABLE 9-3 FACTORS FOR SEISMIC FORTIFICATION
N 0.8
Eccentric compression and f ≤ 0.15
cA
2) Checking whether section dimensions meet requirements under the actions of seismic
loads. First, a check is made to ensure the design shear (V) is less than or equal to the
maximum resistance of the section (VRd1 ) under the seismic loads:
V ≤ VRd1
For beams:
1
VRd1 = 0.2βc fc bh0
γRE
For columns:
1
VRd1 = γ 0.20βc fc bh0 for λ > 2
RE
1
VRd1 = γ 0.15βc fc bh0 forλ ≤ 2
RE
λ = M/(Vh0 )
VRD1 Maximum shear resistance.
VRD1 = VRd1
CRVRD1 Ratio of the design shear force V to the resistance VRd1.
V
CRVRD1 =
VRd1
The design process stops if CRVRD1>1.0
3) Maximum shear force resisted without shear reinforcements under the actions of
seismic loads.
If the member is a beam, axial forces are not present (N=0), and the shear force from the
concentrated load is less than 75%:
1
VRd2 = 0.42ft bh0
γRE
If the member is an independent beam and the shear force from the concentrated load is
more than 75%,
1 1.05
VRd2 = f bh
γRE λ + 1 t 0
If the member is a column and N is compressive (N < 0)
1 1.05
VRd2 = [ f bh − 0.056N]
γRE λ + 1 t 0
If N is tensile (N > 0)
1 1.05
VRd2 = [ f bh − 0.2N]
γRE λ + 1 t 0
VRd2 ≥ 0
The following are given in CivilFEM results:
VRD2 Maximum design shear force resisted by the section without crushing of
the concrete compressive struts.
VRD2 = VRd2
CRVRD2 Ratio of the design shear force V to the resistance VRd2.
V
CRVRD2 =
VRd2
For sections subjected to an axial tensile force so that V Rd2=0, CRVRD2 is taken as 2100.
The design process stops if CRVRD2=1.0 because the reinforcement will not be required for
the strength (minimum reinforcements are still necessary).
VRD3 = Vs
5) Calculating the required transverse reinforcement ratio. Once the required shear
strength of the reinforcement has been obtained, the reinforcement area per unit length
can be calculated:
Asv V − VRd2
= x γRE
S αcf fyv h0
where:
αcf = 1.0
Asv cross-sectional area of the shear reinforcement.
s spacing of the stirrups measured along the longitudinal axis.
The area of the designed reinforcement per unit length is stored in the CivilFEM results
file as the parameter:
Asv
ASSH =
S
In this case, the element will be labeled as designed (provided that design process is
correct for both element sections).
If the design is not possible, the reinforcement will be assigned the value 2 100.
1) Obtaining materials strength properties. These properties are obtained from the
material properties associated to the transverse cross section and for the active time.
The required data are the following:
fc design compressive strength of concrete.
ft design tensile strength of concrete.
fy design tensile strength for torsion reinforcement.
2) Obtaining geometrical data of the section. Required data for shear checking are the
following:
Ac total cross-sectional area of the concrete section.
3) Obtaining geometrical parameters depending on specified code. The required data are
the following:
b minimum width of the section over the effective depth or section inner
diameter for circular section.
h0 height of the section or outer diameter for circular section.
Wt1 Plastic resistance of torsion moment for branch 1 for T and double T section/I-
section.
Wt2 Plastic resistance of torsion moment for branch 2 for T and double T section/I-
section.
Section 6.6.1.. provides detailed information on how to calculate the required data for
each code and valid section.
4) Obtaining reinforcement data of the section. Required data are the following ones:
Transverse Reinforcement
Ast /S Area of transverse reinforcement per unit length.
Longitudinal Reinforcement
Asl total area of the longitudinal reinforcement.
5) Obtaining section internal forces and moments. The torsional moment that acts on the
section is obtained from the CivilFEM results file (.RCF).
Moment Description
T Design torsion moment
N Axial force
Results are written in the CivilFEM results file for both element ends as the parameters:
TRD1 = TRd1
CRTRD1 Ratio of the design torsional moment T to the resistance T Rd1.
T
CRTRD1 =
TRd1
7) Calculating the maximum torsional moment resisted without reinforcement.
T ≤ TRd2
where
N
TRd2 = 0.35ft Wt − 0.07 W
Ac t
N (< 0) compressive axial force, if |N| > 0.3fc A, assume|N| = 0.3fc A.
TRd2 = 0.35αh ft Wt
Results are written in the CivilFEM results file for both element ends as the parameters:
Ast1 Acor
Ts = 1.2√ζfy
S
Astl S
ζ=A is the ratio between longitudinal reinforcement and hoop reinforcement
st1 Ucor
strength 0.6 ≤ ζ ≤ 1.7; ζ > 1.7 if, assume ζ = 1.7
Ast1 T − TRd2
=
S 1.2√ζfy Acor
The area of the designed transverse reinforcement per unit length is stored in the CivilFEM
results file as the parameter:
Ast
ASTT =
S
9) Calculating the required longitudinal reinforcement ratio. The longitudinal
reinforcement is calculated from:
ζAst1 Ucor
Astl =
S
where:
ASLT = Astl
If both transverse and longitudinal reinforcements are designed for both element
sections, this element will be labeled as designed.
1) Obtaining material strength properties. The required data are the following:
fc design compressive strength of concrete.
ft design tensile strength of concrete.
fy design tensile strength for torsion reinforcements
Wt2 Plastic resistance of torsion moment for branch 2 for T and double T section/I-
section.
4) Obtaining reinforcement data of the section. Required data are the following:
Shear Reinforcement
Asv /S area of reinforcement per unit length.
Transverse Torsion Reinforcement
Ast1 /S area of reinforcement per unit length.
Torsion Longitudinal Reinforcement
Astl total area of the longitudinal reinforcement.
5) Obtaining the section internal forces and moments. The shear force that acts on the
section, as well as the concomitant axial force and bending moment, are obtained from
the CivilFEM results file (.RCF).
Force Description
Results are written in the CivilFEM results file for both element ends as the parameters:
Results are written in the CivilFEM results file for both element ends as the parameters:
VRD2 = VRd2
CRVRD2 Ratio of the design shear force V to the resistance VRd1.
V
CRVRD2 =
VRd2
For sections subjected to an axial tensile force so that V Rd2=0, CRVRD1 is
taken as 2100.
Tc = 0.35αh βt ft Wt
and torsion.
1.75
Vc = (1.5 − βt )( f bh − 0.07N)
λ+1 t 0
N
Tc = βt (0.35ft − 0.07 )Wt
A
Results obtained are written for each end in the CivilFEM results file as the following
parameters:
VRD2 = VC
Tc Torsion strength of concrete.
VRd3 = Vc + Vs TRd3 = Tc + Ts
Asv
Vs = 1.25fyv h0
S
fy Ast1 Acor
Ts = 1.2√ζ S
Results obtained are written for each end in the CivilFEM results file as the following
parameters:
VRD3 = VRd3
CRVRD3 Ratio of the design shear force (V) to the shear resistance V Rd3.
V
CRVRD3 =
VRd3
If VRd3 = 0, CRVRD3 is taken as 2100.
Asv V − Vc
=
S αcf fyv h0
Torsion:
Ast1 T − Tc
=
S 1.2√ζfy Acor
where
The area of the designed reinforcement per unit length is stored in the CivilFEM results
file as the parameter:
Asv
ASSH =
S
Ast1
ASTT =
S
7) Calculating the required longitudinal requirement ratio.
ζAst1 Ucor
Astl =
S
The area of the designed longitudinal reinforcement is stored in the CivilFEM results file
as the parameter:
ASLT = Astl
If both transverse and longitudinal reinforcements are designed for both element
sections, this element will be labeled as designed.
1) Obtaining material strength properties. These properties are obtained from the material
properties associated with each transverse cross section and for the active time.
The required data are the following ones:
3) Obtaining geometrical parameters depending on specified code. The required data are
the following:
bw web width or diameter of circular section.
d distance from the extreme compressed fiber to the centroid of the
longitudinal tensile reinforcement in the Y direction, (for circular sections, this
should be greater than the distance from the extreme compressed fiber to the
centroid of the tensile reinforcement in the opposite half of the member).
Section 6.6.1. provides detailed information on how to calculate the required data for
each code and valid section.
Vc = 2√fc′ bw d
where:
√fc′ square root of specified compressive strength of concrete, in psi (always taken
as less than 100 psi).
For sections subject to a compressive axial force:
Nu
Vc = 2 (1 + ) √fc′ bw d
2000Ag
Where Nu/Ag is expressed in psi.
If section is subjected to a tensile force so that the tensile stress is less than 500 psi:
Nu
Vc = 2 (1 + ) √fc′ bw d
500Ag
If section is subjected to a tensile force so that the tensile stress exceeds 500 psi, it is
assumed Vc = 0.
The calculated result for both element ends is stored in the CivilFEM results file as the
parameter VC:
9) Obtaining shear criterion. The section will be valid for shear if the following condition is
satisfied:
Vu ≤ ϕVn = ϕ(Vc + Vs )
φ strength reduction factor of the section, (0.85 for shear and torsion).
Therefore, the shear criterion for the validity of the section is defined as follows:
Vu
CRT_TOT = ≤1
ϕVn
For each element, this value is stored in the CivilFEM results file as the parameter
CRT_TOT.
If the strength provided by concrete is null and the shear reinforcement is not defined in
the section, then Vn = 0, and the criterion will be equal to 2100.
1) Obtaining material strength properties. These properties are obtained from the
material properties associated with each transverse cross section and for the active
time.
Section 6.6.1. provides detailed information on how to calculate the required data for
each code and valid section.
6) Calculating the shear strength provided by concrete. First, we calculate the shear
strength provided by concrete (Vc) with the following expression:
Vc = 2√fc′ bw d
where:
√fc′ square root of specified compressive strength of concrete, in psi (always taken
as less than 100 psi).
For sections subject to a compressive axial force:
Nu
Vc = 2 (1 + ) √fc′ bw d
2000 Ag
Where Nu /Ag is expressed in psi.
If section is subjected to a tensile force so that the tensile stress is less than 500 psi:
Nu
Vc = 2 (1 + ) √fc′ bw d
500 Ag
If section is subjected to a tensile force so that the tensile stress exceeds 500 psi, it is
assumed Vc = 0.
The calculated result is stored in the CivilFEM results file for both element ends as the
parameter:
Vu =≤ ϕVn = ϕ(Vc + Vs )
Therefore, the required shear force of the reinforcement must be:
Vu
Vs = −Vc ≤ 8√fc′ bw d
ϕ
If the required shear strength of the reinforcement does not satisfy the expression
above, the section will not be designed. Consequently, the parameters for the
reinforcement data will be defined as 2100. Therefore:
As
ASSH = = 2100
S
In this case, the element will be labeled as not designed, and the program will then
advance to the following element.
Calculated results are stored in the CivilFEM results file for both element ends as the
parameter:
VS = Vs ≤ 8√fc′ bw d
8) Calculating the required reinforcement ratio. Once the required shear strength of the
reinforcement has been obtained, the reinforcement can be calculated with the
following expression:
Av Vs
=
s fy (sin α + cos α)d
Where:
Av
ASSH =
s
In this case, the element will be labeled as designed (providing the design procedure is
correct for both element sections).
1) Obtaining material strength properties. These properties are obtained from the
material properties associated with each transverse cross section and for the active
time.
4) Obtaining reinforcement data of the section. Required data are the following:
angle between shear reinforcement and the longitudinal axis of the member.
As /S area of reinforcement per unit of length.
The reinforcement ratio may also be obtained with the following data:
diameter of bars.
5) Obtaining forces and moments acting on the section. The shear force that acts on the
section is obtained from the CivilFEM results file (.RCF).
Force Description
6) Checking failure by compression in the web. First, a check is made to ensure the design
shear force (VSd) is less than or equal to the oblique compression resistance of the
concrete in the web (VRd2). VRd2 is calculated with Model I if = 45º and with Model II if
≠ 45º:
VSd ≤ VRd2
Model I
Model II
For each element end, calculated results are written in the CivilFEM results file:
VSd ≤ VRd3
VRd3 = Vc + Vsw
Vsw contribution of web shear transverse reinforcement to the shear strength.
Vc contribution of concrete to the shear strength.
Model I
Asw
Vsw = 0.9 ∙ d ∙ fywd (sin α + cos α)
S
Where
Model II
Asw
Vsw = 0.9 ∙ d ∙ fywd (cot anα + cot anα) ∙ sin α
S
Where
For each end, calculated results are written in the CivilFEM results file:
8) Obtaining shear criterion. The shear criterion indicates whether the section is valid for
the design forces (if it is less than 1, the section satisfies the code prescriptions; whereas
if it exceeds 1, the section will not be valid). Furthermore, it includes information about
how close the design force is to the ultimate section strength. The shear criterion is
defined as follows:
VSd VSd
CRT_TOT = Max ( ; )
VRd2 VRd3
For each element end, this value is stored in the CivilFEM results file as CRT_TOT.
A value 2100 for this criterion indicates that the shear strength due to tension in the web
(VRd3) is equal to zero, as was indicated in the previous step.
1) Obtaining material strength properties. These properties are obtained from the
material properties associated with each transverse cross section and for the active
time.
he effective thickness.
Ae area involved by the center-line of the effective hollow section.
Ue perimeter of the center-line of the effective hollow section.
Angle of the compressive struts of concrete with the longitudinal axis of
member:
30º < < 45º
Section 6.6.1.. provides detailed information on how to calculate the required data for
each code and valid section.
3) Obtaining reinforcement data of the section. Required data are the following:
Transverse Reinforcement
ASt /S area of transverse reinforcement per unit of length.
The reinforcement ratio can also be obtained with the following data:
Longitudinal Reinforcement
Asl total area of the longitudinal reinforcement.
The reinforcement ratio can also be obtained from the following data:
Moment Description
5) Checking compression failure of concrete. Firstly, a check is made to ensure the design
torsional moment (TSd) is less than or equal to the ultimate torsional moment cause by
the compression of the concrete (TRd2); therefore, the following condition must be
satisfied:
TSd ≤ TRd2
TRd2 = 0.50 ∙ αv2 ∙ fcd ∙ Ae ∙ he ∙ sin 20
Where:
ck f
Av2 = 1 − 250 (fck in MPa).
TRD2 Maximum torsional moment resisted by the section without crushing the
concrete compressive struts due to compression.
TRD2 = TRd2
CRTTRD2 Ratio of the design torsional moment (TSd) to the resistance TRd2.
TSd
CRTTRD2 =
R Rd2
6) Checking transverse reinforcement failure. The condition for tensile failure of the
transverse reinforcement when a torsional moment TSd is applied is as follows:
TSd ≤ TRd3
TRd3 = (Ast /s) ∙ fywd ∙ 2Ae ∙ cot anθ
where:
7) Checking longitudinal reinforcement failure. The condition of tensile failure for the
longitudinal reinforcement when a torsional moment TSd is applied is as follows:
TSd ≤ TRd4
TRd4 = (Asl /Ue ) ∙ fywd ∙ 2Ae ∙ tan θ
where:
A value 2100 for this criterion would indicate the non-definition of one of the torsion
reinforcements.
1) Torsion checking considering a null shear force. This check is accomplished with the
same steps as for the check of elements subjected to pure torsion according to
NBR6118.
Except for this check, the CRT_TOT criterion is stored in the CivilFEM results file as
CRTTRS for each element end.
1) Shear checking assuming a null torsional moment. This check follows the same
procedure as for the checking of elements only subjected to shear according to
NBR6118.
Except for this check, the CRT_TOT criterion is stored in the CivilFEM results file as
CRTSHR for each element end.
VSd TSd
( )+( )≤1
VRd2 TRd2
where:
For each element, this criterion value is stored in the CivilFEM results file as CRTCST.
4) Obtaining the combined shear and torsion criterion. This criterion considers pure
shear, pure torsion and concrete ultimate strength condition criteria. The criterion
determines whether the section is valid and is defined as follows:
A value 2100 for this criterion indicates that one of the denominators is null, and
therefore, one of the reinforcements is not defined.
1) Obtaining material strength properties. These properties are obtained from the
material properties associated with each transverse cross section and for the active
time.
2) Obtaining section geometrical data. Required data for shear designing are the
following:
3) Obtaining geometrical parameters depending on specified code. Required data are the
following:
4) Obtaining reinforcement data of the section. With the shear reinforcement design, it is
possible to indicate the angle btetweeen the reinforcement and the longitudinal axis
of the member. If this angle is null or it is not defined, = 90º. Other reinforcement
data are ignored.
5) Obtaining forces and moments acting on the section. The shear force that acts on the
section is obtained from the CivilFEM results file (.RCF).
Force Description
6) Checking compression failure in the web. Firstly, a check is made to ensure the design
shear force (VSd) is less than or equal to the oblique compression resistance of concrete
in the web (VRd2). VRd2 is calculated with Model I Model II if
VSd ≤ VRd2
Model I
f
ck
αv2 = 1 − 250 (fck in MPa).
Model II
For each element end, calculated results are written in the CivilFEM results file as:
Asw 100
ASSH = 2
s
In this case, the element is labeled as not designed and the program then advances then
to next element.
In the case there is no failure due to oblique compression, the calculation process
continues.
7) Checking if shear reinforcement will be required. First, a check is made to ensure the
design shear force (Vsd) is less than or equal to the strength provided by the concrete in
members without shear reinforcement (Vc). VRd3 is calculated with Model I
with Model II
VSd ≤ VRd3
VRd3 = Vc
Model I
Model II
0 Only tension in the section
Vc = {
Vc1 Tension and compression in the section
If the section does not require shear reinforcement, the following parameters are
defined (for both element ends):
VC = Vc
VRD3 = VRd3 = Vc
VSW = 0
Asw
ASSH = =0
s
If the section requires shear reinforcement the calculation process continues.
VSd ≤ VRd3
VRd3 = Vc + Vsw
Vsw contribution of web shear transverse reinforcement to the shear strength.
Vc contribution of concrete to the shear strength.
Model I
Asw
Vsw = 0.9 ∙ d ∙ fywd (sin α + cos α)
S
Where
Model II
Asw
Vsw = 0.9 ∙ d ∙ fywd (cot anα + cot anθ) ∙ sinα
S
Where
Vsw = VRd3 − Vc
For each element end, the value of Vc and Vsw is stored in the CivilFEM results file:
VC = Vc
VSW = Vsw
10) Caculating the required reinforcement ratio. Once the required shear strength of the
reinforcement has been obtained, the reinforcement ratio can be calculated:
Asw Vsw
= for Model I
s 0.9 ∙ d ∙ fywd (sin α + cos α)
Asw Vsw
= for Model II
s 0.9 ∙ d ∙ fywd (cot an α + cot an α) ∙ sin α
Where:
Asw /S cross-sectional area of the designed shear reinforcement per unit length.
fywd design strength of reinforcement, limited to 435 MPa.
The area of designed reinforcement per unit length is stored in the CivilFEM results file
for both ends:
Asw
ASSH =
S
In this case the element is labeled as designed (provided that the design process is
correct for both element sections).
1) Obtaining material strength properties. These properties are obtained from the
material properties associated with each transverse cross section and for the active
time.
Section 6.6.1.. provides detailed information on how to calculate the required data for
each code and valid section.
3) Obtaining forces and moments acting on the section. The torsional moment that acts
on the section is obtained from the CivilFEM results file (.RCF).
Moment Description
4) Checking compression failure of concrete. First, the design torsional moment (TSd) must
be less than or equal to the ultimate torsional moment due to compression in the
concrete (TRd2); therefore, the following condition must be satisfied:
TSd ≤ TRd2
TRd2 = 0.50 ∙ αv2 ∙ fcd ∙ Ae ∙ he ∙ sin2 θ
Where:
f
ck
αv2 = 1 250 (fck in MPa).
TRD2 Maximum torsional moment resisted by the section without crushing the
concrete compressive struts due to compression.
TRD2 = TRd2
CRTTRD2 Ratio of the design torsional moment (TSd) to the resistance TRd2.
TSd
CRTTRD2 =
TRd2
If design torsional moment is greater than the torsional moment that causes the
compression failure of concrete, the reinforcement design is not feasible. Therefore, the
parameters for reinforcement data are assigned a value of 2100.
Ast
ASTT = = 2100 for transverse reinforcement
S
In the case there is no failure due to oblique compression, the calculation process
continues.
ASt TSd
= tan θ
S fywd ∙ 2Ae
The area per unit length of the designed transverse reinforcement is stored in the
CivilFEM results file for both element ends as:
Ast
ASTT =
S
6) Calculating the longitudinal reinforcement required. The ultimate strength condition of
the longitudinal reinforcement is:
Ue
ASl = ∙ T ∙ cot an θ
fywd ∙ 2Ae Sd
The area of the designed longitudinal reinforcement is stored in the CivilFEM results file
for both element ends as:
ASLT = Asl
If the design for both element sections is completed for both transverse and longitudinal
reinforcements, the element will be labeled as designed.
1) Torsion design considering a null shear force. This design is accomplished with the
same steps as for the designing of elements subjected to pure torsion according to
NBR6118.
2) Shear design assuming a null torsional moment. This design follows the same
procedure as for the design of elements only subjected to shear force according to
NBR6118.
3) Checking the failure condition by compression in the concrete. The design torsional
moment (TSd) and the design shear force (VSd) must satisfy the following condition:
VSd TSd
( )+( )≤1
VRd2 TRd2
where:
For each element end, this criterion value is stored in the CivilFEM results file as CRTCST.
4) Obtaining required shear and torsion reinforcement ratios. If the concrete ultimate
strength condition is satisfied (i.e. the concrete can resist the combined shear and
torsion action), the reinforcements calculated are taken as the designed reinforcements.
The element will be labeld as designed.
The checking for shear according to EHE-08 follows the steps below:
1) Obtaining material strength properties. These properties are obtained from the material
properties associated to each transverse cross section and for the active time.
The required data are the following:
fck characteristic compressive strength of concrete.
φ diameter of bars.
5) Obtaining forces and moments acting on the section. The shear force that acts on the
section, as well as the concomitant axial force and bending moment, are obtained from
the CivilFEM results file.
Force Description
6) Checking failure by compression in the web. First, a check is made to ensure the design
shear force (Vrd ) is less than or equal to the oblique compression resistance of concrete
in the web (Vu1 ):
Vrd ≤ Vu1
cot θ + cot α
Vu1 = K f1cd bw ∙ d
1 + cot 2 θ
where:
1 σ′cd = 0
σ′cd
1+ 0 < σ′cd ≤ 0.25 ∙ fcd
fcd
𝐾
1.25 0.25 ∙ fcd < σ′cd ≤ 0.50 ∙ fcd
σ′cd
2.5 (1 − ) 0.50 ∙ fcd < σ′cd ≤ fcd
{ fcd
σ′cd effective axial stress in concrete (compression positive) considering the axial
stress taken by compressed reinforcement.
For each element end, calculated results are written in the CivilFEM results file:
Vrd ≤ Vu2
Vu2 = Vsu + Vcu
Vsu contribution of web shear transverse reinforcement to the shear strength.
Vcu contribution of concrete to the shear strength.
Vsu = 0
0.18
Vu2 = Vcu = [ ξ(100ρ1 fck )1/3 + 0.15σ′cd ] bw d
γc
0.075 3/2
Vu2 >[ ξ √fck + 0.15σ′cd ] bw d
γc
where:
Nd
σ′cd = < 0.30 ∙ fcd ≤ 12 MPa (Compression positive)
Ac
200
ξ= 1+√ < 2, d in mm
d
As
Vsu = 0.9 d sin α(cot α + cot θ) f
S yd
where:
0.15
Vcu = [ ξ(100 ρ1 fck )1/3 + 0.15σ′cd ] bw d β
γc
where:
2 cot θ − 1
β= if 0.5 ≤ cot θ < cot θe
2 cot θe − 1
cot θ − 2
β= if cot θe ≤ cot θ ≤ 2.0
cot θe − 2
2
√fct,m − fct,m (σxd + σyd ) + σxd σyd
≥ 0.5
cot θe = {
fct,m − σyd ≤ 2.0
σxd , σyd design normal stresses, at the section’s center of gravity, parallel to the
longitudinal axis of member and the shear force Vd respectively (tension
positive)
σ
Taking σyd = 0 cot θe = √1 − f xd
ct,m
In addition, the increment in tensile force due to shear force is calculated with the
following equation:
Vsu
∆T = Vrd · cot θ − · cot θ + cot α
2
For each end, calculated results are written in the CivilFEM results file as:
The tension increment due to shear force is stored in the CivilFEM results file as
INCTENS.
8) Obtaining shear criterion. The shear criterion indicates whether the section is valid or
not for the design forces (if it is less than 1, the section satisfies the code provisions;
whereas if it exceeds 1, the section will not be valid). Furthermore, it includes
information about how close the design force is to the ultimate section strength. The
shear criterion is defined as follows:
Vrd Vrd
CRT_TOT = Max ( ; )≤1
Vu1 Vu2
For each element end, this value is stored in the CivilFEM results file as CRT_TOT.
A value 2100 for this criterion indicates that the shear strength for tension in the web
(Vu2 ) is equal to zero, as was described in the previous step.
1) Obtaining material strength properties. These properties are obtained from the material
properties associated to each transverse cross section and for the active time.
=1 if there are closed stirrups only along the periphery of the member (value by
default for solid sections).
Transverse Reinforcement
Ast /S area of transverse reinforcement per unit of length.
The reinforcement ratio can also be obtained with the following data:
Longitudinal Reinforcement
Asl total area of the longitudinal reinforcement.
The reinforcement ratio can also be obtained with the following data:
Moment Description
5) Checking compression failure of concrete. First, a check is made to ensure the design
torsional moment (Td ) is less than or equal to the ultimate torsional moment due to
compression in the concrete (Tu1 ); as a result, the following condition must be satisfied:
Td ≤ Tu1
cot θ
Tu1 = 2Kα f1cd Ae he
1 + cot 2 θ
Where:
TU1 Maximum torsional moment that can be resisted by the section without
crushing due to compression of concrete compressive struts.
TU1 = Tu1
CRTTU1 Ratio of the design torsional moment (Td ) to the resistance Tu1 .
Td
CRTTU1 =
Tu1
6) Checking transverse reinforcement failure. The tensile failure condition of the
transverse reinforcement in a section subjected to a torsional moment Td is:
Td ≤ Tu2
2 Ae At
Tu2 = fyd cot θ
S
where:
Td ≤ Tu3
2 Ae
Tu3 = A f tan θ
Ue sl yd
Where Asl is the area of the longitudinal torsion reinforcement.
Td Td Td
CRT_TOT = Max ( ; ; )≤1
Tu1 Tu2 Tu3
For each element end, this value is stored in the CivilFEM results file as CRT_TOT.
A value 2100 for this criterion indicates that any one of the torsion reinforcements are
not defined.
1) Torsion checking considering a null shear force. This check is accomplished with the
same steps as for the check of elements subjected to pure torsion according to EHE-08.
For each element end, this value is stored in the CivilFEM results file as CRTTRS.
2) Shear checking assuming a null torsional moment. Follows the same procedure as for
the check of elements only subjected to shear according to EHE-08.
For each element end, this value is stored in the CivilFEM results file as CRTSHR.
3) Checking the ultimate compressive strength condition of concrete. The design torsional
moment (Td ) and the design shear force (Vrd ) must satisfy the following condition:
TSd β VSd β
( ) +( ) ≤1
Tu1 Vu1
Where:
he
β = 2 (1 − )
bw
Tu1 ultimate torsional moment due to compression of concrete, calculated in step
No. 1.
For each element, this criterion value is stored in the CivilFEM results file as CRTCST.
4) Obtaining the combined shear and torsion criterion. This criterion comprehends pure
shear, pure torsion and concrete ultimate strength condition criteria. The criterion
determines whether the section is valid or not, and it is defined as follows:
A value 2100 for this criterion indicates that one of the denominators is null, because one
of the reinforcements is not defined.
bw Width of element equal to the total width in solid sections or in case of box
sections, the width equals the sum of the width of both webs.
d effective depth of the section.
Force Description
6) Checking compression failure in the web. First, a check is made to ensure the
design shear force (Vrd ) is less than or equal to the oblique compression resistance of
concrete in the web (Vu1 ):
Vrd ≤ Vu1
cot θ+cot α
Vu1 = K f1cd bw ∙ d 1+cot2 θ
where:
σ′cd effective axial stress in concrete (compression positive) considering the axial
stress taken by reinforcement in compression.
For each element end, calculated results are written in the CivilFEM results file as:
VU1 Ultimate shear strength due to oblique compression of the concrete in web.
VU1 = Vu1
CRTVU1 Ratio of the design shear force (VRd ) to the resistance Vu1 .
V
CRTVU1 = Vrd
u1
If the design shear force is greater than the shear force that causes failure due to oblique
compression in the concrete of the web, the reinforcement design will not be feasible. The
parameter where the reinforcement data is stored will be defined as 2100.
As
ASSH = = 2100
s
In this case, the element is labeled as not designed, and the program then advances to next
element.
In the case there is no failure due to oblique compression, the calculation process continues.
Vrd ≤ Vu2
0.18
Vu2 = Vcu = [ ξ(100ρ1 fck )1/3 + 0.15σ′cd ] bw d
γc
0.075
Vu2 > [ γ ξ3⁄2 √fck + 0.15σ′cd ] bw d
c
where:
Nd
σ′cd = < 0.30 ∙ fcd ≤ 12 MPa (Compression positive)
Ac
200
ξ= 1+√ < 2, d in mm
d
VCU = Vcu
VU2 = Vcu
VSU = 0
As
ASSH = =0
s
Vrd ≤ Vu2
Vu2 = Vsu + Vcu
Vsu contribution of transverse shear reinforcement in the web to the shear strength.
Vcu contribution of concrete to the shear strength.
0.15
Vcu = [ ξ(100ρ1 fck )1/3 + 0.15σ′cd ] bw d β
γc
where:
2 cot θ−1
β = 2 cotθ if 0.5 ≤ cot θ < cot θe
e −1
cot θ−2
β = cot θ if cot θe ≤ cot θ ≤ 2.0
e −2
σxd , σyd design normal stresses, at the center of gravity of the section, parallel to the
longitudinal axis of the member or to the shear force Vd , respectively (tension positive)
σxd
Taking σyd = 0 → cot θe = √1 − f
ct,m
VCU = Vcu
VSU = Vsu
9) Required reinforcement ratio. Once the required shear strength of the shear
reinforcement has been obtained, the reinforcement ratio can be calculated from the
equation below:
As Vsu
=f
S yd 0.9 d (cot α+cot θ)
Where:
In this case, the element is labeled as designed (provided that the design process is correct
for both element sections).
=0 if closed stirrups are placed in both faces of the equivalent hollow section wall
or of the real hollow section (value by default for hollow sections).
=1 if closed stirrups are only placed along the periphery of the member (value by
default for solid sections).
3) Obtaining forces and moments acting on the section. The torsional moment
that acts on the section is obtained from the CivilFEM results file.
Moment Description
Td ≤ Tu1
cot θ
Tu1 = 2Kα f1cd Ae he 1+cot2 θ
where:
1.20 if stirrups are only placed along the periphery of the member.
1.50 if closed stirrups are placed at both faces of the wall of the effective hollow
section or of the real hollow section.
If design torsional moment is greater than the torsional moment that causes the
compression failure of concrete, the reinforcement design will not be feasible. Therefore,
the parameters for the reinforcement data will be defined as 2 100.
Ast
AST/ST = = 2100 for transverse reinforcement
S
In the case there is no failure due to oblique compression, the calculation process
continues.
where:
At area of the section of one of the bars used as transverse reinforcement for
torsion.
s spacing of the closed stirrups of the transverse reinforcement for torsion.
Therefore, the required transverse reinforcement is:
At T
= 2 A df tan θ
S e yd
The area per unit length of the designed transverse reinforcement is stored in the CivilFEM
results file for both element ends as:
At
ASTT = S
The area of the designed longitudinal reinforcement is stored in the CivilFEM results file for
both element ends as:
ASLT = Asl
If design for both element sections is done for both transverse and longitudinal
reinforcements, and the element will be labeled as designed.
1) Torsion design considering a null shear force. This design is accomplished with the
same steps as for the design of elements subjected to pure torsion according to EHE-08.
2) Shear design assuming a null torsional moment. This design follows the same
procedure as for the design of elements only subjected to shear force according to EHE-
08.
3) Checking the failure condition by compression in the concrete. The design torsional
moment (Td) and the design shear force (Vrd) must to satisfy the following condition:
TSd β VSd β
( ) +( ) ≤1
Tu1 Vu1
where:
he
β = 2 (1 − )
bw
Tu1 ultimate torsional moment due to compression of concrete, calculated in step
1.
For each element end, this criterion value is stored in the CivilFEM results file as CRTCST.
4) Obtaining required shear and torsion reinforcement ratios. If the concrete ultimate
strength condition is satisfied (i.e. the concrete can resist the combined shear and
torsion action), the reinforcements calculated in steps 1 and 2 are taken as the designed
reinforcements. The element will be labeled as designed.
If the concrete ultimate strength condition is not satisfied, the parameters corresponding to
each reinforcement group will take the value 2100.
1) Obtaining material strength properties. These properties are obtained from the material
properties associated with each transverse cross section and for the active time. Those
material properties should be previously defined. The required data are the following:
fck characteristic compressive strength of concrete.
fy characteristic yield strength of reinforcement.
γc partial safety factor for concrete.
γs partial safety factor for reinforcement.
6) Calculating the nominal shear stress. The nominal shear stress is calculated by the
following expression:
Vu
τv ≤
bw ∙ d
This stress is written for each end of the element in the CivilFEM results file as:
TAOV Shear strength
TAOV = τv
7) Checking of the maximum shear stress. The nominal shear stress must be less than or
equal to the maximum shear stress:
τv ≤ τc max
where τc max is given in Table 20 according to the concrete type:
Results are stored for each end in the CivilFEM results file as the following parameters:
where:
For members subjected to axial compression Pu, the design shear strength of concrete,
given in Table 19, shall be multiplied by the following factor:
3Pu
δ= 1+ ≤ 1.5
Ac fck
Asw
Vus = 0.87fy d(sin α + cos α)
s
Asw total cross sectional area of the shear reinforcement
s spacing of the stirrups along the axis of the member
Results are stored for each end in the CivilFEM results file as the following parameters:
9) Obtaining shear criterion. The shear criterion indicates whether the section is valid or
not for the design forces (if it is less than 1, the section satisfies the code prescriptions,
whereas if it exceeds 1, the section will not be valid). Furthermore, it includes
information about how close is the design force from the ultimate section strength. The
shear criterion is defined as follows:
τv Vu
CRT_TOT = Max ( ; )≤1
τc max Vut
For each end, this value is stored in the CivilFEM results file as the parameter CRT_TOT.
A value of 2100 for this criterion would mean that Vut are equal to zero.
1) Obtaining material strength properties. These properties are obtained from the material
properties associated with the transverse cross section and for the active time.
2) Obtaining of the geometrical parameters of the section. Geometrical parameters of the
section must be defined within the CivilFEM database.
3) Obtaining geometrical parameters depending on specified code. The required data are
the following:
bw effective width of the section.
The reinforcement ratio may also be obtained with the following data:
The reinforcement ratio can also be obtained with the following data:
5) Obtaining section internal forces and moments. The forces and moments that acts on
the section are obtained from the CivilFEM results file.
Force/Moment Description
6) Calculating the equivalent shear. Equivalent shear shall be calculated from the following
formula:
Tu
Ve = Vu + 1.6
bw
7) Calculating the equivalent nominal shear stress. The equivalent nominal shear stress
shall be calculated from the following formula:
Ve
τve ≤
bw ∙ d
Results are written in the CivilFEM results file for both element ends as the parameters:
8) Checking with the maximum shear stress. The equivalent nominal shear stress must be
less than or equal to the maximum shear stress:
τve ≤ τc max
c max is given in Table 20 according to the type of concrete:
Results are stored for each end in the CivilFEM results file as the following parameters:
Results are stored for each end in the CivilFEM results file as the following parameters:
1 + D⁄b
w
Mt = Tu ( )
1.7
D overall depth
12) Obtaining total criterion. The criterion of the combined axial, bending, shear and
torsional checking is obtained from the enveloping of the partial criterions. If it is less
than 1, the section is valid; if it exceeds 1, the section is not valid:
CRT_TOT = Max (CRTCMAX; CRTATT; CRTASL)
This value is stored in the CivilFEM results file for both element
ends as the parameter CRT_TOT.
A value of 2100 for this criterion indicates that the shear and
torsion transverse reinforcements have not been defined.
ρ1 ratio of the tensile reinforcement extending beyond the effective depth of the
considered section, except in supports where the total area of the tensile reinforcement is
used.:
Asl
ρ1 = b
w d
Force Description
This stress is written for each end in the CivilFEM results file as:
τv ≤ τc max
c max is given in Table 20 according to the concrete type:
Results are stored for each end in the CivilFEM results file as the following
parameters:
TCMAX Maximum shear stress.
TCMAX = τc max
CRTCMAX Ratio of the nominal shear stress to the shear maximum stress.
τv
CRTCMAX = τ
c max
If the nominal shear stress is greater than the maximum shear stress, the
reinforcement design will not be possible; therefore, the parameter where the
reinforcement amount is stored will be defined as 2100.
As
ASSH = = 2100
S
In this case, the element will be labeled as not designed, advancing then to the
following element end.
where:
Vu design shear force
Vut shear resistance of the section
Vuc concrete contribution to the shear strength
Vus shear reinforcement contribution to the shear strength
Therefore, the shear reinforcement contribution shall be:
Vus = Vu − Vuc
The concrete contribution to the strength is:
Vuc = τc ∙ bw ∙ d
c is given in Table 19 according to the concrete type and the amount of the
longitudinal tension reinforcement:
For members subjected to axial compression Pu, the design shear strength of
concrete, given in Table 19, shall be multiplied by the following factor:
3Pu
δ= 1+A ≤ 1.5
c fck
For each element end, the Vus value is included in the CivilFEM results file as the
parameter:
VUS = Vus
9) Calculating the required reinforcement ratio. The resistance contribution of
the shear reinforcement is calculated with the following expression:
Asw
Vus = 0.87fy d(sin α + cos α)
S
Asw area of the cross-section of the shear reinforcement
s spacing of the stirrups measured along the longitudinal axis
Therefore:
Asw Vus
= 0.87f
S y d(sin α+cos α)
The area of the designed reinforcement per unit length is stored in the CivilFEM
results file for both element ends:
Asw
ASSH = S
In this case, the element will be labeled as designed (providing the design procedure
is correct for both element sections).
If the reinforcement design is not possible, the reinforcement value is taken as 2 100
and the element will be considered not designed.
DSG_CRT Design criterion (Ok the element is designed and NotOk the element is not
designed).
1) Obtaining material strength properties. These properties are obtained from the material
properties associated to each transverse cross section and for the active time,.
The required data are the following:
Asl
ρ1 =
bw d
6) Calculating the equivalent shear. Equivalent shear shall be calculated from the following
formula:
Tu
Ve = Vu + 1.6
bw
7) Calculating the equivalent nominal shear stress. The equivalent nominal shear stress
shall be calculated from the following formula:
Ve
τve ≤
bw ∙ d
Results are written in the CivilFEM results file for both element ends as the parameters:
8) Checking with the maximum shear stress. The equivalent nominal shear stress must be
less than or equal to the maximum shear stress:
τve ≤ τc max
c max is given in Table 20 according to the type of concrete:
Results are stored for each end in the CivilFEM results file as the following parameters:
As
ASSH = = 2100
S
9) Checking whether the section will require transverse reinforcement. This reinforcement
is not required if the equivalent nominal shear stress is less than or equal to the
maximum shear stress:
τve ≤ τc
c is
given in Table 19 according to the concrete type and the amount of the
longitudinal tension reinforcement:
Results are stored for each end in the CivilFEM results file as
the following parameters:
ATT Area of the required transverse reinforcement.
Asv
ATT = =0
Sv
10) Calculating the required transverse reinforcement. If the equivalent nominal stress
exceeds the maximum shear stress, the required transverse reinforcement will be
calculated by:
Asv Tu Vu
= +
Sv bw d1 (0.87fy ) 2.5 d1 (0.87fy )
ATT Area of the necessary transverse reinforcement
Asv
ATT = ( )
Sv nec
11) Calculating the longitudinal reinforcement amount. A check is made to ensure the
defined longitudinal bending reinforcement resists an equivalent bending moment given
by the formula:
Mel = Mu + Mt
where
1 + D⁄b
w
Mt = Tu ( )
1.7
D overall depth
REINFACT = 2100
If the reinforcement design is not possible at both ends, the reinforcement value is taken
as 2100 and the element will be considered not designed.
DSG_CRT Design criterion (Ok the element is designed and NotOk the element is
not designed).
Wk ≤ Wmax
where:
Wk Design crack width.
Wmax Maximum crack width
The design crack width is obtained from the following expression (Art. 7.3.4):
fct,eff
σs −kt (1+αe ρp,eff )
ρp,eff σ
εsm − εcm = ≥ 0.6 Es
Es s
Where 1 is the larger tensile strain and 2 is the smaller tensile strain at the
boundary of a section subjected to eccentric tension.
k 3 , k 4 Constants defined in the National Annexes.
POS Cracking position inside the section. (Not valid for decompression
checking).
1 Upper fiber.
-1 Lower fiber.
For the cracking check (wmax > 0) the total criterion is defined as:
Wk
CRT_TOT = W
max
Therefore, values for the total criterion larger than one indicate that the section does
not pass as valid for this code.
sd ≤ s
Where:
sd Reinforcement spacing closest to the fiber in tension
s Design reinforcement spacing
CivilFEM checks this condition by applying the general calculation method for the
reinforcement spacing (Art. 10.6.4):
40,000
s = 15 ( ) − 2.5c𝑐
𝑓𝑠
where:
fs Calculated stress in reinforcement at service loads.
cc Geometrical cover
The calculation of the stresses is an iterative process in which the program searches for the
deformation plane that causes a stress state that is in equilibrium with the external loads.
The reinforcement stress is obtained from this deformation plane and from the
reinforcement position.
If the loads acting on the cross section cause collapse under axial plus bending checking, the
cross section and the element to which it belongs are marked as non checked.
checking).
POS Cracking position inside the section. (Not valid for decompression
checking).
1 Upper fiber.
-1 Lower fiber.
For the cracking check (sd > 0) the total criterion is defined as:
Sd
CRT_TOT =
S
where
With CivilFEM it is possible to accomplish the following check and analysis types:
Valid cross-sections supported by CivilFEM for checks according to Eurocode 3 are the
following:
All rolled shapes included in the program libraries (see the hot rolled shapes library).
The following welded beams: double T shapes, U or channel shapes, T shapes, box,
equal and unequal legs angles and pipes.
Structural steel sections defined by plates.
CivilFEM considers the above sections as sections composed of plates; for example, an I-
section is composed by five plates: four flanges and one web. These cross sections are
YCF ZEC3
YS
ZCF G YEC3
ZS
O
For the Eurocode 3 axes system:
YEC3 axis is the relevant axis for bending and its orientation is defined by the
user (in steel check process).
To define this reference system, the user must indicate which direction of the CivilFEM axis
(-Z, -Y, +Z or +Y) coincides with the relevant axis for positive bending. The user may define
this reference system when checking according to this code. In conclusion, the code
reference system coincides with that of CivilFEM, but it is rotated a multiple of 90 degrees,
as shown in table below.
Description Property
M0
Partial safety factors M1
M2
Elasticity modulus E
Poisson coefficient
Shear modulus G
*th =thickness of the plate
Gross section data correspond to the nominal properties of the cross-section. For the net
section, only the area is considered. This area is calculated by subtracting the holes for
screws, rivets and other holes from the gross section area. The area of holes is introduced
within the structural steel code properties.
Effective section data and section and plates class data are obtained in the checking process
according to the effective width method. For class 4 cross-sections, this method subtracts
the non-resistance zones for local buckling. However, for cross-sections of a lower class, the
sections are not reduced for local buckling.
In the following tables, the section data used in Eurocode 3 are shown:
Description Data
Input data:
1.- Height H
2.- Web thickness Tw
3.- Flanges thickness Tf
4.- Flanges width B
5.- Distance between flanges Hi
6.- Radius of fillet (Rolled shapes) r1
7.- Toe radius (Rolled shapes) r2
8.- Weld throat thickness (Welded shapes) a
9.- Web free depth d
Input data:
1.- Depth in Y Tky CivilFEM
2.- Depth in Z tkz CivilFEM
3.- Cross-section area A
4.- Moments of inertia for torsion It CivilFEM
5.- Moments of inertia for bending Iyy, Izz CivilFEM
6.- Product of inertia Izy CivilFEM
7.- Elastic resistant modulus Wely, Welz CivilFEM
8.- Plastic resistant modulus Wply, Wplz CivilFEM
9.- Radius of gyration iy, iz CivilFEM
10.- Gravity center coordinates Ycdg, Zcdg Section
11.- Extreme coordinates of the perimeter Ymin, Ymax, Section
Zmin, Zmax
12.- Distance between GC and SC in Y and in Z Yms, Zms Section
13.- Warping constant Iw
The effective section depends on the section geometry and on the forces and moments that
are applied to it. Consequently, for each element end, the effective section is calculated.
Output data:
1.- Cross-section area Aeff
2.- Moments of inertia for bending Iyyeff, Izzeff CivilFEM
3.- Product of inertia Izyeff CivilFEM
4.- Elastic resistant modulus Wyeff, Wzeff CivilFEM
5.- Gravity center coordinates Ygeff, Zgeff Section
6.- Distance between GC and SC in Y and in Z Ymseff, Zmseff Section
7.- Warping constant Iw
8.- Shear resistant areas Yws, Zws CivilFEM
Description EN 1993-1-
1:2005
Input data:
Description EN 1993-1-
1:2005
buckling length for plane XY =L*K XY ) (Effective buckling length
for plane XZ =L*K XZ ).
3.- Lateral buckling factors, depending on the load and restraint C1, C2, C3
conditions.
4.- Equivalent uniform moment factors for flexural buckling. CMy, CMz
Calculated properties:
e. If necessary for the type of check (check for buckling), calculate the critical
forces and moments of the section for buckling: elastic critical forces for the
XY and XZ planes and elastic critical moment for lateral-torsional buckling.
(See section: Calculation of critical forces and moments).
f. Obtain internal forces and moments: NEd , Vy.Ed , Vz.Ed , Mx.Ed , My.Ed , Mz.Ed
within the section.
g. Specific section checking according to the type of external load. The specific
check includes:
1. If necessary, selecting the forces and moments considered for the
determination of the section class and used for the checking process.
2. Obtaining the cross-section class and calculating the effective section
properties.
3. Checking the cross-section according to the external load and its class by
calculating the check criterion.
h. Store the results.
1. Plate function: webs and flanges in Y and Z axis, according to the considered
relevant axis of bending.
2. Plate union condition: internal plates or outstand plates.
For sections included in the program libraries, the information above is defined for each
plate. CivilFEM classifies plates as flanges or webs according to their axis and provides the
plate union condition for each end. Ends can be classified as fixed or free (a fixed end is
connected to another plate and free end is not).
For checking the structure for safety, Eurocode 3 classifies sections as one of four possible
classes:
Class 1 Cross-sections which can form a plastic hinge with the rotation capacity
required for plastic analysis.
Class 2 Cross-sections which can reach their plastic moment resistance, but have
limited rotation capacity.
Class 3 Cross-sections for which the stress in the extreme compression fiber of the
steel member can reach the yield strength, but local buckling is liable to
prevent the development of the plastic moment resistance.
Class 4 Cross-sections for which it is necessary to make explicit allowances for the
effects of local buckling when determining their moment resistance or
compression resistance.
The cross-section class is the highest (least favorable) class of all of its elements: flanges and
webs (plates). First, the class of each plate is determined according to the limits of Eurocode
3. The plate class depends on the following:
1. The geometric width to thickness ratio with the plate width properly corrected
according to the plate and shape type.
GeomRat = Corrected_Width / thickness
The width correction consists of subtracting the zone that does not contribute to
buckling resistance in the fixed ends. This zone depends on the shape type of the
section. Usually, the radii of the fillet in hot rolled shapes or the weld throats in
welded shapes determine the deduction zone. The values of the corrected width that
CivilFEM uses for each shape type include:
Welded Shapes:
Double T section:
Corrected width = d
Outstand flanges:
Corrected B Tw
− − r1
width 2 2
Where:
B Flanges width
Tw Web thickness
𝑟1 Radius of fillet
T section:
Corrected width = d
Outstand flanges:
C section:
Corrected width = d
Outstand flanges:
Corrected
B – Tw –r1
width
L section:
Box section:
Internal webs:
Corrected width = H
H Height
Internal flanges:
Corrected width = B − 2 ∙ Tw
Tw Web thickness
Corrected width = H
Rolled Shapes:
Double T section:
Corrected width = d
Outstand flanges:
B Flanges width
T Section:
Corrected width = d
Outstand flanges:
C Section:
Corrected width = d
Outstand flanges:
Corrected width = B
L Section:
Box section:
Internal webs:
Corrected width = d
Internal flanges:
Corrected width = B − 3 ∙ Tf
Tf Flanges thickness
Pipe section:
Corrected width = H
2. The limit listed below for width to thickness ratio. This limit depends on the
material parameter and the normal stress distribution in the plate section. The
latter value is given by the following parameters: , Ψ and k0, and the plate type,
internal or outstand; the outstand case depends on if the free end is under
tension or compression.
Limit (class) = f(ε, α, Ψ, k 0 )
ε = √235⁄fy (fy in N⁄mm2 )
where:
σ2 ⁄σ1
k0 Buckling factor
1. Obtain stresses at first plate ends from the stresses applied on the section, properly
filtered according to the check type requested by the user.
2. Calculate the parameters: , Ψ and k0
For internal plates:
1≥Ψ≤0 8.2
k0
1.05 + Ψ
16
k0 = k 0 = 7.81 − 6.29 ∙ Ψ + 9.78 ∙ Ψ 2
0 > 𝛹 > −1 √(1 + Ψ)2 + 0.112 ∙ (1 − Ψ)2 + (1 + Ψ)
−1 ≥ Ψ − 2 k 0 = 5.98 ∙ (1 − Ψ)2
Ψ ≤ −2 k 0 = infinite
For outstand plates with an absolute value of the stress at the free end greater than
the corresponding value at the fixed end:
For 1 ≥ Ψ ≥ −1
k 0 = 0.57 − 0.21 ∙ Ψ + 0.07 ∙ Ψ 2
For −1 > 𝛹
k 0 = infinite
For outstand plates with an absolute value of the stress at the free end lower than
the corresponding value at the fixed end:
For 1≥Ψ≥0
0.578
k0 =
Ψ + 0.34
For 0 > 𝛹 ≥ −1
k 0 = 1.7 − 5 ∙ Ψ + 17.1 ∙ Ψ2
For −1 > 𝛹
k 0 = infinite
Cases in which 𝑘0 = infinite are not included in Eurocode 3. With these cases, the plate is
considered to be practically in tension and it will not be necessary to determine the class.
These cases have been included in the program to avoid errors, and the value 𝑘0 = 𝑖𝑛𝑓𝑖𝑛𝑖𝑡𝑒
has been adopted because the resultant plate class is 1 and the plate reduction factor is =
1 (the same values as if the whole plate was in tension). The reduction factor is used later in
the effective section calculation.
3. Obtain the limiting proportions as functions of: , Ψ and k0 and the plate
characteristics (internal, outstand: free end in compression or tension).
EN 1993-1-1:2005:
Internal plates:
Limit(1) = 9 ε / α
Limit(2) = 10 ε / α
Limit(3) = 21 ε √K 0
9ε
Limit(1) =
α√α
10 ε
Limit(2) =
α√α
Limit(3) = 21 ε√K 0
Above is the general equation used by the program to obtain the limiting proportions
for determining plate classes. In addition, plates of Eurocode 3 may be checked
according to special cases.
For example:
For class 4 sections, the section resistance is reduced, using the effective width method.
For each section plate, the effective lengths at both ends of the plate and the reduction
factors 𝜌1 and 𝜌2 are calculated. These factors relate the length of the effective zone at each
plate end to its width.
Effective_length_end 1 = plate_width∗ ρ1
Effective_length_end 2 = plate_width∗ ρ2
The following formula from Eurocode 3 has been implemented for this process:
Ψ = σ2 ⁄σ1
1. Internal plates:
beff = ρ b̅
be1 = 2 beff / (5 − Ψ)
be1
ρ1 =
plate_width
be2
ρ2 =
plate_width
beff = ρ bc = ρ b̅/(1 − Ψ)
2. Outstand plates:
beff = ρ b̅
beff
ρ1 =
plate_width
ρ2 = 0
For Ψ < 0(end 1 fixed and in tension, end 2 free and in compression)
beff + bt
ρ1 =
plate_width
ρ2 = 0
For Ψ < 0 (end 1 fixed and in compression, end 2 free and in tension)
beff
ρ1 =
plate_width
bt
ρ2 =
plate_width
𝜌1 and 𝜌2 are switched.
EN 1993-1-1:2005:
λ̅p − 0.055(3 + Ψ)
ρ= 2
λ̅p
ρ=1
λ̅p − 0.188
ρ= 2
λ̅p
ρ=1
b̅⁄t
λ̅p =
28.4ε√k 0
where:
t = relevant thickness
= material parameter
k0 = buckling factor
1. Effective widths of flanges are calculated from factors α and Ψ these factors are
determined from the gross section properties. As a result, an intermediate
section is obtained with reductions taken in the flanges only.
2. The resultant section properties are obtained and factors α and Ψ are calculated
again.
3. Effective widths of webs are calculated so that the finalized effective section is
determined. Finally, the section properties are recalculated once more.
The recalculated section properties are included in the effective section data table.
Checking can be accomplished with the gross, net or effective section properties,
according to the section class and checking type.
Each checking type follows a specific procedure that will be explained in the following
sections.
where Nt.Rd is the design tension resistance of the cross-section, taken as the smaller
value of:
4. Output results are written in the CivilFEM results file (.CRCF). Checking results:
criteria and variables are described in the following table:
EN 1993-1-1:2005:
4. Output results written in the CivilFEM results file (.CRCF) . Checking results: criteria
and variables are described at the following table.
3. Criteria calculation.
For members subjected to a bending moment in the absence of shear force, the
following condition is checked at each section:
where:
MEd
|MEd | ≤ Mc.Rd → Crt_TOT = Crt_My = | |≤1
Mc.Rd
Class 1 or 2 cross-sections:
Mc.Rd = Wpl ∙ fy ⁄ YM 0
Mc.Rd = Wel ∙ fy ⁄ YM 0
EN 1993-1-1:2005:
Mc.Rd = Weff ∙ fy ⁄ YM 0
4. Output results are written in the CivilFEM results file (.CRCF). Checking results:
criteria and variables are described in the following table.
where:
Where:
hw Web depth
tw Web thickness
4. Output results are written in the CivilFEM results file (.CRCF). Checking results:
criteria and variables are described in the following table.
MEd = MY or MZ Design value of the bending moment along the relevant axis of
bending.
Md
|MEd | ≤ MV.Rd → Crt_TOT = Crt_BS = | |≤1
M V.Rd
Where:
The reduction for shear is applied if the design value of the shear force exceeds 50%
of the design plastic shear resistance of the cross-section; written explicitly as:
EN 1993-1-1:2005:
a. For double T cross-sections with equal flanges, bending about the major axis:
ρA2v fy
MV.Rd = (Wpl − ) ⁄Y
4t w M0
2
2VEd
ρ=( − 1)
Vpl.Rd
Aw = hw t w
fy = fy (1 − ρ)
Note: This reduction of the yield strength fy is applied to the entire section. Eurocode
3 only requires the reduction to be applied to the shear area, and therefore, it is a
conservative simplification.
For both cases, MV.Rd is the smaller value of either MV.Rd or MC.Rd.
4. Output results are written in the CivilFEM results file (.CRCF). Checking results:
criteria and variables are described in the following table.
My.Ed = MY or MZ Design value of the bending moment along the relevant axis of
bending.
Mz.Ed = MZ or MY Design value of the bending moment about the secondary axis
of bending.
2
N
MNz.Rd = Mzpl.Rd [1 − ( Ed⁄N ) ]
pl.Rd
Where and b are constants, which may take the following values:
= 2 and b =5n β 1
For circular tubes:
= 2 and b =2
For rectangular hollow sections:
1.66
α = β = 1−1.13n2
but αβ6
NEd
n=( )
Npl.Rd
Furthermore, the code specifies that in the case of rolled shapes for I or H sections or
other sections with flanges, it is not necessary to reduce the design plastic strength
for bending around the y-y axis due to the axial force if the following two conditions
are fulfilled:
Nd ≤ 0.25 ∙ Npl.Rd ∙ y
0.5 ∙ hw ∙ t w ∙ fy
Nd ≤
γM0
(if it does not reach half the tension strength of the web)
The same is applicable for bending around the z-z axis due to the axial force. There is
no reduction when the following condition is fulfiled:
hw ∙ t w ∙ fy
Nd ≤
γM0
My.Ed
( )≤1
MNy.Rd
Condition equivalent to:
My.Ed
Crt_TOT = Crt_My = ( )
MNy.Rd
Class 3 sections (without holes for fasteners):
NEd My.Ed
( )+( )≤1
Afyd Wel.y fyd
Which is equivalent to:
MNYRD MNy∙Rd, Wel.y ∙ fyd, Reduced design moment resistance of the cross-
Weff∙y ∙ fyd section about Y axis
MNZRD MNz.Rd, Wel.z ∙ fyd, Reduced design moment resistance of the cross-
Weff∙ Z ∙ fyd section about Z axis
1. Forces and moments selection. The forces and moments considered for this
checking type are:
NEd = FX Design value of the axial force.
My.Ed = MY or MZ Design value of the bending moment about the relevant axis of
bending.
Mz.Ed = MZ or MY Design value of the bending moment about the secondary axis
of bending.
fyd = fy (1 − ρ)/YM 0
where:
2
ρ = (2VEd /Vpl.Rd − 1) for VEd /Vpl.Rd > 0.5
This yield strength reduction is selectively applied to the resistance of the cross-
section along each axis, according to the previous conditions.
Note: The yield strength reduction is applied to the entire cross-section; however,
Eurocode only requires the reduction to be applied to the shear area. Thus, it is a
conservative simplification.
4. Output results are written in the CivilFEM results file (.CRCF). Checking results:
criteria and variables are described in the following table.
where:
χ Reduction factor for the relevant buckling mode, the program does
not consider the torsional or the lateral-torsional buckling.
1
χ= 1⁄ ≤1
∅ + (∅2 − λ̅2 ) 2
Buckling Buckling
Section type Limits
axis
Steel fy
curve
Thick weld:
Reinforced box all all c 0.49
a/t>0.5 b/t<30 h/tw<30
sections
In other case all all b 0.34
1⁄
λ̅ = [βA Afy /Ncr ] 2
Where Ncr is the elastic critical force for the relevant buckling mode. (See section for
Critical Forces and Moments Calculation).
In the case of angular sections, the buckling length will be taken as the highest among
the buckling lengths on the Y and Z axis.
4. The elastic critical axial forces are calculated in the planes XY (Ncrxy) and XZ (Ncrxz)
and the corresponding values of xy and xz , and the correspondent to the
principal axis Ncru and Ncrv and the values for u and v taking the smaller one as
the final value for .
χ = min(χxy , χxz , χu , χv )
5. Output results are written in the CivilFEM results file (.CRCF). Checking results:
criteria and variables are described in the following table.
where:
1
χLT = 1⁄ ≤1
∅LT + (∅2LT − λ̅2LT ) 2
Where:
h/b>2 b 0.34
h/b>2 d 0.76
Others 0.76
4. Output results are written in the CivilFEM results file (.CRCF). Checking results:
criteria and variables are described in the following table.
NEd
Crt_N1 = ( ) Axial force criterion 1.
Nb,Rd 1
NEd
Crt_N2 = ( ) Axial force criterion 2.
Nb,Rd 2
Crt_TOT2 Criterion 2
Where:
Nb,Rd1 = χy Afy /γM1 Mb,Rdy1 = χLT Wy fy /γM1 Mb,Rdz1 = W f /γ
z y M1
Nb,Rd2 = χy Afy /γM1 Mb,Rdy2 = χLT Wy fy /γM1 Mb,Rdz2 = W f /γ
z y M1
Depending Depending
on on
4 Aeff Weff,y Weff,z 0.8 1 members members
and and
stresses stresses
Interaction Factors:
Section
Class Ky Kz K yLT
type
NEd
RHS 1 + (λ̅z − 0.2)
χz NC,Rd
where:
λy y λz Limited slenderness values for y-y and z-z axes, less than 1.
fy
NC,Rd = A ∗
γM1
4. Output results are written in the CivilFEM results file (.CRCF). Checking results:
criteria and variables are described in the following table.
K_Z Kz Parameter K z .
K_LT K LT Parameter K LT .
CRT_N1 NEd /NcRd1 Axial criterion.
CRT_MY1 K y Cmy (My,Ed + NEd ∙ eNy )/Myb,Rd1 Bending Y criterion.
where:
A Gross area.
E Elasticity modulus.
The buckling length in both planes is the length between the ends restrained against lateral
movement and it is obtained from the member properties, according to the following
expressions:
Lxy = L ∙ Cfbuckxy
Lxz = L ∙ Cfbuckxz
where:
For the calculation of the elastic critical moment for lateral-torsional buckling, Mcr, the
following equation shall be used. This equation is only valid for uniform symmetrical cross-
sections about the minor axis (Annex F, ENV 1993-1-1:1992). Eurocode 3 does not provide a
method for calculating this moment in nonsymmetrical cross-sections or sections with other
symmetry plane (angles, channel section, etc.).
1/2
π2 EIz k 2 Iw (kL)2 GIt 2
Mcr = C1 2
{[( ) + 2 + [C2 Zg − C3 Zj ] ] − [C2 Zg − C3 Zj ]}
(kL) k w Iz π EIz
0.5
Zj = Zs − ∫ (y 2 + z 2 ) z dA
Iy
A
where:
E Elasticity modulus.
G Shear modulus.
Zg Za − Zs
A Cross-section area.
Factors C and k are read from the properties at structural element level.
∫ (y 2 + z 2 ) z dA = ∑ Si ∗ ∫ (y 2 + z 2 ) z dl
A i=1 Li
where:
si = thickness of plate i
dA = si * dl
y = y1 + I∗ cos α
z = z1 + I∗ sin α
z2 − z1
α = arctan
y2 − y1
Li
Description Property
Elasticity modulus E
Poisson coefficient
Shear modulus G
*th =thickness of the plate
Gross section data correspond to the nominal properties of the cross-section. For the net
section, only the area is considered. This area is calculated by subtracting the holes for
screws, rivets and other holes from the gross section area. (The area of holes is introduced
within the structural steel code properties).
The effective section data and the section and plates class data are obtained in the checking
process according to chapter B, section B4 of the code. This chapter classifies steel sections
into three groups (compact, noncompact and slender), depending upon the width-thickness
ratio and other mandatory limits.
The AISC 13TH Edition module utilizes the gross section data in user units and the CivilFEM
axis or section axis as initial data. The program calculates the effective section data and the
class data, and stores them in CivilFEM’s results file, in user units and in CivilFEM or section
axis.
The section data used in AISC 13TH Edition are shown in the following tables:
Description Data
Input data:
1.- Height H
2.- Web thickness Tw
3.- Flanges thickness Tf
4.- Flanges width B
5.- Distance between flanges Hi
6.- Radius of fillet (Rolled shapes) r1
7.- Toe radius (Rolled shapes) r2
8.- Weld throat thickness (Welded shapes) a
9.- Web free depth d
Input data:
1.- Depth in Y Tky CivilFEM
2.- Depth in Z tkz CivilFEM
3.- Cross-section area A
4.- Moments of inertia for torsion It CivilFEM
5.- Moments of inertia for bending Iyy, Izz CivilFEM
6.- Product of inertia Izy CivilFEM
7.- Elastic resistant modulus Wely, Welz CivilFEM
8.- Plastic resistant modulus Wply, Wplz CivilFEM
9.- Radius of gyration iy, iz CivilFEM
10.- Gravity center coordinates Ycdg, Zcdg Section
11.- Extreme coordinates of the perimeter Ymin, Ymax, Section
Zmin, Zmax
12.- Distance between GC and SC in Y and in Z Yms, Zms Section
13.- Warping constant Iw
14.- Shear resistant areas Yws, Zws CivilFEM
15.- Torsional resistant modulus Xwt CivilFEM
16.- Moments of inertia for bending about U, V Iuu, Ivv Principal
17.- Angle Y->U or Z->V CivilFEM
Description Data
Input data:
1.- Gross section area Agross
2.- Area of holes Aholes
Output data:
1.- Cross-section area Anet
The effective section depends upon the geometry of the section; thus, the effective section
is calculated for each element and each of the ends of the element.
Description Data
Input data: (None)
Output data:
Description Data
Input data:
Output data:
R u ≤ ϕR n
Where:
Rn Nominal strength.
ϕ Resistance factor.
ΦR n Design strength
R a ≤ R n /Ω
Where:
Rn Nominal strength.
Ω Safety factor
R n /Ω Allowable strength
Therefore, the code suggests different lambda values depending on if the element is
subjected to compression, flexure or compression plus flexure.
The section classification is the worst-case scenario of all of its plates. Therefore, the class is
calculated for each plate with the exception of pipe sections, which have their own
formulation because it cannot be decomposed into plates. This classification will consider
the following parameters:
a) Length of elements:
The program will define the element length (b or h) as the length of the plate
(distance between the extreme points), except when otherwise specified.
Once the principal axis of bending is defined, the program will examine the plates of
the section. Fields Pty and Ptz of the plates indicate if they behave as flanges, webs
or undefined, choosing the correct one for the each axis. If undefined, the following
criterion will be used to classify the plate as flange or web:
If |∆y| < |∆z| (increments of end coordinates) and flexure is in the Y axis, it will be
considered a web; if not, it will be a flange. The reverse will hold true for flexure in
the Z-axis.
The length of the plate h will be taken as the value d for the section
dimensions.
Section Box:
The length of the plate will be taken as the width length minus three times
the thickness.
λp = 0.0
E
λr = 1.49√F
y
Pipe sections
E
λr = 0.11
Fy
Box sections
E
λp = 1.12√F
y
E
λr = 1.40√F
y
- Unstiffened elements:
E
λp = 0.0 λr = 0.56√F
y
Angular sections
E
λr = 0.45√F
y
Stem of T sections
E
λr = 0.75√F
y
Section I and C:
Py = Fy ∙ Ag ; Φb = 0.90
4
kc =
√h⁄t
w
𝐹𝐿 = minimum of (Fyf − Fr ) and (Fyw ) where Fyf and Fyw are the Fy of flange
and web respectively.
E E
λp = 0.38√F λr = 0.83√F
L L
E E
λp = 0.38√F λr = 0.95√F
yf L /kc
Flange:
Pu E P
If ⁄ΦP ≤ 0.125 ∶ λp = 3.76√F (1 − 2.75 ∅Pu )
y y y
Pu E P E
If ⁄ΦP > 0.125 ∶ λp = 1.12 √F (2.33 − ∅Pu ) ≥ 1.49√F
y y y y
E P
Always: λr = 5.70√F (1 − 0.74 ΦPu )
y y
Pipe section:
E
λp = 0.07 F
y
E
λr = 0.31 F
y
Box section:
E
λp = 1.12
Fy
E
λr = 1.40
Fy
Flanges: the program distinguishes between the flange and web upon the
principal axis chosen by the user.
Pu E 𝑃
If ⁄ΦP ≤ 0.125 ∶ λp = 3.76√F (1 − 2.75 Φ𝑃𝑢 )
y y 𝑦
Pu E P E
If ⁄ΦP > 0.125 ∶ λp = 1.12√F (2.33 − ΦPu ) ≥ 1.49√F
y y y y
E P
Always: λr = 5.70√F (1 − 0.74 ΦPu )
y y
T section:
λp = 0.0
E
Stem: λp = 0.75√
Fy
E
Flanges: λr = 0.56√F
y
Design tensile strength Φt Pn and the allowable tensile strength Pn ⁄Ωt , of tension members,
shall be the lower value of :
Being:
Ag Gross area.
The effective net area will be taken as Ag – AHOLES. The user will need to enter the correct
value for AHOLES (the code indicates that the diameter is 1/16th in. (2 mm) greater than the
real diameter).
The nominal compressive strength, Pn , shall be the lowest value obtained according to the
limit states of flexural buckling, torsional buckling and flexural-torsional buckling.
Pn = Ag Fcr (E3-1)
KI Fy
λc = √
rπ E
Q = Qs Qa
KL E
a) For : ≤ 4.71√QF
r y
QFy
Fcr = Q (0.658 Fe ) Fy
KL E
b) for > 4.71√QF
r y
Fcr = 0.877Fe
Where:
l Unbraced length.
Fe π2 E
Elastic critical buckling stress Fe = KL 2
( )
r
Factor Q for compact and noncompact sections is always 1. Nevertheless, for slender
sections, the value of Q has a particular procedure. Such procedure is described below:
For unstiffened plates, Qs must be calculated and for stiffened plates, Qa must be
determined. If these cases do not apply (box sections or angular sections, for example), a
value of 1 for these factors will be taken.
Factor Qs:
If there are several plates free, the value of Qs is taken as the biggest value of all of them.
The program will check the slenderness of the section in the following order:
Angular
λ
Q s = 1.340 − 0.76
If 0.45√E⁄Fy < 𝜆 ≤ .91√E⁄Fy
√E⁄Fy
E⁄Fy
If 0.91√E⁄Fy < 𝜆 Q s = 0.53
λ2
Stem of T
λ
Q s = 1.908 − 1.22
If 0.75√E⁄Fy < 𝜆 ≤ 1.03√E⁄Fy
√E⁄Fy
E⁄Fy
If 1.03√E⁄Fy < 𝜆 Q s = 0.69
λ2
Rolled shapes
λ
Q s = 1.415 − 0.74
If 0.56√E⁄Fy < 𝜆 ≤ 1.03√E⁄Fy
√E⁄Fy
E⁄Fy
If 1.03√E⁄Fy < 𝜆 Q s = 0.69
λ2
Other sections
λ
Q s = 1.415 − 0.65
If 0.64√k c ∙ E⁄Fy λ ≤ 1.17√k c ∙ E⁄Fy
√k c ∙ E⁄Fy
E/Fy
If 1.17√k c ∙ E/Fy < 𝜆 Q s = 0.90k c
λ2
Factor Qa:
With the be values for each plate, the part that does not contribute [t·(b-be )] is
subtracted from the area (where t is the plate thickness). Using this procedure, the
effective area is calculated.
Pn = Ag Fcr
c) for λe √Q ≤ 1.5
2
Fcr = Q(0.658Qλe )Fy
Where:
Fy
λe = √
Fe
Q = Qs Qa
Factor Q for compact and noncompact sections is 1. Nevertheless, for slender sections, the Q
factor has a particular procedure of calculation. Such procedure is equal to the one
previously described.
The elastic stress for critical torsional buckling or flexural-torsional buckling Fe is calculated
as the lowest root of the following third degree equation, in which the axis have been
changed to adapt to the CivilFEM normal axis:
y 2 Z 2
(Fe − Fex )(Fe − Fey )(Fe − Fez ) − Fe2 (Fe − Fez ) ( 0 ) − Fe2 (Fe − Fey ) ( 0 ) = 0
r 0 r 0
Where:
Iy + Iz
r̅ 02 = y02 + Z02 +
A
𝑦02 + 𝑍02
𝐻 =1−( )
𝑟̅0 2
π2 ∙ E
Fey =
K y ∙ I/ry
π2 ∙ E
Fez =
K z ∙ I/rz
π2 ∙ E ∙ Cw 1
Fex =( + G ∙ J) ∙
(Kx ∙ I) A ∙ r̅02
where:
l Unbraced length.
In this formula, CivilFEM principal axes are used. If the CivilFEM axes are the principal axes
5º sexagesimal degrees, K y and K z are calculated with respect to the Y and Z-axes of
CivilFEM. If this is not the case (angular shapes, for example) axes U and V will be used as
principal axes, with U as the axis with higher inertia.
The torsional inertia (Ixx in CivilFEM, J in AISC 13TH Edition) is calculated for CivilFEM
sections, but not for captured sections. Therefore the user will have to introduce this
parameter in the mechanical properties of CivilFEM.
The design flexural strength, ϕb Mn , and the allowable flexural strength, Mn /Ωb , shall be
determined as follows:
Where Mn is the lowest value of four checks according to sections F2 through F12:
a) Yielding
b) Lateral-torsional buckling
c) Flange local buckling
d) Web local buckling
The value of the nominal flexural strength with the following considerations:
Limit
Shape Mr Fcr p r
State
I, C Cb X1 √2 X2X Lb E X1
LTB FL S z √1 + 1 2 1.76√ √ √1 + X2 FL2
loaded λ 2λ2 rz Fyf FL 1 +
in the
axis of 0.69E
rolled b
higher FLB λ2
FL S z Class B4.1 Class B4.1
0.90Ekc t
inertia. welded
λ2
Limit
Shape Mr Fcr p r
State
I, C LTB N.A. N.A. N.A. N.A. N.A.
loaded
in the
axis of FLB 0.69E b Class
Fy S y Class B4.1
lower λ2 t B4.1
inertia.
Limit
Shape Mr Fcr p r
State
Box
Seff b
FLB Fyt Seff F Class B4.1 Class B4.1
S y t
Limit
Shape Mr Fcr p r Notes
State
LTB NA NA NA NA NA
Slender:
Limited
Pipe Fcr S
0.33E Class Class by
FLB
Non-compact: D⁄t
D⁄t B4.1 B4.1 Class
0.021E B4.1
Mn = ( + Fy ) ∙ S
D⁄t
WLB NA NA NA NA NA
Limit
Shape Mr Fcr p r
State
π√EIz GJ
LTB Mn = Mcr = [B + √1 + B 2 ] N.A. N.A. N.A. N.A.
T, loaded in Lb
web plane
FLB N.A. N.A. N.A. N.A. N.A.
Where:
π EGJA
X1 = √
Sz 2
Cw Sz 2
X2 = 4 ( )
Iz GJ
d Iz
B = +2.3 √
Lb J
For slender webs the nominal flexural strength Mn is the minimum of the following checks:
tension-flange yield
compression flange buckling
Mn = Sxc Fy
where:
Mn = Sxc R PG Fcr
where:
aw hc E
R PG = 1 − ( − 5.70√ ) ≤ 1.0
1200 + 300aw t w Fy
The critical stress depends upon different slenderness parameters such as , λp , λr and Cpg
in the following way:
For λp ≤ λ ≤ λr λ − λp
Fcr = Cb ∙ Fyf ∙ [1 − 0.3 ∙ ( )] ≤ Fyf
λr − λp
E
λp = 1.1 ∙ √
Fyf
E
λr = π ∙ √
0.7Fyf
rT is the radius of gyration of compression flange plus one third of the compression
portion of the web (mm).
E
λp = 0.38 ∙ √
Fyf
E
λr = 1.35 ∙ √
Fyf /k c
Cb = 1
k c = 4/√h/t w
and
0.35 ≤ k c ≤ 0.76
Between these two slenderness, the program will choose values the value that produces a
lower critical stress.
According to the limit states of shear yielding and shear buckling, the nominal shear
strength, Vn , of unstiffened webs is:
Vn = 0.6Fy Aw Cv
For webs of all other doubly symmetric shapes and singly symmetric shapes and channels
Cv is determined as follows:
It is assumed that there are no stiffeners; therefore, the web plate buckling coefficient K v
will be calculated as a constant equal to 5.0.
1. Yielding
2. Lateral-torsional buckling
3. Flange local buckling
4. Web local buckling
In the case of having bending plus tension or bending plus compression, the interaction
between flexure and axial force is limited by the following equations:
P
(a) For Pr ≥ 0.2
c
Pr 8 M Mry
+ 9 (Mrz + M ) ≤ 1.0 (H1-1a)
Pc cz cy
P
(b) For Pr ≥ 0.2
c
Pr M Mry
+ (Mrz + M ) ≤ 1.0 (H1-1b)
2Pc cz cy
Design: ϕb Mn (LRFD) or
Design: ϕc Pn (LRFD) or
Design: ϕb Mn (LRFD) or
Fn = Fcr
The types of analyses considered in this standard have been developed according to the
ultimate limit state in agreement with the simple and continuous design methods. Semi-
continuous design and experimental verification fall beyond the scope of this specification.
The applicable cross sections for checking procedures include rolled or welded sections
subjected to axial forces, shear, and bending in 2D and 3D as well as solid sections subjected
to the aforementioned forces.
The calculations made by CivilFEM correspond to the design guidelines of British Standard
5950:2000 Structural use of steelwork in building: Part 1. Code of practice for design – Rolled
and welded sections.
YCF YBS
YS
ZCF XBS
G
ZS
O
YEC3 axis is the relevant axis for bending and its orientation is defined by the
user (in steel check process).
To define this reference system, the user must indicate which direction of the CivilFEM axis
(-Z, -Y, +Z or +Y) coincides with the relevant axis for positive bending. The user may define
this reference system when checking according to this code. In conclusion, the code
reference system coincides with that of CivilFEM, but it is rotated a multiple of 90 degrees,
as shown in table below.
The code uses other safety factors (γI , γp ) which depend on the type of loads and which
must be used when performing load combinations.
From the net section, the net area and the effective net area are considered. The net area is
calculated by subtracting the area of holes for screws, rivets and other holes from the gross
section area, taking into account the deduction for fastener holes according to section 3.4.4
of the code (see figures 3 and 4 of the code). The area of holes is introduced within the
structural steel code properties.
The effective net area is obtained from the net area, multiplying it by a coefficient K e which
depends on type of steel used. This coefficient is calculated by the program and stored
together with the material properties.
Effective section data are obtained in the checking process according to the effective width
method (Sect. 3.6 of BS 5950:2000). This method discounts the non-resistance zones for
local buckling in class 4 cross-sections. For cross-sections of a lower class, this method does
not reduce the section because of local buckling.
As an alternative method for slender cross sections calculation, a reduced design strength
(ρyr ) may be calculated at which the cross section would be class 3 (section 3.6.5 of the
code).
Section and element class data are obtained using tables 11 and 12 of BS 5950:2000 (section
3.5.2). The classification of each element is based on its width to thickness ratio and
according to section type (hot-rolled or welded), element type (web or flange) and position
(internal or external element). CivilFEM assumes the section class as the largest from all the
elements (least favorable).
The initial required data for the BS 5950:2000 module includes the gross section data in user
units and the CivilFEM axis or section axis (see the section corresponding to Reference axis in
beam sections in Chapter 5 of this Manual). The data are then properly converted from the
section’s axis into the BS 5950:2000 axis and the results are given in the code axis. The
program calculates the effective and net section data and the class data and stores them
into CivilFEM’s results file in user units and in the CivilFEM coordinate system.
Description Data
Input data:
1.- Height H
2.- Web thickness Tw
3.- Flanges thickness Tf
4.- Flanges width B
5.- Distance between flanges Hi
6.- Radius of fillet (Rolled shapes) r1
7.- Toe radius (Rolled shapes) r2
8.- Weld throat thickness (Welded shapes) a
9.- Web free depth d
Description Data
Input:
1.- Area A
2.- Moments of inertia for torsion It
3.- Moments of inertia for bending Ixx, Iyy
4.- Product of inertia Ixy
5.- Elastic resistant modulus Wx, Wy
6.- Plastic resistant modulus Wpx, Wpy
7.- Radius of gyration ix, iy
Output Data:
Description Data
Input data:
AHOLES*
Output data:
Ant = A - AHOLES
Aneff = K e ∙ Ant with Aneff A (Gross area)
* Deduction for holes are introduced as a code property
Description Data
Input data:
None
Description Data
Output data:
Description Data
Input data:
1.- Number of elements N
2.- Element type: flange or web (for the relevant axis of bending) Pltype
3.- Union condition at the ends: free or fixed Cp1, Cp2
4.- Element thickness t
5.- Coordinates of the extreme points of the element (using Section axes) Yp1, Yp2,
Zp1, Zp2
Output data:
6.- Element class Cl
7.- Reduction factor (for class 4 section- alternative method) fr
8.- Web Class Webclass
Input data:
5.- Lateral torsional buckling factor for Y axis Klty Section 4.3.5
8.- Equivalent uniform moment factor for major axis flexural mx Section 4.8.3
bending
9.- Equivalent uniform moment factor for minor axis flexural my Section 4.8.3
bending
10.- Equivalent uniform moment factor for lateral mlt Section 4.3.6.6
torsional buckling
11.- Depth of the compression flanges lip DL Section 4.3.6.7
0: Not defined
1: -Z CivilFEM
2: +Y CivilFEM
3: +Z CivilFEM
4: -Y CivilFEM
Yield strength Ys
Ultimate strength Us
Design strength ρy
Ke parameter Ke
Safety factor γM
Calculated properties:
Shear Modulus:
E
G=
2∗ (1+ v)
Epsilon, material coefficient:
The sections of the shapes included in the program libraries contain this information for
each element. CivilFEM classifies elements as either flange or web according to each axis and
gives the element union condition at each end. The ends can be classified as fixed or free
(i.e. an end is called fixed if it is in contact with another plate and free if it is not).
For checking the structure for safety, BS 5950:2000 classifies cross sections into four
different classes to determine whether local buckling influences their capacity (section
3.5.2):
Class 1 Plastic cross sections are those in which a plastic hinge can be
developed with sufficient rotation capacity to allow redistribution of
moments within the structure.
Class 2 Compact cross sections are those in which the full plastic moment
capacity can be developed but local buckling may prevent
development of a plastic hinge with sufficient rotation capacity to
permit plastic design.
Class 3 Semi-compact sections are those in which the stress at the extreme
fibers can reach the design strength but local buckling may prevent
the development of the full plastic moment.
Class 4 Slender sections are those which contain slender elements subject to
compression due to moment or axial load. Local buckling may
prevent the stress in a slender section from reaching the design
strength.
The cross-section class is the highest (least favorable) class of its elements: flanges and webs.
The class of each element is first determined according to the limits of tables 11 and 12 of BS
5950:2000. According to these tables, the class of an element depends on:
1. The width to thickness ratio. The dimensions of the elements (b, d, t, T) should
be
taken as shown in Figure 5 of the code.
Rd = Width / Thickness
2. The limits of this ratio, according to the type of section, element (flange or web) and
position (internal or outside). Elements that do not meet the limits for class 3 semi-
compact are classified as class 4. The limits are the following (refer to figure 5 of the
code for dimensions):
Sections other than circular hollow sections (CHS) and rectangular hollow section
(RHS):
b+d
≤ 24 ∙ ε
t
For
r1 > 0
R d = D⁄t D = Diameter.
t = Wall thickness.
Web, compression due to 64∗ ε/(1 + 0.6r1 ) 80∗ ε/(1 + r1 ) 120∗ ε/(1 + 2r2 )
bending
but ≥ 40∗ ε but ≥ 40∗ ε but ≥ 40∗ ε
but ≥ 40∗ ε
Web, compression due to 56∗ ε/(1 + 0.6r1 ) 70∗ ε/(1 + r1 ) 105∗ ε/(1 + r2 )
but ≥ 35∗ ε
Notes:
1. The classification of the elements according to the way they work (webs or flanges) is
included in the program section library. In other cases the user can specify it or, by
default, the program will automatically determine it as a function of the angle with
respect to the principal axis of bending, following the below criterion:
For Web
For Flange
2. Apart from the type of section, type and position of the element, the limits of the
d on the
parameters r1 r2 ,
Fc
r2 =
Ag ∙ ρyw
b) For I or H-sections with unequal flanges:
The program deals with this type of sections as generic sections for
which the values of r1 and 𝑟2 are the following:
r1 = 1
r2 = 1
c) Rectangular hollow sections or welded box sections with equal
flanges:
F
c
r1 = 2∙d∙t∙ρ with −1 < 𝑟1 ≤ 1
yw
Fc
r2 =
Ag ∙ ρyw
Where:
d Web depth.
t Web thickness.
3. The webs are also classified for shear buckling resistance according to the following
criteria:
a. For rolled sections with Rd > 70 ∗
b. For welded sections with Rd > 62 ∗
In these cases, the shear buckling resistance should be checked according to the
section 4.4.5 of the BS 5950:2000.
4. Class 3 semi-compact sections are designed using the effective plastic modulus
Seff according to section 3.5.6 and followings of BS 5950:2000.
The local buckling resistance of class 4 slender cross sections is performed by adopting
effective section properties. The width of the compression elements are reduced in such
way that the effective width of a class 4 section will be the same as the maximum width for a
class 3 section.
For outstand elements, the reduction is applied to its free end, and for internal elements,
the reduction is applied to the non-effective zone, comprised of the central portion of the
element with two equal portions of effective zone at the ends.
For each section element, the program calculates two reduction factors
ρ1 and ρ2 to determine the effective width at each element end. These factors relate the
width of the effective zone at each end with the width of the plate.
Effective_width_end1 = plate_width∗ ρ2
Effective_ width _end 2 = plate_width∗ ρ2
1 2
1 b 2 b
The effective area is determined from the effective cross section as shown in Figure 8a of the
code (section 3.6.2.2).
The effective modulus is determined from the effective cross section as shown in Figure 8b
of the code (section 3.6.2.3).
For cross sections with slender webs, the effective modulus is determined from the effective
cross section as shown in Figure 9 of the code (section 3.6.2.4).
For circular hollow sections, the effective modulus and the effective area is determined
according to the section 3.6.6 of BS 5950:2000.
β3 2
fr = ( )
β
ρyr = fr ∙ ρy
Where:
2. Class determination and calculation either of the effective section properties or the
design strength reduction factor for slender sections (depending on the selected
method).
3. Criteria calculation
In members subjected to bending moment and shear force, three conditions should be
checked:
Where:
Shear area.
Av
where:
t Total web thickness.
B Breadth.
D Overall depth.
Fv
Crt_PV = ≤1
Vw
Vw = ∑ q w ∙ d ∙ t
Where:
The critical shear strength is obtained following the Appendix H.1 of the code
where q w = Fn(ρy , d⁄t, d⁄a)and a is the distance between stiffeners. The ratio
d/a may be introduced by the user. By default, d/a = 1.
If the web of the section is not slender (d/t < 70· for rolled sections and
d/t < 62· for welded sections):
Crt_PV = 0
3.3. Bending moment check
Besides the shear checking, the following condition at each section is checked (Article
4.2.5 of BS 5950:2000):
M
Mx ≤ Mc Crt_M = Mx ≤ 1
c
Mc = fr ∙ ρy ∙ Mdf
Where:
Moment capacity.
Mc
The reduction of the bending resistant modulus due to the effect of shear load is only
applied if the shear load is above 60% of shear capacity of the section:
Fv > 0.6 Pv
1. If Fv ≤ 0.6 Pv
Mdf = S − Sv ∙ ρ
b. For semi-compact sections:
Mdf = Seff − Sv ∙ ρ
c. For slender sections:
Sv
Mdf = Zeff − ρ ∙ ( )
1.5
2 ∙ Fv 2
ρ=[ ]
Pv
Where:
Sv Parameter Calculation
Sv = S − Sf
Where:
S ∑
Plastic resistant modulus of the section: S= S
i = elements i
∑
of the shear area: Sr = S
i = webs i
5. Output results are written in the CivilFEM results file (.CRCF). Checking results:
criteria and variables are described in the following table:
2. Class determination.
3. Criteria calculation.
Resistance to lateral-torsional buckling need not be checked separately for the following
cases:
2 340∗ 275/ρy
3 225∗ 275/ρy
4 170∗ 275/ρy
When checking for lateral torsional buckling of beams, the criterion shall be taken as:
mLT ∙ Mx
Crt_TOT = ≤1
Mb
Where:
If the equivalent slenderness λLT is less than or equal to the limiting slenderness λL0
for the relevant design strength given in the tables 16 and 17 of the code, then ρb
should be taken as equal to ρy and no considerations for lateral torsional buckling
will be necessary.
Otherwise the bending strength is obtained from the formula given in Appendix B.2.1
of the code:
ρE ∙ρy
For λLT > λL0 → ρb = 1 ⁄
ϕLT +(ϕLT2 −ρE ∙ρy ) 2
ρy (ηLT + 1) ∙ ρE
ϕLT =
2
ρE = (π2 ∙ E⁄ 2 )
λLT
Where LT is the Perry coefficient
The Perry coefficient ηLT for lateral torsional buckling should be taken as follows:
Where:
1⁄
π2 E 2
λL0 Limiting equivalent slenderness: λL0 = 0.4 ( ρ )
y
λLT = uvλ√βw
The ratio βw depends on the section class:
The buckling parameter u and the torsional index x are calculated as follows:
Icf
η=
Icf + Itf
Where:
Itf Moment of area of the tension flange about the minor axis
of the section.
Where:
B. Equivalent slenderness determination for Box Sections including RHS (Appendix B.2.6)
The equivalent slenderness, λLT , for box sections is taken directly from the
expression below:
1⁄
λLT = 2.25 ∙ (Φb ∙ λ ∙ βw ) 2
1⁄
Sx2 ∙ γ′ 2
Φb = ( )
A∙J
Iy J
γ′ (1 − ) ∙ (1 − )
Ix 2.6 ∙ Ix
C. Equivalent slenderness determination for T sections (Appendix B.2.8)
The equivalent slenderness, λLT , for T sections is obtained from the following:
a) If Ixx = Iyy : Lateral torsional buckling does not occur and λLT = 0
b) If Iyy > Ixx : Lateral torsional buckling occurs about the x-x axis and λLT is given
by:
βW LE B 0.5
λLT = 2.8 ( )
T2
c) If: Ixx < Iyy Lateral torsional buckling occurs about the x-x axis and λLT is given by:
λLT = uνλ√βW
0.25
4Sx2 γ
u=( 2)
A2 (D − T⁄2)
−1⁄
1⁄ 2
2 2
v = [(w + 0.05(λ⁄x) + Ψ2 ) + Ψ]
4H
w=( 2)
Iy (D − T⁄2)
x = 0.566(D − T⁄2)(A⁄J)0.5
γ = 1 − Iy ⁄Ix
B3 T 3 (D − T⁄2)3 t 3
H= +
144 36
D. Equivalent slenderness determination for Equal Angle sections (Appendix B.2.9.1)
The equivalent slenderness, λLT , for equal angle sections is obtained from the
following:
The equivalent slenderness, λLT , for unequal angle sections is obtained from the
following:
∫ υ(u2i + ν2i ) 1
Ψa = [2υ0 − ]
Iu t
The monosymmetry index Ψa for an unequal angle is taken as positive when the
short leg is in compression and negative when the long leg is in compression.
2. Class determination.
3. Criteria calculation.
For members under axial tension, the general criterion Crt_TOT is checked at each
section. This criterion coincides with the axial criterion Crt_N:
F
F ≤ Pt Crt_TOT = Crt_N = Pt ≤ 1
Where Pt is the tension capacity: Pt = Aneff /ρy
4. Output results are written in the CivilFEM results file (.CRCF). Checking results:
criteria and variables are described in the following table:
2. Class determination.
3. Criteria calculation.
For members under axial compression, the general criterion Crt_TOT is checked at
each section. This criterion coincides with the axial compression criterion Crt_CB:
F
F ≤ Pc Crt_TOT = Pc ≤ 1
Where:
ρc Compressive strength.
𝜆 LE
Slenderness: λ = ⁄i
g
The Perry coefficient η for flexural buckling under load should be taken as follows
(Appendix C.2):
η = 0.001 ∙ a ∙ (λ − λo )
Where λo is the limiting slenderness:
1⁄2
π2 ∙ E
λo = 0.2 ∙ ( )
ρy
The constant a (Robertson constant) is determined by the program from the type of
section and buckling axis, according to the table 23 of the BS 5950:2000. Therefore, if
the user introduces a value for this constant in member properties, the program will
give precedence to the user’s value.
To distinguish between I and H shapes the program follows the criteria below:
bending axis.
2. Class determination.
3. Criteria calculation.
For members subjected to an axial tension force and bending moments, each section
should be checked according the same conditions for members subjected to a shear
force and bending moments (see section 9.8.3 of this manual).
Therefore, for this type of checking, the following conditions are checked:
Fvx
Crt_VX = ≤1
Pvx
Fvy
Crt_VY = ≤1
Pvy
Where Fvx and Fvy are the shear forces about X and Y axis, and Pvx and Pvy the
shear capacity about X and Y axis.
Fvx
Crt_PVX = ≤1
Vwx
Fvy
Crt_PVY = ≤1
Vwy
Where Vwx and Vwy are the shear buckling resistance about X and Y axis,
respectively.
Vwx = ∑ q wx ∙ d ∙ t
Vwy = ∑ q wy ∙ d ∙ t
F Mx My
+ + ≤1
Aneff ∙ ρy Mcx Mcy
Equivalent to:
F Axial force.
Mcx and Mcy are calculated according to the Article 4.2.5 of BS 5950:2000.
For this checking type (moments on both directions), the shear area, the plastic
modulus and the Sv parameter are calculated with respect to both directions (X and Y
axis).
2. Class determination.
3. Criteria calculation.
Compression members are checked for local capacity at the points of greatest bending
and axial load. This capacity may be limited by either yielding or local buckling,
depending on the section properties. The member is then checked for global buckling.
Therefore, for this type of checking, the following conditions are checked:
F Axial load
Fc Compression capacity:
Pc Compression resistance.
The calculations performed by CivilFEM correspond to the provisions of this code according
to the following sections:
1 Allowable Stresses
Description Property
Steel yield strength Sy (th)
Modulus of Elasticity E
*th = plate thickness
Data Description
A Area of the cross-section
From the net section, only the area is considered. This area is calculated by subtracting the
holes for screws, rivets and other holes from the gross sectional area. The user should be
aware that the code indicates the diameter used to calculate the area of holes is greater
than the real diameter. The area of holes is introduced within the structural steel code
properties.
In order to determine the effective net area Ae of axially loaded tension members, the
reduction coefficient Ct must be set (parameter). By default, Ct=0.75.
(*)
Su on the effective net area
Ft = 0.45 ∙ Sy
ft
CRT_STR = ≤1
Ft
I I
STR_RT = max ( , )
ry rz
SLD_RT
CRT_SLD = ≤1
240
CRT_TOT=MAX(CRT_STR,CRT_SLD)
Fv = 0.40 ∙ Sy
fv
CRT_TOT = ≤1
Fv
Vy Vz
Fv = MAX ( , )
Yws Zws
1- Gross sections of columns, except those fabricated from austenitic stainless steel:
(KI⁄r)2
[1 − ] ∙ Fy
2 ∙ Cc 2
FA = if kI⁄r ≤ Cc
5 3(KI⁄r) (KI⁄r)3
+ −
3 8 ∙ Cc 8 ∙ Cc 3
12π2 E kI
FA = if > Cc
23 ∙ (KI/r)2 r
where
2π2 E
Cc = √
Sy
kI/r
FA = Sy (0.47 − 444 ) if kI/r ≤ 120
kI/r
FA = Sy (0.40 − 600 ) if kI/r > 120
FA = 0.60Sy
kI ∙ I kz ∙ I
STR_RT = max ( , )
ry rz
SLD_RT
CRT_SLD = ≤1
200
Qs = 15500/[Sy(b/t)2 ]
Qs = 20000 /[Sy(b/t)2 ]
Qs = 20000 /[Sy(b/t)2 ]
Furthermore, proportions of unstiffened elements of channels and tees that exceed the
limits above are checked for the following limits:
This proportion checking result is defined in the CivilFEM results file (.CRCF) as CTR_W with a
value of 0.0 if the proportional limits are fulfilled and 2100 if they are not.
253t 50.3
be = [1 − ]≤b
√f (b/t)√f
253t 44.3
be = [1 − ]≤b
√f (b/t)√f
Where f is the axial compressive stress on the member based on the effective area, in
ksi.
If unstiffened elements are included in the total cross section, f must be such that the
maximum compressive stress in the unstiffened elements does not exceed Fa Qs .
Therefore, the calculation of the effective width of stiffened elements adheres to the
following iterative process:
Using the effective width be , the form factor Qa is then calculated by the ratio of the
effective area to the total area.
Qa = Aef / A
The allowable stress for axially loaded compression members shall not exceed:
(KI/r)2
Qs Qa [1 − ] ∙ Fy
2 ∙ Cc 2
FA ≤ if kI/r ≤ Cc
5 3(KI/r) (KI/r)3
+ −
3 8 ∙ Cc 8 ∙ Cc 3
After verifing the equation above, the equivalent stress obtained fa is divided by the steel
design strength Fa to obtain a value stored as the CRT_STR parameter in the active
alternative in CivilFEM’s results file for each element end. This value must be between 0.0
and 1.0 so that the element will be valid according to ASME BPVC III Subsection NF;
therefore, the equivalent stress must be lower than the steel design strength.
fa
CRT_TOT =
Fa
(a) Compact sections: For a section to qualify as compact, its flanges must be continuously
connected to the web or webs and the width-thickness ratios of its compression elements
must not exceed the limiting ratios below:
(c) Miscellaneous members: limit ratios above do not apply to these members.
1- I Sections:
a. Compact sections bent about their minor axis of inertia shall not exceed a
bending stress of:
FB = 0.75 ∙ Sy
b. Members with a high flange width-thickness ratio bent about their minor axis
of inertia shall not exceed a bending stress of:
FB = Sy[1.075 − 0.005(br /2t f )√Sy]
c. Compact sections bent about their major axis of inertia shall not exceed:
FB = 0.66Sy
d. Members with a high flange width-thickness ratio bent about their major axis
of inertia shall not exceed a bending stress of:
FB = Sy[0.79 − 0.002(bf /2t f )√Sy]
e. Miscellaneous member sections bent about their major axis of inertia shall
not exceed the larger value below:
2
FB1 = { [Sy(I/rc )2 ] /(1530 ∙ 103 ∙ Cb )} Sy ≤ 0.60 ∙ Sy
3
When the area of the compression flange is greater than or equal to the area
of the tension flange:
f. Members not included above which are braced laterally in the region of the
compressive stress shall not exceed a bending stress of:
FB = 0.60 ∙ Sy
If these members are not braced laterally in the region of the compressive
stress, the section will be not checked.
3- Pipe Sections:
a. If the diameter-thickness ratio of hollow, circular sections does not exceed
3300/Sy, the bending stress shall not exceed:
FB = 0.66 ∙ Sy
If the diameter-thickness ratio is greater than the value above, the section will
be not checked.
4- U channel Sections:
a. If the section is bent about its major axis of inertia, the bending stress shall
not exceed the larger value below:
2
FB1 = { − [Sy(I⁄rc )2 /(1530 ∙ 103 ∙ Cb )]} Sy ≤ 0.60 ∙ Sy
3
When the area of the compression flange is greater than or equal to the area
of the tension flange,
b. Members not included above which are braced laterally in the region of the
compressive stress shall not exceed a bending stress of:
FB = 0.60 ∙ Sy
If these members are not braced laterally in the region of the compressive
stress, the section will be not checked.
5- Tees Sections:
a. Compact sections loaded in the direction of the web which coincides with the
minor axis of inertia, shall not exceed a bending stress of:
FB = 0.66 ∙ Sy
b. Members with a high flange width-thickness ratio which are loaded in the
direction of the web coinciding with the minor axis of inertia shall not exceed
a bending stress of:
FB = Sy[0.79 − 0.002(bf ⁄2t f )√Sy]
When the compression flange area is greater than or equal to the tension
flange area:
d. Members not included above which are braced laterally in the region of the
compressive stress shall not exceed a bending stress of:
FB = 0.60 ∙ Sy
If these members are not braced laterally in the region of the compressive
stress, the section will be not checked.
If these members are not braced laterally in the region of compressive stress,
the section will be not checked.
Qs = 1.0
Qs = 1.340 − 0.00447(b⁄t)√Sy
Qs = 15500/[Sy(b⁄t)2 ]
Qs = 1.0
Qs = 1.908 − 0.00715(b⁄t)√Sy
Qs = 20000/[Sy(b⁄t)2 ]
Qs = 1.0
Qs = 1.415 − 0.00437(b⁄t)√Sy
Qs = 20000/[Sy(b⁄t)2 ]
Furthermore, unstiffened elements of channels and tees with proportions that exceed the
limits above are checked for the following limits:
This proportion checking result is written in the CivilFEM results file (.CRCF) as CTR_W with a
value of 0.0 if the proportion limits are satisfied and 2100 if they are not.
253t 50.3
be = [1 − ]≤b
√f (b⁄t)√f
253t 44.3
be = [1 − ]≤b
√f (b⁄t)√f
Where f is the compressive stress on member based on the effective area, in ksi.
If unstiffened elements are included in the total cross section, f must have a value such
that the maximum compressive stress in the unstiffened elements does not exceed
Fb Qs . Therefore, the calculation of the effective width of stiffened elements adheres to
the following iterative process:
This iteration is repeated until the axial compressive stress is less than Fb Qs or the
effective area is equal to the total area.
Using the effective width be , the form factor Qa is then calculated by the ratio of the
effective area to the total area.
Qa = Aef/A
The computed bending stress Fb , obtained from the effective area, is divided by the steel
design strength Fb in order to obtain a value that is stored as the CRT_TOT parameter in the
active alternative in CivilFEM’s results file for each element end. This value must be between
0.0 and 1.0 so that the element will be valid according to ASME BPVC III Subsection NF;
therefore, the equivalent stress must be less than the steel design strength.
fb
CRT_TOT = ≤1
Fb
fa fby fbz
+ + ≤ 1.0
0.60 ∙ Sy Fby Fbz
fa fby fbz
+ + ≤ 1.0
Fa Fby Fbz
fa fby fbz
+ + ≤ 1.5
Fa Fby Fbz
The Total Criterion will be the maximum value of the equations below and will be stored as
the CRT_TOT parameter in the active alternative in CivilFEM’s results file for each element
end. This value must be between 0.0 and 1.0 for the element to be valid according to ASME
BPVC III Subsection NF; therefore, the equivalent stress must be less than the steel design
strength.
Members subject to both axial tension and bending stresses shall satisfy the requirements of
the following equation:
fa fby fbz
+ + ≤ 1.0
0.60 ∙ Sy Fby Fbz
Where fb is the computed bending tensile stress. However, the computed bending
compressive stress, taken alone, shall not exceed the allowable compressive stress F a.
The total criterion is stored as the CRT_TOT parameter in the active alternative in CivilFEM’s
results file for each element end. This value shall be between 0.0 and 1.0 for the element to
be valid according to ASME BPVC III Subsection NF; consequently, the equivalent stress must
be less than the steel design strength.
Description Property
Steel yield strength f(th)
Data Description
A Area of the cross-section
Iy Moment of inertia about Y axis
From net section, only the area is considered. This area is calculated by subtracting the holes
for screws, rivets and other holes from the gross section area. The user should be aware that
LRFD indicates the diameter from which to calculate the area of holes is greater than the real
diameter. The area of holes is introduced within the structural steel code properties.
Input data:
Y If b⁄h ≤ 0.8 b b
Z
Welded Section b b
Channel
Y
Rolled or Welded b b
Z
Pipe Rolled a a
Y
Z
By dimensions b b
L angle Rolled b b
Square
Tubing or Box
Rolled or Welded if
Y
(b + h)/2 c c
> 20
Z t
Standard T
Y
Z Rolled or Welded b b
Welded (default) b b
My M
(Iz Z − Iyz y) − γ z (Iy y − Iyz Z)
γ y z
σ∗ = σn 2
Iy Iz − Iyz
Where:
Z 1.20 1.05
Y
1.20 if My > 0
Z
1.05
1.05 if My ≤ 0
Z 1.15 1.15
Z
1.05 1.05
Y
1.20 if Mz > 0
Z
1.20
1.05 if Mz ≤ 0
σ∗
CRT_TOT =
σu
Ty Tz
σ∗ = σt = MAX ( , )
Yws Zws
Where:
σ∗
CRT_TOT = ≤1
σU
Where:
Ty Tz
σ∗ = σt = MAX ( , )
Yws Zws
Where:
σ∗ = √σn2 + 3σt 2
The maximum equivalent stress for each element end is stored in the active alternative in
CivilFEM’s results file with the parameter named SCEQV.
σ∗
CRT_TOT = ≤1
βF
Where β is the amplifying factor for the combined design strength. If σn and σt have
different sign β= 1.2, otherwise β= 1.1.
n1 N
σ∗ = (1 − 0.5 )
n An
Where:
N Axial force
n1
In CivilFEM coefficient is given by RTB factor which can be modified in the structural steel
n
code properties.
σ∗
CRT_TOT = ≤1
f
My M
(Iz Z − Iyz y) − γ z (Iy y − Iyz Z)
N γ y z
σ∗ = + 2
An Iy Iz − Iyz
Where:
Plastic development coefficients γy , γz are obtained from the associated in the structural
steel code properties.
σ∗
CRT_TOT = ≤1
f
N
σ∗ =
φA
Where φ is the stability coefficient for axially compressed members. The stability coefficient
φ is calculated from the slenderness ratio:
ky
λy = L
iy
kz
λz = L
iz
Where:
In non symmetric sections, the axes are defined as the directions of principal inertia.
To compute φ:
λ
a) If λn = π √fy /E ≤ 0.215 then φ = 1 − α1 λ2n
b) Otherwise:
1
φ= 2
[(α2 + α3 λn + λ2n ) − √(α2 + α3 λn + λ2n )2 − 4λ2n ]
2λn
CROSS SECTION α1 α2 α3
σ∗
CRT_TOT = ≤1
f
Partial safety factor for material Resistance of member to buckling γm0 = 1.1
250
Constant є 𝜀=√
fy
For the net section, only the area is considered. This area is calculated by subtracting the
holes for screws, rivets and other holes from the gross section area.
Effective section data and section and plates class data are obtained in the checking process
according to the effective width method. For class 4 cross-sections, this method subtracts
the non-resistance zones for local buckling. However, for cross-sections of a lower class, the
sections are not reduced for local buckling.
The initial required data for the IS 800:2007 module includes the gross section data in user
units and the CivilFEM or section axis. In the following tables, the section data used in IS
800:2007 are shown:
Description Data
Input data:
1.- Height H
2.- Web thickness Tw
3.- Flanges thickness Tf
4.- Flanges width B
5.- Distance between flanges Hi
6.- Radius of fillet (Rolled shapes) r1
7.- Toe radius (Rolled shapes) r2
8.- Weld throat thickness (Welded shapes) a
9.- Web free depth d
Input data:
1.- Depth in Y Tky CivilFEM
2.- Depth in Z tkz CivilFEM
3.- Cross-section area A
4.- Moments of inertia for torsion It CivilFEM
5.- Moments of inertia for bending Iyy, Izz CivilFEM
6.- Product of inertia Izy CivilFEM
7.- Elastic resistant modulus Wely, Welz CivilFEM
8.- Plastic resistant modulus Wply, Wplz CivilFEM
9.- Radius of gyration iy, iz CivilFEM
10.- Gravity center coordinates Ycdg, Zcdg Section
11.- Extreme coordinates of the perimeter Ymin, Ymax, Section
Zmin, Zmax
12.- Distance between GC and SC in Y and in Z Yms, Zms Section
13.- Warping constant Iw
14.- Shear resistant areas Yws, Zws CivilFEM
15.- Torsional resistant modulus Xwt CivilFEM
16.- Moments of inertia for bending about U, V Iuu, Ivv Principal
17.- Angle Y->U or Z->V CivilFEM
Description Data
Input data:
1.- Gross section area Agross
2.- Area of holes Aholes
Output data:
1.- Net Cross-section area Anet
The effective section depends on the section geometry and on the forces and moments that
are applied to it. Consequently, for each element end, the effective section is calculated.
Output data:
1.- Cross-section area Aeff
2.- Moments of inertia for bending Iyyeff, Izzeff CivilFEM
3.- Product of inertia Izyeff CivilFEM
4.- Elastic resistant modulus Wyeff, Wzeff CivilFEM
5.- Gravity center coordinates Ygeff, Zgeff Section
6.- Distance between GC and SC in Y and in Z Ymseff, Zmseff Section
7.- Warping constant Iw
8.- Shear resistant areas Yws, Zws CivilFEM
Description Data
Input data:
1.- Plates number N
2.- Plate type: flange or web (for the relevant axis of bending) Pltype
3.- Union condition at the ends: free or fixed Cp1, Cp2
4.- Plate thickness t
5.- Coordinates of the extreme points of the plate (in Section axis) Yp1, Yp2,
Zp1, Zp2
Output data:
6.- Reduction factors of the plates at each end Rho1, Rho2
7.- Plates class Cl
For IS 800:2007 checking, the data set used at member level are shown in the following
table. All the data are stored with the section data in user units and in the CivilFEM
reference axis. This data is defined as the parameters:
L, K, KW, C1, C2, C3, CMY, CMZ, CMLT, CFBUCKXY and CFBUCKXZ.
Note that CFBUCKXY and CFBUCKXZ are used for simple buckling calculations and K, KW,
C1, C2, C3, CMY, CMZ, CMLT are used for lateral and torsional buckling. This is important
for understanding the way CivilFEM obtains buckling length. In simple buckling, buckling
effective length (K*L according to 7.2.1) is obtained as CFBUCKXZ*L or CFBUCKXY*L.
Lateral buckling effective length (LLT according to 8.3) is obtained using K*L (this K is the
one entered in the Member Properties pane).
Member Properties
Description IS800-07
Input data:
3.- Lateral buckling factors, depending on the load and restraint C1, C2, C3
conditions
4.- Equivalent uniform moment factors for flexural buckling CMy, CMz
7.- Buckling factors for planes XZ and YZ (Effective buckling length for Cfbuckxy,
plane XY =L*Cfbuckxy ) (Effective buckling length for plane XZ Cfbuckxz
=L*Cfbuckxz )
Evaluation steps:
3. Read the CivilFEM axis to be considered as the relevant axis for bending so that it
coincides with the Y axis of IS 800:2007. In CivilFEM, by default, the principle bending
axis that coincides with the +Y axis of IS 800:2007 is the –Z.
4. The following operations are necessary for each selected element:
a. Obtain material properties of the element stored in CivilFEM database and
calculate the rest of the properties needed for checking:
Properties obtained from CivilFEM database:
Calculated properties:
Plate function: webs and flanges in Y and Z axis, according to the considered relevant
axis of bending.
Plate union condition: internal plates or outstand plates.
For sections included in the program libraries, the information above is defined for each
plate. CivilFEM classifies plates as flanges or webs according to their axis and provides the
plate union condition for each end. Ends can be classified as fixed or free (a fixed end is
connected to another plate and free end is not).
For checking the structure for safety, IS 800:2007 classifies sections as one of four possible
classes:
Class 1 Cross-sections, which can develop plastic hinges and have the rotation
(Plastic) capacity required for failure of the structure by formation of plastic
mechanism.
Class 3 Cross-sections, in which the extreme fiber in compression can reach yield
(Semi-Compact) stress, but cannot develop the plastic moment of resistance, due to local
buckling.
Class 4 Cross-sections in which the elements buckle locally even before reaching
(Slender) yield stress.
The cross-section class is the highest (least favorable) class of all of its elements: flanges and
webs (plates). First, the class of each plate is determined according to the limits of IS
800:2007. The plate class depends on the following:
- The geometric width to thickness ratio with the plate width properly corrected
according to the plate and shape type.
GeomRat = Corrected_Width / thickness
The width correction consists of subtracting the zone that does not contribute to
buckling resistance in the fixed ends. This zone depends on the shape type of the
section. Usually, the radii of the fillet in hot rolled shapes or the weld throats in
welded shapes determine the deduction zone. The values of the corrected width that
CivilFEM uses for each shape type include:
Welded Shapes:
Double T section:
Corrected width = d
Outstand flanges:
Corrected 𝐵 Tw
− − r1
width 2 2
Where:
B Flanges width
Tw Web thickness
r1 Radius of fillet
T section:
Corrected width = d
Outstand flanges:
B
Corrected width =
2
C section:
Corrected width = d
Outstand flanges:
Corrected
𝐵 − Tw − r1
width
L section:
Box section:
Internal webs:
Corrected width = H
H Height
Internal flanges:
Corrected width = B = 2 ∙ TW
Tw Web thickness
Corrected width = H
Rolled Shapes:
Double T section:
Corrected width = d
Outstand flanges:
B
Corrected width =
2
B Flanges width
T Section:
Corrected width = d
Outstand flanges:
B
Corrected width =
2
C Section:
Corrected width = d
Outstand flanges:
Corrected width = B
L Section:
Box section:
Internal webs:
Corrected width = d
Internal flanges:
Corrected width = 𝐵 − 3 ∙ Tf
Tf Flanges thickness
Pipe section:
Corrected width = H
The limit listed below for width to thickness ratio. This limit depends on the material
where:
σ2 /σ1
k0 Buckling factor
Obtain stresses at first plate ends from the stresses applied on the section, properly
filtered according to the check type requested by the user.
k0
For internal plates:
Ψ ≤ −2 k 0 = infinite
For outstand plates with an absolute value of the stress at the free end greater than
the corresponding value at the fixed end:
For 1 ≥ Ψ ≥ −1
k 0 = 0.57 − 0.21 ∙ Ψ + 0.07 ∙ Ψ2
For −1 > Ψ
k 0 = infinite
For outstand plates with an absolute value of the stress at the free end lower than
the corresponding value at the fixed end:
For 1≥Ψ≥0
0.578
k0 =
Ψ + 0.34
For 0 > Ψ ≥ −1
k 0 = 1.7 − 5 ∙ Ψ + 17.1 ∙ Ψ2
For −1 > Ψ
k 0 = infinite
Cases in which k 0 = infinite are not included in IS 800:2007. With these cases, the plate is
considered to be practically in tension and it will not be necessary to determine the class.
These cases have been included in the program to avoid errors, and the value k 0 =infinite has
been adopted because the resultant plate class is 1 and the plate reduction factor is = 1
(the same values as if the whole plate was in tension). The reduction factor is used later in
the effective section calculation.
Internal plates:
Limit(3) = 62 ε (1 − Ψ)√(−Ψ) -1
Limit(1) = 9 ε/α
Limit(2) = 10 ε/α
Limit(3) = 21 ε/√k 0
9ε
Limit(1) =
α√α
10 ε
Limit(2) =
α√α
Limit(3) = 21 ε/√k 0
Above is the general equation used by the program to obtain the limiting proportions
for determining plate classes. In addition, plates of IS 800:2007 may be checked
according to special cases.
For example:
all plates
In sections under pure bending:
For class 4 sections, the section resistance is reduced, using the effective width method.
For each section plate, the effective lengths at both ends of the plate and the reduction
1 2 are calculated. These factors relate the length of the effective zone at each
plate end to its width.
Effective_length_end 2 =
The following formula from IS 800:2007 has been implemented for this process:
Ψ = σ2 σ1
1. Internal plates:
Internal plates
beff = ρb̅
be1 = 2beff /(5 − Ψ)
be2 = beff − be1
be1
ρ1 =
plate_width
be2
ρ2 =
plate_width
be2 + bt
ρ2 =
plate_width
2. Outstand plates:
beff = ρb̅
be1
ρ1 =
plate_width
ρ2 = 0
For Ψ < 0 (end 1 fixed and in tension, end 2 free and in compression)
For Ψ < 0 (end 1 fixed and in compression, end 2 free and in tension)
λ̅p − 0.055(3 + Ψ)
ρ=
λ̅2p
ρ=1
λ̅p − 0.188
ρ=
λ̅2p
ρ=1
b̅/t
λ̅p =
28.4ε√k 0
where:
t = relevant thickness
= material parameter
k0 = buckling factor
Each checking type follows a specific procedure that will be explained in the following
sections.
- Class determination.
- Criteria calculation.
For members under axial tension, the general criterion Crt_TOT is checked at each
section.
T
T ≤ Td Crt_TOT = T ≤ 1
d
If we only take into account the design strength due to yielding of gross section (article
6.2, IS800:2007):
Td = Tdg = Ag fy /γm0
If we take into account the design strength in tension of a plate, ,as governed by rupture
of net cross-sectional area:
Td = min(Tdg , Tdn )
- Output results are written in the CivilFEM results file as an alternative. Checking
results: criteria and variables are described in the following table:
where:
Class 1 or 2 cross-sections:
- Output results are written in the CivilFEM results file as an alternative. Checking
results: criteria and variables are described in the following table.
where:
Av shear area.
Av = dt w (𝑅𝑂𝐿𝐿𝐸𝐷 𝑆𝐸𝐶𝑇𝐼𝑂𝑁𝑆)
Where:
The reduction for shear is applied if the design value of the shear force exceeds 50%
of the design plastic shear resistance of the cross-section; written explicitly as:
- For double T cross-sections with equal flanges, bending about the major axis:
ρA2 f
MV.Rd=(Wpl − 4t v) y⁄Y
w M0
2
2Vd
ρ=( − 1)
Vpl.Rd
Aw = hw t w
Note: This reduction of the yield strength fy is applied to the entire section. IS
800:2007 only requires the reduction to be applied to the shear area, and therefore,
it is a conservative simplification.
For both cases, MV.Rd is the smaller value of either MV.Rd or MC.Rd .
- Output results are written in the CivilFEM results file as an alternative. Checking
results: criteria and variables are described in the following table.
My.d = 𝑀𝑦 𝑜𝑟 𝑀𝑧 Design value of the bending moment along the relevant axis of
bending.
Mz.d = 𝑀𝑧 𝑜𝑟 𝑀𝑦 Design value of the bending moment about the secondary axis
of bending.
My.d
Crt_My = ( )
MNy.Rd
Mz.d
Crt_Mz = ( )
MNz.Rd
Where MNy.Rd and MNz.Rd are the design moment resistance of the cross-section,
reduced by the presence of the axial force:
2
N
MNy.Rd = Mypl.Rd [1 − ( d⁄N ) ]
pl.Rd
2
N
MNz.Rd = Mzpl.Rd [1 − ( d⁄N ) ]
pl.Rd
Where and b are constants, which may take the following values:
α = 2 and β = 5n β≥1
For circular tubes:
α = 2 and β = 2
For rectangular hollow sections:
1.66
α = β = 1−1.13n2 but α=β≤6
For solid rectangles and plates (the rest of sections):
α = β = 1.73 + 1.8n3
Nd
n=( )
Npl.Rd
My.d
( )≤1
MNy.Rd
Condition equivalent to:
My.d
Crt_TOT = Crt_My = ( )
MNy.Rd
Class 3 sections (without holes for fasteners):
Nd My.d Mz.d
( )+( )+( )≤1
Afyd Wel.y fyd Wel.z fyd
Condition equivalent to:
Nd My.d
( )+( )≤1
Afyd Wel.y fyd
Which is equivalent to:
My.d + Nd eNy
Crt_My = ( )
Weff.y fyd
Mz.d + Nd eNy
Crt_Mz = ( )
Weff.z fyd
Where:
Checking of Members under Bending Moment + Axial Force and Bi-axial Bending + Axial
Force
MNYRD MNy∙Rd ,Wel.y ∙ fyd , Reduced design moment resistance of the cross-
W ∙f section about Y axis
eff∙y yd
where:
Reduction factor for the relevant buckling mode, the program does
not consider the torsional or the lateral-torsional buckling.
1
χ= 1⁄ ≤1
Φ + (Φ2 − λ̅2 ) 2
1⁄
λ̅ = [βA Afy /Ncr ] 2
Where Ncr is the elastic critical force for the relevant buckling mode. (See section for
Critical Forces and Moments Calculation).
The elastic critical axial forces are calculated in the planes XY (Ncrxy ) and XZ (Ncrxz )
and the corresponding values of χxy and χxz , taking the smaller one as the final value
for .
χ = min(χxy , χxz )
- Output results are written in the CivilFEM results file as an alternative. Checking
results: criteria and variables are described in the following table.
- Criteria calculation.
With checking lateral-torsional buckling of members subjected to combined bending
and axial tension, the value of the axial force is multiplied by a reduction factor
Ψvec in order to consider the axial force and bending moment as a vector magnitude.
The value of Ψvec depends on the country where the code will be applied. That factor
is introduced as a property at member level, and typically its value is equal to: Ψvec =
0.8
The stress in the extreme compression fiber is calculated as follows:
MSd Ψvec Nt.Sd
σcom.ed = −
Wcom A
Where Wcom is the elastic section modulus for the extreme compression fiber and
Nt.Sd is the design value of the axial tension.
Where:
- Output results are written in the CivilFEM results file as an alternative. Checking
results: criteria and variables are described in the following table.
- Criteria calculation.
Nd My.d Mz.d
| |+| |+| |≤1
Nb.Rd Myb.Rd Mzb.Rd
Crt_TOT = Crt_N + Crt_My + Crt_Mz 1
where:
Nd Axial criterion.
Crt_N = | |
Nb.Rd
The member resistances depend on the cross-section class and on the possibility that
the lateral-torsional buckling is a potential failure mode for the structure.
Nd k y My.d k z Mz.d
+ + ≤1
χmin Afy /γM1 WPl.y fy /γM1 WPl.z fy /γM1
where:
μ y ∙ Nd
ky = 1 − ≤ 1.5
χy ∙ A ∙ fy
Wpl.y − Wel.y
μy = λ̅y (2βMy − 4) + [ ] μy ≤ 0.90
Wel.y
μz Nd
kz = 1 − k ≤ 1.5
χz Afy z
Wpl.z −Welz
μz =λ̅z (2βMz − 4) + [ ] μz ≤ 0.90
Wel.z
χmin = min(χy ; χz )
Where:
βMy and βMz are equivalent uniform moment factors for flexural bending.
These factors are entered as properties at member level. (See
section Data at Member Level, factors BetaMy and BetaMz).
Nd k LT My.d k z Mz.d
+ + ≤1
χz Afy /γM1 χLT Wpl.y fy /γM1 WPl.z fy /γM1
where:
μLT ∙ Nd
k LT = 1 − ≤1
χz ∙ A ∙ fy
μLT = 0.15 λ̅ CM.LT − 0.15 μLT ≤ 0.90
where CM.LT is an equivalent uniform moment factor for lateral-torsional buckling.
This factor, as the precedent factors CMy and CMz.
Nd k y My.d k z Mz.d
+ + ≤1
χmin Afy /γM1 Wel.y fy /γM1 Wel.z Fy /γM1
where ky, kz and min are as for Class 1 and 2 cross-sections.
Nd k y My.d k z Mz.d
+ + ≤1
χz Afy /γM1 χLT Wel.y fy /γM1 Wel.z Fy /γM1
Aeff , Weff.y , Weff.z , eN.y , eNz are defined in the section corresponding to
Checking of members under bending and axial
force and bi-axial bending.
k LT is similar to class 1 and 2 cross-sections, but uses the effective area Aeff,
instead of the gross area A.
Checking Parameters:
A Wy Wz αy αz eN,y eN,z eN,z
Class
A Wpl,y Wpl,z
1 0.6 0.6 0 0
A Wpl,y Wpl,z
2 0.6 0.6 0 0
A Wel,y Wel,z
3 0.8 1 0 0
Depending Depending
on on
4 A eff Well,y Weff,z 0.8 1 members members
and and
stresses stresses
Interaction Factors:
Section
Class ky kz k yLT
type
NEd
I, H 1 + (λ̅z − 0.6)
NEd χz NC,Rd 0.1. λ̅z NEd
1y2 1 + (λ̅y − 0.2) 1− . . 0.6 + λ̅z
χy NC,Rd NEd (CmLT − 0.25) χz NC,Rd
RHS 1 + (λ̅y − 0.2)
χz NC,Rd
where:
λy y λz Limited slenderness values for y-y and z-z axes, less than 1.
fy
NC,Rd = A∗
γM1
- Output results are written in the CivilFEM results file as an alternative. Checking
results: criteria and variables are described in the following table.
A Gross area.
E Elasticity modulus.
The buckling length in both planes is the length between the ends restrained against lateral
movement and it is obtained from the member properties, according to the following
expressions:
L xy L·Cfbuckxy
Lxz L·Cfbuckxz
where:
For the calculation of the elastic critical moment for lateral-torsional buckling, Mcr, the
following equation shall be used. This equation is only valid for uniform symmetrical cross-
sections about the minor axis (Annex E, IS 800:2007). IS 800:2007 does not provide a method
for calculating this moment in nonsymmetrical cross-sections or sections with other
symmetry plane (angles, channel section, etc.).
1/2
π2 Elz k 2 Iw (kL)2 Glt 2
𝑀𝑐𝑟 = C1 {[( ) + + [C2 Z g − C3 Z j ] ] − [C2 Zg − C3 Zj ]}
(kL)2 k w Iz π2 Elz
0.5 ∫ 2
Zj = Zs − (y + z 2 )z dA
Iy A
where:
E Elasticity modulus.
G Shear modulus.
Zg Za – Zs
A Cross-section area.
where:
Si = thickness of plate i
dA = Si ∗ dl
y = y1 + I ∗ cosα
z = z1 + I ∗ sinα
z2 − z1
α = arctang
y2 − y1
Li
With CivilFEM it is possible to perform the following checking and analysis types:
For AASHTO LRFD BRIDGE DESIGN SPECIFICATIONS 2010 checking, the following material
properties are used:
Description Property
Elasticity modulus E
Poisson coefficient
Shear modulus G
*th =thickness of plate
Elasticity modulus E
Poisson’s ratio: ν
Shear modulus G
c) Initiate the values of the plate’s reduction factors and the other plate’s parameters to
determine its class.
e) Results. In CivilFEM.
The required data for the different checking types are provided within tables found in their
corresponding section of this manual.
Therefore, the code suggests different lambda values depending on if the element is
subjected to compression, flexure or compression plus flexure.
The section classification is the worst-case scenario of all of its plates. Therefore, the class is
calculated for each plate with the exception of pipe sections, which have their own
formulation because it cannot be decomposed into plates. This classification will consider
the following parameters:
a) Length of elements:
The program will define the element length (b or h) as the length of the plate
(distance between the extreme points), except when otherwise specified.
Once the principal axis of bending is defined, the program will examine the plates of
the section. Fields Pty and Ptz of the plates indicate if they behave as flanges, webs
or undefined, choosing the correct one for the each axis. If undefined, the following
criterion will be used to classify the plate as flange or web: if |y|<|z|
(increments of end coordinates) and flexure is in the Y axis, it will be considered a
web; if not, it will be a flange. The reverse will hold true for flexure in the Z-axis.
The length of the plate h will be taken as the value d for the section
dimensions.
Section Box:
The length of the plate will be taken as the width length minus three times
the thickness.
E
λ = 1.49√
Fy
Pipe sections
E
λ = 0.11
Fy
Box sections
E
λ = 1.40√
Fy
- Unstiffened elements:
E
λ = 0.56√
Fy
Angular sections
E
λ = 0.45√
Fy
Stem of T sections
E
λ = 0.75√
Fy
Section I:
Flanges:
E EKc
λp = 0.38√F λr = 0.95√ F
yc yr
Fyr = minimum of 0.7Fyc , R h Fyw Sxt /Sxc y Fyw but no less than 0.5Fyc .
Web:
𝐸
√F
yc
𝜆𝑝 = 2
MP
(0.54 R M − 0.09)
h y
E
λr = 5.70√
Fy
Section C
Flanges:
E EKc
λp = 3.76√F λr = 0.95√ F
y yr
Fyr = minimum of 0.7Fyc , R h Fyw Sxt /Sxc y Fyw but no less than 0.5Fyc .
Web:
E
λp = 3.76√
Fy
E
λr = 5.70√
Fy
Pipe section:
E
λp = 0.07
Fy
E
λr = 0.31
Fy
Box section:
Flanges of box section:
E
λp = 1.12√
Fy
E
λr = 1.40√
Fy
Webs: the program distinguishes between the flange and web upon the
principal axis chosen by the user.
E
λp = 2.42√
Fy
E
λr = 5.70√
Fy
T section:
E
Flange: λr = 0.38√
Fy
E
λp = 1.0√
Fy
Web: No limits are included for flexure classification, so class section is only
checked for flange limit.
The axial tension force must be taken as positive (if the tension force has a negative value,
the element will not be checked)
Φy = 0.95
Φu = 0.80
Being:
Ag Gross area.
The effective net area will be taken as Ag – AHOLES. The user will need to enter the correct
value for AHOLES (the code indicates that the diameter is 1/16th in. (2 mm) greater than the
real diameter).
Axial compression check by la AASHTO LRFD BRIDGE DESIGN SPECIFICATIONS 2010 of the
design compressive strength, Φc Pn , are determined as follows:
Φc = 0.90
Q = Qs Qa
P
(a) for Pe ≥ 0.44
0
P0
Pn = (0.658Pe ) P0
P
(b) for Pe < 0.44
0
Pn = 0.877Pe
Being:
P0 = QFy Ag
π2
Pe = EAg
Kl 2
(r )
s
Where:
l Unbraced length.
Factor Q for compact and noncompact sections is always 1. Nevertheless, for slender
sections ( exceed ratio given in 10-G.6.1.1 ) , the value of Q = Qs Qa has a particular
procedure. Such procedure is described below:
For unstiffened plates, Qs must be calculated and for stiffened plates, Qa must be
determined. If these cases do not apply (box sections or angular sections, for
example), a value of 1 for these factors will be taken.
For circular sections, there is a particular procedure of calculating Q. Such procedure is
described below:
For circular sections, Q is:
0.038∙E 2
Q = Qa = +3 0.11 E⁄F ≤ D⁄t < 0.45 E⁄F
Fy (D⁄t) y y
Factor Qs:
If there are several plates free, the value of Qs is taken as the biggest value of all of
them. The program will check the slenderness of the section in the following order:
Angular
λ
If 0.45√E⁄Fy < 𝜆 ≤ 0.91√E⁄Fy Qs = 1.340 − 0.76
√E⁄Fy
E/Fy
If 0.91√E⁄Fy < 𝜆 Qs = 0.53
λ2
Stem of T
λ
If 0.75√E⁄Fy < 𝜆 ≤ 1.03√E⁄Fy Qs = 1.908 − 1.22
√E⁄Fy
E/Fy
If 1.03√E⁄Fy < 𝜆 Qs = 0.69
λ2
Rolled shapes
λ
If 0.56√E⁄Fy < 𝜆 ≤ 1.03√E⁄Fy Qs = 1.415 − 0.74
√E⁄Fy
E/Fy
If 1.03√E⁄Fy < 𝜆 Qs = 0.69
λ2
Other sections
Qs
If 0.64√k c ∙ E⁄Fy < 𝜆 ≤ 1.17√k c ∙ E⁄Fy λ
= 1.415 − 0.65
√k c ∙ E⁄Fy
E/Fy
If 1.17√k c ∙ E⁄Fy < 𝜆 Qs = 0.90
λ2
Factor Qa:
E E 0.38 E
If λ ≥ 1.40√ be = 1.92 ∙ t√ [1 − √ ]
f f λ f
With the be values for each plate, the part that does not contribute [t·(b-be)] is
subtracted from the area (where t is the plate thickness). Using this procedure, the
effective area is calculated.
P0
Pn = (0.658Pe ) P0
P
(b) for Pe < 0.44
0
Pn = 0.877Pe
Where:
P0 = QFy Ag
Q = Qs Qa
Factor Q for compact and noncompact sections is 1. Nevertheless, for slender sections, the Q
factor has a particular procedure of calculation. Such procedure is equal to the one
previously described.
The elastic stress for critical torsional buckling or flexural-torsional buckling Fe is calculated
as the lowest root of the following third degree equation, in which the axis have been
changed to adapt to the CivilFEM normal axis:
y 2 Z 2
(Pe − Pex )(Pe − Pey )(Pe − Pez ) − Pe2 (Pe − Pez ) ( 0 ) − Pe2 (Pe − Pey ) ( 0 ) = 0 (6.9.4.1.3-7)
r 0 r
0
Where:
Iy + Iz
r̅ 02 = y02 + z02 +
A
y0 + Z02
2
H=1−( )
r̅ 02
π2 ∙ E
Pey = 2A
(K y ∙ I⁄ry )
π2 ∙ E
Pez = A
(K z ∙ I⁄rz )2
π2 ∙ E ∙ Cw
Pex = ( )
(K x ∙ I)2
where:
l Unbraced length.
In this formula, CivilFEM principal axes are used. If the CivilFEM axes are the principal axes
5º sexagesimal degrees, Ky and Kz are calculated with respect to the Y and Z-axes of
CivilFEM. If this is not the case (angular shapes, for example) axes U and V will be used as
principal axes, with U as the axis with higher inertia.
X X X Non-slender
BOX web
(6.12.2.2.2) (6.12.2.2.2) (6.12.2.2.2)
X X X X Non-slender
T SECTION flange
(6.12.2.2.4) (6.12.2.2.4) (6.12.2.2.4) (6.12.2.2.4)
X X X Non-slender
I SECTION
web and Fy<70
(A.6.3.3) (A.6.3.2) ksi
(FLEXUREABOU
T STRONG AXIS)
DOUBLE T X X Non-slender
flanges
(FLEXURE (6.12.2.2.1)
ABOUT WEAK
AXIS)
SECTION C X X Compact
members
(FLEXURE (6.12.2.2.5) (6.12.2.2.5)
ABOUT
STRONG AXIS)
SECTION C X X Non-slender
flanges
(FLEXURE (6.12.2.2.5)
ABOUT WEAK
AXIS)
f = 1.00
e) Yielding (Y)
f) Lateral-torsional buckling (LTB)
g) Flange local buckling (FLB)
h) Web local buckling (WLB)
FLB
If λp ≤ λ ≤ λr
y b F
Mn = Mp = (Mp − Fy S) (3.57 t f √ 𝐸 − 4.0) ≤ Mp
f
If𝜆 > λr
Mn = Fy Seff
WLB
If 𝜆 > 𝜆p
𝐷
y F
Mn = Mp − (Mp − Fy S ) (0.305 t √ 𝐸 − 0.738) ≤ Mp
w
Circular tubes (compact, non-compact and slender under the ratio limit
E
λ = 0.45 F )
y
1. Yielding
M n = Mp
2. Local buckling
If λp ≤ λ ≤ λr
0.021E
Mn = [ + Fy ] S
λ
If 𝜆 > 𝜆r
Mn = Fcr S
0.33E
Fcr =
λ
T shape
1. Yielding Mn = Mp
2. LTB
𝜋√EIy GJ
Mn = [𝐵 + √1 + 𝐵 2 ] ≤ Mp
Lb
d Iy
B = ±2.3 √
Lb J
(The plus sign for B shall apply when the stem is in tension and the minus sign shall apply
when the stem is in compression)
3. FLB
Ifλp ≤ λ ≤ λr
λ−λp
Mn = Mp − (Mp − 0.7Fy Sxc ) (λ ) ≤ 1.6My
r −λp
λ > λr is not provided because the limiting slenderness value is larger than
12 (Eq. 6.10.2.2-1)
2. LTB
E
Lp = 1.0rt √
Fy
2
E J F S h
Lr = 1.95rt √ √1 + √1 + 6.76 ( yr x )
Fyr Sx h EJ
Where:
bf
rt = radius of gyration =
Dc fw
√12 (1 + )
3bf t f
If Lb ≤ Lp
Mn = My R pc
If Lp < Lb ≤ Lr
Fyr Sx L −Lp
Mn = Cb [1 − (1 − M )( Lb−L )] My R pc ≤ My R pc
y Rpc r p
If Lb > Lr
Mn = Fcr Sx
C b π2 E 𝐽 L 2
Fcr = 2 √1 + 0.078 ( b)
L Sx h r
( b) t
rt
3. FLB
If λ ≤ λp
Mn = My R pc
If λ ≤ λp
Fyr Sx λ−λp
Mn = [1 − (1 − R ) (λ )] R pc My
pc My r −λp
R pc is the web plastification factor for the compression flange determined as specified in
Article A6.2.1 or Article A6.2.2:
E
√F E
y
If is compact web λ≤ Mp 2 ≤ 5.7√F
(0.54 −0.09) y
Rh M y
Mp
R pc =
My
E
If is non-compact web, λ ≤ 5.7√F
y
R h My λ − λp M p M p
R pc = [1 − (1 − )( )] ≤
Mp λr − λp M y M y
R h is the hybrid factor and for sections that are checked in CivilFEM takes a value of 1.
1. Yielding:
Mn = Mp
2. FLB
If λ ≤ λp
Mn =Mp
If λp ≤ λ ≤ λr
Sy λ− λp
Mn = 1 − (1 − Z )( ) Fyf Zy
y 𝐸
0.45√
F
[ fy
]
E
Lp = 1.76ry √
Fy
2
Lr = 1.95 rts
E
√S
Jc
√1 + √1 + 6.76 (0.7Fy Sx h0)
0.7Fy x h0 EJc
If Lp <Lb <Lr
L −Lp
Mn = Cb [Mp − (Mp − 0.7Fy Sx )( Lb−L )] ≤ Mp
r p
If Lb >Lr
Mn =Fcr Sx
Cb π2 E Jc Lb 2
Fcr = √
2 1 + 0.078 ( )
L Sx h0 rts
(r b )
ts
h0 Iy
C= √
2 Cw
2
√Iy Cw
rts =
Sx
Where:
Cw =warping constant(in6)
2. FLB
If λ ≤ λp
Mn = M p
Ifλp ≤ λ ≤ λr
Sy λ − λp
Mn = 1 − (1 − )( ) Fyf Zy
Zy
E
0.45√F
fy
[ ]
To calculate the nominal shear strength CivilFEM follows the provisions of the article
6.10.9.2 except for box-shaped (6.12.1.2.3b) and circular tubes (6.12.1.2.3c)
Vn =C∗ Vp
C is the ratio of the shear-buckling resistance to the shear yield strength determined as:
D k E
a. For ≤ 1.12√ F Cv = 1.0 (AASHTO 6.10.9.3.2-4)
tw y
Ek D Ek 1.12 Ek
b. For 1.12√ F < t ≤ 1.40√F Cv = h √t (AASHTO 6.10.9.3.2-5)
y w y w
tw
D Ek 1.57 Ek
c. For tw
≤ 1.40√ F Cy = h 2 (F ) (AASHTO 6.10.9.3.2-6)
y ( ) y
tw
The web plate buckling coefficient, Kv, will be calculated as a constant equal to 5.0.
For shape-box sections D is the clear distance between flanges less inside corner radius on
each side. Both webs area shall be considered effective in resisting the shear.
For circular tubes the nominal shear strength will be taken as:
Vn = 0.5Fcr A
1.60E
Fcr1 = 5 ≤ 0.58Fy
L D
√ v ( )4
D t
0.78E
Fcr2 = 3 ≤ 0.58Fy
D 2
(t)
1. Yielding
2. Lateral-torsional buckling
3. Flange local buckling
4. Web local buckling
In the case of having bending plus tension or bending plus compression, the interaction
between flexure and axial force is limited by the following equations:
Pr
(c) For ≥ 0.2
Pc
Pu 8 M Muy
+ 9 ( Muz + M ) ≤ 1.0 (6.8.2.3-2, 6.9.2.2-2)
Pr rz ry
Pr
(d) For < 0.2
Pc
Pu M Muy
+ ( Muz + M ) ≤ 1.0 (6.8.2.3-1, 6.9.2.2-1)
2Pr rz ry
Where:
Pr Factored resistance.
If one of these checks do not meet the code requirements, it will not be possible to check
the member under flexure plus tension / compression.
Description Property
Elasticity modulus E
Poisson coefficient
Shear modulus G
*th =thickness of the plate
Gross section data correspond to the nominal properties of the cross-section. For the net
section, only the area is considered. This area is calculated by subtracting the holes for
screws, rivets and other holes from the gross section area. (The area of holes is introduced
within the structural steel code properties).
The effective section data and the section and plates class data are obtained in the checking
process according to chapter B, section B4 of the code. This chapter classifies steel sections
into three groups (compact, noncompact and slender), depending upon the width-thickness
ratio and other mandatory limits.
The AISC 14TH Edition module utilizes the gross section data in user units and the CivilFEM
axis or section axis as initial data. The program calculates the effective section data and the
class data, and stores them in CivilFEM’s results file, in user units and in CivilFEM or section
axis.
The section data used in AISC 14TH Edition are shown in the following tables:
Description Data
Input data:
1.- Height H
2.- Web thickness Tw
3.- Flanges thickness Tf
4.- Flanges width B
5.- Distance between flanges Hi
6.- Radius of fillet (Rolled shapes) r1
7.- Toe radius (Rolled shapes) r2
8.- Weld throat thickness (Welded shapes) a
9.- Web free depth d
Input data:
1.- Depth in Y Tky CivilFEM
2.- Depth in Z tkz CivilFEM
3.- Cross-section area A
4.- Moments of inertia for torsion It CivilFEM
5.- Moments of inertia for bending Iyy, Izz CivilFEM
6.- Product of inertia Izy CivilFEM
7.- Elastic resistant modulus Wely, Welz CivilFEM
8.- Plastic resistant modulus Wply, Wplz CivilFEM
9.- Radius of gyration iy, iz CivilFEM
10.- Gravity center coordinates Ycdg, Zcdg Section
11.- Extreme coordinates of the perimeter Ymin, Ymax, Section
Zmin, Zmax
12.- Distance between GC and SC in Y and in Z Yms, Zms Section
13.- Warping constant Iw
14.- Shear resistant areas Yws, Zws CivilFEM
15.- Torsional resistant modulus Xwt CivilFEM
16.- Moments of inertia for bending about U, V Iuu, Ivv Principal
17.- Angle Y->U or Z->V CivilFEM
Description Data
Input data:
1.- Gross section area Agross
2.- Area of holes Aholes
Output data:
1.- Cross-section area Anet
The effective section depends upon the geometry of the section; thus, the effective section
is calculated for each element and each of the ends of the element.
Description Data
Input data: (None)
Output data:
Description Data
Input data:
Output data:
R u ≤ ϕR n
Where:
Rn Nominal strength.
ϕ Resistance factor.
ΦR n Design strength
R a ≤ R n /Ω
Where:
Rn Nominal strength.
Ω Safety factor
R n /Ω Allowable strength
Therefore, the code suggests different lambda values depending on if the element is
subjected to compression, flexure or compression plus flexure.
The section classification is the worst-case scenario of all of its plates. Therefore, the class is
calculated for each plate with the exception of pipe sections, which have their own
formulation because it cannot be decomposed into plates. This classification will consider
the following parameters:
a) Length of elements:
The program will define the element length (b or h) as the length of the plate
(distance between the extreme points), except when otherwise specified.
Once the principal axis of bending is defined, the program will examine the plates of
the section. Fields Pty and Ptz of the plates indicate if they behave as flanges, webs
or undefined, choosing the correct one for the each axis. If undefined, the following
criterion will be used to classify the plate as flange or web:
If |∆y| < |∆z| (increments of end coordinates) and flexure is in the Y axis, it will be
considered a web; if not, it will be a flange. The reverse will hold true for flexure in
the Z-axis.
The length of the plate h will be taken as the value d for the section
dimensions.
Section Box:
The length of the plate will be taken as the width length minus three times
the thickness.
λp = 0.0
E
λr = 1.49√F
y
Pipe sections
E
λr = 0.11
Fy
Box sections
E
λp = 1.12√F
y
E
λr = 1.40√F
y
- Unstiffened elements:
E
λp = 0.0 λr = 0.56√F
y
Angular sections
E
λr = 0.45√F
y
Stem of T sections
E
λr = 0.75√F
y
Section I and C:
Py = Fy ∙ Ag ; Φb = 0.90
4
kc =
√h⁄t
w
𝐹𝐿 = minimum of (Fyf − Fr ) and (Fyw ) where Fyf and Fyw are the Fy of flange
and web respectively.
E E
λp = 0.38√F λr = 0.83√F
L L
E E
λp = 0.38√F λr = 0.95√F
yf L /kc
Flange:
Pu E P
If ⁄ΦP ≤ 0.125 ∶ λp = 3.76√F (1 − 2.75 ∅Pu )
y y y
Pu E P E
If ⁄ΦP > 0.125 ∶ λp = 1.12 √F (2.33 − ∅Pu ) ≥ 1.49√F
y y y y
E P
Always: λr = 5.70√F (1 − 0.74 ΦPu )
y y
Pipe section:
E
λp = 0.07 F
y
E
λr = 0.31 F
y
Box section:
E
λp = 1.12
Fy
E
λr = 1.40
Fy
Flanges: the program distinguishes between the flange and web upon the
principal axis chosen by the user.
Pu E 𝑃
If ⁄ΦP ≤ 0.125 ∶ λp = 3.76√F (1 − 2.75 Φ𝑃𝑢 )
y y 𝑦
Pu E P E
If ⁄ΦP > 0.125 ∶ λp = 1.12√F (2.33 − ΦPu ) ≥ 1.49√F
y y y y
E P
Always: λr = 5.70√F (1 − 0.74 ΦPu )
y y
T section:
λp = 0.0
E
Stem: λp = 0.75√
Fy
E
Flanges: λr = 0.56√F
y
Design tensile strength Φt Pn and the allowable tensile strength Pn ⁄Ωt , of tension members,
shall be the lower value of :
Being:
Ag Gross area.
The effective net area will be taken as Ag – AHOLES. The user will need to enter the correct
value for AHOLES (the code indicates that the diameter is 1/16th in. (2 mm) greater than the
real diameter).
The nominal compressive strength, Pn , shall be the lowest value obtained according to the
limit states of flexural buckling, torsional buckling and flexural-torsional buckling.
Pn = Ag Fcr (E3-1)
KI Fy
λc = √
rπ E
Q = Qs Qa
KL E
d) For : ≤ 4.71√QF
r y
QFy
Fcr = Q (0.658 Fe ) Fy
KL E
e) for > 4.71√QF
r y
Fcr = 0.877Fe
Where:
l Unbraced length.
Fe π2 E
Elastic critical buckling stress Fe = KL 2
( )
r
Factor Q for compact and noncompact sections is always 1. Nevertheless, for slender
sections, the value of Q has a particular procedure. Such procedure is described below:
For unstiffened plates, Qs must be calculated and for stiffened plates, Qa must be
determined. If these cases do not apply (box sections or angular sections, for example), a
value of 1 for these factors will be taken.
Factor Qs:
If there are several plates free, the value of Qs is taken as the biggest value of all of them.
The program will check the slenderness of the section in the following order:
Angular
λ
Q s = 1.340 − 0.76
If 0.45√E⁄Fy < 𝜆 ≤ .91√E⁄Fy
√E⁄Fy
E⁄Fy
If 0.91√E⁄Fy < 𝜆 Q s = 0.53
λ2
Stem of T
λ
Q s = 1.908 − 1.22
If 0.75√E⁄Fy < 𝜆 ≤ 1.03√E⁄Fy
√E⁄Fy
E⁄Fy
If 1.03√E⁄Fy < 𝜆 Q s = 0.69
λ2
Rolled shapes
λ
Q s = 1.415 − 0.74
If 0.56√E⁄Fy < 𝜆 ≤ 1.03√E⁄Fy
√E⁄Fy
E⁄Fy
If 1.03√E⁄Fy < 𝜆 Q s = 0.69
λ2
Other sections
λ
Q s = 1.415 − 0.65
If 0.64√k c ∙ E⁄Fy λ ≤ 1.17√k c ∙ E⁄Fy
√k c ∙ E⁄Fy
E/Fy
If 1.17√k c ∙ E/Fy < 𝜆 Q s = 0.90k c
λ2
Factor Qa:
With the be values for each plate, the part that does not contribute [t·(b-be )] is
subtracted from the area (where t is the plate thickness). Using this procedure, the
effective area is calculated.
Pn = Ag Fcr
f) for λe √Q ≤ 1.5
2
Fcr = Q(0.658Qλe )Fy
Where:
Fy
λe = √
Fe
Q = Qs Qa
Factor Q for compact and noncompact sections is 1. Nevertheless, for slender sections, the Q
factor has a particular procedure of calculation. Such procedure is equal to the one
previously described.
The elastic stress for critical torsional buckling or flexural-torsional buckling Fe is calculated
as the lowest root of the following third degree equation, in which the axis have been
changed to adapt to the CivilFEM normal axis:
y 2 Z 2
(Fe − Fex )(Fe − Fey )(Fe − Fez ) − Fe2 (Fe − Fez ) ( 0 ) − Fe2 (Fe − Fey ) ( 0 ) = 0
r 0 r 0
Where:
Iy + Iz
r̅ 02 = y02 + Z02 +
A
𝑦02 + 𝑍02
𝐻 =1−( )
𝑟̅0 2
π2 ∙ E
Fey =
K y ∙ I/ry
π2 ∙ E
Fez =
K z ∙ I/rz
π2 ∙ E ∙ Cw 1
Fex =( + G ∙ J) ∙
(Kx ∙ I) A ∙ r̅02
where:
l Unbraced length.
In this formula, CivilFEM principal axes are used. If the CivilFEM axes are the principal axes
5º sexagesimal degrees, K y and K z are calculated with respect to the Y and Z-axes of
CivilFEM. If this is not the case (angular shapes, for example) axes U and V will be used as
principal axes, with U as the axis with higher inertia.
The torsional inertia (Ixx in CivilFEM, J in AISC 13TH Edition) is calculated for CivilFEM
sections, but not for captured sections. Therefore the user will have to introduce this
parameter in the mechanical properties of CivilFEM.
The design flexural strength, ϕb Mn , and the allowable flexural strength, Mn /Ωb , shall be
determined as follows:
Where Mn is the lowest value of four checks according to sections F2 through F12:
i) Yielding
j) Lateral-torsional buckling
k) Flange local buckling
l) Web local buckling
The value of the nominal flexural strength with the following considerations:
Limit
Shape Mr Fcr p r
State
I, C Cb X1 √2 X2X Lb E X1
LTB FL S z √1 + 1 2 1.76√ √ √1 + X2 FL2
loaded λ 2λ2 rz Fyf FL 1 +
in the
axis of 0.69E
rolled b
higher FLB λ2
FL S z Class B4.1 Class B4.1
0.90Ekc t
inertia. welded
λ2
Limit
Shape Mr Fcr p r
State
I, C LTB N.A. N.A. N.A. N.A. N.A.
loaded
in the
axis of FLB 0.69E b Class
Fy S y Class B4.1
lower λ2 t B4.1
inertia.
Limit
Shape Mr Fcr p r
State
Box
Seff b
FLB Fyt Seff F Class B4.1 Class B4.1
S y t
Limit
Shape Mr Fcr p r Notes
State
LTB NA NA NA NA NA
Slender:
Limited
Pipe Fcr S
0.33E Class Class by
FLB
Non-compact: D⁄t
D⁄t B4.1 B4.1 Class
0.021E B4.1
Mn = ( + Fy ) ∙ S
D⁄t
WLB NA NA NA NA NA
Limit
Shape Mr Fcr p r
State
π√EIz GJ
LTB Mn = Mcr = [B + √1 + B 2 ] N.A. N.A. N.A. N.A.
T, loaded in Lb
web plane
FLB N.A. N.A. N.A. N.A. N.A.
Where:
π EGJA
X1 = √
Sz 2
Cw Sz 2
X2 = 4 ( )
Iz GJ
d Iz
B = +2.3 √
Lb J
For slender webs the nominal flexural strength Mn is the minimum of the following checks:
tension-flange yield
compression flange buckling
Mn = Sxc Fy
where:
Mn = Sxc R PG Fcr
where:
aw hc E
R PG = 1 − ( − 5.70√ ) ≤ 1.0
1200 + 300aw t w Fy
The critical stress depends upon different slenderness parameters such as , λp , λr and Cpg
in the following way:
For λp ≤ λ ≤ λr λ − λp
Fcr = Cb ∙ Fyf ∙ [1 − 0.3 ∙ ( )] ≤ Fyf
λr − λp
E
λp = 1.1 ∙ √
Fyf
E
λr = π ∙ √
0.7Fyf
rT is the radius of gyration of compression flange plus one third of the compression
portion of the web (mm).
E
λp = 0.38 ∙ √
Fyf
E
λr = 1.35 ∙ √
Fyf /k c
Cb = 1
k c = 4/√h/t w
and
0.35 ≤ k c ≤ 0.76
Between these two slenderness, the program will choose values the value that produces a
lower critical stress.
According to the limit states of shear yielding and shear buckling, the nominal shear
strength, Vn , of unstiffened webs is:
Vn = 0.6Fy Aw Cv
For webs of all other doubly symmetric shapes and singly symmetric shapes and channels
Cv is determined as follows:
It is assumed that there are no stiffeners; therefore, the web plate buckling coefficient K v
will be calculated as a constant equal to 5.0.
5. Yielding
6. Lateral-torsional buckling
7. Flange local buckling
8. Web local buckling
In the case of having bending plus tension or bending plus compression, the interaction
between flexure and axial force is limited by the following equations:
P
(e) For Pr ≥ 0.2
c
Pr 8 M Mry
+ 9 (Mrz + M ) ≤ 1.0 (H1-1a)
Pc cz cy
P
(f) For Pr ≥ 0.2
c
Pr M Mry
+ (Mrz + M ) ≤ 1.0 (H1-1b)
2Pc cz cy
Design: ϕb Mn (LRFD) or
Design: ϕc Pn (LRFD) or
Design: ϕb Mn (LRFD) or
Fn = Fcr
Chapter 8
Seismic Design
8.1. Introduction
Seismic design with CivilFEM provides the user a set of tools to analyze seismic action on
structures, according to the provisions of:
1. Spectrum definition.
2. Calculation of mode shapes.
3. Modal combination.
Once the data have been input, the fraction is obtained by dividing the design ground
acceleration ag by the gravity acceleration g, displayed below:
ag
α=
g
If the spectrum is elastic, the ordinates of the horizontal spectrum are obtained as
follows:
T β0
Sd (T) = α ∙ S ∙ [1 + ( − 1)] TA < 𝑇 ≤ TB
TB q
β0
Sd (T) = α ∙ S ∙ TB < 𝑇 ≤ TC
q
β0 TC Kd1
Sd (T) = α ∙ S ∙ [ ] TC < 𝑇 ≤ TD
q T
β0 TC Kd1 TD Kd2
Sd (T) = α ∙ S ∙ [ ] [ ] TD < 𝑇 ≤ TE
q TD T
Where:
q = behavior factor. The values for this factor differ for the horizontal
seismic action and for the vertical seismic action. Therefore, this
factor assumes two different values qh and qv depending on the
material type.
Kd1, Kd2 = exponents which influence the shape of the design spectrum for a
vibration period greater than TC, TD respectively.
If the spectrum is the design spectrum, the ordinates of the horizontal spectrum are
obtained as follows:
2 T 2.5 2
Sd (T) = ag ∙ S ∙ [ + ( − )] 0 < 𝑇 ≤ TB
3 TB q 3
2.5
Sd (T) = ag ∙ S ∙ TB < 𝑇 ≤ TC
q
2.5 TC
Sd (T) = ag ∙ S ∙ [ ] TC < 𝑇 ≤ TD
q T
≥ β ∙ ag
2.5 TC ∙ Td
Sd (T) = ag ∙ S ∙ [ 2 ] TD < 𝑇
q T
≥ β ∙ ag
Where:
q = behavior factor. The values of this factor are different for the
horizontal seismic action and for the vertical seismic action.
Therefore, this factor assumes two different values qh and qv
For the elastic spectrum, the ordinates of the vertical spectrum are obtained as
follows:
T
Sve (T) = avg ∙ [1 + (η ∙ 3.0 − 1)] 0 < 𝑇 ≤ TB
TB
TC
Se (T) = ave ∙ η ∙ 3.0 ∙ [ ] TC < 𝑇 ≤ TD
T
TC ∙ TD
Sve (T) = avg ∙ η ∙ 3.0 ∙ [ ] TD < 𝑇 ≤ 4s
T2
Where:
To obtain the vertical design spectrum, the same expressions of the horizontal design
spectrum are utilized with S=1 and the recommended values of ag ,Tc and Td in the
vertical elastic response spectra table.
ab
AB Ratio of the basic seismic acceleration to the gravity acceleration[ ].
g
K Coefficient of contribution.
Once the data have been input, TA and TB are calculated by:
c
TA = k ∙
10
c
TB = k ∙
2.5
In addition, the amplification coefficient of soil S is calculated by:
C
S= for ρ ∙ 𝖺b ≤ 0.1 ∙ g
1.25
C 𝖺b C
S= + 3.33 (ρ ∙ − 0.1) ∙ (1 − ) for 0.1 ∙ g ≤ ρ ∙ 𝖺b ≤ 0.4 ∙ g
1.25 g 1.25
Finally, the modification factor of the spectrum is calculated as a function of the damping
by:
ν = (5⁄Ω)0.4
S𝖺
α(T) =
𝖺
The design spectrum Sd is given by (Art. 3.6.2.2):
𝖺b
Sd = (Ti ) = αi ∙ S ∙ ρ ∙ g ∙ ( )
g
where:
αi = α(Ti ) ∙ β if Ti ≥ TA
T
αi = 1 + (2.5β − 1) ∙ T i if Ti ≤ TA
A
ν
β=
μ
1. The first 10 values for periods Ti between 1/10·TA and TA are calculated by:
i ∙ TA
Ti =
10
where: i = 1 to 10
a. If the spectrum type entered is linear, then the ordinates of the spectrum (Ti)
are obtained with the following equation:
α(T) = 1 + 1.5 ∙ T⁄TA
where: i = 1 to 10
b. If the spectrum type is simplified, then the ordinates of the spectrum (Ti) are
obtained by:
α(Ti ) = α(TA )
where: i = 1 to 10
2. The remaining values of the period and of the ordinates of both spectrum types are
calculated as follows:
a. Values of the period:
10 ∙ TB
Ti =
(21 − i)
where: i = 10 to 20
where: i = 10 to 20
Once the values of the period and the ordinates of the spectrum are calculated, the spectral
accelerations are obtained for two orthogonal directions consisting of the X and Y global
axes by applying:
Sd (Ti )x = Sd (Ti )
Sd (Ti )y = Sd (Ti )
For vertical movements, the ordinates of the spectrum will be reduced by a factor of 0.7.
Once the vibration modes are obtained they are combined to obtain the response of the
structure.
𝑁 𝑁
𝑅𝑚 = √∑ ∑ 𝜀𝑖𝑗 |𝑅𝑖 ∙ 𝑅𝑗 |
1 1
Where:
3/2
8 ∙ √𝜉𝑖 ∙ 𝜉𝑗 ∙ (𝜉𝑖 + 𝑟𝑖𝑗 ∙ 𝜉𝑗 ) ∙ (𝑟𝑖𝑗 )
𝜀𝑖𝑗 = 2 2 2
(1 − (𝑟𝑖𝑗 ) ) + 4 ∙ 𝜉𝑖 ∙ 𝜉𝑗 ∙ 𝑟𝑖𝑗 ∙ (1 + (𝑟𝑖𝑗 ) ) + 4 ∙ (𝜉𝑖2 + 𝜉𝑗2 ) ∙ (𝑟𝑖𝑗 )
Where:
𝑤𝑗
𝑟𝑖𝑗 =
𝑤𝑖
𝑁
𝑅𝑚 = √∑ 𝑅𝑖2
1
(𝑅 𝑚𝑎𝑥 )𝑖 = √∑((𝑅𝛼𝑚𝑎𝑥 )𝑖 )2
𝛼
Where:
Where P and S are the primary and secondary combination factor defined by the user.
Real number.
Integer number.
2D point (x, y).
2D vector (x, y).
3D point (x, y, z).
3D vector (x, y, z).
Parameters can be used (instead of a literal number) as a property to any CivilFEM property;
the parameter is evaluated and its current value is used for that property (i.e. Material’s
Young Modulus).
Parameter
area A
circle area Ac
Distinction is made between upper and lower case letters. Example: Different parameter
names because of upper and lower cases.
Parameter
area a
angle A
Reserved words cannot be used as parameter names. Reserved words are the function and
constant names defined in the next sections. Example: Invalid parameter name.
Parameter
AND, E, NOT, OR, PI, pi, abs, acos, acosd, acosu, arccos, arccosd, arccosu, arcsin, arcsind,
arcsinu, arctan, arctand, arctanu, asin, asind, asinu, atan, atan2, atand, atanu, ceil, cos,
cosd, cosh, coshd, coshu, cosu, cross, distance, division, dot, e, exp, fact, factorial, floor,
fmod, g_SI, g_ft, ln, log, max, middlePoint, min, mod, norm, oneX2d, oneX3d, oneY2d,
oneY3d, oneZ3d, ones2d, ones3d, percent, percentage, pow, projectionXY, projectionXZ,
projectionYZ, rotate, rotateCW, rotateX, rotateXCW, rotateY, rotateYCW, rotateZ,
rotateZCW, round, roundUp, sin, sind, sinh, sinhd, sinhu, sinu, sqrt, sum, tan, tand, tanh,
tanhd, tanhu, tanu, trunc, truncate, unitary, zero2d, zero3d, Σ, π, ⋁
There is also a list of parameter names already used for predefined local parameters
(parameters for individual material, section or other properties…) that neither can be used
for global parameters:
9.1.2. Constants
Numbers assigned to parameters.
Parameter Input
area A 5.1
number of bars n_bars 24
Predefined constants
Constant
Value Description
Name
Parameter Input
Earth’s gravity g g_SI
9.1.3. Operators
Arithmetic operators:
Addition (+)
Subtraction (-)
Multiplication (*)
Division (/)
Module (mod): the remainder of the first number when divided by the
second.
Power (^)
Example:
C A*B 287
D A mod B 6
Less than (<): “A<B” returns true if parameter “A” is less than parameter “B”.
Greater than (>): “A>B” returns true if parameter “A” is greater than parameter “B”.
Less than or Equal to (<=): “A<=B” returns true if parameter “A” is equal or less than
parameter “B”.
Greater than or Equal to (>=): “A>=B” returns true if parameter “A” is equal or
greater than parameter “B”.
Equal (=): “A=B” returns true if parameter “A” is equal to parameter “B”.
Different from (<>): “A<>B” returns true if parameter “A” is different from parameter
“B”.
Logical operators:
Example:
A B A! A && B A || B
T T F T T
T F F F T
F T T F T
F T T F F
Operator precedence:
When several operations occur in an expression, each part is evaluated and resolved in a
predetermined order called operator precedence. Parentheses can be used to override the
order of precedence and force operations within parentheses to be evaluated before those
outside. Within parentheses, however, normal operator precedence is maintained.
Operators are sorted in precedence levels from highest to lowest precedence as shown in
the following list. When two or more operators in an expression have the same precedence
level, operations are evaluated from left to right.
I. Power (^).
II. Multiplication (*), division (/), module (mod).
III. Addition (+), subtraction (-).
IV. Less than (<), less than or equal to (<=), greater than (>), greater than or equal to
(>=), equal to (=), different from (<>).
V. NOT (!).
VI. AND (&&).
VII. OR (||).
Example:
9.1.4. Functions
Absolute value (abs).
The returned values will be in the units of the model (degrees by default). If the results are
assigned to an angular parameter, they will be shown in the units of the parameter (proper
conversion will be applied). If the functions are going to be operated with undefined
parameters or dimensionless values, then the results will be operated in the units of the
model, but the alternative functions: asinr, acosr, atanr are available to return results in
radians, or: asind, acosd, atand to return results in degrees, or: asinu, acosu, atanu to return
results in the user units defined in the model (work the same as: asin, acos, atan).
Hyperbolic functions: Hyperbolic sine (sinh), Hyperbolic cosine (cosh), Hyperbolic tangent
(tanh).
Minimum (min)
Maximum (max)
As round(A) 1
Bs round(B) 2
Cs round(C) -2
Ds round(D) -3
Factorial (fact)
Map a real number to the smallest following integer (ceil): The ceil of 2.8 is 3.0. The ceil of -
2.8 is -2.0.
Map a real number to the largest previous integer (floor): The floor of 2.8 is 2.0. The floor of
-2.8 is -3.0.
Remainder of the integer division of two real numbers (fmod): The remainder of -10.00 /
3.00 is -1.0. fmod(-10.0,3.0)=-1.0
9.1.5. Units
The user has great flexibility in specifying parameter units. However, it is strongly
recommended to take into account the following notes in order to avoid unit conversion
problems:
All dimensional parameters, that is, all variables where a unit type was
assigned (length, mass, etc.) are correctly converted to consistent units before
operation. Problems may arise when operating with variables with unknown
unit types.
o By default, parameters are of “undefined” unit type, which means that
those parameters may have units but are not specified yet. Those
parameters are not converted and will be operated as dimensionless.
As all the other parameters are converted to consistent units, the
effect of operating the undefined parameters with them would be
equivalent to considering the undefined parameters to be defined in
the same consistent units. Users may be aware of this to avoid
unintended results.
o Dimensionless unit type parameters should be reserved to truly
dimensionless variables.
The key is to know that, before operating, all dimensional parameters are
converted to a consistent units system based on the Principal Units of the
Model (Environment -> Model Configuration -> Units), not to the visualization
units.
o The Derived Units of the model can be customized by the user for
visualization or other purposes, and may be unconsistent with the
principal units… So, only the Principal Units of the model are
considered for the consistent units system used on calculations.
o For the Derived Units of the model, the associated consistent units are
shown between brackets. For example, if the units of the model are:
meters (“m”), seconds (“s”), and kilometers per hour (“km/h”), then
the derived consistent units will be shown as “[m/s]”.
The usage of undefined and/or dimensionless parameters or values in a
formula, that is also using other parameters with assigned unit types, may lead
to misinterpretation in formula evaluation if the unit system is changed or the
model is imported in a different unit system (for example, the change of a
model in Imperial Units to International Units).
o To avoid this kind of situations, CivilFEM “remembers” the units that
were used to define each formula. If those original units are no longer
the same as the units of the model, then, to avoid misinterpretations,
the original units will be shown after a semicolon and used to evaluate
the formula as originaly intended.
o As a rule, formulas are always evaluated in the consistent unit system
based on the principal units of the model, unless other interpretation
units are specified after a semicolon in the formula. In that case, units
after the semicolon will be used for the consistent unit system of that
particular formula.
o The effect of this is formulas will never be misinterpreted due a
change in the units system, even when using undefined or
dimensionless parameters or values, even when mixing formulas from
different unit systems, as the values will still be calculated as originaly
intended and properly converted to the new unit system.
o The idea behind this innovation is to preserve the real magnitudes of
the model, no matter what changes in the unit visualization. If this is
not what intended, the user may remove the units after the semicolon
in the formula.
o For example, in a model defined with Imperial Units with a parameter
“x” in inches, you may use the formula “1+x” so the dimensionless
constant “1” actually operates as 1 inch. When you import that model
in another one with International Units, the parameter “x” would be
converted to meters by default, but the formula will be shown as
“1+x;in” (which means “x” must be converted to inches before
operating, as originaly intended) and the result in inches will be
properly converted to meters.
Example: Unit conversion in a mixed strategy (it is recommended to avoid this case,
specifying the units whenever is possible).
Unit entered
Parameter Magnitude by the User
For those parameters with no specific unit defined by the user, the
corresponding unit of the model (global system unit) will be assigned. In this
example, the International Units System is considered to be the unit system
of the model (global unit system). Therefore, R2 and Rp should be in m.
As you can see, the rectangle and triangle perimeters are properly
computed:
Now, if the unit system of the model (global system of units) is set to
Imperial Units (inches), the parameters expressed in the units of the
model will be computed in a consistent unit system based on the Imperial
Units, unless other units are specified after a semicolon. That could be a
problem for the undefined parameters of this example, as proper
conversions could only be performed on parameter with properly defined
units, but all formulas involving parameters with units will “remember”
those original units to evaluate as originally intended (so those original
units will be shown after a semicolon). Again, the rectangle and triangle
perimeters are properly computed:
Parameter name: In this column the parameter name will be set. Any occurrence of the
parameter name inside any CivilFEM form will be detected and CivilFEM will substitute
the parameter for its value or formula.
Parameter type: The user can choose between the following parameter types: 2D Point,
2D Vector, 3D Point, 3D Vector, Integer number, Real number. This is useful when the
parameterized value is of the point or vector class. The user just needs to define the
point instead of its two or three individual components.
There is a key difference between a point and a vector: when changing from one
coordinate system to another, points are transformed taking into account the change
of origin and vectors are unaffected by the origin.
Unit type: A list of unit types is available so any unit can be chosen so the user can define
its unit later.
Coordinate system: As different coordinate sytems can be defined in CivilFEM, this
column lets the user choose the system used to define a point or vector parameter. This
makes the point or vector referenced to the coordinate system, so modifying the
coordinate system will modify the global position of the point or vector (but not its
coordinates in the local coordinate system).
Formula: The user is not restricted to entering values for defining a parameter. An
arbitray formula (the formula must begin with an equal sign) can be entered to define
the final value. This is a very powerful feature as another parameter can be used inside a
formula, linking several parameters in the definition. A whole model can be changed in
this way just by changing a single value.
Value: A fixed numerical value can be entered directly. If the user has used the formula
option, the calculated value will be displayed here.
Unit: The unit can be chosen using this option, so the user has total flexibility when
defining the parameter using a mix unit approach.
The following figures show an example of the Parameter List window usage in conjunction
with geometry creation.
In the previous figure, three parameters are created. Vertical is a real number of the type
length that is defined using a direct value of 5. Then a Horiz parameter is created using a
formula: =Vertical*1.5 . The resulting value is 7.5. Finally a 3D point parameter called P1 is
created using the formula =(Vertical, Horiz, 0) . The resulting point can be directly used when
creating geometry, entering the point with the formula =P1 .
To start using Python in CivilFEM just activate the Script editor window.
Always refer to CivilFEM Python Manual and CivilFEM Script Manual to know all available
commands.
One of the biggest differences between the Python language and other programming
languages is that Python does not denote blocks of code with reserved words or symbols
such as if..then..endif (FORTRAN) or if { ... } (curly braces in C). Instead, indenting is used for
this purpose. For example, the take following block of FORTRAN code:
if(jtype.eq.49) then
ladt=idt+lofr
endif
if jtype == 49:
ladt=idt+lofr
Python matches the amount of indenting to the block of code. The colon at the end of the if
statement denotes that it is a compound statement. All the lines that are to be in that block
of code need to be at the same indent level. The block of code is ended when the indenting
level returns to the level of to the compound statement. The examples in the following
chapters will show you more about the Python syntax.
1. String: A character string similar to the char data in C and character in FORTRAN. A
string may be specified using either single or double quotes.
2. Float: A floating point number similar to the double data type in C and the real*8
data type in FORTRAN.
3. Integer: An integer or fixed point number similar to the long int data type in C and
the integer*8 data type in FORTRAN.
1. List: A Python list is essentially a linked list that can be accessed like an array using
the square bracket operators [ ]. The list can be composed of strings, floats, or
integers to name a few.
The material covered in this tutorial is very basic and should be easy to access and
understand for the first time Python user.
A multi-dimension list is created by first creating a single dimensional list, and then creating
the other dimensions, as follows (a 3x2 array):
A = [None] * 3
for i in range(3)
A[i] = [None] * 2
Polyline:
1. # Points
2. p1 = pnt("Point1", [1,2,3])
3. p2 = pnt("Point2", [2,3,4])
4. p3 = pnt("Point3", [3,4,5])
5. p4 = pnt("Point4", [4,5,6])
6. # Polyline
Lines 1-5: To add a commentary, the # symbol must be inserted first. To create a point
command, createPoint (or alias pnt) is used. If CivilFEM Python Manual is opened then
createPoint needs two arguments:
1) GeomName (str): Name.
2) Pnt (Point): Coordinates of the point.
Each point is saved into a variable to be used later as a list (p1, p2, …)
Lines 6-7: To create a polyline, command createPolyline (or alias polyline) is used. If CivilFEM
Python Manual is opened then createPolyline needs two arguments:
1) GeomName (str): Name.
2) POINT ([Entity]): List of points (between square brackets [ ]) to define the polyline.
The material covered in this tutorial is very basic and should be easy to access and
understand for the first time Python user.
A multi-dimension list is created by first creating a single dimensional list, and then creating
the other dimensions, as follows (a 3x2 array):
A = [None] * 3
for i in range(3)
A[i] = [None] * 2
Always refer to CivilFEM Python Manual and CivilFEM Script Manual to know all available
commands.