Reports¶
Common formats¶
Common use format strings.
Export displacements¶
Export displacement values.
- postprocess.reports.export_displacements.getDisplacementsDict(nmbComb, nodes, structuralModel=True)¶
Creates a dictionary with the nodes displacements.
- Parameters
nmbComb – combination name.
nodes – node set.
structuralModel – true if structural model, false if solid mechanics model.
Export internal forces¶
Export internal force values.
- postprocess.reports.export_internal_forces.export_beam_internal_forces(nmbComb, elems, fName)¶
Writes a comma separated values file with the element’s internal forces.
- Parameters
nmbComb – name of the load combination.
elems – finite elements to export internal forces from.
- postprocess.reports.export_internal_forces.export_internal_forces(nmbComb, elems, fDesc, woodArmerAlsoForAxialForces=False)¶
Writes a comma separated values file with the element’s internal forces.
- Parameters
nmbComb – combination name.
elems – element set.
fDesc – file descriptor to write internal forces on.
woodArmerAlsoForAxialForces – if true, use Wood-Armer method for both axial and bending internal forces otherwise, use it only for bending moments.
- postprocess.reports.export_internal_forces.export_shell_internal_forces(nmbComb, elems, fDesc, woodArmerAlsoForAxialForces=False)¶
Writes a comma separated values file with the element’s internal forces.
- Parameters
nmbComb – combination name.
elems – element set whose internal forces will be exported..
fDesc – file descriptor to write internal forces on.
woodArmerAlsoForAxialForces – if true, use Wood-Armer method for both axial and bending internal forces otherwise, use it only for bending moments.
- postprocess.reports.export_internal_forces.exporta_esfuerzos_shell_set(preprocessor, nmbComb, st, fDesc, woodArmerAlsoForAxialForces=False)¶
Writes a comma separated values file with the element’s internal forces.
- Parameters
nmbComb – combination name.
st – XC set containing the elements whose internal forces will be exported.
fDesc – file descriptor to write internal forces on.
woodArmerAlsoForAxialForces – if true, use Wood-Armer method for both axial and bending internal forces otherwise, use it only for bending moments.
- postprocess.reports.export_internal_forces.get_internal_forces_dict(nmbComb, elems, vonMisesStressId='max_von_mises_stress', woodArmerAlsoForAxialForces=False)¶
Creates a dictionary with the element’s internal forces.
- Parameters
nmbComb – combination name.
elems – element set.
vonMisesStressId – identifier of the Von Mises stress to read (see NDMaterial and MembranePlateFiberSection).
woodArmerAlsoForAxialForces – if true, use Wood-Armer method for both axial and bending internal forces otherwise, use it only for bending moments.
Graphical reports¶
- class postprocess.reports.graphical_reports.LoadCaseDispParameters(loadCaseName, loadCaseDescr, loadCaseExpr, setsToDispLoads, setsToDispDspRot, setsToDispIntForc)¶
Bases:
postprocess.reports.graphical_reports.RecordDisp
- Parameters for the generation of graphic files and adding to
report-tex files for a load case
- Variables
loadCaseName – name of the load case to be depicted
loadCaseDescr – description text of the load case
loadCaseExpr – mathematical expression to define the load case (ex: ‘1.0*GselfWeight+1.0*DeadLoad’)
- getCaptionText(setDescr, unitsDescr, captTexts=None)¶
Return the caption text.
- Parameters
setDescr – set description.
unitsDescr – units description.
captTexts – text describing the internal force…
- getDescription()¶
- loadReports(FEcase, texFile, cfg)¶
Creates the graphics files of loads for the load case and insert them in a LaTex file
- Parameters
FEcase – finite element problem
texFile – laTex file where to include the graphics (e.g.:’text/report_loads.tex’)
cfg – instance of EnvConfig class with config parameters
- simplLCReports(FEproblem, texFile, cfg)¶
- Creates the graphics files of displacements and internal forces
calculated for a simple load case and insert them in a LaTex file
- Parameters
FEproblem – finite element problem
texFile – laTex file where to include the graphics (e.g.:’text/report_loads.tex’)
cfg – instance of EnvConfig class with config parameters
- solveLC(modelSpace)¶
Solve load case
- writeLoadReport(modelSpace, texFile, cfg)¶
- Creates the graphics files of loads for the load case and insert
them in a LaTex file
- Parameters
modelSpace – PredefinedSpace object used to create the FE model (see predefined_spaces.py).
texFile – laTex file where to include the graphics (e.g.:’text/report_loads.tex’)
cfg – instance of EnvConfig class with config parameters
- writeSimpleLoadCaseReport(modelSpace, texFile, cfg)¶
- Creates the graphics files of displacements and internal forces
calculated for a simple load case and insert them in a LaTex file
- Parameters
modelSpace – model space object (see predefined_spaces.py).
texFile – laTex file where to include the graphics (e.g.:’text/report_loads.tex’)
cfg – instance of EnvConfig class with config parameters
- class postprocess.reports.graphical_reports.OuputUnits¶
Bases:
object
Unit for the generation of graphic files report files.
- Variables
unitsScaleLoads – factor to apply to loads if we want to change the units (defaults to 1).
unitsLoads – text to especify the units in which loads are represented (defaults to ‘units:[m,kN]’)
vectorScaleLoads – factor to apply to the vectors length in the representation of element loads (defaults to 1).
vectorScalePointLoads – factor to apply to the vectors length in the representation of nodal loads (defaults to 1).
unitsScaleDispl – factor to apply to displacements if we want to change the units (defaults to 1).
unitsDispl – text to especify the units in which displacements are represented (defaults to ‘[m])’
scaleDispBeamIntForc – tuple (escN,escQ,escM) correponding to the scales to apply to displays of, respectively, axial forces (N), shear forces (Q) or bending moments (M) in beam elements (defaults to (1.0,1.0,1.0))
scaleDispReactions – tuple (escN,escM) correponding to the scales to apply to displays of, respectively, forces (F) or moments (M) in nodal reactions (defaults to (1.0,1.0))
scaleDispEigenvectors – tuple (escN,escM) correponding to the scales to apply to displays of eigenvectors (defaults to (1.0,1.0))
unitsScaleForc – factor to apply to internal forces if we want to change the units (defaults to 1).
unitsForc – text to especify the units in which forces are represented (defaults to ‘[kN/m]’)
unitsScaleMom – factor to apply to internal moments if we want to change the units (defaults to 1).
unitsMom – text to especify the units in which bending moments are represented (defaults to ‘[kN.m/m]’)
- class postprocess.reports.graphical_reports.RecordDisp(setsToDispLoads=None, setsToDispDspRot=None, setsToDispIntForc=None)¶
Bases:
postprocess.reports.graphical_reports.OuputUnits
Generation of graphic displays
- Variables
setsToDispLoads – ordered list of sets of elements to display loads
setsToDispBeamLoads – ordered list of sets of beam elements to display loads (defaults to [])
compElLoad – component of load on beam elements to be represented available components: ‘axialComponent’, ‘transComponent’, ‘transYComponent’,’transZComponent’ (defaults to ‘transComponent’)
multByElemSizeLoads – boolean value that must be True if we want to represent the total load on each element (=load multiplied by element size -length, area or volume-) and False if we are going to depict the value of the uniform load per unit area (defaults to False)
listDspRot – ordered list of displacement or rotations to be displayed available components: ‘uX’, ‘uY’, ‘uZ’, ‘rotX’, rotY’, ‘rotZ’ (defaults to [‘uX’, ‘uY’, ‘uZ’])
setsToDispDspRot – ordered list of sets of elements to display displacements or rotations
listIntForc – ordered list of internal forces to be displayed as scalar field over «shell» elements available components: ‘N1’, ‘N2’, ‘M1’, ‘M2’, ‘Q1’, ‘Q2’ (defaults to [‘N1’, ‘N2’, ‘M1’, ‘M2’, ‘Q1’, ‘Q2’])
setsToDispIntForc – ordered list of sets of elements (of type «shell») to display internal forces
listBeamIntForc – ordered list of internal forces to be displayed as diagrams on lines for «beam» elements available components: ‘N’, ‘My’, ‘Mz’, ‘Qy’, ‘Qz’,’T’ (defaults to [‘N’, ‘My’, ‘Mz’, ‘Qy’, ‘Qz’,’T’])
setsToDispBeamIntForc – ordered list of sets of elements (of type «beam») to display internal forces (defaults to [])
setsToDispReactions – ordered list of sets of nodes to display reactions (defaults to [])
cameraParameters – parameters that define the camera position, zoom, etc.
cameraParametersForBeams – parameters that define the camera position, zoom, etc for displaying beam elements.
- dispLoadCaseBeamEl(setToDisplay, caption=None, fileName=None, defFScale=0.0)¶
Display the loads applied on beam elements and nodes for a given load case
- Parameters
setToDisplay – set of beam elements to be represented
caption – caption for the graphic
fileName – name of the file to plot the graphic. Defaults to None, in that case an screen display is generated
defFScale – factor to apply to current displacement of nodes so that the display position of each node equals to the initial position plus its displacement multiplied by this factor. (Defaults to 0.0, i.e. display of initial/undeformed shape)
- displayDispRot(fileName=None)¶
- Displays the component of the displacement or rotations
on the set argument.
- Parameters
setToDisplay – set of elements to be displayed (defaults to total set)
fileName – full name of the graphic file to generate. Defaults to ` None`, in this case it returns a console output graphic.,
defFScale – factor to apply to current displacement of nodes so that the display position of each node equals to the initial position plus its displacement multiplied by this factor. (Defaults to 0.0, i.e. display of initial/undeformed shape)
- displayEigenvectorsOnSets(eigenMode, fileName=None, defFScale=0.0)¶
displays the reactions as vector on affected nodes
- Parameters
fileName – name of the file to plot the graphic. Defaults to None, in that case an screen display is generated
defFScale – factor to apply to current displacement of nodes so that the display position of each node equals to the initial position plus its displacement multiplied by this factor. (Defaults to 0.0, i.e. display of initial/undeformed shape)
- displayIntForcDiag(itemToDisp, fileName=None, defFScale=0.0, orientScbar=1, overrideScaleFactor=None, titleScbar=None)¶
- displays the component of internal forces as a
diagram over lines (i.e. appropriated for beam elements).
- Parameters
itemToDisp – component of the internal forces (‘N’, ‘Qy’ (or ‘Vy’), ‘Qz’ (or ‘Vz’), ‘My’, ‘Mz’, ‘T’) to be depicted
unitDescription – string like ‘[kN/m] or [kN m/m]’
fileName – name of the file to plot the graphic. Defaults to None, in that case an screen display is generated
defFScale – factor to apply to current displacement of nodes so that the display position of each node equals to the initial position plus its displacement multiplied by this factor. (Defaults to 0.0, i.e. display of initial/undeformed shape)
overrideScaleFactor – if not none, override the scale factor in outputStyle.
orientScbar – orientation of the scalar bar (defaults to 1-horiz)
titleScbar – title for the scalar bar (defaults to None)
- displayLoadOnSets(caption=None, fileName=None, defFScale=0.0)¶
Displays load vectors for each of the sets in self.setsToDispLoads
- Parameters
caption – text to display in the graphic. Defaults to ` None` in this case the text is the load case description and the units of the loads.
fileName – full name of the graphic file to generate. Defaults to ` None`, in this case it returns a console output graphic.,
defFScale – factor to apply to current displacement of nodes so that the display position of each node equals to the initial position plus its displacement multiplied by this factor. (Defaults to 0.0, i.e. display of initial/undeformed shape)
- displayReactionsOnSets(fileName=None, defFScale=0.0, inclInertia=False, reactionCheckTolerance=1e-07)¶
displays the reactions as vector on affected nodes
- Parameters
fileName – name of the file to plot the graphic. Defaults to None, in that case an screen display is generated
defFScale – factor to apply to current displacement of nodes so that the display position of each node equals to the initial position plus its displacement multiplied by this factor. (Defaults to 0.0, i.e. display of initial/undeformed shape)
inclInertia – include inertia effects (defaults to false).
reactionCheckTolerance – relative tolerance when checking reaction values.
- getDescription()¶
- getOutputHandler(setToDisplay)¶
Return an output handler from the set argument. NOT a very elegant solution-> to refactor.
- postprocess.reports.graphical_reports.getLabelText(caption)¶
Return the text to label the figures removing spaces and strange chars from the input.
- postprocess.reports.graphical_reports.getLoadCaseDispParametersFromLoadPattern(loadPattern, modelSpace=None, unitsScaleLoads=0.001, unitsScaleDispl=0.001, setsToDispLoads=None, setsToDispDspRot=None, setsToDispIntForc=None)¶
Matplotlib graphics of_material diagrams¶
- class postprocess.reports.graph_material.InteractionDiagram3DGraphic(intDiagram3D, axialForceScaleFactor=0.1, title='Interaction diagram.', fUnitConv=0.001, coloredBy=0)¶
Bases:
object
- show()¶
Show the 3D diagram in the screen.
- class postprocess.reports.graph_material.InteractionDiagramGraphic(title, xLabel='Mz [kN m]', yLabel='N [kN]')¶
Bases:
postprocess.reports.graph_material.MPLGraphic
Matplotlib grahic of a interaction diagram
- Variables
xLabel – label for the x axis.
yLabel – label for the y axis.
- setupGraphic(diag, internalForces=None)¶
Prepares the graphic of the interaction diagram.
- Parameters
diag – 2D polygon representing the contour of the interaction diagram.
internalForces – set of internal forces to be represented as dots over the interaction diagram.
- class postprocess.reports.graph_material.MPLGraphic(title)¶
Bases:
object
Base class for matplotlib graphics.
- Variables
fScale – graphics scale factor.
fig – matplotlib figure.
- close()¶
- getPathPolygon(plg)¶
Return a matplotlib Path from the given polygon.
- Parameters
plg – 2D polygon.
- savefig(fileName)¶
- show()¶
Reports of cable capacity¶
- postprocess.reports.list_cable_capacity.listTieStrength(preprocessor, setName, fName, titulo)¶
Prints the normal stresses check results in elastic domain for a set of elements that represent a tie.
- postprocess.reports.list_cable_capacity.printCabeceraListadoTirante(archivo, tit)¶
- postprocess.reports.list_cable_capacity.printCierreListadoTirante(archivo)¶
Reports of capacity_factor¶
- postprocess.reports.list_capacity_factor.listaCapacityFactor(preprocessor, setName, outputFile, title)¶
Print results of normal stresses in elastic range checking for an element set whose material is a steel shape.
- Parameters
preprocessor – XC preprocessor for the finite element problem.
setName – name of the set whose elements will be checked.
outputFile – output file.
title – listing title.
- postprocess.reports.list_capacity_factor.printCabeceraListadoCapacityFactor(outputFile, sectionName)¶
Print header for capacity factors listing.
- Parameters
outputFile – output file.
sectionName – name of the section being checked.
- postprocess.reports.list_capacity_factor.printCierreListadoCapacityFactor(outputFile)¶
Reports of cracking results¶
- postprocess.reports.list_cracking.printCabeceraListadoFisuracion(outputFile, sectionName, title)¶
Prints the header for crack width listings.
- Parameters
outputFile – output file.
sectionName – name of the section being checked.
title – title for the tabular data.
- postprocess.reports.list_cracking.printCierreListadoFisuracion(outputFile)¶
Closes the crack width listings.
- Parameters
outputFile – output file.
Lists of data for reports¶
- postprocess.reports.list_data.listBarElementSet(elements, fmt)¶
Returns a tabulate object containing the bar element data.
- Parameters
elements – iterable containing the elements.
fmt – format for coordinates.
- postprocess.reports.list_data.listElementSet(elements)¶
Returns a tabulate object containing the element data.
- Parameters
elements – iterable containing the elements.
- postprocess.reports.list_data.listKPtsSet(kPts, fmt)¶
Return a tabulate object containing the point data
- Parameters
kPts – iterable containing the points.
fmt – format for coordinates.
- postprocess.reports.list_data.listLineEntities(line, nmbProcLstElementos, fmt)¶
- Returs a dictionary with the tabulate objects containing
the nodes and elements of the line.
- Parameters
line – line to extract the nodes from.
nmbProcLstElementos – function to be used for the element list.
fmt – format for the node coordinates.
- postprocess.reports.list_data.listLineSet(lines)¶
Returns a tabulate object containing the line data.
- Parameters
lines – iterable containing the lines.
- postprocess.reports.list_data.listNodeSet(nodes, fmt)¶
Returns a tabulate object containing the node data.
- Parameters
nodes – iterable containing the nodes.
fmt – format for coordinates.
- postprocess.reports.list_data.listSet(xcSet, elementListFunction, fmt)¶
- Returs a dictionary with the tabulate objects containing
the set components.
- Parameters
xcSet – XC set.
elementListFunction – function to be used for the element list.
fmt – format for coordinates.
- postprocess.reports.list_data.listTrussElementSet(elements)¶
Returns a tabulate object containing the truss element data.
- Parameters
elements – iterable containing the elements.
Lists of displacements for reports¶
- class postprocess.reports.list_displacements.RecordListadoDesplazamientos¶
Bases:
object
- formato = '{:7.2f}'¶
- generaListadoDesplazamientos(nmbComb, outputFile)¶
Creates a displacements listing.
- Parameters
nmbComb – load combination.
outputFile – output file.
- listaCabeceras = []¶
- pointsLists = []¶
- sectionHeadingA = 'subsection'¶
- sectionHeadingB = 'subsubsection'¶
- title = 'Displacements'¶
- postprocess.reports.list_displacements.listNodeDisplacements(nmbComb, nodeList, fmt, outputFile, ltxSectioning, title)¶
Print the displacements of the nodes contained in the list argument.
- Parameters
nmbComb – name of the load combination.
nodeList – node list.
fmt – format for numbers.
outputFile – output file name.
ltxSectioning – latex sectioning command (chapter, section,…).
title – title.
- postprocess.reports.list_displacements.listNodeDisplacementsLineas(nmbComb, xcSet, fmt, outputFile, ltxSectioning, title)¶
- Print the displacements of the nodes belonging to the lines
contained in the argument set.
- Parameters
nmbComb – load combination.
xcSet – XC set containing the lines.
fmt – format string for the displacements.
outputFile – output file.
ltxSectioning – latex sectioning command (chapter, section,…).
title – section title.
- postprocess.reports.list_displacements.listNodeDisplacementsSET(nmbComb, xcSet, fmt, outputFile, ltxSectioning, title)¶
Lists the displacements of the nodes contained in the argument set.
- Parameters
nmbComb – load combination.
xcSet – XC set containing the nodes.
fmt – format string for the displacements.
outputFile – output file.
ltxSectioning – latex sectioning command (chapter, section,…).
title – section title.
- postprocess.reports.list_displacements.listNodeDisplacementsSet(nmbComb, xcSet, fmt, outputFile)¶
Prints the displacements of the nodes contained in the set argument.
- Parameters
nmbComb – name of the load combination.
xcSet – set containing the points points.
fmt – format for numbers.
outputFile – output file name.
ltxSectioning – latex sectioning command (chapter, section,…).
title – title.
- postprocess.reports.list_displacements.listPointsDisplacements(nmbComb, pointList, fmt, outputFile, ltxSectioning, title)¶
Writes a list of the displacements of the nodes associated to the points.
- Parameters
nmbComb – name of the combination for which the displacements were obtained.
pointList – list of points.
fmt – format for numbers.
outputFile – output file name.
ltxSectioning – latex sectioning command (chapter, section,…).
title – title.
Lists of internal forces for reports¶
- postprocess.reports.list_internal_forces.listBarSetInternalForces(nmbComb, xcSet, fmt, outputFile)¶
Print internal forces on the elements in the set argument.
- Parameters
nmbComb – name of the load combination.
xcSet – XC set containing the nodes.
fmt – format for numbers.
outputFile – output file name.
ltxSectioning – latex sectioning command (chapter, section,…).
title – title.
- postprocess.reports.list_internal_forces.listBarSetInternalForcesAndCF(nmbComb, xcSet, fmt, outputFile, nmbDiag)¶
- Print internal forces and capacity factor of the elements contained
in the argument set.
- Parameters
nmbComb – name of the load combination.
xcSet – XC set containing the nodes.
fmt – format for numbers.
outputFile – output file name.
ltxSectioning – latex sectioning command (chapter, section,…).
title – title.
- postprocess.reports.list_internal_forces.listLineSetInternalForces(nmbComb, xcSet, fmt, outputFile, ltxSectioning, title)¶
- Print internal forces on the elements of the lines in the
set argument.
- Parameters
nmbComb – name of the load combination.
xcSet – XC set containing the nodes.
fmt – format for numbers.
outputFile – output file name.
ltxSectioning – latex sectioning command (chapter, section,…).
title – title.
- postprocess.reports.list_internal_forces.listLineSetInternalForcesAndCF(nmbComb, xcSet, fmt, outputFile, ltxSectioning, title, nmbDiag)¶
- Print internal forces and capacity factor of the elements contained
in the lines of the argument set.
- Parameters
nmbComb – name of the load combination.
xcSet – XC set containing the nodes.
fmt – format for numbers.
outputFile – output file name.
ltxSectioning – latex sectioning command (chapter, section,…).
title – title.
nmbDiag – name of the interaction diagram.
- postprocess.reports.list_internal_forces.listaDatosEsfuerzosTrussSet(nmbComb, xcSet, fmt, outputFile)¶
Print internal forces on the truss elements in the set argument.
- Parameters
nmbComb – name of the load combination.
xcSet – XC set containing the nodes.
fmt – format for numbers.
outputFile – output file name.
- postprocess.reports.list_internal_forces.listaEsfuerzosElasticBeam3dSet(nmbComb, xcSet, fmt, outputFile)¶
- Print internal forces on the truss elements of the lines in the
set argument.
- Parameters
nmbComb – name of the load combination.
xcSet – XC set containing the nodes.
fmt – format for numbers.
outputFile – output file name.
- postprocess.reports.list_internal_forces.listaEsfuerzosTrussLineas(nmbComb, xcSet, fmt, outputFile, ltxSectioning, title)¶
- Print internal forces on the truss elements of the lines in the
set argument.
- Parameters
nmbComb – name of the load combination.
xcSet – XC set containing the nodes.
fmt – format for numbers.
outputFile – output file name.
ltxSectioning – latex sectioning command (chapter, section,…).
title – title.
- postprocess.reports.list_internal_forces.listaEsfuerzosTrussSet(nmbComb, xcSet, fmt, outputFile, ltxSectioning, title)¶
Print internal forces on the truss elements in the set argument.
- Parameters
nmbComb – name of the load combination.
xcSet – XC set containing the nodes.
fmt – format for numbers.
outputFile – output file name.
ltxSectioning – latex sectioning command (chapter, section,…).
title – title.
- postprocess.reports.list_internal_forces.listaEsfuerzosZeroLengthSet(nmbComb, xcSet, fmt, outputFile, ltxSectioning, title)¶
- Print internal forces on the zero length elements in the
set argument.
- Parameters
nmbComb – name of the load combination.
xcSet – XC set containing the nodes.
fmt – format for numbers.
outputFile – output file name.
ltxSectioning – latex sectioning command (chapter, section,…).
title – title.
Lists of loads for reports¶
Create load lists in LaTeX.
- postprocess.reports.list_loads.ElementLoadList(loadPattern, outputFile, fmt)¶
List loads on elements.
- Parameters
loadPattern – load pattern.
outputFile – output file name.
fmt – format for numbers.
- postprocess.reports.list_loads.listNodalLoads(loadPattern, outputFile, fmt)¶
List loads on nodes.
- Parameters
loadPattern – load pattern.
outputFile – output file name.
fmt – format for numbers.
- postprocess.reports.list_loads.punctualLoadList(loadPattern, outputFile, load, fmt)¶
List of punctual loads.
- Parameters
loadPattern – load pattern.
outputFile – output file name.
load – load vector.
fmt – format for numbers.
- postprocess.reports.list_loads.uniformLoadList(loadPattern, outputFile, load, fmt)¶
List of uniform loads.
- Parameters
loadPattern – load pattern.
outputFile – output file name.
fmt – format for numbers.
Lists displacements maximum and minimum for reports¶
- postprocess.reports.list_max_min_displacements.listNodeUMaxUMin(preprocessor, setName, tit, fmt, fName)¶
Print the extrema of the displacements of the nodes set which name is being passed as parameter.
- postprocess.reports.list_max_min_displacements.listNodeVMaxVMin(xcSet, tit, fmt, outputFile)¶
Print the extrema of the displacements of the nodes set which name is being passed as parameter.
- Parameters
xcSet – set containing the nodes to list.
tit – caption for the table.
fmt – format for the displacement values.
outputFile – output file.
- postprocess.reports.list_max_min_displacements.listNodeWMaxWMin(xcSet, tit, fmt, outputFile)¶
Print displacement extrema of the nodes set which name is being passed as parameter.
- Parameters
xcSet – set containing the nodes to list.
tit – caption for the table.
fmt – format for the displacement values.
outputFile – output file.
Lists of metal-profile capacity for reports¶
- postprocess.reports.list_metal_profiles_capacity.listSteelShapeTNStrengthElasticRange(xcSet, fName, titulo)¶
Print the results of normal stresses checking in an element set whose material is a steel shape.
- postprocess.reports.list_metal_profiles_capacity.listSteelShapeVStrength(xcSet, fName, titulo)¶
Print the results of shear stress checking in an element set whose material is a steel shape.
- postprocess.reports.list_metal_profiles_capacity.printTNListingEndSteelShape(archivo)¶
Closes the listing.
- postprocess.reports.list_metal_profiles_capacity.printTNListingHeaderSteelShape(archivo, tit)¶
Open the normal stresses listing.
- postprocess.reports.list_metal_profiles_capacity.printVListingHeaderSteelShape(archivo, tit)¶
Open the shear listing.
Lists of axial and shear internal forces in beams for reports¶
- postprocess.reports.list_N_V_beams.listBarNormalStressesLaTeX(nmbDBase, nmbTabla, nmbArchivoListadoTex)¶
Result of normal stresses in linear elements to include in a LaTeX file.
- postprocess.reports.list_N_V_beams.listaBarShearLaTeX(nmbDBase, nmbTabla, nmbArchivoListadoTex)¶
Shear check results in linear elements to include in a LaTeX file.
Lists of reactions for reports¶
Generation of reactions repports.
- class postprocess.reports.list_reactions.ReactionsListRecord¶
Bases:
object
- formato = '{:7.2f}'¶
- listaCabeceras = []¶
- nodeLists = []¶
- sectionHeadingA = 'subsection'¶
- sectionHeadingB = 'subsubsection'¶
- titulo = 'Reactions'¶
- write(preprocessor, nmbComb, outputFile)¶
- postprocess.reports.list_reactions.listNodeReactions(preprocessor, nmbComb, nodeList, fmt, outputFile, ltxSectioning, title, inclInertia=False)¶
Prints reactions for each of the nodes from the list.
- Parameters
preprocessor – XC preprocessor for the finite element problem.
nmbComb – name of the load combination.
nodeList – node list.
fmt – format for numbers.
outputFile – output file name.
ltxSectioning – latex sectioning command (chapter, section,…).
title – title.
inclInertia – include inertia effects (defaults to false).
- postprocess.reports.list_reactions.listPointReactions(preprocessor, nmbComb, pointList, fmt, outputFile, ltxSectioning, title, inclInertia=False)¶
- Print the reactions associated with the nodes associated to the
points from the list.
- Parameters
preprocessor – XC preprocessor for the finite element problem.
nmbComb – name of the load combination.
pointList – point list.
fmt – format for numbers.
outputFile – output file name.
ltxSectioning – latex sectioning command (chapter, section,…).
title – title.
inclInertia – include inertia effects (defaults to false).
- postprocess.reports.list_reactions.listPointReactionsCSV(preprocessor, nmbComb, pointList, fmt, outputFile, inclInertia=False)¶
Prints the reactions in CSV (comma separated values) format.
- Parameters
preprocessor – XC preprocessor for the finite element problem.
nmbComb – name of the load combination.
pointList – point list.
fmt – format for numbers.
outputFile – output file name.
ltxSectioning – latex sectioning command (chapter, section,…).
title – title.
inclInertia – include inertia effects (defaults to false).
Lists of shear internal forces for reports¶
- postprocess.reports.list_shear.printShearVerificationListingFoot(outputFile)¶
Print the shear verification listing foot.
- postprocess.reports.list_shear.printShearVerificationListingHeader(outputFile, sectionName, title)¶
Prints the header of the shear verification listing.
- Parameters
outputFile – output file.
sectionName – name of the section being checked.
title – title for the tabular data.
Reports of material properties¶
- class postprocess.reports.report_material.ConcreteReport(concrDiag)¶
Bases:
object
Constructs LaTex tables for depicting porperties of concrete materials.
- Variables
concrDiag – concrete material (of type concrete01 or concrete02)
- tableCompress()¶
returns a LaTeX table that depicts the concrete compressive properties.
- tableTens()¶
returns a LaTeX table that depicts the concrete tensile properties.
- tableTensStiff(paramTensStiffness)¶
- returns a LaTeX table that depicts the concrete tension
stiffening properties (concrete of type concrete02).
- Parameters
paramTensStiffness – instance of the object concrete_base.paramTensStiffness that defines the parameters of tension stiffness
- postprocess.reports.report_material.report_concrete02(concrDiag, paramTensStiffening, grTitle, grFileName, texFileName)¶
return a LaTeX table that depicts the concrete compressive, tensile and tension-stiffening properties as well as its stress-strain graphic.
- Parameters
concrDiag – concrete material of type concrete02
paramTensStiffening – instance of the object concrete_base.paramTensStiffness that defines the parameters of tension stiffness.
grTitle – title for the graphic
grFileName – name of the graphics file
texFileName – name of the LaTeX file