18#include "Parameters.h"
19#include "RobinBoundaryCondition.h"
27#include "fils_struct.hpp"
29#include "Parameters.h"
31#include "ArtificialNeuralNetMaterial.h"
49 bool defined() {
return n != 0; };
85 bool defined() {
return dof != 0; };
129 bool weakDir =
false;
166 std::string robin_vtp_file =
"";
169 double resistance = 0.0;
245 consts::ElementType eType = consts::ElementType::NA;
284 std::string file_name;
285 std::string mesh_name;
333 consts::ConstitutiveModelType volType = consts::ConstitutiveModelType::stIso_NA;
339 consts::ConstitutiveModelType isoType = consts::ConstitutiveModelType::stIso_NA;
387 consts::FluidViscosityModelType viscType = consts::FluidViscosityModelType::viscType_NA;
412 consts::SolidViscosityModelType viscType = consts::SolidViscosityModelType::viscType_NA;
431 consts::EquationType phys = consts::EquationType::phys_NA;
438 std::map<consts::PhysicalProperyType,double> prop;
527 consts::ElementType eType = consts::ElementType::NA;
598 std::vector<fsType> fs;
601 double qmTRI3 = 2.0/3.0;
607 bool boundary_integral =
false;
608 bool spatial =
false;
609 bool volume_integral =
false;
611 bool no_options_set() {
612 return !(boundary_integral | spatial | volume_integral);
615 void set_option(consts::OutputType type,
bool value)
617 if (type == consts::OutputType::boundary_integral) {
618 boundary_integral = value;
619 }
else if (type == consts::OutputType::spatial) {
621 }
else if (type == consts::OutputType::volume_integral) {
622 volume_integral = value;
637 consts::OutputNameType grp = consts::OutputNameType::outGrp_NA;
656 consts::SolverType
LS_type = consts::SolverType::lSolver_NA;
711 consts::ContactModelType cType = consts::ContactModelType::cntctM_NA;
733 consts::CplBCType bGrp = consts::CplBCType::cplBC_NA;
774 std::string solver_library;
778 std::map<std::string,std::string> block_surface_map;
781 std::string configuration_file;
784 std::string coupling_type;
787 bool have_initial_flows =
false;
788 double initial_flows;
791 bool have_initial_pressures =
false;
792 double initial_pressures;
796 bool has_data =
false;
799 void add_block_face(
const std::string& block_name,
const std::string& face_name);
815 bool useSvZeroD =
false;
818 bool initRCR =
false;
830 consts::CplBCType
schm = consts::CplBCType::cplBC_NA;
856 std::vector<cplFaceType>
fa;
866 std::string dname =
"";
896 consts::ElementType
eType = consts::ElementType::NA;
1045 std::vector<faceType>
fa;
1130 consts::EquationType
phys = consts::EquationType::phys_NA;
1251 consts::MeshGeneratorType
method = consts::MeshGeneratorType::RMSH_TETGEN;
1273 double maxRadRatio = 0.0;
1444 bool savedOnce =
false;
1459 double sdf_default = 10.0;
1462 double sdf_deps = 0.04;
1465 double sdf_deps_close = 0.25;
1489 double meanPU = 0.0;
1492 double meanPD = 0.0;
1495 double relax_factor = 0.5;
1505 std::vector<mshType> msh;
1613 std::array<double,3> timeP;
1796 Array<double> Vinit;
1797 Array<double> Dinit;
1813 fsi_linear_solver::FSILS_lhsType
lhs;
1842 bool debug_active =
false;
The Array3 template class implements a simple interface to 3D arrays.
Definition Array3.h:25
Definition ArtificialNeuralNetMaterial.h:30
The ComMod class duplicates the data structures in the Fortran COMMOD module defined in MOD....
Definition ComMod.h:1514
std::string stopTrigName
Stop_trigger file name.
Definition ComMod.h:1699
ibType ib
IB: Immersed boundary data structure.
Definition ComMod.h:1834
int stFileIncr
Increment in saving restart file.
Definition ComMod.h:1656
int nITs
Number of initialization time steps.
Definition ComMod.h:1641
bool ibFlag
Whether any Immersed Boundary (IB) treatment is required.
Definition ComMod.h:1574
Vector< int > colPtr
Column pointer (for sparse LHS matrix structure) Modified in: lhsa()
Definition ComMod.h:1710
bool zeroAve
Reset averaging variables from zero.
Definition ComMod.h:1553
std::string saveName
Saved output file name.
Definition ComMod.h:1693
std::vector< Array2D > grisMapList
RIS mapping array, with global (total) enumeration.
Definition ComMod.h:1743
int nMsh
Number of meshes.
Definition ComMod.h:1632
chnlType std
Input/output to the screen is handled by this structure.
Definition ComMod.h:1819
bool savedOnce
Whether any file being saved.
Definition ComMod.h:1535
risFaceType ris
risFace object
Definition ComMod.h:1837
bool stFileRepl
Whether to overwrite restart file or not.
Definition ComMod.h:1544
Array< double > varWallProps
CMM-variable wall properties: 1-thickness, 2-Elasticity modulus.
Definition ComMod.h:1800
Array< double > x
Position vector of mesh nodes (in ref config)
Definition ComMod.h:1764
bool cmmVarWall
Whether variable wall properties are used for CMM.
Definition ComMod.h:1559
std::array< int, 7 > stamp
Stamp ID to make sure simulation is compatible with stFiles.
Definition ComMod.h:1653
Array< double > Ad
Time derivative of displacement.
Definition ComMod.h:1781
int cTS
Current time step.
Definition ComMod.h:1611
int dof
Current equation degrees of freedom.
Definition ComMod.h:1619
bool urisFlag
Whether any URIS surface is considered.
Definition ComMod.h:1586
int gtnNo
Global total number of nodes, across all meshes (total) and all procs (global)
Definition ComMod.h:1623
std::string stFileName
Restart file name.
Definition ComMod.h:1696
int tnNo
Total number of nodes (number of nodes on current proc across all meshes)
Definition ComMod.h:1663
int nsd
Number of spatial dimensions.
Definition ComMod.h:1635
int nFacesLS
Number of faces in the LHS passed to FSILS.
Definition ComMod.h:1629
int nsymd
Number of stress values to be stored.
Definition ComMod.h:1669
Array< double > Yn
New variables (velocity); unknown result at next time step.
Definition ComMod.h:1770
double urisRes
URIS resistance.
Definition ComMod.h:1595
bool ichckIEN
Check IEN array for initial mesh.
Definition ComMod.h:1550
std::string iniFilePath
Initialization file path.
Definition ComMod.h:1690
Vector< int > rowPtr
Row pointer (for sparse LHS matrix structure) Modified in: lhsa()
Definition ComMod.h:1720
std::string precompFileName
Precomputed state-variable file name.
Definition ComMod.h:1702
std::vector< Array2D > risMapList
RIS mapping array, with local (mesh) enumeration.
Definition ComMod.h:1740
int cEq
Current equation.
Definition ComMod.h:1608
Vector< int > cmmBdry
Boundary nodes set for CMM initialization and for zeroing-out non-wall nodal displacements.
Definition ComMod.h:1728
Array< double > Val
LHS matrix.
Definition ComMod.h:1761
bool bin2VTK
Postprocess step - convert bin to vtk.
Definition ComMod.h:1577
bool saveAve
Whether to averaged results.
Definition ComMod.h:1529
bool saveVTK
Whether to save to VTK files.
Definition ComMod.h:1532
int tDof
Total number of degrees of freedom per node.
Definition ComMod.h:1659
std::vector< urisType > uris
unfitted RIS object
Definition ComMod.h:1840
bool ris0DFlag
Whether any one-sided RIS surface with 0D coupling is considered.
Definition ComMod.h:1583
bool risFlag
Whether any RIS surface is considered.
Definition ComMod.h:1580
std::string precompFieldName
Precomputed state-variable field name.
Definition ComMod.h:1705
bool cmmInit
Whether CMM equation is initialized.
Definition ComMod.h:1556
Array< double > Rd
Residual of the displacement equation.
Definition ComMod.h:1784
cplBCType cplBC
Coupled BCs structures used for multidomain simulations.
Definition ComMod.h:1807
double time
Time.
Definition ComMod.h:1684
Array< double > Dn
New integrated variables (displacement)
Definition ComMod.h:1755
bool pstEq
Whether PRESTRESS is being solved.
Definition ComMod.h:1565
bool resetSim
Restart simulation after remeshing.
Definition ComMod.h:1547
Array< double > An
New time derivative of variables (acceleration); unknown result at next time step.
Definition ComMod.h:1749
double dt
Time step size.
Definition ComMod.h:1678
bool urisActFlag
Whether the URIS surface is active.
Definition ComMod.h:1589
Array< double > R
Residual vector.
Definition ComMod.h:1758
rmshType rmsh
Remesher type.
Definition ComMod.h:1828
int saveIncr
Increment in saving solutions.
Definition ComMod.h:1650
bool usePrecomp
Whether to use precomputed state-variable solutions.
Definition ComMod.h:1601
ioType io
To group above channels.
Definition ComMod.h:1822
cntctModelType cntctM
Contact model type.
Definition ComMod.h:1831
double urisResClose
URIS resistance when the valve is closed.
Definition ComMod.h:1598
int RisnbrIter
Nbr of iterations.
Definition ComMod.h:1672
cmType cm
The general communicator.
Definition ComMod.h:1825
int nUris
Number of URIS surfaces (uninitialized, to be set later)
Definition ComMod.h:1592
int startTS
Starting time step.
Definition ComMod.h:1616
Vector< int > idMap
Array that maps global node id to rowN in the matrix Modified in: lhsa()
Definition ComMod.h:1724
bool stFileFlag
Whether start from beginning or from simulations.
Definition ComMod.h:1541
bool sepOutput
Whether to use separator in output.
Definition ComMod.h:1538
bool shlEq
Whether shell equation is being solved.
Definition ComMod.h:1562
std::vector< eqType > eq
All data related to equations are stored in this container.
Definition ComMod.h:1810
bool iCntct
Whether to detect and apply any contact model.
Definition ComMod.h:1571
double precompDt
Time step size of the precomputed state-variables.
Definition ComMod.h:1681
Array< double > Do
Old integrated variables (displacement)
Definition ComMod.h:1752
bool dFlag
Whether there is a requirement to update mesh and Dn-Do variables.
Definition ComMod.h:1523
int cDmn
Current domain.
Definition ComMod.h:1605
int nTS
Number of time steps.
Definition ComMod.h:1638
Array< double > Ao
Old time derivative of variables (acceleration); known result at current time step.
Definition ComMod.h:1746
int nEq
Number of equations.
Definition ComMod.h:1626
Vector< int > iblank
IB: iblank used for immersed boundaries (1 => solid, 0 => fluid)
Definition ComMod.h:1731
Array< double > Kd
LHS matrix for displacement equation.
Definition ComMod.h:1787
std::vector< mshType > msh
All the meshes are stored in this variable.
Definition ComMod.h:1816
int recLn
stFiles record length
Definition ComMod.h:1644
int rsTS
Restart Time Step.
Definition ComMod.h:1666
bool mvMsh
Whether mesh is moving.
Definition ComMod.h:1526
Vector< double > Pinit
Temporary storage for initializing state variables.
Definition ComMod.h:1795
Vector< int > ltg
Local to global pointer tnNo --> gtnNo.
Definition ComMod.h:1716
fsi_linear_solver::FSILS_lhsType lhs
FSILS data structure to produce LHS sparse matrix.
Definition ComMod.h:1813
Array< double > Yo
Old variables (velocity); known result at current time step.
Definition ComMod.h:1767
Array< double > Bf
Body force.
Definition ComMod.h:1773
Vector< int > dmnId
Domain ID.
Definition ComMod.h:1713
Array< double > pS0
Variables for prestress calculations.
Definition ComMod.h:1790
int saveATS
Start saving after this number of time step.
Definition ComMod.h:1647
bool sstEq
Whether velocity-pressure based structural dynamics solver is used.
Definition ComMod.h:1568
The LinearAlgebra class provides an abstract interface to linear algebra frameworks: FSILS,...
Definition LinearAlgebra.h:13
Moving boundary data structure (used for general BC)
Definition ComMod.h:82
Definition RobinBoundaryCondition.h:37
Keep track of time.
Definition Timer.h:13
The Vector template class is used for storing int and double data.
Definition Vector.h:23
Mesh adjacency (neighboring element for each element)
Definition ComMod.h:457
Boundary condition data type.
Definition ComMod.h:126
Class storing data for B-Splines.
Definition ComMod.h:206
Cardiac electrophysiology model type.
Definition CepMod.h:131
Channel type, used in I/O.
Definition ChnlMod.h:19
The cmType class stores data and defines methods used for mpi communication.
Definition CmMod.h:55
Contact model type.
Definition ComMod.h:708
For coupled 0D-3D problems.
Definition ComMod.h:805
consts::CplBCType schm
Implicit/Explicit/Semi-implicit schemes.
Definition ComMod.h:830
int nX
Number of unknowns in the 0D domain.
Definition ComMod.h:824
int nFa
Number of coupled faces.
Definition ComMod.h:821
Vector< double > xo
Old time step unknowns in the 0D domain.
Definition ComMod.h:850
bool useGenBC
Whether to use genBC.
Definition ComMod.h:812
std::string binPath
Path to the 0D code binary file.
Definition ComMod.h:834
std::string saveName
The name of history file containing "X".
Definition ComMod.h:843
std::string commuName
File name for communication between 0D and 3D.
Definition ComMod.h:837
bool coupled
Is multi-domain active.
Definition ComMod.h:809
std::vector< cplFaceType > fa
Data structure used for communicating with 0D code.
Definition ComMod.h:856
Vector< double > xp
Output variables to be printed.
Definition ComMod.h:853
Vector< double > xn
New time step unknowns in the 0D domain.
Definition ComMod.h:847
int nXp
Number of output variables addition to nX.
Definition ComMod.h:827
This type will be used to write data in the VTK files.
Definition ComMod.h:1212
Domain type is to keep track with element belong to which domain and also different physical quantiti...
Definition ComMod.h:422
Equation type.
Definition ComMod.h:1069
LinearAlgebra * linear_algebra
Interface to a numerical linear algebra library.
Definition ComMod.h:1179
double roInf
Definition ComMod.h:1157
int maxItr
Maximum iteration for this eq.
Definition ComMod.h:1100
int s
Pointer to start of unknown Yo(:,s:e)
Definition ComMod.h:1094
int nDmnIB
IB: Number of immersed domains.
Definition ComMod.h:1118
bool coupled
Should be satisfied in a coupled/uncoupled fashion.
Definition ComMod.h:1075
bool ok
Satisfied/not satisfied.
Definition ComMod.h:1079
int nBcIB
Number of BCs on immersed surfaces.
Definition ComMod.h:1124
std::string sym
Equation symbol.
Definition ComMod.h:1163
bool assmTLS
Use C++ Trilinos framework for assembly and for linear solvers.
Definition ComMod.h:1085
lsType ls
type of linear solver
Definition ComMod.h:1167
std::vector< outputType > outIB
IB: Outputs.
Definition ComMod.h:1200
double tol
Accepted relative tolerance.
Definition ComMod.h:1160
bool useTLS
Use C++ Trilinos framework for the linear solvers.
Definition ComMod.h:1082
int itr
Number of performed iterations.
Definition ComMod.h:1097
double gam
Definition ComMod.h:1148
std::vector< outputType > outURIS
URIS: Outputs.
Definition ComMod.h:1203
int nBc
Number of BCs.
Definition ComMod.h:1121
int e
Pointer to end of unknown Yo(:,s:e)
Definition ComMod.h:1091
std::vector< dmnType > dmn
domains that this equation must be solved
Definition ComMod.h:1191
consts::PreconditionerType linear_algebra_preconditioner
The type of preconditioner used by the interface to a numerical linear algebra library.
Definition ComMod.h:1176
int nOutIB
IB: Number of possible outputs.
Definition ComMod.h:1109
double am
Definition ComMod.h:1142
double iNorm
Initial norm of residual.
Definition ComMod.h:1151
consts::LinearAlgebraType linear_algebra_assembly_type
The type of assembly interface to a numerical linear algebra library.
Definition ComMod.h:1173
consts::LinearAlgebraType linear_algebra_type
The type of interface to a numerical linear algebra library.
Definition ComMod.h:1170
int nOutURIS
URIS: Number of possible outputs.
Definition ComMod.h:1112
std::vector< bfType > bf
Body force associated with this equation.
Definition ComMod.h:1206
double pNorm
First iteration norm.
Definition ComMod.h:1154
double af
Definition ComMod.h:1135
int nBf
Number of BFs.
Definition ComMod.h:1127
int nDmn
Number of domains.
Definition ComMod.h:1115
int nOutput
Number of possible outputs.
Definition ComMod.h:1106
std::vector< dmnType > dmnIB
IB: immersed domains that this equation must be solved.
Definition ComMod.h:1194
std::vector< bcType > bc
BCs associated with this equation;.
Definition ComMod.h:1185
std::vector< bcType > bcIB
IB: BCs associated with this equation on immersed surfaces.
Definition ComMod.h:1188
int dof
Degrees of freedom.
Definition ComMod.h:1088
fsi_linear_solver::FSILS_lsType FSILS
FSILS type of linear solver.
Definition ComMod.h:1182
consts::EquationType phys
Type of equation fluid/heatF/heatS/lElas/FSI.
Definition ComMod.h:1130
std::vector< outputType > output
Outputs.
Definition ComMod.h:1197
double beta
Definition ComMod.h:1145
int minItr
Minimum iteration for this eq.
Definition ComMod.h:1103
The face type containing mesh at boundary.
Definition ComMod.h:511
void destroy()
Free memory and reset some data members.
Definition ComMod.cpp:120
Fourier coefficients that are used to specify unsteady BCs.
Definition ComMod.h:46
Fluid viscosity model type.
Definition ComMod.h:383
Function spaces (basis) type.
Definition ComMod.h:233
void destroy()
SUBROUTINE DESTROYFS(fs)
Definition ComMod.cpp:157
Vector< int > nG
Num traces (Gauss points) local to each process.
Definition ComMod.h:1300
Vector< int > n
Num traces (nodes) local to each process.
Definition ComMod.h:1294
Vector< int > gE
Pointer to global trace (Gauss point) stacked contiguously.
Definition ComMod.h:1303
Vector< int > gN
Pointer to global trace (node num) stacked contiguously.
Definition ComMod.h:1297
Immersed Boundary (IB) data type.
Definition ComMod.h:1310
Array< double > x
IB position coordinates.
Definition ComMod.h:1354
Array< double > Aun
Time derivative of displacement (new)
Definition ComMod.h:1363
int cpld
IB coupling.
Definition ComMod.h:1322
Array< double > Ku
LHS tangent matrix for displacement.
Definition ComMod.h:1393
int tnNo
Total number of IB nodes.
Definition ComMod.h:1336
Array< double > Un
Displacement (projected on background mesh, new, n+af)
Definition ComMod.h:1381
int cEq
Current equation.
Definition ComMod.h:1333
Array< double > R
Residual (FSI force)
Definition ComMod.h:1384
int intrp
IB interpolation method.
Definition ComMod.h:1326
Array< double > Uo
Displacement (projected on background mesh, old)
Definition ComMod.h:1378
Array< double > Yb
Velocity (new)
Definition ComMod.h:1357
Array< double > Ubn
Displacement (new)
Definition ComMod.h:1372
int cDmn
Current IB domain ID.
Definition ComMod.h:1330
double callD[4]
IB call duration (1: total time; 2: update; 3,4: communication)
Definition ComMod.h:1342
ibCommType cm
IB communicator.
Definition ComMod.h:1399
Vector< int > rowPtr
Row pointer (for sparse LHS matrix storage)
Definition ComMod.h:1348
Array< double > Rub
Residual (displacement, IB mesh)
Definition ComMod.h:1390
bool savedOnce
Whether any file being saved.
Definition ComMod.h:1314
Vector< int > dmnID
IB Domain ID.
Definition ComMod.h:1345
Array< double > Auo
Time derivative of displacement (old)
Definition ComMod.h:1360
Array< double > Ubk
Displacement (n+af)
Definition ComMod.h:1375
int nMsh
Number of IB meshes.
Definition ComMod.h:1339
int mthd
IB method.
Definition ComMod.h:1318
std::vector< mshType > msh
DERIVED class VARIABLES IB meshes;.
Definition ComMod.h:1396
Array< double > Ubo
Displacement (old)
Definition ComMod.h:1369
Vector< int > colPtr
Column pointer (for sparse LHS matrix storage)
Definition ComMod.h:1351
Array< double > Ru
Residual (displacement, background mesh)
Definition ComMod.h:1387
Array< double > Auk
Time derivative of displacement (n+am)
Definition ComMod.h:1366
Only to group four channels, in case I rather have them as one variable.
Definition ChnlMod.h:50
Linear system of equations solver type.
Definition ComMod.h:652
double absTol
Absolute tolerance (IN)
Definition ComMod.h:683
int cN
Number of |x| norms (OUT)
Definition ComMod.h:674
int cD
Number of <x.y> dot products (OUT)
Definition ComMod.h:677
double fNorm
Final norm of residual (OUT)
Definition ComMod.h:692
double callD
Calling duration (OUT)
Definition ComMod.h:698
int reserve
Only for data alignment (-)
Definition ComMod.h:680
bool suc
Successful solving (OUT)
Definition ComMod.h:659
int mItr
Maximum iterations (IN)
Definition ComMod.h:662
consts::SolverType LS_type
LS solver (IN)
Definition ComMod.h:656
int itr
Number of iteration (OUT)
Definition ComMod.h:668
double relTol
Relative tolerance (IN)
Definition ComMod.h:686
double dB
Res. rduction in last itr. (OUT)
Definition ComMod.h:695
int sD
Space dimension (IN)
Definition ComMod.h:665
int cM
Number of Ax multiple (OUT)
Definition ComMod.h:671
double iNorm
Initial norm of residual (OUT)
Definition ComMod.h:689
This is the container for a mesh or NURBS patch, those specific to NURBS are noted.
Definition ComMod.h:863
int nNo
Number of nodes (control points) for 2D elements?
Definition ComMod.h:924
Vector< double > w
Gauss weights.
Definition ComMod.h:993
std::vector< std::vector< int > > ordering
@breif ordering: node ordering for boundaries
Definition ComMod.h:951
Array< double > N
Parent shape function.
Definition ComMod.h:1005
traceType trc
IB: tracers.
Definition ComMod.h:1048
Array3< double > Ys
Solution field (displacement, velocity, pressure, etc.) for a known, potentially time-varying,...
Definition ComMod.h:1027
Vector< int > eDist
Element distribution between processors.
Definition ComMod.h:954
Vector< int > iGC
IB: Whether a cell is a ghost cell or not.
Definition ComMod.h:987
adjType nAdj
Mesh nodal adjacency.
Definition ComMod.h:1033
Array< double > xib
Bounds on parameteric coordinates.
Definition ComMod.h:999
adjType eAdj
Mesh element adjacency.
Definition ComMod.h:1036
int nG
Number of Gauss points for integration.
Definition ComMod.h:921
int nFa
Number of faces.
Definition ComMod.h:915
Array< double > x
Position coordinates (not always, however, as they get overwritten by read_vtu_pdata())
Definition ComMod.h:1002
std::vector< fsType > fs
Function spaces (basis)
Definition ComMod.h:1039
Array3< double > Nxx
Second derivatives of shape functions - used for shells & IGA davep double Nxx(:,:,...
Definition ComMod.h:1023
int gnNo
Global number of nodes (control points) on a single mesh.
Definition ComMod.h:906
double dx
IB: Mesh size parameter.
Definition ComMod.h:939
bool lShpF
Whether the shape function is linear.
Definition ComMod.h:887
Vector< int > lN
Global to local maping tnNo --> nNo.
Definition ComMod.h:978
Vector< int > otnIEN
gIEN mapper from old to new
Definition ComMod.h:972
int nFn
Number of fiber directions.
Definition ComMod.h:933
Vector< int > eRIS
RIS: flags of whether elemets are adjacent to RIS projections.
Definition ComMod.h:1052
Array< int > eIEN
Shells: extended IEN array with neighboring nodes.
Definition ComMod.h:981
Vector< int > gN
Global nodes maping nNo --> tnNo.
Definition ComMod.h:960
bool lFib
Whether the mesh is fibers (Purkinje)
Definition ComMod.h:893
double v
The volume of this mesh.
Definition ComMod.h:948
int eNoN
Number of nodes (control points) in a single element.
Definition ComMod.h:900
double scF
Mesh scale factor.
Definition ComMod.h:936
Vector< int > eId
Element domain ID number.
Definition ComMod.h:957
int gnEl
Global number of elements (knot spans)
Definition ComMod.h:903
double res
RIS resistance value.
Definition ComMod.h:942
Vector< int > partRIS
RIS: processor ids to change element partitions to.
Definition ComMod.h:1055
int nSl
Number of elements sample points to be outputs (NURBS)
Definition ComMod.h:927
Array< double > xi
Gauss integration points in parametric space.
Definition ComMod.h:996
Array< double > fN
Fiber orientations stored at the element level - used for electrophysiology and solid mechanics.
Definition ComMod.h:1015
int nFs
Number of function spaces.
Definition ComMod.h:918
Array< int > sbc
Shells: boundary condition variable.
Definition ComMod.h:984
bool lShl
Whether the mesh is shell.
Definition ComMod.h:890
Array< double > Nb
Shape function bounds.
Definition ComMod.h:1008
Array< double > nV
Normal vector to each nodal point (for Shells)
Definition ComMod.h:1011
Vector< double > nW
Control points weights (NURBS)
Definition ComMod.h:990
Array3< double > Nx
Parent shape functions gradient double Nx(:,:,:)
Definition ComMod.h:1019
std::vector< faceType > fa
Faces are stored in this variable.
Definition ComMod.h:1045
Vector< int > gpN
GLobal projected nodes mapping projected -> unprojected mapping.
Definition ComMod.h:963
Array< int > gIEN
Global connectivity array mappig eNoN,nEl --> gnNo.
Definition ComMod.h:966
int vtkType
The element type recognized by VTK format.
Definition ComMod.h:930
int nEl
Number of elements (knot spans)
Definition ComMod.h:912
consts::ElementType eType
Element type.
Definition ComMod.h:896
int nEf
Number of element face. Used for reading Gambit mesh files.
Definition ComMod.h:909
std::string name
Mesh Name.
Definition ComMod.h:1030
std::vector< bsType > bs
BSpline in different directions (NURBS)
Definition ComMod.h:1042
double tol
RIS projection tolerance.
Definition ComMod.h:945
Array< int > IEN
The connectivity array mapping eNoN,nEl --> nNo.
Definition ComMod.h:969
double qmTET4
TET4 quadrature modifier.
Definition ComMod.h:1058
Array< int > INN
Local knot pointer (NURBS)
Definition ComMod.h:975
Declared type for outputed variables.
Definition ComMod.h:630
Data type for Resistive Immersed Surface.
Definition ComMod.h:1405
Array3< int > lst
List of meshes, and faces connected. The first face is the.
Definition ComMod.h:1416
std::vector< bool > status
Status RIS interface.
Definition ComMod.h:1431
Vector< double > Res
Resistance value.
Definition ComMod.h:1419
Vector< int > nbrIter
Count time steps where no check is needed.
Definition ComMod.h:1412
Array< double > meanP
Mean distal and proximal pressure (1: distal, 2: proximal)
Definition ComMod.h:1425
int nbrRIS
Number of RIS surface.
Definition ComMod.h:1409
Vector< double > meanFl
Mean flux on the RIS surface.
Definition ComMod.h:1428
std::vector< bool > clsFlg
Flag closed surface active, the valve is considerd open initially.
Definition ComMod.h:1422
Vector< double > iNorm
Initial norm of an equation.
Definition ComMod.h:1279
int rTS
Time step from which remeshing is done.
Definition ComMod.h:1257
int freq
Time step frequency for forced remeshing.
Definition ComMod.h:1266
int cpVar
Time step freq for saving data.
Definition ComMod.h:1260
Array< double > A0
Copy of solution variables where remeshing starts.
Definition ComMod.h:1282
int cntr
Counter to track number of remesh done.
Definition ComMod.h:1254
std::vector< bool > flag
Flag is set if remeshing is required for each mesh.
Definition ComMod.h:1287
double time
Time where remeshing starts.
Definition ComMod.h:1269
consts::MeshGeneratorType method
Method for remeshing: 1-TetGen, 2-MeshSim.
Definition ComMod.h:1251
double minDihedAng
Mesh quality parameters.
Definition ComMod.h:1272
int fTS
Time step at which forced remeshing is done.
Definition ComMod.h:1263
Vector< double > maxEdgeSize
Edge size of mesh.
Definition ComMod.h:1276
bool isReqd
Whether remesh is required for problem or not.
Definition ComMod.h:1248
Fluid viscosity model type.
Definition ComMod.h:408
Structural domain type.
Definition ComMod.h:330
Definition Parameters.h:657
Tracer type used for immersed boundaries. Identifies traces of nodes and integration points on backgr...
Definition ComMod.h:476
Unfitted Resistive Immersed surface data type.
Definition ComMod.h:1437
TODO: for now, better to organize these within a class
Definition ComMod.h:1734
Store options for output types.
Definition ComMod.h:606