| 
    Nektar++
    
   | 
 
#include <VCSMapping.h>


Static Public Member Functions | |
| static  SolverUtils::EquationSystemSharedPtr  | create (const LibUtilities::SessionReaderSharedPtr &pSession) | 
| Creates an instance of this class.  More... | |
  Static Public Member Functions inherited from Nektar::VelocityCorrectionScheme | |
| static  SolverUtils::EquationSystemSharedPtr  | create (const LibUtilities::SessionReaderSharedPtr &pSession) | 
| Creates an instance of this class.  More... | |
Static Public Attributes | |
| static std::string | className | 
| Name of class.  More... | |
  Static Public Attributes inherited from Nektar::VelocityCorrectionScheme | |
| static std::string | className | 
| Name of class.  More... | |
Protected Member Functions | |
| virtual void | v_DoInitialise (void) | 
| Sets up initial conditions.  More... | |
| virtual void | v_SetUpPressureForcing (const Array< OneD, const Array< OneD, NekDouble > > &fields, Array< OneD, Array< OneD, NekDouble > > &Forcing, const NekDouble aii_Dt) | 
| virtual void | v_SetUpViscousForcing (const Array< OneD, const Array< OneD, NekDouble > > &inarray, Array< OneD, Array< OneD, NekDouble > > &Forcing, const NekDouble aii_Dt) | 
| virtual void | v_SolvePressure (const Array< OneD, NekDouble > &Forcing) | 
| virtual void | v_SolveViscous (const Array< OneD, const Array< OneD, NekDouble > > &Forcing, Array< OneD, Array< OneD, NekDouble > > &outarray, const NekDouble aii_Dt) | 
| virtual void | v_EvaluateAdvection_SetPressureBCs (const Array< OneD, const Array< OneD, NekDouble > > &inarray, Array< OneD, Array< OneD, NekDouble > > &outarray, const NekDouble time) | 
  Protected Member Functions inherited from Nektar::VelocityCorrectionScheme | |
| virtual void | v_GenerateSummary (SolverUtils::SummaryList &s) | 
| Print a summary of time stepping parameters.  More... | |
| virtual void | v_TransCoeffToPhys (void) | 
| Virtual function for transformation to physical space.  More... | |
| virtual void | v_TransPhysToCoeff (void) | 
| Virtual function for transformation to coefficient space.  More... | |
| virtual Array< OneD, bool > | v_GetSystemSingularChecks () | 
| virtual int | v_GetForceDimension () | 
  Protected Member Functions inherited from Nektar::IncNavierStokes | |
| IncNavierStokes (const LibUtilities::SessionReaderSharedPtr &pSession) | |
| Constructor.  More... | |
| EquationType | GetEquationType (void) | 
| void | EvaluateAdvectionTerms (const Array< OneD, const Array< OneD, NekDouble > > &inarray, Array< OneD, Array< OneD, NekDouble > > &outarray, Array< OneD, NekDouble > &wk=NullNekDouble1DArray) | 
| void | WriteModalEnergy (void) | 
| void | SetBoundaryConditions (NekDouble time) | 
| time dependent boundary conditions updating  More... | |
| void | SetRadiationBoundaryForcing (int fieldid) | 
| Set Radiation forcing term.  More... | |
| void | SetZeroNormalVelocity () | 
| Set Normal Velocity Component to Zero.  More... | |
| bool | CalcSteadyState (void) | 
| evaluate steady state  More... | |
| virtual  MultiRegions::ExpListSharedPtr  | v_GetPressure () | 
| virtual bool | v_PreIntegrate (int step) | 
| virtual bool | v_PostIntegrate (int step) | 
  Protected Member Functions inherited from Nektar::SolverUtils::UnsteadySystem | |
