www.mooseframework.org
Public Member Functions | Protected Member Functions | Protected Attributes | List of all members
GeneralizedPlaneStrainOffDiagOSPD Class Reference

Kernel class for coupled off diagonal Jacobian entries of ordinary state-based peridynamic generalized plane strain model. More...

#include <GeneralizedPlaneStrainOffDiagOSPD.h>

Inheritance diagram for GeneralizedPlaneStrainOffDiagOSPD:
[legend]

Public Member Functions

 GeneralizedPlaneStrainOffDiagOSPD (const InputParameters &parameters)
 
virtual void computeOffDiagJacobian (MooseVariableFEBase &jvar) override
 
virtual void computeLocalOffDiagJacobian (unsigned int)
 Function to compute local contribution to the off-diagonal Jacobian at the current nodes. More...
 
virtual void computePDNonlocalOffDiagJacobian (unsigned int, unsigned int)
 Function to compute nonlocal contribution to the off-diagonal Jacobian at the current nodes. More...
 
virtual void initialSetup () override
 
virtual void prepare () override
 

Protected Member Functions

virtual void computeLocalResidual () override
 
virtual void computeOffDiagJacobianScalar (unsigned int jvar_num) override
 
void computeDispFullOffDiagJacobianScalar (unsigned int component, unsigned int jvar_num)
 Function to compute the full off diagonal Jacobian for coupling between displacements and scalar variable. More...
 
void computeDispPartialOffDiagJacobianScalar (unsigned int component, unsigned int jvar_num)
 Function to compute partial off diagonal Jacobian for coupling between displacements and scalar variable. More...
 
void computeTempOffDiagJacobianScalar (unsigned int jvar_num)
 Function to compute off disgonal Jacobian for coupling between temperature and scalar variable. More...
 

Protected Attributes

const MaterialProperty< RankFourTensor > & _Cijkl
 Material point based material property. More...
 
const unsigned int _scalar_out_of_plane_strain_var_num
 The variable number of the scalar out-of-plane strain variable. More...
 
std::vector< MooseVariable * > _disp_var
 displacement variables More...
 
unsigned int _ndisp
 number of displacement components More...
 
const std::vector< RealGradient > * _orientation
 Vector of bond in current configuration. More...
 
std::vector< dof_id_type > _ivardofs_ij
 Current variable dof numbers for nodes i and j. More...
 
RealGradient _cur_ori_ij
 Vector of bond in current configuration. More...
 
Real _cur_len_ij
 Current bond length. More...
 
const MaterialProperty< Real > & _bond_dfdE_ij
 Bond based material properties. More...
 
const MaterialProperty< Real > & _bond_dfdE_i_j
 
const MaterialProperty< Real > & _alpha
 
const bool _temp_coupled
 Temperature variable. More...
 
MooseVariable * _temp_var
 
const bool _out_of_plane_strain_coupled
 Parameters for out-of-plane strain in weak plane stress formulation. More...
 
MooseVariable * _out_of_plane_strain_var
 

Detailed Description

Kernel class for coupled off diagonal Jacobian entries of ordinary state-based peridynamic generalized plane strain model.

Definition at line 23 of file GeneralizedPlaneStrainOffDiagOSPD.h.

Constructor & Destructor Documentation

◆ GeneralizedPlaneStrainOffDiagOSPD()

GeneralizedPlaneStrainOffDiagOSPD::GeneralizedPlaneStrainOffDiagOSPD ( const InputParameters &  parameters)

Definition at line 34 of file GeneralizedPlaneStrainOffDiagOSPD.C.

36  : MechanicsBasePD(parameters),
37  _bond_dfdE_ij(getMaterialProperty<Real>("bond_dfdE_ij")),
38  _bond_dfdE_i_j(getMaterialProperty<Real>("bond_dfdE_i_j")),
39  _alpha(getMaterialProperty<Real>("thermal_expansion_coeff")),
40  _Cijkl(getMaterialProperty<RankFourTensor>("elasticity_tensor")),
41  _scalar_out_of_plane_strain_var_num(coupledScalar("scalar_out_of_plane_strain"))
42 {
43  // Consistency check
44  if (_disp_var.size() != 2)
45  mooseError("GeneralizedPlaneStrain only works for two dimensional case!");
46 }

