gmsh-TingyuanDoc  0.1
An Open-Source Timing-driven Analytical Mixed-size FPGA Placer
contextMeshOptions Struct Reference

#include <Context.h>

Public Attributes

int optimize
 
int optimizeNetgen
 
int refineSteps
 
int smoothCrossField
 
int crossFieldClosestPoint
 
double lcFactor
 
double randFactor
 
double randFactor3d
 
double lcIntegrationPrecision
 
double optimizeThreshold
 
double normals
 
double tangents
 
double explode
 
double angleSmoothNormals
 
double allowSwapEdgeAngle
 
double qualityInf
 
double qualitySup
 
double radiusInf
 
double radiusSup
 
double lcMin
 
double lcMax
 
double toleranceEdgeLength
 
double toleranceInitialDelaunay
 
double anisoMax
 
double smoothRatio
 
int lcFromPoints
 
int lcFromParametricPoints
 
int lcFromCurvature
 
int lcFromCurvatureIso
 
int lcExtendFromBoundary
 
int nbSmoothing
 
int algo2d
 
int algo3d
 
int algoSubdivide
 
int algoSwitchOnFailure
 
int algoRecombine
 
int recombineAll
 
int recombineOptimizeTopology
 
int recombineNodeRepositioning
 
double recombineMinimumQuality
 
int recombine3DAll
 
int recombine3DLevel
 
int recombine3DConformity
 
int flexibleTransfinite
 
int transfiniteTri
 
int maxRetries
 
int order
 
int secondOrderLinear
 
int secondOrderIncomplete
 
int meshOnlyVisible
 
int meshOnlyEmpty
 
int minCircleNodes
 
int minCurveNodes
 
int minLineNodes
 
int hoOptimize
 
int hoPeriodic
 
int hoNLayers
 
int hoPrimSurfMesh
 
int hoIterMax
 
int hoPassMax
 
int hoDistCAD
 
int hoSavePeriodic
 
int hoFixBndNodes
 
double hoThresholdMin
 
double hoThresholdMax
 
double hoPoissonRatio
 
bool hoNewFastCurvingAlgo
 
int hoCurveOuterBL
 
double hoMaxRho
 
double hoMaxAngle
 
double hoMaxInnerAngle
 
int NewtonConvergenceTestXYZ
 
int maxIterDelaunay3D
 
int ignorePeriodicityMsh2
 
int ignoreParametrizationMsh4
 
int boundaryLayerFanElements
 
int maxNumThreads1D
 
int maxNumThreads2D
 
int maxNumThreads3D
 
double angleToleranceFacetOverlap
 
double toleranceReferenceElement
 
int renumber
 
int compoundClassify
 
int reparamMaxTriangles
 
double compoundLcFactor
 
unsigned int randomSeed
 
int nLayersPerGap
 
double gradation
 
int quadqsSizemapMethod
 
int quadqsTopoOptimMethods
 
double quadqsRemeshingBoldness
 
double quadqsScalingOnTriangulation
 
int oldInitialDelaunay2D
 
int fileFormat
 
int firstElementTag
 
int firstNodeTag
 
double mshFileVersion
 
double medFileMinorVersion
 
double scalingFactor
 
int medImportGroupsOfNodes
 
int medSingleModel
 
int saveAll
 
int saveTri
 
int saveGroupsOfNodes
 
int saveGroupsOfElements
 
int readGroupsOfElements
 
int binary
 
int bdfFieldFormat
 
int unvStrictFormat
 
int stlRemoveDuplicateTriangles
 
int stlOneSolidPerSurface
 
double stlLinearDeflection
 
double stlAngularDeflection
 
bool stlLinearDeflectionRelative
 
int saveParametric
 
int saveTopology
 
int saveWithoutOrphans
 
int zoneDefinition
 
int saveElementTagType
 
int switchElementTags
 
int cgnsImportIgnoreBC
 
int cgnsImportIgnoreSolution
 
int cgnsImportOrder
 
int cgnsConstructTopology
 
int cgnsExportCPEX0045
 
int cgnsExportStructured
 
int preserveNumberingMsh2
 
int createTopologyMsh2
 
int numPartitions
 
int partitionCreateTopology
 
int partitionCreateGhostCells
 
int partitionCreatePhysicals
 
int partitionSplitMeshFiles
 
int partitionSaveTopologyFile
 
int partitionTriWeight
 
int partitionQuaWeight
 
int partitionTetWeight
 
int partitionHexWeight
 
int partitionLinWeight
 
int partitionPriWeight
 
int partitionPyrWeight
 
