![]() |
|
Namespace for physical parameters. More...
Enumerations | |
enum | { Driven_cavity , Through_flow } |
Enumeration for the problem ids. More... | |
enum | { Driven_cavity , Step } |
Enumeration for the problem ids. More... | |
Functions | |
double | degtorad (const double &ang_deg) |
Convert degrees to radians. More... | |
void | prescribed_traction (const double &t, const Vector< double > &x, const Vector< double > &n, Vector< double > &traction) |
Traction at the outflow boundary. More... | |
Variables | |
static const unsigned | Dim = 2 |
Problem dimension. More... | |
static const double | X_min = 0.0 |
Min and max x value respectively. More... | |
static const double | X_max = 1.0 |
static const double | Y_min = 0.0 |
Min and max y value respectively. More... | |
static const double | Y_max = 1.0 |
static const double | Lx = X_max - X_min |
The domain length in the x and y direction respectively. More... | |
static const double | Ly = Y_max - Y_min |
unsigned | Visc = 0 |
The viscous term. More... | |
double | Re = 100.0 |
Reynolds number. More... | |
double | Ang_deg = 30.0 |
Tilting angle of the domain with the x-axis. More... | |
double | Ang_rad = -1.0 |
unsigned | Noel = 4 |
Number of elements in 1D. More... | |
bool | Use_trilinos = false |
Use trilinos? More... | |
bool | Use_lsc = false |
Use LSC preconditioner for the Navier-Stokes block? More... | |
bool | Use_amg_for_f = false |
Use Boomer AMG for the momentum block? More... | |
bool | Use_amg_for_p = false |
Use Boomer AMG for the pressure block? More... | |
unsigned | Soln_num = 0 |
Soln number (for doc_solution) More... | |
Vector< unsigned > | Iterations |
Storage for number of iterations during Newton steps. More... | |
Vector< double > | Linear_solver_time |
Storage for linear solver times during Newton steps. More... | |
unsigned | Nx =4 |
Number of elements in x direction. More... | |
unsigned | Ny =4 |
Number of elements in x direction. More... | |
bool | Dump_matrices =true |
By default we're dumping the matrices for comparison. More... | |
bool | Halt_code =false |
Namespace for physical parameters.
Namespace for parameters.
///////////////////////////////////////////////////////////////////// ///////////////////////////////////////////////////////////////////// /////////////////////////////////////////////////////////////////////
///////////////////////////////////////////////////////////////////// ///////////////////////////////////////////////////////////////////// ///////////////////////////////////////////////////////////////////// ///////////////////////////////////////////////////////////////////// ///////////////////////////////////////////////////////////////////// /////////////////////////////////////////////////////////////////////
void Global_Variables::prescribed_traction | ( | const double & | t, |
const Vector< double > & | x, | ||
const Vector< double > & | n, | ||
Vector< double > & | traction | ||
) |
Traction at the outflow boundary.
Referenced by FpTestProblem::create_refineable_traction_elements(), and FpTestProblem::create_traction_elements().
double Global_Variables::Ang_deg = 30.0 |
Tilting angle of the domain with the x-axis.
Referenced by main().
double Global_Variables::Ang_rad = -1.0 |
|
static |
Problem dimension.
Referenced by SpineGravityTractionElement< ELEMENT >::add_generic_residual_contribution(), alignedboxCastTests(), alignedboxNonIntegralRotatable(), SpineGravityTractionElement< ELEMENT >::assign_additional_local_eqn_numbers(), oomph::Multi_domain_functions::aux_setup_multi_domain_interaction(), boxGetCorners(), oomph::MyProblem::build(), CauchyBounds(), EqualityChecker< Scalar, StorageIndex, Dim >::check_recursive(), oomph::HelmholtzDtNBoundaryElement< ELEMENT >::compute_gamma_contribution(), Eigen::Transform< Scalar_, Dim_, Mode_, Options_ >::computeRotationScaling(), Eigen::Transform< Scalar_, Dim_, Mode_, Options_ >::computeScalingRotation(), oomph::MyProblem::dim(), oomph::QSUPGAdvectionDiffusionElement< DIM, NNODE_1D >::dshape_and_dtest_eulerian_at_knot_adv_diff(), Eigen::Transform< Scalar_, Dim_, Mode_, Options_ >::EIGEN_MAKE_ALIGNED_OPERATOR_NEW_IF_VECTORIZABLE_FIXED_SIZE(), oomph::PolarStreamfunctionTractionElement< ELEMENT >::fill_in_generic_residual_contribution(), oomph::PolarNavierStokesTractionElement< ELEMENT >::fill_in_generic_residual_contribution(), oomph::AdvectionDiffusionFluxElement< ELEMENT >::fill_in_generic_residual_contribution_adv_diff_flux(), oomph::LinearisedAxisymPoroelasticBJS_FSIElement< FLUID_BULK_ELEMENT, POROELASTICITY_BULK_ELEMENT >::fill_in_generic_residual_contribution_axisym_poroelastic_fsi(), oomph::NavierStokesSpaceTimeTractionElement< ELEMENT >::fill_in_generic_residual_contribution_fluid_traction(), oomph::NavierStokesMixedOrderSpaceTimeTractionElement< ELEMENT >::fill_in_generic_residual_contribution_fluid_traction(), oomph::NavierStokesTractionElement< ELEMENT >::fill_in_generic_residual_contribution_fluid_traction(), oomph::LinearisedFSIAxisymmetricNStNoSlipBCElementElement< FLUID_BULK_ELEMENT, SOLID_BULK_ELEMENT >::fill_in_generic_residual_contribution_fsi_no_slip_axisym(), oomph::HelmholtzFluxElement< ELEMENT >::fill_in_generic_residual_contribution_helmholtz_flux(), oomph::PMLHelmholtzFluxElement< ELEMENT >::fill_in_generic_residual_contribution_helmholtz_flux(), oomph::FourierDecomposedHelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >::fill_in_generic_residual_contribution_helmholtz_flux_from_displacement(), oomph::HelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >::fill_in_generic_residual_contribution_helmholtz_flux_from_displacement(), oomph::PMLHelmholtzFluxFromNormalDisplacementBCElement< HELMHOLTZ_BULK_ELEMENT, ELASTICITY_BULK_ELEMENT >::fill_in_generic_residual_contribution_helmholtz_flux_from_displacement(), oomph::LinearWaveFluxElement< ELEMENT >::fill_in_generic_residual_contribution_lin_wave_flux(), oomph::PoissonFluxElement< ELEMENT >::fill_in_generic_residual_contribution_poisson_flux(), oomph::UnsteadyHeatBaseFaceElement< ELEMENT >::fill_in_generic_residual_contribution_ust_heat_flux(), oomph::HeatedPenetratorFluxElement< ELEMENT >::fill_in_generic_residual_contribution_ust_heat_flux(), oomph::UnsteadyHeatFluxPseudoMeltElement< ELEMENT >::fill_in_generic_residual_contribution_ust_heat_flux(), oomph::UnsteadyHeatFluxElement< ELEMENT >::fill_in_generic_residual_contribution_ust_heat_flux(), SpineGravityTractionElement< ELEMENT >::flow(), SpineGravityTractionElement< ELEMENT >::get_flux(), oomph::PolarStressIntegralElement< ELEMENT >::get_shear_stress(), hyperplane(), main(), Eigen::Matrix< Scalar_, Rows_, Cols_, Options_, MaxRows_, MaxCols_ >::Matrix(), oomph::MyProblem::MyProblem(), Eigen::UniformScaling< Scalar_ >::operator*(), Eigen::Translation< Scalar_, Dim_ >::operator*(), Eigen::Matrix< Scalar_, Rows_, Cols_, Options_, MaxRows_, MaxCols_ >::operator=(), oomph::MyProblem::output_ltes(), parametrizedline(), polynomialsolver(), oomph::StorableShapeElementBase::pre_compute_d2shape_local_at_knots(), oomph::StorableShapeElementBase::pre_compute_dshape_local_at_knots(), Eigen::Transform< Scalar_, Dim_, Mode_, Options_ >::prescale(), Eigen::Transform< Scalar_, Dim_, Mode_, Options_ >::preshear(), Eigen::Transform< Scalar_, Dim_, Mode_, Options_ >::pretranslate(), realRoots_to_monicPolynomial_test(), oomph::RefineableNavierStokesSpaceTimeTractionElement< ELEMENT >::refineable_fill_in_generic_residual_contribution_fluid_traction(), oomph::RefineableNavierStokesMixedOrderSpaceTimeTractionElement< ELEMENT >::refineable_fill_in_generic_residual_contribution_fluid_traction(), oomph::RefineableNavierStokesTractionElement< ELEMENT >::refineable_fill_in_generic_residual_contribution_fluid_traction(), Eigen::internal::transform_transform_product_impl< Transform< Scalar, Dim, AffineCompact, LhsOptions >, Transform< Scalar, Dim, Projective, RhsOptions >, true >::run(), Eigen::internal::transform_transform_product_impl< Transform< Scalar, Dim, Projective, LhsOptions >, Transform< Scalar, Dim, AffineCompact, RhsOptions >, true >::run(), Eigen::internal::transform_left_product_impl< Other, AffineCompact, Options, Dim, HDim, HDim, HDim >::run(), Eigen::internal::transform_left_product_impl< Other, Mode, Options, Dim, HDim, Dim, HDim >::run(), Eigen::internal::transform_left_product_impl< Other, AffineCompact, Options, Dim, HDim, Dim, HDim >::run(), Eigen::internal::transform_left_product_impl< Other, Mode, Options, Dim, HDim, Dim, Dim >::run(), Eigen::internal::transform_right_product_impl< TransformType, MatrixType, 1, RhsCols >::run(), Eigen::internal::transform_right_product_impl< TransformType, MatrixType, 2, RhsCols >::run(), Eigen::internal::transform_right_product_impl< TransformType, MatrixType, 2, 1 >::run(), Eigen::internal::transform_make_affine< Mode >::run(), Eigen::Transform< Scalar_, Dim_, Mode_, Options_ >::scale(), oomph::Multi_domain_functions::setup_multi_domain_interaction(), Eigen::Transform< Scalar_, Dim_, Mode_, Options_ >::shear(), oomph::PVDEquationsWithPressure< DIM >::solid_pshape_at_knot(), SpineGravityTractionElement< ELEMENT >::SpineGravityTractionElement(), Eigen::internal::toRotationMatrix(), Eigen::Transform< Scalar_, Dim_, Mode_, Options_ >::translate(), Eigen::Transform< Scalar_, Dim_, Mode_, Options_ >::translation(), and Eigen::Transform< Scalar_, Dim_, Mode_, Options_ >::translationExt().
bool Global_Variables::Dump_matrices =true |
By default we're dumping the matrices for comparison.
Referenced by RectangularDrivenCavityProblem< ELEMENT >::compare_assembly_strategies(), and main().
bool Global_Variables::Halt_code =false |
Halt code execution at the end of the most memory-intensive phase?
Referenced by RectangularDrivenCavityProblem< ELEMENT >::compare_assembly_strategies(), and main().
Storage for number of iterations during Newton steps.
Referenced by TiltedCavityProblem< ELEMENT >::actions_after_newton_step(), FpTestProblem::actions_after_newton_step(), TiltedCavityProblem< ELEMENT >::actions_before_newton_solve(), FpTestProblem::actions_before_newton_solve(), oomph::ComplexDampedJacobi< MATRIX >::complex_solve_helper(), oomph::ComplexGMRES< MATRIX >::complex_solve_helper(), main(), oomph::CG< MATRIX >::solve_helper(), oomph::BiCGStab< MATRIX >::solve_helper(), oomph::GS< MATRIX >::solve_helper(), oomph::DampedJacobi< MATRIX >::solve_helper(), oomph::GMRES< MATRIX >::solve_helper(), oomph::HelmholtzGMRESMG< MATRIX >::solve_helper(), and oomph::HelmholtzFGMRESMG< MATRIX >::solve_helper().
Storage for linear solver times during Newton steps.
Referenced by FpTestProblem::actions_after_newton_step(), FpTestProblem::actions_before_newton_solve(), and main().
The domain length in the x and y direction respectively.
Referenced by TiltedCavityProblem< ELEMENT >::TiltedCavityProblem().
Referenced by TiltedCavityProblem< ELEMENT >::TiltedCavityProblem().
unsigned Global_Variables::Noel = 4 |
Number of elements in 1D.
Referenced by main(), and TiltedCavityProblem< ELEMENT >::TiltedCavityProblem().
unsigned Global_Variables::Nx =4 |
Number of elements in x direction.
Referenced by RectangularDrivenCavityProblem< ELEMENT >::compare_assembly_strategies(), and main().
unsigned Global_Variables::Ny =4 |
Number of elements in x direction.
Referenced by RectangularDrivenCavityProblem< ELEMENT >::compare_assembly_strategies(), and main().
double Global_Variables::Re = 100.0 |
Reynolds number.
Referenced by FpTestProblem::FpTestProblem(), main(), and TiltedCavityProblem< ELEMENT >::TiltedCavityProblem().
unsigned Global_Variables::Soln_num = 0 |
Soln number (for doc_solution)
Referenced by TiltedCavityProblem< ELEMENT >::doc_solution(), and main().
bool Global_Variables::Use_amg_for_f = false |
Use Boomer AMG for the momentum block?
Referenced by main(), and TiltedCavityProblem< ELEMENT >::TiltedCavityProblem().
bool Global_Variables::Use_amg_for_p = false |
Use Boomer AMG for the pressure block?
Referenced by main(), and TiltedCavityProblem< ELEMENT >::TiltedCavityProblem().
bool Global_Variables::Use_lsc = false |
Use LSC preconditioner for the Navier-Stokes block?
Referenced by main(), and TiltedCavityProblem< ELEMENT >::TiltedCavityProblem().
bool Global_Variables::Use_trilinos = false |
Use trilinos?
Referenced by main(), and TiltedCavityProblem< ELEMENT >::TiltedCavityProblem().
unsigned Global_Variables::Visc = 0 |
The viscous term.
Referenced by main(), and TiltedCavityProblem< ELEMENT >::TiltedCavityProblem().
|
static |
|
static |
Min and max x value respectively.
|
static |
|
static |
Min and max y value respectively.
Referenced by TiltedCavityProblem< ELEMENT >::actions_before_newton_solve().