proteus  1.8.1
C/C++/Fortran libraries
Public Member Functions | Public Attributes | List of all members
CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT > Class Template Reference

#include </Users/cekees/proteus/proteus/CompKernel.h>

Collaboration diagram for CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >:
[legend]

Public Member Functions

 CompKernel ()
 
void calculateG (double *jacInv, double *G, double &G_dd_G, double &tr_G)
 
void calculateGScale (double *G, double *v, double &h)
 
void valFromDOF (const double *dof, const int *l2g_element, const double *trial_ref, double &val)
 
void gradFromDOF (const double *dof, const int *l2g_element, const double *grad_trial, double *grad)
 
void hessFromDOF (const double *dof, const int *l2g_element, const double *hess_trial, double *hess)
 
void valFromElementDOF (const double *dof, const double *trial_ref, double &val)
 
void gradFromElementDOF (const double *dof, const double *grad_trial, double *grad)
 
void gradTrialFromRef (const double *grad_trial_ref, const double *jacInv, double *grad_trial)
 
void DOFaverage (const double *dof, const int *l2g_element, double &val)
 
void hessTrialFromRef (const double *hess_trial_ref, const double *jacInv, double *hess_trial)
 
void gradTestFromRef (const double *grad_test_ref, const double *jacInv, double *grad_test)
 
void backwardEuler (const double &dt, const double &m_old, const double &m, const double &dm, double &mt, double &dmt)
 
void bdf (const double &alpha, const double &beta, const double &m, const double &dm, double &mt, double &dmt)
 
void bdfC2 (const double &alpha, const double &beta, const double &m, const double &dm, const double &dm2, double &mt, double &dmt, double &dm2t)
 
double Mass_weak (const double &mt, const double &w_dV)
 
double MassJacobian_weak (const double &dmt, const double &v, const double &w_dV)
 
double Mass_strong (const double &mt)
 
double MassJacobian_strong (const double &dmt, const double &v)
 
double Mass_adjoint (const double &dmt, const double &w_dV)
 
double pressureProjection_weak (const double &viscosity, const double &p, const double &p_avg, const double &q, const double &dV)
 
double Advection_weak (const double f[2], const double grad_w_dV[2])
 
double AdvectionJacobian_weak (const double df[2], const double &v, const double grad_w_dV[2])
 
double Advection_strong (const double df[2], const double grad_u[2])
 
double AdvectionJacobian_strong (const double df[2], const double grad_v[2])
 
double Advection_adjoint (const double df[2], const double grad_w_dV[2])
 
double Hamiltonian_weak (const double &H, const double &w_dV)
 
double HamiltonianJacobian_weak (const double dH[2], const double grad_v[2], const double &w_dV)
 
double Hamiltonian_strong (const double dH[2], const double grad_u[2])
 
double HamiltonianJacobian_strong (const double dH[2], const double grad_v[2])
 
double Hamiltonian_adjoint (const double dH[2], const double grad_w_dV[2])
 
double Diffusion_weak (int *rowptr, int *colind, double *a, const double grad_phi[2], const double grad_w_dV[2])
 
double DiffusionJacobian_weak (int *rowptr, int *colind, double *a, double *da, const double grad_phi[2], const double grad_w_dV[2], const double &dphi, const double &v, const double grad_v[2])
 
double SimpleDiffusionJacobian_weak (int *rowptr, int *colind, double *a, const double grad_v[2], const double grad_w_dV[2])
 
double Reaction_weak (const double &r, const double &w_dV)
 
double ReactionJacobian_weak (const double &dr, const double &v, const double &w_dV)
 
double Reaction_strong (const double &r)
 
double ReactionJacobian_strong (const double &dr, const double &v)
 
double Reaction_adjoint (const double &dr, const double &w_dV)
 
void calculateNumericalDiffusion (const double &shockCapturingDiffusion, const double &elementDiameter, const double &strong_residual, const double grad_u[2], double &numDiff)
 