int partitionTrihWeight
 
int partitionOldStyleMsh2
 
int partitionConvertMsh2
 
int metisAlgorithm
 
int metisEdgeMatching
 
int metisRefinementAlgorithm
 
int metisObjective
 
int metisMinConn
 
double metisMaxLoadImbalance
 
int draw
 
int changed
 
int light
 
int lightTwoSide
 
int lightLines
 
int nodeType
 
int nodes
 
int lines
 
int triangles
 
int quadrangles
 
int tetrahedra
 
int hexahedra
 
int prisms
 
int pyramids
 
int trihedra
 
int surfaceEdges
 
int surfaceFaces
 
int volumeEdges
 
int volumeFaces
 
int numSubEdges
 
int nodeLabels
 
int lineLabels
 
int surfaceLabels
 
int volumeLabels
 
int qualityType
 
int labelType
 
double nodeSize
 
double lineWidth
 
int dual
 
int voronoi
 
int drawSkinOnly
 
int colorCarousel
 
int labelSampling
 
int smoothNormals
 
int clip
 

Detailed Description

Definition at line 17 of file Context.h.

Member Data Documentation

◆ algo2d

◆ algo3d

int contextMeshOptions::algo3d

Definition at line 29 of file Context.h.

Referenced by GenerateMesh(), CTX::init(), MeshDelaunayVolume(), and opt_mesh_algo3d().

◆ algoRecombine

◆ algoSubdivide

int contextMeshOptions::algoSubdivide

Definition at line 29 of file Context.h.

Referenced by GenerateMesh(), CTX::init(), and opt_mesh_algo_subdivide().

◆ algoSwitchOnFailure

int contextMeshOptions::algoSwitchOnFailure

Definition at line 29 of file Context.h.

Referenced by opt_mesh_algo_switch_on_failure().

◆ allowSwapEdgeAngle

double contextMeshOptions::allowSwapEdgeAngle

Definition at line 23 of file Context.h.

Referenced by opt_mesh_allow_swap_edge_angle().

◆ angleSmoothNormals

double contextMeshOptions::angleSmoothNormals

Definition at line 22 of file Context.h.

Referenced by CTX::init(), and opt_mesh_angle_smooth_normals().

◆ angleToleranceFacetOverlap

double contextMeshOptions::angleToleranceFacetOverlap

Definition at line 47 of file Context.h.

Referenced by opt_mesh_angle_tolerance_facet_overlap().

◆ anisoMax

double contextMeshOptions::anisoMax

Definition at line 26 of file Context.h.

Referenced by opt_mesh_aniso_max().

◆ bdfFieldFormat

int contextMeshOptions::bdfFieldFormat

Definition at line 62 of file Context.h.

Referenced by opt_mesh_bdf_field_format().

◆ binary

int contextMeshOptions::binary

Definition at line 62 of file Context.h.

Referenced by CreateOutputFile(), opt_mesh_binary(), and PView::write().

◆ boundaryLayerFanElements

int contextMeshOptions::boundaryLayerFanElements

Definition at line 45 of file Context.h.

Referenced by BoundaryLayerField::fanSize(), and opt_mesh_boundary_layer_fan_elements().

◆ cgnsConstructTopology

int contextMeshOptions::cgnsConstructTopology

Definition at line 69 of file Context.h.

Referenced by opt_mesh_cgns_construct_topology().

◆ cgnsExportCPEX0045

int contextMeshOptions::cgnsExportCPEX0045

Definition at line 69 of file Context.h.

Referenced by opt_mesh_cgns_export_cpex0045().

◆ cgnsExportStructured

int contextMeshOptions::cgnsExportStructured

Definition at line 69 of file Context.h.

Referenced by CreateOutputFile(), and opt_mesh_cgns_export_structured().

◆ cgnsImportIgnoreBC

int contextMeshOptions::cgnsImportIgnoreBC

Definition at line 68 of file Context.h.

Referenced by opt_mesh_cgns_import_ignore_bc().

◆ cgnsImportIgnoreSolution

int contextMeshOptions::cgnsImportIgnoreSolution

Definition at line 68 of file Context.h.

Referenced by opt_mesh_cgns_import_ignore_solution().

◆ cgnsImportOrder

int contextMeshOptions::cgnsImportOrder

Definition at line 68 of file Context.h.

Referenced by opt_mesh_cgns_import_order().

◆ changed

◆ clip

int contextMeshOptions::clip

Definition at line 89 of file Context.h.

Referenced by drawContext::drawAxes(), and opt_mesh_clip().

◆ colorCarousel

◆ compoundClassify

