28 #ifndef OOMPH_SPHERICAL_NAVIER_STOKES_ELEMENTS_HEADER
29 #define OOMPH_SPHERICAL_NAVIER_STOKES_ELEMENTS_HEADER
33 #include <oomph-lib-config.h>
38 #include "../generic/Qelements.h"
39 #include "../generic/fsi.h"
139 DShape& dtestdx)
const = 0;
149 DShape& dtestdx)
const = 0;
153 Shape& psi)
const = 0;
176 for (
unsigned i = 0;
i < 3;
i++)
184 (*Body_force_fct_pt)(time,
x, result);
218 inline double cot(
const double& th)
const
220 return (1 /
tan(th));
249 const double&
re()
const
376 const unsigned&
i)
const
412 for (
unsigned t = 0;
t < n_time;
t++)
443 virtual void fix_pressure(
const unsigned& p_dof,
const double& p_value) = 0;
512 const unsigned& which_one = 0);
525 void output(std::ostream& outfile,
const unsigned& nplot);
537 void output(FILE* file_pt,
const unsigned& nplot);
551 void full_output(std::ostream& outfile,
const unsigned& nplot);
558 const unsigned& nplot,
570 const unsigned& nplot,
577 const unsigned& nplot,
605 std::ostream& outfile,
623 const double Re = this->
re();
639 const double Re = this->
re();
655 const double Re = this->
re();
698 residuals, jacobian, mass_matrix, 2);
706 unsigned n_node =
nnode();
712 for (
unsigned i = 0;
i < 3;
i++)
719 for (
unsigned l = 0; l < n_node; l++)
728 const unsigned&
i)
const
731 unsigned n_node =
nnode();
741 double interpolated_u = 0.0;
743 for (
unsigned l = 0; l < n_node; l++)
745 interpolated_u +=
nodal_value(l, u_nodal_index) * psi[l];
748 return (interpolated_u);
755 const unsigned&
j)
const
758 unsigned n_node =
nnode();
769 double interpolated_dudx = 0.0;
771 for (
unsigned l = 0; l < n_node; l++)
773 interpolated_dudx +=
nodal_value(l, u_nodal_index) * dpsidx(l,
j);
776 return (interpolated_dudx);
790 double interpolated_p = 0.0;
792 for (
unsigned l = 0; l < n_pres; l++)
797 return (interpolated_p);
907 std::set<std::pair<Data*, unsigned>>& paired_load_data);
917 std::set<std::pair<Data*, unsigned>>& paired_pressure_data);
926 void output(std::ostream& outfile,
const unsigned& nplot)
939 void output(FILE* file_pt,
const unsigned& nplot)
976 std::list<std::pair<unsigned long, unsigned>>& dof_lookup_list)
const;
997 for (
unsigned i = 0;
i < 9;
i++)
1000 dtestdx(
i, 0) = dpsidx(
i, 0);
1001 dtestdx(
i, 1) = dpsidx(
i, 1);
1023 for (
unsigned i = 0;
i < 9;
i++)
1026 dtestdx(
i, 0) = dpsidx(
i, 0);
1027 dtestdx(
i, 1) = dpsidx(
i, 1);
1052 for (
unsigned i = 0;
i < 3;
i++)
test[
i] = psi[
i];
1116 const unsigned& ipt,
1187 std::set<std::pair<Data*, unsigned>>& paired_load_data);
1198 std::set<std::pair<Data*, unsigned>>& paired_pressure_data);
1207 void output(std::ostream& outfile,
const unsigned& nplot)
1219 void output(FILE* file_pt,
const unsigned& nplot)
1239 std::list<std::pair<unsigned long, unsigned>>& dof_lookup_list)
const;
1261 for (
unsigned i = 0;
i < 9;
i++)
1264 dtestdx(
i, 0) = dpsidx(
i, 0);
1265 dtestdx(
i, 1) = dpsidx(
i, 1);
1288 for (
unsigned i = 0;
i < 9;
i++)
1291 dtestdx(
i, 0) = dpsidx(
i, 0);
1292 dtestdx(
i, 1) = dpsidx(
i, 1);
1305 double psi1[2], psi2[2];
1312 for (
unsigned i = 0;
i < 2;
i++)
1314 for (
unsigned j = 0;
j < 2;
j++)
1317 psi[2 *
i +
j] = psi2[
i] * psi1[
j];
1332 for (
unsigned i = 0;
i < 4;
i++)
test[
i] = psi[
i];
AnnoyingScalar cos(const AnnoyingScalar &x)
Definition: AnnoyingScalar.h:136
AnnoyingScalar sin(const AnnoyingScalar &x)
Definition: AnnoyingScalar.h:137
int i
Definition: BiCGSTAB_step_by_step.cpp:9
const unsigned n
Definition: CG3DPackingUnitTest.cpp:11
JacobiRotation< float > J
Definition: Jacobi_makeJacobi.cpp:3
void load(Archive &ar, ParticleHandler &handl)
Definition: Particles.h:21
void pin(const unsigned &i)
Pin the i-th stored variable.
Definition: nodes.h:385
TimeStepper *& time_stepper_pt()
Return the pointer to the timestepper.
Definition: nodes.h:238
void set_value(const unsigned &i, const double &value_)
Definition: nodes.h:271
double value(const unsigned &i) const
Definition: nodes.h:293
FaceGeometry()
Definition: spherical_navier_stokes_elements.h:1075
FaceGeometry()
Definition: spherical_navier_stokes_elements.h:1355
FaceGeometry()
Definition: spherical_navier_stokes_elements.h:1063
FaceGeometry()
Definition: spherical_navier_stokes_elements.h:1344
Definition: elements.h:4998
Node *& node_pt(const unsigned &n)
Return a pointer to the local node n.
Definition: elements.h:2175
double nodal_value(const unsigned &n, const unsigned &i) const
Definition: elements.h:2593
virtual void shape(const Vector< double > &s, Shape &psi) const =0
int nodal_local_eqn(const unsigned &n, const unsigned &i) const
Definition: elements.h:1432
unsigned nnode() const
Return the number of nodes.
Definition: elements.h:2210
void(* SteadyExactSolutionFctPt)(const Vector< double > &, Vector< double > &)
Definition: elements.h:1759
virtual double dshape_eulerian_at_knot(const unsigned &ipt, Shape &psi, DShape &dpsidx) const
Definition: elements.cc:3325
void(* UnsteadyExactSolutionFctPt)(const double &, const Vector< double > &, Vector< double > &)
Definition: elements.h:1765
double dshape_eulerian(const Vector< double > &s, Shape &psi, DShape &dpsidx) const
Definition: elements.cc:3298
Data *& internal_data_pt(const unsigned &i)
Return a pointer to i-th internal data object.
Definition: elements.h:622
int internal_local_eqn(const unsigned &i, const unsigned &j) const
Definition: elements.h:267
static DenseMatrix< double > Dummy_matrix
Definition: elements.h:227
unsigned add_internal_data(Data *const &data_pt, const bool &fd=true)
Definition: elements.cc:62
TimeStepper *& time_stepper_pt()
Definition: geom_objects.h:192
Definition: elements.h:5231
Definition: elements.h:3439
Definition: Qelements.h:459
Definition: spherical_navier_stokes_elements.h:815
void identify_load_data(std::set< std::pair< Data *, unsigned >> &paired_load_data)
Definition: spherical_navier_stokes_elements.cc:2369
void full_output(std::ostream &outfile, const unsigned &nplot)
Definition: spherical_navier_stokes_elements.h:956
void output(std::ostream &outfile, const unsigned &nplot)
Redirect output to SphericalNavierStokesEquations output.
Definition: spherical_navier_stokes_elements.h:926
void output(std::ostream &outfile)
Redirect output to SphericalNavierStokesEquations output.
Definition: spherical_navier_stokes_elements.h:920
void output(FILE *file_pt, const unsigned &nplot)
Redirect output to SphericalNavierStokesEquations output.
Definition: spherical_navier_stokes_elements.h:939
int p_local_eqn(const unsigned &n) const
Return the local equation numbers for the pressure values.
Definition: spherical_navier_stokes_elements.h:855
void fix_pressure(const unsigned &p_dof, const double &p_value)
Pin p_dof-th pressure dof and set it to value specified by p_value.
Definition: spherical_navier_stokes_elements.h:892
unsigned required_nvalue(const unsigned &n) const
Number of values (pinned or dofs) required at local node n.
Definition: spherical_navier_stokes_elements.h:871
double dshape_and_dtest_eulerian_at_knot_spherical_nst(const unsigned &ipt, Shape &psi, DShape &dpsidx, Shape &test, DShape &dtestdx) const
Definition: spherical_navier_stokes_elements.h:1013
void full_output(std::ostream &outfile)
Definition: spherical_navier_stokes_elements.h:948
double p_spherical_nst(const unsigned &i) const
Definition: spherical_navier_stokes_elements.h:880
void output(FILE *file_pt)
Redirect output to SphericalNavierStokesEquations output.
Definition: spherical_navier_stokes_elements.h:933
QSphericalCrouzeixRaviartElement()
Constructor, there are 3 internal values (for the pressure)
Definition: spherical_navier_stokes_elements.h:862
void get_dof_numbers_for_unknowns(std::list< std::pair< unsigned long, unsigned >> &dof_lookup_list) const
Definition: spherical_navier_stokes_elements.cc:2429
void identify_pressure_data(std::set< std::pair< Data *, unsigned >> &paired_pressure_data)
Definition: spherical_navier_stokes_elements.cc:2404
static const unsigned Initial_Nvalue[]
Static array of ints to hold required number of variables at nodes.
Definition: spherical_navier_stokes_elements.h:818
unsigned npres_spherical_nst() const
Return number of pressure values.
Definition: spherical_navier_stokes_elements.h:886
void pshape_spherical_nst(const Vector< double > &s, Shape &psi) const
Pressure shape functions at local coordinate s.
Definition: spherical_navier_stokes_elements.h:1037
unsigned ndof_types() const
Definition: spherical_navier_stokes_elements.h:964
unsigned P_spherical_nst_internal_index
Definition: spherical_navier_stokes_elements.h:823
double dshape_and_dtest_eulerian_spherical_nst(const Vector< double > &s, Shape &psi, DShape &dpsidx, Shape &test, DShape &dtestdx) const
Definition: spherical_navier_stokes_elements.h:987
Definition: spherical_navier_stokes_elements.h:1092
QSphericalTaylorHoodElement()
Constructor, no internal data points.
Definition: spherical_navier_stokes_elements.h:1138
double p_spherical_nst(const unsigned &n_p) const
Definition: spherical_navier_stokes_elements.h:1159
unsigned ndof_types() const
Definition: spherical_navier_stokes_elements.h:1227
int p_local_eqn(const unsigned &n) const
Return the local equation numbers for the pressure values.
Definition: spherical_navier_stokes_elements.h:1131
int p_nodal_index_spherical_nst() const
Definition: spherical_navier_stokes_elements.h:1152
virtual unsigned required_nvalue(const unsigned &n) const
Definition: spherical_navier_stokes_elements.h:1145
void output(FILE *file_pt)
Redirect output to SphericalNavierStokesEquations output.
Definition: spherical_navier_stokes_elements.h:1213
void get_dof_numbers_for_unknowns(std::list< std::pair< unsigned long, unsigned >> &dof_lookup_list) const
Definition: spherical_navier_stokes_elements.cc:2576
static const unsigned Initial_Nvalue[]
Static array of ints to hold number of variables at node.
Definition: spherical_navier_stokes_elements.h:1095
void output(std::ostream &outfile, const unsigned &nplot)
Redirect output to SphericalNavierStokesEquations output.
Definition: spherical_navier_stokes_elements.h:1207
void fix_pressure(const unsigned &p_dof, const double &p_value)
Pin p_dof-th pressure dof and set it to value specified by p_value.
Definition: spherical_navier_stokes_elements.h:1171
void pshape_spherical_nst(const Vector< double > &s, Shape &psi) const
Pressure shape functions at local coordinate s.
Definition: spherical_navier_stokes_elements.h:1301
double dshape_and_dtest_eulerian_at_knot_spherical_nst(const unsigned &ipt, Shape &psi, DShape &dpsidx, Shape &test, DShape &dtestdx) const
Definition: spherical_navier_stokes_elements.h:1278
double dshape_and_dtest_eulerian_spherical_nst(const Vector< double > &s, Shape &psi, DShape &dpsidx, Shape &test, DShape &dtestdx) const
Definition: spherical_navier_stokes_elements.h:1251
void output(FILE *file_pt, const unsigned &nplot)
Redirect output to SphericalNavierStokesEquations output.
Definition: spherical_navier_stokes_elements.h:1219
void identify_load_data(std::set< std::pair< Data *, unsigned >> &paired_load_data)
Definition: spherical_navier_stokes_elements.cc:2514
static const unsigned Pconv[]
Definition: spherical_navier_stokes_elements.h:1100
void output(std::ostream &outfile)
Redirect output to SphericalNavierStokesEquations output.
Definition: spherical_navier_stokes_elements.h:1201
void identify_pressure_data(std::set< std::pair< Data *, unsigned >> &paired_pressure_data)
Definition: spherical_navier_stokes_elements.cc:2549
unsigned npres_spherical_nst() const
Return number of pressure values.
Definition: spherical_navier_stokes_elements.h:1165
Definition: spherical_navier_stokes_elements.h:57
SphericalNavierStokesSourceFctPt & source_fct_pt()
Access function for the source-function pointer.
Definition: spherical_navier_stokes_elements.h:347
double d_kin_energy_dt() const
Get integral of time derivative of kinetic energy over element.
Definition: spherical_navier_stokes_elements.cc:1414
void compute_error(std::ostream &outfile, FiniteElement::UnsteadyExactSolutionFctPt exact_soln_pt, const double &time, double &error, double &norm)
Definition: spherical_navier_stokes_elements.cc:156
void get_vorticity(const Vector< double > &s, Vector< double > &vorticity) const
Compute the vorticity vector at local coordinate s.
Definition: spherical_navier_stokes_elements.cc:1300
SphericalNavierStokesSourceFctPt Source_fct_pt
Pointer to volumetric source function.
Definition: spherical_navier_stokes_elements.h:119
double interpolated_dudx_spherical_nst(const Vector< double > &s, const unsigned &i, const unsigned &j) const
Definition: spherical_navier_stokes_elements.h:753
virtual double dshape_and_dtest_eulerian_at_knot_spherical_nst(const unsigned &ipt, Shape &psi, DShape &dpsidx, Shape &test, DShape &dtestdx) const =0
double pressure_integral() const
Integral of pressure over element.
Definition: spherical_navier_stokes_elements.cc:1521
virtual void pshape_spherical_nst(const Vector< double > &s, Shape &psi) const =0
Compute the pressure shape functions at local coordinate s.
void compute_error_e(std::ostream &outfile, FiniteElement::SteadyExactSolutionFctPt exact_soln_pt, FiniteElement::SteadyExactSolutionFctPt exact_soln_dr_pt, FiniteElement::SteadyExactSolutionFctPt exact_soln_dtheta_pt, double &u_error, double &u_norm, double &p_error, double &p_norm)
Definition: spherical_navier_stokes_elements.cc:312
void output(std::ostream &outfile)
Definition: spherical_navier_stokes_elements.h:517
void full_output(std::ostream &outfile)
Definition: spherical_navier_stokes_elements.h:542
virtual unsigned u_index_spherical_nst(const unsigned &i) const
Definition: spherical_navier_stokes_elements.h:387
double * Density_Ratio_pt
Definition: spherical_navier_stokes_elements.h:94
const double & re() const
Reynolds number.
Definition: spherical_navier_stokes_elements.h:249
SphericalNavierStokesSourceFctPt source_fct_pt() const
Access function for the source-function pointer. Const version.
Definition: spherical_navier_stokes_elements.h:353
virtual double dshape_and_dtest_eulerian_spherical_nst(const Vector< double > &s, Shape &psi, DShape &dpsidx, Shape &test, DShape &dtestdx) const =0
static double Default_Physical_Ratio_Value
Navier–Stokes equations static data.
Definition: spherical_navier_stokes_elements.h:80
void get_pressure_and_velocity_mass_matrix_diagonal(Vector< double > &press_mass_diag, Vector< double > &veloc_mass_diag, const unsigned &which_one=0)
Definition: spherical_navier_stokes_elements.cc:62
double * ReSt_pt
Pointer to global Reynolds number x Strouhal number (=Womersley)
Definition: spherical_navier_stokes_elements.h:102
void strain_rate(const Vector< double > &s, DenseMatrix< double > &strain_rate) const
Strain-rate tensor: 1/2 (du_i/dx_j + du_j/dx_i)
Definition: spherical_navier_stokes_elements.cc:1197
static Vector< double > Gamma
Vector to decide whether the stress-divergence form is used or not.
Definition: spherical_navier_stokes_elements.h:244
double *& viscosity_ratio_pt()
Pointer to Viscosity Ratio.
Definition: spherical_navier_stokes_elements.h:280
const double & re_invro() const
Global Reynolds number multiplied by inverse Rossby number.
Definition: spherical_navier_stokes_elements.h:311
double u_spherical_nst(const unsigned &n, const unsigned &i) const
Definition: spherical_navier_stokes_elements.h:367
void fill_in_contribution_to_jacobian(Vector< double > &residuals, DenseMatrix< double > &jacobian)
Definition: spherical_navier_stokes_elements.h:681
void fill_in_contribution_to_residuals(Vector< double > &residuals)
Compute the element's residual Vector.
Definition: spherical_navier_stokes_elements.h:668
virtual double p_spherical_nst(const unsigned &n_p) const =0
double *& re_invfr_pt()
Pointer to global inverse Froude number.
Definition: spherical_navier_stokes_elements.h:305
const double & density_ratio() const
Definition: spherical_navier_stokes_elements.h:287
Vector< double > * G_pt
Pointer to global gravity Vector.
Definition: spherical_navier_stokes_elements.h:113
virtual void get_body_force_spherical_nst(const double &time, const unsigned &ipt, const Vector< double > &s, const Vector< double > &x, Vector< double > &result)
Definition: spherical_navier_stokes_elements.h:166
static int Pressure_not_stored_at_node
Definition: spherical_navier_stokes_elements.h:72
double du_dt_spherical_nst(const unsigned &n, const unsigned &i) const
Definition: spherical_navier_stokes_elements.h:395
double * ReInvRo_pt
Definition: spherical_navier_stokes_elements.h:110
double *& re_pt()
Pointer to Reynolds number.
Definition: spherical_navier_stokes_elements.h:261
void output(FILE *file_pt)
Definition: spherical_navier_stokes_elements.h:529
virtual int p_nodal_index_spherical_nst() const
Definition: spherical_navier_stokes_elements.h:448
double * Re_pt
Pointer to global Reynolds number.
Definition: spherical_navier_stokes_elements.h:99
double * Viscosity_Ratio_pt
Definition: spherical_navier_stokes_elements.h:90
Vector< double > actual_dr(const Vector< double > &x)
Definition: spherical_navier_stokes_elements.h:637
const double & re_invfr() const
Global inverse Froude number.
Definition: spherical_navier_stokes_elements.h:299
virtual void pshape_spherical_nst(const Vector< double > &s, Shape &psi, Shape &test) const =0
void disable_ALE()
Definition: spherical_navier_stokes_elements.h:424
SphericalNavierStokesBodyForceFctPt body_force_fct_pt() const
Access function for the body-force pointer. Const version.
Definition: spherical_navier_stokes_elements.h:341
double cot(const double &th) const
Definition: spherical_navier_stokes_elements.h:218
double *& re_invro_pt()
Pointer to global inverse Froude number.
Definition: spherical_navier_stokes_elements.h:317
double interpolated_p_spherical_nst(const Vector< double > &s) const
Return FE interpolated pressure at local coordinate s.
Definition: spherical_navier_stokes_elements.h:780
void compute_shear_stress(std::ostream &outfile)
Definition: spherical_navier_stokes_elements.cc:495
void output_fct(std::ostream &outfile, const unsigned &nplot, FiniteElement::SteadyExactSolutionFctPt exact_soln_pt)
Definition: spherical_navier_stokes_elements.cc:630
double kin_energy() const
Get integral of kinetic energy over element.
Definition: spherical_navier_stokes_elements.cc:1370
void output_vorticity(std::ostream &outfile, const unsigned &nplot)
Definition: spherical_navier_stokes_elements.cc:1046
double dissipation() const
Return integral of dissipation over element.
Definition: spherical_navier_stokes_elements.cc:1086
static double Default_Physical_Constant_Value
Navier–Stokes equations static data.
Definition: spherical_navier_stokes_elements.h:76
void get_traction(const Vector< double > &s, const Vector< double > &N, Vector< double > &traction)
Definition: spherical_navier_stokes_elements.cc:1137
double(* SphericalNavierStokesSourceFctPt)(const double &time, const Vector< double > &x)
Definition: spherical_navier_stokes_elements.h:66
Vector< double > actual_dth(const Vector< double > &x)
Definition: spherical_navier_stokes_elements.h:653
const Vector< double > & g() const
Vector of gravitational components.
Definition: spherical_navier_stokes_elements.h:323
double * ReInvFr_pt
Definition: spherical_navier_stokes_elements.h:106
void fill_in_contribution_to_jacobian_and_mass_matrix(Vector< double > &residuals, DenseMatrix< double > &jacobian, DenseMatrix< double > &mass_matrix)
Definition: spherical_navier_stokes_elements.h:691
virtual void fill_in_generic_residual_contribution_spherical_nst(Vector< double > &residuals, DenseMatrix< double > &jacobian, DenseMatrix< double > &mass_matrix, unsigned flag)
Definition: spherical_navier_stokes_elements.cc:1566
static Vector< double > Default_Gravity_vector
Static default value for the gravity vector.
Definition: spherical_navier_stokes_elements.h:83
SphericalNavierStokesBodyForceFctPt Body_force_fct_pt
Pointer to body force function.
Definition: spherical_navier_stokes_elements.h:116
double *& re_st_pt()
Pointer to product of Reynolds and Strouhal number (=Womersley number)
Definition: spherical_navier_stokes_elements.h:267
double u_spherical_nst(const unsigned &t, const unsigned &n, const unsigned &i) const
Definition: spherical_navier_stokes_elements.h:374
virtual int p_local_eqn(const unsigned &n) const =0
SphericalNavierStokesEquations()
Definition: spherical_navier_stokes_elements.h:226
virtual unsigned npres_spherical_nst() const =0
Function to return number of pressure degrees of freedom.
void extract_velocity(std::ostream &outfile)
Definition: spherical_navier_stokes_elements.cc:540
virtual void fix_pressure(const unsigned &p_dof, const double &p_value)=0
Pin p_dof-th pressure dof and set it to value specified by p_value.
double interpolated_u_spherical_nst(const Vector< double > &s, const unsigned &i) const
Return FE interpolated velocity u[i] at local coordinate s.
Definition: spherical_navier_stokes_elements.h:727
bool ALE_is_disabled
Definition: spherical_navier_stokes_elements.h:124
void output_veloc(std::ostream &outfile, const unsigned &nplot, const unsigned &t)
Definition: spherical_navier_stokes_elements.cc:743
void get_load(const Vector< double > &s, const Vector< double > &N, Vector< double > &load)
Definition: spherical_navier_stokes_elements.h:492
void(* SphericalNavierStokesBodyForceFctPt)(const double &time, const Vector< double > &x, Vector< double > &body_force)
Definition: spherical_navier_stokes_elements.h:61
void enable_ALE()
Definition: spherical_navier_stokes_elements.h:433
const double & re_st() const
Product of Reynolds and Strouhal number (=Womersley number)
Definition: spherical_navier_stokes_elements.h:255
void interpolated_u_spherical_nst(const Vector< double > &s, Vector< double > &veloc) const
Compute vector of FE interpolated velocity u at local coordinate s.
Definition: spherical_navier_stokes_elements.h:702
Vector< double > *& g_pt()
Pointer to Vector of gravitational components.
Definition: spherical_navier_stokes_elements.h:329
SphericalNavierStokesBodyForceFctPt & body_force_fct_pt()
Access function for the body-force pointer.
Definition: spherical_navier_stokes_elements.h:335
virtual double get_source_spherical_nst(double time, const unsigned &ipt, const Vector< double > &x)
Definition: spherical_navier_stokes_elements.h:190
const double & viscosity_ratio() const
Definition: spherical_navier_stokes_elements.h:274
Vector< double > actual(const Vector< double > &x)
Definition: spherical_navier_stokes_elements.h:621
double *& density_ratio_pt()
Pointer to Density ratio.
Definition: spherical_navier_stokes_elements.h:293
Definition: timesteppers.h:231
unsigned ntstorage() const
Definition: timesteppers.h:601
virtual double weight(const unsigned &i, const unsigned &j) const
Access function for j-th weight for the i-th derivative.
Definition: timesteppers.h:594
std::string type() const
Definition: timesteppers.h:490
@ N
Definition: constructor.cpp:22
RealScalar s
Definition: level1_cplx_impl.h:130
double theta
Definition: two_d_biharmonic.cc:236
EIGEN_STRONG_INLINE EIGEN_DEVICE_FUNC bfloat16 tan(const bfloat16 &a)
Definition: BFloat16.h:633
double Re
Reynolds number.
Definition: axisym_navier_stokes/counter_rotating_disks/counter_rotating_disks.cc:61
void body_force(const double &time, const Vector< double > &x, Vector< double > &result)
Definition: axisym_linear_elasticity/cylinder/cylinder.cc:96
int error
Definition: calibrate.py:297
void shape< 2 >(const double &s, double *Psi)
1D shape functions specialised to linear order (2 Nodes)
Definition: shape.h:608
DRAIG: Change all instances of (SPATIAL_DIM) to (DIM-1).
Definition: AnisotropicHookean.h:10
list x
Definition: plotDoE.py:28
t
Definition: plotPSD.py:36
Definition: indexed_view.cpp:20
void set(Container &c, Position position, const Value &value)
Definition: stdlist_overload.cpp:36
std::ptrdiff_t j
Definition: tut_arithmetic_redux_minmax.cpp:2