Nektar++
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Pages
Functions | Variables
CompressibleBL.cpp File Reference
#include <cstdio>
#include <cstdlib>
#include <string>
#include <iostream>
#include <iomanip>
#include <cmath>
#include <MultiRegions/ExpList.h>
#include <MultiRegions/ExpList1D.h>
#include <MultiRegions/ExpList2D.h>
#include <MultiRegions/ExpList2DHomogeneous1D.h>
#include <MultiRegions/ExpList3DHomogeneous1D.h>
#include <MultiRegions/ExpList3DHomogeneous2D.h>
#include <MultiRegions/ExpList3D.h>
#include <MultiRegions/AssemblyMap/AssemblyMapDG.h>
#include <MultiRegions/ContField2D.h>
#include <MultiRegions/ContField3D.h>
#include <MultiRegions/DisContField2D.h>
#include <MultiRegions/DisContField3D.h>
#include <LocalRegions/MatrixKey.h>
#include <LocalRegions/Expansion2D.h>
#include <LocalRegions/Expansion3D.h>
#include <LocalRegions/Expansion.h>
#include <LibUtilities/BasicUtils/FieldIO.h>
#include <LibUtilities/BasicUtils/NekFactory.hpp>
#include <LibUtilities/BasicUtils/SessionReader.h>
#include <LibUtilities/BasicUtils/SharedArray.hpp>
#include <LibUtilities/Communication/Comm.h>
#include <LibUtilities/Memory/NekMemoryManager.hpp>
#include <SpatialDomains/MeshGraph2D.h>
#include <SpatialDomains/MeshGraph3D.h>
#include <SolverUtils/SolverUtilsDeclspec.h>
Include dependency graph for CompressibleBL.cpp:

Go to the source code of this file.

Functions

void COMPBL (Array< OneD, NekDouble > v, Array< OneD, NekDouble > dv)
 
void RK4 (Array< OneD, NekDouble > y, Array< OneD, NekDouble > dydx, int n, NekDouble x, NekDouble h, Array< OneD, NekDouble > yout)
 
void RKDUMB (Array< OneD, NekDouble > vstart, int nvar, NekDouble x1, NekDouble x2, int m_xpoints, Array< OneD, NekDouble > xx, Array< OneD, Array< OneD, NekDouble > > y)
 
void OUTPUT (int m_xpoints, Array< OneD, NekDouble > xx, Array< OneD, Array< OneD, NekDouble > > ff, int nQuadraturePts, Array< OneD, NekDouble > x_QuadraturePts, Array< OneD, NekDouble > y_QuadraturePts, Array< OneD, NekDouble > u_QuadraturePts, Array< OneD, NekDouble > v_QuadraturePts, Array< OneD, NekDouble > rho_QuadraturePts, Array< OneD, NekDouble > T_QuadraturePts)
 
int main (int argc, char *argv[])
 

Variables

NekDouble m_Re
 
NekDouble m_Mach
 
NekDouble L
 
NekDouble m_Tinf
 
NekDouble m_Suth
 
NekDouble m_Tw
 
NekDouble m_Twall
 
NekDouble m_Gamma
 
NekDouble m_Pr
 
NekDouble m_long
 
NekDouble m_uInf
 
NekDouble m_rhoInf
 
NekDouble m_R
 
NekDouble m_vInf
 
NekDouble m_mu
 
NekDouble m_To = 273.11
 
const int m_xpoints = 1000001
 
const NekDouble Nvisc = 1
 
const NekDouble Omega = 1
 
const NekDouble etamax = 10.0
 
const NekDouble errtol = 1e-5
 

Function Documentation

void COMPBL ( Array< OneD, NekDouble v,
Array< OneD, NekDouble dv 
)

Calculate the compressible boundary layer using the similarity solution

Definition at line 105 of file CompressibleBL.cpp.

References m_Gamma, m_Mach, m_Pr, m_Suth, m_Twall, Nvisc, and Omega.

Referenced by OUTPUT(), RK4(), and RKDUMB().

107 {
108  NekDouble c, dcdg, cp;
109 
110  if (Nvisc == 1)
111  {
112  c = sqrt(v[3]) * (1.0 + m_Suth) / (v[3] + m_Suth);
113  dcdg = 1.0 / (2. * sqrt(v[3])) - sqrt(v[3]) / (v[3]+m_Suth);
114  dcdg = dcdg * (1.0 + m_Suth) / (v[3] + m_Suth);
115  cp = dcdg * v[4];
116  }
117  if (Nvisc == 2)
118  {
119  c = pow(v[3], (Omega-1.0));
120  dcdg = (Omega - 1.0) * pow(v[3], (Omega - 2.0));
121  cp = dcdg * v[4];
122  }
123  if (Nvisc == 3)
124  {
125  c = sqrt(m_Twall) * (1.0 + m_Suth) / (m_Suth + m_Twall);
126  cp = 0.0;
127  }
128 
129  dv[0] = v[1];
130  dv[1] = v[2];
131  dv[2] = - v[2] * (cp + v[0]) / c;
132  dv[3] = v[4];
133  dv[4] = - v[4] * (cp + m_Pr * v[0]) / c -
134  m_Pr * (m_Gamma - 1.0) * pow(m_Mach, 2.0) *
135  pow(v[2], 2);
136 }
NekDouble m_Mach
const NekDouble Omega
NekDouble m_Twall
NekDouble m_Pr
double NekDouble
NekDouble m_Suth
const NekDouble Nvisc
NekDouble m_Gamma
int main ( int  argc,
char *  argv[] 
)