int contextMeshOptions::compoundClassify

Definition at line 48 of file Context.h.

Referenced by opt_mesh_compound_classify().

◆ compoundLcFactor

double contextMeshOptions::compoundLcFactor

Definition at line 49 of file Context.h.

Referenced by GEdge::mesh(), GFace::mesh(), and opt_mesh_compound_lc_factor().

◆ createTopologyMsh2

int contextMeshOptions::createTopologyMsh2

Definition at line 70 of file Context.h.

Referenced by opt_mesh_create_topology_msh2().

◆ crossFieldClosestPoint

int contextMeshOptions::crossFieldClosestPoint

Definition at line 20 of file Context.h.

Referenced by opt_mesh_cross_field_closest_point().

◆ draw

int contextMeshOptions::draw

Definition at line 82 of file Context.h.

Referenced by CTX::init(), and GMSH_Plugin::setDrawFunction().

◆ drawSkinOnly

int contextMeshOptions::drawSkinOnly

Definition at line 88 of file Context.h.

Referenced by addElementsInArrays(), and opt_mesh_draw_skin_only().

◆ dual

int contextMeshOptions::dual

Definition at line 88 of file Context.h.

Referenced by opt_mesh_dual().

◆ explode

double contextMeshOptions::explode

◆ fileFormat

int contextMeshOptions::fileFormat

Definition at line 57 of file Context.h.

Referenced by opt_mesh_file_format().

◆ firstElementTag

int contextMeshOptions::firstElementTag

◆ firstNodeTag

int contextMeshOptions::firstNodeTag

◆ flexibleTransfinite

int contextMeshOptions::flexibleTransfinite

Definition at line 34 of file Context.h.

Referenced by filterPoints(), meshGEdgeProcessing(), and opt_mesh_flexible_transfinite().

◆ gradation

double contextMeshOptions::gradation

Definition at line 52 of file Context.h.

Referenced by GetMeshOption().

◆ hexahedra

int contextMeshOptions::hexahedra

Definition at line 83 of file Context.h.

Referenced by CTX::init(), initMeshGRegion::operator()(), and opt_mesh_hexahedra().

◆ hoCurveOuterBL

int contextMeshOptions::hoCurveOuterBL

Definition at line 42 of file Context.h.

Referenced by opt_mesh_ho_curve_outer_BL(), and OptimizeMesh().

◆ hoDistCAD

int contextMeshOptions::hoDistCAD

Definition at line 39 of file Context.h.

Referenced by opt_mesh_ho_dist_cad(), and OptimizeMesh().

◆ hoFixBndNodes

int contextMeshOptions::hoFixBndNodes

Definition at line 39 of file Context.h.

Referenced by opt_mesh_ho_fix_bnd_nodes(), and OptimizeMesh().

◆ hoIterMax

int contextMeshOptions::hoIterMax

Definition at line 38 of file Context.h.

Referenced by opt_mesh_ho_iter_max(), and OptimizeMesh().

◆ hoMaxAngle

double contextMeshOptions::hoMaxAngle

Definition at line 43 of file Context.h.

Referenced by opt_mesh_ho_max_angle(), and OptimizeMesh().

◆ hoMaxInnerAngle

double contextMeshOptions::hoMaxInnerAngle

Definition at line 43 of file Context.h.

Referenced by opt_mesh_ho_max_in_angle(), and OptimizeMesh().

◆ hoMaxRho

double contextMeshOptions::hoMaxRho

Definition at line 43 of file Context.h.

Referenced by opt_mesh_ho_max_rho(), and OptimizeMesh().

◆ hoNewFastCurvingAlgo

bool contextMeshOptions::hoNewFastCurvingAlgo

Definition at line 41 of file Context.h.

Referenced by opt_mesh_ho_fast_new_algo().

◆ hoNLayers

int contextMeshOptions::hoNLayers

Definition at line 38 of file Context.h.

Referenced by opt_mesh_ho_nlayers(), and OptimizeMesh().

◆ hoOptimize

int contextMeshOptions::hoOptimize

Definition at line 38 of file Context.h.

Referenced by GenerateMesh(), CTX::init(), opt_mesh_ho_optimize(), and RefineMesh().

◆ hoPassMax

int contextMeshOptions::hoPassMax

Definition at line 38 of file Context.h.

Referenced by opt_mesh_ho_pass_max(), and OptimizeMesh().

◆ hoPeriodic

int contextMeshOptions::hoPeriodic

Definition at line 38 of file Context.h.

Referenced by opt_mesh_ho_periodic().

◆ hoPoissonRatio

