MAST
MAST::FluidElemBase Class Reference

This class provides the necessary functions to evaluate the flux vectors and their Jacobians for both inviscid and viscous flows. More...

#include <fluid_elem_base.h>

Inheritance diagram for MAST::FluidElemBase:
Collaboration diagram for MAST::FluidElemBase:

Public Member Functions

 FluidElemBase (const unsigned int dimension, const MAST::FlightCondition &f)
 Constructor. More...
 
virtual ~FluidElemBase ()
 
void get_infinity_vars (RealVectorX &vars_inf) const
 
bool if_viscous () const
 
void calculate_dxidX (const unsigned int qp, const MAST::FEBase &fe, RealMatrixX &dxi_dX, RealMatrixX &dX_dxi)
 
void update_solution_at_quadrature_point (const unsigned int qp, const MAST::FEBase &fe, const RealVectorX &elem_solution, RealVectorX &conservative_sol, MAST::PrimitiveSolution &primitive_sol, MAST::FEMOperatorMatrix &B_mat, std::vector< MAST::FEMOperatorMatrix > &dB_mat)
 
void calculate_advection_flux (const unsigned int calculate_dim, const MAST::PrimitiveSolution &sol, RealVectorX &flux)
 
void calculate_diffusion_flux (const unsigned int calculate_dim, const MAST::PrimitiveSolution &sol, const RealMatrixX &stress_tensor, const RealVectorX &temp_gradient, RealVectorX &flux)
 
void calculate_diffusion_tensors (const RealVectorX &elem_sol, const std::vector< MAST::FEMOperatorMatrix > &dB_mat, const RealMatrixX &dprim_dcons, const MAST::PrimitiveSolution &psol, RealMatrixX &stress_tensor, RealVectorX &temp_gradient)
 calculates and returns the stress tensor in stress_tensor. More...
 
void calculate_diffusion_tensors_sensitivity (const RealVectorX &elem_sol, const RealVectorX &elem_sol_sens, const std::vector< MAST::FEMOperatorMatrix > &dB_mat, const RealMatrixX &dprim_dcons, const MAST::PrimitiveSolution &psol, const MAST::SmallPerturbationPrimitiveSolution< Real > &dsol, RealMatrixX &stress_tensor_sens, RealVectorX &temp_gradient_sens)
 calculates and returns the stress tensor in stress_tensor. More...
 
void calculate_conservative_variable_jacobian (const MAST::PrimitiveSolution &sol, RealMatrixX &dcons_dprim, RealMatrixX &dprim_dcons)
 
void calculate_advection_flux_jacobian (const unsigned int calculate_dim, const MAST::PrimitiveSolution &sol, RealMatrixX &mat)
 
void calculate_advection_flux_jacobian_rho_derivative (const unsigned int calculate_dim, const MAST::PrimitiveSolution &sol, RealMatrixX &mat)
 
void calculate_advection_flux_jacobian_u1_derivative (const unsigned int calculate_dim, const MAST::PrimitiveSolution &sol, RealMatrixX &mat)
 
void calculate_advection_flux_jacobian_u2_derivative (const unsigned int calculate_dim, const MAST::PrimitiveSolution &sol, RealMatrixX &mat)
 
void calculate_advection_flux_jacobian_u3_derivative (const unsigned int calculate_dim, const MAST::PrimitiveSolution &sol, RealMatrixX &mat)
 
void calculate_advection_flux_jacobian_T_derivative (const unsigned int calculate_dim, const MAST::PrimitiveSolution &sol, RealMatrixX &mat)
 
template<typename ValType >
void calculate_advection_flux_jacobian_vec_mult_second_derivative (const unsigned int calculate_dim, const MAST::PrimitiveSolution &sol, const ValType &lin_sol, RealMatrixX &mat)
 
template<typename ValType >
void calculate_advection_flux_jacobian_vec_adjoint_mult_second_derivative (const unsigned int calculate_dim, const MAST::PrimitiveSolution &sol, const ValType &lin_sol, RealMatrixX &mat)
 
void calculate_diffusion_flux_jacobian (const unsigned int flux_dim, const unsigned int deriv_dim, const MAST::PrimitiveSolution &sol, RealMatrixX &mat)
 
void calculate_diffusion_flux_jacobian_primitive_vars (const unsigned int flux_dim, const unsigned int deriv_dim, const RealVectorX &uvec, const bool zero_kth, const MAST::PrimitiveSolution &sol, RealMatrixX &mat)
 