Member Function Documentation

◆ computeDispFullOffDiagJacobianScalar()

void GeneralizedPlaneStrainOffDiagOSPD::computeDispFullOffDiagJacobianScalar ( unsigned int  component,
unsigned int  jvar_num 
)
protected

Function to compute the full off diagonal Jacobian for coupling between displacements and scalar variable.

Parameters
componentThe index of displacement component
jvar_numThe coupled scalar variable number

Definition at line 71 of file GeneralizedPlaneStrainOffDiagOSPD.C.

73 {
74 
75  DenseMatrix<Number> & ken = _assembly.jacobianBlock(_var.number(), jvar_num);
76  DenseMatrix<Number> & kne = _assembly.jacobianBlock(jvar_num, _var.number());
77  MooseVariableScalar & jvar = _sys.getScalarVariable(_tid, jvar_num);
78 
79  // LOCAL jacobian contribution
80  // fill in the column corresponding to the scalar variable from bond ij
81  for (_i = 0; _i < _test.size(); _i++)
82  for (_j = 0; _j < jvar.order(); _j++)
83  ken(_i, _j) +=
84  (_i == _j ? -1 : 1) * _cur_ori_ij(component) * _bond_dfdE_ij[0] * _bond_status_ij;
85 
86  // NONLOCAL jacobian contribution
87  std::vector<dof_id_type> ivardofs(_nnodes), neighbors(_nnodes), bonds(_nnodes);
88  // for off-diagonal low components
89  RankTwoTensor delta(RankTwoTensor::initIdentity);
90  std::vector<RankTwoTensor> shape(_nnodes), dgrad(_nnodes);
91 
92  for (unsigned int cur_nd = 0; cur_nd < _nnodes; cur_nd++)
93  {
94  if (_dim == 2)
95  shape[cur_nd](2, 2) = dgrad[cur_nd](2, 2) = 1.0;
96 
97  // calculation of jacobian contribution to current node's neighbors
98  ivardofs[cur_nd] = _ivardofs_ij[cur_nd];
99  neighbors = _pdmesh.getNeighbors(_current_elem->node_id(cur_nd));
100  bonds = _pdmesh.getBonds(_current_elem->node_id(cur_nd));
101  for (unsigned int k = 0; k < neighbors.size(); k++)
102  {
103  Node * node_k = _pdmesh.nodePtr(neighbors[k]);
104  ivardofs[1 - cur_nd] = node_k->dof_number(_sys.number(), _var.number(), 0);
105  Real vol_k = _pdmesh.getPDNodeVolume(neighbors[k]);
106 
107  // obtain bond k's origin length and current orientation
108  RealGradient origin_ori_k = *node_k - *_pdmesh.nodePtr(_current_elem->node_id(cur_nd));
109 
110  RealGradient current_ori_k(_dim);
111  for (unsigned int j = 0; j < _dim; j++)
112  current_ori_k(j) = origin_ori_k(j) + _disp_var[j]->getNodalValue(*node_k) -
113  _disp_var[j]->getNodalValue(*_current_elem->node_ptr(cur_nd));
114 
115  Real origin_len_k = origin_ori_k.norm();
116  Real current_len_k = current_ori_k.norm();
117 
118  // bond status for bond k
119  Real bond_status_k = _bond_status_var->getElementalValue(_pdmesh.elemPtr(bonds[k]));
120 
121  // prepare shape tensor and deformation gradient tensor for current node
122  for (unsigned int m = 0; m < _dim; m++)
123  for (unsigned int n = 0; n < _dim; n++)
124  {
125  shape[cur_nd](m, n) += vol_k * _horiz_rad[cur_nd] / origin_len_k * origin_ori_k(m) *
126  origin_ori_k(n) * bond_status_k;
127  dgrad[cur_nd](m, n) += vol_k * _horiz_rad[cur_nd] / origin_len_k * current_ori_k(m) *
128  origin_ori_k(n) * bond_status_k;
129  }
130 
131  // cache the nonlocal jacobian contribution
132  _local_ke.resize(ken.m(), ken.n());
133  _local_ke.zero();
134  _local_ke(0, 0) = (cur_nd == 0 ? -1 : 1) * current_ori_k(component) / current_len_k *
135  _bond_dfdE_i_j[cur_nd] / origin_len_k * vol_k * bond_status_k *
136  _bond_status_ij;
137  _local_ke(1, 0) = (cur_nd == 0 ? 1 : -1) * current_ori_k(component) / current_len_k *
138  _bond_dfdE_i_j[cur_nd] / origin_len_k * vol_k * bond_status_k *
139  _bond_status_ij;
140 
141  _assembly.cacheJacobianBlock(_local_ke, ivardofs, jvar.dofIndices(), _var.scalingFactor());
142  }
143 
144  // finalize the shape tensor and deformation gradient tensor for node_i
145  if (MooseUtils::absoluteFuzzyEqual(shape[cur_nd].det(), 0.0))
146  {
147  shape[cur_nd] = delta;
148  dgrad[cur_nd] = delta;
149  }
150  else
151  {
152  // inverse the shape tensor at node i
153  shape[cur_nd] = shape[cur_nd].inverse();
154  // calculate the deformation gradient tensor at node i
155  dgrad[cur_nd] = dgrad[cur_nd] * shape[cur_nd];
156  }
157  }
158 
159  // off-diagonal jacobian entries on the row
160  Real dEidUi = -_vols_ij[1] * _horiz_rad[0] / _origin_vec_ij.norm() *
161  (_Cijkl[0](2, 2, 0, 0) *
162  (_origin_vec_ij(0) * shape[0](0, 0) + _origin_vec_ij(1) * shape[0](1, 0)) *
163  dgrad[0](component, 0) +
164  _Cijkl[0](2, 2, 1, 1) *
165  (_origin_vec_ij(0) * shape[0](0, 1) + _origin_vec_ij(1) * shape[0](1, 1)) *
166  dgrad[0](component, 1));
167  Real dEjdUj = _vols_ij[0] * _horiz_rad[1] / _origin_vec_ij.norm() *
168  (_Cijkl[0](2, 2, 0, 0) *
169  (_origin_vec_ij(0) * shape[1](0, 0) + _origin_vec_ij(1) * shape[1](1, 0)) *
170  dgrad[1](component, 0) +
171  _Cijkl[0](2, 2, 1, 1) *
172  (_origin_vec_ij(0) * shape[1](0, 1) + _origin_vec_ij(1) * shape[1](1, 1)) *
173  dgrad[1](component, 1));
174 
175  // fill in the row corresponding to the scalar variable
176  kne(0, 0) += (dEidUi * _vols_ij[0] - dEjdUj * _vols_ij[1]) * _bond_status_ij; // node i
177  kne(0, 1) += (dEjdUj * _vols_ij[1] - dEidUi * _vols_ij[0]) * _bond_status_ij; // node j
178 }