| SOLVER_UTILS_EXPORT | UnsteadySystem (const LibUtilities::SessionReaderSharedPtr &pSession) | 
| Initialises UnsteadySystem class members.  More... | |
| SOLVER_UTILS_EXPORT NekDouble | MaxTimeStepEstimator () | 
| Get the maximum timestep estimator for cfl control.  More... | |
| virtual SOLVER_UTILS_EXPORT void | v_DoSolve () | 
| Solves an unsteady problem.  More... | |
| virtual SOLVER_UTILS_EXPORT void | v_AppendOutput1D (Array< OneD, Array< OneD, NekDouble > > &solution1D) | 
| Print the solution at each solution point in a txt file.  More... | |
| virtual SOLVER_UTILS_EXPORT void | v_NumericalFlux (Array< OneD, Array< OneD, NekDouble > > &physfield, Array< OneD, Array< OneD, NekDouble > > &numfluxX, Array< OneD, Array< OneD, NekDouble > > &numfluxY) | 
| virtual SOLVER_UTILS_EXPORT void | v_NumFluxforScalar (const Array< OneD, Array< OneD, NekDouble > > &ufield, Array< OneD, Array< OneD, Array< OneD, NekDouble > > > &uflux) | 
| virtual SOLVER_UTILS_EXPORT void | v_NumFluxforVector (const Array< OneD, Array< OneD, NekDouble > > &ufield, Array< OneD, Array< OneD, Array< OneD, NekDouble > > > &qfield, Array< OneD, Array< OneD, NekDouble > > &qflux) | 
| virtual SOLVER_UTILS_EXPORT  NekDouble  | v_GetTimeStep (const Array< OneD, const Array< OneD, NekDouble > > &inarray) | 
| Return the timestep to be used for the next step in the time-marching loop.  More... | |
| virtual SOLVER_UTILS_EXPORT bool | v_SteadyStateCheck (int step) | 
| SOLVER_UTILS_EXPORT void | CheckForRestartTime (NekDouble &time) | 
| SOLVER_UTILS_EXPORT void | SVVVarDiffCoeff (const Array< OneD, Array< OneD, NekDouble > > vel, StdRegions::VarCoeffMap &varCoeffMap) | 
| Evaluate the SVV diffusion coefficient according to Moura's paper where it should proportional to h time velocity.  More... | |
  Protected Member Functions inherited from Nektar::SolverUtils::EquationSystem | |
| SOLVER_UTILS_EXPORT | EquationSystem (const LibUtilities::SessionReaderSharedPtr &pSession) | 
| Initialises EquationSystem class members.  More... | |
| int | nocase_cmp (const std::string &s1, const std::string &s2) | 
| virtual SOLVER_UTILS_EXPORT  NekDouble  | v_LinfError (unsigned int field, const Array< OneD, NekDouble > &exactsoln=NullNekDouble1DArray) | 
| Virtual function for the L_inf error computation between fields and a given exact solution.  More... | |
| virtual SOLVER_UTILS_EXPORT  NekDouble  | v_L2Error (unsigned int field, const Array< OneD, NekDouble > &exactsoln=NullNekDouble1DArray, bool Normalised=false) | 
| Virtual function for the L_2 error computation between fields and a given exact solution.  More... | |
| virtual SOLVER_UTILS_EXPORT void | v_SetInitialConditions (NekDouble initialtime=0.0, bool dumpInitialConditions=true, const int domain=0) | 
| virtual SOLVER_UTILS_EXPORT void | v_EvaluateExactSolution (unsigned int field, Array< OneD, NekDouble > &outfield, const NekDouble time) | 
| SOLVER_UTILS_EXPORT void | SetUpBaseFields (SpatialDomains::MeshGraphSharedPtr &mesh) | 
| SOLVER_UTILS_EXPORT void | ImportFldBase (std::string pInfile, SpatialDomains::MeshGraphSharedPtr pGraph) | 
| virtual SOLVER_UTILS_EXPORT void | v_Output (void) | 
| virtual SOLVER_UTILS_EXPORT void | v_ExtraFldOutput (std::vector< Array< OneD, NekDouble > > &fieldcoeffs, std::vector< std::string > &variables) | 
Protected Attributes | |
| GlobalMapping::MappingSharedPtr | m_mapping | 
| bool | m_verbose | 
| bool | m_implicitPressure | 
| bool | m_implicitViscous | 
| bool | m_neglectViscous | 
| NekDouble | m_pressureTolerance | 
| NekDouble | m_viscousTolerance | 
| NekDouble | m_pressureRelaxation | 
| NekDouble | m_viscousRelaxation | 
| Array< OneD, Array< OneD,  NekDouble > >  | m_gradP | 
  Protected Attributes inherited from Nektar::VelocityCorrectionScheme | |
| bool | m_useHomo1DSpecVanVisc | 
| bool to identify if spectral vanishing viscosity is active.  More... | |
| bool | m_useSpecVanVisc | 
| bool to identify if spectral vanishing viscosity is active.  More... | |
| NekDouble | m_sVVCutoffRatio | 
| cutt off ratio from which to start decayhing modes  More... | |
| NekDouble | m_sVVDiffCoeff | 
| Diffusion coefficient of SVV modes.  More... | |
| Array< OneD, NekDouble > | m_saved_aii_Dt | 
| Save aiiDt value to use as a trip to reset global matrix setup.  More... | |
| StdRegions::VarCoeffMap | m_varCoeffLap | 
| Variable Coefficient map for the Laplacian which can be activated as part of SVV or otherwise.  More... | |
  Protected Attributes inherited from Nektar::IncNavierStokes | |
| ExtrapolateSharedPtr | m_extrapolation | 
| std::ofstream | m_mdlFile | 
| modal energy file  More... | |
| bool | m_SmoothAdvection | 
| bool to identify if advection term smoothing is requested  More... | |
| std::vector < SolverUtils::ForcingSharedPtr >  | m_forcing | 
| Forcing terms.  More... | |
| int | m_nConvectiveFields | 
| Number of fields to be convected;.  More... | |
| Array< OneD, int > | m_velocity | 
| int which identifies which components of m_fields contains the velocity (u,v,w);  More... | |
| MultiRegions::ExpListSharedPtr | m_pressure | 
| Pointer to field holding pressure field.  More... | |
| NekDouble | m_kinvis | 
| Kinematic viscosity.  More... | |
| int | m_energysteps | 
| dump energy to file at steps time  More... | |
| int | m_cflsteps | 
| dump cfl estimate  More... | |
| int | m_steadyStateSteps | 
| Check for steady state at step interval.  More... | |
| NekDouble | m_steadyStateTol | 
| Tolerance to which steady state should be evaluated at.  More... | |
| EquationType | m_equationType | 
| equation type;  More... | |
| Array< OneD, Array< OneD, int > > | m_fieldsBCToElmtID | 
| Mapping from BCs to Elmt IDs.  More... | |
| Array< OneD, Array< OneD, int > > | m_fieldsBCToTraceID | 
| Mapping from BCs to Elmt Edge IDs.  More... | |
| Array< OneD, Array< OneD,  NekDouble > >  | m_fieldsRadiationFactor | 
| RHS Factor for Radiation Condition.  More... | |
| int | m_intSteps | 
| Number of time integration steps AND Order of extrapolation for pressure boundary conditions.  More... | |
  Protected Attributes inherited from Nektar::SolverUtils::AdvectionSystem | |
| SolverUtils::AdvectionSharedPtr | m_advObject | 
| Advection term.  More... | |
  Protected Attributes inherited from Nektar::SolverUtils::UnsteadySystem | |
| int | m_infosteps | 
| Number of time steps between outputting status information.  More... | |
| LibUtilities::TimeIntegrationWrapperSharedPtr | m_intScheme | 
| Wrapper to the time integration scheme.  More... | |
| LibUtilities::TimeIntegrationSchemeOperators | m_ode | 
| The time integration scheme operators to use.  More... | |
| LibUtilities::TimeIntegrationSolutionSharedPtr | m_intSoln | 
| NekDouble | m_epsilon | 
| bool | m_explicitDiffusion | 
| Indicates if explicit or implicit treatment of diffusion is used.  More... | |
| bool | m_explicitAdvection | 
| Indicates if explicit or implicit treatment of advection is used.  More... | |
| bool | m_explicitReaction | 
| Indicates if explicit or implicit treatment of reaction is used.  More... | |
| bool | m_homoInitialFwd | 
| Flag to determine if simulation should start in homogeneous forward transformed state.  More... | |
| std::vector< int > | m_intVariables | 
| std::vector< FilterSharedPtr > | m_filters | 
  Protected Attributes inherited from Nektar::SolverUtils::EquationSystem | |
| LibUtilities::CommSharedPtr | m_comm | 
| Communicator.  More... | |
| LibUtilities::SessionReaderSharedPtr | m_session | 
| The session reader.  More... | |
| LibUtilities::FieldIOSharedPtr | m_fld | 
| Field input/output.  More... | |
| std::map< std::string, Array < OneD, Array< OneD, float > > >  | m_interpWeights | 
| Map of the interpolation weights for a specific filename.  More... | |
| std::map< std::string, Array < OneD, Array< OneD, unsigned int > > >  | m_interpInds | 
| Map of the interpolation indices for a specific filename.  More... | |
| Array< OneD,  MultiRegions::ExpListSharedPtr >  | m_fields | 
| Array holding all dependent variables.  More... | |
| Array< OneD,  MultiRegions::ExpListSharedPtr >  | m_base | 
| Base fields.  More... | |
| Array< OneD,  MultiRegions::ExpListSharedPtr >  | m_derivedfields | 
| Array holding all dependent variables.  More... | |
| SpatialDomains::BoundaryConditionsSharedPtr | m_boundaryConditions | 
| Pointer to boundary conditions object.  More... | |
| SpatialDomains::MeshGraphSharedPtr | m_graph | 
| Pointer to graph defining mesh.  More... | |
| std::string | m_sessionName | 
| Name of the session.  More... | |
| NekDouble | m_time | 
| Current time of simulation.  More... | |
| int | m_initialStep | 
| Number of the step where the simulation should begin.  More... | |
| NekDouble | m_fintime | 
| Finish time of the simulation.  More... | |
| NekDouble | m_timestep | 
| Time step size.  More... | |
| NekDouble | m_lambda | 
| Lambda constant in real system if one required.  More... | |
| std::set< std::string > | m_loadedFields | 
| NekDouble | m_checktime | 
| Time between checkpoints.  More... | |
| int | m_nchk | 
| Number of checkpoints written so far.  More... | |
| int | m_steps | 
| Number of steps to take.  More... | |
| int | m_checksteps | 
| Number of steps between checkpoints.  More... | |
| int | m_spacedim | 
| Spatial dimension (>= expansion dim).  More... | |
| int | m_expdim | 
| Expansion dimension.  More... | |
| bool | m_singleMode | 
| Flag to determine if single homogeneous mode is used.  More... | |
| bool | m_halfMode | 
| Flag to determine if half homogeneous mode is used.  More... | |
| bool | m_multipleModes | 
| Flag to determine if use multiple homogenenous modes are used.  More... | |
| bool | m_useFFT | 
| Flag to determine if FFT is used for homogeneous transform.  More... | |
| bool | m_homogen_dealiasing | 
| Flag to determine if dealiasing is used for homogeneous simulations.  More... | |
| bool | m_specHP_dealiasing | 
| Flag to determine if dealisising is usde for the Spectral/hp element discretisation.  More... | |
| enum MultiRegions::ProjectionType | m_projectionType | 
| Type of projection; e.g continuous or discontinuous.  More... | |
| Array< OneD, Array< OneD,  NekDouble > >  | m_traceNormals | 
| Array holding trace normals for DG simulations in the forwards direction.  More... | |
| Array< OneD, Array< OneD,  Array< OneD, NekDouble > > >  | m_gradtan | 
| 1 x nvariable x nq  More... | |
| Array< OneD, Array< OneD,  Array< OneD, NekDouble > > >  | m_tanbasis | 
| 2 x m_spacedim x nq  More... | |
| Array< OneD, bool > | m_checkIfSystemSingular | 
| Flag to indicate if the fields should be checked for singularity.  More... | |
| LibUtilities::FieldMetaDataMap | m_fieldMetaDataMap | 
| Map to identify relevant solver info to dump in output fields.  More... | |
| int | m_NumQuadPointsError | 
| Number of Quadrature points used to work out the error.  More... | |
| enum HomogeneousType | m_HomogeneousType | 
| NekDouble | m_LhomX | 
| physical length in X direction (if homogeneous)  More... | |
| NekDouble | m_LhomY | 
| physical length in Y direction (if homogeneous)  More... | |
| NekDouble | m_LhomZ | 
| physical length in Z direction (if homogeneous)  More... | |
| int | m_npointsX | 
| number of points in X direction (if homogeneous)  More... | |
| int | m_npointsY | 
| number of points in Y direction (if homogeneous)  More... | |
| int | m_npointsZ | 
| number of points in Z direction (if homogeneous)  More... | |
| int | m_HomoDirec | 
| number of homogenous directions  More... | |
Private Member Functions | |
| void | MappingAdvectionCorrection (const Array< OneD, const Array< OneD, NekDouble > > &velPhys, Array< OneD, Array< OneD, NekDouble > > &outarray) | 
| void | MappingAccelerationCorrection (const Array< OneD, const Array< OneD, NekDouble > > &vel, const Array< OneD, const Array< OneD, NekDouble > > &velPhys, Array< OneD, Array< OneD, NekDouble > > &outarray) | 
| void | MappingPressureCorrection (Array< OneD, Array< OneD, NekDouble > > &outarray) | 
| void | MappingViscousCorrection (const Array< OneD, const Array< OneD, NekDouble > > &velPhys, Array< OneD, Array< OneD, NekDouble > > &outarray) | 
Private Attributes | |
| Array< OneD, Array< OneD,  NekDouble > >  | m_presForcingCorrection | 
Additional Inherited Members | |
  Public Attributes inherited from Nektar::SolverUtils::UnsteadySystem | |
| NekDouble | m_cflSafetyFactor | 
| CFL safety factor (comprise between 0 to 1).  More... | |
  Protected Types inherited from Nektar::SolverUtils::EquationSystem | |
| enum | HomogeneousType { eHomogeneous1D, eHomogeneous2D, eHomogeneous3D, eNotHomogeneous } | 
| Parameter for homogeneous expansions.  More... | |
Definition at line 44 of file VCSMapping.h.
| Nektar::VCSMapping::VCSMapping | ( | const LibUtilities::SessionReaderSharedPtr & | pSession | ) | 
Constructor.
Constructor. Creates ...
| param | 
Definition at line 57 of file VCSMapping.cpp.
      
  | 
  virtual | 
| void Nektar::VCSMapping::ApplyIncNSMappingForcing | ( | const Array< OneD, const Array< OneD, NekDouble > > & | inarray, | 
| Array< OneD, Array< OneD, NekDouble > > & | outarray | ||
| ) | 
Explicit terms of the mapping
Definition at line 741 of file VCSMapping.cpp.
References Nektar::SolverUtils::EquationSystem::m_fields, m_implicitPressure, m_implicitViscous, Nektar::IncNavierStokes::m_kinvis, m_mapping, Nektar::IncNavierStokes::m_nConvectiveFields, m_neglectViscous, MappingAccelerationCorrection(), MappingAdvectionCorrection(), MappingPressureCorrection(), MappingViscousCorrection(), Vmath::Smul(), Vmath::Vadd(), and Vmath::Vcopy().
Referenced by v_EvaluateAdvection_SetPressureBCs().
      
  | 
  inlinestatic | 
Creates an instance of this class.
Definition at line 49 of file VCSMapping.h.
References Nektar::MemoryManager< DataType >::AllocateSharedPtr().
      
  | 
  private | 
Definition at line 849 of file VCSMapping.cpp.
References Nektar::MultiRegions::DirCartesianMap, Nektar::SolverUtils::EquationSystem::m_fields, m_mapping, Nektar::IncNavierStokes::m_nConvectiveFields, Vmath::Neg(), Vmath::Vadd(), Vmath::Vvtvp(), and Vmath::Zero().
Referenced by ApplyIncNSMappingForcing().
      
  | 
  private | 
Definition at line 824 of file VCSMapping.cpp.
References Nektar::SolverUtils::EquationSystem::m_fields, m_mapping, Nektar::IncNavierStokes::m_nConvectiveFields, Vmath::Neg(), Vmath::Vvtvp(), and Vmath::Zero().
Referenced by ApplyIncNSMappingForcing().
      
  | 
  private | 
Definition at line 928 of file VCSMapping.cpp.
References Nektar::SolverUtils::EquationSystem::m_fields, m_gradP, m_mapping, Nektar::IncNavierStokes::m_nConvectiveFields, Vmath::Vdiv(), and Vmath::Vsub().
Referenced by ApplyIncNSMappingForcing().
      
  | 
  private | 