void calculate_advection_flux_jacobian_sensitivity_for_conservative_variable (const unsigned int calculate_dim, const MAST::PrimitiveSolution &sol, std::vector< RealMatrixX > &mat)
 
void calculate_advection_flux_jacobian_sensitivity_for_primitive_variable (const unsigned int calculate_dim, const unsigned int primitive_var, const MAST::PrimitiveSolution &sol, RealMatrixX &mat)
 
void calculate_advection_left_eigenvector_and_inverse_for_normal (const MAST::PrimitiveSolution &sol, const libMesh::Point &normal, RealVectorX &eig_vals, RealMatrixX &l_eig_mat, RealMatrixX &l_eig_mat_inv_tr)
 
void calculate_advection_left_eigenvector_and_inverse_rho_derivative_for_normal (const MAST::PrimitiveSolution &sol, const libMesh::Point &normal, RealMatrixX &eig_vals, RealMatrixX &l_eig_mat, RealMatrixX &l_eig_mat_inv_tr)
 
void calculate_advection_left_eigenvector_and_inverse_u1_derivative_for_normal (const MAST::PrimitiveSolution &sol, const libMesh::Point &normal, RealMatrixX &eig_vals, RealMatrixX &l_eig_mat, RealMatrixX &l_eig_mat_inv_tr)
 
void calculate_advection_left_eigenvector_and_inverse_u2_derivative_for_normal (const MAST::PrimitiveSolution &sol, const libMesh::Point &normal, RealMatrixX &eig_vals, RealMatrixX &l_eig_mat, RealMatrixX &l_eig_mat_inv_tr)
 
void calculate_advection_left_eigenvector_and_inverse_u3_derivative_for_normal (const MAST::PrimitiveSolution &sol, const libMesh::Point &normal, RealMatrixX &eig_vals, RealMatrixX &l_eig_mat, RealMatrixX &l_eig_mat_inv_tr)
 
void calculate_advection_left_eigenvector_and_inverse_T_derivative_for_normal (const MAST::PrimitiveSolution &sol, const libMesh::Point &normal, RealMatrixX &eig_vals, RealMatrixX &l_eig_mat, RealMatrixX &l_eig_mat_inv_tr)
 
template<typename ValType >
void calculate_advection_outflow_flux_jacobian_vec_mult_second_derivative (const MAST::PrimitiveSolution &sol, const libMesh::Point &normal, const ValType &lin_sol, RealMatrixX &mat)
 
template<typename ValType >
void calculate_advection_outflow_flux_jacobian_vec_adjoint_mult_second_derivative (const MAST::PrimitiveSolution &sol, const libMesh::Point &normal, const ValType &lin_sol, RealMatrixX &mat)
 
void calculate_entropy_variable_jacobian (const MAST::PrimitiveSolution &sol, RealMatrixX &dUdV, RealMatrixX &dVdU)
 
void calculate_pressure_derivative_wrt_conservative_variables (const MAST::PrimitiveSolution &sol, RealVectorX &dpdX)
 
void calculate_advection_flux_jacobian_for_moving_solid_wall_boundary (const MAST::PrimitiveSolution &sol, const Real ui_ni, const libMesh::Point &nvec, const RealVectorX &dnvec, RealMatrixX &mat)
 
void calculate_advection_flux_jacobian_rho_derivative_for_moving_solid_wall_boundary (const MAST::PrimitiveSolution &sol, const Real ui_ni, const libMesh::Point &nvec, const RealVectorX &dnvec, RealMatrixX &mat)
 
void calculate_advection_flux_jacobian_u1_derivative_for_moving_solid_wall_boundary (const MAST::PrimitiveSolution &sol, const Real ui_ni, const libMesh::Point &nvec, const RealVectorX &dnvec, RealMatrixX &mat)
 
void calculate_advection_flux_jacobian_u2_derivative_for_moving_solid_wall_boundary (const MAST::PrimitiveSolution &sol, const Real ui_ni, const libMesh::Point &nvec, const RealVectorX &dnvec, RealMatrixX &mat)
 
void calculate_advection_flux_jacobian_u3_derivative_for_moving_solid_wall_boundary (const MAST::PrimitiveSolution &sol, const Real ui_ni, const libMesh::Point &nvec, const RealVectorX &dnvec, RealMatrixX &mat)
 