Referenced by computeOffDiagJacobianScalar().

◆ computeDispPartialOffDiagJacobianScalar()

void GeneralizedPlaneStrainOffDiagOSPD::computeDispPartialOffDiagJacobianScalar ( unsigned int  component,
unsigned int  jvar_num 
)
protected

Function to compute partial off diagonal Jacobian for coupling between displacements and scalar variable.

Parameters
componentThe index of displacement component
jvar_numThe coupled scalar variable number

Definition at line 181 of file GeneralizedPlaneStrainOffDiagOSPD.C.

183 {
184  DenseMatrix<Number> & ken = _assembly.jacobianBlock(_var.number(), jvar_num);
185  DenseMatrix<Number> & kne = _assembly.jacobianBlock(jvar_num, _var.number());
186  MooseVariableScalar & jvar = _sys.getScalarVariable(_tid, jvar_num);
187 
188  // fill in the column corresponding to the scalar variable from bond ij
189  for (_i = 0; _i < _test.size(); _i++)
190  for (_j = 0; _j < jvar.order(); _j++)
191  {
192  ken(_i, _j) +=
193  (_i == _j ? -1 : 1) * _cur_ori_ij(component) * _bond_dfdE_ij[0] * _bond_status_ij;
194  kne(_j, _i) +=
195  (_i == _j ? -1 : 1) * _cur_ori_ij(component) * _bond_dfdE_ij[0] * _bond_status_ij;
196  }
197 }

