![]() |
|
DRAIG: Change all instances of (SPATIAL_DIM) to (DIM-1). More...
Typedefs | |
typedef void(* | CoordinateMappingFctPt) (const Vector< double > &s, Vector< double > &s_bulk) |
typedef void(* | BulkCoordinateDerivativesFctPt) (const Vector< double > &s, DenseMatrix< double > &ds_bulk_dsface, unsigned &interior_direction) |
Enumerations | |
enum | Sample_Point_Container_Type { UseRefineableBinArray = 1 , UseNonRefineableBinArray = 2 } |
Enumeration to identify type of sample point container. More... | |
Functions | |
std::ostream & | operator<< (std::ostream &os, const Vector< double > &a) |
template<class T > | |
T | smart_cast_preconditioner (Preconditioner *prec_pt) |
std::string | real_date_time () |
virtual unsigned | u_index_cons_axisym_adv_diff () const |
double | du_dt_cons_axisym_adv_diff (const unsigned &n) const |
void | disable_ALE () |
void | enable_ALE () |
void | output (std::ostream &outfile) |
Output with default number of plot points. More... | |
void | output (std::ostream &outfile, const unsigned &nplot) |
void | output (FILE *file_pt) |
C_style output with default number of plot points. More... | |
void | output (FILE *file_pt, const unsigned &n_plot) |
void | output_fct (std::ostream &outfile, const unsigned &nplot, FiniteElement::SteadyExactSolutionFctPt exact_soln_pt) |
Output exact soln: r,z,u_exact at nplot^2 plot points. More... | |
virtual void | output_fct (std::ostream &outfile, const unsigned &nplot, const double &time, FiniteElement::UnsteadyExactSolutionFctPt exact_soln_pt) |
void | compute_error (std::ostream &outfile, FiniteElement::SteadyExactSolutionFctPt exact_soln_pt, double &error, double &norm) |
Get error against and norm of exact solution. More... | |
void | compute_error (std::ostream &outfile, FiniteElement::UnsteadyExactSolutionFctPt exact_soln_pt, const double &time, double &error, double &norm) |
Dummy, time dependent error checker. More... | |
double | integrate_u () |
Integrate the concentration over the element. More... | |
GeneralisedAxisymAdvectionDiffusionSourceFctPt & | source_fct_pt () |
Access function: Pointer to source function. More... | |
GeneralisedAxisymAdvectionDiffusionWindFctPt & | wind_fct_pt () |
Access function: Pointer to wind function. More... | |
GeneralisedAxisymAdvectionDiffusionWindFctPt & | conserved_wind_fct_pt () |
Access function: Pointer to additional (conservative) wind function. More... | |
GeneralisedAxisymAdvectionDiffusionDiffFctPt & | diff_fct_pt () |
Access function: Pointer to diffusion function. More... | |
const double & | pe () const |
Peclet number. More... | |
double *& | pe_pt () |
Pointer to Peclet number. More... | |
const double & | pe_st () const |
Peclet number multiplied by Strouhal number. More... | |
double *& | pe_st_pt () |
Pointer to Peclet number multipled by Strouha number. More... | |
virtual void | get_source_cons_axisym_adv_diff (const unsigned &ipt, const Vector< double > &x, double &source) const |
virtual void | get_wind_cons_axisym_adv_diff (const unsigned &ipt, const Vector< double > &s, const Vector< double > &x, Vector< double > &wind) const |
virtual void | get_conserved_wind_cons_axisym_adv_diff (const unsigned &ipt, const Vector< double > &s, const Vector< double > &x, Vector< double > &wind) const |
virtual void | get_diff_cons_axisym_adv_diff (const unsigned &ipt, const Vector< double > &s, const Vector< double > &x, DenseMatrix< double > &D) const |
void | get_flux (const Vector< double > &s, Vector< double > &flux) const |
Get flux: \(\mbox{flux}[i] = \mbox{d}u / \mbox{d}x_i \). More... | |
void | get_total_flux (const Vector< double > &s, Vector< double > &total_flux) const |
Get flux: \(\mbox{flux}[i] = \mbox{d}u / \mbox{d}x_i \). More... | |
void | fill_in_contribution_to_residuals (Vector< double > &residuals) |
Add the element's contribution to its residual vector (wrapper) More... | |
void | fill_in_contribution_to_jacobian (Vector< double > &residuals, DenseMatrix< double > &jacobian) |
void | fill_in_contribution_to_jacobian_and_mass_matrix (Vector< double > &residuals, DenseMatrix< double > &jacobian, DenseMatrix< double > &mass_matrix) |
double | interpolated_u_cons_axisym_adv_diff (const Vector< double > &s) const |
Return FE representation of function value u(s) at local coordinate s. More... | |
unsigned | self_test () |
Self-test: Return 0 for OK. More... | |
virtual double | dshape_and_dtest_eulerian_cons_axisym_adv_diff (const Vector< double > &s, Shape &psi, DShape &dpsidx, Shape &test, DShape &dtestdx) const =0 |
virtual double | dshape_and_dtest_eulerian_at_knot_cons_axisym_adv_diff (const unsigned &ipt, Shape &psi, DShape &dpsidx, Shape &test, DShape &dtestdx) const =0 |
virtual void | fill_in_generic_residual_contribution_cons_axisym_adv_diff (Vector< double > &residuals, DenseMatrix< double > &jacobian, DenseMatrix< double > &mass_matrix, unsigned flag) |
int | superlu_complex (int *, int *, int *, int *, std::complex< double > *, int *, int *, std::complex< double > *, int *, int *, int *, void *, int *) |
std::ostream & | operator<< (std::ostream &out, const DoubleVector &v) |
output operator More... | |
void | post_midpoint_update (Data *dat_pt, const bool &update_pinned) |
std::ostream & | operator<< (std::ostream &stream, LinearAlgebraDistribution &dist) |
output operator More... | |
int | superlu (int *, int *, int *, int *, double *, int *, int *, double *, int *, int *, int *, void *, int *) |
double | get_lu_factor_memory_usage_in_bytes () |
double | get_total_memory_usage_in_bytes () |
std::ostream & | operator<< (std::ostream &out, const Data &d) |
std::ostream & | operator<< (std::ostream &out, const Node &nd) |
void | pause (std::string message) |
Pause and display message. More... | |
template<class Target , class Source > | |
Target | checked_dynamic_cast (Source *x) |
template<class Target , class Source > | |
Target | checked_static_cast (Source *x) |
void | METIS_PartGraphKway (int *, int *, int *, int *, int *, int *, int *, int *, int *, int *, int *) |
Metis graph partitioning function. More... | |
void | METIS_PartGraphVKway (int *, int *, int *, int *, int *, int *, int *, int *, int *, int *, int *) |
Variables | |
double * | Pe_pt |
Pointer to global Peclet number. More... | |
double * | PeSt_pt |
Pointer to global Peclet number multiplied by Strouhal number. More... | |
GeneralisedAxisymAdvectionDiffusionSourceFctPt | Source_fct_pt |
Pointer to source function: More... | |
GeneralisedAxisymAdvectionDiffusionWindFctPt | Wind_fct_pt |
Pointer to wind function: More... | |
GeneralisedAxisymAdvectionDiffusionWindFctPt | Conserved_wind_fct_pt |
Pointer to additional (conservative) wind function: More... | |
GeneralisedAxisymAdvectionDiffusionDiffFctPt | Diff_fct_pt |
Pointer to diffusivity funciton. More... | |
bool | ALE_is_disabled |
static double | Default_peclet_number |
Static default value for the Peclet number. More... | |
Nullstream | oomph_nullstream |
Single (global) instantiation of the Nullstream. More... | |
OomphInfo | oomph_info |
OutputModifier | default_output_modifier |
Single global instatiation of the default output modifier. More... | |
DRAIG: Change all instances of (SPATIAL_DIM) to (DIM-1).
////////////////////////////////////////////////////////////////// ////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////
/////////////////////////////////////////////////////////////////// /////////////////////////////////////////////////////////////////// /////////////////////////////////////////////////////////////////// ///////////////////////////////////////////////////////////////////
////////////////////////////////////////////////////////////////////// ////////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////////
/////////////////////////////////////////////////////////////////// /////////////////////////////////////////////////////////////////// ///////////////////////////////////////////////////////////////////
///////////////////////////////////////////////////////////////// ///////////////////////////////////////////////////////////////// /////////////////////////////////////////////////////////////////
///////////////////////////////////////////////////////////////////// ///////////////////////////////////////////////////////////////////// /////////////////////////////////////////////////////////////////////
//////////////////////////////////////////////////////////////////// //////////////////////////////////////////////////////////////////// ////////////////////////////////////////////////////////////////////
///////////////////////////////////////////////////////////////////////// ///////////////////////////////////////////////////////////////////////// /////////////////////////////////////////////////////////////////////////
typedef void(* oomph::BulkCoordinateDerivativesFctPt) (const Vector< double > &s, DenseMatrix< double > &ds_bulk_dsface, unsigned &interior_direction) |
Typedef for the function that returns the partial derivative of the local coordinates in the bulk element with respect to the coordinates along the face. In addition this function returns an index of one of the bulk local coordinates that varies away from the edge
Typedef for the function that translates the face coordinate to the coordinate in the bulk element
|
inline |
Runtime checked dynamic cast. This is the safe but slightly slower cast. Use it in any of these cases:
References OOMPH_CURRENT_FUNCTION, OOMPH_EXCEPTION_LOCATION, Eigen::Architecture::Target, tmp, and plotDoE::x.
|
inline |
Checked static cast. Only use this cast if ALL of these are true:
References OOMPH_CURRENT_FUNCTION, OOMPH_EXCEPTION_LOCATION, Eigen::Architecture::Target, and plotDoE::x.
void oomph::compute_error | ( | std::ostream & | outfile, |
FiniteElement::SteadyExactSolutionFctPt | exact_soln_pt, | ||
double & | error, | ||
double & | norm | ||
) |
Get error against and norm of exact solution.
Referenced by AdvectionProblem::compute_error(), TwoDDGProblem< ELEMENT >::compute_error(), NonIsothermalAxisymmetricQCrouzeixRaviartElement::compute_error(), oomph::TLinearHeatAndElasticityElement< DIM, NNODE_1D >::compute_error(), TwoDDGProblem< ELEMENT >::parameter_study(), and AdvectionProblem::parameter_study().
void oomph::compute_error | ( | std::ostream & | outfile, |
FiniteElement::UnsteadyExactSolutionFctPt | exact_soln_pt, | ||
const double & | time, | ||
double & | error, | ||
double & | norm | ||
) |
Dummy, time dependent error checker.
References OOMPH_CURRENT_FUNCTION, and OOMPH_EXCEPTION_LOCATION.
GeneralisedAxisymAdvectionDiffusionWindFctPt oomph::conserved_wind_fct_pt | ( | ) | const |
Access function: Pointer to additional (conservative) wind function.
Access function: Pointer to additional (conservative) wind function. Const version
References Conserved_wind_fct_pt.
GeneralisedAxisymAdvectionDiffusionDiffFctPt oomph::diff_fct_pt | ( | ) |
Access function: Pointer to diffusion function.
Access function: Pointer to diffusion function. Const version.
References Diff_fct_pt.
void oomph::disable_ALE | ( | ) |
Disable ALE, i.e. assert the mesh is not moving – you do this at your own risk!
References ALE_is_disabled.
|
protectedpure virtual |
Shape/test functions and derivs w.r.t. to global coords at integration point ipt; return Jacobian of mapping
Referenced by oomph::RefineableGeneralisedAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_cons_axisym_adv_diff().
|
protectedpure virtual |
Shape/test functions and derivs w.r.t. to global coords at local coord. s; return Jacobian of mapping
du/dt at local node n. Uses suitably interpolated value for hanging nodes.
References oomph::TimeStepper::is_steady(), n, oomph::TimeStepper::ntstorage(), plotPSD::t, u_index_cons_axisym_adv_diff(), and oomph::TimeStepper::weight().
Referenced by oomph::RefineableGeneralisedAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_cons_axisym_adv_diff().
void oomph::enable_ALE | ( | ) |
(Re-)enable ALE, i.e. take possible mesh motion into account when evaluating the time-derivative. Note: By default, ALE is enabled, at the expense of possibly creating unnecessary work in problems where the mesh is, in fact, stationary.
References ALE_is_disabled.
void oomph::fill_in_contribution_to_jacobian | ( | Vector< double > & | residuals, |
DenseMatrix< double > & | jacobian | ||
) |
Add the element's contribution to its residual vector and the element Jacobian matrix (wrapper)
References oomph::GeneralisedElement::Dummy_matrix, and fill_in_generic_residual_contribution_cons_axisym_adv_diff().
Referenced by DistanceWrapper< ELEMENT >::fill_in_contribution_to_jacobian(), oomph::TLinearHeatAndElasticityElement< DIM, NNODE_1D >::fill_in_contribution_to_jacobian(), oomph::HeatedLinearSurfaceContactElement< ELEMENT >::fill_in_contribution_to_jacobian(), oomph::HeatedPenetratorFluxElement< ELEMENT >::fill_in_contribution_to_jacobian(), NonIsothermalAxisymmetricQCrouzeixRaviartElement::fill_in_contribution_to_jacobian(), oomph::ProjectableElement< ELEMENT >::fill_in_contribution_to_jacobian(), oomph::PseudoSolidNodeUpdateElement< BASIC, SOLID >::fill_in_contribution_to_jacobian(), oomph::RefineablePseudoSolidNodeUpdateElement< BASIC, SOLID >::fill_in_contribution_to_jacobian(), oomph::RefineableNavierStokesBoussinesqElement< NST_ELEMENT, AD_ELEMENT >::fill_in_contribution_to_jacobian(), oomph::RefineableAdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::fill_in_contribution_to_jacobian(), oomph::NavierStokesBoussinesqElement< NST_ELEMENT, AD_ELEMENT >::fill_in_contribution_to_jacobian(), oomph::AdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::fill_in_contribution_to_jacobian(), oomph::SpineLineMarangoniFluidInterfaceElement< ELEMENT >::fill_in_contribution_to_jacobian_and_mass_matrix(), oomph::SpineAxisymmetricMarangoniSurfactantFluidInterfaceElement< ELEMENT >::fill_in_contribution_to_jacobian_and_mass_matrix(), and oomph::SpineLineMarangoniSurfactantFluidInterfaceElement< ELEMENT >::fill_in_contribution_to_jacobian_and_mass_matrix().
void oomph::fill_in_contribution_to_jacobian_and_mass_matrix | ( | Vector< double > & | residuals, |
DenseMatrix< double > & | jacobian, | ||
DenseMatrix< double > & | mass_matrix | ||
) |
Add the element's contribution to its residuals vector, jacobian matrix and mass matrix
References fill_in_generic_residual_contribution_cons_axisym_adv_diff().
Referenced by oomph::PseudoSolidNodeUpdateElement< BASIC, SOLID >::fill_in_contribution_to_jacobian_and_mass_matrix(), and oomph::RefineablePseudoSolidNodeUpdateElement< BASIC, SOLID >::fill_in_contribution_to_jacobian_and_mass_matrix().
Add the element's contribution to its residual vector (wrapper)
References oomph::GeneralisedElement::Dummy_matrix, and fill_in_generic_residual_contribution_cons_axisym_adv_diff().
Referenced by FixSpineHeightElement::fill_in_contribution_to_jacobian(), FluxConstraint::fill_in_contribution_to_jacobian(), oomph::TLinearHeatAndElasticityElement< DIM, NNODE_1D >::fill_in_contribution_to_residuals(), NonIsothermalAxisymmetricQCrouzeixRaviartElement::fill_in_contribution_to_residuals(), oomph::ProjectableElement< ELEMENT >::fill_in_contribution_to_residuals(), oomph::PseudoSolidNodeUpdateElement< BASIC, SOLID >::fill_in_contribution_to_residuals(), oomph::RefineablePseudoSolidNodeUpdateElement< BASIC, SOLID >::fill_in_contribution_to_residuals(), oomph::PseudoSolidNodeUpdateElement< BASIC, SOLID >::fill_in_shape_derivatives_by_fd(), oomph::RefineablePseudoSolidNodeUpdateElement< BASIC, SOLID >::fill_in_shape_derivatives_by_fd(), and oomph::DGSpectralScalarAdvectionElement< 1, NNODE_1D >::get_inverse_mass_matrix_times_residuals().
|
protectedvirtual |
Add the element's contribution to its residual vector only (if flag=and/or element Jacobian matrix
Referenced by fill_in_contribution_to_jacobian(), fill_in_contribution_to_jacobian_and_mass_matrix(), and fill_in_contribution_to_residuals().
|
inlinevirtual |
Get additional (conservative) wind at (Eulerian) position x and/or local coordinate s. This function is virtual to allow overloading in multi-physics problems where the wind function might be determined by another system of equations
References Conserved_wind_fct_pt, i, and plotDoE::x.
Referenced by oomph::RefineableGeneralisedAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_cons_axisym_adv_diff(), and get_total_flux().
|
inlinevirtual |
Get diffusivity tensor at (Eulerian) position x and/or local coordinate s. This function is virtual to allow overloading in multi-physics problems where the wind function might be determined by another system of equations
References D, Diff_fct_pt, i, j, and plotDoE::x.
Referenced by oomph::RefineableGeneralisedAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_cons_axisym_adv_diff(), and get_total_flux().
Get flux: \(\mbox{flux}[i] = \mbox{d}u / \mbox{d}x_i \).
References ProblemParameters::flux(), j, s, and u_index_cons_axisym_adv_diff().
Referenced by oomph::SurfaceMeltElement< ELEMENT >::fill_in_contribution_to_residuals_surface_melt(), oomph::AdvectionDiffusionFluxElement< ELEMENT >::fill_in_generic_residual_contribution_adv_diff_flux(), oomph::FourierDecomposedHelmholtzFluxElement< ELEMENT >::fill_in_generic_residual_contribution_fourier_decomposed_helmholtz_flux(), oomph::HelmholtzFluxElement< ELEMENT >::fill_in_generic_residual_contribution_helmholtz_flux(), oomph::PMLHelmholtzFluxElement< ELEMENT >::fill_in_generic_residual_contribution_helmholtz_flux(), oomph::LinearWaveFluxElement< ELEMENT >::fill_in_generic_residual_contribution_lin_wave_flux(), oomph::PMLFourierDecomposedHelmholtzFluxElement< ELEMENT >::fill_in_generic_residual_contribution_pml_fourier_decomposed_helmholtz_flux(), oomph::PoissonFluxElement< ELEMENT >::fill_in_generic_residual_contribution_poisson_flux(), oomph::UnsteadyHeatBaseFaceElement< 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(), AirwayReopeningProblem< ELEMENT >::get_outlet_flux(), RefineableModalPoissonEquations< DIM >::get_Z2_flux(), and oomph::RefineableGeneralisedAxisymAdvectionDiffusionEquations::get_Z2_flux().
double oomph::get_lu_factor_memory_usage_in_bytes | ( | ) |
Function to calculate the number of bytes used to store the LU factors
Referenced by oomph::SuperLUSolver::get_memory_usage_for_lu_factors().
|
inlinevirtual |
Get source term at (Eulerian) position x. This function is virtual to allow overloading in multi-physics problems where the strength of the source function might be determined by another system of equations
References TestProblem::source(), Source_fct_pt, and plotDoE::x.
Referenced by oomph::RefineableGeneralisedAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_cons_axisym_adv_diff().
Get flux: \(\mbox{flux}[i] = \mbox{d}u / \mbox{d}x_i \).
References D, get_conserved_wind_cons_axisym_adv_diff(), get_diff_cons_axisym_adv_diff(), i, j, s, and u_index_cons_axisym_adv_diff().
double oomph::get_total_memory_usage_in_bytes | ( | ) |
Function to calculate the number of bytes used in calculating and storing the LU factors
Referenced by oomph::SuperLUSolver::get_total_needed_memory().
|
inlinevirtual |
Get wind at (Eulerian) position x and/or local coordinate s. This function is virtual to allow overloading in multi-physics problems where the wind function might be determined by another system of equations
References i, Wind_fct_pt, and plotDoE::x.
Referenced by oomph::RefineableGeneralisedAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_cons_axisym_adv_diff().
double oomph::integrate_u | ( | ) |
Integrate the concentration over the element.
Return FE representation of function value u(s) at local coordinate s.
References s, oomph::OneDimLagrange::shape(), and u_index_cons_axisym_adv_diff().
void oomph::METIS_PartGraphKway | ( | int * | , |
int * | , | ||
int * | , | ||
int * | , | ||
int * | , | ||
int * | , | ||
int * | , | ||
int * | , | ||
int * | , | ||
int * | , | ||
int * | |||
) |
Metis graph partitioning function.
Referenced by oomph::METIS::partition_mesh().
void oomph::METIS_PartGraphVKway | ( | int * | , |
int * | , | ||
int * | , | ||
int * | , | ||
int * | , | ||
int * | , | ||
int * | , | ||
int * | , | ||
int * | , | ||
int * | , | ||
int * | |||
) |
Metis graph partitioning function – decomposes nodal graph based on minimum communication volume
Referenced by oomph::METIS::partition_mesh().
Adds all elements of the vector to an output stream. NB: this is a global function and a friend of the Vec3D class!
[in] | os | the output stream, |
[in] | a | The vector of interest |
std::ostream& oomph::operator<< | ( | std::ostream & | out, |
const Data & | d | ||
) |
Data output operator: output equation numbers and values at all times, along with any extra information stored for the timestepper.
std::ostream& oomph::operator<< | ( | std::ostream & | out, |
const DoubleVector & | v | ||
) |
output operator
Ouput operator for DoubleVector.
std::ostream& oomph::operator<< | ( | std::ostream & | out, |
const Node & | nd | ||
) |
Node output operator: output equation numbers and values at all times, along with any extra information stored for the timestepper.
std::ostream& oomph::operator<< | ( | std::ostream & | stream, |
LinearAlgebraDistribution & | dist | ||
) |
void oomph::output | ( | FILE * | file_pt | ) |
C_style output with default number of plot points.
References output().
void oomph::output | ( | FILE * | file_pt, |
const unsigned & | n_plot | ||
) |
C-style output FE representation of soln: r,z,u at n_plot^2 plot points
Referenced by QGeneralisedAxisymAdvectionDiffusionElement< NNODE_1D >::output().
void oomph::output | ( | std::ostream & | outfile | ) |
Output with default number of plot points.
Referenced by oomph::VectorHelpers::cross(), DarcyProblem< ELEMENT >::doc_shape_functions(), MortaringValidationProblem< ELEMENT, NON_MORTAR_ELEMENT >::MortaringValidationProblem(), output(), oomph::QElement< 1, NNODE_1D >::output(), oomph::QElement< 2, NNODE_1D >::output(), oomph::QElement< 3, NNODE_1D >::output(), SpineGravityTractionElement< ELEMENT >::output(), oomph::TElement< 1, NNODE_1D >::output(), oomph::TElement< 2, NNODE_1D >::output(), oomph::TElement< 3, NNODE_1D >::output(), oomph::DenseMatrix< T >::output(), oomph::MyProblem::output_ltes(), MortaringValidationProblem< ELEMENT, NON_MORTAR_ELEMENT >::run(), oomph::TrilinosMLPreconditioner::set_output(), oomph::StringConversion::to_lower(), and oomph::StringConversion::to_upper().
void oomph::output | ( | std::ostream & | outfile, |
const unsigned & | nplot | ||
) |
Output FE representation of soln: r,z,u at nplot^2 plot points
|
virtual |
Output exact soln: r,z,,u_exact at nplot^2 plot points (dummy time-dependent version to keep intel compiler happy)
References OOMPH_CURRENT_FUNCTION, and OOMPH_EXCEPTION_LOCATION.
Referenced by QGeneralisedAxisymAdvectionDiffusionElement< NNODE_1D >::output_fct().
void oomph::output_fct | ( | std::ostream & | outfile, |
const unsigned & | nplot, | ||
FiniteElement::SteadyExactSolutionFctPt | exact_soln_pt | ||
) |
Output exact soln: r,z,u_exact at nplot^2 plot points.
Referenced by NonIsothermalAxisymmetricQCrouzeixRaviartElement::output_fct(), and oomph::TLinearHeatAndElasticityElement< DIM, NNODE_1D >::output_fct().
void oomph::pause | ( | std::string | message | ) |
Pause and display message.
Pause and dump out message.
References oomph_info, oomph::PauseFlags::PauseFlag, and oomph::Global_string_for_annotation::string().
Referenced by oomph::OcTree::doc_face_neighbours(), oomph::OcTree::doc_true_edge_neighbours(), main(), oomph::TreeBasedRefineableMeshBase::refine_as_in_reference_mesh(), PoissonProblem< ELEMENT >::run_it(), set_pseudo_elastic_fsi_solver(), oomph::StefanBoltzmannHelper::setup_stefan_boltzmann_visibility(), oomph::Problem::sparse_assemble_row_or_column_compressed_with_lists(), oomph::Problem::sparse_assemble_row_or_column_compressed_with_maps(), oomph::Problem::sparse_assemble_row_or_column_compressed_with_two_arrays(), oomph::Problem::sparse_assemble_row_or_column_compressed_with_two_vectors(), oomph::Problem::sparse_assemble_row_or_column_compressed_with_vectors_of_pairs(), and FpTestProblem::validate_fp().
const double& oomph::pe | ( | ) | const |
Peclet number.
References Pe_pt.
Referenced by oomph::AdvectionDiffusionEquations< DIM >::fill_in_generic_residual_contribution_adv_diff(), oomph::RefineableAdvectionDiffusionEquations< DIM >::fill_in_generic_residual_contribution_adv_diff(), oomph::GeneralisedAdvectionDiffusionEquations< DIM >::fill_in_generic_residual_contribution_cons_adv_diff(), oomph::RefineableGeneralisedAdvectionDiffusionEquations< DIM >::fill_in_generic_residual_contribution_cons_adv_diff(), oomph::RefineableGeneralisedAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_cons_axisym_adv_diff(), RefineableQAxisymAdvectionDiffusionBoussinesqElement::fill_in_off_diagonal_block_analytic(), QAxisymAdvectionDiffusionElementWithExternalElement::fill_in_off_diagonal_block_analytic(), RefineableQAdvectionDiffusionElementWithExternalElement< DIM >::fill_in_off_diagonal_block_analytic(), QAdvectionDiffusionElementWithExternalElement< DIM >::fill_in_off_diagonal_block_analytic(), oomph::RefineableAdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::fill_in_off_diagonal_block_analytic(), oomph::AdvectionDiffusionBoussinesqElement< AD_ELEMENT, NST_ELEMENT >::fill_in_off_diagonal_block_analytic(), and RefineableBuoyantQCrouzeixRaviartElement< DIM >::fill_in_off_diagonal_jacobian_blocks_analytic().
const double& oomph::pe_st | ( | ) | const |
Peclet number multiplied by Strouhal number.
References PeSt_pt.
Referenced by oomph::AdvectionDiffusionEquations< DIM >::fill_in_generic_residual_contribution_adv_diff(), oomph::RefineableAdvectionDiffusionEquations< DIM >::fill_in_generic_residual_contribution_adv_diff(), oomph::GeneralisedAdvectionDiffusionEquations< DIM >::fill_in_generic_residual_contribution_cons_adv_diff(), oomph::RefineableGeneralisedAdvectionDiffusionEquations< DIM >::fill_in_generic_residual_contribution_cons_adv_diff(), and oomph::RefineableGeneralisedAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_cons_axisym_adv_diff().
double*& oomph::pe_st_pt | ( | ) |
Local (not exported in header) helper function to handle midpoint update on a data object.
References oomph::Data::eqn_number(), oomph::Data::is_a_copy(), j, oomph::Data::nvalue(), oomph::Data::set_value(), and oomph::Data::value().
Referenced by oomph::IMRByBDF::actions_after_timestep().
|
inline |
References oomph::Global_string_for_annotation::string().
Referenced by oomph::MyProblem::initial_doc().
unsigned oomph::self_test | ( | ) |
Self-test: Return 0 for OK.
Referenced by DemoPoissonProblem::actions_before_newton_solve(), TestPoissonProblem< ELEMENT >::doc_solution(), oomph::MGSolver< DIM >::full_setup(), and TwoNodePoissonElement::self_test().
T oomph::smart_cast_preconditioner | ( | Preconditioner * | prec_pt | ) |
Given a preconditioner: 1) if it's a the right type of preconditioner return it 2) otherwise if its a SoM preconditioner containing the right type of preconditioner then return a pointer to the underlying preconditioner. 3) otherwise return null
GeneralisedAxisymAdvectionDiffusionSourceFctPt oomph::source_fct_pt | ( | ) |
Access function: Pointer to source function.
Access function: Pointer to source function. Const version.
References Source_fct_pt.
Referenced by RefineableModalPoissonEquations< DIM >::further_build(), LinearWaveProblem< ELEMENT, TIMESTEPPER >::LinearWaveProblem(), main(), and oomph::BiharmonicProblem< DIM >::set_source_function().
int oomph::superlu_complex | ( | int * | , |
int * | , | ||
int * | , | ||
int * | , | ||
std::complex< double > * | , | ||
int * | , | ||
int * | , | ||
std::complex< double > * | , | ||
int * | , | ||
int * | , | ||
int * | , | ||
void * | , | ||
int * | |||
) |
///////////////////////////////////////////////////////////////////// ///////////////////////////////////////////////////////////////////// /////////////////////////////////////////////////////////////////////
Referenced by oomph::CRComplexMatrix::clean_up_memory(), oomph::CCComplexMatrix::clean_up_memory(), oomph::CRComplexMatrix::lubksub(), oomph::CCComplexMatrix::lubksub(), oomph::CRComplexMatrix::ludecompose(), and oomph::CCComplexMatrix::ludecompose().
|
inlinevirtual |
A class for all elements that solve the Advection Diffusion equations in conservative form using isoparametric elements in a cylindrical polar coordinate system. \mbox{\boldmath$\nabla\cdot$} \left( Pe \mbox{\boldmath$w$}(\mbox{\boldmath$x$}) u
class GeneralisedAxisymAdvectionDiffusionEquations : public virtual FiniteElement { public: Function pointer to source function fct(x,f(x)) – x is a Vector! typedef void (*GeneralisedAxisymAdvectionDiffusionSourceFctPt)( const Vector<double>& x, double& f);
Function pointer to wind function fct(x,w(x)) – x is a Vector! typedef void (*GeneralisedAxisymAdvectionDiffusionWindFctPt)( const Vector<double>& x, Vector<double>& wind);
Function pointer to a diffusivity function typedef void (*GeneralisedAxisymAdvectionDiffusionDiffFctPt)( const Vector<double>& x, DenseMatrix<double>& D);
Constructor: Initialise the Source_fct_pt and Wind_fct_pt to null and set (pointer to) Peclet number to default GeneralisedAxisymAdvectionDiffusionEquations() : Source_fct_pt(0), Wind_fct_pt(0), Conserved_wind_fct_pt(0), Diff_fct_pt(0), ALE_is_disabled(false) { Set Peclet number to default Pe_pt = Set Peclet Strouhal number to default PeSt_pt = }
Broken copy constructor GeneralisedAxisymAdvectionDiffusionEquations( const GeneralisedAxisymAdvectionDiffusionEquations& dummy) = delete;
Broken assignment operator Commented out broken assignment operator because this can lead to a conflict warning when used in the virtual inheritence hierarchy. Essentially the compiler doesn't realise that two separate implementations of the broken function are the same and so, quite rightly, it shouts. /*void operator=(const GeneralisedAxisymAdvectionDiffusionEquations&) = delete; Return the index at which the unknown value is stored. The default value, 0, is appropriate for single-physics problems, when there is only one variable, the value that satisfies the advection-diffusion equation. In derived multi-physics elements, this function should be overloaded to reflect the chosen storage scheme. Note that these equations require that the unknown is always stored at the same index at each node.
Referenced by du_dt_cons_axisym_adv_diff(), oomph::RefineableGeneralisedAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_cons_axisym_adv_diff(), get_flux(), oomph::RefineableGeneralisedAxisymAdvectionDiffusionEquations::get_interpolated_values(), get_total_flux(), and interpolated_u_cons_axisym_adv_diff().
GeneralisedAxisymAdvectionDiffusionWindFctPt oomph::wind_fct_pt | ( | ) |
Access function: Pointer to wind function.
Access function: Pointer to wind function. Const version.
References Wind_fct_pt.
Referenced by ContProblem< ELEMENT >::ContProblem(), and DGProblem< ELEMENT >::DGProblem().
|
protected |
Boolean flag to indicate if ALE formulation is disabled when time-derivatives are computed. Only set to false if you're sure that the mesh is stationary.
Referenced by oomph::GeneralisedNewtonianNavierStokesEquations< DIM >::d_kin_energy_dt(), oomph::SpaceTimeNavierStokesEquations< DIM >::d_kin_energy_dt(), oomph::SpaceTimeNavierStokesMixedOrderEquations< DIM >::d_kin_energy_dt(), disable_ALE(), enable_ALE(), oomph::AdvectionDiffusionEquations< DIM >::fill_in_generic_residual_contribution_adv_diff(), oomph::RefineableAdvectionDiffusionEquations< DIM >::fill_in_generic_residual_contribution_adv_diff(), oomph::AdvectionDiffusionReactionEquations< NREAGENT, DIM >::fill_in_generic_residual_contribution_adv_diff_react(), oomph::RefineableAdvectionDiffusionReactionEquations< NREAGENT, DIM >::fill_in_generic_residual_contribution_adv_diff_react(), oomph::GeneralisedAdvectionDiffusionEquations< DIM >::fill_in_generic_residual_contribution_cons_adv_diff(), oomph::RefineableGeneralisedAdvectionDiffusionEquations< DIM >::fill_in_generic_residual_contribution_cons_adv_diff(), oomph::RefineableGeneralisedAxisymAdvectionDiffusionEquations::fill_in_generic_residual_contribution_cons_axisym_adv_diff(), oomph::RefineableSpaceTimeNavierStokesEquations< DIM >::fill_in_generic_residual_contribution_nst(), oomph::RefineableSpaceTimeNavierStokesMixedOrderEquations< DIM >::fill_in_generic_residual_contribution_nst(), oomph::SpaceTimeNavierStokesEquations< DIM >::fill_in_generic_residual_contribution_nst(), oomph::SpaceTimeNavierStokesMixedOrderEquations< DIM >::fill_in_generic_residual_contribution_nst(), oomph::GeneralisedNewtonianNavierStokesEquations< DIM >::fill_in_generic_residual_contribution_nst(), oomph::RefineableGeneralisedNewtonianNavierStokesEquations< DIM >::fill_in_generic_residual_contribution_nst(), oomph::NavierStokesEquations< DIM >::fill_in_generic_residual_contribution_nst(), oomph::RefineableNavierStokesEquations< DIM >::fill_in_generic_residual_contribution_nst(), oomph::RefineableSpaceTimeUnsteadyHeatEquations< SPATIAL_DIM >::fill_in_generic_residual_contribution_ust_heat(), oomph::RefineableSpaceTimeUnsteadyHeatMixedOrderEquations< SPATIAL_DIM >::fill_in_generic_residual_contribution_ust_heat(), oomph::RefineableUnsteadyHeatEquations< DIM >::fill_in_generic_residual_contribution_ust_heat(), oomph::UnsteadyHeatEquations< DIM >::fill_in_generic_residual_contribution_ust_heat(), oomph::NavierStokesElementWithSingularity< BASIC_NAVIER_STOKES_ELEMENT >::fill_in_generic_residual_contribution_wrapped_nst(), oomph::RefineableGeneralisedAxisymAdvectionDiffusionEquations::further_build(), oomph::QTaylorHoodSpaceTimeElement< 2 >::get_dof_numbers_for_unknowns(), oomph::GeneralisedNewtonianNavierStokesEquations< DIM >::get_dresidual_dnodal_coordinates(), oomph::RefineableGeneralisedNewtonianNavierStokesEquations< DIM >::get_dresidual_dnodal_coordinates(), oomph::NavierStokesEquations< DIM >::get_dresidual_dnodal_coordinates(), oomph::RefineableNavierStokesEquations< DIM >::get_dresidual_dnodal_coordinates(), oomph::SpaceTimeNavierStokesEquations< DIM >::get_dresidual_dnodal_coordinates(), oomph::RefineableSpaceTimeNavierStokesEquations< DIM >::get_dresidual_dnodal_coordinates(), oomph::QTaylorHoodElement< 2 >::identify_load_data(), oomph::GeneralisedAdvectionDiffusionEquations< 2 >::output_fct(), and oomph::UnsteadyHeatEquations< 2 >::output_fct().
|
protected |
Pointer to additional (conservative) wind function:
Referenced by conserved_wind_fct_pt(), oomph::RefineableGeneralisedAxisymAdvectionDiffusionEquations::further_build(), and get_conserved_wind_cons_axisym_adv_diff().
OutputModifier oomph::default_output_modifier |
Single global instatiation of the default output modifier.
Referenced by main().
|
staticprivate |
Static default value for the Peclet number.
|
protected |
Pointer to diffusivity funciton.
Referenced by ModalPoissonEquations< DIM >::diff_fct_pt(), diff_fct_pt(), oomph::RefineableGeneralisedAxisymAdvectionDiffusionEquations::further_build(), ModalPoissonEquations< DIM >::get_diff(), and get_diff_cons_axisym_adv_diff().
OomphInfo oomph::oomph_info |
Single (global) instantiation of the OomphInfo object – this is used throughout the library as a "replacement" for std::cout
Referenced by MeltContactProblem< ELEMENT >::actions_after_adapt(), ContactProblem< ELEMENT >::actions_after_adapt(), RefineableDrivenCavityProblem< ELEMENT >::actions_after_adapt(), QuarterCircleDrivenCavityProblem< ELEMENT >::actions_after_adapt(), PRefineableDrivenCavityProblem< ELEMENT >::actions_after_adapt(), NavierStokesProblem< ELEMENT >::actions_after_parameter_increase(), RefineableFishPoissonProblem< ELEMENT >::actions_before_adapt(), MeltContactProblem< ELEMENT >::actions_before_implicit_timestep(), SolarRadiationProblem< ELEMENT >::actions_before_implicit_timestep(), ContactProblem< ELEMENT >::actions_before_implicit_timestep(), PressureWaveFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::actions_before_implicit_timestep(), PseudoElasticCollapsibleChannelProblem< FLUID_ELEMENT, SOLID_ELEMENT >::actions_before_implicit_timestep(), StefanBoltzmannProblem< ELEMENT >::actions_before_newton_solve(), oomph::BiharmonicProblem< DIM >::actions_before_newton_solve(), oomph::BiharmonicFluidProblem< DIM >::actions_before_newton_solve(), oomph::NonLinearElasticitySmoothMesh< ELEMENT >::actions_before_newton_solve(), oomph::RefineableTetgenMesh< ELEMENT >::adapt(), oomph::RefineableGmshTetMesh< ELEMENT >::adapt(), oomph::TreeBasedRefineableMeshBase::adapt(), oomph::Problem::adapt(), oomph::Problem::adapt_based_on_error_estimates(), oomph::TreeBasedRefineableMeshBase::adapt_mesh(), oomph::PeriodicOrbitAssemblyHandler< NNODE_1D >::adapt_temporal_mesh(), oomph::Problem::adaptive_unsteady_newton_solve(), oomph::GeneralisedElement::add_external_data(), oomph::GeneralisedElement::add_internal_data(), oomph::Problem::add_time_stepper_pt(), MovingBlockProblem< ELEMENT >::apply_boundary_conditions(), PMLStructuredCubicHelmholtz< ELEMENT >::apply_boundary_conditions(), NavierStokesProblem< ELEMENT >::apply_boundary_conditions(), oomph::Problem::arc_length_step_solve(), oomph::Problem::arc_length_step_solve_helper(), oomph::TetMeshBase::assess_mesh_quality(), oomph::Problem::assign_eqn_numbers(), oomph::Multi_domain_functions::aux_setup_multi_domain_interaction(), AxiPoroProblem< ELEMENT, TIMESTEPPER >::AxiPoroProblem(), AxisymmetricVibratingShellProblem< ELEMENT >::AxisymmetricVibratingShellProblem(), oomph::MumpsSolver::backsub(), oomph::Problem::bifurcation_adapt_helper(), BiharmonicTestProblem1::BiharmonicTestProblem1(), oomph::BlackBoxFDNewtonSolver::black_box_fd_newton_solve(), oomph::HelmholtzMGPreconditioner< DIM >::block_preconditioner_self_test(), oomph::ODEProblem::build(), oomph::QSpectralElement< 3, NNODE_1D >::build_face_element(), oomph::MeshAsGeomObject::build_it(), oomph::ExtrudedCubeMeshFromQuadMesh< ELEMENT >::build_mesh(), oomph::FishMesh< ELEMENT >::build_mesh(), AxisymmetricVibratingShellProblem< ELEMENT >::calculate_error_of_fixed_point_iteration(), VibratingShellProblem< ELEMENT >::calculate_error_of_fixed_point_iteration(), oomph::CassonTanMilRegWithBlendingConstitutiveEquation< DIM >::CassonTanMilRegWithBlendingConstitutiveEquation(), oomph::BinaryTreeForest::check_all_neighbours(), oomph::OcTreeForest::check_all_neighbours(), oomph::QuadTreeForest::check_all_neighbours(), oomph::Mesh::check_for_repeated_nodes(), oomph::HypreHelpers::check_HYPRE_error_flag(), oomph::PRefineableQElement< 2, INITIAL_NNODE_1D >::check_integrity(), oomph::RefineableQElement< 3 >::check_integrity(), oomph::RefineableQElement< 1 >::check_integrity(), oomph::RefineableQElement< 2 >::check_integrity(), check_locate_zeta(), oomph::SolarRadiationBase::check_quadrant_jump(), VorticityRecoveryProblem< ELEMENT >::check_smoothed_vorticity(), CoatedDiskProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::CoatedDiskProblem(), CollapsibleChannelProblem< ELEMENT >::CollapsibleChannelProblem(), MovingBlockProblem< ELEMENT >::complete_element_build(), oomph::TreeBasedRefineableMeshBase::complete_hanging_nodes(), AxisymmetricVibratingShellProblem< ELEMENT >::complete_problem_setup(), VibratingShellProblem< ELEMENT >::complete_problem_setup(), ContactProblem< ELEMENT >::complete_problem_setup(), oomph::ComplexDampedJacobi< MATRIX >::complex_solve_helper(), oomph::ComplexGMRES< MATRIX >::complex_solve_helper(), oomph::RefineableTriangleMesh< ELEMENT >::compute_area_target(), ModalPoissonEquations< DIM >::compute_error(), oomph::CRDoubleMatrixHelpers::concatenate(), oomph::Problem::copy(), MeltContactProblem< ELEMENT >::create_contact_elements(), ContactProblem< ELEMENT >::create_displ_imposition_elements(), MovingBlockProblem< ELEMENT >::create_extruded_mesh(), ExtrudedMovingCylinderProblem< TWO_D_ELEMENT, THREE_D_ELEMENT >::create_extruded_mesh(), MeltContactProblem< ELEMENT >::create_flux_elements(), RefineableRotatingCylinderProblem< ELEMENT >::create_free_surface_elements(), StefanBoltzmannProblem< ELEMENT >::create_melt_elements(), oomph::GmshTetScaffoldMesh::create_mesh_from_msh_file(), FpTestProblem::create_refineable_traction_elements(), NavierStokesProblem< ELEMENT >::create_spacetime_mesh(), FpTestProblem::create_traction_elements(), oomph::FiniteElement::d_dshape_eulerian_dnodal_coordinates_templated_helper(), DarcyProblem< ELEMENT >::DarcyProblem(), oomph::Problem::debug_hook_fct(), demo_smoothing_with_linear_elasticity(), demo_smoothing_with_nonlinear_elasticity(), demo_smoothing_with_poisson(), oomph::MGSolver< DIM >::disable_output(), oomph::HelmholtzMGPreconditioner< DIM >::disable_output(), oomph::DiskWithTorusAroundEdgeTetMeshFacetedSurface::DiskWithTorusAroundEdgeTetMeshFacetedSurface(), oomph::FiniteElement::dJ_eulerian_dnodal_coordinates_templated_helper(), oomph::CommandLineArgs::doc_available_flags(), oomph::Mesh::doc_boundary_coordinates(), Global_Physical_Variables::doc_dependent_parameters(), oomph::Problem::doc_errors(), GlobalParameters::doc_maximum_central_box_deformation(), GlobalParameters::doc_navier_stokes_parameters(), FSIChannelWithLeafletProblem< ELEMENT >::doc_parameters(), UnstructuredFvKProblem< ELEMENT >::doc_solution(), ExtrudedMovingCylinderProblem< TWO_D_ELEMENT, THREE_D_ELEMENT >::doc_solution(), MeltContactProblem< ELEMENT >::doc_solution(), SolarRadiationProblem< ELEMENT >::doc_solution(), ContactProblem< ELEMENT >::doc_solution(), StefanBoltzmannProblem< ELEMENT >::doc_solution(), CoatedDiskProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::doc_solution(), PrescribedBoundaryDisplacementProblem< ELEMENT >::doc_solution(), PMLStructuredCubicHelmholtz< ELEMENT >::doc_solution(), UnsteadyHeatProblem< ELEMENT >::doc_solution(), NavierStokesProblem< ELEMENT >::doc_solution(), FlowAroundCylinderProblem< ELEMENT >::doc_solution(), UnstructuredImmersedEllipseProblem< ELEMENT >::doc_solution(), AxisymmetricVibratingShellProblem< ELEMENT >::doc_solution(), VibratingShellProblem< ELEMENT >::doc_solution(), UnstructuredPoissonProblem< ELEMENT >::doc_solution(), RefineableUnsteadyHeatProblem< ELEMENT >::doc_solution(), BubbleInChannelProblem< ELEMENT >::doc_solution(), DropInChannelProblem< ELEMENT >::doc_solution(), UnstructuredFluidProblem< ELEMENT >::doc_solution(), RefineableDrivenCavityProblem< ELEMENT >::doc_solution(), AxiPoroProblem< ELEMENT, TIMESTEPPER >::doc_solution(), TetmeshPoissonProblem< ELEMENT >::doc_solution(), FourierDecomposedHelmholtzProblem< ELEMENT >::doc_solution(), HelmholtzPointSourceProblem< ELEMENT >::doc_solution(), ScatteringProblem< ELEMENT >::doc_solution(), CoatedSphereProblem< ELASTICITY_ELEMENT, HELMHOLTZ_ELEMENT >::doc_solution(), LinearWaveProblem< ELEMENT, TIMESTEPPER >::doc_solution(), RefineableFishPoissonProblem< ELEMENT >::doc_solution(), FluxPoissonMGProblem< ELEMENT, MESH >::doc_solution(), UnitCubePoissonMGProblem< ELEMENT, MESH >::doc_solution(), PMLFourierDecomposedHelmholtzProblem< ELEMENT >::doc_solution(), oomph::NonLinearElasticitySmoothMesh< ELEMENT >::doc_solution(), oomph::BiharmonicProblem< DIM >::doc_solution(), oomph::BiharmonicFluidProblem< DIM >::doc_solution(), oomph::CommandLineArgs::doc_specified_flags(), oomph::BlockPreconditioner< MATRIX >::document(), oomph::Problem::doubly_adaptive_unsteady_newton_solve_helper(), oomph::PRefineableQElement< 1, INITIAL_NNODE_1D >::dshape_local(), UnsteadyHeatProblem< ELEMENT >::enforce_time_periodic_boundary_conditions(), oomph::CRDoubleMatrix::entries_are_sorted(), extrapolated_strain_rate(), ExtrudedMovingCylinderProblem< TWO_D_ELEMENT, THREE_D_ELEMENT >::ExtrudedMovingCylinderProblem(), oomph::MumpsSolver::factorise(), oomph::HeatedLinearSurfaceContactElement< ELEMENT >::fill_in_contribution_to_residuals_surface_contact(), oomph::SolidFiniteElement::fill_in_generic_jacobian_for_solid_ic(), oomph::NavierStokesElementWithSingularity< BASIC_NAVIER_STOKES_ELEMENT >::fill_in_generic_residual_contribution_wrapped_nst(), oomph::BrethertonSpineMesh< ELEMENT, INTERFACE_ELEMENT >::find_distance_to_free_surface(), FlowAroundCylinderProblem< ELEMENT >::FlowAroundCylinderProblem(), FpTestProblem::FpTestProblem(), FSIChannelWithLeafletProblem< ELEMENT >::FSIChannelWithLeafletProblem(), FSICollapsibleChannelProblem< ELEMENT >::FSICollapsibleChannelProblem(), STSpineMesh< ELEMENT, INTERFACE_ELEMENT >::full_output(), oomph::MGSolver< DIM >::full_setup(), oomph::HelmholtzMGPreconditioner< DIM >::full_setup(), oomph::FullCircleMesh< ELEMENT >::FullCircleMesh(), oomph::GeompackQuadScaffoldMesh::GeompackQuadScaffoldMesh(), oomph::Problem::get_all_error_estimates(), oomph::KirchhoffLoveShellEquations::get_energy(), oomph::Problem::get_inverse_mass_matrix_times_residuals(), oomph::FpPressureAdvectionDiffusionProblem< ELEMENT >::get_pressure_advection_diffusion_jacobian(), oomph::VorticitySmootherElement< ELEMENT >::get_raw_velocity_deriv(), oomph::VorticitySmootherElement< ELEMENT >::get_raw_vorticity_deriv(), oomph::VorticitySmootherElement< ELEMENT >::get_raw_vorticity_second_deriv(), oomph::VorticitySmootherElement< ELEMENT >::get_raw_vorticity_third_deriv(), oomph::VorticitySmoother< ELEMENT >::get_recovered_vorticity_in_patch(), GlobalFct::get_residuals(), AxisymmetricVibratingShellProblem< ELEMENT >::global_temporal_error_norm(), VibratingShellProblem< ELEMENT >::global_temporal_error_norm(), RefineableUnsteadyHeatProblem< ELEMENT >::global_temporal_error_norm(), oomph::Problem::globally_convergent_line_search(), GluedSolidMesh::glue(), oomph::GmshTetScaffoldMesh::GmshTetScaffoldMesh(), HeatedCircularPenetratorElement::HeatedCircularPenetratorElement(), oomph::HerschelBulkleyTanMilRegConstitutiveEquation< DIM >::HerschelBulkleyTanMilRegConstitutiveEquation(), oomph::HerschelBulkleyTanMilRegWithBlendingConstitutiveEquation< DIM >::HerschelBulkleyTanMilRegWithBlendingConstitutiveEquation(), oomph::HypreInterface::hypre_matrix_setup(), oomph::HypreInterface::hypre_solve(), oomph::HypreInterface::hypre_solver_setup(), oomph::MPI_Helpers::init(), ModalPRefineableQElement< DIM >::initial_setup(), oomph::FiniteElement::invert_jacobian(), oomph::FiniteElement::J_eulerian(), oomph::FiniteElement::J_eulerian_at_knot(), oomph::PRefineableQElement< 1, INITIAL_NNODE_1D >::local_coordinate_of_node(), oomph::FiniteElement::locate_zeta(), main(), oomph::MGSolver< DIM >::mg_solve(), oomph::HelmholtzMGPreconditioner< DIM >::mg_solve(), MultiPoissonProblem< ELEMENT >::MultiPoissonProblem(), NavierStokesProblem< ELEMENT >::NavierStokesProblem(), oomph::Problem::newton_solve(), oomph::Problem::newton_solve_continuation(), oomph::Mesh::node_update(), NonRefineableBinArray::NonRefineableBinArray(), oomph::DGEulerFaceElement< ELEMENT >::numerical_flux(), oomph::ObsoleteCode::obsolete(), oomph::PRefineableQElement< 3, INITIAL_NNODE_1D >::oc_hang_helper(), oomph::NonLinearElasticitySmoothMesh< ELEMENT >::operator()(), oomph::LinearElasticitySmoothMesh< LINEAR_ELASTICITY_ELEMENT >::operator()(), oomph::PoissonSmoothMesh< POISSON_ELEMENT >::operator()(), oomph::CommandLineArgs::output(), RefineableBin::output(), oomph::Mesh::output(), oomph::ClampedHermiteShellBoundaryConditionElement::output(), RefineableBin::output_bin_vertices(), ModalPoissonEquations< DIM >::output_fct(), oomph::Mesh::output_fct(), RefineableBinArray::output_neighbouring_bins(), output_vector(), oomph::TreeBasedRefineableMeshBase::p_adapt(), oomph::Problem::p_adapt(), oomph::TreeBasedRefineableMeshBase::p_adapt_mesh(), ModalPRefineableQElement< DIM >::p_refine(), oomph::Problem::p_refine_selected_elements(), oomph::Problem::p_refine_uniformly(), oomph::Problem::p_refine_uniformly_aux(), oomph::Problem::p_unrefine_uniformly(), parallel_test(), oomph::CommandLineArgs::parse_and_assign(), oomph::METIS::partition_mesh(), pause(), GlobalFct::plot_it(), oomph::StorableShapeElementBase::pre_compute_d2shape_eulerian_at_knots(), oomph::StorableShapeSolidElementBase::pre_compute_d2shape_lagrangian_at_knots(), oomph::StorableShapeElementBase::pre_compute_d2shape_local_at_knots(), oomph::BlockDiagonalPreconditioner< MATRIX >::preconditioner_solve(), oomph::HelmholtzMGPreconditioner< DIM >::preconditioner_solve(), oomph::PressureBasedSolidLSCPreconditioner::preconditioner_solve(), oomph::BandedBlockTriangularPreconditioner< MATRIX >::preconditioner_solve(), oomph::GMRESBlockPreconditioner::preconditioner_solve(), oomph::MGPreconditioner< DIM >::preconditioner_solve(), PRefineableDrivenCavityProblem< ELEMENT >::PRefineableDrivenCavityProblem(), print_elemental_jacobian(), BinArray::profile_get_neighbouring_bins_helper(), oomph::ProjectionProblem< PROJECTABLE_ELEMENT >::project(), oomph::PseudoBucklingRing::PseudoBucklingRing(), oomph::PRefineableQElement< 2, INITIAL_NNODE_1D >::quad_hang_helper(), oomph::QuarterTubeMesh< ELEMENT >::QuarterTubeMesh(), oomph::Problem::read(), PoissonProblem< ELEMENT >::read_custom_distribution_from_file(), oomph::VorticitySmoother< ELEMENT >::recover_vorticity(), oomph::TreeBasedRefineableMeshBase::refine_as_in_reference_mesh(), CollapsibleChannelProblem< ELEMENT >::refine_elements_based_on_x_coord(), oomph::Problem::refine_selected_elements(), oomph::Problem::refine_uniformly(), oomph::Problem::refine_uniformly_aux(), RefineableBinArray::RefineableBinArray(), oomph::RefineableFullCircleMesh< ELEMENT >::RefineableFullCircleMesh(), oomph::RefineableQuarterTubeMesh< ELEMENT >::RefineableQuarterTubeMesh(), RefineableRotatingCylinderProblem< ELEMENT >::RefineableRotatingCylinderProblem(), oomph::RefineableTubeMesh< ELEMENT >::RefineableTubeMesh(), RefineableUnsteadyHeatProblem< ELEMENT >::RefineableUnsteadyHeatProblem(), oomph::HSL_MA42::reorder_elements(), oomph::HyprePreconditioner::report_cumulative_solve_times(), oomph::DGFaceElement::report_info(), oomph::BrethertonSpineMesh< ELEMENT, SpineLineFluidInterfaceElement< ELEMENT > >::reposition_spines(), oomph::BrethertonSpineMesh< ELEMENT, INTERFACE_ELEMENT >::reposition_spines(), oomph::SuperLUSolver::resolve(), oomph::MumpsSolver::resolve(), oomph::TrilinosAztecOOSolver::resolve(), oomph::SuperLUSolver::resolve_transpose(), AxisymmetricVibratingShellProblem< ELEMENT >::restart(), VibratingShellProblem< ELEMENT >::restart(), RefineableUnsteadyHeatProblem< ELEMENT >::restart(), NavierStokesProblem< ELEMENT >::run_natural_continuation(), PoissonProblem< ELEMENT >::save_custom_distribution_to_file(), oomph::JacksHelloWorld::say_it_external(), oomph::JacksHelloWorld::say_it_inline(), oomph::VorticitySmootherElement< ELEMENT >::scalar_name_paraview(), oomph::MyProblem::segregated_pin_indices(), oomph::SegregatableFSIProblem::segregated_solve(), oomph::AlgebraicNode::self_test(), oomph::AlgebraicMesh::self_test(), oomph::BinaryTree::self_test(), oomph::BinaryTreeForest::self_test(), oomph::GeneralisedElement::self_test(), oomph::MGSolver< DIM >::self_test(), oomph::Mesh::self_test(), oomph::Data::self_test(), oomph::OcTree::self_test(), oomph::OcTreeForest::self_test(), oomph::Problem::self_test(), oomph::QuadTree::self_test(), oomph::QuadTreeForest::self_test(), oomph::Problem::set_explicit_time_stepper_pt(), RefineableUnsteadyHeatProblem< ELEMENT >::set_initial_condition(), FSIChannelWithLeafletProblem< ELEMENT >::set_iterative_solver(), oomph::SolidICProblem::set_newmark_initial_condition_consistently(), oomph::SolidICProblem::set_newmark_initial_condition_directly(), Global_Parameters::set_parameters(), GlobalFct::set_spurious_solution(), oomph::SolidICProblem::set_static_initial_condition(), oomph::TwoPlusThree< MATRIX >::setup(), oomph::TwoPlusThreeUpperTriangularWithTwoLevelSubsidiary< MATRIX >::setup(), BoussinesqPreconditioner::setup(), oomph::BiharmonicPreconditioner::setup(), oomph::BlockDiagonalPreconditioner< MATRIX >::setup(), oomph::BlockTriangularPreconditioner< MATRIX >::setup(), oomph::MGPreconditioner< DIM >::setup(), oomph::HyprePreconditioner::setup(), oomph::NewMumpsPreconditioner::setup(), oomph::SuperLUPreconditioner::setup(), oomph::FSIPreconditioner::setup(), oomph::NavierStokesSchurComplementPreconditioner::setup(), oomph::HelmholtzMGPreconditioner< DIM >::setup(), oomph::PressureBasedSolidLSCPreconditioner::setup(), oomph::ExactDGPBlockPreconditioner< MATRIX >::setup(), oomph::BandedBlockTriangularPreconditioner< MATRIX >::setup(), oomph::SpaceTimeNavierStokesSubsidiaryPreconditioner::setup(), oomph::GMRESBlockPreconditioner::setup(), oomph::MatrixVectorProduct::setup(), oomph::WomersleyImpedanceTubeBase< ELEMENT, DIM >::setup(), oomph::LineVisualiser::setup(), oomph::HelmholtzMGPreconditioner< DIM >::setup_coarsest_level_structures(), oomph::LineVisualiser::setup_from_file(), oomph::TR::setup_initial_derivative(), RefineableDrivenCavityProblem< ELEMENT >::setup_line_plot_points(), RectangularDrivenCavityProblem< ELEMENT >::setup_line_plot_points(), oomph::MGSolver< DIM >::setup_mg_hierarchy(), oomph::HelmholtzMGPreconditioner< DIM >::setup_mg_hierarchy(), oomph::MGSolver< DIM >::setup_mg_structures(), oomph::HelmholtzMGPreconditioner< DIM >::setup_mg_structures(), oomph::VorticitySmoother< ELEMENT >::setup_patches(), oomph::Z2ErrorEstimator::setup_patches(), oomph::SolidICProblem::setup_problem(), StefanBoltzmannProblem< ELEMENT >::setup_sb_radiation(), oomph::SegregatableFSIProblem::setup_segregated_solver(), SolarRadiationProblem< ELEMENT >::setup_shielding_nodes(), oomph::MGSolver< DIM >::setup_smoothers(), oomph::HelmholtzMGPreconditioner< DIM >::setup_smoothers(), oomph::OcTree::setup_static_data(), oomph::StefanBoltzmannHelper::setup_stefan_boltzmann_visibility(), oomph::MGSolver< DIM >::setup_transfer_matrices(), oomph::HelmholtzMGPreconditioner< DIM >::setup_transfer_matrices(), oomph::TrilinosMLPreconditioner::setup_trilinos_preconditioner(), oomph::PRefineableQElement< 1, INITIAL_NNODE_1D >::shape(), SheetGlueProblem< ELEMENT >::SheetGlueProblem(), oomph::SimpleCubicTetMesh< ELEMENT >::SimpleCubicTetMesh(), oomph::SiskoTanMilRegWithBlendingConstitutiveEquation< DIM >::SiskoTanMilRegWithBlendingConstitutiveEquation(), oomph::MyProblem::smart_time_step(), oomph::RefineableTetgenMesh< ELEMENT >::snap_nodes_onto_boundary(), oomph::TetMeshBase::snap_nodes_onto_geometric_objects(), oomph::MumpsSolver::solve(), oomph::HSL_MA42::solve(), oomph::MGSolver< DIM >::solve(), oomph::CG< MATRIX >::solve(), oomph::BiCGStab< MATRIX >::solve(), oomph::GS< MATRIX >::solve(), oomph::GS< CRDoubleMatrix >::solve(), oomph::DampedJacobi< MATRIX >::solve(), oomph::GMRES< MATRIX >::solve(), oomph::AugmentedProblemGMRES::solve(), oomph::DenseLU::solve(), oomph::FD_LU::solve(), oomph::SuperLUSolver::solve(), oomph::HelmholtzGMRESMG< MATRIX >::solve(), oomph::HelmholtzFGMRESMG< MATRIX >::solve(), oomph::HypreSolver::solve(), oomph::TrilinosAztecOOSolver::solve(), oomph::ARPACK::solve_eigenproblem(), oomph::ANASAZI::solve_eigenproblem(), oomph::CG< MATRIX >::solve_helper(), oomph::BiCGStab< MATRIX >::solve_helper(), oomph::GS< MATRIX >::solve_helper(), oomph::GS< CRDoubleMatrix >::solve_helper(), oomph::DampedJacobi< MATRIX >::solve_helper(), oomph::GMRES< MATRIX >::solve_helper(), oomph::AugmentedProblemGMRES::solve_helper(), oomph::HelmholtzGMRESMG< MATRIX >::solve_helper(), oomph::HelmholtzFGMRESMG< MATRIX >::solve_helper(), oomph::SuperLUSolver::solve_transpose(), oomph::TrilinosAztecOOSolver::solve_using_AztecOO(), solve_with_fully_automatic_adaptation(), solve_with_incremental_adaptation(), solve_with_selected_refinement_pattern(), oomph::TrilinosAztecOOSolver::solver_setup(), oomph::Problem::sparse_assemble_row_or_column_compressed_with_lists(), oomph::Problem::sparse_assemble_row_or_column_compressed_with_maps(), oomph::Problem::sparse_assemble_row_or_column_compressed_with_two_arrays(), oomph::Problem::sparse_assemble_row_or_column_compressed_with_two_vectors(), oomph::Problem::sparse_assemble_row_or_column_compressed_with_vectors_of_pairs(), oomph::TetMeshBase::split_elements_in_corners(), oomph::Problem::steady_newton_solve(), PseudoElasticCollapsibleChannelProblem< FLUID_ELEMENT, SOLID_ELEMENT >::steady_run(), oomph::SegregatableFSIProblem::steady_segregated_solve(), StefanBoltzmannProblem< ELEMENT >::StefanBoltzmannProblem(), HomogenisationProblem< ELEMENT >::sub_solve(), STSpineMesh< ELEMENT, INTERFACE_ELEMENT >::surface_output(), TetmeshPoissonProblem< ELEMENT >::TetmeshPoissonProblem(), TiltedCavityProblem< ELEMENT >::TiltedCavityProblem(), oomph::TubeMesh< ELEMENT >::TubeMesh(), oomph::MyProblem::undo_segregated_pinning(), oomph::Problem::unrefine_uniformly(), oomph::Problem::unsteady_newton_solve(), PseudoElasticCollapsibleChannelProblem< FLUID_ELEMENT, SOLID_ELEMENT >::unsteady_run(), CollapsibleChannelProblem< ELEMENT >::unsteady_run(), oomph::SegregatableFSIProblem::unsteady_segregated_solve(), FlowAroundCylinderProblem< ELEMENT >::unsteady_simulation(), UnsteadyHeatProblem< ELEMENT >::UnsteadyHeatProblem(), UnstructuredFSIProblem< FLUID_ELEMENT, SOLID_ELEMENT >::UnstructuredFSIProblem(), UnstructuredFvKProblem< ELEMENT >::UnstructuredFvKProblem(), UnstructuredPoissonProblem< ELEMENT >::UnstructuredPoissonProblem(), oomph::RefineableTetgenMesh< ELEMENT >::update_faceted_surface_using_face_mesh(), oomph::SolarRadiationBase::update_limiting_angles(), oomph::FpPressureAdvectionDiffusionProblem< ELEMENT >::validate(), VibratingShellProblem< ELEMENT >::VibratingShellProblem(), oomph::WomersleyProblem< ELEMENT, DIM >::WomersleyProblem(), and oomph::HyprePreconditioner::~HyprePreconditioner().
Nullstream oomph::oomph_nullstream |
Single (global) instantiation of the Nullstream.
///////////////////////////////////////////////////////////////////////// ///////////////////////////////////////////////////////////////////////// /////////////////////////////////////////////////////////////////////////
Referenced by PMLStructuredCubicHelmholtz< ELEMENT >::apply_boundary_conditions(), oomph::MGSolver< DIM >::disable_output(), oomph::HelmholtzMGPreconditioner< DIM >::disable_output(), main(), oomph::OomphInfo::operator<<(), oomph::BlockDiagonalPreconditioner< MATRIX >::setup(), oomph::BlockTriangularPreconditioner< MATRIX >::setup(), oomph::ExactDGPBlockPreconditioner< MATRIX >::setup(), oomph::BandedBlockTriangularPreconditioner< MATRIX >::setup(), oomph::SpaceTimeNavierStokesSubsidiaryPreconditioner::setup(), and oomph::GMRESBlockPreconditioner::setup().
|
protected |
Pointer to global Peclet number.
Referenced by oomph::RefineableGeneralisedAxisymAdvectionDiffusionEquations::further_build(), pe(), and pe_pt().
|
protected |
Pointer to global Peclet number multiplied by Strouhal number.
Referenced by oomph::RefineableGeneralisedAxisymAdvectionDiffusionEquations::further_build(), pe_st(), and pe_st_pt().
|
protected |
Pointer to source function:
Referenced by RefineableUnsteadyHeatProblem< ELEMENT >::build_mesh(), ExtrudedMovingCylinderProblem< TWO_D_ELEMENT, THREE_D_ELEMENT >::complete_element_setup(), PoissonProblem< ELEMENT >::complete_problem_setup(), RefineableModalPoissonEquations< DIM >::further_build(), oomph::RefineableGeneralisedAxisymAdvectionDiffusionEquations::further_build(), get_source_cons_axisym_adv_diff(), ModalPoissonEquations< DIM >::get_source_poisson(), ModalPoissonEquations< DIM >::source_fct_pt(), source_fct_pt(), and Wind_fct_pt().
|
protected |
Pointer to wind function:
Referenced by oomph::RefineableGeneralisedAxisymAdvectionDiffusionEquations::further_build(), get_wind_cons_axisym_adv_diff(), and wind_fct_pt().