svMultiPhysics
Loading...
Searching...
No Matches
ComMod.h
1/* Copyright (c) Stanford University, The Regents of the University of California, and others.
2 *
3 * All Rights Reserved.
4 *
5 * See Copyright-SimVascular.txt for additional details.
6 *
7 * Permission is hereby granted, free of charge, to any person obtaining
8 * a copy of this software and associated documentation files (the
9 * "Software"), to deal in the Software without restriction, including
10 * without limitation the rights to use, copy, modify, merge, publish,
11 * distribute, sublicense, and/or sell copies of the Software, and to
12 * permit persons to whom the Software is furnished to do so, subject
13 * to the following conditions:
14 *
15 * The above copyright notice and this permission notice shall be included
16 * in all copies or substantial portions of the Software.
17 *
18 * THIS SOFTWARE IS PROVIDED BY THE COPYRIGHT HOLDERS AND CONTRIBUTORS "AS
19 * IS" AND ANY EXPRESS OR IMPLIED WARRANTIES, INCLUDING, BUT NOT LIMITED
20 * TO, THE IMPLIED WARRANTIES OF MERCHANTABILITY AND FITNESS FOR A
21 * PARTICULAR PURPOSE ARE DISCLAIMED. IN NO EVENT SHALL THE COPYRIGHT OWNER
22 * OR CONTRIBUTORS BE LIABLE FOR ANY DIRECT, INDIRECT, INCIDENTAL, SPECIAL,
23 * EXEMPLARY, OR CONSEQUENTIAL DAMAGES (INCLUDING, BUT NOT LIMITED TO,
24 * PROCUREMENT OF SUBSTITUTE GOODS OR SERVICES; LOSS OF USE, DATA, OR
25 * PROFITS; OR BUSINESS INTERRUPTION) HOWEVER CAUSED AND ON ANY THEORY OF
26 * LIABILITY, WHETHER IN CONTRACT, STRICT LIABILITY, OR TORT (INCLUDING
27 * NEGLIGENCE OR OTHERWISE) ARISING IN ANY WAY OUT OF THE USE OF THIS
28 * SOFTWARE, EVEN IF ADVISED OF THE POSSIBILITY OF SUCH DAMAGE.
29 */
30
31// The classes defined here duplicate the data structures in the Fortran COMMOD module
32// defined in MOD.f.
33//
34// All of the data structures used for the mesh, boundarsy conditions and solver parameters, etc.
35// are defined here.
36
37#ifndef COMMOD_H
38#define COMMOD_H
39
40#include "Array.h"
41#include "Array3.h"
42#include "CepMod.h"
43#include "ChnlMod.h"
44#include "CmMod.h"
45#include "Timer.h"
46#include "Vector.h"
47
48#include "DebugMsg.h"
49
50#include "consts.h"
51
52#include "fils_struct.hpp"
53
54#include <array>
55#include <iostream>
56#include <string>
57#include <vector>
58
59class LinearAlgebra;
60
61/// @brief Fourier coefficients that are used to specify unsteady BCs
62//
63class fcType
64{
65 public:
66
67 bool defined() { return n != 0; };
68
69 // If this is a ramp function
70 bool lrmp = false;
71
72 // Number of Fourier coefficient
73 int n = 0;
74
75 // No. of dimensions (scalar or vector)
76 int d = 0;
77
78 // Initial value
80
81 // Time derivative of linear part
83
84 // Period
85 double T = 0.0;
86
87 // Initial time
88 double ti = 0.0;
89
90 // Imaginary part of coefficint
91 Array<double> i;
92
93 // Real part of coefficint
94 Array<double> r;
95};
96
97/// @brief Moving boundary data structure (used for general BC)
98//
99class MBType
100{
101 public:
102
103 bool defined() { return dof != 0; };
104
105 // Degrees of freedom of d(:,.,.)
106 int dof = 0;
107
108 // Number of time points to be read
109 int nTP = 0;
110
111 // The period of data
112 double period = 0.0;
113
114 // Time points
116
117 // Displacements at each direction, location, and time point
119};
120
122{
123 public:
124
125 // Proximal resistance
126 double Rp = 0.0;
127
128 // Capacitance
129 double C = 0.0;
130
131 // Distance resistance
132 double Rd = 0.0;
133
134 // Distal pressure
135 double Pd = 0.0;
136
137 // Initial value
138 double Xo = 0.0;
139};
140
141/// @brief Boundary condition data type
142//
144{
145 public:
146
147 // Strong/Weak application of Dirichlet BC
148 bool weakDir = false;
149
150 // Whether load vector changes with deformation
151 // (Neu - struct/ustruct only)
152 bool flwP = false;
153
154 // Robin: apply only in normal direction
155 bool rbnN = false;
156
157 // Pre/Res/Flat/Para... boundary types
158 //
159 // This stores differnt BCs as bitwise values.
160 //
161 int bType = 0;
162
163 // Pointer to coupledBC%face
164 int cplBCptr = -1;
165
166 // The face index that corresponds to this BC
167 int iFa = -1;
168
169 // The mesh index that corresponds to this BC
170 int iM = -1;
171
172 // Pointer to FSILS%bc
173 int lsPtr = -1;
174
175 // Undeforming Neu BC master-slave node parameters.
176 int masN = 0;
177
178 // Defined steady value
179 double g = 0.0;
180
181 // Neu: defined resistance
182 double r = 0.0;
183
184 // Robin: stiffness
185 double k = 0.0;
186
187 // Robin: damping
188 double c = 0.0;
189
190 // Penalty parameters for weakly applied Dir BC
191 Vector<double> tauB{0.0, 0.0};
192 //double tauB[2];
193
194 // Direction vector for imposing the BC
195 Vector<int> eDrn;
196
197 // Defined steady vector (traction)
199
200 // Spatial dependant BC (profile data)
202
203 // General BC (unsteady and UD combination)
204 //
205 // This is declare ALLOCATABLE in MOD.f.
206 //
207 MBType gm;
208
209 // Time dependant BC (Unsteady imposed value);
210 //
211 // This is declare ALLOCATABLE in MOD.f.
212 //
213 fcType gt;
214
215 // Neu: RCR
216 rcrType RCR;
217};
218
219/// @brief Class storing data for B-Splines.
220//
221class bsType
222{
223 public:
224
225 // Number of knots (p + nNo + 1)
226 int n = 0;
227
228 // Number of Gauss points for integration
229 int nG = 0;
230
231 // Number of knot spans (element)
232 int nEl = 0;
233
234 // Number of control points (nodes)
235 int nNo = 0;
236
237 // Number of sample points in each element (for output)
238 int nSl = 0;
239
240 // The order
241 int p = 0;
242
243 // Knot vector.
245};
246
247/// @brief Function spaces (basis) type.
248//
249class fsType {
250
251 public:
252
253 fsType();
254
255 void destroy();
256
257 // Whether the basis function is linear
258 bool lShpF = false;
259
260 // Element type
261 consts::ElementType eType = consts::ElementType::NA;
262
263 // Number of basis functions, typically equals msh%eNoN
264 int eNoN = 0;
265
266 // Number of Gauss points for integration
267 int nG = 0;
268
269 // Gauss weights
271
272 // Gauss integration points in parametric space
273 Array<double> xi;
274
275 // Bounds on Gauss integration points in parametric space
276 Array<double> xib;
277
278 // Parent shape function
279 Array<double> N;
280
281 // Bounds on shape functions
282 Array<double> Nb;
283
284 // Parent shape functions gradient
286
287 // Second derivatives of shape functions - used for shells & IGA
288 Array3<double> Nxx;
289};
290
291//--------
292// bfType
293//--------
294// Body force data structure type
295//
297{
298 public:
299
300 std::string file_name;
301 std::string mesh_name;
302
303 // Type of body force applied
304 int bType = 0;
305
306 // No. of dimensions (1 or nsd)
307 int dof = 0;
308
309 // Mesh index corresponding to this body force
310 int iM = -1;
311
312 // Steady value
314
315 // Steady but spatially dependant
316 Array<double> bx;
317
318 // Time dependant (unsteady imposed value)
319 fcType bt;
320
321 // General (unsteady and spatially dependent combination)
322 MBType bm;
323};
324
325// Fiber stress type
327{
328 public:
329
330 // Type of fiber stress
331 int fType = 0;
332
333 // Constant steady value
334 double g = 0.0;
335
336 // Cross fiber stress parameter
337 double eta_s = 0.0;
338
339 // Unsteady time-dependent values
340 fcType gt;
341};
342
343/// @brief Structural domain type
344//
346{
347 public:
348 // Type of constitutive model (volumetric) for struct/FSI
349 consts::ConstitutiveModelType volType = consts::ConstitutiveModelType::stIso_NA;
350
351 // Penalty parameter
352 double Kpen = 0.0;
353
354 // Type of constitutive model (isochoric) for struct/FSI
355 consts::ConstitutiveModelType isoType = consts::ConstitutiveModelType::stIso_NA;
356
357 // Parameters specific to the constitutive model (isochoric)
358 // NeoHookean model (C10 = mu/2)
359 double C10 = 0.0;
360
361 // Mooney-Rivlin model (C10, C01)
362 double C01 = 0.0;
363
364 // Holzapfel model(a, b, aff, bff, ass, bss, afs, bfs, kap)
365 double a = 0.0;
366 double b = 0.0;
367 double aff = 0.0;
368 double bff = 0.0;
369 double ass = 0.0;
370 double bss = 0.0;
371 double afs = 0.0;
372 double bfs = 0.0;
373
374 // Collagen fiber dispersion parameter (Holzapfel model)
375 double kap = 0.0;
376
377 // Heaviside function parameter (Holzapfel-Ogden model)
378 double khs = 100.0;
379
380 // Lee-Sacks model
381 double a0 = 0.0;
382 double b1 = 0.0;
383 double b2 = 0.0;
384 double mu0 = 0.0;
385
386 // Fiber reinforcement stress
387 fibStrsType Tf;
388};
389
390/// @brief Fluid viscosity model type
391//
393{
394 public:
395
396 // Type of constitutive model for fluid viscosity
397 consts::FluidViscosityModelType viscType = consts::FluidViscosityModelType::viscType_NA;
398
399 // Limiting zero shear-rate viscosity value
400 double mu_o = 0.0;
401
402 // Limiting high shear-rate viscosity (asymptotic) value (at infinity)
403 double mu_i = 0.0;
404
405 // Strain-rate tensor multiplier
406 double lam = 0.0;
407
408 // Strain-rate tensor exponent
409 double a = 0.0;
410
411 // Power-law exponent
412 double n = 0.0;
413};
414
415/// @brief Fluid viscosity model type
416//
418{
419 public:
420
421 // Type of constitutive model for fluid viscosity
422 consts::SolidViscosityModelType viscType = consts::SolidViscosityModelType::viscType_NA;
423
424 // Viscosity value
425 double mu = 0.0;
426};
427
428/// @brief Domain type is to keep track with element belong to which domain
429/// and also different physical quantities
430//
432{
433 public:
434 dmnType();
435 ~dmnType();
436
437 // The domain ID. Default includes entire domain
438 int Id = -1;
439
440 // Which physics must be solved in this domain
441 consts::EquationType phys = consts::EquationType::phys_NA;
442
443 // The volume of this domain
444 double v = 0.0;
445
446 // General physical properties such as density, elastic modulus...
447 // FIX davep double prop[maxNProp] ;
448 std::map<consts::PhysicalProperyType,double> prop;
449 //double prop[consts::maxNProp];
450
451 // Electrophysiology model
452 cepModelType cep;
453
454 // Structure material model
455 stModelType stM;
456
457 // Viscosity model for fluids
458 fluidViscModelType fluid_visc;
459
460 // Viscosity model for solids
461 solidViscModelType solid_visc;
462};
463
464/// @brief Mesh adjacency (neighboring element for each element)
465//
467{
468 public:
469 void destroy();
470
471 // No of non-zeros
472 int nnz = 0;
473
474 // Column pointer
475 Vector<int> pcol;
476
477 // Row pointer
478 Vector<int> prow;
479
480};
481
482/// @brief Tracer type used for immersed boundaries. Identifies traces of
483/// nodes and integration points on background mesh elements
484//
486{
487 public:
488 // No. of non-zero nodal traces
489 int n = 0;
490
491 // No. of non-zero integration point traces
492 int nG = 0;
493
494 // Local to global nodes maping nNo --> tnNo
495 Vector<int> gN;
496
497 // Self pointer of each trace to the IB integration point and
498 // element ID
499 Array<int> gE;
500
501 // Nodal trace pointer array stores two values for each trace.
502 // (1) background mesh element to which the trace points to,
503 // (2) mesh ID
504 Array<int> nptr;
505
506 // Integration point tracer array stores two values for each trace
507 // (1) background mesh element to which the trace points to,
508 // (2) mesh ID
509 Array<int> gptr;
510
511 // Parametric coordinate for each nodal trace
512 Array<double> xi;
513
514 // Parametric coordinate for each Gauss point trace
515 Array<double> xiG;
516};
517
518/// @brief The face type containing mesh at boundary
519//
521{
522 public:
523 faceType();
524 ~faceType();
525
526 void destroy();
527
528 //faceType& operator=(const faceType& rhs);
529
530 // Parametric direction normal to this face (NURBS)
531 int d = 0;
532
533 // Number of nodes (control points) in a single element
534 int eNoN = 0;
535
536 // Element type
537 consts::ElementType eType = consts::ElementType::NA;
538
539 // The mesh index that this face belongs to
540 int iM = 0;
541
542 // Number of elements
543 int nEl = 0;
544
545 // Global number of elements
546 int gnEl = 0;
547
548 // Number of function spaces
549 int nFs = 0;
550
551 // Number of Gauss points for integration
552 int nG = 0;
553
554 // Number of nodes
555 int nNo = 0;
556
557 // Global element Ids
558 Vector<int> gE;
559
560 // Global node Ids
561 Vector<int> gN;
562
563 // Global to local maping tnNo --> nNo
564 Vector<int> lN;
565
566 // Connectivity array
567 Array<int> IEN;
568
569 // EBC array (gE + gIEN)
570 Array<int> gebc;
571
572 // Surface area
573 double area = 0.0;
574
575 // Gauss point weights
577
578 // Position coordinates
579 Array<double> x;
580
581 // Gauss points in parametric space
582 Array<double> xi;
583
584 // Shape functions at Gauss points
585 Array<double> N;
586
587 // Normal vector to each nodal point
588 Array<double> nV;
589
590 // Shape functions derivative at Gauss points
591 // double Nx(:,:,:);
593
594 // Second derivatives of shape functions - for shells & IGA
595 // double Nxx(:,:,:);
596 Array3<double> Nxx;
597
598 // Face name for flux files
599 std::string name;
600
601 // Face nodal adjacency
602 adjType nAdj;
603
604 // Face element adjacency
605 adjType eAdj;
606
607 // Function spaces (basis)
608 std::vector<fsType> fs;
609
610 // TRI3 quadrature modifier
611 double qmTRI3 = 2.0/3.0;
612};
613
614/// @brief Store options for output types.
615//
617 bool boundary_integral = false;
618 bool spatial = false;
619 bool volume_integral = false;
620
621 bool no_options_set() {
622 return !(boundary_integral | spatial | volume_integral);
623 }
624
625 void set_option(consts::OutputType type, bool value)
626 {
627 if (type == consts::OutputType::boundary_integral) {
628 boundary_integral = value;
629 } else if (type == consts::OutputType::spatial) {
630 spatial = value;
631 } else if (type == consts::OutputType::volume_integral) {
632 volume_integral = value;
633 }
634 }
635};
636
637/// @brief Declared type for outputed variables
638//
640{
641 public:
642
643 // Options to write various output types.
644 OutputOptions options;
645
646 // The group that this belong to (one of outType_*)
647 consts::OutputNameType grp = consts::OutputNameType::outGrp_NA;
648
649 // Length of the outputed variable
650 int l = 0;
651
652 // Offset from the first index
653 int o = 0;
654
655 // The name to be used for the output and also in input file
656 std::string name;
657};
658
659/// @brief Linear system of equations solver type
660//
662{
663 public:
664
665 /// @brief LS solver (IN)
666 consts::SolverType LS_type = consts::SolverType::lSolver_NA;
667
668 /// @brief Successful solving (OUT)
669 bool suc = false;
670
671 /// @brief Maximum iterations (IN)
672 int mItr = 1000;
673
674 /// @brief Space dimension (IN)
675 int sD = 0;
676
677 /// @brief Number of iteration (OUT)
678 int itr = 0;
679
680 /// @brief Number of Ax multiple (OUT)
681 int cM = 0;
682
683 /// @brief Number of |x| norms (OUT)
684 int cN = 0;
685
686 /// @brief Number of <x.y> dot products (OUT)
687 int cD = 0;
688
689 /// @brief Only for data alignment (-)
690 int reserve = 0;
691
692 /// @brief Absolute tolerance (IN)
693 double absTol = 1e-08;
694
695 /// @brief Relative tolerance (IN)
696 double relTol = 0.0;
697
698 /// @brief Initial norm of residual (OUT)
699 double iNorm = 0.0;
700
701 /// @brief Final norm of residual (OUT)
702 double fNorm = 0.0;
703
704 /// @brief Res. rduction in last itr. (OUT)
705 double dB = 0.0;
706
707 /// @brief Calling duration (OUT)
708 double callD = 0.0;
709
710 //@brief Configuration file for linear solvers (Trilinos, PETSc)
711 std::string config;
712};
713
714
715/// @brief Contact model type
716//
718{
719 public:
720 // Contact model
721 consts::ContactModelType cType = consts::ContactModelType::cntctM_NA;
722
723 // Penalty parameter
724 double k = 0.0;
725
726 // Min depth of penetration
727 double h = 0.0;
728
729 // Max depth of penetration
730 double c = 0.0;
731
732 // Min norm of face normals in contact
733 double al = 0.0;
734
735 // Tolerance
736 double tol = 0.0;
737};
738
740{
741 public:
742 // GenBC_Dir/GenBC_Neu
743 consts::CplBCType bGrp = consts::CplBCType::cplBC_NA;
744
745 // Pointer to X
746 int Xptr = -1;
747
748 // Internal genBC use
749 int eqv = 0;
750
751 // Flow rates at t
752 double Qo = 0.0;
753
754 // Flow rates at t+dt
755 double Qn = 0.0;
756
757 // Pressures at t
758 double Po = 0.0;
759
760 // Pressures at t+dt
761 double Pn = 0.0;
762
763 // Imposed flow/pressure
764 double y = 0.0;
765
766 // Name of the face
767 std::string name;
768
769 // RCR type BC
770 rcrType RCR;
771};
772
773/// @brief For coupled 0D-3D problems
774//
776{
777 public:
778 cplBCType();
779 /// @brief Is multi-domain active
780 bool coupled = false;
781
782 /// @brief Whether to use genBC
783 bool useGenBC = false;
784
785 // Whether to use svZeroD
786 bool useSvZeroD = false;
787
788 // Whether to initialize RCR from flow data
789 bool initRCR = false;
790
791 /// @brief Number of coupled faces
792 int nFa = 0;
793
794 /// @brief Number of unknowns in the 0D domain
795 int nX = 0;
796
797 /// @brief Number of output variables addition to nX
798 int nXp = 0;
799
800 /// @brief Implicit/Explicit/Semi-implicit schemes
801 consts::CplBCType schm = consts::CplBCType::cplBC_NA;
802 //int schm = cplBC_NA;
803
804 /// @brief Path to the 0D code binary file
805 std::string binPath;
806
807 /// @brief File name for communication between 0D and 3D
808 std::string commuName;
809 //std::string commuName = ".CPLBC_0D_3D.tmp";
810
811 /// @brief The name of history file containing "X"
812 std::string saveName;
813 //std::string(LEN=stdL) :: saveName = "LPN.dat";
814
815 /// @brief New time step unknowns in the 0D domain
817
818 /// @brief Old time step unknowns in the 0D domain
820
821 /// @brief Output variables to be printed
823
824 /// @brief Data structure used for communicating with 0D code
825 std::vector<cplFaceType> fa;
826};
827
828/// @brief This is the container for a mesh or NURBS patch, those specific
829/// to NURBS are noted
830//
832{
833 public:
834 mshType();
835 std::string dname = "";
836
837/*
838 mshType(const mshType &other)
839 {
840 std::cout << "c c c c c mshType copy c c c c c" << std::endl;
841 }
842
843 mshType& operator = (const mshType &other)
844 {
845 std::cout << "= = = = = mshType assignment = = = = =" << std::endl;
846 return *this;
847 }
848*/
849
850 ~mshType()
851 {
852 //std::cout << "- - - - - mshType dtor - - - - - dname: " << dname << std::endl;
853 };
854
855 /// @brief Whether the shape function is linear
856 bool lShpF = false;
857
858 /// @brief Whether the mesh is shell
859 bool lShl = false;
860
861 /// @brief Whether the mesh is fibers (Purkinje)
862 bool lFib = false;
863
864 /// @brief Element type
865 consts::ElementType eType = consts::ElementType::NA;
866 //int eType = eType_NA
867
868 /// @brief Number of nodes (control points) in a single element
869 int eNoN = 0;
870
871 /// @brief Global number of elements (knot spans)
872 int gnEl = 0;
873
874 /// @brief Global number of nodes (control points) on a single mesh
875 int gnNo = 0;
876
877 /// @brief Number of element face. Used for reading Gambit mesh files
878 int nEf = 0;
879
880 /// @brief Number of elements (knot spans)
881 int nEl = 0;
882
883 /// @brief Number of faces
884 int nFa = 0;
885
886 /// @brief Number of function spaces
887 int nFs = 0;
888
889 /// @brief Number of Gauss points for integration
890 int nG = 0;
891
892 /// @brief Number of nodes (control points) for 2D elements?
893 int nNo = 0;
894
895 /// @brief Number of elements sample points to be outputs (NURBS)
896 int nSl = 0;
897
898 /// @brief The element type recognized by VTK format
899 int vtkType = 0;
900
901 /// @brief Number of fiber directions
902 int nFn = 0;
903
904 /// @brief Mesh scale factor
905 double scF = 0.0;
906
907 /// @brief IB: Mesh size parameter
908 double dx = 0.0;
909
910 /// @breif ordering: node ordering for boundaries
911 std::vector<std::vector<int>> ordering;
912
913 /// @brief Element distribution between processors
915
916 /// @brief Element domain ID number
918
919 /// @brief Global nodes maping nNo --> tnNo
921
922 /// @brief GLobal projected nodes mapping projected -> unprojected mapping
924
925 /// @brief Global connectivity array mappig eNoN,nEl --> gnNo
926 Array<int> gIEN;
927
928 /// @brief The connectivity array mapping eNoN,nEl --> nNo
929 Array<int> IEN;
930
931 /// @brief gIEN mapper from old to new
933
934 /// @brief Local knot pointer (NURBS)
935 Array<int> INN;
936
937 /// @brief Global to local maping tnNo --> nNo
939
940 /// @brief Shells: extended IEN array with neighboring nodes
941 Array<int> eIEN;
942
943 /// @brief Shells: boundary condition variable
944 Array<int> sbc;
945
946 /// @brief IB: Whether a cell is a ghost cell or not
948
949 /// @brief Control points weights (NURBS)
951
952 /// @brief Gauss weights
954
955 /// @brief Gauss integration points in parametric space
956 Array<double> xi;
957
958 /// @brief Bounds on parameteric coordinates
959 Array<double> xib;
960
961 /// @brief Position coordinates (not always, however, as they get overwritten by read_vtu_pdata())
962 Array<double> x;
963
964 /// @brief Parent shape function
965 Array<double> N;
966
967 /// @brief Shape function bounds
968 Array<double> Nb;
969
970 /// @brief Normal vector to each nodal point (for Shells)
971 Array<double> nV;
972
973 /// @brief Fiber orientations stored at the element level - used for
974 /// electrophysiology and solid mechanics
975 Array<double> fN;
976
977 /// @brief Parent shape functions gradient
978 /// double Nx(:,:,:)
980
981 /// @brief Second derivatives of shape functions - used for shells & IGA
982 /// davep double Nxx(:,:,:)
984
985 /// @brief Solution field (displacement, velocity, pressure, etc.) for a known, potentially
986 /// time-varying, quantity of interest across a mesh
988
989 /// @brief Mesh Name
990 std::string name;
991
992 /// @brief Mesh nodal adjacency
994
995 /// @brief Mesh element adjacency
997
998 /// @brief Function spaces (basis)
999 std::vector<fsType> fs;
1000
1001 /// @brief BSpline in different directions (NURBS)
1002 std::vector<bsType> bs;
1003
1004 /// @brief Faces are stored in this variable
1005 std::vector<faceType> fa;
1006
1007 /// @brief IB: tracers
1009
1010 /// @brief TET4 quadrature modifier
1011 double qmTET4 = (5.0+3.0*sqrt(5.0))/20.0;
1012
1013 private:
1014 //mshType(const mshType&);
1015 //mshType& operator=(const mshType&);
1016
1017};
1018
1019/// @brief Equation type
1020//
1022{
1023 public:
1024 eqType();
1025 ~eqType();
1026
1027 /// @brief Should be satisfied in a coupled/uncoupled fashion
1028 bool coupled = false;
1029 //bool coupled = .TRUE.
1030
1031 /// @brief Satisfied/not satisfied
1032 bool ok = false;
1033
1034 /// @brief Use C++ Trilinos framework for the linear solvers
1035 bool useTLS = false;
1036
1037 /// @brief Use C++ Trilinos framework for assembly and for linear solvers
1038 bool assmTLS = false;
1039
1040 /// @brief Degrees of freedom
1041 int dof = 0;
1042
1043 /// @brief Pointer to end of unknown Yo(:,s:e)
1044 int e = -1;
1045
1046 /// @brief Pointer to start of unknown Yo(:,s:e)
1047 int s = -1;
1048
1049 /// @brief Number of performed iterations
1050 int itr = 0;
1051
1052 /// @brief Maximum iteration for this eq.
1053 int maxItr = 5;
1054
1055 /// @brief Minimum iteration for this eq.
1056 int minItr = 1;
1057
1058 /// @brief Number of possible outputs
1059 int nOutput = 0;
1060
1061 /// @brief IB: Number of possible outputs
1062 int nOutIB = 0;
1063
1064 /// @brief Number of domains
1065 int nDmn = 0;
1066
1067 /// @brief IB: Number of immersed domains
1068 int nDmnIB = 0;
1069
1070 /// @brief Number of BCs
1071 int nBc = 0;
1072
1073 /// @brief Number of BCs on immersed surfaces
1074 int nBcIB = 0;
1075
1076 /// @brief Number of BFs
1077 int nBf = 0;
1078
1079 /// @brief Type of equation fluid/heatF/heatS/lElas/FSI
1080 consts::EquationType phys = consts::EquationType::phys_NA;
1081
1082 // Parameters used for the Generalized α− Method.
1083 //
1084 /// @brief \f$\alpha_f\f$
1085 double af = 0.0;
1086
1087 /// @brief \f$\alpha_m\f$
1088 ///
1089 /// For second order equations: am = (2.0 - roInf) / (1.0 + roInf)
1090 /// First order equations: am = 0.5 * (3.0 - roInf) / (1.0 + roInf)
1091 //
1092 double am = 0.0;
1093
1094 /// @brief \f$\beta\f$
1095 double beta = 0.0;
1096
1097 /// @brief \f$\gamma\f$
1098 double gam = 0.0;
1099
1100 /// @brief Initial norm of residual
1101 double iNorm = 0.0;
1102
1103 /// @brief First iteration norm
1104 double pNorm = 0.0;
1105
1106 /// @brief \f$\rho_{infinity}\f$
1107 double roInf = 0.0;
1108
1109 /// @brief Accepted relative tolerance
1110 double tol = 0.0;
1111
1112 /// @brief Equation symbol
1113 std::string sym;
1114 //std::string(LEN=2) :: sym = "NA";
1115
1116 /// @brief type of linear solver
1118
1119 /// @brief The type of interface to a numerical linear algebra library.
1120 consts::LinearAlgebraType linear_algebra_type;
1121
1122 /// @brief The type of assembly interface to a numerical linear algebra library.
1123 consts::LinearAlgebraType linear_algebra_assembly_type;
1124
1125 /// @brief The type of preconditioner used by the interface to a numerical linear algebra library.
1126 consts::PreconditionerType linear_algebra_preconditioner = consts::PreconditionerType::PREC_FSILS;
1127
1128 /// @brief Interface to a numerical linear algebra library.
1130
1131 /// @brief FSILS type of linear solver
1132 fsi_linear_solver::FSILS_lsType FSILS;
1133
1134 /// @brief BCs associated with this equation;
1135 std::vector<bcType> bc;
1136
1137 /// @brief IB: BCs associated with this equation on immersed surfaces
1138 std::vector<bcType> bcIB;
1139
1140 /// @brief domains that this equation must be solved
1141 std::vector<dmnType> dmn;
1142
1143 /// @brief IB: immersed domains that this equation must be solved
1144 std::vector<dmnType> dmnIB;
1145
1146 /// @brief Outputs
1147 std::vector<outputType> output;
1148
1149 /// @brief IB: Outputs
1150 std::vector<outputType> outIB;
1151
1152 /// @brief Body force associated with this equation
1153 std::vector<bfType> bf;
1154};
1155
1156/// @brief This type will be used to write data in the VTK files.
1157//
1159{
1160 public:
1161
1162 // Element number of nodes
1163 int eNoN = 0;
1164
1165 // Number of elements
1166 int nEl = 0;
1167
1168 // Number of nodes
1169 int nNo = 0;
1170
1171 // vtk type
1172 int vtkType = 0;
1173
1174 // Connectivity array
1175 Array<int> IEN;
1176
1177 // Element based variables to be written
1178 Array<double> xe;
1179
1180 // All the variables after transformation to global format
1181 Array<double> gx;
1182
1183 // All the variables to be written (including position)
1184 Array<double> x;
1185};
1186
1187
1189{
1190 public:
1191
1192 rmshType();
1193
1194 /// @brief Whether remesh is required for problem or not
1195 bool isReqd = false;
1196
1197 /// @brief Method for remeshing: 1-TetGen, 2-MeshSim
1198 consts::MeshGeneratorType method = consts::MeshGeneratorType::RMSH_TETGEN;
1199
1200 /// @brief Counter to track number of remesh done
1201 int cntr = 0;
1202
1203 /// @brief Time step from which remeshing is done
1204 int rTS = 0;
1205
1206 /// @brief Time step freq for saving data
1207 int cpVar = 0;
1208
1209 /// @brief Time step at which forced remeshing is done
1210 int fTS = 1000;
1211
1212 /// @brief Time step frequency for forced remeshing
1213 int freq = 1000;
1214
1215 /// @brief Time where remeshing starts
1216 double time = 0.0;
1217
1218 /// @brief Mesh quality parameters
1219 double minDihedAng = 0.0;
1220 double maxRadRatio = 0.0;
1221
1222 /// @brief Edge size of mesh
1224
1225 /// @brief Initial norm of an equation
1227
1228 /// @brief Copy of solution variables where remeshing starts
1229 Array<double> A0;
1230 Array<double> Y0;
1231 Array<double> D0;
1232
1233 /// @brief Flag is set if remeshing is required for each mesh
1234 std::vector<bool> flag;
1235};
1236
1238{
1239 public:
1240 /// @brief Num traces (nodes) local to each process
1242
1243 /// @brief Pointer to global trace (node num) stacked contiguously
1245
1246 /// @brief Num traces (Gauss points) local to each process
1248
1249 /// @brief Pointer to global trace (Gauss point) stacked contiguously
1251};
1252
1253
1254/// @brief Immersed Boundary (IB) data type
1255//
1257{
1258 public:
1259
1260 /// @brief Whether any file being saved
1261 bool savedOnce = false;
1262 //bool savedOnce = .FALSE.
1263
1264 /// @brief IB method
1265 int mthd = 0;
1266 //int mthd = ibMthd_NA;
1267
1268 /// @brief IB coupling
1269 int cpld = 0;
1270 //int cpld = ibCpld_NA;
1271
1272 /// @brief IB interpolation method
1273 int intrp = 0;
1274 //int intrp = ibIntrp_NA;
1275
1276 /// @brief Current IB domain ID
1277 int cDmn = 0;
1278
1279 /// @brief Current equation
1280 int cEq = 0;
1281
1282 /// @brief Total number of IB nodes
1283 int tnNo = 0;
1284
1285 /// @brief Number of IB meshes
1286 int nMsh = 0;
1287
1288 /// @brief IB call duration (1: total time; 2: update; 3,4: communication)
1289 double callD[4] = {0.0, 0.0, 0.0, 0.0};
1290
1291 /// @brief IB Domain ID
1293
1294 /// @brief Row pointer (for sparse LHS matrix storage)
1296
1297 /// @brief Column pointer (for sparse LHS matrix storage)
1299
1300 /// @brief IB position coordinates
1301 Array<double> x;
1302
1303 /// @brief Velocity (new)
1304 Array<double> Yb;
1305
1306 /// @brief Time derivative of displacement (old)
1307 Array<double> Auo;
1308
1309 /// @brief Time derivative of displacement (new)
1310 Array<double> Aun;
1311
1312 /// @brief Time derivative of displacement (n+am)
1313 Array<double> Auk;
1314
1315 /// @brief Displacement (old)
1316 Array<double> Ubo;
1317
1318 /// @brief Displacement (new)
1319 Array<double> Ubn;
1320
1321 /// @brief Displacement (n+af)
1322 Array<double> Ubk;
1323
1324 /// @brief Displacement (projected on background mesh, old)
1325 Array<double> Uo;
1326
1327 /// @brief Displacement (projected on background mesh, new, n+af)
1328 Array<double> Un;
1329
1330 /// @brief Residual (FSI force)
1331 Array<double> R;
1332
1333 /// @brief Residual (displacement, background mesh)
1334 Array<double> Ru;
1335
1336 /// @brief Residual (displacement, IB mesh)
1337 Array<double> Rub;
1338
1339 /// @brief LHS tangent matrix for displacement
1340 Array<double> Ku;
1341
1342 /// @brief DERIVED class VARIABLES IB meshes;
1343 std::vector<mshType> msh;
1344
1345 /// @brief IB communicator
1347};
1348
1349/// @brief The ComMod class duplicates the data structures in the Fortran COMMOD module
1350/// defined in MOD.f.
1351///
1352/// The data members here are the global variables exposed by the COMMOD module.
1353//
1354class ComMod {
1355
1356 public:
1357 ComMod();
1358 ~ComMod();
1359
1360 //----- bool members -----//
1361
1362 /// @brief Whether there is a requirement to update mesh and Dn-Do variables
1363 bool dFlag = false;
1364
1365 /// @brief Whether mesh is moving
1366 bool mvMsh = false;
1367
1368 /// @brief Whether to averaged results
1369 bool saveAve = false;
1370
1371 /// @brief Whether to save to VTK files
1372 bool saveVTK = false;
1373
1374 /// @brief Whether any file being saved
1375 bool savedOnce = false;
1376
1377 /// @brief Whether to use separator in output
1378 bool sepOutput = false;
1379
1380 /// @brief Whether start from beginning or from simulations
1381 bool stFileFlag = false;
1382
1383 /// @brief Whether to overwrite restart file or not
1384 bool stFileRepl = false;
1385
1386 /// @brief Restart simulation after remeshing
1387 bool resetSim = false;
1388
1389 /// @brief Check IEN array for initial mesh
1390 bool ichckIEN = false;
1391
1392 /// @brief Reset averaging variables from zero
1393 bool zeroAve = false;
1394
1395 /// @brief Whether CMM equation is initialized
1396 bool cmmInit = false;
1397
1398 /// @brief Whether variable wall properties are used for CMM
1399 bool cmmVarWall = false;
1400
1401 /// @brief Whether shell equation is being solved
1402 bool shlEq = false;
1403
1404 /// @brief Whether PRESTRESS is being solved
1405 bool pstEq = false;
1406
1407 /// @brief Whether velocity-pressure based structural dynamics solver is used
1408 bool sstEq = false;
1409
1410 /// @brief Whether to detect and apply any contact model
1411 bool iCntct = false;
1412
1413 /// @brief Whether any Immersed Boundary (IB) treatment is required
1414 bool ibFlag = false;
1415
1416 /// @brief Postprocess step - convert bin to vtk
1417 bool bin2VTK = false;
1418
1419 /// @brief Whether to use precomputed state-variable solutions
1420 bool usePrecomp = false;
1421
1422 //----- int members -----//
1423
1424 /// @brief Current domain
1425 int cDmn = 0;
1426
1427 /// @brief Current equation
1428 int cEq = 0;
1429
1430 /// @brief Current time step
1431 int cTS = 0;
1432
1433 std::array<double,3> timeP;
1434
1435 /// @brief Starting time step
1436 int startTS = 0;
1437
1438 /// @brief Current equation degrees of freedom
1439 int dof = 0;
1440
1441 /// @brief Global total number of nodes, across all meshes (total) and all
1442 /// procs (global)
1443 int gtnNo = 0;
1444
1445 /// @brief Number of equations
1446 int nEq = 0;
1447
1448 /// @brief Number of faces in the LHS passed to FSILS
1449 int nFacesLS = 0;
1450
1451 /// @brief Number of meshes
1452 int nMsh = 0;
1453
1454 /// @brief Number of spatial dimensions
1455 int nsd = 0;
1456
1457 /// @brief Number of time steps
1458 int nTS = 0;
1459
1460 /// @brief Number of initialization time steps
1461 int nITs = 0;
1462
1463 /// @brief stFiles record length
1464 int recLn = 0;
1465
1466 /// @brief Start saving after this number of time step
1467 int saveATS = 0;
1468
1469 /// @brief Increment in saving solutions
1470 int saveIncr = 0;
1471
1472 /// @brief Stamp ID to make sure simulation is compatible with stFiles
1473 std::array<int,7> stamp;
1474
1475 /// @brief Increment in saving restart file
1476 int stFileIncr = 0;
1477
1478 /// @brief Total number of degrees of freedom per node
1479 int tDof = 0;
1480
1481 /// @brief Total number of nodes (total number of nodes on current processor across
1482 /// all meshes)
1483 int tnNo = 0;
1484
1485 /// @brief Restart Time Step
1486 int rsTS = 0;
1487
1488 /// @brief Number of stress values to be stored
1489 int nsymd = 0;
1490
1491
1492 //----- double members -----//
1493
1494 /// @brief Time step size
1495 double dt = 0.0;
1496
1497 /// @brief Time step size of the precomputed state-variables
1498 double precompDt = 0.0;
1499
1500 /// @brief Time
1501 double time = 0.0;
1502
1503
1504 //----- string members -----//
1505
1506 /// @brief Initialization file path
1507 std::string iniFilePath;
1508
1509 /// @brief Saved output file name
1510 std::string saveName;
1511
1512 /// @brief Restart file name
1513 std::string stFileName;
1514
1515 /// @brief Stop_trigger file name
1516 std::string stopTrigName;
1517
1518 /// @brief Precomputed state-variable file name
1519 std::string precompFileName;
1520
1521 /// @brief Precomputed state-variable field name
1522 std::string precompFieldName;
1523 // ALLOCATABLE DATA
1524
1525 /// @brief Column pointer (for sparse LHS matrix structure)
1526 /// Modified in: lhsa()
1528
1529 /// @brief Domain ID
1531
1532 /// @brief Local to global pointer tnNo --> gtnNo
1534
1535 /// @brief Row pointer (for sparse LHS matrix structure)
1536 /// Modified in: lhsa()
1538
1539 /// @brief Array that maps global node id to rowN in the matrix
1540 /// Modified in: lhsa()
1542
1543 /// @brief Boundary nodes set for CMM initialization and for zeroing-out
1544 /// non-wall nodal displacements
1546
1547 /// @brief IB: iblank used for immersed boundaries (1 => solid, 0 => fluid)
1549
1550 /// @brief Old time derivative of variables (acceleration); known result at current time step
1551 Array<double> Ao;
1552
1553 /// @brief New time derivative of variables (acceleration); unknown result at next time step
1554 Array<double> An;
1555
1556 /// @brief Old integrated variables (displacement)
1557 Array<double> Do;
1558
1559 /// @brief New integrated variables (displacement)
1560 Array<double> Dn;
1561
1562 /// @brief Residual vector
1563 Array<double> R;
1564
1565 /// @brief LHS matrix
1566 Array<double> Val;
1567
1568 /// @brief Position vector of mesh nodes (in ref config)
1569 Array<double> x;
1570
1571 /// @brief Old variables (velocity); known result at current time step
1572 Array<double> Yo;
1573
1574 /// @brief New variables (velocity); unknown result at next time step
1575 Array<double> Yn;
1576
1577 /// @brief Body force
1578 Array<double> Bf;
1579
1580 //-----------------------------------------------------
1581 // Additional arrays for velocity-based formulation of
1582 // nonlinear solid mechanics.
1583 //-----------------------------------------------------
1584
1585 /// @brief Time derivative of displacement
1586 Array<double> Ad;
1587
1588 /// @brief Residual of the displacement equation
1589 Array<double> Rd;
1590
1591 /// @brief LHS matrix for displacement equation
1592 Array<double> Kd;
1593
1594 /// @brief Variables for prestress calculations
1595 Array<double> pS0;
1596 Array<double> pSn;
1597 Vector<double> pSa;
1598
1599 /// @brief Temporary storage for initializing state variables
1601 Array<double> Vinit;
1602 Array<double> Dinit;
1603
1604 /// @brief CMM-variable wall properties: 1-thickness, 2-Elasticity modulus
1605 Array<double> varWallProps;
1606
1607 //------------------------
1608 // DERIVED TYPE VARIABLES
1609 //------------------------
1610
1611 /// @brief Coupled BCs structures used for multidomain simulations
1613
1614 /// @brief All data related to equations are stored in this container
1615 std::vector<eqType> eq;
1616
1617 /// @brief FSILS data structure to produce LHS sparse matrix
1618 fsi_linear_solver::FSILS_lhsType lhs;
1619
1620 /// @brief All the meshes are stored in this variable
1621 std::vector<mshType> msh;
1622
1623 /// @brief Input/output to the screen is handled by this structure
1624 chnlType std, err, wrn, dbg;
1625
1626 /// @brief To group above channels
1628
1629 /// @brief The general communicator
1631
1632 /// @brief Remesher type
1634
1635 /// @brief Contact model type
1637
1638 /// @brief IB: Immersed boundary data structure
1640
1641 bool debug_active = false;
1642
1643 Timer timer;
1644};
1645
1646#endif
1647
The Array3 template class implements a simple interface to 3D arrays.
Definition Array3.h:52
The ComMod class duplicates the data structures in the Fortran COMMOD module defined in MOD....
Definition ComMod.h:1354
std::string stopTrigName
Stop_trigger file name.
Definition ComMod.h:1516
ibType ib
IB: Immersed boundary data structure.
Definition ComMod.h:1639
int stFileIncr
Increment in saving restart file.
Definition ComMod.h:1476
int nITs
Number of initialization time steps.
Definition ComMod.h:1461
bool ibFlag
Whether any Immersed Boundary (IB) treatment is required.
Definition ComMod.h:1414
Vector< int > colPtr
Column pointer (for sparse LHS matrix structure) Modified in: lhsa()
Definition ComMod.h:1527
bool zeroAve
Reset averaging variables from zero.
Definition ComMod.h:1393
std::string saveName
Saved output file name.
Definition ComMod.h:1510
int nMsh
Number of meshes.
Definition ComMod.h:1452
chnlType std
Input/output to the screen is handled by this structure.
Definition ComMod.h:1624
bool savedOnce
Whether any file being saved.
Definition ComMod.h:1375
bool stFileRepl
Whether to overwrite restart file or not.
Definition ComMod.h:1384
Array< double > varWallProps
CMM-variable wall properties: 1-thickness, 2-Elasticity modulus.
Definition ComMod.h:1605
Array< double > x
Position vector of mesh nodes (in ref config)
Definition ComMod.h:1569
bool cmmVarWall
Whether variable wall properties are used for CMM.
Definition ComMod.h:1399
std::array< int, 7 > stamp
Stamp ID to make sure simulation is compatible with stFiles.
Definition ComMod.h:1473
Array< double > Ad
Time derivative of displacement.
Definition ComMod.h:1586
int cTS
Current time step.
Definition ComMod.h:1431
int dof
Current equation degrees of freedom.
Definition ComMod.h:1439
int gtnNo
Global total number of nodes, across all meshes (total) and all procs (global)
Definition ComMod.h:1443
std::string stFileName
Restart file name.
Definition ComMod.h:1513
int tnNo
Total number of nodes (total number of nodes on current processor across all meshes)
Definition ComMod.h:1483
int nsd
Number of spatial dimensions.
Definition ComMod.h:1455
int nFacesLS
Number of faces in the LHS passed to FSILS.
Definition ComMod.h:1449
int nsymd
Number of stress values to be stored.
Definition ComMod.h:1489
Array< double > Yn
New variables (velocity); unknown result at next time step.
Definition ComMod.h:1575
bool ichckIEN
Check IEN array for initial mesh.
Definition ComMod.h:1390
std::string iniFilePath
Initialization file path.
Definition ComMod.h:1507
Vector< int > rowPtr
Row pointer (for sparse LHS matrix structure) Modified in: lhsa()
Definition ComMod.h:1537
std::string precompFileName
Precomputed state-variable file name.
Definition ComMod.h:1519
int cEq
Current equation.
Definition ComMod.h:1428
Vector< int > cmmBdry
Boundary nodes set for CMM initialization and for zeroing-out non-wall nodal displacements.
Definition ComMod.h:1545
Array< double > Val
LHS matrix.
Definition ComMod.h:1566
bool bin2VTK
Postprocess step - convert bin to vtk.
Definition ComMod.h:1417
bool saveAve
Whether to averaged results.
Definition ComMod.h:1369
bool saveVTK
Whether to save to VTK files.
Definition ComMod.h:1372
int tDof
Total number of degrees of freedom per node.
Definition ComMod.h:1479
std::string precompFieldName
Precomputed state-variable field name.
Definition ComMod.h:1522
bool cmmInit
Whether CMM equation is initialized.
Definition ComMod.h:1396
Array< double > Rd
Residual of the displacement equation.
Definition ComMod.h:1589
cplBCType cplBC
Coupled BCs structures used for multidomain simulations.
Definition ComMod.h:1612
double time
Time.
Definition ComMod.h:1501
Array< double > Dn
New integrated variables (displacement)
Definition ComMod.h:1560
bool pstEq
Whether PRESTRESS is being solved.
Definition ComMod.h:1405
bool resetSim
Restart simulation after remeshing.
Definition ComMod.h:1387
Array< double > An
New time derivative of variables (acceleration); unknown result at next time step.
Definition ComMod.h:1554
double dt
Time step size.
Definition ComMod.h:1495
Array< double > R
Residual vector.
Definition ComMod.h:1563
rmshType rmsh
Remesher type.
Definition ComMod.h:1633
int saveIncr
Increment in saving solutions.
Definition ComMod.h:1470
bool usePrecomp
Whether to use precomputed state-variable solutions.
Definition ComMod.h:1420
ioType io
To group above channels.
Definition ComMod.h:1627
cntctModelType cntctM
Contact model type.
Definition ComMod.h:1636
cmType cm
The general communicator.
Definition ComMod.h:1630
int startTS
Starting time step.
Definition ComMod.h:1436
Vector< int > idMap
Array that maps global node id to rowN in the matrix Modified in: lhsa()
Definition ComMod.h:1541
bool stFileFlag
Whether start from beginning or from simulations.
Definition ComMod.h:1381
bool sepOutput
Whether to use separator in output.
Definition ComMod.h:1378
bool shlEq
Whether shell equation is being solved.
Definition ComMod.h:1402
std::vector< eqType > eq
All data related to equations are stored in this container.
Definition ComMod.h:1615
bool iCntct
Whether to detect and apply any contact model.
Definition ComMod.h:1411
double precompDt
Time step size of the precomputed state-variables.
Definition ComMod.h:1498
Array< double > Do
Old integrated variables (displacement)
Definition ComMod.h:1557
bool dFlag
Whether there is a requirement to update mesh and Dn-Do variables.
Definition ComMod.h:1363
int cDmn
Current domain.
Definition ComMod.h:1425
int nTS
Number of time steps.
Definition ComMod.h:1458
Array< double > Ao
Old time derivative of variables (acceleration); known result at current time step.
Definition ComMod.h:1551
int nEq
Number of equations.
Definition ComMod.h:1446
Vector< int > iblank
IB: iblank used for immersed boundaries (1 => solid, 0 => fluid)
Definition ComMod.h:1548
Array< double > Kd
LHS matrix for displacement equation.
Definition ComMod.h:1592
std::vector< mshType > msh
All the meshes are stored in this variable.
Definition ComMod.h:1621
int recLn
stFiles record length
Definition ComMod.h:1464
int rsTS
Restart Time Step.
Definition ComMod.h:1486
bool mvMsh
Whether mesh is moving.
Definition ComMod.h:1366
Vector< double > Pinit
Temporary storage for initializing state variables.
Definition ComMod.h:1600
Vector< int > ltg
Local to global pointer tnNo --> gtnNo.
Definition ComMod.h:1533
fsi_linear_solver::FSILS_lhsType lhs
FSILS data structure to produce LHS sparse matrix.
Definition ComMod.h:1618
Array< double > Yo
Old variables (velocity); known result at current time step.
Definition ComMod.h:1572
Array< double > Bf
Body force.
Definition ComMod.h:1578
Vector< int > dmnId
Domain ID.
Definition ComMod.h:1530
Array< double > pS0
Variables for prestress calculations.
Definition ComMod.h:1595
int saveATS
Start saving after this number of time step.
Definition ComMod.h:1467
bool sstEq
Whether velocity-pressure based structural dynamics solver is used.
Definition ComMod.h:1408
The LinearAlgebra class provides an abstract interface to linear algebra frameworks: FSILS,...
Definition LinearAlgebra.h:40
Moving boundary data structure (used for general BC)
Definition ComMod.h:100
Keep track of time.
Definition Timer.h:40
The Vector template class is used for storing int and double data.
Definition Vector.h:50
Mesh adjacency (neighboring element for each element)
Definition ComMod.h:467
Boundary condition data type.
Definition ComMod.h:144
Definition ComMod.h:297
Class storing data for B-Splines.
Definition ComMod.h:222
Cardiac electrophysiology model type.
Definition CepMod.h:158
Channel type, used in I/O.
Definition ChnlMod.h:46
The cmType class stores data and defines methods used for mpi communication.
Definition CmMod.h:82
Contact model type.
Definition ComMod.h:718
For coupled 0D-3D problems.
Definition ComMod.h:776
consts::CplBCType schm
Implicit/Explicit/Semi-implicit schemes.
Definition ComMod.h:801
int nX
Number of unknowns in the 0D domain.
Definition ComMod.h:795
int nFa
Number of coupled faces.
Definition ComMod.h:792
Vector< double > xo
Old time step unknowns in the 0D domain.
Definition ComMod.h:819
bool useGenBC
Whether to use genBC.
Definition ComMod.h:783
std::string binPath
Path to the 0D code binary file.
Definition ComMod.h:805
std::string saveName
The name of history file containing "X".
Definition ComMod.h:812
std::string commuName
File name for communication between 0D and 3D.
Definition ComMod.h:808
bool coupled
Is multi-domain active.
Definition ComMod.h:780
std::vector< cplFaceType > fa
Data structure used for communicating with 0D code.
Definition ComMod.h:825
Vector< double > xp
Output variables to be printed.
Definition ComMod.h:822
Vector< double > xn
New time step unknowns in the 0D domain.
Definition ComMod.h:816
int nXp
Number of output variables addition to nX.
Definition ComMod.h:798
Definition ComMod.h:740
This type will be used to write data in the VTK files.
Definition ComMod.h:1159
Domain type is to keep track with element belong to which domain and also different physical quantiti...
Definition ComMod.h:432
Equation type.
Definition ComMod.h:1022
LinearAlgebra * linear_algebra
Interface to a numerical linear algebra library.
Definition ComMod.h:1129
double roInf
Definition ComMod.h:1107
int maxItr
Maximum iteration for this eq.
Definition ComMod.h:1053
int s
Pointer to start of unknown Yo(:,s:e)
Definition ComMod.h:1047
int nDmnIB
IB: Number of immersed domains.
Definition ComMod.h:1068
bool coupled
Should be satisfied in a coupled/uncoupled fashion.
Definition ComMod.h:1028
bool ok
Satisfied/not satisfied.
Definition ComMod.h:1032
int nBcIB
Number of BCs on immersed surfaces.
Definition ComMod.h:1074
std::string sym
Equation symbol.
Definition ComMod.h:1113
bool assmTLS
Use C++ Trilinos framework for assembly and for linear solvers.
Definition ComMod.h:1038
lsType ls
type of linear solver
Definition ComMod.h:1117
std::vector< outputType > outIB
IB: Outputs.
Definition ComMod.h:1150
double tol
Accepted relative tolerance.
Definition ComMod.h:1110
bool useTLS
Use C++ Trilinos framework for the linear solvers.
Definition ComMod.h:1035
int itr
Number of performed iterations.
Definition ComMod.h:1050
double gam
Definition ComMod.h:1098
int nBc
Number of BCs.
Definition ComMod.h:1071
int e
Pointer to end of unknown Yo(:,s:e)
Definition ComMod.h:1044
std::vector< dmnType > dmn
domains that this equation must be solved
Definition ComMod.h:1141
consts::PreconditionerType linear_algebra_preconditioner
The type of preconditioner used by the interface to a numerical linear algebra library.
Definition ComMod.h:1126
int nOutIB
IB: Number of possible outputs.
Definition ComMod.h:1062
double am
Definition ComMod.h:1092
double iNorm
Initial norm of residual.
Definition ComMod.h:1101
consts::LinearAlgebraType linear_algebra_assembly_type
The type of assembly interface to a numerical linear algebra library.
Definition ComMod.h:1123
consts::LinearAlgebraType linear_algebra_type
The type of interface to a numerical linear algebra library.
Definition ComMod.h:1120
std::vector< bfType > bf
Body force associated with this equation.
Definition ComMod.h:1153
double pNorm
First iteration norm.
Definition ComMod.h:1104
double af
Definition ComMod.h:1085
int nBf
Number of BFs.
Definition ComMod.h:1077
int nDmn
Number of domains.
Definition ComMod.h:1065
int nOutput
Number of possible outputs.
Definition ComMod.h:1059
std::vector< dmnType > dmnIB
IB: immersed domains that this equation must be solved.
Definition ComMod.h:1144
std::vector< bcType > bc
BCs associated with this equation;.
Definition ComMod.h:1135
std::vector< bcType > bcIB
IB: BCs associated with this equation on immersed surfaces.
Definition ComMod.h:1138
int dof
Degrees of freedom.
Definition ComMod.h:1041
fsi_linear_solver::FSILS_lsType FSILS
FSILS type of linear solver.
Definition ComMod.h:1132
consts::EquationType phys
Type of equation fluid/heatF/heatS/lElas/FSI.
Definition ComMod.h:1080
std::vector< outputType > output
Outputs.
Definition ComMod.h:1147
double beta
Definition ComMod.h:1095
int minItr
Minimum iteration for this eq.
Definition ComMod.h:1056
The face type containing mesh at boundary.
Definition ComMod.h:521
void destroy()
Free memory and reset some data members.
Definition ComMod.cpp:138
Fourier coefficients that are used to specify unsteady BCs.
Definition ComMod.h:64
Definition ComMod.h:327
Fluid viscosity model type.
Definition ComMod.h:393
Function spaces (basis) type.
Definition ComMod.h:249
void destroy()
SUBROUTINE DESTROYFS(fs)
Definition ComMod.cpp:175
Definition ComMod.h:1238
Vector< int > nG
Num traces (Gauss points) local to each process.
Definition ComMod.h:1247
Vector< int > n
Num traces (nodes) local to each process.
Definition ComMod.h:1241
Vector< int > gE
Pointer to global trace (Gauss point) stacked contiguously.
Definition ComMod.h:1250
Vector< int > gN
Pointer to global trace (node num) stacked contiguously.
Definition ComMod.h:1244
Immersed Boundary (IB) data type.
Definition ComMod.h:1257
Array< double > x
IB position coordinates.
Definition ComMod.h:1301
Array< double > Aun
Time derivative of displacement (new)
Definition ComMod.h:1310
int cpld
IB coupling.
Definition ComMod.h:1269
Array< double > Ku
LHS tangent matrix for displacement.
Definition ComMod.h:1340
int tnNo
Total number of IB nodes.
Definition ComMod.h:1283
Array< double > Un
Displacement (projected on background mesh, new, n+af)
Definition ComMod.h:1328
int cEq
Current equation.
Definition ComMod.h:1280
Array< double > R
Residual (FSI force)
Definition ComMod.h:1331
int intrp
IB interpolation method.
Definition ComMod.h:1273
Array< double > Uo
Displacement (projected on background mesh, old)
Definition ComMod.h:1325
Array< double > Yb
Velocity (new)
Definition ComMod.h:1304
Array< double > Ubn
Displacement (new)
Definition ComMod.h:1319
int cDmn
Current IB domain ID.
Definition ComMod.h:1277
double callD[4]
IB call duration (1: total time; 2: update; 3,4: communication)
Definition ComMod.h:1289
ibCommType cm
IB communicator.
Definition ComMod.h:1346
Vector< int > rowPtr
Row pointer (for sparse LHS matrix storage)
Definition ComMod.h:1295
Array< double > Rub
Residual (displacement, IB mesh)
Definition ComMod.h:1337
bool savedOnce
Whether any file being saved.
Definition ComMod.h:1261
Vector< int > dmnID
IB Domain ID.
Definition ComMod.h:1292
Array< double > Auo
Time derivative of displacement (old)
Definition ComMod.h:1307
Array< double > Ubk
Displacement (n+af)
Definition ComMod.h:1322
int nMsh
Number of IB meshes.
Definition ComMod.h:1286
int mthd
IB method.
Definition ComMod.h:1265
std::vector< mshType > msh
DERIVED class VARIABLES IB meshes;.
Definition ComMod.h:1343
Array< double > Ubo
Displacement (old)
Definition ComMod.h:1316
Vector< int > colPtr
Column pointer (for sparse LHS matrix storage)
Definition ComMod.h:1298
Array< double > Ru
Residual (displacement, background mesh)
Definition ComMod.h:1334
Array< double > Auk
Time derivative of displacement (n+am)
Definition ComMod.h:1313
Only to group four channels, in case I rather have them as one variable.
Definition ChnlMod.h:77
Linear system of equations solver type.
Definition ComMod.h:662
double absTol
Absolute tolerance (IN)
Definition ComMod.h:693
int cN
Number of |x| norms (OUT)
Definition ComMod.h:684
int cD
Number of <x.y> dot products (OUT)
Definition ComMod.h:687
double fNorm
Final norm of residual (OUT)
Definition ComMod.h:702
double callD
Calling duration (OUT)
Definition ComMod.h:708
int reserve
Only for data alignment (-)
Definition ComMod.h:690
bool suc
Successful solving (OUT)
Definition ComMod.h:669
int mItr
Maximum iterations (IN)
Definition ComMod.h:672
consts::SolverType LS_type
LS solver (IN)
Definition ComMod.h:666
int itr
Number of iteration (OUT)
Definition ComMod.h:678
double relTol
Relative tolerance (IN)
Definition ComMod.h:696
double dB
Res. rduction in last itr. (OUT)
Definition ComMod.h:705
int sD
Space dimension (IN)
Definition ComMod.h:675
int cM
Number of Ax multiple (OUT)
Definition ComMod.h:681
double iNorm
Initial norm of residual (OUT)
Definition ComMod.h:699
This is the container for a mesh or NURBS patch, those specific to NURBS are noted.
Definition ComMod.h:832
int nNo
Number of nodes (control points) for 2D elements?
Definition ComMod.h:893
Vector< double > w
Gauss weights.
Definition ComMod.h:953
std::vector< std::vector< int > > ordering
@breif ordering: node ordering for boundaries
Definition ComMod.h:911
Array< double > N
Parent shape function.
Definition ComMod.h:965
traceType trc
IB: tracers.
Definition ComMod.h:1008
Array3< double > Ys
Solution field (displacement, velocity, pressure, etc.) for a known, potentially time-varying,...
Definition ComMod.h:987
Vector< int > eDist
Element distribution between processors.
Definition ComMod.h:914
Vector< int > iGC
IB: Whether a cell is a ghost cell or not.
Definition ComMod.h:947
adjType nAdj
Mesh nodal adjacency.
Definition ComMod.h:993
Array< double > xib
Bounds on parameteric coordinates.
Definition ComMod.h:959
adjType eAdj
Mesh element adjacency.
Definition ComMod.h:996
int nG
Number of Gauss points for integration.
Definition ComMod.h:890
int nFa
Number of faces.
Definition ComMod.h:884
Array< double > x
Position coordinates (not always, however, as they get overwritten by read_vtu_pdata())
Definition ComMod.h:962
std::vector< fsType > fs
Function spaces (basis)
Definition ComMod.h:999
Array3< double > Nxx
Second derivatives of shape functions - used for shells & IGA davep double Nxx(:,:,...
Definition ComMod.h:983
int gnNo
Global number of nodes (control points) on a single mesh.
Definition ComMod.h:875
double dx
IB: Mesh size parameter.
Definition ComMod.h:908
bool lShpF
Whether the shape function is linear.
Definition ComMod.h:856
Vector< int > lN
Global to local maping tnNo --> nNo.
Definition ComMod.h:938
Vector< int > otnIEN
gIEN mapper from old to new
Definition ComMod.h:932
int nFn
Number of fiber directions.
Definition ComMod.h:902
Array< int > eIEN
Shells: extended IEN array with neighboring nodes.
Definition ComMod.h:941
Vector< int > gN
Global nodes maping nNo --> tnNo.
Definition ComMod.h:920
bool lFib
Whether the mesh is fibers (Purkinje)
Definition ComMod.h:862
int eNoN
Number of nodes (control points) in a single element.
Definition ComMod.h:869
double scF
Mesh scale factor.
Definition ComMod.h:905
Vector< int > eId
Element domain ID number.
Definition ComMod.h:917
int gnEl
Global number of elements (knot spans)
Definition ComMod.h:872
int nSl
Number of elements sample points to be outputs (NURBS)
Definition ComMod.h:896
Array< double > xi
Gauss integration points in parametric space.
Definition ComMod.h:956
Array< double > fN
Fiber orientations stored at the element level - used for electrophysiology and solid mechanics.
Definition ComMod.h:975
int nFs
Number of function spaces.
Definition ComMod.h:887
Array< int > sbc
Shells: boundary condition variable.
Definition ComMod.h:944
bool lShl
Whether the mesh is shell.
Definition ComMod.h:859
Array< double > Nb
Shape function bounds.
Definition ComMod.h:968
Array< double > nV
Normal vector to each nodal point (for Shells)
Definition ComMod.h:971
Vector< double > nW
Control points weights (NURBS)
Definition ComMod.h:950
Array3< double > Nx
Parent shape functions gradient double Nx(:,:,:)
Definition ComMod.h:979
std::vector< faceType > fa
Faces are stored in this variable.
Definition ComMod.h:1005
Vector< int > gpN
GLobal projected nodes mapping projected -> unprojected mapping.
Definition ComMod.h:923
Array< int > gIEN
Global connectivity array mappig eNoN,nEl --> gnNo.
Definition ComMod.h:926
int vtkType
The element type recognized by VTK format.
Definition ComMod.h:899
int nEl
Number of elements (knot spans)
Definition ComMod.h:881
consts::ElementType eType
Element type.
Definition ComMod.h:865
int nEf
Number of element face. Used for reading Gambit mesh files.
Definition ComMod.h:878
std::string name
Mesh Name.
Definition ComMod.h:990
std::vector< bsType > bs
BSpline in different directions (NURBS)
Definition ComMod.h:1002
Array< int > IEN
The connectivity array mapping eNoN,nEl --> nNo.
Definition ComMod.h:929
double qmTET4
TET4 quadrature modifier.
Definition ComMod.h:1011
Array< int > INN
Local knot pointer (NURBS)
Definition ComMod.h:935
Declared type for outputed variables.
Definition ComMod.h:640
Definition ComMod.h:122
Definition ComMod.h:1189
Vector< double > iNorm
Initial norm of an equation.
Definition ComMod.h:1226
int rTS
Time step from which remeshing is done.
Definition ComMod.h:1204
int freq
Time step frequency for forced remeshing.
Definition ComMod.h:1213
int cpVar
Time step freq for saving data.
Definition ComMod.h:1207
Array< double > A0
Copy of solution variables where remeshing starts.
Definition ComMod.h:1229
int cntr
Counter to track number of remesh done.
Definition ComMod.h:1201
std::vector< bool > flag
Flag is set if remeshing is required for each mesh.
Definition ComMod.h:1234
double time
Time where remeshing starts.
Definition ComMod.h:1216
consts::MeshGeneratorType method
Method for remeshing: 1-TetGen, 2-MeshSim.
Definition ComMod.h:1198
double minDihedAng
Mesh quality parameters.
Definition ComMod.h:1219
int fTS
Time step at which forced remeshing is done.
Definition ComMod.h:1210
Vector< double > maxEdgeSize
Edge size of mesh.
Definition ComMod.h:1223
bool isReqd
Whether remesh is required for problem or not.
Definition ComMod.h:1195
Fluid viscosity model type.
Definition ComMod.h:418
Structural domain type.
Definition ComMod.h:346
Tracer type used for immersed boundaries. Identifies traces of nodes and integration points on backgr...
Definition ComMod.h:486
Store options for output types.
Definition ComMod.h:616