Referenced by computeOffDiagJacobianScalar().

◆ computeLocalOffDiagJacobian()

virtual void MechanicsBasePD::computeLocalOffDiagJacobian ( unsigned int  )
inlinevirtualinherited

Function to compute local contribution to the off-diagonal Jacobian at the current nodes.

Parameters
coupled_componentThe coupled variable number

Reimplemented in MechanicsBPD, MechanicsOSPD, FiniteStrainMechanicsNOSPD, ForceStabilizedSmallStrainMechanicsNOSPD, SmallStrainMechanicsNOSPD, and WeakPlaneStressNOSPD.

Definition at line 35 of file MechanicsBasePD.h.

35 {};

Referenced by MechanicsBasePD::computeOffDiagJacobian().

◆ computeLocalResidual()

virtual void GeneralizedPlaneStrainOffDiagOSPD::computeLocalResidual ( )
inlineoverrideprotectedvirtual

Definition at line 29 of file GeneralizedPlaneStrainOffDiagOSPD.h.

29 {};

◆ computeOffDiagJacobian()

void MechanicsBasePD::computeOffDiagJacobian ( MooseVariableFEBase &  jvar)
overridevirtualinherited

Definition at line 71 of file MechanicsBasePD.C.

72 {
73  prepare();
74 
75  if (jvar.number() == _var.number())
76  computeJacobian();
77  else
78  {
79  unsigned int coupled_component = 0;
80  bool active = false;
81 
82  for (unsigned int i = 0; i < _dim; ++i)
83  if (jvar.number() == _disp_var[i]->number())
84  {
85  coupled_component = i;
86  active = true;
87  }
88 
89  if (_temp_coupled && jvar.number() == _temp_var->number())
90  {
91  coupled_component = 3;
92  active = true;
93  }
94 
95  if (_out_of_plane_strain_coupled && jvar.number() == _out_of_plane_strain_var->number())
96  {
97  coupled_component = 4;
98  active = true;
99  }
100 
101  if (active)
102  {
103  DenseMatrix<Number> & ke = _assembly.jacobianBlock(_var.number(), jvar.number());
104  _local_ke.resize(ke.m(), ke.n());
105  _local_ke.zero();
106 
107  computeLocalOffDiagJacobian(coupled_component);
108 
109  ke += _local_ke;
110 
111  if (_use_full_jacobian)
112  computePDNonlocalOffDiagJacobian(jvar.number(), coupled_component);
113  }
114  }
115 }

◆ computeOffDiagJacobianScalar()

void GeneralizedPlaneStrainOffDiagOSPD::computeOffDiagJacobianScalar ( unsigned int  jvar_num)
overrideprotectedvirtual

Definition at line 49 of file GeneralizedPlaneStrainOffDiagOSPD.C.

50 {
52  {
53  prepare();
54 
55  if (_var.number() == _disp_var[0]->number())
56  if (_use_full_jacobian)
58  else
60  else if (_var.number() == _disp_var[1]->number())
61  if (_use_full_jacobian)
63  else
65  else if (_temp_coupled ? _var.number() == _temp_var->number() : 0)
67  }
68 }

◆ computePDNonlocalOffDiagJacobian()