Definition at line 955 of file VCSMapping.cpp.
References m_mapping.
Referenced by ApplyIncNSMappingForcing().
Sets up initial conditions.
Sets the initial conditions.
Reimplemented from Nektar::VelocityCorrectionScheme.
Definition at line 147 of file VCSMapping.cpp.
References Nektar::MultiRegions::DirCartesianMap, Nektar::SolverUtils::EquationSystem::m_fieldMetaDataMap, Nektar::SolverUtils::EquationSystem::m_fields, m_gradP, Nektar::IncNavierStokes::m_kinvis, m_mapping, Nektar::IncNavierStokes::m_nConvectiveFields, Nektar::IncNavierStokes::m_pressure, Nektar::SolverUtils::EquationSystem::m_timestep, and Nektar::SolverUtils::UnsteadySystem::v_DoInitialise().
      
  | 
  protectedvirtual | 
Explicit part of the method - Advection, Forcing + HOPBCs
Reimplemented from Nektar::VelocityCorrectionScheme.
Definition at line 188 of file VCSMapping.cpp.
References ApplyIncNSMappingForcing(), Nektar::IncNavierStokes::EvaluateAdvectionTerms(), Nektar::IncNavierStokes::m_extrapolation, Nektar::SolverUtils::EquationSystem::m_fields, Nektar::IncNavierStokes::m_forcing, Nektar::IncNavierStokes::m_kinvis, m_mapping, Nektar::IncNavierStokes::m_nConvectiveFields, Nektar::IncNavierStokes::m_pressure, Nektar::IncNavierStokes::m_SmoothAdvection, and Nektar::SolverUtils::EquationSystem::m_timestep.
      
  | 
  virtual | 
Init object for UnsteadySystem class.
Initialization object for UnsteadySystem class.
Reimplemented from Nektar::VelocityCorrectionScheme.
Definition at line 65 of file VCSMapping.cpp.
References ASSERTL0, Nektar::LibUtilities::NekFactory< tKey, tBase, >::CreateInstance(), Nektar::LibUtilities::eIMEXOrder1, Nektar::LibUtilities::eIMEXOrder2, Nektar::LibUtilities::eIMEXOrder3, Nektar::GetExtrapolateFactory(), Nektar::GlobalMapping::Mapping::Load(), Nektar::SolverUtils::AdvectionSystem::m_advObject, Nektar::IncNavierStokes::m_extrapolation, Nektar::SolverUtils::EquationSystem::m_fields, m_implicitPressure, m_implicitViscous, Nektar::SolverUtils::UnsteadySystem::m_intScheme, m_mapping, m_neglectViscous, m_presForcingCorrection, Nektar::IncNavierStokes::m_pressure, m_pressureRelaxation, m_pressureTolerance, Nektar::SolverUtils::EquationSystem::m_session, Nektar::IncNavierStokes::m_velocity, m_verbose, m_viscousRelaxation, m_viscousTolerance, and Nektar::VelocityCorrectionScheme::v_InitObject().
      
  | 
  protectedvirtual | 
Forcing term for Poisson solver solver
Reimplemented from Nektar::VelocityCorrectionScheme.
Definition at line 234 of file VCSMapping.cpp.
References Nektar::MultiRegions::DirCartesianMap, Nektar::IncNavierStokes::m_extrapolation, Nektar::SolverUtils::EquationSystem::m_fields, m_implicitViscous, Nektar::IncNavierStokes::m_kinvis, m_mapping, Nektar::IncNavierStokes::m_nConvectiveFields, m_presForcingCorrection, Vmath::Smul(), Nektar::VelocityCorrectionScheme::v_SetUpPressureForcing(), Vmath::Vadd(), Vmath::Vcopy(), Vmath::Vdiv(), Vmath::Vmul(), Vmath::Vsub(), and Vmath::Zero().
      
  | 
  protectedvirtual | 
Forcing term for Helmholtz solver
Reimplemented from Nektar::VelocityCorrectionScheme.
Definition at line 353 of file VCSMapping.cpp.
References Nektar::SolverUtils::EquationSystem::m_fields, m_gradP, m_implicitPressure, Nektar::IncNavierStokes::m_kinvis, m_mapping, Nektar::IncNavierStokes::m_pressure, Nektar::IncNavierStokes::m_velocity, Vmath::Vcopy(), and Vmath::Vdiv().
      
  | 
  protectedvirtual | 