Calculate the compressible boundary layer solution for a given 3D mesh and dump the solution into a .rst file.

Definition at line 363 of file CompressibleBL.cpp.

References Nektar::MemoryManager< DataType >::AllocateSharedPtr(), ASSERTL0, Nektar::LibUtilities::SessionReader::CreateInstance(), errtol, etamax, m_Gamma, m_long, m_Mach, m_mu, m_Pr, m_R, m_Re, m_rhoInf, m_Suth, m_Tinf, m_Tw, m_Twall, m_uInf, m_vInf, m_xpoints, OUTPUT(), Nektar::SpatialDomains::MeshGraph::Read(), RKDUMB(), Vmath::Vcopy(), and Nektar::LibUtilities::Write().

364 {
365  // Variable initialisation
366  int nmax = 5;
367  int maxit = 10;
368 
369  string opt;
370 
371  int i, j, k, numModes;
372 
375  Array<OneD, NekDouble> parameter(9, 0.0);
376 
377  for (i = 0; i < nmax; i++)
378  {
380  }
381 
382  Array<OneD, NekDouble > vstart(nmax, 0.0);
388 
389  NekDouble al11, al21, al12, al22, det;
390 
391  // Reading the session file
393  = LibUtilities::SessionReader::CreateInstance(argc, argv);
394 
395  // Read in mesh from input file and create an object of class MeshGraph
397  = SpatialDomains::MeshGraph::Read(vSession);
398 
399  int expdim = graphShPt->GetMeshDimension();
400 
401  int nElements, nQuadraturePts = 0;
402  Array<OneD, NekDouble> x_QuadraturePts;
403  Array<OneD, NekDouble> y_QuadraturePts;
404  Array<OneD, NekDouble> z_QuadraturePts;
405 
406  if (expdim == 2)
407  {
409  ::AllocateSharedPtr(vSession);
410 
413  ::AllocateSharedPtr(vSession, graphShPt,
414  vSession->GetVariable(0));
415 
416  // Get the total number of elements
417  nElements = Domain->GetExpSize();
418  std::cout << "Number of elements = "
419  << nElements << std::endl;
420 
421  // Get the total number of quadrature points (depends on n. modes)
422  nQuadraturePts = Domain->GetTotPoints();
423  std::cout << "Number of quadrature points = "
424  << nQuadraturePts << std::endl;
425 
426  // Coordinates of the quadrature points
427  x_QuadraturePts = Array<OneD, NekDouble>(nQuadraturePts);
428  y_QuadraturePts = Array<OneD, NekDouble>(nQuadraturePts);
429  z_QuadraturePts = Array<OneD, NekDouble>(nQuadraturePts);
430  Domain->GetCoords(x_QuadraturePts, y_QuadraturePts, z_QuadraturePts);
431  }
432  else if (expdim == 3)
433  {
435  ::AllocateSharedPtr(vSession);
436 
439  ::AllocateSharedPtr(vSession, graphShPt, vSession->GetVariable(0));
440 
441  // Get the total number of elements
442  nElements = Domain->GetExpSize();
443  std::cout << "Number of elements = "
444  << nElements << std::endl;
445 
446  // Get the total number of quadrature points (depends on n. modes)
447  nQuadraturePts = Domain->GetTotPoints();
448  std::cout << "Number of quadrature points = "
449  << nQuadraturePts << std::endl;
450 
451  // Coordinates of the quadrature points
452  x_QuadraturePts = Array<OneD, NekDouble>(nQuadraturePts);
453  y_QuadraturePts = Array<OneD, NekDouble>(nQuadraturePts);
454  z_QuadraturePts = Array<OneD, NekDouble>(nQuadraturePts);
455  Domain->GetCoords(x_QuadraturePts, y_QuadraturePts, z_QuadraturePts);
456  }
457  else
458  {
459  ASSERTL0(false, "Routine available for 2D and 3D problem only.")
460  }
461 
462  // Loading parameters from session file
463  vSession->LoadParameter("Re", m_Re, 1.0);
464  vSession->LoadParameter("Mach", m_Mach, 1.0);
465  vSession->LoadParameter("TInf", m_Tinf, 1.0);
466  vSession->LoadParameter("Twall", m_Twall, 1.0);
467  vSession->LoadParameter("Gamma", m_Gamma, 1.0);
468  vSession->LoadParameter("Pr", m_Pr, 1.0);
469  vSession->LoadParameter("L", m_long, 1.0);
470  vSession->LoadParameter("rhoInf", m_rhoInf, 1.0);
471  vSession->LoadParameter("uInf", m_uInf, 1.0);
472  vSession->LoadParameter("GasConstant", m_R, 1.0);
473  vSession->LoadParameter("vInf", m_vInf, 1.0);
474  vSession->LoadParameter("mu", m_mu, 1.0);
475 
476  // Rescaling factors
477  m_Suth = 110.4 / m_Tinf;
478  m_Tw = m_Twall / m_Tinf;
479  m_Re = m_Re / m_long;
480 
481  cout << "Number of points" << " " << m_xpoints << endl;
482 
483  // Defining the solution arrays
484  Array<OneD, NekDouble> u_QuadraturePts (nQuadraturePts, 0.0);
485  Array<OneD, NekDouble> v_QuadraturePts (nQuadraturePts, 0.0);
486  Array<OneD, NekDouble> rho_QuadraturePts(nQuadraturePts, 0.0);
487  Array<OneD, NekDouble> T_QuadraturePts (nQuadraturePts, 0.0);
488 
489  // Calculation of the similarity variables
490  if (m_Tw > 0)
491  {
492  vstart[3] = m_Tw;
493  }
494  if (m_Tw < 0.0)
495  {
496  v[1] = 1.0 + 0.5 * 0.84 * (m_Gamma - 1) * (m_Mach * m_Mach);
497  v[0] = 0.47 * pow(v[1], 0.21);
498  }
499  else
500  {
501  v[1] = 0.062 * pow(m_Mach, 2) - 0.1 * (m_Tw - 1.0) *
502  (10 + m_Mach) / (0.2 + m_Mach);
503  v[0] = 0.45 - 0.01 * m_Mach + (m_Tw - 1.0) * 0.06;
504  m_Twall = m_Tw;
505  }
506 
507  dv[0] = v[0] * 0.01;
508 
509  if (m_Tw < 0.0)
510  {
511  dv[1] = v[1] * 0.01;
512  }
513  else
514  {
515  dv[1] = 0.1;
516  }
517 
518  vstart[2] = v[0];
519 
520  if (m_Tw < 0)
521  {
522  vstart[3] = v[1];
523  m_Twall = vstart[3];
524  }
525  else
526  {
527  vstart[4] = v[1];
528  }
529 
530  RKDUMB(vstart, 5, 0.0, etamax, m_xpoints, xx, ff);
531 
532  for (k = 0; k < maxit; k++)
533  {
534  vstart[2] = v[0];
535 
536  if (m_Tw < 0)
537  {
538  vstart[3] = v[1];
539  m_Twall = vstart[3];
540  }
541  else
542  {
543  vstart[4] = v[1];
544  }
545 
546  RKDUMB(vstart, 5, 0.0, etamax, m_xpoints, xx, ff);
547 
548  NekDouble err = fabs(ff[1][m_xpoints] - 1) +
549  fabs(ff[3][m_xpoints] - 1);
550 
551  cout << "err" << scientific << setprecision(9) << " " << err << endl;
552 
553  if (expdim == 2)
554  {
555  if (err < errtol)
556  {
557  cout << "Calculating" << endl;
558  OUTPUT(m_xpoints, xx, ff, nQuadraturePts, x_QuadraturePts,
559  y_QuadraturePts, u_QuadraturePts, v_QuadraturePts,
560  rho_QuadraturePts, T_QuadraturePts);
561  break;
562  }
563  else
564  {
565  f[0] = ff[1][m_xpoints] - 1;
566  f[1] = ff[3][m_xpoints] - 1;
567  vstart[2] = v[0] + dv[0];
568 
569  if (m_Tw < 0)
570  {
571  vstart[3] = v[1];
572  m_Twall = vstart[3];
573  }
574  else
575  {
576  vstart[4] = v[1];
577  }
578 
579  RKDUMB(vstart, 5, 0.0, etamax, m_xpoints, xx, ff);
580 
581  f1[0] = ff[1][m_xpoints] - 1;
582  f1[1] = ff[3][m_xpoints] - 1;
583 
584  vstart[2] = v[0];
585 
586  if (m_Tw < 0)
587  {
588  vstart[3] = v[1] + dv[1];
589  m_Twall = vstart[3];
590  }
591  else
592  {
593  vstart[4] = v[1] + dv[1];
594  }
595 
596  RKDUMB(vstart, 5, 0.0, etamax, m_xpoints, xx, ff);
597 
598  f2[0] = ff[1][m_xpoints] - 1;
599  f2[1] = ff[3][m_xpoints] - 1;
600 
601  al11 = (f1[0] - f[0]) / dv[0];
602  al21 = (f1[1] - f[1]) / dv[0];
603  al12 = (f2[0] - f[0]) / dv[1];
604  al22 = (f2[1] - f[1]) / dv[1];
605  det = al11 * al22 - al21 * al12;
606 
607  dv[0] = ( - al22 * f[0] + al12 * f[1]) / det;
608  dv[1] = (al21 * f[0] - al11 * f[1]) / det;
609  v[0] = v[0] + dv[0];
610  v[1] = v[1] + dv[1];
611  }
612  }
613  else if (expdim == 3)
614  {
615  {
616  if (err < errtol)
617  {
618  cout << "Calculating" << endl;
619  OUTPUT(m_xpoints, xx, ff, nQuadraturePts, x_QuadraturePts,
620  z_QuadraturePts, u_QuadraturePts, v_QuadraturePts,
621  rho_QuadraturePts, T_QuadraturePts);
622  break;
623  }
624  else
625  {
626  f[0] = ff[1][m_xpoints] - 1;
627  f[1] = ff[3][m_xpoints] - 1;
628  vstart[2] = v[0] + dv[0];
629 
630  if (m_Tw < 0)
631  {
632  vstart[3] = v[1];
633  m_Twall = vstart[3];
634  }
635  else
636  {
637  vstart[4] = v[1];
638  }
639 
640  RKDUMB(vstart, 5, 0.0, etamax, m_xpoints, xx, ff);
641 
642  f1[0] = ff[1][m_xpoints] - 1;
643  f1[1] = ff[3][m_xpoints] - 1;
644 
645  vstart[2] = v[0];
646 
647  if (m_Tw < 0)
648  {
649  vstart[3] = v[1] + dv[1];
650  m_Twall = vstart[3];
651  }
652  else
653  {
654  vstart[4] = v[1] + dv[1];
655  }
656 
657  RKDUMB(vstart, 5, 0.0, etamax, m_xpoints, xx, ff);
658 
659  f2[0] = ff[1][m_xpoints] - 1;
660  f2[1] = ff[3][m_xpoints] - 1;
661 
662  al11 = (f1[0] - f[0]) / dv[0];
663  al21 = (f1[1] - f[1]) / dv[0];
664  al12 = (f2[0] - f[0]) / dv[1];
665  al22 = (f2[1] - f[1]) / dv[1];
666  det = al11 * al22 - al21 * al12;
667 
668  dv[0] = ( - al22 * f[0] + al12 * f[1]) / det;
669  dv[1] = (al21 * f[0] - al11 * f[1]) / det;
670  v[0] = v[0] + dv[0];
671  v[1] = v[1] + dv[1];
672  }
673  }
674  }
675  }
676 
677  // Verification of the compressible similarity solution
678  ofstream verif;
679  verif.open("similarity_solution.dat");
680  for (i=0; i< nQuadraturePts; i++)
681  {
682  verif << scientific << setprecision(9) << x_QuadraturePts[i]
683  << " \t " << y_QuadraturePts[i] << " \t " ;
684  verif << scientific << setprecision(9) << u_QuadraturePts[i]
685  << " \t " << v_QuadraturePts[i] << " \t " ;
686  verif << scientific << setprecision(9) << rho_QuadraturePts[i]
687  << " \t " << T_QuadraturePts[i] << endl;
688  }
689  verif.close();
690 
691  // Calculation of the physical variables
692  for (i = 0; i < nQuadraturePts; i++)
693  {
694  rho_QuadraturePts[i] = rho_QuadraturePts[i] * m_rhoInf;
695  u_QuadraturePts[i] = u_QuadraturePts[i] * m_uInf;
696  v_QuadraturePts[i] = v_QuadraturePts[i] * m_uInf;
697  T_QuadraturePts[i] = T_QuadraturePts[i] * m_Tinf;
698 
699  T_QuadraturePts[i] = T_QuadraturePts[i] * rho_QuadraturePts[i] * m_R;
700  T_QuadraturePts[i] = T_QuadraturePts[i] / (m_Gamma-1);
701  T_QuadraturePts[i] = T_QuadraturePts[i] + 0.5 * rho_QuadraturePts[i] * (
702  pow(u_QuadraturePts[i], 2.0) + pow(v_QuadraturePts[i], 2.0));
703 
704  u_QuadraturePts[i] = u_QuadraturePts[i] * rho_QuadraturePts[i];
705  v_QuadraturePts[i] = v_QuadraturePts[i] * rho_QuadraturePts[i];
706  }
707  string file_name;
708  if (expdim == 2)
709  {
711  ::AllocateSharedPtr(vSession);
712 
715  ::AllocateSharedPtr(vSession, graphShPt, vSession->GetVariable(0));
716 
720  ::AllocateSharedPtr(vSession, graphShPt);
721 
724  ::AllocateSharedPtr(vSession, graphShPt);
725 
728  ::AllocateSharedPtr(vSession, graphShPt);
729 
732  ::AllocateSharedPtr(vSession, graphShPt);
733 
734  // Filling the 2D expansion using a recursive algorithm based on the
735  // mesh ordering
737  Basis = Domain->GetExp(0)->GetBasis(0);
738  numModes = Basis->GetNumModes();
739 
740  std::cout << "Number of modes = " << numModes << std::endl;
741 
742  // Copying the ukGlobal vector in m_phys (with the same pattern of
743  // m_phys)
744  Vmath::Vcopy(nQuadraturePts, u_QuadraturePts, 1,
745  Exp2D_uk->UpdatePhys(), 1);
746  Vmath::Vcopy(nQuadraturePts, v_QuadraturePts, 1,
747  Exp2D_vk->UpdatePhys(), 1);
748  Vmath::Vcopy(nQuadraturePts, rho_QuadraturePts, 1,
749  Exp2D_rhok->UpdatePhys(), 1);
750  Vmath::Vcopy(nQuadraturePts, T_QuadraturePts, 1,
751  Exp2D_Tk->UpdatePhys(), 1);
752 
753  // Initialisation of the ExpList Exp
754  Exp[0] = Exp2D_rhok;
755  Exp[1] = Exp2D_uk;
756  Exp[2] = Exp2D_vk;
757  Exp[3] = Exp2D_Tk;
758 
759  // Expansion coefficient extraction (necessary to write the .fld file)
760  Exp[0]->FwdTrans(Exp2D_rhok->GetPhys(), Exp[0]->UpdateCoeffs());
761  Exp[1]->FwdTrans(Exp2D_uk->GetPhys(), Exp[1]->UpdateCoeffs());
762  Exp[2]->FwdTrans(Exp2D_vk->GetPhys(), Exp[2]->UpdateCoeffs());
763  Exp[3]->FwdTrans(Exp2D_Tk->GetPhys(), Exp[3]->UpdateCoeffs());
764 
765  // Definition of the name of the .fld file
766  cout << argv[1] << endl;
767  string tmp = argv[1];
768  int len = tmp.size();
769  for (i = 0; i < len-4; ++i)
770  {
771  file_name += argv[1][i];
772  }
773  file_name = file_name+".rst";
774 
775  // Definition of the Field
776  std::vector<LibUtilities::FieldDefinitionsSharedPtr>
777  FieldDef = Exp[0]->GetFieldDefinitions();
778  std::vector<std::vector<NekDouble> > FieldData(FieldDef.size());
779 
780  for (j = 0; j < 4; j++)
781  {
782  for (i = 0; i < FieldDef.size(); i++)
783  {
784  if (j == 0)
785  {
786  FieldDef[i]->m_fields.push_back("rho");
787  }
788  else if (j == 1)
789  {
790  FieldDef[i]->m_fields.push_back("rhou");
791  }
792  else if (j == 2 )
793  {
794  FieldDef[i]->m_fields.push_back("rhov");
795  }
796  else if (j == 3 )
797  {
798  FieldDef[i]->m_fields.push_back("E");
799  }
800  Exp[j]->AppendFieldData(FieldDef[i], FieldData[i]);
801  }
802  }
803 
804  LibUtilities::Write(file_name, FieldDef, FieldData);
805  }
806  else if (expdim == 3)
807  {
809  ::AllocateSharedPtr(vSession);
810 
813  ::AllocateSharedPtr(vSession, graphShPt, vSession->GetVariable(0));
814 
815  Array<OneD,NekDouble> w_QuadraturePts;
816  w_QuadraturePts = Array<OneD,NekDouble>(nQuadraturePts, 0.0);
818 
821  ::AllocateSharedPtr(vSession, graphShPt);
822 
825  ::AllocateSharedPtr(vSession, graphShPt);
826 
829  ::AllocateSharedPtr(vSession, graphShPt);
830 
833  ::AllocateSharedPtr(vSession, graphShPt);
834 
837  ::AllocateSharedPtr(vSession, graphShPt);
838 
839  // Filling the 3D expansion using a recursive algorithm based
840  // on the mesh ordering
842  Basis = Domain->GetExp(0)->GetBasis(0);
843  numModes = Basis->GetNumModes();
844 
845  std::cout<< "Number of modes = " << numModes << std::endl;
846 
847  // Copying the ukGlobal vector in m_phys (with the same pattern
848  // of m_phys)
849  Vmath::Vcopy(nQuadraturePts, rho_QuadraturePts, 1,
850  Exp3D_rhok->UpdatePhys(), 1);
851  Vmath::Vcopy(nQuadraturePts, u_QuadraturePts, 1,
852  Exp3D_uk->UpdatePhys(), 1);
853  Vmath::Vcopy(nQuadraturePts, w_QuadraturePts, 1,
854  Exp3D_vk->UpdatePhys(), 1);
855  Vmath::Vcopy(nQuadraturePts, v_QuadraturePts, 1,
856  Exp3D_wk->UpdatePhys(), 1);
857  Vmath::Vcopy(nQuadraturePts, T_QuadraturePts, 1,
858  Exp3D_Tk->UpdatePhys(), 1);
859 
860  // Initialisation of the ExpList Exp
861  Exp[0] = Exp3D_rhok;
862  Exp[1] = Exp3D_uk;
863  Exp[2] = Exp3D_vk;
864  Exp[3] = Exp3D_wk;
865  Exp[4] = Exp3D_Tk;
866 
867  // Expansion coefficient extraction (necessary to write the .fld file)
868  Exp[0]->FwdTrans(Exp3D_rhok->GetPhys(), Exp[0]->UpdateCoeffs());
869  Exp[1]->FwdTrans(Exp3D_uk->GetPhys(), Exp[1]->UpdateCoeffs());
870  Exp[2]->FwdTrans(Exp3D_vk->GetPhys(), Exp[2]->UpdateCoeffs());
871  Exp[3]->FwdTrans(Exp3D_wk->GetPhys(), Exp[3]->UpdateCoeffs());
872  Exp[4]->FwdTrans(Exp3D_Tk->GetPhys(), Exp[4]->UpdateCoeffs());
873 
874  // Definition of the name of the .fld file
875  cout << argv[1] << endl;
876  string tmp = argv[1];
877  int len = tmp.size();
878  for (i = 0; i < len-4; ++i)
879  {
880  file_name += argv[1][i];
881  }
882  file_name = file_name+".rst";
883 
884  // Definition of the Field
885  std::vector<LibUtilities::FieldDefinitionsSharedPtr>
886  FieldDef = Exp[0]->GetFieldDefinitions();
887  std::vector<std::vector<NekDouble> > FieldData(FieldDef.size());
888 
889  for (j = 0; j < 5; j++)
890  {
891  for (i = 0; i < FieldDef.size(); i++)
892  {
893  if (j == 0)
894  {
895  FieldDef[i]->m_fields.push_back("rho");
896  }
897  else if (j == 1)
898  {
899  FieldDef[i]->m_fields.push_back("rhou");
900  }
901  else if (j == 2 )
902  {
903  FieldDef[i]->m_fields.push_back("rhov");
904  }
905  else if (j == 3 )
906  {
907  FieldDef[i]->m_fields.push_back("rhow");
908  }
909  else if (j == 4 )
910  {
911  FieldDef[i]->m_fields.push_back("E");
912  }
913  Exp[j]->AppendFieldData(FieldDef[i], FieldData[i]);
914  }
915  }
916 
917  LibUtilities::Write(file_name, FieldDef, FieldData);
918  }
919 
920  std::cout <<"----------------------------------------------------\n";
921  std::cout <<"\n=================================================\n";
922  std::cout <<"Similarity solution \n";
923  std::cout <<"===================================================\n";
924  std::cout <<"***************************************************\n";
925  std::cout <<"DATA FROM THE SESSION FILE:\n";
926  std::cout << "Reynolds number = " << m_Re
927  << "\t[-]" << std::endl;
928  std::cout << "Mach number = " << m_Mach
929  << "\t[-]" << std::endl;
930  std::cout << "Characteristic length = " << m_long
931  << "\t[m]" << std::endl;
932  std::cout << "U_infinity = " << m_uInf
933  << "\t[m/s]" << std::endl;
934  std::cout <<"***************************************************\n";
935  std::cout <<"---------------------------------------------------\n";
936  std::cout <<"MESH and EXPANSION DATA:\n";
937  std::cout << "Done." << std::endl;
938 
939  return 0;
940 }
#define ASSERTL0(condition, msg)
Definition: ErrorUtil.hpp:161
NekDouble m_Mach
void OUTPUT(int m_xpoints, Array< OneD, NekDouble > xx, Array< OneD, Array< OneD, NekDouble > > ff, int nQuadraturePts, Array< OneD, NekDouble > x_QuadraturePts, Array< OneD, NekDouble > y_QuadraturePts, Array< OneD, NekDouble > u_QuadraturePts, Array< OneD, NekDouble > v_QuadraturePts, Array< OneD, NekDouble > rho_QuadraturePts, Array< OneD, NekDouble > T_QuadraturePts)
General purpose memory allocation routines with the ability to allocate from thread specific memory p...
NekDouble m_Tw
NekDouble m_Tinf
NekDouble m_vInf
NekDouble m_Twall
NekDouble m_uInf
boost::shared_ptr< ContField2D > ContField2DSharedPtr
Definition: ContField2D.h:293
NekDouble m_mu
boost::shared_ptr< SessionReader > SessionReaderSharedPtr
Definition: MeshPartition.h:51
NekDouble m_rhoInf
const NekDouble etamax
NekDouble m_Pr
NekDouble m_Re
NekDouble m_long
void RKDUMB(Array< OneD, NekDouble > vstart, int nvar, NekDouble x1, NekDouble x2, int m_xpoints, Array< OneD, NekDouble > xx, Array< OneD, Array< OneD, NekDouble > > y)
double NekDouble
NekDouble m_Suth
boost::shared_ptr< ExpList2D > ExpList2DSharedPtr
Shared pointer to an ExpList2D object.
Definition: ExpList2D.h:49
const int m_xpoints
boost::shared_ptr< ExpList3D > ExpList3DSharedPtr
Shared pointer to an ExpList3D object.
Definition: ExpList3D.h:114
NekDouble m_R
void Write(const std::string &outFile, std::vector< FieldDefinitionsSharedPtr > &fielddefs, std::vector< std::vector< NekDouble > > &fielddata, const FieldMetaDataMap &fieldinfomap)
Write a field file in serial only.
Definition: FieldIO.cpp:81
boost::shared_ptr< Basis > BasisSharedPtr
const NekDouble errtol
boost::shared_ptr< ContField3D > ContField3DSharedPtr
Definition: ContField3D.h:191
boost::shared_ptr< MeshGraph > MeshGraphSharedPtr
Definition: MeshGraph.h:442
void Vcopy(int n, const T *x, const int incx, T *y, const int incy)
Definition: Vmath.cpp:1047
NekDouble m_Gamma
void OUTPUT ( int  m_xpoints,
Array< OneD, NekDouble xx,
Array< OneD, Array< OneD, NekDouble > >  ff,
int  nQuadraturePts,
Array< OneD, NekDouble x_QuadraturePts,
Array< OneD, NekDouble y_QuadraturePts,
Array< OneD, NekDouble u_QuadraturePts,
Array< OneD, NekDouble v_QuadraturePts,
Array< OneD, NekDouble rho_QuadraturePts,
Array< OneD, NekDouble T_QuadraturePts 
)

Create the output file

Definition at line 234 of file CompressibleBL.cpp.

References ASSERTL0, COMPBL(), etamax, m_mu, m_Pr, m_Re, m_rhoInf, m_Suth, m_uInf, and m_xpoints.

Referenced by main().

244 {
253  Array <OneD, NekDouble > velocity(m_xpoints, 0.0);
255 
256 
257  NekDouble dd, dm, scale, flg;
258  NekDouble xcher, ycher;
259  int index = -1;
260 
261  z[0] = 0.0;
262  NekDouble sumd = 0.0;
263 
264  for (int i = 1; i < m_xpoints ; i++)
265  {
266  z[i] = z[i-1] + 0.5 * (xx[i] - xx[i-1]) * (ff[3][i] + ff[3][i-1]);
267  dm = ff[3][i-1] - ff[1][i-1];
268  dd = ff[3][i] - ff[1][i];
269  sumd = sumd + 0.5 * (xx[i] - xx[i-1]) * (dd + dm);
270 
271  if ((ff[1][i] > 0.999) && (flg < 1.0))
272  {
273  flg = 2.0;
274  }
275  }
276 
277  scale = sumd;
278 
279  ofstream file3;
280  file3.open("physical_data.dat");
281 
282  NekDouble xin, rex, delsx, delta;
283 
284  for (int i = 0; i < m_xpoints; i++)
285  {
286  for (int k = 0; k < 5; k++)
287  {
288  v[k] = ff[k][i];
289  }
290  COMPBL(v, dv);
291  u[i] = ff[1][i];
292  t[i] = ff[3][i];
293  rho[i] = (1.0 / ff[3][i]);
294  vv[i] = -ff[0][i]/sqrt(m_uInf);
295  mu[i] = pow(t[i], 1.5) * (1 + m_Suth) / (t[i] + m_Suth) / (m_Re);
296  velocity[i] = ff[0][i] ;
297  }
298 
299  NekDouble scale2, coeff;
300 
301  for (int i = 0; i < nQuadraturePts; i++)
302  {
303  if (i%100000 == 0)
304  {
305  cout << "i" << " " << i << "/" << nQuadraturePts << endl;
306  }
307 
308  xcher = x_QuadraturePts[i];
309  ycher = y_QuadraturePts[i];
310 
311  scale = sumd;
312  xin = xcher;
313  rex = 0.5 * pow(((m_Re) / scale), 2) + (m_Re) * xin;
314  delsx = sqrt(2.0 / rex) * scale * (xin)* m_Pr;
315  scale = scale / delsx;
316  delta = 4.91 * sqrt((xin * m_mu) / (m_rhoInf * m_uInf));
317  scale2 = ycher * (scale * delta) / sqrt(etamax) ;
318  coeff = 0.5 * sqrt( 2 / (xcher*m_Re)) ;
319 
320  if (scale2 > z[m_xpoints-3])
321  {
322  u_QuadraturePts[i] = 1;
323  rho_QuadraturePts[i] = 1;
324  T_QuadraturePts[i] = 1.0 / rho_QuadraturePts[i];
325  v_QuadraturePts[i] = coeff * (z[m_xpoints-3] -
326  velocity[m_xpoints-3]);
327 
328  file3 << xcher << " "
329  << ycher << " "
330  << velocity[m_xpoints-3] << " "
331  << z[m_xpoints-3] << " "
332  << u[m_xpoints-3]
333  << endl;
334  }
335  else
336  {
337  for (int j = 0 ; j< m_xpoints-1; j++)
338  {
339  if ((z[j] <= scale2) && (z[j+1] > scale2))
340  {
341  index = j;
342  break;
343  }
344  }
345  if (index == -1)
346  {
347  ASSERTL0(false, "Could not determine index in CompressibleBL");
348  }
349 
350  u_QuadraturePts[i] = u[index];
351  rho_QuadraturePts[i] = rho[index];
352  T_QuadraturePts[i] = 1.0/rho_QuadraturePts[i];
353  v_QuadraturePts[i] = coeff * (u[index]*scale2 - velocity[index]);
354  }
355  }
356 }
#define ASSERTL0(condition, msg)
Definition: ErrorUtil.hpp:161
NekDouble m_uInf
NekDouble m_mu
NekDouble m_rhoInf
const NekDouble etamax
NekDouble m_Pr
NekDouble m_Re
double NekDouble
NekDouble m_Suth
const int m_xpoints
void COMPBL(Array< OneD, NekDouble > v, Array< OneD, NekDouble > dv)
void RK4 ( Array< OneD, NekDouble y,
Array< OneD, NekDouble dydx,
int  n,
NekDouble  x,
NekDouble  h,
Array< OneD, NekDouble yout 
)

Perform the RK4 integration

Definition at line 141 of file CompressibleBL.cpp.

References COMPBL().

Referenced by RKDUMB().

147 {
148  int nmax = 5;
149 
150  Array<OneD, NekDouble> yt (nmax, 0.0);
151  Array<OneD, NekDouble> dyt(nmax, 0.0);
152  Array<OneD, NekDouble> dym(nmax, 0.0);
153  NekDouble hh = h * 0.5;
154  NekDouble h6 = h / 6;
155 
156  for (int i = 0; i < n ; i++)
157  {
158  yt[i] = y[i] + hh * dydx[i];
159  }
160 
161  COMPBL(yt, dyt);
162 
163  for (int i = 0; i < n; i++)
164  {
165  yt[i] = y[i] + hh * dyt[i];
166  }
167 
168  COMPBL(yt, dym);
169 
170  for (int i = 0; i < n; i++)
171  {
172  yt[i] = y[i] + h * dym[i];
173  dym[i] = dyt[i] + dym[i];
174  }
175 
176  COMPBL(yt, dyt);
177 
178  for (int i = 0; i < n; i++)
179  {
180  yout[i] = y[i] + h6 * (dydx[i] + dyt[i] + 2 * dym[i]);
181  }
182 }
double NekDouble
void COMPBL(Array< OneD, NekDouble > v, Array< OneD, NekDouble > dv)
void RKDUMB ( Array< OneD, NekDouble vstart,
int  nvar,
NekDouble  x1,
NekDouble  x2,
int  m_xpoints,
Array< OneD, NekDouble xx,
Array< OneD, Array< OneD, NekDouble > >  y 
)

Calculate initial guess for RK4

Definition at line 188 of file CompressibleBL.cpp.

References COMPBL(), m_xpoints, and RK4().

Referenced by main().

195 {
196  int nmax = 5;
197  NekDouble x, h;
198  Array<OneD, NekDouble> v (nmax, 0.0);
199  Array<OneD, NekDouble> dv(nmax, 0.0);
200 
201  for (int i = 0; i < nvar; i++)
202  {
203  v[i] = vstart[i];
204  y[i][0] = v[i];
205  }
206 
207  xx[0] = x1;
208  x = x1;
209  h = (x2-x1) / m_xpoints;
210 
211  for (int k = 0; k < m_xpoints; k++)
212  {
213  COMPBL(v, dv);
214  RK4 (v, dv, nvar, x, h, v);
215 
216  if (x + h == x)
217  {
218  cout << "bug" << endl;
219  }
220 
221  x = x + h;
222  xx[k+1] = x;
223 
224  for (int i = 0; i < nvar; i++)
225  {
226  y[i][k+1] = v[i];
227  }
228  }
229 }
void RK4(Array< OneD, NekDouble > y, Array< OneD, NekDouble > dydx, int n, NekDouble x, NekDouble h, Array< OneD, NekDouble > yout)
double NekDouble
const int m_xpoints
void COMPBL(Array< OneD, NekDouble > v, Array< OneD, NekDouble > dv)

Variable Documentation

const NekDouble errtol = 1e-5

Definition at line 99 of file CompressibleBL.cpp.

Referenced by main().

const NekDouble etamax = 10.0

Definition at line 98 of file CompressibleBL.cpp.

Referenced by main(), and OUTPUT().

Definition at line 79 of file CompressibleBL.cpp.

Referenced by main().

NekDouble m_Gamma

Definition at line 84 of file CompressibleBL.cpp.

Referenced by COMPBL(), and main().

NekDouble m_long

Definition at line 86 of file CompressibleBL.cpp.

Referenced by main().

NekDouble m_Mach

Definition at line 78 of file CompressibleBL.cpp.

Referenced by COMPBL(), and main().

NekDouble m_mu

Definition at line 91 of file CompressibleBL.cpp.

Referenced by main(), and OUTPUT().

NekDouble m_Pr

Definition at line 85 of file CompressibleBL.cpp.

Referenced by COMPBL(), main(), and OUTPUT().

NekDouble m_R

Definition at line 89 of file CompressibleBL.cpp.

Referenced by main().

NekDouble m_Re

Definition at line 77 of file CompressibleBL.cpp.

Referenced by main(), and OUTPUT().

NekDouble m_rhoInf

Definition at line 88 of file CompressibleBL.cpp.

Referenced by main(), and OUTPUT().

NekDouble m_Suth

Definition at line 81 of file CompressibleBL.cpp.

Referenced by COMPBL(), main(), and OUTPUT().

NekDouble m_Tinf

Definition at line 80 of file CompressibleBL.cpp.

Referenced by main().

NekDouble m_To = 273.11

Definition at line 92 of file CompressibleBL.cpp.

NekDouble m_Tw

Definition at line 82 of file CompressibleBL.cpp.

Referenced by main().

NekDouble m_Twall

Definition at line 83 of file CompressibleBL.cpp.

Referenced by COMPBL(), and main().

NekDouble m_uInf

Definition at line 87 of file CompressibleBL.cpp.

Referenced by main(), and OUTPUT().

NekDouble m_vInf

Definition at line 90 of file CompressibleBL.cpp.

Referenced by main().

const int m_xpoints = 1000001

Definition at line 94 of file CompressibleBL.cpp.

Referenced by main(), OUTPUT(), and RKDUMB().

const NekDouble Nvisc = 1

Definition at line 96 of file CompressibleBL.cpp.

Referenced by COMPBL().

const NekDouble Omega = 1

Definition at line 97 of file CompressibleBL.cpp.

Referenced by COMPBL().