virtual void MechanicsBasePD::computePDNonlocalOffDiagJacobian ( unsigned int  ,
unsigned int   
)
inlinevirtualinherited

Function to compute nonlocal contribution to the off-diagonal Jacobian at the current nodes.

Parameters
jvar_numThe number of the first coupled variable
coupled_componentThe component number of the second coupled variable

Reimplemented in MechanicsOSPD, FiniteStrainMechanicsNOSPD, ForceStabilizedSmallStrainMechanicsNOSPD, SmallStrainMechanicsNOSPD, and WeakPlaneStressNOSPD.

Definition at line 42 of file MechanicsBasePD.h.

43  {};

Referenced by MechanicsBasePD::computeOffDiagJacobian().

◆ computeTempOffDiagJacobianScalar()

void GeneralizedPlaneStrainOffDiagOSPD::computeTempOffDiagJacobianScalar ( unsigned int  jvar_num)
protected

Function to compute off disgonal Jacobian for coupling between temperature and scalar variable.

Parameters
jvar_numThe coupled scalar variable number

Definition at line 200 of file GeneralizedPlaneStrainOffDiagOSPD.C.

201 {
202  // off-diagonal jacobian entries on the row
203 
204  DenseMatrix<Number> & kne = _assembly.jacobianBlock(jvar_num, _var.number());
205 
206  // number of neighbors for node i and j
207  unsigned int nn_i = _pdmesh.getNeighbors(_current_elem->node_id(0)).size();
208  unsigned int nn_j = _pdmesh.getNeighbors(_current_elem->node_id(1)).size();
209 
210  // one-way coupling between the strain_zz and temperature. fill in the row corresponding to the
211  // scalar variable strain_zz
212  kne(0, 0) += -_alpha[0] *
213  (_Cijkl[0](2, 2, 0, 0) + _Cijkl[0](2, 2, 1, 1) + _Cijkl[0](2, 2, 2, 2)) *
214  _vols_ij[0] / nn_i; // node i
215  kne(0, 1) += -_alpha[0] *
216  (_Cijkl[0](2, 2, 0, 0) + _Cijkl[0](2, 2, 1, 1) + _Cijkl[0](2, 2, 2, 2)) *
217  _vols_ij[1] / nn_j; // node j
218 }

Referenced by computeOffDiagJacobianScalar().

◆ initialSetup()

void MechanicsBasePD::initialSetup ( )
overridevirtualinherited

Definition at line 47 of file MechanicsBasePD.C.

48 {
49  _orientation = &_assembly.getFE(FEType(), 1)->get_dxyzdxi();
50 }

◆ prepare()

void MechanicsBasePD::prepare ( )
overridevirtualinherited

Definition at line 53 of file MechanicsBasePD.C.

54 {
56 
57  _ivardofs_ij.resize(_nnodes);
58 
59  for (unsigned int i = 0; i < _nnodes; ++i)
60  _ivardofs_ij[i] = _current_elem->node_ptr(i)->dof_number(_sys.number(), _var.number(), 0);
61 
62  for (unsigned int i = 0; i < _dim; ++i)
63  _cur_ori_ij(i) = _origin_vec_ij(i) + _disp_var[i]->getNodalValue(*_current_elem->node_ptr(1)) -
64  _disp_var[i]->getNodalValue(*_current_elem->node_ptr(0));
65 
66  _cur_len_ij = _cur_ori_ij.norm();
68 }

Referenced by MechanicsBasePD::computeOffDiagJacobian(), computeOffDiagJacobianScalar(), and GeneralizedPlaneStrainOffDiagNOSPD::computeOffDiagJacobianScalar().

Member Data Documentation

◆ _alpha

const MaterialProperty<Real>& GeneralizedPlaneStrainOffDiagOSPD::_alpha
protected

◆ _bond_dfdE_i_j

const MaterialProperty<Real>& GeneralizedPlaneStrainOffDiagOSPD::_bond_dfdE_i_j
protected

◆ _bond_dfdE_ij