void calculate_advection_flux_jacobian_T_derivative_for_moving_solid_wall_boundary (const MAST::PrimitiveSolution &sol, const Real ui_ni, const libMesh::Point &nvec, const RealVectorX &dnvec, RealMatrixX &mat)
 
template<typename ValType >
void calculate_advection_flux_jacobian_vec_mult_second_derivative_for_moving_solid_wall_boundary (const MAST::PrimitiveSolution &sol, const Real ui_ni, const libMesh::Point &nvec, const RealVectorX &dnvec, const ValType &lin_sol, RealMatrixX &mat)
 
template<typename ValType >
void calculate_advection_flux_jacobian_vec_adjoint_mult_second_derivative_for_moving_solid_wall_boundary (const MAST::PrimitiveSolution &sol, const Real ui_ni, const libMesh::Point &nvec, const RealVectorX &dnvec, const ValType &lin_sol, RealMatrixX &mat)
 
bool calculate_barth_tau_matrix (const unsigned int qp, const MAST::FEBase &fe, const MAST::PrimitiveSolution &sol, RealMatrixX &tau, std::vector< RealMatrixX > &tau_sens)
 
bool calculate_aliabadi_tau_matrix (const unsigned int qp, const MAST::FEBase &fe, const MAST::PrimitiveSolution &sol, RealMatrixX &tau, std::vector< RealMatrixX > &tau_sens)
 
void calculate_hartmann_discontinuity_operator (const unsigned int qp, const MAST::FEBase &fe, const MAST::PrimitiveSolution &sol, const RealVectorX &elem_solution, const std::vector< MAST::FEMOperatorMatrix > &dB_mat, const RealMatrixX &Ai_Bi_advection, RealVectorX &discontinuity_val)
 
void calculate_aliabadi_discontinuity_operator (const unsigned int qp, const MAST::FEBase &fe, const MAST::PrimitiveSolution &sol, const RealVectorX &elem_solution, const std::vector< MAST::FEMOperatorMatrix > &dB_mat, const RealMatrixX &Ai_Bi_advection, RealVectorX &discontinuity_val)
 
template<typename ValType >
void calculate_small_disturbance_aliabadi_discontinuity_operator (const unsigned int qp, const MAST::FEBase &fe, const MAST::PrimitiveSolution &sol, const MAST::SmallPerturbationPrimitiveSolution< ValType > &dsol, const RealVectorX &elem_solution, const std::vector< MAST::FEMOperatorMatrix > &dB_mat, const RealMatrixX &Ai_Bi_advection, RealVectorX &discontinuity_val)
 
void calculate_differential_operator_matrix (const unsigned int qp, const MAST::FEBase &fe, const RealVectorX &elem_solution, const MAST::PrimitiveSolution &sol, const MAST::FEMOperatorMatrix &B_mat, const std::vector< MAST::FEMOperatorMatrix > &dB_mat, const std::vector< RealMatrixX > &Ai_advection, const RealMatrixX &Ai_Bi_advection, const std::vector< std::vector< RealMatrixX > > &Ai_sens, RealMatrixX &LS_operator, RealMatrixX &LS_sens)
 

Public Attributes

const MAST::FlightConditionflight_condition
 This defines the surface motion for use with the nonlinear fluid solver. More...
 
unsigned int dim
 

Protected Attributes

std::vector< MAST::FluidPrimitiveVars_active_primitive_vars
 
std::vector< FluidConservativeVars_active_conservative_vars
 
bool _if_viscous
 
bool _include_pressure_switch
 
Real _dissipation_scaling
 

Detailed Description

This class provides the necessary functions to evaluate the flux vectors and their Jacobians for both inviscid and viscous flows.

Definition at line 73 of file fluid_elem_base.h.

Constructor & Destructor Documentation

MAST::FluidElemBase::FluidElemBase ( const unsigned int  dimension,
const MAST::FlightCondition f 
)

Constructor.

Definition at line 39 of file fluid_elem_base.cpp.

MAST::FluidElemBase::~FluidElemBase ( )
virtual

Definition at line 73 of file fluid_elem_base.cpp.

Here is the call graph for this function:

Member Function Documentation

void MAST::FluidElemBase::calculate_advection_flux ( const unsigned int  calculate_dim,
const MAST::PrimitiveSolution sol,
RealVectorX flux 
)

Definition at line 150 of file fluid_elem_base.cpp.

Here is the caller graph for this function:

void MAST::FluidElemBase::calculate_advection_flux_jacobian ( const unsigned int  calculate_dim,
const MAST::PrimitiveSolution sol,
RealMatrixX mat 
)

Definition at line 428 of file fluid_elem_base.cpp.

Here is the call graph for this function:

Here is the caller graph for this function:

void MAST::FluidElemBase::calculate_advection_flux_jacobian_for_moving_solid_wall_boundary ( const MAST::PrimitiveSolution sol,
const Real  ui_ni,
const libMesh::Point &  nvec,
const RealVectorX dnvec,
RealMatrixX mat 
)

Definition at line 1583 of file fluid_elem_base.cpp.

Here is the call graph for this function:

Here is the caller graph for this function:

void MAST::FluidElemBase::calculate_advection_flux_jacobian_rho_derivative ( const unsigned int  calculate_dim,
const MAST::PrimitiveSolution sol,
RealMatrixX mat 
)

Here is the caller graph for this function:

void MAST::FluidElemBase::calculate_advection_flux_jacobian_rho_derivative_for_moving_solid_wall_boundary ( const MAST::PrimitiveSolution sol,
const Real  ui_ni,
const libMesh::Point &  nvec,
const RealVectorX dnvec,
RealMatrixX mat 
)

Here is the caller graph for this function:

void MAST::FluidElemBase::calculate_advection_flux_jacobian_sensitivity_for_conservative_variable ( const unsigned int  calculate_dim,
const MAST::PrimitiveSolution sol,
std::vector< RealMatrixX > &  mat 
)

Definition at line 976 of file fluid_elem_base.cpp.

Here is the call graph for this function:

Here is the caller graph for this function:

void MAST::FluidElemBase::calculate_advection_flux_jacobian_sensitivity_for_primitive_variable ( const unsigned int  calculate_dim,
const unsigned int  primitive_var,
const MAST::PrimitiveSolution sol,
RealMatrixX mat 
)

Definition at line 1009 of file fluid_elem_base.cpp.

Here is the call graph for this function:

Here is the caller graph for this function:

void MAST::FluidElemBase::calculate_advection_flux_jacobian_T_derivative ( const unsigned int  calculate_dim,
const MAST::PrimitiveSolution sol,
RealMatrixX mat 
)

Here is the caller graph for this function:

void MAST::FluidElemBase::calculate_advection_flux_jacobian_T_derivative_for_moving_solid_wall_boundary ( const MAST::PrimitiveSolution sol,
const Real  ui_ni,
const libMesh::Point &  nvec,
const RealVectorX dnvec,
RealMatrixX mat 
)

Here is the caller graph for this function:

void MAST::FluidElemBase::calculate_advection_flux_jacobian_u1_derivative ( const unsigned int  calculate_dim,
const MAST::PrimitiveSolution sol,
RealMatrixX mat 
)

Here is the caller graph for this function:

void MAST::FluidElemBase::calculate_advection_flux_jacobian_u1_derivative_for_moving_solid_wall_boundary ( const MAST::PrimitiveSolution sol,
const Real  ui_ni,
const libMesh::Point &  nvec,
const RealVectorX dnvec,
RealMatrixX mat 
)

Here is the caller graph for this function:

void MAST::FluidElemBase::calculate_advection_flux_jacobian_u2_derivative ( const unsigned int  calculate_dim,
const MAST::PrimitiveSolution sol,
RealMatrixX mat 
)

Here is the caller graph for this function:

void MAST::FluidElemBase::calculate_advection_flux_jacobian_u2_derivative_for_moving_solid_wall_boundary ( const MAST::PrimitiveSolution sol,
const Real  ui_ni,
const libMesh::Point &  nvec,
const RealVectorX dnvec,
RealMatrixX mat 
)

Here is the caller graph for this function:

void MAST::FluidElemBase::calculate_advection_flux_jacobian_u3_derivative ( const unsigned int  calculate_dim,
const MAST::PrimitiveSolution sol,
RealMatrixX mat 
)

Here is the caller graph for this function:

void MAST::FluidElemBase::calculate_advection_flux_jacobian_u3_derivative_for_moving_solid_wall_boundary ( const MAST::PrimitiveSolution sol,
const Real  ui_ni,
const libMesh::Point &  nvec,
const RealVectorX dnvec,
RealMatrixX mat 
)

Here is the caller graph for this function:

template<typename ValType >
void MAST::FluidElemBase::calculate_advection_flux_jacobian_vec_adjoint_mult_second_derivative ( const unsigned int  calculate_dim,
const MAST::PrimitiveSolution sol,
const ValType &  lin_sol,
RealMatrixX mat 
)

Here is the caller graph for this function:

template<typename ValType >
void MAST::FluidElemBase::calculate_advection_flux_jacobian_vec_adjoint_mult_second_derivative_for_moving_solid_wall_boundary ( const MAST::PrimitiveSolution sol,
const Real  ui_ni,
const libMesh::Point &  nvec,
const RealVectorX dnvec,
const ValType &  lin_sol,
RealMatrixX mat 
)

Here is the caller graph for this function:

template<typename ValType >
void MAST::FluidElemBase::calculate_advection_flux_jacobian_vec_mult_second_derivative ( const unsigned int  calculate_dim,
const MAST::PrimitiveSolution sol,
const ValType &  lin_sol,
RealMatrixX mat 
)

Here is the caller graph for this function:

template<typename ValType >
void MAST::FluidElemBase::calculate_advection_flux_jacobian_vec_mult_second_derivative_for_moving_solid_wall_boundary ( const MAST::PrimitiveSolution sol,
const Real  ui_ni,
const libMesh::Point &  nvec,
const RealVectorX dnvec,
const ValType &  lin_sol,
RealMatrixX mat 
)

Here is the caller graph for this function:

void MAST::FluidElemBase::calculate_advection_left_eigenvector_and_inverse_for_normal ( const MAST::PrimitiveSolution sol,
const libMesh::Point &  normal,
RealVectorX eig_vals,
RealMatrixX l_eig_mat,
RealMatrixX l_eig_mat_inv_tr 
)

Definition at line 1285 of file fluid_elem_base.cpp.

Here is the call graph for this function:

Here is the caller graph for this function:

void MAST::FluidElemBase::calculate_advection_left_eigenvector_and_inverse_rho_derivative_for_normal ( const MAST::PrimitiveSolution sol,
const libMesh::Point &  normal,
RealMatrixX eig_vals,
RealMatrixX l_eig_mat,
RealMatrixX l_eig_mat_inv_tr 
)

Here is the caller graph for this function:

void MAST::FluidElemBase::calculate_advection_left_eigenvector_and_inverse_T_derivative_for_normal ( const MAST::PrimitiveSolution sol,
const libMesh::Point &  normal,
RealMatrixX eig_vals,
RealMatrixX l_eig_mat,
RealMatrixX l_eig_mat_inv_tr 
)

Here is the caller graph for this function:

void MAST::FluidElemBase::calculate_advection_left_eigenvector_and_inverse_u1_derivative_for_normal ( const MAST::PrimitiveSolution sol,
const libMesh::Point &  normal,
RealMatrixX eig_vals,
RealMatrixX l_eig_mat,
RealMatrixX l_eig_mat_inv_tr 
)

Here is the caller graph for this function:

void MAST::FluidElemBase::calculate_advection_left_eigenvector_and_inverse_u2_derivative_for_normal ( const MAST::PrimitiveSolution sol,
const libMesh::Point &  normal,
RealMatrixX eig_vals,
RealMatrixX l_eig_mat,
RealMatrixX l_eig_mat_inv_tr 
)

Here is the caller graph for this function:

void MAST::FluidElemBase::calculate_advection_left_eigenvector_and_inverse_u3_derivative_for_normal ( const MAST::PrimitiveSolution sol,
const libMesh::Point &  normal,
RealMatrixX eig_vals,
RealMatrixX l_eig_mat,
RealMatrixX l_eig_mat_inv_tr 
)

Here is the caller graph for this function:

template<typename ValType >
void MAST::FluidElemBase::calculate_advection_outflow_flux_jacobian_vec_adjoint_mult_second_derivative ( const MAST::PrimitiveSolution sol,
const libMesh::Point &  normal,
const ValType &  lin_sol,
RealMatrixX mat 
)

Here is the caller graph for this function:

template<typename ValType >
void MAST::FluidElemBase::calculate_advection_outflow_flux_jacobian_vec_mult_second_derivative ( const MAST::PrimitiveSolution sol,
const libMesh::Point &  normal,
const ValType &  lin_sol,
RealMatrixX mat 
)

Here is the caller graph for this function:

void MAST::FluidElemBase::calculate_aliabadi_discontinuity_operator ( const unsigned int  qp,
const MAST::FEBase fe,
const MAST::PrimitiveSolution sol,
const RealVectorX elem_solution,
const std::vector< MAST::FEMOperatorMatrix > &  dB_mat,
const RealMatrixX Ai_Bi_advection,
RealVectorX discontinuity_val 
)

Definition at line 2239 of file fluid_elem_base.cpp.

Here is the call graph for this function:

Here is the caller graph for this function:

bool MAST::FluidElemBase::calculate_aliabadi_tau_matrix ( const unsigned int  qp,
const MAST::FEBase fe,
const MAST::PrimitiveSolution sol,
RealMatrixX tau,
std::vector< RealMatrixX > &  tau_sens 
)

Definition at line 1954 of file fluid_elem_base.cpp.

Here is the call graph for this function:

Here is the caller graph for this function:

bool MAST::FluidElemBase::calculate_barth_tau_matrix ( const unsigned int  qp,
const MAST::FEBase fe,
const MAST::PrimitiveSolution sol,
RealMatrixX tau,
std::vector< RealMatrixX > &  tau_sens 
)

Definition at line 1876 of file fluid_elem_base.cpp.

Here is the call graph for this function:

Here is the caller graph for this function:

void MAST::FluidElemBase::calculate_conservative_variable_jacobian ( const MAST::PrimitiveSolution sol,
RealMatrixX dcons_dprim,
RealMatrixX dprim_dcons 
)

Definition at line 340 of file fluid_elem_base.cpp.

Here is the call graph for this function:

Here is the caller graph for this function:

void MAST::FluidElemBase::calculate_differential_operator_matrix ( const unsigned int  qp,
const MAST::FEBase fe,
const RealVectorX elem_solution,
const MAST::PrimitiveSolution sol,
const MAST::FEMOperatorMatrix B_mat,
const std::vector< MAST::FEMOperatorMatrix > &  dB_mat,
const std::vector< RealMatrixX > &  Ai_advection,
const RealMatrixX Ai_Bi_advection,
const std::vector< std::vector< RealMatrixX > > &  Ai_sens,
RealMatrixX LS_operator,
RealMatrixX LS_sens 
)

Definition at line 2475 of file fluid_elem_base.cpp.

Here is the call graph for this function:

Here is the caller graph for this function:

void MAST::FluidElemBase::calculate_diffusion_flux ( const unsigned int  calculate_dim,
const MAST::PrimitiveSolution sol,
const RealMatrixX stress_tensor,
const RealVectorX temp_gradient,
RealVectorX flux 
)

Definition at line 222 of file fluid_elem_base.cpp.

Here is the call graph for this function:

Here is the caller graph for this function:

void MAST::FluidElemBase::calculate_diffusion_flux_jacobian ( const unsigned int  flux_dim,
const unsigned int  deriv_dim,
const MAST::PrimitiveSolution sol,
RealMatrixX mat 
)

Definition at line 759 of file fluid_elem_base.cpp.

Here is the call graph for this function:

Here is the caller graph for this function:

void MAST::FluidElemBase::calculate_diffusion_flux_jacobian_primitive_vars ( const unsigned int  flux_dim,
const unsigned int  deriv_dim,
const RealVectorX uvec,
const bool  zero_kth,
const MAST::PrimitiveSolution sol,
RealMatrixX mat 
)

Definition at line 575 of file fluid_elem_base.cpp.

Here is the call graph for this function:

Here is the caller graph for this function:

void MAST::FluidElemBase::calculate_diffusion_tensors ( const RealVectorX elem_sol,
const std::vector< MAST::FEMOperatorMatrix > &  dB_mat,
const RealMatrixX dprim_dcons,
const MAST::PrimitiveSolution psol,
RealMatrixX stress_tensor,
RealVectorX temp_gradient 
)

calculates and returns the stress tensor in stress_tensor.

Definition at line 255 of file fluid_elem_base.cpp.

Here is the call graph for this function:

Here is the caller graph for this function:

void MAST::FluidElemBase::calculate_diffusion_tensors_sensitivity ( const RealVectorX elem_sol,
const RealVectorX elem_sol_sens,
const std::vector< MAST::FEMOperatorMatrix > &  dB_mat,
const RealMatrixX dprim_dcons,
const MAST::PrimitiveSolution psol,
const MAST::SmallPerturbationPrimitiveSolution< Real > &  dsol,
RealMatrixX stress_tensor_sens,
RealVectorX temp_gradient_sens 
)