Solve pressure system
Reimplemented from Nektar::VelocityCorrectionScheme.
Definition at line 430 of file VCSMapping.cpp.
References ASSERTL0, Nektar::MultiRegions::DirCartesianMap, Nektar::StdRegions::eFactorLambda, Nektar::IncNavierStokes::m_extrapolation, Nektar::SolverUtils::EquationSystem::m_fields, m_implicitPressure, m_mapping, Nektar::IncNavierStokes::m_nConvectiveFields, Nektar::IncNavierStokes::m_pressure, m_pressureRelaxation, m_pressureTolerance, Nektar::SolverUtils::EquationSystem::m_session, m_verbose, Vmath::Neg(), Nektar::NullFlagList, Vmath::Smul(), Nektar::VelocityCorrectionScheme::v_SolvePressure(), Vmath::Vadd(), Vmath::Vcopy(), Vmath::Vmul(), and Vmath::Vsub().
      
  | 
  protectedvirtual | 
Solve velocity system
Reimplemented from Nektar::VelocityCorrectionScheme.
Definition at line 574 of file VCSMapping.cpp.
References ASSERTL0, Nektar::StdRegions::eFactorLambda, Nektar::StdRegions::eFactorSVVCutoffRatio, Nektar::StdRegions::eFactorSVVDiffCoeff, Nektar::SolverUtils::EquationSystem::m_fields, m_implicitViscous, Nektar::IncNavierStokes::m_kinvis, m_mapping, Nektar::IncNavierStokes::m_nConvectiveFields, Nektar::SolverUtils::EquationSystem::m_session, Nektar::VelocityCorrectionScheme::m_sVVCutoffRatio, Nektar::VelocityCorrectionScheme::m_sVVDiffCoeff, Nektar::VelocityCorrectionScheme::m_useSpecVanVisc, m_verbose, m_viscousRelaxation, m_viscousTolerance, Nektar::NullFlagList, Vmath::Smul(), Nektar::VelocityCorrectionScheme::v_SolveViscous(), Vmath::Vadd(), and Vmath::Vcopy().
      
  | 
  static | 
Definition at line 93 of file VCSMapping.h.
Referenced by MappingPressureCorrection(), v_DoInitialise(), and v_SetUpViscousForcing().
      
  | 
  protected | 
Definition at line 82 of file VCSMapping.h.
Referenced by ApplyIncNSMappingForcing(), v_InitObject(), v_SetUpViscousForcing(), and v_SolvePressure().
      
  | 
  protected | 
Definition at line 83 of file VCSMapping.h.
Referenced by ApplyIncNSMappingForcing(), v_InitObject(), v_SetUpPressureForcing(), and v_SolveViscous().
      
  | 
  protected | 
Definition at line 76 of file VCSMapping.h.
Referenced by ApplyIncNSMappingForcing(), MappingAccelerationCorrection(), MappingAdvectionCorrection(), MappingPressureCorrection(), MappingViscousCorrection(), v_DoInitialise(), v_EvaluateAdvection_SetPressureBCs(), v_InitObject(), v_SetUpPressureForcing(), v_SetUpViscousForcing(), v_SolvePressure(), and v_SolveViscous().
      
  | 
  protected | 
Definition at line 84 of file VCSMapping.h.
Referenced by ApplyIncNSMappingForcing(), and v_InitObject().
Definition at line 122 of file VCSMapping.h.
Referenced by v_InitObject(), and v_SetUpPressureForcing().
      
  | 
  protected | 
Definition at line 89 of file VCSMapping.h.
Referenced by v_InitObject(), and v_SolvePressure().
      
  | 
  protected | 
Definition at line 87 of file VCSMapping.h.
Referenced by v_InitObject(), and v_SolvePressure().
      
  | 
  protected | 
Definition at line 78 of file VCSMapping.h.
Referenced by v_InitObject(), v_SolvePressure(), and v_SolveViscous().
      
  | 
  protected | 
Definition at line 90 of file VCSMapping.h.
Referenced by v_InitObject(), and v_SolveViscous().
      
  | 
  protected | 
Definition at line 88 of file VCSMapping.h.
Referenced by v_InitObject(), and v_SolveViscous().
 1.8.8