double contextMeshOptions::hoPoissonRatio

Definition at line 40 of file Context.h.

Referenced by opt_mesh_ho_poisson().

◆ hoPrimSurfMesh

int contextMeshOptions::hoPrimSurfMesh

Definition at line 38 of file Context.h.

Referenced by opt_mesh_ho_prim_surf_mesh(), and OptimizeMesh().

◆ hoSavePeriodic

int contextMeshOptions::hoSavePeriodic

Definition at line 39 of file Context.h.

Referenced by opt_mesh_ho_save_periodic().

◆ hoThresholdMax

double contextMeshOptions::hoThresholdMax

Definition at line 40 of file Context.h.

Referenced by opt_mesh_ho_threshold_max(), and OptimizeMesh().

◆ hoThresholdMin

double contextMeshOptions::hoThresholdMin

Definition at line 40 of file Context.h.

Referenced by opt_mesh_ho_threshold_min(), and OptimizeMesh().

◆ ignoreParametrizationMsh4

int contextMeshOptions::ignoreParametrizationMsh4

Definition at line 45 of file Context.h.

Referenced by opt_mesh_ignore_parametrization().

◆ ignorePeriodicityMsh2

int contextMeshOptions::ignorePeriodicityMsh2

Definition at line 45 of file Context.h.

Referenced by opt_mesh_ignore_periodicity().

◆ labelSampling

int contextMeshOptions::labelSampling

Definition at line 88 of file Context.h.

Referenced by drawElementLabels(), drawVerticesPerEntity(), and opt_mesh_label_sampling().

◆ labelType

int contextMeshOptions::labelType

Definition at line 86 of file Context.h.

Referenced by opt_mesh_label_type().

◆ lcExtendFromBoundary

int contextMeshOptions::lcExtendFromBoundary

◆ lcFactor

◆ lcFromCurvature

◆ lcFromCurvatureIso

int contextMeshOptions::lcFromCurvatureIso

Definition at line 27 of file Context.h.

Referenced by LC_MVertex_CURV_ANISO(), and opt_mesh_lc_from_curvature_iso().

◆ lcFromParametricPoints

int contextMeshOptions::lcFromParametricPoints

Definition at line 27 of file Context.h.

Referenced by CTX::init(), and opt_mesh_lc_from_parametric_points().

◆ lcFromPoints

int contextMeshOptions::lcFromPoints

◆ lcIntegrationPrecision

double contextMeshOptions::lcIntegrationPrecision

Definition at line 21 of file Context.h.

Referenced by CTX::init(), and opt_mesh_lc_integration_precision().

◆ lcMax

◆ lcMin

double contextMeshOptions::lcMin

◆ light

◆ lightLines

int contextMeshOptions::lightLines

◆ lightTwoSide

int contextMeshOptions::lightTwoSide

Definition at line 82 of file Context.h.

Referenced by opt_mesh_light_two_side().

◆ lineLabels

int contextMeshOptions::lineLabels

Definition at line 86 of file Context.h.

Referenced by opt_mesh_line_labels().

◆ lines

int contextMeshOptions::lines

Definition at line 83 of file Context.h.

Referenced by CTX::init(), initMeshGEdge::operator()(), and opt_mesh_lines().

◆ lineWidth

double contextMeshOptions::lineWidth

Definition at line 87 of file Context.h.

Referenced by opt_mesh_line_width().

◆ maxIterDelaunay3D

int contextMeshOptions::maxIterDelaunay3D

Definition at line 44 of file Context.h.

Referenced by opt_mesh_max_iter_delaunay_3d().

◆ maxNumThreads1D

int contextMeshOptions::maxNumThreads1D

Definition at line 46 of file Context.h.

Referenced by Mesh1D(), and opt_mesh_max_num_threads_1d().

◆ maxNumThreads2D

int contextMeshOptions::maxNumThreads2D

Definition at line 46 of file Context.h.

Referenced by Mesh2D(), and opt_mesh_max_num_threads_2d().

◆ maxNumThreads3D

int contextMeshOptions::maxNumThreads3D

Definition at line 46 of file Context.h.

Referenced by opt_mesh_max_num_threads_3d().

◆ maxRetries

int contextMeshOptions::maxRetries

Definition at line 34 of file Context.h.

Referenced by opt_mesh_max_retries().

◆ medFileMinorVersion

double contextMeshOptions::medFileMinorVersion

Definition at line 58 of file Context.h.

Referenced by opt_mesh_med_file_minor_version().

◆ medImportGroupsOfNodes

int contextMeshOptions::medImportGroupsOfNodes

