1#ifndef CREATE_STRUCTUREMODEL__HH
2#define CREATE_STRUCTUREMODEL__HH
4#include <dune/composites/Setup/Cijkl.hh>
5#include <dune/composites/Setup/Region.hh>
7#include <dune/composites/Driver/Solvers/solver_info.hh>
8#include <dune/composites/Driver/Solvers/solvers.hh>
20 template <
typename YGRID>
25 typedef typename YGRID::LeafGridView YGV;
26 typedef Dune::FieldVector<double,3> FieldVec;
27 typedef Dune::FieldVector<double,6> Tensor2;
28 typedef Dune::FieldMatrix<double,6,6> Tensor4;
34 std::array<std::vector<double>,3> coords;
38 Dune::MPIHelper& helper;
39 std::vector<Tensor4> baseTensor;
43 std::vector<Material> myMaterials;
44 std::vector<Region>
R;
48 std::vector<Tensor4>
C;
61 std::vector<std::vector<double>> sig;
65 std::string vtk_displacement_output;
66 std::string vtk_stress_output;
67 std::string vtk_properties_output;
73 SolverInfo solverParameters;
77 bool failureCriterionDefined;
81 double gravity = 9.80665;
86 baseGridModel(Dune::MPIHelper& helper_,
bool GenEO =
false) : helper(helper_){
89 if (helper.size() > 1){
93 intOrder = config.get<
int>(
"fe.intOrder",5);
100 vtk_displacement_output =
"baseModel_displacement";
101 vtk_stress_output =
"baseModel_stress";
102 vtk_properties_output =
"baseModel_properties";
104 residualHeat =
false;
106 failureCriterionDefined =
false;
114 computeElasticTensors();
118 void inline sizeStressVector(
int nel){
120 for (
unsigned int i = 0; i < sig.size(); i++){
125 void inline setStress(
int id, Dune::FieldVector<double,6>& element_stress){
126 for (
int i = 0; i < 6; i++){
127 sig[id][i] = element_stress[i];
131 Dune::FieldVector<double,6>
inline getStress(
int id){
132 Dune::FieldVector<double,6> element_stress;
133 for (
int i = 0; i < 6; i++){
134 element_stress[i] = sig[id][i];
136 return element_stress;
139 int inline getIntOrder()
const {
148 int inline whichRegion(
const FieldVec& x){
152 for (
unsigned int k = 0; k <
R.size(); k++){
154 if (x[0] < Lx && flag ==
false){ ans = k; flag =
true; }
159 int inline whichLayer(FieldVec& x,
unsigned int r){
160 assert(r <
R.size());
164 for (
unsigned int k = 0; k <
R[r].layers.size(); k++){
165 z +=
R[r].layers[k].getThickness();
166 if (x[2] < z && flag ==
false){ ans = k; flag =
true; }
174 if(residualHeat !=
false){
175 double deltaT = -160.;
176 double alpha11 = -0.342 * 1e-6;
177 double alpha22 = 25.8 * 1e-6;
178 double alpha33 = 25.8 * 1e-6;
179 double alpharesin = 25.8 * 1e-6;
180 if(getMaterialTypeFromElement(
id) == 0){
181 f[0] = alpharesin*deltaT;
182 f[1] = alpharesin*deltaT;
183 f[2] = alpharesin*deltaT;
186 f[0] = alpha11*deltaT;
187 f[1] = alpha22*deltaT;
188 f[2] = alpha33*deltaT;
193 inline void evaluateWeight(Dune::FieldVector<double,3>& f,
int id)
const{
195 f[2] = - gravity * myMaterials[pg].density;
198 inline void setPressure(
double q_new) {
203 inline void evaluateNeumann(
const Dune::FieldVector<double,3> &x,Dune::FieldVector<double,3>& h,
const Dune::FieldVector<double,3>& normal)
const{
208 void inline setSolver(){
210 if (helper.size() > 1){
215 int inline getElements(
int i){
235 std::vector<int>
nel(3);
237 for (
int i = 0; i < 3; i++){
238 double h = 1. /
nel[i];
239 coords[i].resize(
nel[i] + 1);
241 for (
int j = 1; j <=
nel[i]; j++){
242 coords[i][j] = coords[i][j-1] + h;
257 ifstream csvFile(pathToCsv);
258 if(! csvFile)
throw std::runtime_error(
"Could not open file " + pathToCsv);
265 getline(csvFile, line);
266 istringstream lineStream(line);
268 for (
int j = 0; j < 2; j++){
270 getline(lineStream, item,
',');
271 if(helper.rank() == 0) std::cout << item << std::endl;
274 numRegions = atof(item.c_str());
275 if(helper.rank() == 0) std::cout <<
"Number of Regions = " << numRegions << std::endl;
276 R.resize(numRegions);
278 getline(csvFile, line);
279 istringstream lS2(line);
282 getline(lS2, item,
',');
283 getline(lS2, item,
',');
284 maxPly = atof(item.c_str());
285 if(helper.rank() == 0) std::cout <<
"maxPly = " << maxPly << std::endl;
287 getline(csvFile, line);
288 istringstream lS3(line);
289 for (
int j = 0; j < 4; j++){
291 getline(lS3, item,
',');
296 if(helper.rank() == 0) std::cout <<
"periodic = " <<
periodic << std::endl;
298 for(
int j = 0; j < numRegions; j++){
301 R[j].setNumLayers(maxPly);
302 getline(csvFile, line); getline(csvFile, line);
303 int numParameters = 1;
304 istringstream lS4(line);
305 for (
int ii = 0; ii < numParameters; ii++){
306 getline(lS4, item,
',');
308 R[j].setType(atof(item.c_str()));
309 numParameters =
R[j].numParameters;
312 R[j].setParameter(ii-1,atof(item.c_str()));
316 for (
int k = 0; k < maxPly; k++){
318 getline(csvFile, line);
319 istringstream lS5(line);
320 getline(lS5,item,
',');
321 R[j].layers[k].setElements(atof(item.c_str()));
324 getline(lS5,item,
',');
327 R[j].layers[k].setMaterial(atof(item.c_str()) );
328 getline(lS5,item,
',');
329 R[j].layers[k].setThickness(atof(item.c_str()));
332 getline(lS5,item,
',');
333 R[j].layers[k].setOrientation(atof(item.c_str()));
348 std::vector<double>
meshRatio(
int N,
double scaling,
int direction){
350 std::vector<double> h(N);
351 for(
int i = 0; i < N; i++)
359 if(scaling<1) k = 1.0/scaling;
360 std::vector<double> h(N);
361 double h0 = 1./N*1./(1.+(k-1)/2.);
362 for(
int i = 0; i < N; i++){
363 h[i] = (i*(k-1)/(N-1)+1.0)*h0;
366 std::vector<double> h2(N);
367 for(
int i = 0; i< N; i++){
384 std::vector<double> h(N), a(M);
386 if(scaling<1) k2 = 1.0/scaling;
387 for(
int i = 0; i < M; i++){
388 a[i] = float(i)*(k2-1)/(M-1)+1.;
390 double h0 = 1./M*1./(1.+(k2-1)/2.);
391 for(
int i = 0; i < M; i++){
393 h[N-1 - i] = a[i]*h0/2.;
397 for(
int i = 0; i< M; i++){
415 void inline GeometryBuilder(std::vector<Dune::FieldVector<int,3>> directions, std::vector<Dune::FieldVector<double,3>> grading){
417 if(helper.rank() == 0) std::cout <<
"=== Building Geometry" << std::endl;
419 Dune::FieldVector<double,3> origin(0.0);
422 int numRegions =
R.size();
425 int nely =
R[0].nel[1];
427 for (
int i = 0; i < numRegions;i++){
429 assert(
R[i].
nel[1] == nely);
432 if(helper.rank() == 0) std::cout <<
"Elements in x direction " << std::endl;
434 coords[0].resize(nelx + 1);
435 coords[0][0] = origin[0];
438 for (
int i = 0; i < numRegions; i++){
439 auto hx =
meshRatio(
R[i].
nel[0], grading[i][0], directions[i][0]);
440 R[i].nel[0] = hx.size();
441 for (
int j = 0; j <
R[i].nel[0]; j++){
442 coords[0][k] = coords[0][k-1] +
R[i].L[0] * hx[j];
448 coords[1].resize(nely + 1);
449 coords[1][0] = origin[0];
450 auto hy =
meshRatio(
R[0].
nel[1], grading[0][1],directions[0][1]);
451 for (
int j = 1; j <
R[0].nel[1] + 1; j++){
452 coords[1][j] = coords[1][j-1] +
R[0].L[1] * hy[j-1];
458 for (
unsigned int i = 0; i <
R[0].layers.size(); i++){
460 nelz +=
R[0].layers[i].getElements();
462 coords[2].resize(nelz + 1);
463 coords[2][0] = origin[2];
466 for (
unsigned int i = 0; i <
R[0].layers.size(); i++){
467 auto hz =
meshRatio(
R[0].layers[i].getElements(), grading[0][2], directions[0][2]);
468 for (
int k = 0; k <
R[0].layers[i].getElements(); k++){
470 coords[2][e] = coords[2][e-1] +
R[0].layers[i].getThickness() * hz[k];
473 R[0].L[2] = coords[2][e];
477 void inline GeometryBuilder(){
479 if(helper.rank() == 0) std::cout <<
"=== Building Geometry" << std::endl;
481 Dune::FieldVector<double,3> origin(0.0);
484 int numRegions =
R.size();
487 int nely =
R[0].nel[1];
489 for (
int i = 0; i < numRegions;i++){
491 assert(
R[i].
nel[1] == nely);
494 if(helper.rank() == 0) std::cout <<
"Elements in x direction " << std::endl;
496 coords[0].resize(nelx + 1);
497 coords[0][0] = origin[0];
501 for (
int i = 0; i < numRegions; i++){
502 double hx =
R[i].L[0] /
R[i].nel[0];
503 for (
int j = 0; j <
R[i].nel[0]; j++){
504 coords[0][k] = coords[0][k-1] + hx;
510 coords[1].resize(nely + 1);
511 coords[1][0] = origin[0];
512 double hy =
R[0].L[1] /
R[0].nel[1];
513 for (
int j = 1; j <
R[0].nel[1] + 1; j++){
514 coords[1][j] = coords[1][j-1] + hy;
520 for (
unsigned int i = 0; i <
R[0].layers.size(); i++){
522 nelz +=
R[0].layers[i].getElements();
524 coords[2].resize(nelz + 1);
525 coords[2][0] = origin[2];
528 for (
unsigned int i = 0; i <
R[0].layers.size(); i++){
529 double hz =
R[0].layers[i].getThickness() /
R[0].layers[i].getElements();
530 for (
int k = 0; k <
R[0].layers[i].getElements(); k++){
532 coords[2][e] = coords[2][e-1] + hz;
535 R[0].L[2] = coords[2][e];
539 int inline getSizeCoords(
int i){
540 return coords[i].size();
544 void setUpMaterials(){
549 myMaterials[0].setType(0);
550 myMaterials[0].setProp(0,10000.);
551 myMaterials[0].setProp(1,0.35);
552 myMaterials[0].setDensity(1.57e-5);
555 myMaterials[1].setType(1);
556 myMaterials[1].setProp(0,162000.);
557 myMaterials[1].setProp(1,10000.);
558 myMaterials[1].setProp(2,10000.);
559 myMaterials[1].setProp(3,0.35);
560 myMaterials[1].setProp(4,0.35);
561 myMaterials[1].setProp(5,0.49);
562 myMaterials[1].setProp(6,5200.);
563 myMaterials[1].setProp(7,5200.);
564 myMaterials[1].setProp(8,3500.);
565 myMaterials[1].setDensity(1.57e-5);
568 myMaterials[2].setType(0);
569 myMaterials[2].setProp(0,10000000.);
570 myMaterials[2].setProp(1,0.35);
571 myMaterials[2].setDensity(1.57e-5);
575 double inline FailureCriteria(Dune::FieldVector<double,6>& stress)
const{
580 void assignMaterials(std::vector<int>& PGin_){
582 rot123.resize(PGin_.size());
583 for(
int id = 0;
id < PGin_.size();
id++){
590 void computeTensorsOnGrid(
const GV& gv){
591 typedef typename GV::Traits::template Codim<0>::Iterator ElementIterator;
592 const typename GV::IndexSet& is = gv.indexSet();
593 C.resize(gv.size(0));
595 for (ElementIterator it = gv.template begin<0>(); it!=gv.template end<0>(); ++it){
596 int id = is.index(*it);
599 C[id] = TensorRotation(baseTensor[pg],
rot123[
id],2);
604 template <
class GV,
class GV2>
605 void computeTensorsOnGrid(
const GV& gv,
const GV2& gv2){
607 typedef typename GV::Traits::template Codim<0>::Iterator ElementIterator;
608 const typename GV::IndexSet& is = gv.indexSet();
609 C.resize(gv.size(0));
612 auto it2 = gv2.template begin<0>();
614 for (ElementIterator it = gv.template begin<0>(); it!=gv.template end<0>(); ++it)
616 int id = is.index(*it);
618 C[id] = TensorRotation(baseTensor[pg],
rot123[
id],2);
623 inline FieldVec gridTransformation(
const FieldVec & x)
const{
629 std::array<int, 3>
inline GridPartition(){
631 std::array<int, 3> Partitioning;
632 std::fill(Partitioning.begin(),Partitioning.end(), 1);
636 void inline setPG(
const YGV& ygv){
638 rot123.resize(ygv.size(0));
640 for (
const auto& eit : elements(ygv)){
641 int id = ygv.indexSet().index(eit);
642 auto point = eit.geometry().center();
644 int theRegion = whichRegion(point);
645 int theLayer = whichLayer(point,theRegion);
646 elemIndx2PG[id] =
R[theRegion].layers[theLayer].getMaterial();
647 rot123[id] =
R[theRegion].layers[theLayer].getOrientation();
648 for(
int i = 0; i < eit.geometry().corners(); i++){
649 auto pc = eit.geometry().corner(i);
658 int inline getMaterialType(
int whichMaterial){
660 return myMaterials[whichMaterial].Type;
663 int inline setPhysicalGroup(FieldVec& x){
667 void inline computeElasticTensors(){
671 baseTensor[i] = Cijkl(myMaterials[i]);
676 Tensor4 TensorRotation(Tensor4& baseC,
double theta,
int i_dim)
const
678 Tensor4 locC = baseC;
679 Tensor4 R2(0.0),R2T(0.0);
682 double c = cos(theta*M_PI/180.0);
683 double s = sin(theta*M_PI/180.0);
684 Dune::FieldMatrix<double,3,3> A;
685 if(i_dim == 2) A = {{c,s,0},{-s,c,0},{0,0,1}};
686 if(i_dim == 1) A = {{c,0,-s},{0,1,0},{s,0,c}};
687 if(i_dim == 0) A = {{1,0,0},{0,c,s},{0,-s,c}};
691 transpose<Tensor4,6>(R2,R2T);
694 locC.leftmultiply(R2);
695 locC.rightmultiply(R2T);
699 Tensor4 TensorRotationLeft(Tensor4& C_local,
double theta,
int i_dim)
const{
700 Tensor4 locC = C_local;
701 Tensor4 R2(0.0),R2T(0.0);
704 double c = cos(theta*M_PI/180.0);
705 double s = sin(theta*M_PI/180.0);
706 Dune::FieldMatrix<double,3,3> A;
707 if(i_dim == 2) A = {{c,s,0},{-s,c,0},{0,0,1}};
708 if(i_dim == 1) A = {{c,0,-s},{0,1,0},{s,0,c}};
709 if(i_dim == 0) A = {{1,0,0},{0,c,s},{0,-s,c}};
715 locC.leftmultiply(R2);
719 Tensor4 TensorRotationRight(Tensor4& C_local,
double theta,
int i_dim)
const{
720 Tensor4 locC = C_local;
721 Tensor4 R2(0.0),R2T(0.0);
724 double c = cos(theta*M_PI/180.0);
725 double s = sin(theta*M_PI/180.0);
726 Dune::FieldMatrix<double,3,3> A;
727 if(i_dim == 2) A = {{c,s,0},{-s,c,0},{0,0,1}};
728 if(i_dim == 1) A = {{c,0,-s},{0,1,0},{s,0,c}};
729 if(i_dim == 0) A = {{1,0,0},{0,c,s},{0,-s,c}};
733 transpose<Tensor4,6>(R2,R2T);
736 locC.rightmultiply(R2T);
742 Tensor4 getMatrix(Dune::FieldMatrix<double,3,3> A)
const{
744 R[0][0] = A[0][0]*A[0][0];
R[0][1] = A[0][1]*A[0][1];
R[0][2] = A[0][2]*A[0][2];
745 R[1][0] = A[1][0]*A[1][0];
R[1][1] = A[1][1]*A[1][1];
R[1][2] = A[1][2]*A[1][2];
746 R[2][0] = A[2][0]*A[2][0];
R[2][1] = A[2][1]*A[2][1];
R[2][2] = A[2][2]*A[2][2];
748 R[0][3] = 2.0*A[0][1]*A[0][2];
R[0][4] = 2.0*A[0][0]*A[0][2];
R[0][5] = 2.0*A[0][0]*A[0][1];
749 R[1][3] = 2.0*A[1][1]*A[1][2];
R[1][4] = 2.0*A[1][0]*A[1][2];
R[1][5] = 2.0*A[1][0]*A[1][1];
750 R[2][3] = 2.0*A[2][1]*A[2][2];
R[2][4] = 2.0*A[2][0]*A[2][2];
R[2][5] = 2.0*A[2][0]*A[2][1];
752 R[3][0] = A[1][0]*A[2][0];
R[3][1] = A[1][1]*A[2][1];
R[3][2] = A[1][2]*A[2][2];
753 R[4][0] = A[0][0]*A[2][0];
R[4][1] = A[0][1]*A[2][1];
R[4][2] = A[0][2]*A[2][2];
754 R[5][0] = A[0][0]*A[1][0];
R[5][1] = A[0][1]*A[1][1];
R[5][2] = A[0][2]*A[1][2];
756 R[3][3] = A[1][1]*A[2][2]+A[1][2]*A[2][1];
R[3][4] = A[1][0]*A[2][2]+A[1][2]*A[2][0];
R[3][5] = A[1][0]*A[2][1]+A[1][1]*A[2][0];
757 R[4][3] = A[0][1]*A[2][2]+A[2][1]*A[0][2];
R[4][4] = A[0][0]*A[2][2]+A[2][0]*A[0][2];
R[4][5] = A[2][0]*A[0][1]+A[2][1]*A[0][0];
758 R[5][3] = A[0][1]*A[1][2]+A[0][2]*A[1][1];
R[5][4] = A[0][0]*A[1][2]+A[0][2]*A[1][0];
R[5][5] = A[0][0]*A[1][1]+A[0][1]*A[1][0];
765 Tensor4
inline getElasticTensor(
int id)
const {
return C[id]; }
767 std::vector<double> returnTheta(
const FieldVec& x)
const{
770 FieldVec xph = x; xph[0] += h/2.;
771 FieldVec xmh = x; xmh[0] -= h/2.;
772 y = gridTransformation(xph);
773 yph = gridTransformation(xmh);
774 auto angle = atan2((yph[2]-y[2])/h,(yph[0]-y[0])/h);
775 std::vector<double> theta(3);
800 double inline getMaterialTypeFromElement(
int id)
const{
802 return myMaterials[pg].Type;
805 double inline getOrientation(
int id)
const {
return rot123[id];}
807 template<
class GO,
class U,
class GFS,
class C,
class MBE,
class GV>
808 void inline postprocess(
const GO& go, U& u,
const GFS& gfs,
const C& cg,
const GV gv, MBE& mbe){
812 template<
class GO,
class GO_EXT,
class V,
class GFS,
class GFS_EXT,
class C,
class CON,
class MBE,
class LOP>
813 bool inline solve(GO& go, V& u,
const GFS& gfs,
const GFS_EXT& gfs_ext,
C& cg, CON& constraints, MBE& mbe, LOP& lop){
816 if(solverParameters.UG ==
true){
817 typedef Dune::PDELab::ISTLBackend_NOVLP_CG_AMG_SSOR<GO> NOVLP_AMG;
818 NOVLP_AMG ls(go,500,2);
819 Dune::PDELab::StationaryLinearProblemSolver<GO,NOVLP_AMG,V> slp(go,ls,u,solverParameters.KrylovTol);
823 if(gfs.gridView().comm().size() > 1){
824 if(solverParameters.preconditioner ==
"GenEO"){
825#if HAVE_SUITESPARSE and HAVE_ARPACKPP
826 if(gfs.gridView().comm().rank() == 0) std::cout <<
"Starting solve with Geneo Preconditioner" << std::endl;
827 typedef Dune::Geneo::CG_GenEO<V,GFS,GFS_EXT,GO,GO_EXT,LOP,CON,MBE> GenEO;
828 int cells = std::pow(gfs.gridView().size(0),1./3.);
829 GenEO mysolver(u,gfs,gfs_ext,lop,constraints,mbe,solverParameters,helper, cells);
833 if(gfs.gridView().comm().rank() == 0) std::cout <<
"GenEO solver requires UMFPack and Arpack." << std::endl;
836 if(solverParameters.preconditioner ==
"OneLevel_AdditiveSchwarz"){
838 typedef Dune::PDELab::ISTLBackend_OVLP_CG_UMFPack<GFS, C> PAR_UMF;
839 PAR_UMF ls(gfs,cg,solverParameters.MaxIt,solverParameters.verb);
840 Dune::PDELab::StationaryLinearProblemSolver<GO,PAR_UMF,V> slp(go,ls,u,solverParameters.KrylovTol);
844 if(gfs.gridView().comm().rank() == 0) std::cout <<
"PAR_UMFPack solver not available" << std::endl;
848 if(solverParameters.solver ==
"Hypre"){
850 typedef typename GO::Jacobian Matrix;
855 HypreSolver<GFS, Matrix, V> solver(gfs,u,a,b, solverParameters.KrylovTol);
860 if(gfs.gridView().comm().rank() == 0) std::cout <<
"Hypre solver not available" << std::endl;
863 if(gfs.gridView().comm().size() == 1){
864 if(solverParameters.solver ==
"UMFPack"){
866 typedef Dune::PDELab::ISTLBackend_SEQ_UMFPack SEQ_UMF;
868 Dune::PDELab::StationaryLinearProblemSolver<GO, SEQ_UMF,V> slp(go,ls,u,1e-6);
871 if(gfs.gridView().comm().rank() == 0) std::cout <<
"SEQ_UMFPack solver not available" << std::endl;
875 if(solverParameters.preconditioner ==
"AMG"){
876 typedef Dune::PDELab::ISTLBackend_SEQ_CG_AMG_SSOR<GO> SEQ_CG_AMG_SSOR;
878 Dune::PDELab::StationaryLinearProblemSolver<GO,SEQ_CG_AMG_SSOR,V> slp(go,ls,u,
tolerance);
structuredGridModel class.
Definition: baseGridModel.hh:21
void LayerCakeFromFile(string pathToCsv)
Function to read LayerCake from File.
Definition: baseGridModel.hh:255
std::vector< double > meshRatio(int N, double scaling, int direction)
Function defining mesh grading.
Definition: baseGridModel.hh:348
std::vector< Tensor4 > C
Vector defining rotation of ply in material coordinates.
Definition: baseGridModel.hh:48
void setThermal(bool t)
returns true when thermal strain is applied
Definition: baseGridModel.hh:144
bool stress_Plot_ascii
Variable if stress is plotted out in vtk format.
Definition: baseGridModel.hh:63
int solver_tolerance
Variable which controls solver type (UMFPack for sequential and GENEO for parallel)
Definition: baseGridModel.hh:53
int Krylov_Verb
Tolerance of Solver (ignored for a direct solver)
Definition: baseGridModel.hh:54
int solver_type
Tolerance of iterative solver.
Definition: baseGridModel.hh:52
std::vector< double > rot123
std::vector containing information of each material defined
Definition: baseGridModel.hh:47
baseGridModel(Dune::MPIHelper &helper_, bool GenEO=false)
The main constructor.
Definition: baseGridModel.hh:86
std::vector< int > elemIndx2PG
std::vector containing information of each Region
Definition: baseGridModel.hh:46
std::vector< int > nel
Gaussian order of integration (default value is 5)
Definition: baseGridModel.hh:69
std::bitset< 3 > periodic
Array which stores periodicity of grid in each of the 3 dimensions, default value are set to all fals...
Definition: baseGridModel.hh:37
int solver_verb
Variable define max iterations.
Definition: baseGridModel.hh:56
bool isMPC(FieldVec &x)
A function which returns whether a point is constrained by a multi-point-constraint.
Definition: baseGridModel.hh:790
double evaluateDirichlet(const FieldVec &x, int dof) const
returns the Dirichlet boundary value at a point for the degree of freedom dof.
Definition: baseGridModel.hh:795
int overlap
Size of overlap between subdomains for domain decomposition.
Definition: baseGridModel.hh:32
std::vector< double > stackSeq
Set whether to use residual heat stresses, default false.
Definition: baseGridModel.hh:60
void LayerCake()
A member taking which constructs the base layered laminate in untransformed coordinates.
Definition: baseGridModel.hh:227
bool isParallel
Number of elements in each direction.
Definition: baseGridModel.hh:70
bool verbosity
Vector storing elastic tensor within each element.
Definition: baseGridModel.hh:50
void evaluateNeumann(const Dune::FieldVector< double, 3 > &x, Dune::FieldVector< double, 3 > &h, const Dune::FieldVector< double, 3 > &normal) const
function which evaluates the Neumann boundary conditions at the point x
Definition: baseGridModel.hh:203
int numMaterials
Number of Different types of materials defined for applications.
Definition: baseGridModel.hh:42
std::vector< Region > R
std::vector containing information of each material defined
Definition: baseGridModel.hh:44
int Krylov_Max_It
Variable Controlling Verbosity of Krylov Solver.
Definition: baseGridModel.hh:55
bool isDirichlet(FieldVec &x, int dof)
Definition: baseGridModel.hh:782
double q
Instance of SolverInfo to define solver parameters and store solver results e.g. iterations,...
Definition: baseGridModel.hh:75
double tolerance
Variable controls level of output to interface.
Definition: baseGridModel.hh:51
void evaluateHeat(Tensor2 &f, int id) const
Function which evaluates the thermal stress tensor sig_thermal on an element.
Definition: baseGridModel.hh:172
bool setUp_Required
Boolean variable which indicates if run is parallel or not, this later will allow to run multiple sol...
Definition: baseGridModel.hh:71