void calculateNumericalDiffusion (const double &shockCapturingDiffusion, const double G[2 *2], const double &strong_residual, const double grad_u[2], double &numDiff)
 
void calculateNumericalDiffusion (const double &shockCapturingDiffusion, const double &uref, const double &beta, const double G[2 *2], const double &G_dd_G, const double &strong_residual, const double grad_u[2], double &numDiff)
 
void calculateNumericalDiffusion (const double &shockCapturingDiffusion, const double G[2 *2], const double &strong_residual, const double vel[2], const double grad_u[2], double &numDiff)
 
void calculateNumericalDiffusion (const double &shockCapturingDiffusion, const double &elementDiameter, const double &strong_residual, const double grad_u[2], double &gradNorm, double &gradNorm_last, double &numDiff)
 
double SubgridError (const double &error, const double &Lstar_w_dV)
 
double SubgridErrorJacobian (const double &derror, const double &Lstar_w_dV)
 
double NumericalDiffusion (const double &numDiff, const double grad_u[2], const double grad_w_dV[2])
 
double NumericalDiffusionJacobian (const double &numDiff, const double grad_v[2], const double grad_w_dV[2])
 
double ExteriorElementBoundaryFlux (const double &flux, const double &w_dS)
 
double InteriorElementBoundaryFlux (const double &flux, const double &w_dS)
 
double ExteriorNumericalAdvectiveFluxJacobian (const double &dflux_left, const double &v)
 
double InteriorNumericalAdvectiveFluxJacobian (const double &dflux_left, const double &v)
 
double ExteriorElementBoundaryScalarDiffusionAdjoint (const int &isDOFBoundary, const int &isFluxBoundary, const double &sigma, const double &u, const double &bc_u, const double normal[2], const double &a, const double grad_w_dS[2])
 
double ExteriorElementBoundaryScalarDiffusionAdjointJacobian (const int &isDOFBoundary, const int &isFluxBoundary, const double &sigma, const double &v, const double normal[2], const double &a, const double grad_w_dS[2])
 
double ExteriorElementBoundaryDiffusionAdjoint (const int &isDOFBoundary, const int &isFluxBoundary, const double &sigma, const double &u, const double &bc_u, const double normal[2], int *rowptr, int *colind, double *a, const double grad_w_dS[2])
 
double ExteriorElementBoundaryDiffusionAdjointJacobian (const int &isDOFBoundary, const int &isFluxBoundary, const double &sigma, const double &v, const double normal[2], int *rowptr, int *colind, double *a, const double grad_w_dS[2])
 
void calculateMapping_element (const int eN, const int k, double *mesh_dof, int *mesh_l2g, double *mesh_trial_ref, double *mesh_grad_trial_ref, double *jac, double &jacDet, double *jacInv, double &x, double &y)
 
void calculateH_element (const int eN, const int k, double *h_dof, int *mesh_l2g, double *mesh_trial_ref, double &h)
 
void calculateMapping_element (const int eN, const int k, double *mesh_dof, int *mesh_l2g, double *mesh_trial_ref, double *mesh_grad_trial_ref, double *jac, double &jacDet, double *jacInv, double &x, double &y, double &z)
 
void calculateMappingVelocity_element (const int eN, const int k, double *meshVelocity_dof, int *mesh_l2g, double *mesh_trial_ref, double &xt, double &yt)
 
void calculateMappingVelocity_element (const int eN, const int k, double *meshVelocity_dof, int *mesh_l2g, double *mesh_trial_ref, double &xt, double &yt, double &zt)
 
void calculateMapping_elementBoundary (const int eN, const int ebN_local, const int kb, const int ebN_local_kb, double *mesh_dof, int *mesh_l2g, double *mesh_trial_trace_ref, double *mesh_grad_trial_trace_ref, double *boundaryJac_ref, double *jac, double &jacDet, double *jacInv, double *boundaryJac, double *metricTensor, double &metricTensorDetSqrt, double *normal_ref, double *normal, double &x, double &y)
 