Definition at line 59 of file Context.h.

Referenced by opt_mesh_med_import_groups_of_nodes().

◆ medSingleModel

int contextMeshOptions::medSingleModel

Definition at line 59 of file Context.h.

Referenced by opt_mesh_med_single_model().

◆ meshOnlyEmpty

int contextMeshOptions::meshOnlyEmpty

Definition at line 36 of file Context.h.

Referenced by opt_mesh_mesh_only_empty().

◆ meshOnlyVisible

int contextMeshOptions::meshOnlyVisible

◆ metisAlgorithm

int contextMeshOptions::metisAlgorithm

Definition at line 78 of file Context.h.

Referenced by opt_mesh_partition_metis_algorithm(), and opt_mesh_partition_num().

◆ metisEdgeMatching

int contextMeshOptions::metisEdgeMatching

Definition at line 78 of file Context.h.

Referenced by opt_mesh_partition_metis_edge_matching().

◆ metisMaxLoadImbalance

double contextMeshOptions::metisMaxLoadImbalance

Definition at line 80 of file Context.h.

Referenced by opt_mesh_partition_metis_max_load_imbalance().

◆ metisMinConn

int contextMeshOptions::metisMinConn

Definition at line 79 of file Context.h.

Referenced by opt_mesh_partition_metis_min_conn().

◆ metisObjective

int contextMeshOptions::metisObjective

Definition at line 79 of file Context.h.

Referenced by opt_mesh_partition_metis_objective().

◆ metisRefinementAlgorithm

int contextMeshOptions::metisRefinementAlgorithm

Definition at line 78 of file Context.h.

Referenced by opt_mesh_partition_metis_refinement_algorithm().

◆ minCircleNodes

int contextMeshOptions::minCircleNodes

◆ minCurveNodes

int contextMeshOptions::minCurveNodes

◆ minLineNodes

int contextMeshOptions::minLineNodes

Definition at line 37 of file Context.h.

Referenced by gmshEdge::minimumMeshSegments(), and opt_mesh_min_line_nodes().

◆ mshFileVersion

double contextMeshOptions::mshFileVersion

Definition at line 58 of file Context.h.

Referenced by CreateOutputFile(), and opt_mesh_msh_file_version().

◆ nbSmoothing

int contextMeshOptions::nbSmoothing

Definition at line 29 of file Context.h.

Referenced by insertVerticesInRegion(), MeshTransfiniteSurface(), and opt_mesh_nb_smoothing().

◆ NewtonConvergenceTestXYZ

int contextMeshOptions::NewtonConvergenceTestXYZ

Definition at line 44 of file Context.h.

Referenced by opt_mesh_newton_convergence_test_xyz(), and GFace::XYZtoUV().

◆ nLayersPerGap

int contextMeshOptions::nLayersPerGap

Definition at line 51 of file Context.h.

Referenced by GetMeshOption().

◆ nodeLabels

◆ nodes

int contextMeshOptions::nodes

Definition at line 83 of file Context.h.

Referenced by opt_mesh_nodes().

◆ nodeSize

double contextMeshOptions::nodeSize

Definition at line 87 of file Context.h.

Referenced by drawVertexLabel(), and opt_mesh_node_size().

◆ nodeType

int contextMeshOptions::nodeType

Definition at line 82 of file Context.h.

Referenced by opt_mesh_node_type().

◆ normals

double contextMeshOptions::normals

Definition at line 22 of file Context.h.

Referenced by drawNormals(), opt_mesh_color_normals(), and opt_mesh_normals().

◆ numPartitions

int contextMeshOptions::numPartitions

Definition at line 72 of file Context.h.

Referenced by opt_mesh_partition_num().

◆ numSubEdges

◆ oldInitialDelaunay2D

int contextMeshOptions::oldInitialDelaunay2D

Definition at line 55 of file Context.h.

Referenced by opt_mesh_old_initial_delaunay_2d().

◆ optimize

int contextMeshOptions::optimize

Definition at line 19 of file Context.h.

Referenced by GenerateMesh(), CTX::init(), and opt_mesh_optimize().

◆ optimizeNetgen

int contextMeshOptions::optimizeNetgen

Definition at line 19 of file Context.h.

Referenced by GenerateMesh(), CTX::init(), and opt_mesh_optimize_netgen().

◆ optimizeThreshold

double contextMeshOptions::optimizeThreshold

Definition at line 22 of file Context.h.

Referenced by opt_mesh_optimize_threshold(), and optimizeMesh().

◆ order

int contextMeshOptions::order

Definition at line 35 of file Context.h.