const MaterialProperty<Real>& GeneralizedPlaneStrainOffDiagOSPD::_bond_dfdE_ij
protected

Bond based material properties.

Definition at line 55 of file GeneralizedPlaneStrainOffDiagOSPD.h.

Referenced by computeDispFullOffDiagJacobianScalar(), and computeDispPartialOffDiagJacobianScalar().

◆ _Cijkl

const MaterialProperty<RankFourTensor>& GeneralizedPlaneStrainOffDiagOSPD::_Cijkl
protected

Material point based material property.

Definition at line 61 of file GeneralizedPlaneStrainOffDiagOSPD.h.

Referenced by computeDispFullOffDiagJacobianScalar(), and computeTempOffDiagJacobianScalar().

◆ _cur_len_ij

Real MechanicsBasePD::_cur_len_ij
protectedinherited

◆ _cur_ori_ij

RealGradient MechanicsBasePD::_cur_ori_ij
protectedinherited

◆ _disp_var

std::vector<MooseVariable *> MechanicsBasePD::_disp_var
protectedinherited

◆ _ivardofs_ij

std::vector<dof_id_type> MechanicsBasePD::_ivardofs_ij
protectedinherited

◆ _ndisp

unsigned int MechanicsBasePD::_ndisp
protectedinherited

number of displacement components

Definition at line 58 of file MechanicsBasePD.h.

Referenced by MechanicsBasePD::MechanicsBasePD().

◆ _orientation

const std::vector<RealGradient>* MechanicsBasePD::_orientation
protectedinherited

Vector of bond in current configuration.

Definition at line 66 of file MechanicsBasePD.h.

Referenced by MechanicsBasePD::initialSetup().

◆ _out_of_plane_strain_coupled

const bool MechanicsBasePD::_out_of_plane_strain_coupled
protectedinherited

Parameters for out-of-plane strain in weak plane stress formulation.

Definition at line 61 of file MechanicsBasePD.h.

Referenced by MechanicsBasePD::computeOffDiagJacobian().

◆ _out_of_plane_strain_var

MooseVariable* MechanicsBasePD::_out_of_plane_strain_var
protectedinherited

Definition at line 62 of file MechanicsBasePD.h.

Referenced by MechanicsBasePD::computeOffDiagJacobian().

◆ _scalar_out_of_plane_strain_var_num

const unsigned int GeneralizedPlaneStrainOffDiagOSPD::_scalar_out_of_plane_strain_var_num
protected

The variable number of the scalar out-of-plane strain variable.

Definition at line 64 of file GeneralizedPlaneStrainOffDiagOSPD.h.

Referenced by computeOffDiagJacobianScalar().

◆ _temp_coupled

const bool MechanicsBasePD::_temp_coupled
protectedinherited

◆ _temp_var

MooseVariable* MechanicsBasePD::_temp_var
protectedinherited

The documentation for this class was generated from the following files:
MechanicsBasePD::MechanicsBasePD
MechanicsBasePD(const InputParameters &parameters)
Definition: MechanicsBasePD.C:29
MechanicsBasePD::_cur_ori_ij
RealGradient _cur_ori_ij
Vector of bond in current configuration.
Definition: MechanicsBasePD.h:72
MechanicsBasePD::_temp_var
MooseVariable * _temp_var
Definition: MechanicsBasePD.h:54
MechanicsBasePD::_temp_coupled
const bool _temp_coupled
Temperature variable.
Definition: MechanicsBasePD.h:53
GeneralizedPlaneStrainOffDiagOSPD::_alpha
const MaterialProperty< Real > & _alpha
Definition: GeneralizedPlaneStrainOffDiagOSPD.h:57
GeneralizedPlaneStrainOffDiagOSPD::_Cijkl
const MaterialProperty< RankFourTensor > & _Cijkl
Material point based material property.
Definition: GeneralizedPlaneStrainOffDiagOSPD.h:61
libMesh::RealGradient
VectorValue< Real > RealGradient
Definition: GrainForceAndTorqueInterface.h:17
GeneralizedPlaneStrainOffDiagOSPD::computeDispFullOffDiagJacobianScalar
void computeDispFullOffDiagJacobianScalar(unsigned int component, unsigned int jvar_num)
Function to compute the full off diagonal Jacobian for coupling between displacements and scalar vari...
Definition: GeneralizedPlaneStrainOffDiagOSPD.C:71
GeneralizedPlaneStrainOffDiagOSPD::computeDispPartialOffDiagJacobianScalar
void computeDispPartialOffDiagJacobianScalar(unsigned int component, unsigned int jvar_num)
Function to compute partial off diagonal Jacobian for coupling between displacements and scalar varia...
Definition: GeneralizedPlaneStrainOffDiagOSPD.C:181
GeneralizedPlaneStrainOffDiagOSPD::_bond_dfdE_ij
const MaterialProperty< Real > & _bond_dfdE_ij
Bond based material properties.
Definition: GeneralizedPlaneStrainOffDiagOSPD.h:55
MechanicsBasePD::_orientation
const std::vector< RealGradient > * _orientation
Vector of bond in current configuration.
Definition: MechanicsBasePD.h:66
MechanicsBasePD::computeLocalOffDiagJacobian
virtual void computeLocalOffDiagJacobian(unsigned int)
Function to compute local contribution to the off-diagonal Jacobian at the current nodes.
Definition: MechanicsBasePD.h:35
MechanicsBasePD::_out_of_plane_strain_var
MooseVariable * _out_of_plane_strain_var
Definition: MechanicsBasePD.h:62
PeridynamicsKernelBase::prepare
virtual void prepare()
Function to precalculate data which will be used in the derived classes.
Definition: PeridynamicsKernelBase.C:43
MechanicsBasePD::_out_of_plane_strain_coupled
const bool _out_of_plane_strain_coupled
Parameters for out-of-plane strain in weak plane stress formulation.
Definition: MechanicsBasePD.h:61
MechanicsBasePD::_ivardofs_ij
std::vector< dof_id_type > _ivardofs_ij
Current variable dof numbers for nodes i and j.
Definition: MechanicsBasePD.h:69
MaterialTensorCalculatorTools::component
Real component(const SymmTensor &symm_tensor, unsigned int index)
Definition: MaterialTensorCalculatorTools.C:16
MechanicsBasePD::computePDNonlocalOffDiagJacobian
virtual void computePDNonlocalOffDiagJacobian(unsigned int, unsigned int)
Function to compute nonlocal contribution to the off-diagonal Jacobian at the current nodes.
Definition: MechanicsBasePD.h:42
MechanicsBasePD::prepare
virtual void prepare() override
Definition: MechanicsBasePD.C:53
RankTwoTensorTempl< Real >
GeneralizedPlaneStrainOffDiagOSPD::computeTempOffDiagJacobianScalar
void computeTempOffDiagJacobianScalar(unsigned int jvar_num)
Function to compute off disgonal Jacobian for coupling between temperature and scalar variable.
Definition: GeneralizedPlaneStrainOffDiagOSPD.C:200
GeneralizedPlaneStrainOffDiagOSPD::_scalar_out_of_plane_strain_var_num
const unsigned int _scalar_out_of_plane_strain_var_num
The variable number of the scalar out-of-plane strain variable.
Definition: GeneralizedPlaneStrainOffDiagOSPD.h:64
GeneralizedPlaneStrainOffDiagOSPD::_bond_dfdE_i_j
const MaterialProperty< Real > & _bond_dfdE_i_j
Definition: GeneralizedPlaneStrainOffDiagOSPD.h:56
MechanicsBasePD::_cur_len_ij
Real _cur_len_ij
Current bond length.
Definition: MechanicsBasePD.h:75
MechanicsBasePD::_disp_var
std::vector< MooseVariable * > _disp_var
displacement variables
Definition: MechanicsBasePD.h:50