void calculateMapping_elementBoundary (const int eN, const int ebN_local, const int kb, const int ebN_local_kb, double *mesh_dof, int *mesh_l2g, double *mesh_trial_trace_ref, double *mesh_grad_trial_trace_ref, double *boundaryJac_ref, double *jac, double &jacDet, double *jacInv, double *boundaryJac, double *metricTensor, double &metricTensorDetSqrt, double *normal_ref, double *normal, double &x, double &y, double &z)
 
void calculateMappingVelocity_elementBoundary (const int eN, const int ebN_local, const int kb, const int ebN_local_kb, double *mesh_velocity_dof, int *mesh_l2g, double *mesh_trial_trace_ref, double &xt, double &yt, double *normal, double *boundaryJac, double *metricTensor, double &metricTensorDetSqrt)
 
void calculateMappingVelocity_elementBoundary (const int eN, const int ebN_local, const int kb, const int ebN_local_kb, double *mesh_velocity_dof, int *mesh_l2g, double *mesh_trial_trace_ref, double &xt, double &yt, double &zt, double *normal, double *boundaryJac, double *metricTensor, double &metricTensorDetSqrt)
 
double Stress_u_weak (double *stress, double *grad_test_dV)
 
double StressJacobian_u_u_weak (double *dstress, double *grad_trial, double *grad_test_dV)
 
double StressJacobian_u_v_weak (double *dstress, double *grad_trial, double *grad_test_dV)
 
double Stress_v_weak (double *stress, double *grad_test_dV)
 
double StressJacobian_v_u_weak (double *dstress, double *grad_trial, double *grad_test_dV)
 
double StressJacobian_v_v_weak (double *dstress, double *grad_trial, double *grad_test_dV)
 
double ExteriorElementBoundaryStressFlux (const double &stressFlux, const double &disp_test_dS)
 
double ExteriorElementBoundaryStressFluxJacobian (const double &dstressFlux, const double &disp_test_dS)
 

Public Attributes

CompKernelSpaceMapping< 2, NDOF_MESH_TRIAL_ELEMENT > mapping
 
const int X
 
const int Y
 
const int XX
 
const int XY
 
const int YX
 
const int YY
 
const int sXX
 
const int sXY
 
const int sYX
 
const int sYY
 
const int nSymTen
 
const int XHX
 
const int YHX
 
const int HXHX
 

Detailed Description

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
class CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >

Definition at line 1856 of file CompKernel.h.

Constructor & Destructor Documentation

◆ CompKernel()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::CompKernel ( )
inline

Definition at line 1870 of file CompKernel.h.

Member Function Documentation

◆ Advection_adjoint()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::Advection_adjoint ( const double  df[2],
const double  grad_w_dV[2] 
)
inline

Definition at line 2126 of file CompKernel.h.

◆ Advection_strong()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::Advection_strong ( const double  df[2],
const double  grad_u[2] 
)
inline

Definition at line 2108 of file CompKernel.h.

◆ Advection_weak()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::Advection_weak ( const double  f[2],
const double  grad_w_dV[2] 
)
inline

Definition at line 2089 of file CompKernel.h.

◆ AdvectionJacobian_strong()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::AdvectionJacobian_strong ( const double  df[2],
const double  grad_v[2] 
)
inline

Definition at line 2117 of file CompKernel.h.

◆ AdvectionJacobian_weak()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::AdvectionJacobian_weak ( const double  df[2],
const double &  v,
const double  grad_w_dV[2] 
)
inline

Definition at line 2098 of file CompKernel.h.

◆ backwardEuler()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
void CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::backwardEuler ( const double &  dt,
const double &  m_old,
const double &  m,
const double &  dm,
double &  mt,
double &  dmt 
)
inline

Definition at line 2013 of file CompKernel.h.

◆ bdf()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
void CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::bdf ( const double &  alpha,
const double &  beta,
const double &  m,
const double &  dm,
double &  mt,
double &  dmt 
)
inline

Definition at line 2019 of file CompKernel.h.

◆ bdfC2()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
void CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::bdfC2 ( const double &  alpha,
const double &  beta,
const double &  m,
const double &  dm,
const double &  dm2,
double &  mt,
double &  dmt,
double &  dm2t 
)
inline

Definition at line 2025 of file CompKernel.h.

◆ calculateG()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
void CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::calculateG ( double *  jacInv,
double *  G,
double &  G_dd_G,
double &  tr_G 
)
inline

Definition at line 1882 of file CompKernel.h.

◆ calculateGScale()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
void CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::calculateGScale ( double *  G,
double *  v,
double &  h 
)
inline

Definition at line 1904 of file CompKernel.h.

◆ calculateH_element()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
void CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::calculateH_element ( const int  eN,
const int  k,
double *  h_dof,
int *  mesh_l2g,
double *  mesh_trial_ref,
double &  h 
)
inline

Definition at line 2495 of file CompKernel.h.

◆ calculateMapping_element() [1/2]

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
void CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::calculateMapping_element ( const int  eN,
const int  k,
double *  mesh_dof,
int *  mesh_l2g,
double *  mesh_trial_ref,
double *  mesh_grad_trial_ref,
double *  jac,
double &  jacDet,
double *  jacInv,
double &  x,
double &  y 
)
inline

Definition at line 2479 of file CompKernel.h.

◆ calculateMapping_element() [2/2]

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
void CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::calculateMapping_element ( const int  eN,
const int  k,
double *  mesh_dof,
int *  mesh_l2g,
double *  mesh_trial_ref,
double *  mesh_grad_trial_ref,
double *  jac,
double &  jacDet,
double *  jacInv,
double &  x,
double &  y,
double &  z 
)
inline

Definition at line 2511 of file CompKernel.h.

◆ calculateMapping_elementBoundary() [1/2]

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
void CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::calculateMapping_elementBoundary ( const int  eN,
const int  ebN_local,
const int  kb,
const int  ebN_local_kb,
double *  mesh_dof,
int *  mesh_l2g,
double *  mesh_trial_trace_ref,
double *  mesh_grad_trial_trace_ref,
double *  boundaryJac_ref,
double *  jac,
double &  jacDet,
double *  jacInv,
double *  boundaryJac,
double *  metricTensor,
double &  metricTensorDetSqrt,
double *  normal_ref,
double *  normal,
double &  x,
double &  y 
)
inline

Definition at line 2554 of file CompKernel.h.

◆ calculateMapping_elementBoundary() [2/2]

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
void CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::calculateMapping_elementBoundary ( const int  eN,
const int  ebN_local,
const int  kb,
const int  ebN_local_kb,
double *  mesh_dof,
int *  mesh_l2g,
double *  mesh_trial_trace_ref,
double *  mesh_grad_trial_trace_ref,
double *  boundaryJac_ref,
double *  jac,
double &  jacDet,
double *  jacInv,
double *  boundaryJac,
double *  metricTensor,
double &  metricTensorDetSqrt,
double *  normal_ref,
double *  normal,
double &  x,
double &  y,
double &  z 
)
inline

Definition at line 2596 of file CompKernel.h.

◆ calculateMappingVelocity_element() [1/2]

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
void CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::calculateMappingVelocity_element ( const int  eN,
const int  k,
double *  meshVelocity_dof,
int *  mesh_l2g,
double *  mesh_trial_ref,
double &  xt,
double &  yt 
)
inline

Definition at line 2528 of file CompKernel.h.

◆ calculateMappingVelocity_element() [2/2]

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
void CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::calculateMappingVelocity_element ( const int  eN,
const int  k,
double *  meshVelocity_dof,
int *  mesh_l2g,
double *  mesh_trial_ref,
double &  xt,
double &  yt,
double &  zt 
)
inline

Definition at line 2540 of file CompKernel.h.

◆ calculateMappingVelocity_elementBoundary() [1/2]

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
void CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::calculateMappingVelocity_elementBoundary ( const int  eN,
const int  ebN_local,
const int  kb,
const int  ebN_local_kb,
double *  mesh_velocity_dof,
int *  mesh_l2g,
double *  mesh_trial_trace_ref,
double &  xt,
double &  yt,
double &  zt,
double *  normal,
double *  boundaryJac,
double *  metricTensor,
double &  metricTensorDetSqrt 
)
inline

Definition at line 2669 of file CompKernel.h.

◆ calculateMappingVelocity_elementBoundary() [2/2]

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
void CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::calculateMappingVelocity_elementBoundary ( const int  eN,
const int  ebN_local,
const int  kb,
const int  ebN_local_kb,
double *  mesh_velocity_dof,
int *  mesh_l2g,
double *  mesh_trial_trace_ref,
double &  xt,
double &  yt,
double *  normal,
double *  boundaryJac,
double *  metricTensor,
double &  metricTensorDetSqrt 
)
inline

Definition at line 2640 of file CompKernel.h.

◆ calculateNumericalDiffusion() [1/5]

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
void CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::calculateNumericalDiffusion ( const double &  shockCapturingDiffusion,
const double &  elementDiameter,
const double &  strong_residual,
const double  grad_u[2],
double &  gradNorm,
double &  gradNorm_last,
double &  numDiff 
)
inline

Definition at line 2330 of file CompKernel.h.

◆ calculateNumericalDiffusion() [2/5]

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
void CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::calculateNumericalDiffusion ( const double &  shockCapturingDiffusion,
const double &  elementDiameter,
const double &  strong_residual,
const double  grad_u[2],
double &  numDiff 
)
inline

Definition at line 2256 of file CompKernel.h.

◆ calculateNumericalDiffusion() [3/5]

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
void CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::calculateNumericalDiffusion ( const double &  shockCapturingDiffusion,
const double &  uref,
const double &  beta,
const double  G[2 *2],
const double &  G_dd_G,
const double &  strong_residual,
const double  grad_u[2],
double &  numDiff 
)
inline

Definition at line 2291 of file CompKernel.h.

◆ calculateNumericalDiffusion() [4/5]

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
void CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::calculateNumericalDiffusion ( const double &  shockCapturingDiffusion,
const double  G[2 *2],
const double &  strong_residual,
const double  grad_u[2],
double &  numDiff 
)
inline

Definition at line 2277 of file CompKernel.h.

◆ calculateNumericalDiffusion() [5/5]

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
void CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::calculateNumericalDiffusion ( const double &  shockCapturingDiffusion,
const double  G[2 *2],
const double &  strong_residual,
const double  vel[2],
const double  grad_u[2],
double &  numDiff 
)
inline

Definition at line 2311 of file CompKernel.h.

◆ Diffusion_weak()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::Diffusion_weak ( int *  rowptr,
int *  colind,
double *  a,
const double  grad_phi[2],
const double  grad_w_dV[2] 
)
inline

Definition at line 2178 of file CompKernel.h.

◆ DiffusionJacobian_weak()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::DiffusionJacobian_weak ( int *  rowptr,
int *  colind,
double *  a,
double *  da,
const double  grad_phi[2],
const double  grad_w_dV[2],
const double &  dphi,
const double &  v,
const double  grad_v[2] 
)
inline

Definition at line 2191 of file CompKernel.h.

◆ DOFaverage()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
void CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::DOFaverage ( const double *  dof,
const int *  l2g_element,
double &  val 
)
inline

Definition at line 1977 of file CompKernel.h.

◆ ExteriorElementBoundaryDiffusionAdjoint()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::ExteriorElementBoundaryDiffusionAdjoint ( const int &  isDOFBoundary,
const int &  isFluxBoundary,
const double &  sigma,
const double &  u,
const double &  bc_u,
const double  normal[2],
int *  rowptr,
int *  colind,
double *  a,
const double  grad_w_dS[2] 
)
inline

Definition at line 2444 of file CompKernel.h.

◆ ExteriorElementBoundaryDiffusionAdjointJacobian()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::ExteriorElementBoundaryDiffusionAdjointJacobian ( const int &  isDOFBoundary,
const int &  isFluxBoundary,
const double &  sigma,
const double &  v,
const double  normal[2],
int *  rowptr,
int *  colind,
double *  a,
const double  grad_w_dS[2] 
)
inline

Definition at line 2462 of file CompKernel.h.

◆ ExteriorElementBoundaryFlux()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::ExteriorElementBoundaryFlux ( const double &  flux,
const double &  w_dS 
)
inline

Definition at line 2385 of file CompKernel.h.

◆ ExteriorElementBoundaryScalarDiffusionAdjoint()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::ExteriorElementBoundaryScalarDiffusionAdjoint ( const int &  isDOFBoundary,
const int &  isFluxBoundary,
const double &  sigma,
const double &  u,
const double &  bc_u,
const double  normal[2],
const double &  a,
const double  grad_w_dS[2] 
)
inline

Definition at line 2409 of file CompKernel.h.

◆ ExteriorElementBoundaryScalarDiffusionAdjointJacobian()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::ExteriorElementBoundaryScalarDiffusionAdjointJacobian ( const int &  isDOFBoundary,
const int &  isFluxBoundary,
const double &  sigma,
const double &  v,
const double  normal[2],
const double &  a,
const double  grad_w_dS[2] 
)
inline

Definition at line 2427 of file CompKernel.h.

◆ ExteriorElementBoundaryStressFlux()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::ExteriorElementBoundaryStressFlux ( const double &  stressFlux,
const double &  disp_test_dS 
)
inline

Definition at line 2731 of file CompKernel.h.

◆ ExteriorElementBoundaryStressFluxJacobian()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::ExteriorElementBoundaryStressFluxJacobian ( const double &  dstressFlux,
const double &  disp_test_dS 
)
inline

Definition at line 2735 of file CompKernel.h.

◆ ExteriorNumericalAdvectiveFluxJacobian()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::ExteriorNumericalAdvectiveFluxJacobian ( const double &  dflux_left,
const double &  v 
)
inline

Definition at line 2397 of file CompKernel.h.

◆ gradFromDOF()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
void CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::gradFromDOF ( const double *  dof,
const int *  l2g_element,
const double *  grad_trial,
double *  grad 
)
inline

Definition at line 1919 of file CompKernel.h.

◆ gradFromElementDOF()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
void CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::gradFromElementDOF ( const double *  dof,
const double *  grad_trial,
double *  grad 
)
inline

Definition at line 1946 of file CompKernel.h.

◆ gradTestFromRef()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
void CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::gradTestFromRef ( const double *  grad_test_ref,
const double *  jacInv,
double *  grad_test 
)
inline

Definition at line 2002 of file CompKernel.h.

◆ gradTrialFromRef()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
void CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::gradTrialFromRef ( const double *  grad_trial_ref,
const double *  jacInv,
double *  grad_trial 
)
inline

Definition at line 1955 of file CompKernel.h.

◆ Hamiltonian_adjoint()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::Hamiltonian_adjoint ( const double  dH[2],
const double  grad_w_dV[2] 
)
inline

Definition at line 2169 of file CompKernel.h.

◆ Hamiltonian_strong()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::Hamiltonian_strong ( const double  dH[2],
const double  grad_u[2] 
)
inline

Definition at line 2151 of file CompKernel.h.

◆ Hamiltonian_weak()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::Hamiltonian_weak ( const double &  H,
const double &  w_dV 
)
inline

Definition at line 2135 of file CompKernel.h.

◆ HamiltonianJacobian_strong()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::HamiltonianJacobian_strong ( const double  dH[2],
const double  grad_v[2] 
)
inline

Definition at line 2160 of file CompKernel.h.

◆ HamiltonianJacobian_weak()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::HamiltonianJacobian_weak ( const double  dH[2],
const double  grad_v[2],
const double &  w_dV 
)
inline

Definition at line 2141 of file CompKernel.h.

◆ hessFromDOF()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
void CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::hessFromDOF ( const double *  dof,
const int *  l2g_element,
const double *  hess_trial,
double *  hess 
)
inline

Definition at line 1928 of file CompKernel.h.

◆ hessTrialFromRef()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
void CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::hessTrialFromRef ( const double *  hess_trial_ref,
const double *  jacInv,
double *  hess_trial 
)
inline

Definition at line 1988 of file CompKernel.h.

◆ InteriorElementBoundaryFlux()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::InteriorElementBoundaryFlux ( const double &  flux,
const double &  w_dS 
)
inline

Definition at line 2391 of file CompKernel.h.

◆ InteriorNumericalAdvectiveFluxJacobian()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::InteriorNumericalAdvectiveFluxJacobian ( const double &  dflux_left,
const double &  v 
)
inline

Definition at line 2403 of file CompKernel.h.

◆ Mass_adjoint()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::Mass_adjoint ( const double &  dmt,
const double &  w_dV 
)
inline

Definition at line 2055 of file CompKernel.h.

◆ Mass_strong()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::Mass_strong ( const double &  mt)
inline

Definition at line 2044 of file CompKernel.h.

◆ Mass_weak()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::Mass_weak ( const double &  mt,
const double &  w_dV 
)
inline

Definition at line 2032 of file CompKernel.h.

◆ MassJacobian_strong()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::MassJacobian_strong ( const double &  dmt,
const double &  v 
)
inline

Definition at line 2049 of file CompKernel.h.

◆ MassJacobian_weak()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::MassJacobian_weak ( const double &  dmt,
const double &  v,
const double &  w_dV 
)
inline

Definition at line 2037 of file CompKernel.h.

◆ NumericalDiffusion()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::NumericalDiffusion ( const double &  numDiff,
const double  grad_u[2],
const double  grad_w_dV[2] 
)
inline

Definition at line 2363 of file CompKernel.h.

◆ NumericalDiffusionJacobian()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::NumericalDiffusionJacobian ( const double &  numDiff,
const double  grad_v[2],
const double  grad_w_dV[2] 
)
inline

Definition at line 2373 of file CompKernel.h.

◆ pressureProjection_weak()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::pressureProjection_weak ( const double &  viscosity,
const double &  p,
const double &  p_avg,
const double &  q,
const double &  dV 
)
inline

Definition at line 2079 of file CompKernel.h.

◆ Reaction_adjoint()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::Reaction_adjoint ( const double &  dr,
const double &  w_dV 
)
inline

Definition at line 2250 of file CompKernel.h.

◆ Reaction_strong()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::Reaction_strong ( const double &  r)
inline

Definition at line 2239 of file CompKernel.h.

◆ Reaction_weak()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::Reaction_weak ( const double &  r,
const double &  w_dV 
)
inline

Definition at line 2226 of file CompKernel.h.

◆ ReactionJacobian_strong()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::ReactionJacobian_strong ( const double &  dr,
const double &  v 
)
inline

Definition at line 2244 of file CompKernel.h.

◆ ReactionJacobian_weak()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::ReactionJacobian_weak ( const double &  dr,
const double &  v,
const double &  w_dV 
)
inline

Definition at line 2232 of file CompKernel.h.

◆ SimpleDiffusionJacobian_weak()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::SimpleDiffusionJacobian_weak ( int *  rowptr,
int *  colind,
double *  a,
const double  grad_v[2],
const double  grad_w_dV[2] 
)
inline

Definition at line 2211 of file CompKernel.h.

◆ Stress_u_weak()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::Stress_u_weak ( double *  stress,
double *  grad_test_dV 
)
inline

Definition at line 2699 of file CompKernel.h.

◆ Stress_v_weak()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::Stress_v_weak ( double *  stress,
double *  grad_test_dV 
)
inline

Definition at line 2715 of file CompKernel.h.

◆ StressJacobian_u_u_weak()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::StressJacobian_u_u_weak ( double *  dstress,
double *  grad_trial,
double *  grad_test_dV 
)
inline

Definition at line 2703 of file CompKernel.h.

◆ StressJacobian_u_v_weak()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::StressJacobian_u_v_weak ( double *  dstress,
double *  grad_trial,
double *  grad_test_dV 
)
inline

Definition at line 2709 of file CompKernel.h.

◆ StressJacobian_v_u_weak()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::StressJacobian_v_u_weak ( double *  dstress,
double *  grad_trial,
double *  grad_test_dV 
)
inline

Definition at line 2719 of file CompKernel.h.

◆ StressJacobian_v_v_weak()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::StressJacobian_v_v_weak ( double *  dstress,
double *  grad_trial,
double *  grad_test_dV 
)
inline

Definition at line 2725 of file CompKernel.h.

◆ SubgridError()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::SubgridError ( const double &  error,
const double &  Lstar_w_dV 
)
inline

Definition at line 2351 of file CompKernel.h.

◆ SubgridErrorJacobian()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
double CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::SubgridErrorJacobian ( const double &  derror,
const double &  Lstar_w_dV 
)
inline

Definition at line 2357 of file CompKernel.h.

◆ valFromDOF()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
void CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::valFromDOF ( const double *  dof,
const int *  l2g_element,
const double *  trial_ref,
double &  val 
)
inline

Definition at line 1912 of file CompKernel.h.

◆ valFromElementDOF()

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
void CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::valFromElementDOF ( const double *  dof,
const double *  trial_ref,
double &  val 
)
inline

Definition at line 1939 of file CompKernel.h.

Member Data Documentation

◆ HXHX

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
const int CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::HXHX

Definition at line 1869 of file CompKernel.h.

◆ mapping

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
CompKernelSpaceMapping<2,NDOF_MESH_TRIAL_ELEMENT> CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::mapping

Definition at line 1859 of file CompKernel.h.

◆ nSymTen

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
const int CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::nSymTen

Definition at line 1866 of file CompKernel.h.

◆ sXX

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
const int CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::sXX

Definition at line 1864 of file CompKernel.h.

◆ sXY

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
const int CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::sXY

Definition at line 1864 of file CompKernel.h.

◆ sYX

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
const int CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::sYX

Definition at line 1865 of file CompKernel.h.

◆ sYY

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
const int CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::sYY

Definition at line 1865 of file CompKernel.h.

◆ X

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
const int CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::X

Definition at line 1860 of file CompKernel.h.

◆ XHX

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
const int CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::XHX

Definition at line 1867 of file CompKernel.h.

◆ XX

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
const int CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::XX

Definition at line 1862 of file CompKernel.h.

◆ XY

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
const int CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::XY

Definition at line 1862 of file CompKernel.h.

◆ Y

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
const int CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::Y

Definition at line 1861 of file CompKernel.h.

◆ YHX

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
const int CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::YHX

Definition at line 1868 of file CompKernel.h.

◆ YX

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
const int CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::YX

Definition at line 1863 of file CompKernel.h.

◆ YY

template<int NDOF_MESH_TRIAL_ELEMENT, int NDOF_TRIAL_ELEMENT, int NDOF_TEST_ELEMENT>
const int CompKernel< 2, NDOF_MESH_TRIAL_ELEMENT, NDOF_TRIAL_ELEMENT, NDOF_TEST_ELEMENT >::YY

Definition at line 1863 of file CompKernel.h.


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