Referenced by GenerateMesh(), CTX::init(), opt_mesh_order(), and GModel::writeMESH().

◆ partitionConvertMsh2

int contextMeshOptions::partitionConvertMsh2

Definition at line 77 of file Context.h.

Referenced by opt_mesh_partition_convert_msh2().

◆ partitionCreateGhostCells

int contextMeshOptions::partitionCreateGhostCells

Definition at line 72 of file Context.h.

Referenced by opt_mesh_partition_create_ghost_cells().

◆ partitionCreatePhysicals

int contextMeshOptions::partitionCreatePhysicals

Definition at line 73 of file Context.h.

Referenced by opt_mesh_partition_create_physicals().

◆ partitionCreateTopology

int contextMeshOptions::partitionCreateTopology

Definition at line 72 of file Context.h.

Referenced by opt_mesh_partition_create_topology().

◆ partitionHexWeight

int contextMeshOptions::partitionHexWeight

Definition at line 75 of file Context.h.

Referenced by opt_mesh_partition_hex_weight().

◆ partitionLinWeight

int contextMeshOptions::partitionLinWeight

Definition at line 75 of file Context.h.

Referenced by opt_mesh_partition_line_weight().

◆ partitionOldStyleMsh2

int contextMeshOptions::partitionOldStyleMsh2

Definition at line 77 of file Context.h.

Referenced by opt_mesh_partition_old_style_msh2().

◆ partitionPriWeight

int contextMeshOptions::partitionPriWeight

Definition at line 76 of file Context.h.

Referenced by opt_mesh_partition_pri_weight().

◆ partitionPyrWeight

int contextMeshOptions::partitionPyrWeight

Definition at line 76 of file Context.h.

Referenced by opt_mesh_partition_pyr_weight().

◆ partitionQuaWeight

int contextMeshOptions::partitionQuaWeight

Definition at line 74 of file Context.h.

Referenced by opt_mesh_partition_qua_weight().

◆ partitionSaveTopologyFile

int contextMeshOptions::partitionSaveTopologyFile

Definition at line 74 of file Context.h.

Referenced by opt_mesh_partition_save_topology_file().

◆ partitionSplitMeshFiles

int contextMeshOptions::partitionSplitMeshFiles

Definition at line 73 of file Context.h.

Referenced by opt_mesh_partition_split_mesh_files().

◆ partitionTetWeight

int contextMeshOptions::partitionTetWeight

Definition at line 75 of file Context.h.

Referenced by opt_mesh_partition_tet_weight().

◆ partitionTrihWeight

int contextMeshOptions::partitionTrihWeight

Definition at line 76 of file Context.h.

Referenced by opt_mesh_partition_trih_weight().

◆ partitionTriWeight

int contextMeshOptions::partitionTriWeight

Definition at line 74 of file Context.h.

Referenced by opt_mesh_partition_tri_weight().

◆ preserveNumberingMsh2

int contextMeshOptions::preserveNumberingMsh2

Definition at line 70 of file Context.h.

Referenced by opt_mesh_preserve_numbering_msh2().

◆ prisms

int contextMeshOptions::prisms

Definition at line 83 of file Context.h.

Referenced by CTX::init(), initMeshGRegion::operator()(), and opt_mesh_prisms().

◆ pyramids

int contextMeshOptions::pyramids

Definition at line 84 of file Context.h.

Referenced by CTX::init(), initMeshGRegion::operator()(), and opt_mesh_pyramids().

◆ quadqsRemeshingBoldness

double contextMeshOptions::quadqsRemeshingBoldness

Definition at line 54 of file Context.h.

Referenced by opt_mesh_quadqs_remeshing_boldness().

◆ quadqsScalingOnTriangulation

double contextMeshOptions::quadqsScalingOnTriangulation

Definition at line 54 of file Context.h.

Referenced by opt_mesh_quadqs_scaling_on_triangulation().

◆ quadqsSizemapMethod

int contextMeshOptions::quadqsSizemapMethod

Definition at line 53 of file Context.h.

Referenced by opt_mesh_quadqs_sizemap_method().

◆ quadqsTopoOptimMethods

int contextMeshOptions::quadqsTopoOptimMethods

Definition at line 53 of file Context.h.

Referenced by opt_mesh_quadqs_topo_optim_methods().

◆ quadrangles

int contextMeshOptions::quadrangles

Definition at line 83 of file Context.h.

Referenced by CTX::init(), initMeshGFace::operator()(), and opt_mesh_quadrangles().

◆ qualityInf

double contextMeshOptions::qualityInf

Definition at line 24 of file Context.h.

Referenced by CTX::init(), and opt_mesh_quality_inf().

◆ qualitySup

double contextMeshOptions::qualitySup

Definition at line 24 of file Context.h.

Referenced by CTX::init(), isElementVisible(), and opt_mesh_quality_sup().

◆ qualityType

int contextMeshOptions::qualityType

Definition at line 86 of file Context.h.

Referenced by CTX::init(), and opt_mesh_quality_type().

◆ radiusInf

double contextMeshOptions::radiusInf

Definition at line 24 of file Context.h.

Referenced by CTX::init(), and opt_mesh_radius_inf().

◆ radiusSup

double contextMeshOptions::radiusSup

Definition at line 24 of file Context.h.

Referenced by CTX::init(), isElementVisible(), and opt_mesh_radius_sup().

◆ randFactor

double contextMeshOptions::randFactor

Definition at line 21 of file Context.h.

Referenced by CTX::init(), meshGenerator(), meshGeneratorPeriodic(), and opt_mesh_rand_factor().

◆ randFactor3d

double contextMeshOptions::randFactor3d

Definition at line 21 of file Context.h.

Referenced by delaunayTriangulation(), and opt_mesh_rand_factor3d().

◆ randomSeed

unsigned int contextMeshOptions::randomSeed

Definition at line 50 of file Context.h.

Referenced by opt_mesh_random_seed().

◆ readGroupsOfElements

int contextMeshOptions::readGroupsOfElements

Definition at line 61 of file Context.h.

Referenced by opt_mesh_read_groups_of_elements().

◆ recombine3DAll

int contextMeshOptions::recombine3DAll

Definition at line 33 of file Context.h.

Referenced by CTX::init(), Mesh3D(), and opt_mesh_recombine3d_all().

◆ recombine3DConformity

int contextMeshOptions::recombine3DConformity

Definition at line 33 of file Context.h.

Referenced by Mesh3D(), and opt_mesh_recombine3d_conformity().

◆ recombine3DLevel

int contextMeshOptions::recombine3DLevel

Definition at line 33 of file Context.h.

Referenced by opt_mesh_recombine3d_level().

◆ recombineAll

◆ recombineMinimumQuality

double contextMeshOptions::recombineMinimumQuality

◆ recombineNodeRepositioning

int contextMeshOptions::recombineNodeRepositioning

◆ recombineOptimizeTopology

◆ refineSteps

int contextMeshOptions::refineSteps

Definition at line 19 of file Context.h.

Referenced by CTX::init(), and opt_mesh_refine_steps().

◆ renumber

int contextMeshOptions::renumber

Definition at line 48 of file Context.h.

Referenced by GModel::adaptMesh(), and opt_mesh_renumber().

◆ reparamMaxTriangles

int contextMeshOptions::reparamMaxTriangles

Definition at line 48 of file Context.h.

Referenced by classifyFaces(), and opt_mesh_reparam_max_triangles().

◆ saveAll

int contextMeshOptions::saveAll

Definition at line 60 of file Context.h.

Referenced by CreateOutputFile(), and opt_mesh_save_all().

◆ saveElementTagType

int contextMeshOptions::saveElementTagType

Definition at line 67 of file Context.h.

Referenced by CreateOutputFile(), and opt_mesh_save_element_tag_type().

◆ saveGroupsOfElements

int contextMeshOptions::saveGroupsOfElements

Definition at line 60 of file Context.h.

Referenced by CreateOutputFile(), and opt_mesh_save_groups_of_elements().

◆ saveGroupsOfNodes

int contextMeshOptions::saveGroupsOfNodes

Definition at line 60 of file Context.h.

Referenced by CreateOutputFile(), and opt_mesh_save_groups_of_nodes().

◆ saveParametric

int contextMeshOptions::saveParametric

Definition at line 66 of file Context.h.

Referenced by CreateOutputFile(), and opt_mesh_save_parametric().

◆ saveTopology

int contextMeshOptions::saveTopology

Definition at line 66 of file Context.h.

Referenced by opt_mesh_save_topology().

◆ saveTri

int contextMeshOptions::saveTri

Definition at line 60 of file Context.h.

Referenced by GModel::buildCutGModel(), CTX::init(), and MElement::writeMSH2().

◆ saveWithoutOrphans

int contextMeshOptions::saveWithoutOrphans

◆ scalingFactor

double contextMeshOptions::scalingFactor

Definition at line 58 of file Context.h.

Referenced by CreateOutputFile(), CTX::init(), and opt_mesh_scaling_factor().

◆ secondOrderIncomplete