calculates and returns the stress tensor in stress_tensor.

Definition at line 292 of file fluid_elem_base.cpp.

Here is the call graph for this function:

Here is the caller graph for this function:

void MAST::FluidElemBase::calculate_dxidX ( const unsigned int  qp,
const MAST::FEBase fe,
RealMatrixX dxi_dX,
RealMatrixX dX_dxi 
)

Definition at line 2095 of file fluid_elem_base.cpp.

Here is the call graph for this function:

Here is the caller graph for this function:

void MAST::FluidElemBase::calculate_entropy_variable_jacobian ( const MAST::PrimitiveSolution sol,
RealMatrixX dUdV,
RealMatrixX dVdU 
)

Definition at line 1732 of file fluid_elem_base.cpp.

Here is the call graph for this function:

Here is the caller graph for this function:

void MAST::FluidElemBase::calculate_hartmann_discontinuity_operator ( const unsigned int  qp,
const MAST::FEBase fe,
const MAST::PrimitiveSolution sol,
const RealVectorX elem_solution,
const std::vector< MAST::FEMOperatorMatrix > &  dB_mat,
const RealMatrixX Ai_Bi_advection,
RealVectorX discontinuity_val 
)

Definition at line 2176 of file fluid_elem_base.cpp.

Here is the call graph for this function:

Here is the caller graph for this function:

void MAST::FluidElemBase::calculate_pressure_derivative_wrt_conservative_variables ( const MAST::PrimitiveSolution sol,
RealVectorX dpdX 
)

Definition at line 1544 of file fluid_elem_base.cpp.

Here is the call graph for this function:

Here is the caller graph for this function:

template<typename ValType >
template void MAST::FluidElemBase::calculate_small_disturbance_aliabadi_discontinuity_operator< Complex > ( const unsigned int  qp,
const MAST::FEBase fe,
const MAST::PrimitiveSolution sol,
const MAST::SmallPerturbationPrimitiveSolution< ValType > &  dsol,
const RealVectorX elem_solution,
const std::vector< MAST::FEMOperatorMatrix > &  dB_mat,
const RealMatrixX Ai_Bi_advection,
RealVectorX discontinuity_val 
)

Definition at line 2374 of file fluid_elem_base.cpp.

Here is the call graph for this function:

Here is the caller graph for this function:

void MAST::FluidElemBase::get_infinity_vars ( RealVectorX vars_inf) const

Definition at line 83 of file fluid_elem_base.cpp.

Here is the call graph for this function:

Here is the caller graph for this function:

bool MAST::FluidElemBase::if_viscous ( ) const
inline

Definition at line 100 of file fluid_elem_base.h.

Here is the call graph for this function:

Here is the caller graph for this function:

void MAST::FluidElemBase::update_solution_at_quadrature_point ( const unsigned int  qp,
const MAST::FEBase fe,
const RealVectorX elem_solution,
RealVectorX conservative_sol,
MAST::PrimitiveSolution primitive_sol,
MAST::FEMOperatorMatrix B_mat,
std::vector< MAST::FEMOperatorMatrix > &  dB_mat 
)

Definition at line 103 of file fluid_elem_base.cpp.

Here is the call graph for this function:

Here is the caller graph for this function:

Member Data Documentation

std::vector<FluidConservativeVars> MAST::FluidElemBase::_active_conservative_vars
protected

Definition at line 446 of file fluid_elem_base.h.

std::vector<MAST::FluidPrimitiveVars> MAST::FluidElemBase::_active_primitive_vars
protected

Definition at line 444 of file fluid_elem_base.h.

Real MAST::FluidElemBase::_dissipation_scaling
protected

Definition at line 452 of file fluid_elem_base.h.

bool MAST::FluidElemBase::_if_viscous
protected

Definition at line 448 of file fluid_elem_base.h.

bool MAST::FluidElemBase::_include_pressure_switch
protected

Definition at line 450 of file fluid_elem_base.h.

unsigned int MAST::FluidElemBase::dim

Definition at line 98 of file fluid_elem_base.h.

const MAST::FlightCondition* MAST::FluidElemBase::flight_condition

This defines the surface motion for use with the nonlinear fluid solver.

This can be used to define either a time-dependent motion, or a steady-state motion.

Definition at line 96 of file fluid_elem_base.h.


The documentation for this class was generated from the following files: