27 #include "grins_config.h"
36 #include "libmesh/getpot.h"
37 #include "libmesh/string_to_enum.h"
38 #include "libmesh/fem_system.h"
39 #include "libmesh/quadrature.h"
47 _stab_helper( physics_name+
"StabHelper", input )
59 context.get_element_fe(this->_press_var.p())->get_dphi();
61 context.get_element_fe(this->_flow_vars.u())->get_dphi();
62 context.get_element_fe(this->_flow_vars.u())->get_d2phi();
72 const unsigned int n_u_dofs = context.get_dof_indices(_flow_vars.u()).size();
73 const unsigned int n_T_dofs = context.get_dof_indices(_temp_vars.T()).size();
76 const std::vector<libMesh::Real> &JxW =
77 context.get_element_fe(_flow_vars.u())->get_JxW();
79 const std::vector<std::vector<libMesh::Real> >& T_phi =
80 context.get_element_fe(this->_temp_vars.T())->get_phi();
82 const std::vector<std::vector<libMesh::Real> >& u_phi =
83 context.get_element_fe(this->_flow_vars.u())->get_phi();
85 const std::vector<std::vector<libMesh::RealGradient> >& u_gradphi =
86 context.get_element_fe(this->_flow_vars.u())->get_dphi();
88 const std::vector<std::vector<libMesh::RealTensor> >& u_hessphi =
89 context.get_element_fe(this->_flow_vars.u())->get_d2phi();
92 libMesh::DenseSubVector<libMesh::Number> &Fu = context.get_elem_residual(_flow_vars.u());
93 libMesh::DenseSubVector<libMesh::Number> &Fv = context.get_elem_residual(_flow_vars.v());
94 libMesh::DenseSubVector<libMesh::Number> *Fw = NULL;
96 libMesh::DenseSubMatrix<libMesh::Number> &KuT =
97 context.get_elem_jacobian(_flow_vars.u(), _temp_vars.T());
98 libMesh::DenseSubMatrix<libMesh::Number> &KvT =
99 context.get_elem_jacobian(_flow_vars.v(), _temp_vars.T());
100 libMesh::DenseSubMatrix<libMesh::Number> &Kuu =
101 context.get_elem_jacobian(_flow_vars.u(), _flow_vars.u());
102 libMesh::DenseSubMatrix<libMesh::Number> &Kuv =
103 context.get_elem_jacobian(_flow_vars.u(), _flow_vars.v());
104 libMesh::DenseSubMatrix<libMesh::Number> &Kvu =
105 context.get_elem_jacobian(_flow_vars.v(), _flow_vars.u());
106 libMesh::DenseSubMatrix<libMesh::Number> &Kvv =
107 context.get_elem_jacobian(_flow_vars.v(), _flow_vars.v());
109 libMesh::DenseSubMatrix<libMesh::Number> *KwT = NULL;
110 libMesh::DenseSubMatrix<libMesh::Number> *Kuw = NULL;
111 libMesh::DenseSubMatrix<libMesh::Number> *Kvw = NULL;
112 libMesh::DenseSubMatrix<libMesh::Number> *Kwu = NULL;
113 libMesh::DenseSubMatrix<libMesh::Number> *Kwv = NULL;
114 libMesh::DenseSubMatrix<libMesh::Number> *Kww = NULL;
117 if(this->_flow_vars.dim() == 3)
119 Fw = &context.get_elem_residual(this->_flow_vars.w());
120 KwT = &context.get_elem_jacobian
121 (_flow_vars.w(), _temp_vars.T());
122 Kuw = &context.get_elem_jacobian
123 (_flow_vars.u(), _flow_vars.w());
124 Kvw = &context.get_elem_jacobian
125 (_flow_vars.v(), _flow_vars.w());
126 Kwu = &context.get_elem_jacobian
127 (_flow_vars.w(), _flow_vars.u());
128 Kwv = &context.get_elem_jacobian
129 (_flow_vars.w(), _flow_vars.v());
130 Kww = &context.get_elem_jacobian
131 (_flow_vars.w(), _flow_vars.w());
140 unsigned int n_qpoints = context.get_element_qrule().n_points();
142 libMesh::FEBase* fe = context.get_element_fe(this->_flow_vars.u());
144 for (
unsigned int qp=0; qp != n_qpoints; qp++)
146 libMesh::RealGradient g = this->_stab_helper.compute_g( fe, context, qp );
147 libMesh::RealTensor G = this->_stab_helper.compute_G( fe, context, qp );
149 libMesh::RealGradient U( context.interior_value( this->_flow_vars.u(), qp ),
150 context.interior_value( this->_flow_vars.v(), qp ) );
151 if( this->_flow_vars.dim() == 3 )
153 U(2) = context.interior_value( this->_flow_vars.w(), qp );
157 libMesh::Real mu_qp = this->_mu(context, qp);
160 libMesh::Real d_tau_M_d_rho;
161 libMesh::Gradient d_tau_M_dU;
163 if (compute_jacobian)
164 this->_stab_helper.compute_tau_momentum_and_derivs
165 ( context, qp, g, G, this->_rho, U, mu_qp,
166 tau_M, d_tau_M_d_rho, d_tau_M_dU,
169 tau_M = this->_stab_helper.compute_tau_momentum
170 ( context, qp, g, G, this->_rho, U, mu_qp,
175 T = context.interior_value(_temp_vars.T(), qp);
177 libMesh::RealGradient d_residual_dT = _rho*_beta_T*_g;
179 libMesh::RealGradient residual = (T-_T_ref)*d_residual_dT;
181 for (
unsigned int i=0; i != n_u_dofs; i++)
183 libMesh::Real test_func = this->_rho*U*u_gradphi[i][qp] +
184 mu_qp*( u_hessphi[i][qp](0,0) + u_hessphi[i][qp](1,1) + u_hessphi[i][qp](2,2) );
185 Fu(i) += -tau_M*residual(0)*test_func*JxW[qp];
187 Fv(i) += -tau_M*residual(1)*test_func*JxW[qp];
189 if (this->_flow_vars.dim() == 3)
191 (*Fw)(i) += -tau_M*residual(2)*test_func*JxW[qp];
194 if (compute_jacobian)
196 libMesh::Gradient d_test_func_dU = this->_rho*u_gradphi[i][qp];
199 for (
unsigned int j=0; j != n_u_dofs; ++j)
201 Kuu(i,j) += -tau_M*residual(0)*d_test_func_dU(0)*u_phi[j][qp]*JxW[qp] * context.get_elem_solution_derivative();
202 Kuu(i,j) += -d_tau_M_dU(0)*u_phi[j][qp]*residual(0)*test_func*JxW[qp] * context.get_elem_solution_derivative();
203 Kuv(i,j) += -tau_M*residual(0)*d_test_func_dU(1)*u_phi[j][qp]*JxW[qp] * context.get_elem_solution_derivative();
204 Kuv(i,j) += -d_tau_M_dU(1)*u_phi[j][qp]*residual(0)*test_func*JxW[qp] * context.get_elem_solution_derivative();
205 Kvu(i,j) += -tau_M*residual(1)*d_test_func_dU(0)*u_phi[j][qp]*JxW[qp] * context.get_elem_solution_derivative();
206 Kvu(i,j) += -d_tau_M_dU(0)*u_phi[j][qp]*residual(1)*test_func*JxW[qp] * context.get_elem_solution_derivative();
207 Kvv(i,j) += -tau_M*residual(1)*d_test_func_dU(1)*u_phi[j][qp]*JxW[qp] * context.get_elem_solution_derivative();
208 Kvv(i,j) += -d_tau_M_dU(1)*u_phi[j][qp]*residual(1)*test_func*JxW[qp] * context.get_elem_solution_derivative();
211 for (
unsigned int j=0; j != n_T_dofs; ++j)
214 KuT(i,j) += -tau_M*d_residual_dT(0)*T_phi[j][qp]*test_func*JxW[qp] * context.get_elem_solution_derivative();
216 KvT(i,j) += -tau_M*d_residual_dT(1)*T_phi[j][qp]*test_func*JxW[qp] * context.get_elem_solution_derivative();
218 if (this->_flow_vars.dim() == 3)
220 for (
unsigned int j=0; j != n_T_dofs; ++j)
223 (*KwT)(i,j) += -tau_M*d_residual_dT(2)*T_phi[j][qp]*test_func*JxW[qp] * context.get_elem_solution_derivative();
226 for (
unsigned int j=0; j != n_u_dofs; ++j)
228 (*Kuw)(i,j) += -tau_M*residual(0)*d_test_func_dU(2)*u_phi[j][qp]*JxW[qp] * context.get_elem_solution_derivative();
229 (*Kuw)(i,j) += -d_tau_M_dU(2)*u_phi[j][qp]*residual(0)*test_func*JxW[qp] * context.get_elem_solution_derivative();
230 (*Kvw)(i,j) += -tau_M*residual(1)*d_test_func_dU(2)*u_phi[j][qp]*JxW[qp] * context.get_elem_solution_derivative();
231 (*Kvw)(i,j) += -d_tau_M_dU(2)*u_phi[j][qp]*residual(1)*test_func*JxW[qp] * context.get_elem_solution_derivative();
232 (*Kwu)(i,j) += -tau_M*residual(2)*d_test_func_dU(0)*u_phi[j][qp]*JxW[qp] * context.get_elem_solution_derivative();
233 (*Kwu)(i,j) += -d_tau_M_dU(0)*u_phi[j][qp]*residual(2)*test_func*JxW[qp] * context.get_elem_solution_derivative();
234 (*Kwv)(i,j) += -tau_M*residual(2)*d_test_func_dU(1)*u_phi[j][qp]*JxW[qp] * context.get_elem_solution_derivative();
235 (*Kwv)(i,j) += -d_tau_M_dU(1)*u_phi[j][qp]*residual(2)*test_func*JxW[qp] * context.get_elem_solution_derivative();
236 (*Kww)(i,j) += -tau_M*residual(2)*d_test_func_dU(2)*u_phi[j][qp]*JxW[qp] * context.get_elem_solution_derivative();
237 (*Kww)(i,j) += -d_tau_M_dU(2)*u_phi[j][qp]*residual(2)*test_func*JxW[qp] * context.get_elem_solution_derivative();
252 const unsigned int n_p_dofs = context.get_dof_indices(_press_var.p()).size();
253 const unsigned int n_u_dofs = context.get_dof_indices(_flow_vars.u()).size();
254 const unsigned int n_T_dofs = context.get_dof_indices(_temp_vars.T()).size();
257 const std::vector<libMesh::Real> &JxW =
258 context.get_element_fe(_flow_vars.u())->get_JxW();
260 const std::vector<std::vector<libMesh::Real> >& T_phi =
261 context.get_element_fe(this->_temp_vars.T())->get_phi();
263 const std::vector<std::vector<libMesh::Real> >& u_phi =
264 context.get_element_fe(this->_flow_vars.u())->get_phi();
266 const std::vector<std::vector<libMesh::RealGradient> >& p_dphi =
267 context.get_element_fe(this->_press_var.p())->get_dphi();
269 libMesh::DenseSubVector<libMesh::Number> &Fp = context.get_elem_residual(this->_press_var.p());
271 libMesh::DenseSubMatrix<libMesh::Number> &KpT =
272 context.get_elem_jacobian(_press_var.p(), _temp_vars.T());
273 libMesh::DenseSubMatrix<libMesh::Number> &Kpu =
274 context.get_elem_jacobian(_press_var.p(), _flow_vars.u());
275 libMesh::DenseSubMatrix<libMesh::Number> &Kpv =
276 context.get_elem_jacobian(_press_var.p(), _flow_vars.v());
277 libMesh::DenseSubMatrix<libMesh::Number> *Kpw = NULL;
279 if(this->_flow_vars.dim() == 3)
281 Kpw = &context.get_elem_jacobian
282 (_press_var.p(), _flow_vars.w());
291 unsigned int n_qpoints = context.get_element_qrule().n_points();
293 libMesh::FEBase* fe = context.get_element_fe(this->_flow_vars.u());
295 for (
unsigned int qp=0; qp != n_qpoints; qp++)
297 libMesh::RealGradient g = this->_stab_helper.compute_g( fe, context, qp );
298 libMesh::RealTensor G = this->_stab_helper.compute_G( fe, context, qp );
300 libMesh::RealGradient U( context.interior_value( this->_flow_vars.u(), qp ),
301 context.interior_value( this->_flow_vars.v(), qp ) );
302 if( this->_flow_vars.dim() == 3 )
304 U(2) = context.interior_value( this->_flow_vars.w(), qp );
308 libMesh::Real mu_qp = this->_mu(context, qp);
311 libMesh::Real d_tau_M_d_rho;
312 libMesh::Gradient d_tau_M_dU;
314 if (compute_jacobian)
315 this->_stab_helper.compute_tau_momentum_and_derivs
316 ( context, qp, g, G, this->_rho, U, mu_qp,
317 tau_M, d_tau_M_d_rho, d_tau_M_dU,
320 tau_M = this->_stab_helper.compute_tau_momentum
321 ( context, qp, g, G, this->_rho, U, mu_qp,
326 T = context.interior_value(_temp_vars.T(), qp);
328 libMesh::RealGradient d_residual_dT = _rho*_beta_T*_g;
330 libMesh::RealGradient residual = (T-_T_ref)*d_residual_dT;
335 for (
unsigned int i=0; i != n_p_dofs; i++)
337 Fp(i) += tau_M*residual*p_dphi[i][qp]*JxW[qp];
339 if (compute_jacobian)
341 for (
unsigned int j=0; j != n_T_dofs; ++j)
343 KpT(i,j) += tau_M*d_residual_dT*T_phi[j][qp]*p_dphi[i][qp]*JxW[qp] * context.get_elem_solution_derivative();
346 for (
unsigned int j=0; j != n_u_dofs; ++j)
348 Kpu(i,j) += d_tau_M_dU(0)*u_phi[j][qp]*residual*p_dphi[i][qp]*JxW[qp] * context.get_elem_solution_derivative();
349 Kpv(i,j) += d_tau_M_dU(1)*u_phi[j][qp]*residual*p_dphi[i][qp]*JxW[qp] * context.get_elem_solution_derivative();
351 if( this->_flow_vars.dim() == 3 )
352 for (
unsigned int j=0; j != n_u_dofs; ++j)
354 (*Kpw)(i,j) += d_tau_M_dU(2)*u_phi[j][qp]*residual*p_dphi[i][qp]*JxW[qp] * context.get_elem_solution_derivative();
363 (
const std::string & param_name,
368 _mu.register_parameter(param_name, param_pointer);
BoussinesqBuoyancyAdjointStabilization()
INSTANTIATE_INC_NS_SUBCLASS(BoussinesqBuoyancyAdjointStabilization)
virtual void init_context(AssemblyContext &context)
Initialize context for added physics variables.
Helper functions for parsing material properties.
~BoussinesqBuoyancyAdjointStabilization()
virtual void element_time_derivative(bool compute_jacobian, AssemblyContext &context)
Time dependent part(s) of physics for element interiors.
virtual void register_parameter(const std::string ¶m_name, libMesh::ParameterMultiAccessor< libMesh::Number > ¶m_pointer) const
Each subclass will register its copy of an independent.
virtual void element_constraint(bool compute_jacobian, AssemblyContext &context)
Constraint part(s) of physics for element interiors.
virtual void register_parameter(const std::string ¶m_name, libMesh::ParameterMultiAccessor< libMesh::Number > ¶m_pointer) const
Each subclass will register its copy of an independent.