44 "UnsteadyAdvectionDiffusion",
49 : UnsteadySystem(pSession),
50 AdvectionSystem(pSession)
61 AdvectionSystem::v_InitObject();
67 m_session->MatchSolverInfo(
"Extrapolation",
"SubStepping",
72 std::vector<std::string> vel;
101 m_session->LoadSolverInfo(
"AdvectionType", advName,
"WeakDG");
103 CreateInstance(advName, advName);
106 m_session->LoadSolverInfo(
"UpwindType", riemName,
"Upwind");
108 CreateInstance(riemName);
115 std::string diffName;
116 m_session->LoadSolverInfo(
"DiffusionType", diffName,
"LDG");
118 CreateInstance(diffName, diffName);
132 m_session->LoadSolverInfo(
"AdvectionType", advName,
135 CreateInstance(advName, advName);
139 if(advName.compare(
"WeakDG") == 0)
142 m_session->LoadSolverInfo(
"UpwindType", riemName,
"Upwind");
144 CreateInstance(riemName);
155 ASSERTL0(
false,
"Explicit Galerkin diffusion not set up.");
162 ASSERTL0(
false,
"Unsupported projection type.");
173 "Projection must be set to Mixed_CG_Discontinuous for "
222 for (i = 0; i < velfield.num_elements(); ++i)
224 m_fields[0]->ExtractTracePhys(velfield[i], tmp);
250 int nVariables = inarray.num_elements();
257 for (
int i = 0; i < nVariables; ++i)
264 inarray, outarray, time);
267 for (
int i = 0; i < nVariables; ++i)
277 for (
int i = 0; i < nVariables; ++i)
280 &outarrayDiff[i][0], 1, &outarray[i][0], 1);
300 int nvariables = inarray.num_elements();
309 for(i = 0; i < nvariables; ++i)
320 for(i = 0; i < nvariables; ++i)
322 m_fields[i]->FwdTrans(inarray[i], coeffs);
323 m_fields[i]->BwdTrans_IterPerExp(coeffs, outarray[i]);
329 ASSERTL0(
false,
"Unknown projection scheme");
349 int nvariables = inarray.num_elements();
364 for (
int n = 1; n < nvariables; ++n)
373 for (
int i = 0; i < nvariables; ++i)
377 inarray[i], 1, F[i], 1);
383 for (
int i = 0; i < nvariables; ++i)
404 "Dimension of flux array and velocity array do not match");
406 const int nq =
m_fields[0]->GetNpoints();
408 for (
int i = 0; i < flux.num_elements(); ++i)
410 for (
int j = 0; j < flux[0].num_elements(); ++j)
434 for (
int k = 0; k < flux.num_elements(); ++k)
444 AdvectionSystem::v_GenerateSummary(s);
477 static int ncalls = 1;
495 cout <<
"Sub-integrating using "<< nsubsteps
500 for (
int m = 0; m < nint; ++m)
503 fields = integrationSoln->UpdateSolutionVector()[m];
512 for(n = 0; n < nsubsteps; ++n)
519 integrationSoln->SetSolVector(m,fields);
529 int n_element =
m_fields[0]->GetExpSize();
541 for(
int el = 0; el < n_element; ++el)
544 (stdVelocity[el] * cLambda *
545 (ExpOrder[el]-1) * (ExpOrder[el]-1));
575 ASSERTL0(0,
"Integration method not suitable: Options include BackwardEuler or BDFImplicitOrder1");
578 m_intSteps = IntegrationScheme->GetIntegrationSteps();
594 int nVariables = inarray.num_elements();
597 int ncoeffs =
m_fields[0]->GetNcoeffs();
602 for(i = 1; i < nVariables; ++i)
604 WeakAdv[i] = WeakAdv[i-1] + ncoeffs;
611 inarray, outarray, time);
613 for(i = 0; i < nVariables; ++i)
615 m_fields[i]->IProductWRTBase(outarray[i],WeakAdv[i]);
624 for(i = 0; i < nVariables; ++i)
630 m_fields[i]->MultiplyByElmtInvMass(WeakAdv[i], WeakAdv[i]);
633 m_fields[i]->BwdTrans(WeakAdv[i], outarray[i]);
645 ASSERTL1(inarray.num_elements() == outarray.num_elements(),
"Inarray and outarray of different sizes ");
647 for(
int i = 0; i < inarray.num_elements(); ++i)
649 Vmath::Vcopy(inarray[i].num_elements(),inarray[i],1,outarray[i],1);
658 ASSERTL1(physfield.num_elements() == Outarray.num_elements(),
659 "Physfield and outarray are of different dimensions");
664 int nTracePts =
m_fields[0]->GetTrace()->GetNpoints();
678 for(i = 0; i < physfield.num_elements(); ++i)
682 m_fields[i]->GetFwdBwdTracePhys(physfield[i], Fwd, Bwd);
685 m_fields[0]->GetTrace()->Upwind(Vn, Fwd, Bwd, numflux);
688 Vmath::Vsub(nTracePts, numflux, 1, Fwd, 1, Fwd, 1);
689 Vmath::Vsub(nTracePts, numflux, 1, Bwd, 1, Bwd, 1);
696 m_fields[0]->AddFwdBwdTraceIntegral(Fwd,Bwd,Outarray[i]);
705 int n_points_0 =
m_fields[0]->GetExp(0)->GetTotPoints();
706 int n_element =
m_fields[0]->GetExpSize();
707 int nvel = inarray.num_elements();
710 ASSERTL0(nvel >= 2,
"Method not implemented for 1D");
719 for (
int i = 0; i < nvel; ++i)
727 for (
int el = 0; el < n_element; ++el)
729 int n_points =
m_fields[0]->GetExp(el)->GetTotPoints();
730 ptsKeys =
m_fields[0]->GetExp(el)->GetPointsKeys();
733 if(n_points != n_points_0)
735 for (
int j = 0; j < nvel; ++j)
739 n_points_0 = n_points;
743 m_fields[0]->GetExp(el)->GetGeom()->GetMetricInfo()->GetDerivFactors(ptsKeys);
745 if (
m_fields[0]->GetExp(el)->GetGeom()->GetMetricInfo()->GetGtype()
748 for (
int i = 0; i < n_points; i++)
750 stdVelocity[0][i] = gmat[0][i]*inarray[0][i+cnt]
751 + gmat[2][i]*inarray[1][i+cnt];
753 stdVelocity[1][i] = gmat[1][i]*inarray[0][i+cnt]
754 + gmat[3][i]*inarray[1][i+cnt];
759 for (
int i = 0; i < n_points; i++)
761 stdVelocity[0][i] = gmat[0][0]*inarray[0][i+cnt]
762 + gmat[2][0]*inarray[1][i+cnt];
764 stdVelocity[1][i] = gmat[1][0]*inarray[0][i+cnt]
765 + gmat[3][0]*inarray[1][i+cnt];
772 for (
int i = 0; i < n_points; i++)
774 pntVelocity = stdVelocity[0][i]*stdVelocity[0][i]
775 + stdVelocity[1][i]*stdVelocity[1][i];
777 if (pntVelocity>maxV[el])
779 maxV[el] = pntVelocity;
782 maxV[el] = sqrt(maxV[el]);
788 for (
int el = 0; el < n_element; ++el)
791 int n_points =
m_fields[0]->GetExp(el)->GetTotPoints();
792 ptsKeys =
m_fields[0]->GetExp(el)->GetPointsKeys();
795 if(n_points != n_points_0)
797 for (
int j = 0; j < nvel; ++j)
801 n_points_0 = n_points;
805 m_fields[0]->GetExp(el)->GetGeom()->GetMetricInfo()->GetDerivFactors(ptsKeys);
807 if (
m_fields[0]->GetExp(el)->GetGeom()->GetMetricInfo()->GetGtype()
810 for (
int i = 0; i < n_points; i++)
812 stdVelocity[0][i] = gmat[0][i]*inarray[0][i+cnt]
813 + gmat[3][i]*inarray[1][i+cnt]
814 + gmat[6][i]*inarray[2][i+cnt];
816 stdVelocity[1][i] = gmat[1][i]*inarray[0][i+cnt]
817 + gmat[4][i]*inarray[1][i+cnt]
818 + gmat[7][i]*inarray[2][i+cnt];
820 stdVelocity[2][i] = gmat[2][i]*inarray[0][i+cnt]
821 + gmat[5][i]*inarray[1][i+cnt]
822 + gmat[8][i]*inarray[2][i+cnt];
827 for (
int i = 0; i < n_points; i++)
829 stdVelocity[0][i] = gmat[0][0]*inarray[0][i+cnt]
830 + gmat[3][0]*inarray[1][i+cnt]
831 + gmat[6][0]*inarray[2][i+cnt];
833 stdVelocity[1][i] = gmat[1][0]*inarray[0][i+cnt]
834 + gmat[4][0]*inarray[1][i+cnt]
835 + gmat[7][0]*inarray[2][i+cnt];
837 stdVelocity[2][i] = gmat[2][0]*inarray[0][i+cnt]
838 + gmat[5][0]*inarray[1][i+cnt]
839 + gmat[8][0]*inarray[2][i+cnt];
845 for (
int i = 0; i < n_points; i++)
847 pntVelocity = stdVelocity[0][i]*stdVelocity[0][i]
848 + stdVelocity[1][i]*stdVelocity[1][i]
849 + stdVelocity[2][i]*stdVelocity[2][i];
851 if (pntVelocity > maxV[el])
853 maxV[el] = pntVelocity;
857 maxV[el] = sqrt(maxV[el]);
void SubStepProjection(const Array< OneD, const Array< OneD, NekDouble > > &inarray, Array< OneD, Array< OneD, NekDouble > > &outarray, const NekDouble time)
#define ASSERTL0(condition, msg)
void GetFluxVectorAdv(const Array< OneD, Array< OneD, NekDouble > > &physfield, Array< OneD, Array< OneD, Array< OneD, NekDouble > > > &flux)
Evaluate the flux at each solution point for the advection part.
Array< OneD, NekDouble > GetMaxStdVelocity(const Array< OneD, Array< OneD, NekDouble > > inarray)
std::vector< PointsKey > PointsKeyVector
BDF multi-step scheme of order 1 (implicit)
bool m_homoInitialFwd
Flag to determine if simulation should start in homogeneous forward transformed state.
tBaseSharedPtr CreateInstance(tKey idKey BOOST_PP_COMMA_IF(MAX_PARAM) BOOST_PP_ENUM_BINARY_PARAMS(MAX_PARAM, tParam, x))
Create an instance of the class referred to by idKey.
SolverUtils::AdvectionSharedPtr m_advObject
Advection term.
NekDouble m_time
Current time of simulation.
bool m_explicitDiffusion
Indicates if explicit or implicit treatment of diffusion is used.
void DefineImplicitSolve(FuncPointerT func, ObjectPointerT obj)
LibUtilities::TimeIntegrationWrapperSharedPtr m_subStepIntegrationScheme
LibUtilities::TimeIntegrationSchemeOperators m_ode
The time integration scheme operators to use.
NekDouble m_timestep
Time step size.
std::vector< std::pair< std::string, std::string > > SummaryList
T Vmin(int n, const T *x, const int incx)
Return the minimum element in x - called vmin to avoid conflict with min.
Array< OneD, Array< OneD, NekDouble > > m_velocity
boost::shared_ptr< TimeIntegrationWrapper > TimeIntegrationWrapperSharedPtr
DiffusionFactory & GetDiffusionFactory()
void Vvtvp(int n, const T *w, const int incw, const T *x, const int incx, const T *y, const int incy, T *z, const int incz)
vvtvp (vector times vector plus vector): z = w*x + y
enum MultiRegions::ProjectionType m_projectionType
Type of projection; e.g continuous or discontinuous.
std::map< ConstFactorType, NekDouble > ConstFactorMap
boost::shared_ptr< SessionReader > SessionReaderSharedPtr
void SubStepAdvection(const Array< OneD, const Array< OneD, NekDouble > > &inarray, Array< OneD, Array< OneD, NekDouble > > &outarray, const NekDouble time)
Array< OneD, NekDouble > & GetNormalVel(const Array< OneD, const Array< OneD, NekDouble > > &velfield)
Get the normal velocity based on input velfield.
Array< OneD, NekDouble > & GetNormalVelocity()
Get the normal velocity based on m_velocity.
SolverUtils::RiemannSolverSharedPtr m_riemannSolver
Array< OneD, Array< OneD, NekDouble > > m_traceNormals
Array holding trace normals for DG simulations in the forwards direction.
void DoOdeProjection(const Array< OneD, const Array< OneD, NekDouble > > &inarray, Array< OneD, Array< OneD, NekDouble > > &outarray, const NekDouble time)
Perform the projection.
void DefineProjection(FuncPointerT func, ObjectPointerT obj)
boost::shared_ptr< Comm > CommSharedPtr
Pointer to a Communicator object.
virtual void DoOdeRhs(const Array< OneD, const Array< OneD, NekDouble > > &inarray, Array< OneD, Array< OneD, NekDouble > > &outarray, const NekDouble time)
Compute the RHS.
void Smul(int n, const T alpha, const T *x, const int incx, T *y, const int incy)
Scalar multiply y = alpha*y.
NekDouble m_sVVCutoffRatio
virtual bool v_PreIntegrate(int step)
PreIntegration step for substepping.
void DefineOdeRhs(FuncPointerT func, ObjectPointerT obj)
Array< OneD, NekDouble > m_traceVn
virtual void v_GenerateSummary(SolverUtils::SummaryList &s)
Print Summary.
RiemannSolverFactory & GetRiemannSolverFactory()
int m_spacedim
Spatial dimension (>= expansion dim).
void SetUpSubSteppingTimeIntegration(int intMethod, const LibUtilities::TimeIntegrationWrapperSharedPtr &IntegrationScheme)
virtual ~UnsteadyAdvectionDiffusion()
Destructor.
SolverUtils::DiffusionSharedPtr m_diffusion
AdvectionFactory & GetAdvectionFactory()
Gets the factory for initialising advection objects.
void Neg(int n, T *x, const int incx)
Negate x = -x.
TimeIntegrationWrapperFactory & GetTimeIntegrationWrapperFactory()
SOLVER_UTILS_EXPORT void EvaluateFunction(Array< OneD, Array< OneD, NekDouble > > &pArray, std::string pFunctionName, const NekDouble pTime=0.0, const int domain=0)
Evaluates a function as specified in the session file.
static std::string className
Name of class.
EquationSystemFactory & GetEquationSystemFactory()
void SubStepAdvance(const LibUtilities::TimeIntegrationSolutionSharedPtr &integrationSoln, int nstep, NekDouble time)
SOLVER_UTILS_EXPORT void SetBoundaryConditions(NekDouble time)
Evaluates the boundary conditions at the given time.
void Vsub(int n, const T *x, const int incx, const T *y, const int incy, T *z, const int incz)
Subtract vector z = x-y.
UnsteadyAdvectionDiffusion(const LibUtilities::SessionReaderSharedPtr &pSession)
Session reader.
BDF multi-step scheme of order 2 (implicit)
virtual void DoImplicitSolve(const Array< OneD, const Array< OneD, NekDouble > > &inarray, Array< OneD, Array< OneD, NekDouble > > &outarray, NekDouble time, NekDouble lambda)
Solve implicitly the diffusion term.
SOLVER_UTILS_EXPORT int GetNpoints()
LibUtilities::TimeIntegrationSchemeOperators m_subStepIntegrationOps
Array< OneD, MultiRegions::ExpListSharedPtr > m_fields
Array holding all dependent variables.
SOLVER_UTILS_EXPORT int GetExpSize()
LibUtilities::SessionReaderSharedPtr m_session
The session reader.
SOLVER_UTILS_EXPORT int GetTraceNpoints()
void AddAdvectionPenaltyFlux(const Array< OneD, const Array< OneD, NekDouble > > &velfield, const Array< OneD, const Array< OneD, NekDouble > > &physfield, Array< OneD, Array< OneD, NekDouble > > &Outarray)
SOLVER_UTILS_EXPORT int GetNcoeffs()
boost::shared_ptr< TimeIntegrationSolution > TimeIntegrationSolutionSharedPtr
LibUtilities::TimeIntegrationWrapperSharedPtr m_intScheme
Wrapper to the time integration scheme.
static SolverUtils::EquationSystemSharedPtr create(const LibUtilities::SessionReaderSharedPtr &pSession)
Creates an instance of this class.
void GetFluxVectorDiff(const int i, const int j, const Array< OneD, Array< OneD, NekDouble > > &physfield, Array< OneD, Array< OneD, NekDouble > > &derivatives, Array< OneD, Array< OneD, NekDouble > > &flux)
Evaluate the flux at each solution point for the diffusion part.
void Zero(int n, T *x, const int incx)
Zero vector.
#define ASSERTL1(condition, msg)
Assert Level 1 – Debugging which is used whether in FULLDEBUG or DEBUG compilation mode...
void Vcopy(int n, const T *x, const int incx, T *y, const int incy)
Geometry is curved or has non-constant factors.
NekDouble m_cflSafetyFactor
virtual void v_InitObject()
Initialise the object.
LibUtilities::TimeIntegrationSolutionSharedPtr m_intSoln
void Vadd(int n, const T *x, const int incx, const T *y, const int incy, T *z, const int incz)
Add vector z = x+y.
void Vmul(int n, const T *x, const int incx, const T *y, const int incy, T *z, const int incz)
Multiply vector z = x*y.
static FlagList NullFlagList
An empty flag list.
NekDouble GetSubstepTimeStep()
tKey RegisterCreatorFunction(tKey idKey, CreatorFunction classCreator, tDescription pDesc="")
Register a class with the factory.