int contextMeshOptions::secondOrderIncomplete

Definition at line 35 of file Context.h.

Referenced by GenerateMesh(), CTX::init(), and opt_mesh_second_order_incomplete().

◆ secondOrderLinear

int contextMeshOptions::secondOrderLinear

Definition at line 35 of file Context.h.

Referenced by GenerateMesh(), CTX::init(), and opt_mesh_second_order_linear().

◆ smoothCrossField

int contextMeshOptions::smoothCrossField

Definition at line 20 of file Context.h.

Referenced by opt_mesh_smooth_cross_field().

◆ smoothNormals

int contextMeshOptions::smoothNormals

Definition at line 89 of file Context.h.

Referenced by addElementsInArrays(), CTX::init(), and opt_mesh_smooth_normals().

◆ smoothRatio

double contextMeshOptions::smoothRatio

◆ stlAngularDeflection

double contextMeshOptions::stlAngularDeflection

Definition at line 64 of file Context.h.

Referenced by opt_mesh_stl_angular_deflection().

◆ stlLinearDeflection

double contextMeshOptions::stlLinearDeflection

Definition at line 64 of file Context.h.

Referenced by opt_mesh_stl_linear_deflection().

◆ stlLinearDeflectionRelative

bool contextMeshOptions::stlLinearDeflectionRelative

Definition at line 65 of file Context.h.

Referenced by opt_mesh_stl_linear_deflection_relative().

◆ stlOneSolidPerSurface

int contextMeshOptions::stlOneSolidPerSurface

Definition at line 63 of file Context.h.

Referenced by CreateOutputFile(), and opt_mesh_stl_one_solid_per_surface().

◆ stlRemoveDuplicateTriangles

int contextMeshOptions::stlRemoveDuplicateTriangles

Definition at line 63 of file Context.h.

Referenced by opt_mesh_stl_remove_duplicate_triangles().

◆ surfaceEdges

int contextMeshOptions::surfaceEdges

◆ surfaceFaces

◆ surfaceLabels

int contextMeshOptions::surfaceLabels

Definition at line 86 of file Context.h.

Referenced by drawContext::draw3d(), and opt_mesh_surface_labels().

◆ switchElementTags

int contextMeshOptions::switchElementTags

Definition at line 67 of file Context.h.

Referenced by CTX::init(), opt_mesh_switch_elem_tags(), and GModel::readUNV().

◆ tangents

double contextMeshOptions::tangents

Definition at line 22 of file Context.h.

Referenced by drawTangents(), opt_mesh_color_tangents(), and opt_mesh_tangents().

◆ tetrahedra

int contextMeshOptions::tetrahedra

Definition at line 83 of file Context.h.

Referenced by CTX::init(), and opt_mesh_tetrahedra().

◆ toleranceEdgeLength

double contextMeshOptions::toleranceEdgeLength

Definition at line 25 of file Context.h.

Referenced by CTX::init(), and opt_mesh_tolerance_edge_length().

◆ toleranceInitialDelaunay

double contextMeshOptions::toleranceInitialDelaunay

Definition at line 25 of file Context.h.

Referenced by CTX::init(), and opt_mesh_tolerance_initial_delaunay().

◆ toleranceReferenceElement

double contextMeshOptions::toleranceReferenceElement

◆ transfiniteTri

int contextMeshOptions::transfiniteTri

Definition at line 34 of file Context.h.

Referenced by opt_mesh_transfinite_tri().

◆ triangles

int contextMeshOptions::triangles

Definition at line 83 of file Context.h.

Referenced by CTX::init(), and opt_mesh_triangles().

◆ trihedra

int contextMeshOptions::trihedra

Definition at line 84 of file Context.h.

Referenced by CTX::init(), initMeshGRegion::operator()(), and opt_mesh_trihedra().

◆ unvStrictFormat

int contextMeshOptions::unvStrictFormat

Definition at line 63 of file Context.h.

Referenced by opt_mesh_unv_strict_format().

◆ volumeEdges

int contextMeshOptions::volumeEdges

◆ volumeFaces

◆ volumeLabels

int contextMeshOptions::volumeLabels

Definition at line 86 of file Context.h.

Referenced by drawContext::draw3d(), and opt_mesh_volume_labels().

◆ voronoi

int contextMeshOptions::voronoi

Definition at line 88 of file Context.h.

Referenced by opt_mesh_voronoi().

◆ zoneDefinition

int contextMeshOptions::zoneDefinition

Definition at line 66 of file Context.h.

Referenced by opt_mesh_zone_definition().


The documentation for this struct was generated from the following file: