- snesmf_reuse_baseTrueSpecifies whether or not to reuse the base vector for matrix-free calculation
Default:True
C++ Type:bool
Description:Specifies whether or not to reuse the base vector for matrix-free calculation
- line_search_packagepetscThe solver package to use to conduct the line-search
Default:petsc
C++ Type:MooseEnum
Description:The solver package to use to conduct the line-search
- time0System time
Default:0
C++ Type:double
Description:System time
- update_xfem_at_timestep_beginFalseShould XFEM update the mesh at the beginning of the timestep
Default:False
C++ Type:bool
Description:Should XFEM update the mesh at the beginning of the timestep
- contact_line_search_allowed_lambda_cuts2The number of times lambda is allowed to be cut in half in the contact line search. We recommend this number be roughly bounded by 0 <= allowed_lambda_cuts <= 3
Default:2
C++ Type:unsigned int
Description:The number of times lambda is allowed to be cut in half in the contact line search. We recommend this number be roughly bounded by 0 <= allowed_lambda_cuts <= 3
- petsc_optionsSingleton PETSc options
C++ Type:MultiMooseEnum
Description:Singleton PETSc options
- max_xfem_update4294967295Maximum number of times to update XFEM crack topology in a step due to evolving cracks
Default:4294967295
C++ Type:unsigned int
Description:Maximum number of times to update XFEM crack topology in a step due to evolving cracks
- splittingTop-level splitting defining a hierarchical decomposition into subsystems to help the solver.
C++ Type:std::vector
Description:Top-level splitting defining a hierarchical decomposition into subsystems to help the solver.
- line_searchdefaultSpecifies the line search type (Note: none = basic)
Default:default
C++ Type:MooseEnum
Description:Specifies the line search type (Note: none = basic)
- contact_line_search_ltolThe linear relative tolerance to be used while the contact state is changing between non-linear iterations. We recommend that this tolerance be looser than the standard linear tolerance
C++ Type:double
Description:The linear relative tolerance to be used while the contact state is changing between non-linear iterations. We recommend that this tolerance be looser than the standard linear tolerance
- petsc_options_valueValues of PETSc name/value pairs (must correspond with "petsc_options_iname"
C++ Type:std::vector
Description:Values of PETSc name/value pairs (must correspond with "petsc_options_iname"
- solve_typePJFNK: Preconditioned Jacobian-Free Newton Krylov JFNK: Jacobian-Free Newton Krylov NEWTON: Full Newton Solve FD: Use finite differences to compute Jacobian LINEAR: Solving a linear problem
C++ Type:MooseEnum
Description:PJFNK: Preconditioned Jacobian-Free Newton Krylov JFNK: Jacobian-Free Newton Krylov NEWTON: Full Newton Solve FD: Use finite differences to compute Jacobian LINEAR: Solving a linear problem
- mffd_typewpSpecifies the finite differencing type for Jacobian-free solve types. Note that the default is wp (for Walker and Pernice).
Default:wp
C++ Type:MooseEnum
Description:Specifies the finite differencing type for Jacobian-free solve types. Note that the default is wp (for Walker and Pernice).
- petsc_options_inameNames of PETSc name/value pairs
C++ Type:MultiMooseEnum
Description:Names of PETSc name/value pairs
<!– MOOSE Documentation Stub: Remove this when content is added. –>
Steady

The Steady has not been documented. The content contained on this page includes the typical automatic documentation associated with a MooseObject; however, what is contained is ultimately determined by what is necessary to make the documentation clear for users.
!syntax description /Executioner/Steady
Input Parameters
- l_abs_step_tol-1Linear Absolute Step Tolerance
Default:-1
C++ Type:double
Options:
Description:Linear Absolute Step Tolerance
- nl_abs_tol1e-50Nonlinear Absolute Tolerance
Default:1e-50
C++ Type:double
Options:
Description:Nonlinear Absolute Tolerance
- nl_max_its50Max Nonlinear Iterations
Default:50
C++ Type:unsigned int
Options:
Description:Max Nonlinear Iterations
- l_max_its10000Max Linear Iterations
Default:10000
C++ Type:unsigned int
Options:
Description:Max Linear Iterations
- compute_initial_residual_before_preset_bcsFalseUse the residual norm computed *before* PresetBCs are imposed in relative convergence check
Default:False
C++ Type:bool
Options:
Description:Use the residual norm computed *before* PresetBCs are imposed in relative convergence check
- nl_rel_tol1e-08Nonlinear Relative Tolerance
Default:1e-08
C++ Type:double
Options:
Description:Nonlinear Relative Tolerance
- l_tol1e-05Linear Tolerance
Default:1e-05
C++ Type:double
Options:
Description:Linear Tolerance
- nl_max_funcs10000Max Nonlinear solver function evaluations
Default:10000
C++ Type:unsigned int
Options:
Description:Max Nonlinear solver function evaluations
- nl_rel_step_tol1e-50Nonlinear Relative step Tolerance
Default:1e-50
C++ Type:double
Options:
Description:Nonlinear Relative step Tolerance
- nl_abs_step_tol1e-50Nonlinear Absolute step Tolerance
Default:1e-50
C++ Type:double
Options:
Description:Nonlinear Absolute step Tolerance
Solver Parameters
Restart Parameters
- picard_abs_tol1e-50The absolute nonlinear residual to shoot for during Picard iterations. This check is performed based on the Master app's nonlinear residual.
Default:1e-50
C++ Type:double
Options:
Description:The absolute nonlinear residual to shoot for during Picard iterations. This check is performed based on the Master app's nonlinear residual.
- picard_rel_tol1e-08The relative nonlinear residual drop to shoot for during Picard iterations. This check is performed based on the Master app's nonlinear residual.
Default:1e-08
C++ Type:double
Options:
Description:The relative nonlinear residual drop to shoot for during Picard iterations. This check is performed based on the Master app's nonlinear residual.
- picard_force_normsFalseForce the evaluation of both the TIMESTEP_BEGIN and TIMESTEP_END norms regardless of the existance of active MultiApps with those execute_on flags, default: false.
Default:False
C++ Type:bool
Options:
Description:Force the evaluation of both the TIMESTEP_BEGIN and TIMESTEP_END norms regardless of the existance of active MultiApps with those execute_on flags, default: false.
- relaxation_factor1Fraction of newly computed value to keep.Set between 0 and 2.
Default:1
C++ Type:double
Options:
Description:Fraction of newly computed value to keep.Set between 0 and 2.
- relaxed_variablesList of variables to relax during Picard Iteration
C++ Type:std::vector
Options:
Description:List of variables to relax during Picard Iteration
- picard_max_its1Maximum number of times each timestep will be solved. Mainly used when wanting to do Picard iterations with MultiApps that are set to execute_on timestep_end or timestep_begin. Setting this parameter to 1 turns off the Picard iterations.
Default:1
C++ Type:unsigned int
Options:
Description:Maximum number of times each timestep will be solved. Mainly used when wanting to do Picard iterations with MultiApps that are set to execute_on timestep_end or timestep_begin. Setting this parameter to 1 turns off the Picard iterations.
Picard Parameters
- no_fe_reinitFalseSpecifies whether or not to reinitialize FEs
Default:False
C++ Type:bool
Options:
Description:Specifies whether or not to reinitialize FEs
- control_tagsAdds user-defined labels for accessing object parameters via control logic.
C++ Type:std::vector
Options:
Description:Adds user-defined labels for accessing object parameters via control logic.
- enableTrueSet the enabled status of the MooseObject.
Default:True
C++ Type:bool
Options:
Description:Set the enabled status of the MooseObject.
Advanced Parameters
Input Files
- test/tests/vectorpostprocessors/line_value_sampler/csv_delimiter.i
- test/tests/materials/output/output_steady.i
- test/tests/mesh/mesh_generation/mesh_generation_test.i
- test/tests/mesh_modifiers/add_side_sets_from_bounding_box/overlapping_sidesets.i
- tutorials/darcy_thermo_mech/step04_velocity_aux/problems/step4.i
- test/tests/dirackernels/constant_point_source/constant_point_source_test.i
- test/tests/controls/tag_based_naming_access/system_asterisk_param.i
- test/tests/variables/fe_hermite/hermite-3-3d.i
- modules/heat_conduction/test/tests/heat_conduction/2d_quadrature_gap_heat_transfer/nonmatching.i
- test/tests/mesh/mesh_generation/disc_sector.i
- test/tests/misc/block_boundary_material_check/side_uo_check.i
- test/tests/outputs/append_date/append_date.i
- modules/heat_conduction/test/tests/heat_source_bar/ad_heat_source_bar.i
- test/tests/meshgenerators/mixed_dim/1d_3d.i
- test/tests/restart/restartable_types/restartable_types2.i
- test/tests/misc/check_error/function_file_test3.i
- test/tests/variables/fe_hier/hier-3-1d.i
- test/tests/outputs/dofmap/simple.i
- test/tests/kernels/forcing_function/forcing_function_neumannbc_test.i
- modules/stochastic_tools/test/tests/distributions/truncated_normal.i
- modules/richards/test/tests/gravity_head_2/gh01.i
- modules/combined/test/tests/heat_conduction_patch/heat_conduction_patch_rz_quad8_test.i
- test/tests/mesh_modifiers/add_side_sets_from_bounding_box/error_no_elements_in_bounding_box.i
- modules/stochastic_tools/test/tests/samplers/monte_carlo/monte_carlo_weibull.i
- test/tests/misc/check_error/bad_bc_var_test.i
- test/tests/materials/material/material_test_dg.i
- test/tests/interfacekernels/1d_interface/ik_save_in_test.i
- test/tests/misc/check_error/subdomain_restricted_kernel_mismatch.i
- test/tests/controls/syntax_based_naming_access/param.i
- modules/richards/test/tests/gravity_head_2/gh03.i
- modules/functional_expansion_tools/test/tests/errors/aux_bad_function.i
- test/tests/misc/check_error/missing_req_par_moose_obj_test.i
- test/tests/materials/boundary_material/bnd_coupling_vol.i
- tutorials/darcy_thermo_mech/step03_darcy_material/tests/kernels/darcy_pressure/darcy_pressure.i
- test/tests/kernels/jxw_grad_test_dep_on_displacements/jxw-cylindrical.i
- test/tests/meshgenerators/centroid_partitioner/centroid_partitioner_mg.i
- test/tests/vectorpostprocessors/nodal_value_sampler/nodal_value_sampler.i
- test/tests/auxkernels/normalization_aux/normalization_aux.i
- test/tests/misc/check_error/checked_pointer_param_test.i
- test/tests/postprocessors/volume/sphere1D.i
- test/tests/restrictable/undefined_ids/undefined_block_kernel.i
- test/tests/materials/material/coupled_material_test.i
- modules/combined/test/tests/linear_elasticity/linear_elastic_material.i
- test/tests/bcs/coupled_dirichlet_bc/coupled_dirichlet_bc.i
- test/tests/postprocessors/all_print_pps/all_print_pps_test.i
- test/tests/userobjects/element_quality_check/failure_error.i
- test/tests/userobjects/shape_element_user_object/shape_side_uo_jac_test.i
- test/tests/meshgenerators/subdomain_bounding_box_generator/oriented_subdomain_bounding_box_generator.i
- test/tests/dirackernels/point_caching/point_caching.i
- modules/porous_flow/test/tests/poroperm/PermFromPoro01.i
- modules/stochastic_tools/test/tests/multiapps/commandline_control/master_wrong_size.i
- test/tests/outputs/debug/show_top_residuals_debug.i
- test/tests/auxkernels/error_function_aux/error_function_aux.i
- modules/porous_flow/test/tests/capillary_pressure/brooks_corey2.i
- modules/richards/test/tests/darcy/jac.i
- test/tests/markers/error_fraction_marker/error_fraction_marker_no_clear_test.i
- test/tests/userobjects/element_quality_check/bypass_warning.i
- examples/ex19_dampers/ex19.i
- modules/richards/test/tests/gravity_head_1/gh04.i
- modules/combined/test/tests/gap_heat_transfer_mortar/ref-displaced.i
- python/chigger/tests/input/simple_diffusion_new_var.i
- modules/phase_field/test/tests/KKS_system/derivative_parsed_material.i
- test/tests/misc/check_error/kernel_with_aux_var.i
- test/tests/restart/restart_diffusion/restart_diffusion_test_steady.i
- test/tests/userobjects/solution_user_object/discontinuous_value_solution_uo_p1.i
- test/tests/mesh_modifiers/image_subdomain/image_2d.i
- test/tests/materials/material/qp_material.i
- test/tests/misc/jacobian/inf_nan.i
- modules/porous_flow/test/tests/newton_cooling/nc04.i
- test/tests/problems/no_kernel_coverage_check/no_coverage_check.i
- test/tests/functions/solution_function/solution_function_grad_p1.i
- python/peacock/tests/input_tab/InputFileEditor/gold/fsp_test.i
- test/tests/postprocessors/receiver_default/defaults.i
- modules/chemical_reactions/test/tests/jacobian/primary_convection.i
- test/tests/userobjects/side_user_object_no_boundary_error/side_no_boundary.i
- test/tests/outputs/postprocessor/show_hide.i
- modules/tensor_mechanics/test/tests/CylindricalRankTwoAux/test.i
- test/tests/meshgenerators/generate_sidesets_bounding_box/error_no_nodes_found.i
- test/tests/misc/check_error/function_file_test16.i
- test/tests/meshgenerators/sidesets_from_points_generator/sidesets_from_points.i
- test/tests/userobjects/geometry_snap/geometrysphere.i
- modules/richards/test/tests/gravity_head_1/gh03.i
- modules/porous_flow/test/tests/gravity/fully_saturated_grav01c.i
- test/tests/mesh_modifiers/add_extra_nodeset/extra_nodeset_coord_test.i
- modules/stochastic_tools/test/tests/distributions/boost_lognormal.i
- test/tests/misc/check_error/coupling_field_into_scalar.i
- modules/combined/test/tests/heat_conduction_patch/heat_conduction_patch_rz_test.i
- test/tests/mesh_modifiers/subdomain_bounding_box/oriented_subdomain_bounding_box_inside.i
- modules/stochastic_tools/test/tests/distributions/normal_direct.i
- test/tests/preconditioners/smp/smp_group_test.i
- test/tests/auxkernels/solution_aux/aux_nonlinear_solution_adapt.i
- modules/phase_field/test/tests/reconstruction/EulerAngleVariables2RGBAux.i
- modules/contact/test/tests/kernels/simple_diffusion/simple_diffusion.i
- modules/heat_conduction/test/tests/verify_against_analytical/ad_2d_steady_state_final_prob.i
- modules/navier_stokes/test/tests/ins/velocity_channel/velocity_inletBC_no_parts.i
- test/tests/misc/check_error/function_file_test13.i
- test/tests/auxkernels/solution_aux/aux_nonlinear_solution_xda.i
- test/tests/constraints/equal_value_embedded_constraint/embedded_constraint.i
- python/peacock/tests/common/bad_mesh.i
- test/tests/misc/check_error/coupling_itself.i
- test/tests/geomsearch/2d_penetration_locator/2d_penetration_locator_test.i
- test/tests/postprocessors/linear_combination/linear_combination.i
- test/tests/vectorpostprocessors/line_function_sampler/line_function_sampler.i
- test/tests/parser/active_inactive/active_inactive.i
- test/tests/kernels/2d_diffusion/parallel_diffusion_test.i
- modules/porous_flow/test/tests/gravity/grav01b.i
- modules/stochastic_tools/test/tests/distributions/uniform.i
- test/tests/vectorpostprocessors/intersection_points_along_line/1d.i
- test/tests/controls/tag_based_naming_access/object_param.i
- test/tests/postprocessors/postprocessor_comparison/postprocessor_comparison.i
- test/tests/materials/get_material_property_names/get_material_property_any_boundary_id.i
- test/tests/mesh_modifiers/add_side_sets/cylinder_normals.i
- modules/stochastic_tools/test/tests/multiapps/commandline_control/master_wrong_num_params.i
- test/tests/mesh_modifiers/assign_element_subdomain_id/tri_with_subdomainid_test.i
- test/tests/mesh/node_list_from_side_list/node_list_from_side_list.i
- test/tests/markers/q_point_marker/q_point_marker.i
- test/tests/materials/derivativematerialinterface/test.i
- test/tests/dgkernels/dg_displacement/dg_displacement.i
- test/tests/mesh/mesh_generation/annulus.i
- test/tests/transfers/multiapp_projection_transfer/high_order_sub.i
- test/tests/misc/check_error/kernel_with_empty_var.i
- test/tests/controls/dependency/test.i
- test/tests/misc/check_error/deprecated_block_test.i
- test/tests/misc/check_error/function_file_test17.i
- modules/phase_field/test/tests/flood_counter_aux_test/simple.i
- test/tests/ics/check_error/two_ics_on_same_block_global.i
- modules/combined/test/tests/nodal_area/nodal_area_2D.i
- test/tests/parser/parser/active_section_test.i
- test/tests/outputs/exodus/exodus.i
- test/tests/outputs/error/all_reserved.i
- test/tests/dirackernels/aux_scalar_variable/aux_scalar_variable.i
- test/tests/vectorpostprocessors/csv_reader/read.i
- test/tests/tag/2d_diffusion_vector_tag_test.i
- test/tests/kernels/anisotropic_diffusion/aniso_diffusion.i
- test/tests/misc/check_error/missing_function_test.i
- test/tests/userobjects/layered_average/layered_average_bounds.i
- modules/porous_flow/test/tests/thm_rehbinder/fixed_outer.i
- test/tests/misc/check_error/function_file_test7.i
- test/tests/misc/check_error/function_file_test11.i
- test/tests/variables/fe_monomial_const/monomial-const-2d.i
- test/tests/variables/fe_hier/hier-2-2d.i
- test/tests/fixedbugs/i8575/test.i
- test/tests/mesh_modifiers/boundingbox_nodeset/boundingbox_nodeset_inside_test.i
- test/tests/materials/material/bnd_material_test.i
- modules/richards/test/tests/jacobian_1/jn_fu_04.i
- test/tests/mesh_modifiers/mesh_extruder/extrude_remap_layer2.i
- test/tests/meshgenerators/sidesets_bounding_box_generator/error_no_side_sets_found.i
- modules/porous_flow/test/tests/newton_cooling/nc02.i
- test/tests/misc/jacobian/med.i
- test/tests/meshgenerators/generate_extra_nodeset/generate_extra_nodeset.i
- test/tests/functions/constant_function/constant_function_test.i
- test/tests/postprocessors/element_l2_norm/element_l2_norm.i
- modules/phase_field/test/tests/KKS_system/kks_phase_concentration.i
- test/tests/variables/fe_hermite_convergence/hermite_converge_dirichlet.i
- test/tests/misc/check_error/scalar_aux_kernel_with_var.i
- test/tests/meshgenerators/generate_sidesets_bounding_box/overlapping_sidesets_not_found.i
- modules/phase_field/test/tests/new_initial_conditions/PolycrystalVariables_initial_from_file.i
- test/tests/ics/depend_on_uo/geometric_neighbors_ic.i
- python/peacock/tests/input_tab/InputTreeWriter/gold/simple_diffusion.i
- test/tests/bcs/nodal_normals/cylinder_hexes_1st_2nd.i
- test/tests/postprocessors/num_vars/num_vars.i
- test/tests/dgkernels/3d_diffusion_dg/3d_diffusion_dg_test.i
- modules/misc/test/tests/kernels/thermo_diffusion/thermo_diffusion.i
- modules/fluid_properties/test/tests/interfaces/nan_interface/nan_interface.i
- test/tests/constraints/coupled_tied_value_constraint/coupled_tied_value_constraint.i
- test/tests/userobjects/layered_average/layered_average_interpolate.i
- modules/combined/test/tests/heat_convection/heat_convection_rz_test.i
- test/tests/meshgenerators/generate_sidesets_bounding_box/error_no_elements_in_bounding_box.i
- modules/porous_flow/test/tests/poroperm/PermFromPoro04.i
- modules/combined/test/tests/elasticitytensor/composite.i
- modules/phase_field/test/tests/free_energy_material/RegularSolutionFreeEnergy_const_T.i
- modules/stochastic_tools/test/tests/samplers/base/mpi.i
- test/tests/mesh/named_entities/name_on_the_fly.i
- modules/phase_field/test/tests/boundary_intersecting_features/boundary_intersecting_features.i
- modules/solid_mechanics/test/tests/crack_loop/crack_loop.i
- test/tests/constraints/nodal_constraint/nodal_constraint_displaced_test.i
- test/tests/misc/block_boundary_material_check/bc_check.i
- test/tests/functions/image_function/image_2d_elemental.i
- test/tests/markers/box_marker/box_marker_adapt_test.i
- test/tests/outputs/xda/xdr.i
- modules/porous_flow/test/tests/relperm/vangenuchten2.i
- modules/tensor_mechanics/examples/bridge/bridge.i
- modules/porous_flow/test/tests/actions/addjoiner_exception.i
- modules/chemical_reactions/test/tests/jacobian/coupled_convreact.i
- test/tests/userobjects/user_object/uo_restart_part2.i
- test/tests/transfers/multiapp_copy_transfer/third_monomial_to_sub/sub.i
- test/tests/geomsearch/1d_penetration_locator/1d_penetration_locator.i
- tutorials/darcy_thermo_mech/step03_darcy_material/tests/materials/packed_column/packed_column.i
- test/tests/dgkernels/jacobian_testing/coupled_dg_jac_test.i
- modules/richards/test/tests/jacobian_1/jn_fu_06.i
- test/tests/parser/param_substitution/param_substitution.i
- test/tests/meshgenerators/stitched_mesh_generator/stitched_mesh_generator2.i
- test/tests/vectorpostprocessors/elements_along_line/1d.i
- modules/tensor_mechanics/test/tests/isotropic_elasticity_tensor/youngs_modulus_poissons_ratio_test.i
- test/tests/mortar/3d/non-conforming-2nd-order.i
- modules/heat_conduction/test/tests/heat_conduction/2d_quadrature_gap_heat_transfer/perfect.i
- test/tests/misc/execute_on/execute_on_test.i
- test/tests/outputs/format/output_test_tecplot.i
- test/tests/vectorpostprocessors/point_value_sampler/point_value_sampler.i
- test/tests/auxkernels/solution_aux/solution_aux_scale.i
- test/tests/auxkernels/solution_aux/solution_aux.i
- test/tests/misc/check_error/assertion_test.i
- modules/fluid_properties/test/tests/ideal_gas/test.i
- test/tests/vectorpostprocessors/parallel_consistency/parallel_consistency.i
- test/tests/bcs/periodic/periodic_subdomain_restricted_test.i
- test/tests/postprocessors/variable_residual_norm/variable_residual.i
- modules/stochastic_tools/test/tests/distributions/boost_weibull.i
- modules/porous_flow/test/tests/gravity/grav01c_action.i
- test/tests/vectorpostprocessors/1d_line_sampler/1d_line_sampler.i
- test/tests/mesh_modifiers/smooth_mesh/mesh_smoother.i
- modules/richards/test/tests/jacobian_1/jn_fu_02.i
- test/tests/meshgenerators/rename_block_generator/rename_block1.i
- test/tests/meshgenerators/concentric_circle_mesh_generator/concentric_circle_mesh2.i
- examples/ex10_aux/ex10.i
- test/tests/tag/2d_diffusion_tag_vector.i
- test/tests/misc/check_error/aux_kernel_with_var.i
- modules/fluid_properties/test/tests/two_phase_fluid_properties_independent/test.i
- test/tests/kernels/ad_coupled_value/ad_aux_coupled_value.i
- test/tests/misc/check_error/coupling_scalar_into_field.i
- test/tests/ics/check_error/two_ics_on_same_boundary.i
- test/tests/misc/stop_for_debugger/stop_for_debugger.i
- test/tests/multiapps/initial_failure/sub.i
- test/tests/bcs/nodal_normals/cylinder_hexes_2nd.i
- test/tests/meshgenerators/generate_extra_nodeset/generate_extra_nodeset_coord.i
- test/tests/dgkernels/2d_diffusion_dg/2d_diffusion_dg_test.i
- test/tests/misc/check_error/override_name_variable_test.i
- test/tests/outputs/oversample/ex02_adapt.i
- test/tests/mesh/patterned_mesh/mesh_tester.i
- modules/phase_field/test/tests/MultiSmoothCircleIC/test_problem.i
- test/tests/kernels/diffusion_with_hanging_node/simple_diffusion.i
- test/tests/markers/block_restricted/marker_block.i
- modules/fluid_properties/test/tests/brine/brine_tabulated.i
- python/peacock/tests/common/simple_diffusion.i
- modules/stochastic_tools/test/tests/multiapps/commandline_control/sub.i
- python/peacock/tests/common/fsp_test.i
- test/tests/outputs/gmv/gmv.i
- test/tests/markers/box_marker/box_marker_test.i
- test/tests/parser/cli_argument/cli_arg_test.i
- test/tests/actions/get_actions/test_get_actions.i
- test/tests/preconditioners/pcside/diffusionCG.i
- modules/phase_field/test/tests/reconstruction/1phase_reconstruction.i
- test/tests/misc/check_error/constraint_with_aux_var.i
- test/tests/ics/random_ic_test/random_ic_test.i
- test/tests/kernels/coupled_kernel_grad/coupled_kernel_grad_test.i
- modules/phase_field/test/tests/MultiPhase/multibarrierfunction.i
- test/tests/misc/check_error/uo_pps_name_collision_test.i
- modules/porous_flow/test/tests/capillary_pressure/vangenuchten2.i
- modules/phase_field/test/tests/KKS_system/bug.i
- test/tests/indicators/depend_material/depend_material.i
- modules/heat_conduction/test/tests/heat_conduction/2d_quadrature_gap_heat_transfer/gap_conductivity_property.i
- modules/phase_field/test/tests/initial_conditions/MultiBoundingBoxIC1D.i
- test/tests/misc/check_error/multi_precond_test.i
- modules/tensor_mechanics/test/tests/stress_recovery/stress_concentration/stress_concentration.i
- test/tests/mesh/mixed_dim/1d_2d_w_matl.i
- modules/combined/test/tests/heat_conduction_ortho/heat_conduction_ortho.i
- test/tests/restart/pointer_restart_errors/pointer_load_error.i
- test/tests/auxkernels/linear_combination/test.i
- tutorials/darcy_thermo_mech/step04_velocity_aux/tests/auxkernels/velocity_aux/velocity_aux.i
- test/tests/outputs/perf_graph/perf_graph.i
- test/tests/postprocessors/side_integral/side_integral_test.i
- test/tests/postprocessors/vector_postprocessor_comparison/vector_postprocessor_comparison.i
- modules/phase_field/test/tests/mesh/mortarperiodic.i
- modules/tensor_mechanics/test/tests/interface_stress/multi.i
- test/tests/preconditioners/multi_cycle_hypre/multi_cycle_hypre.i
- test/tests/materials/material/adv_mat_couple_test2.i
- test/tests/mesh/stitched_mesh/stitched_mesh.i
- test/tests/auxkernels/aux_nodal_scalar_kernel/aux_nodal_scalar_kernel.i
- test/tests/indicators/laplacian_jump_indicator/biharmonic.i
- test/tests/utils/spline_interpolation/bicubic_spline_interpolation_x_normal.i
- test/tests/misc/check_error/function_file_test8.i
- test/tests/mesh_modifiers/rename_block/rename2.i
- test/tests/materials/material_dependency/diff_kernel_aux_mat_dep.i
- modules/phase_field/test/tests/initial_conditions/MultiBoundingBoxIC3D.i
- test/tests/markers/expected_error/displaced_error.i
- test/tests/postprocessors/difference_pps/difference_pps.i
- test/tests/variables/mixed_order_variables/mixed_order_variables_test.i
- test/tests/transfers/from_full_solve/master.i
- test/tests/outputs/misc/default_names.i
- test/tests/bcs/second_deriv/test_lap_bc.i
- test/tests/actions/debug_block/debug_print_actions_test.i
- modules/stochastic_tools/test/tests/distributions/logistic.i
- test/tests/misc/check_error/coupling_nonexistent_field.i
- modules/misc/test/tests/kernels/diffusion/ad_2d_steady_state_final_prob.i
- modules/porous_flow/test/tests/relperm/corey3.i
- modules/chemical_reactions/test/tests/jacobian/coupled_convreact2.i
- modules/porous_flow/test/tests/thermal_conductivity/ThermalCondPorosity01.i
- test/tests/auxkernels/element_length/element_length.i
- test/tests/parser/parser_dependency/parse_depend_mixed_test.i
- examples/ex05_amr/ex05.i
- modules/richards/test/tests/jacobian_1/jn_fu_08.i
- test/tests/outputs/console/console_warning.i
- modules/heat_conduction/test/tests/heat_conduction/3d_quadrature_gap_heat_transfer/second.i
- modules/stochastic_tools/test/tests/samplers/monte_carlo/monte_carlo_uniform.i
- test/tests/meshgenerators/adapt/initial_adaptivity_mg_test.i
- modules/porous_flow/test/tests/flux_limited_TVD_pflow/except03.i
- test/tests/markers/uniform_marker/uniform_marker.i
- test/tests/vectorpostprocessors/elements_along_plane/3d.i
- test/tests/meshgenerators/image_subdomain_generator/image_subdomain_3d.i
- test/tests/vectorpostprocessors/elements_along_plane/1d.i
- test/tests/geomsearch/2d_interior_boundary_penetration_locator/2d_interior_boundary_penetration_locator.i
- test/tests/materials/discrete/recompute_warning.i
- test/tests/vectorpostprocessors/late_declaration_vector_postprocessor/late_declaration_vector_postprocessor.i
- test/tests/materials/discrete/recompute2.i
- modules/porous_flow/test/tests/flux_limited_TVD_pflow/except01.i
- test/tests/problems/custom_fe_problem/custom_fe_problem_test.i
- test/tests/bcs/penalty_dirichlet_bc/penalty_dirichlet_bc_test.i
- test/tests/misc/save_in/save_in_soln_var_err_test.i
- test/tests/mesh_modifiers/add_side_sets_from_bounding_box/multiple_boundary_ids.i
- test/tests/meshgenerators/mesh_extruder_generator/extrude_quad.i
- test/tests/meshgenerators/patterned_mesh_generator/patterned_mesh_generator.i
- test/tests/markers/value_range_marker/value_range_marker_test.i
- test/tests/transfers/multiapp_copy_transfer/second_lagrange_to_sub/sub.i
- test/tests/preconditioners/pbp/pbp_adapt_test.i
- test/tests/bcs/nodal_normals/circle_quads.i
- test/tests/misc/check_error/bad_number.i
- test/tests/tag/tag_ad_kernels.i
- test/tests/misc/check_error/function_file_test2.i
- test/tests/vectorpostprocessors/material_vector_postprocessor/boundary-err.i
- test/tests/preconditioners/smp/smp_single_adapt_test.i
- modules/navier_stokes/test/tests/scalar_adr/supg/2d_advection_error_testing.i
- modules/porous_flow/test/tests/capillary_pressure/vangenuchten3.i
- modules/tensor_mechanics/test/tests/dynamics/linear_constraint/disp_mid.i
- test/tests/outputs/console/console.i
- modules/richards/test/tests/jacobian_1/jn05.i
- test/tests/auxkernels/grad_component/grad_component.i
- modules/solid_mechanics/test/tests/solid_mech_cube/solid_mech_cube_test.i
- test/tests/constraints/tied_value_constraint/tied_value_constraint_test.i
- test/tests/dirackernels/point_caching/point_caching_uniform_refinement.i
- test/tests/markers/value_threshold_marker/value_threshold_marker_test.i
- modules/combined/test/tests/gap_heat_transfer_mortar/gap_heat_transfer_mortar.i
- test/tests/kernels/tag_errors/no_tags/no_tags.i
- test/tests/misc/check_error/bad_kernel_var_test.i
- test/tests/misc/deprecation/deprecation.i
- test/tests/postprocessors/point_value/point_value_error.i
- test/tests/auxkernels/solution_aux/solution_aux_exodus_elem_map.i
- modules/combined/test/tests/heat_conduction_patch/heat_conduction_patch_hex20_test.i
- test/tests/mesh/adapt/initial_adaptivity_test.i
- test/tests/meshgenerators/generate_subdomain_id/generate_subdomain_id.i
- test/tests/bcs/1d_neumann/1d_neumann.i
- test/tests/misc/test_harness_tester/2d_diffusion_test.i
- modules/porous_flow/test/tests/relperm/corey1.i
- test/tests/quadrature/gauss_lobatto/gauss_lobatto.i
- test/tests/mesh_modifiers/add_side_sets/cylinder_points.i
- test/tests/kernels/scalar_constraint/scalar_constraint_kernel_disp.i
- test/tests/functions/image_function/moose_logo_test_2D.i
- test/tests/ics/boundary_ic/boundary_ic.i
- test/tests/postprocessors/nodal_sum/nodal_sum.i
- modules/richards/test/tests/jacobian_1/jn04.i
- modules/porous_flow/test/tests/flux_limited_TVD_pflow/except05.i
- test/tests/variables/fe_hier/hier-3-3d.i
- modules/porous_flow/test/tests/fluids/ideal_gas.i
- modules/fluid_properties/test/tests/methane/methane.i
- test/tests/auxkernels/vectorpostprocessor/vectorpostprocessor.i
- test/tests/indicators/analytical_indicator/analytical_indicator_test.i
- test/tests/mesh/distributed_generated_mesh/distributed_generated_mesh.i
- modules/richards/test/tests/jacobian_1/jn03.i
- test/tests/misc/check_error/scalar_dot_integrity_check.i
- test/tests/auxkernels/nodal_aux_var/multi_update_var_test.i
- examples/ex15_actions/ex15.i
- test/tests/kernels/coupled_kernel_value/coupled_kernel_value_test.i
- test/tests/postprocessors/mms_slope/mms_slope_test.i
- test/tests/preconditioners/pbp/pbp_test_options.i
- test/tests/meshgenerators/sidesets_bounding_box_generator/error_no_nodes_found.i
- modules/porous_flow/test/tests/fluids/h2o.i
- test/tests/mesh/nemesis/nemesis_repartitioning_test.i
- modules/heat_conduction/test/tests/heat_conduction/coupled_convective_heat_flux/coupled_convective_heat_flux.i
- test/tests/meshgenerators/generate_sidesets_bounding_box/error_no_side_sets_found.i
- test/tests/meshgenerators/transform_generator/rotate_and_scale.i
- test/tests/outputs/oversample/oversample.i
- test/tests/vectorpostprocessors/side_value_sampler/side_value_sampler.i
- test/tests/vectorpostprocessors/csv_reader/transfer/master.i
- test/tests/auxkernels/nearest_node_value/nearest_node_value.i
- test/tests/mesh/centroid_partitioner/centroid_partitioner_test.i
- test/tests/outputs/nemesis/nemesis.i
- test/tests/meshgenerators/generate_bounding_box_nodeset/boundingbox_nodeset_inside.i
- modules/phase_field/test/tests/initial_conditions/ClosePackIC_3D.i
- modules/fluid_properties/test/tests/brine/brine.i
- test/tests/mesh/periodic_node_map/test.i
- test/tests/ics/hermite_ic/hermite_ic.i
- test/tests/mesh/gmsh_bcs/gmsh_bc_test.i
- test/tests/materials/derivativematerialinterface/const.i
- test/tests/transfers/multiapp_copy_transfer/constant_monomial_to_sub/sub.i
- modules/porous_flow/examples/flow_through_fractured_media/fine_thick_fracture_steady.i
- modules/xfem/test/tests/single_var_constraint_2d/equal_value.i
- test/tests/mesh/custom_partitioner/custom_linear_partitioner_test.i
- modules/tensor_mechanics/test/tests/ad_elastic/green-lagrange.i
- test/tests/mesh/subdomain_partitioner/subdomain_partitioner.i
- test/tests/meshgenerators/mesh_extruder_generator/extrude_angle.i
- modules/richards/test/tests/jacobian_1/jn02.i
- test/tests/misc/check_error/missing_var_in_kernel_test.i
- examples/ex07_ics/steady.i
- test/tests/mesh_modifiers/add_side_sets/cylinder_normals_fixed.i
- modules/level_set/test/tests/kernels/advection/advection_mms.i
- test/tests/variables/multiblock_restricted_var/multiblock_restricted_var_test.i
- modules/porous_flow/test/tests/relperm/unity.i
- test/tests/misc/block_user_object_check/coupled_check.i
- test/tests/mesh_modifiers/add_side_sets_from_bounding_box/error_boundary_number.i
- test/tests/bcs/function_dirichlet_bc/function_dirichlet_bc_test.i
- test/tests/restart/restart_diffusion/exodus_refined_restart_1_test.i
- examples/ex13_functions/ex13.i
- python/peacock/tests/common/simple_diffusion2.i
- modules/combined/test/tests/eigenstrain/inclusion.i
- test/tests/postprocessors/element_integral/element_integral_test.i
- test/tests/meshgenerators/generate_element_subdomain_id/quad_with_subdomainid.i
- test/tests/outputs/format/output_test_tecplot_binary.i
- test/tests/userobjects/layered_side_integral/layered_side_average.i
- test/tests/misc/check_error/bad_kernel_action.i
- test/tests/mesh/mesh_generation/disc.i
- test/tests/misc/check_error/subdomain_restricted_auxkernel_mismatch.i
- test/tests/bcs/ad_bcs/vector_ad_bc.i
- tutorials/darcy_thermo_mech/step01_diffusion/tests/bcs/diffusion/diffusion.i
- modules/porous_flow/test/tests/relperm/brooks_corey2.i
- test/tests/kernels/ad_simple_diffusion/ad_simple_diffusion.i
- test/tests/mesh/distributed_generated_mesh_bias/distributed_generated_mesh_bias.i
- test/tests/kernels/adv_diff_reaction/adv_diff_reaction_test.i
- test/tests/misc/check_error/function_file_test5.i
- test/tests/outputs/output_interface/indicator.i
- modules/richards/test/tests/jacobian_1/jn06.i
- test/tests/outputs/tecplot/tecplot_binary.i
- test/tests/mesh_modifiers/add_side_sets_from_bounding_box/error_no_side_sets_found.i
- test/tests/kernels/material_derivatives/material_derivatives_test.i
- test/tests/auxkernels/element_aux_var/element_high_order_aux_test.i
- modules/combined/test/tests/linear_elasticity/tensor.i
- modules/tensor_mechanics/test/tests/action/two_coord.i
- test/tests/preconditioners/pbp/pbp_test.i
- test/tests/functions/function_ic/function_ic_test.i
- test/tests/problems/action_custom_fe_problem/action_custom_fe_problem_test.i
- test/tests/misc/save_in/diag_save_in_soln_var_err_test.i
- test/tests/kernels/vector_fe/lagrange_vec_1d.i
- modules/stochastic_tools/test/tests/distributions/normal.i
- test/tests/misc/check_error/steady_no_converge.i
- test/tests/mesh_modifiers/rename_block/rename1.i
- modules/combined/test/tests/multiphase_mechanics/twophasestress.i
- test/tests/outputs/postprocessor/postprocessor_console.i
- test/tests/problems/no_material_coverage_check/no_material_coverage_check.i
- test/tests/outputs/exodus/exodus_input.i
- test/tests/mesh/nemesis/nemesis_test.i
- test/tests/auxkernels/solution_aux/aux_nonlinear_solution.i
- test/tests/outputs/console/console_no_outputs_block.i
- examples/ex02_kernel/ex02_oversample.i
- test/tests/materials/has_material/has_boundary_prop.i
- test/tests/misc/check_error/missing_material_prop_test2.i
- test/tests/transfers/multiapp_copy_transfer/linear_lagrange_to_sub/sub.i
- examples/ex14_pps/ex14_compare_solutions_2.i
- test/tests/ics/check_error/two_ics_on_same_block.i
- test/tests/markers/marker/standard_marker_test.i
- test/tests/variables/previous_newton_iteration/test.i
- modules/fluid_properties/test/tests/auxkernels/stagnation_temperature_aux.i
- modules/navier_stokes/test/tests/ins/pressure_channel/open_bc_pressure_BC_fieldSplit.i
- test/tests/auxkernels/nodal_aux_var/multi_update_elem_var_test.i
- test/tests/dirackernels/point_caching/point_caching_adaptive_refinement.i
- test/tests/auxkernels/diffusion_flux/diffusion_flux.i
- modules/functional_expansion_tools/test/tests/errors/missing_series_duo_axis.i
- test/tests/kernels/vector_fe/lagrange_vec.i
- test/tests/outputs/debug/show_top_residuals_nonlinear_only.i
- test/tests/geomsearch/2d_penetration_locator/2d_triangle.i
- modules/tensor_mechanics/tutorials/basics/part_1.1.i
- modules/porous_flow/test/tests/poroperm/PermFromPoro02.i
- examples/ex17_dirac/ex17.i
- test/tests/dgkernels/2d_diffusion_dg/dg_stateful.i
- python/peacock/tests/input_tab/InputTree/gold/simple_diffusion_vp.i
- test/tests/meshgenerators/sidesets_bounding_box_generator/overlapping_sidesets_not_found.i
- modules/richards/test/tests/gravity_head_1/gh02.i
- test/tests/misc/check_error/dot_integrity_check.i
- modules/porous_flow/test/tests/flux_limited_TVD_pflow/except04.i
- modules/combined/test/tests/heat_convection/heat_convection_rz_tf_test.i
- test/tests/indicators/gradient_jump_indicator/gradient_jump_indicator_test.i
- modules/navier_stokes/test/tests/ins/velocity_channel/velocity_inletBC_by_parts.i
- test/tests/misc/check_error/interface_kernel_with_aux_var.i
- test/tests/userobjects/internal_side_user_object/internal_side_user_object_two_materials.i
- test/tests/multiapps/command_line/master_wrong_size.i
- test/tests/materials/var_coupling/var_stateful_coupling.i
- test/tests/auxkernels/solution_aux/output_error.i
- test/tests/interfacekernels/1d_interface/coupled_value_coupled_flux.i
- test/tests/meshgenerators/sidesets_bounding_box_generator/multiple_boundary_ids_3d.i
- test/tests/functions/solution_function/solution_function_grad_p2.i
- test/tests/mesh/high_order_elems/high_order_elems.i
- modules/combined/test/tests/nodal_area/nodal_area_3D.i
- test/tests/problems/eigen_problem/ne_coupled_picard_sub.i
- test/tests/utils/mffd/mffd_test.i
- modules/combined/test/tests/heat_convection/heat_convection_3d_test.i
- test/tests/meshgenerators/rename_block_generator/rename_block2.i
- test/tests/variables/high_order_monomial/high_order_monomial.i
- test/tests/mesh_modifiers/assign_element_subdomain_id/quad_with_elementid_subdomainid_test.i
- modules/navier_stokes/test/tests/ins/lid_driven/lid_driven_stabilized.i
- modules/level_set/test/tests/transfers/copy_solution/sub.i
- test/tests/misc/save_in/dg_save_in_test.i
- test/tests/misc/block_boundary_material_check/dgkernel_check_boundary.i
- modules/porous_flow/test/tests/gravity/fully_saturated_grav01a.i
- test/tests/functions/parsed/steady.i
- modules/heat_conduction/test/tests/heat_conduction/3d_quadrature_gap_heat_transfer/nonmatching.i
- test/tests/userobjects/nearest_point_layered_average/nearest_point_layered_average.i
- test/tests/dirackernels/material_point_source/material_point_source.i
- test/tests/misc/check_error/nan_test.i
- modules/heat_conduction/test/tests/verify_against_analytical/2d_steady_state_final_prob.i
- modules/richards/test/tests/jacobian_1/jn08.i
- test/tests/postprocessors/element_l2_error_pps/element_l2_error_pp_test.i
- test/tests/preconditioners/fsp/fsp_test.i
- test/tests/outputs/format/output_test_nemesis.i
- test/tests/auxkernels/bounds/bounds_test.i
- test/tests/outputs/csv/csv_sort.i
- modules/tensor_mechanics/test/tests/action/two_block_new.i
- modules/heat_conduction/test/tests/heat_conduction/2d_quadrature_gap_heat_transfer/perfectQ9.i
- test/tests/misc/check_error/dirac_kernel_with_aux_var.i
- modules/fluid_properties/test/tests/water/water.i
- test/tests/geomsearch/quadrature_penetration_locator/quadrature_penetration_locator.i
- test/tests/postprocessors/side_average_value/side_average_value_test.i
- modules/richards/test/tests/gravity_head_2/gh04.i
- stork/test/tests/kernels/simple_diffusion/simple_diffusion.i
- python/peacock/tests/input_tab/InputTree/gold/fsp_test.i
- test/tests/vectorpostprocessors/elements_along_line/3d.i
- modules/richards/test/tests/pressure_pulse/pp_fu_01.i
- modules/richards/test/tests/pressure_pulse/pp_fu_21.i
- modules/functional_expansion_tools/test/tests/standard_use/neglect_invalid_enum.i
- test/tests/meshgenerators/generate_element_subdomain_id/tri_with_subdomainid.i
- modules/phase_field/test/tests/feature_flood_test/parallel_feature_count.i
- test/tests/mesh_modifiers/add_side_sets_from_bounding_box/multiple_boundary_ids_3d.i
- modules/porous_flow/test/tests/newton_cooling/nc06.i
- test/tests/dgkernels/adaptivity/adaptivity.i
- test/tests/misc/check_error/multiple_bad_ic_test.i
- test/tests/utils/spline_interpolation/bicubic_spline_interpolation.i
- test/tests/outputs/oversample/oversample_file.i
- test/tests/geomsearch/3d_penetration_locator/3d_penetration_locator_test.i
- test/tests/auxkernels/nodal_aux_var/nodal_sort_test.i
- test/tests/misc/check_error/check_dynamic_name_block.i
- test/tests/ics/function_ic/parsed_function.i
- test/tests/misc/check_error/kernel_with_vector_var.i
- modules/richards/test/tests/gravity_head_2/gh02.i
- test/tests/postprocessors/side_pps/side_pps_multi_bnd_test.i
- test/tests/outputs/nemesis/nemesis_elemental.i
- test/tests/vectorpostprocessors/work_balance/work_balance.i
- test/tests/postprocessors/area_pp/area_pp.i
- modules/heat_conduction/test/tests/heat_conduction/coupled_convective_heat_flux/coupled_convective_heat_flux_two_phase.i
- test/tests/mesh_modifiers/boundingbox_nodeset/boundingbox_nodeset_outside_test.i
- test/tests/auxkernels/element_quality_aux/element_quality_aux.i
- test/tests/auxkernels/gap_value/gap_value_subdomain_restricted.i
- test/tests/meshgenerators/high_order_elements/high_order_elems.i
- test/tests/misc/block_user_object_check/block_check.i
- test/tests/executioners/executioner/steady-adapt.i
- test/tests/dampers/max_increment/max_increment_damper_test.i
- test/tests/meshgenerators/generate_bounding_box_nodeset/boundingbox_nodeset_outside.i
- test/tests/variables/fe_hier/hier-1-2d.i
- test/tests/multiapps/command_line/master.i
- test/tests/misc/check_error/bad_kernel_test.i
- modules/functional_expansion_tools/test/tests/errors/missing_series_x.i
- test/tests/parser/parse_double_index/parse_double_index.i
- test/tests/kernels/ad_coupled_convection/ad_coupled_convection.i
- test/tests/misc/check_error/multi_master.i
- test/tests/coord_type/coord_type_rz.i
- test/tests/ics/zero_ic/test.i
- modules/misc/test/tests/kernels/diffusion/2d_steady_state_final_prob.i
- test/tests/outputs/common/console.i
- test/tests/misc/check_error/function_file_test15.i
- test/tests/restart/restart/nodal_var_restart.i
- test/tests/materials/get_material_property_names/get_material_property_block_names.i
- modules/combined/examples/effective_properties/effective_th_cond.i
- test/tests/misc/serialized_solution/serialized_solution.i
- test/tests/restrictable/internal_side_user_object/internal_side_user_object.i
- test/tests/restart/restart/elem_part2.i
- test/tests/functions/solution_function/solution_function_exodus_interp_test.i
- test/tests/misc/check_error/double_restrict_uo.i
- test/tests/functions/solution_function/solution_function_exodus_test.i
- test/tests/misc/check_error/range_check_param.i
- modules/navier_stokes/test/tests/scalar_adr/supg/tauOpt.i
- test/tests/meshgenerators/gmsh_bcs/gmsh_bcs.i
- test/tests/misc/check_error/old_integrity_check.i
- test/tests/meshgenerators/mesh_extruder_generator/gen_extrude.i
- modules/tensor_mechanics/test/tests/gravity/gravity_test.i
- modules/chemical_reactions/test/tests/equilibrium_const/constant.i
- test/tests/misc/check_error/function_conflict.i
- test/tests/misc/check_error/invalid_aux_coupling_test.i
- test/tests/kernels/kernel_precompute/adkernel_precompute_test.i
- modules/combined/test/tests/concentration_dependent_elasticity_tensor/concentration_dependent_elasticity_tensor.i
- test/tests/coord_type/coord_type_rz_integrated.i
- modules/navier_stokes/test/tests/ins/pressure_channel/open_bc_pressure_BC.i
- test/tests/materials/parsed/material_chaining.i
- test/tests/meshgenerators/generate_sidesets_bounding_box/generate_sidesets_bounding_box.i
- modules/stochastic_tools/test/tests/distributions/boost_normal.i
- test/tests/misc/check_error/wrong_moose_object_test.i
- modules/functional_expansion_tools/test/tests/errors/missing_series_duo_disc.i
- test/tests/mesh/named_entities/named_entities_test.i
- test/tests/misc/max_var_n_dofs_per_elem/max_var_n_dofs_per_elem.i
- test/tests/kernels/scalar_constraint/scalar_constraint_kernel.i
- modules/navier_stokes/test/tests/scalar_adr/supg/advection_error_testing.i
- test/tests/mesh_modifiers/image_subdomain/image_3d.i
- test/tests/outputs/format/output_test_gmv.i
- modules/porous_flow/test/tests/poroperm/PermTensorFromVar02.i
- test/tests/executioners/full_jacobian_thread_active_bcs/full_jacobian_thread_active_bcs.i
- test/tests/misc/block_boundary_material_check/dgkernel_check_block.i
- modules/heat_conduction/test/tests/heat_conduction/2d_quadrature_gap_heat_transfer/second_order.i
- test/tests/misc/test_harness_tester/2d_diffusion_test2.i
- test/tests/misc/check_error/ic_bnd_for_non_nodal.i
- test/tests/controls/restrict_exec_flag/exec_flag_error.i
- modules/porous_flow/test/tests/gravity/fully_saturated_grav01b.i
- modules/richards/test/tests/gravity_head_1/gh_fu_01.i
- test/tests/restart/pointer_restart_errors/pointer_load_error2.i
- test/tests/auxkernels/solution_aux/aux_nonlinear_solution_adapt_xda.i
- test/tests/postprocessors/element_vec_l2_error_pps/element_vec_l2_error.i
- test/tests/auxkernels/element_aux_var/elemental_sort_test.i
- test/tests/outputs/format/pps_screen_out_warn.i
- test/tests/variables/fe_monomial_const/monomial-const-3d.i
- test/tests/misc/check_error/bad_bc_test.i
- test/tests/quadrature/order/order5.i
- python/chigger/tests/simple/simple_diffusion.i
- modules/functional_expansion_tools/test/tests/errors/bc_flux_bad_function.i
- test/tests/userobjects/solution_user_object/discontinuous_value_solution_uo_p2.i
- modules/richards/test/tests/pressure_pulse/pp01.i
- test/tests/multiapps/picard/steady_picard_sub.i
- modules/richards/test/tests/gravity_head_2/gh_fu_02.i
- test/tests/ics/constant_ic/subdomain_constant_ic_test.i
- modules/richards/test/tests/gravity_head_1/gh08.i
- modules/richards/test/tests/pressure_pulse/pp21.i
- test/tests/misc/check_error/missing_function_file_test.i
- test/tests/meshgenerators/checkpoint/checkpoint_split.i
- test/tests/interfacekernels/1d_interface/single_variable_coupled_flux.i
- tutorials/darcy_thermo_mech/step05_heat_conduction/problems/step5a_steady.i
- modules/porous_flow/test/tests/gravity/grav01c.i
- test/tests/auxkernels/gap_value/gap_value.i
- test/tests/vectorpostprocessors/element_value_sampler/element_value_sampler.i
- test/tests/materials/get_material_property_names/get_material_property_any_block_id.i
- test/tests/mesh_modifiers/assign_subdomain_id/assign_subdomain_id.i
- test/tests/misc/check_error/coupling_nonexistent_scalar.i
- modules/porous_flow/test/tests/gravity/grav01a.i
- test/tests/misc/check_error/bad_second_order_test.i
- modules/combined/test/tests/heat_conduction_patch/heat_conduction_patch_hex20_aniso.i
- test/tests/materials/material/mat_cyclic_coupling.i
- test/tests/controls/time_periods/aux_kernels/enable_disable.i
- test/tests/misc/check_error/missing_mesh_test.i
- modules/phase_field/test/tests/grain_tracker_test/grain_tracker_volume.i
- modules/richards/test/tests/gravity_head_1/gh06.i
- test/tests/userobjects/layered_integral/layered_integral_test.i
- test/tests/outputs/postprocessor/output_pps_hidden_shown_check.i
- test/tests/misc/check_error/check_dynamic_name_boundary.i
- test/tests/materials/ad_material/ad_material.i
- test/tests/restrictable/api_test/block_restrictable.i
- test/tests/postprocessors/element_integral/element_block_integral_test.i
- test/tests/markers/combo_marker/combo_marker_test.i
- test/tests/functions/parsed/function.i
- modules/porous_flow/test/tests/density/GravDensity01.i
- test/tests/vectorpostprocessors/material_vector_postprocessor/block-restrict-err.i
- test/tests/mesh/mixed_dim/1d_2d.i
- modules/richards/test/tests/gravity_head_1/gh_fu_03.i
- test/tests/misc/should_execute/should_execute.i
- test/tests/bcs/nodal_normals/circle_tris.i
- test/tests/problems/mixed_coord/mixed_coord_test.i
- modules/richards/test/tests/jacobian_1/jn_fu_01.i
- test/tests/parser/parser_dependency/parse_depend_pbp_test.i
- tutorials/darcy_thermo_mech/step03_darcy_material/problems/step3.i
- test/tests/userobjects/layered_side_integral/layered_side_flux_average.i
- test/tests/outputs/position/position.i
- test/tests/vectorpostprocessors/least_squares_fit/least_squares_fit.i
- modules/richards/test/tests/jacobian_1/jn_fu_05.i
- modules/fluid_properties/test/tests/auxkernels/stagnation_pressure_aux.i
- test/tests/materials/discrete/recompute_no_calc.i
- test/tests/constraints/equal_value_boundary_constraint/equal_value_boundary_constraint_test.i
- test/tests/userobjects/user_object/user_object_test.i
- test/tests/materials/material/material_block_bound_check.i
- test/tests/quadrature/order/elem5_side7.i
- modules/combined/test/tests/heat_conduction_patch/heat_conduction_patch_test.i
- modules/phase_field/test/tests/MultiPhase/thirdphasesuppressionmaterial.i
- test/tests/variables/fe_hermite/hermite-3-2d.i
- test/tests/misc/check_error/nodal_value_off_block.i
- modules/porous_flow/examples/tutorial/00_2D.i
- test/tests/postprocessors/element_h1_error_pps/element_h1_error_pp_test.i
- test/tests/misc/jacobian/offdiag.i
- test/tests/multiapps/picard/pseudo_transient_picard_master.i
- test/tests/interfacekernels/1d_interface/mixed_shapes.i
- test/tests/auxkernels/element_aux_var/element_aux_var_test.i
- test/tests/kernels/vector_fe/coupled_scalar_default_vector_value.i
- modules/chemical_reactions/test/tests/equilibrium_const/maier_kelly.i
- test/tests/markers/error_tolerance_marker/error_tolerance_marker_test.i
- test/tests/misc/check_error/coupled_grad_without_declare.i
- test/tests/restart/restartable_types/restartable_types.i
- test/tests/geomsearch/fake_block_to_boundary/fake_block_to_boundary.i
- modules/combined/test/tests/gap_heat_transfer_mortar/ref.i
- modules/functional_expansion_tools/test/tests/errors/invalid_bounds_length.i
- test/tests/variables/optionally_coupled/optionally_coupled_system.i
- examples/ex04_bcs/dirichlet_bc.i
- test/tests/misc/check_error/check_syntax_error.i
- modules/porous_flow/test/tests/fluids/methane.i
- test/tests/misc/check_error/add_aux_variable_multiple_test.i
- test/tests/mesh_modifiers/mesh_extruder/extrude_remap_layer1.i
- test/tests/postprocessors/element_pps/elem_pps_multi_block_test.i
- test/tests/vectorpostprocessors/line_material_sampler/line_material_real_sampler.i
- test/tests/materials/derivativematerialinterface/multiblock.i
- modules/combined/test/tests/homogenization/heatConduction2D.i
- test/tests/vectorpostprocessors/elements_along_line/2d.i
- test/tests/mesh_modifiers/add_side_sets_from_bounding_box/overlapping_sidesets_not_found.i
- test/tests/vectorpostprocessors/constant_vector_postprocessor/constant_vector_postprocessor.i
- modules/phase_field/test/tests/free_energy_material/RegularSolutionFreeEnergy_plog.i
- tutorials/darcy_thermo_mech/step01_diffusion/problems/step1.i
- test/tests/misc/jacobian/simple.i
- modules/porous_flow/test/tests/relperm/corey2.i
- test/tests/materials/parsed/parsed_material.i
- modules/porous_flow/test/tests/thm_rehbinder/free_outer.i
- test/tests/userobjects/user_object/uo_restart_part1.i
- test/tests/materials/old_cyclic_dep/test.i
- test/tests/variables/fe_hermite_convergence/hermite_converge_periodic.i
- test/tests/controls/tag_based_naming_access/system_object_param.i
- test/tests/meshgenerators/generate_element_subdomain_id/quad_with_elementid_subdomainid.i
- test/tests/meshgenerators/sidesets_from_normals_generator/sidesets_cylinder_normals.i
- test/tests/partitioners/grid_partitioner/grid_partitioner.i
- test/tests/bcs/pp_neumann/pp_neumann.i
- test/tests/outputs/format/output_test_gnuplot_gif.i
- test/tests/outputs/tecplot/tecplot_append.i
- test/tests/kernels/simple_diffusion/simple_diffusion.i
- test/tests/restart/restart/part2.i
- modules/functional_expansion_tools/test/tests/errors/bc_value_penalty_bad_function.i
- modules/fluid_properties/test/tests/tabulated/tabulated.i
- test/tests/misc/check_error/dg_kernel_with_aux_var.i
- modules/heat_conduction/test/tests/heat_source_bar/heat_source_bar.i
- test/tests/outputs/debug/show_top_residuals_scalar.i
- test/tests/problems/external_problem/external_steady.i
- test/tests/misc/check_error/bad_parsed_function_vars.i
- modules/porous_flow/test/tests/relperm/vangenuchten1.i
- test/tests/mesh/mesh_generation/annulus_sector.i
- test/tests/parser/parser_dependency/parse_depend_reverse_test.i
- modules/heat_conduction/test/tests/semiconductor_linear_conductivity/steinhart-hart_linear.i
- test/tests/kernels/scalarkernel_vectorpostprocessor/scalarkernel_vectorpostprocessor.i
- modules/richards/test/tests/gravity_head_1/gh05.i
- test/tests/postprocessors/nodal_sum/nodal_sum_block_non_unique.i
- test/tests/outputs/debug/show_var_residual_norms.i
- modules/porous_flow/test/tests/poroperm/PermTensorFromVar01.i
- test/tests/meshgenerators/mixed_dim/1d_2d.i
- examples/ex11_prec/default.i
- modules/solid_mechanics/examples/bridge/bridge.i
- test/tests/ics/lagrange_ic/3d_second_order.i
- test/tests/misc/check_error/bad_material_test.i
- test/tests/variables/curvilinear_element/curvilinear_element_test.i
- test/tests/outputs/dofmap/simple_screen.i
- test/tests/controls/tag_based_naming_access/param.i
- python/peacock/tests/input_tab/InputTree/gold/simple_diffusion.i
- test/tests/dgkernels/dg_block_restrict/2d_dg_diffusion_block_restrict.i
- test/tests/bcs/sideset_from_nodeset/sideset_from_nodeset_test.i
- modules/stochastic_tools/test/tests/distributions/weibull.i
- modules/phase_field/test/tests/initial_conditions/MultiBoundingBoxIC2D.i
- test/tests/variables/simple_restricted/simple_restricted.i
- tutorials/darcy_thermo_mech/step01_diffusion/tests/kernels/simple_diffusion/simple_diffusion.i
- test/tests/auxkernels/parsed_aux/parsed_aux_test.i
- test/tests/misc/check_error/function_file_test14.i
- test/tests/userobjects/layered_average/layered_average_bounds_error.i
- test/tests/utils/copy_input_parameters/do_not_copy_parameters.i
- test/tests/kernels/vector_fe/coupled_scalar_vector.i
- modules/phase_field/test/tests/initial_conditions/RampIC.i
- test/tests/misc/check_error/missing_req_par_mesh_block_test.i
- test/tests/misc/check_error/function_file_test12.i
- examples/ex12_pbp/ex12.i
- test/tests/materials/declare_overlap/error.i
- test/tests/vectorpostprocessors/intersection_points_along_line/2d.i
- modules/porous_flow/test/tests/poroperm/PermTensorFromVar03.i
- test/tests/misc/check_error/invalid_steady_exec_test.i
- test/tests/executioners/executioner/steady.i
- test/tests/kernels/2d_diffusion/2d_diffusion_neumannbc_test.i
- test/tests/bcs/penalty_dirichlet_bc/function_penalty_dirichlet_bc_test.i
- test/tests/outputs/error/duplicate_output_files.i
- modules/porous_flow/test/tests/gravity/grav02b.i
- test/tests/auxkernels/solution_aux/thread_xda.i
- test/tests/preconditioners/fsp/fsp_test_image.i
- test/tests/misc/check_error/incomplete_kernel_variable_coverage_test.i
- test/tests/multiapps/command_line/sub.i
- test/tests/parser/param_substitution/param_substitution_in_file.i
- examples/ex01_inputfile/ex01.i
- test/tests/materials/types/test.i
- test/tests/materials/material/material_check_test.i
- modules/combined/test/tests/linear_elasticity/thermal_expansion.i
- test/tests/meshgenerators/sidesets_bounding_box_generator/error_no_elements_in_bounding_box.i
- test/tests/auxkernels/nodal_aux_boundary/nodal_aux_boundary.i
- test/tests/misc/check_error/check_syntax_ok.i
- test/tests/mesh_modifiers/mesh_extruder/extruder_tri.i
- test/tests/misc/check_error/bc_with_aux_var.i
- modules/tensor_mechanics/test/tests/interface_stress/test.i
- test/tests/auxkernels/nodal_aux_var/nodal_aux_var_test.i
- test/tests/postprocessors/element_extreme_value/element_extreme_value.i
- test/tests/indicators/value_jump_indicator/value_jump_indicator_test.i
- test/tests/multiapps/command_line/master_common.i
- test/tests/variables/optionally_coupled/optionally_coupled_twovar.i
- test/tests/controls/syntax_based_naming_access/system_asterisk_param.i
- test/tests/kernels/forcing_function/forcing_function_test.i
- test/tests/meshgenerators/sidesets_bounding_box_generator/overlapping_sidesets.i
- test/tests/restrictable/check_error/check_error.i
- modules/combined/test/tests/eigenstrain/variable.i
- test/tests/variables/coupled_scalar/coupled_scalar.i
- test/tests/postprocessors/element_average_value/element_average_value_test.i
- test/tests/variables/fe_hier/hier-1-3d.i
- test/tests/misc/check_error/function_file_test10.i
- python/peacock/tests/input_tab/InputTreeWriter/gold/simple_diffusion_no_diff.i
- modules/porous_flow/test/tests/actions/addjoiner.i
- examples/ex03_coupling/ex03.i
- test/tests/vectorpostprocessors/csv_reader/transfer/sub.i
- modules/navier_stokes/test/tests/ins/mms/pspg/pspg_mms_test.i
- test/tests/outputs/exodus/exodus_discontinuous.i
- modules/phase_field/test/tests/MultiSmoothCircleIC/latticesmoothcircleIC_bounds.i
- test/tests/variables/fe_hier/hier-1-1d.i
- test/tests/bcs/misc_bcs/vector_neumann_bc_test.i
- test/tests/outputs/variables/show_hide.i
- test/tests/outputs/xda/xda.i
- test/tests/materials/discrete/recompute.i
- test/tests/mesh_modifiers/subdomain_bounding_box/oriented_subdomain_bounding_box.i
- test/tests/auxkernels/grad_component/grad_component_monomial.i
- test/tests/outputs/displacement/displacement_test.i
- test/tests/interfacekernels/2d_interface/coupled_value_coupled_flux.i
- test/tests/preconditioners/fdp/fdp_test.i
- test/tests/postprocessors/axisymmetric_centerline_average_value/axisymmetric_centerline_average_value_test.i
- test/tests/materials/material/material_test.i
- test/tests/geomsearch/quadrature_nearest_node_locator/quadrature_nearest_node_locator.i
- test/tests/outputs/common/exodus.i
- modules/porous_flow/test/tests/pressure_pulse/pressure_pulse_1d_steady.i
- test/tests/misc/check_error/function_file_test6.i
- test/tests/vectorpostprocessors/histogram_vector_postprocessor/histogram_vector_postprocessor.i
- modules/tensor_mechanics/test/tests/isotropic_elasticity_tensor/lambda_shear_modulus_test.i
- test/tests/misc/check_error/linear_interp_not_increasing.i
- test/tests/controls/time_periods/dampers/enable_disable.i
- test/tests/dgkernels/advection_diffusion_mixed_bcs_test_resid_jac/dg_advection_diffusion_test.i
- test/tests/materials/discrete/recompute_boundary_error.i
- test/tests/bcs/1d_neumann/from_cubit.i
- modules/navier_stokes/test/tests/ins/hydrostatic/gravity.i
- test/tests/partitioners/petsc_partitioner/petsc_partitioner.i
- test/tests/multiapps/picard/steady_picard_master.i
- test/tests/outputs/format/output_test_sln.i
- test/tests/geomsearch/quadrature_penetration_locator/1d_quadrature_penetration.i
- test/tests/mortar/2d/non-conforming.i
- test/tests/kernels/block_kernel/block_vars.i
- test/tests/misc/check_error/function_file_test4.i
- test/tests/utils/spline_interpolation/spline_interpolation.i
- test/tests/auxkernels/solution_aux/build.i
- test/tests/userobjects/layered_average/layered_average.i
- test/tests/outputs/error/none_reserved.i
- test/tests/controls/moose_base_naming_access/base_param.i
- modules/heat_conduction/test/tests/meshed_gap_thermal_contact/meshed_gap_thermal_contact.i
- modules/combined/test/tests/multiphase_mechanics/multiphasestress.i
- test/tests/outputs/format/output_test_gnuplot_ps.i
- test/tests/mortar/1d/1d.i
- test/tests/functions/solution_function/solution_function_test.i
- modules/stochastic_tools/test/tests/ics/random_ic_distribution_test/random_ic_distribution_test.i
- test/tests/misc/selective_reinit/selective_reinit_test.i
- test/tests/dampers/constant_damper/constant_damper_test.i
- test/tests/variables/optionally_coupled/optionally_coupled.i
- test/tests/variables/fe_monomial_const/monomial-const-1d.i
- test/tests/bcs/sideset_from_nodeset/sideset_from_nodeset_test2.i
- test/tests/postprocessors/print_perf_data/print_perf_data.i
- test/tests/misc/check_error/unused_param_test.i
- test/tests/misc/check_error/scalar_old_integrity_check.i
- test/tests/ics/dependency/monomial.i
- examples/ex14_pps/ex14.i
- modules/phase_field/test/tests/solution_rasterizer/raster.i
- test/tests/vectorpostprocessors/material_vector_postprocessor/basic.i
- test/tests/mesh_modifiers/add_side_sets_from_bounding_box/error_no_nodes_found.i
- modules/stochastic_tools/test/tests/kernels/simple_diffusion/simple_diffusion.i
- modules/combined/test/tests/gap_heat_transfer_mortar/gap_heat_transfer_mortar_displaced.i
- test/tests/kernels/vector_fe/ad_lagrange_vec.i
- modules/stochastic_tools/test/tests/samplers/base/threads.i
- modules/combined/test/tests/thermal_elastic/derivatives.i
- modules/porous_flow/test/tests/capillary_pressure/vangenuchten1.i
- modules/phase_field/test/tests/new_initial_conditions/SmoothCircleIC_tanh.i
- test/tests/postprocessors/nodal_sum/nodal_sum_block.i
- test/tests/materials/discrete/reset_warning.i
- test/tests/postprocessors/execution_attribute_reporter/execution_attribute_reporter_error.i
- modules/phase_field/test/tests/MultiPhase/orderparameterfunctionmaterial.i
- test/tests/variables/coupled_scalar/coupled_scalar_from_ic.i
- test/tests/interfacekernels/3d_interface/coupled_value_coupled_flux.i
- test/tests/outputs/displaced/non_displaced_fallback.i
- test/tests/ics/function_ic/spline_function.i
- test/tests/misc/check_error/nodal_material_test.i
- test/tests/misc/check_error/3D_RZ_error_check.i
- test/tests/auxkernels/solution_aux/aux_nonlinear_solution_xdr.i
- test/tests/mortar/2d/conforming-2nd-order.i
- test/tests/relationship_managers/geometric_neighbors/geometric_edge_neighbors.i
- test/tests/controls/error/non_existing_dependency.i
- test/tests/geomsearch/nearest_node_locator/nearest_node_locator.i
- test/tests/mortar/2d/conforming_two_var.i
- modules/porous_flow/test/tests/thm_rehbinder/fixed_outer_rz.i
- test/tests/userobjects/shape_element_user_object/shape_side_uo_physics_test.i
- test/tests/mesh/no_mesh_block/generators_no_mesh_block.i
- test/tests/auxkernels/element_aux_var/block_global_depend_elem_aux.i
- test/tests/mesh_modifiers/add_side_sets_from_bounding_box/add_side_sets_from_bounding_box.i
- test/tests/mortar/2d/non-conforming-2nd-order.i
- test/tests/materials/generic_constant_material/generic_constant_material_test.i
- test/tests/mortar/3d/conforming-2nd-order.i
- test/tests/variables/fe_hermite/hermite-3-1d.i
- test/tests/bcs/ad_bcs/ad_bc.i
- test/tests/misc/check_error/function_file_test1.i
- modules/richards/test/tests/gravity_head_1/gh07.i
- modules/functional_expansion_tools/test/tests/errors/bc_value_bad_function.i
- test/tests/markers/dont_mark/dont_mark_test.i
- test/tests/bcs/nodal_normals/cylinder_hexes.i
- test/tests/auxkernels/element_aux_var/l2_element_aux_var_test.i
- test/tests/postprocessors/nodal_pps/nodal_nodeset_pps_test.i
- test/tests/variables/coupled_scalar/coupled_scalar_default.i
- modules/navier_stokes/test/tests/ins/jacobian_test/jacobian_stabilized_test.i
- test/tests/bcs/matched_value_bc/matched_value_bc_test.i
- modules/phase_field/test/tests/free_energy_material/RegularSolutionFreeEnergy.i
- modules/fluid_properties/test/tests/co2/co2.i
- test/tests/transfers/multiapp_copy_transfer/errors/sub.i
- test/tests/misc/check_error/ic_variable_not_specified.i
- test/tests/misc/check_error/nonexistent_pps_test.i
- python/peacock/tests/input_tab/InputTreeWriter/gold/simple_diffusion_inactive.i
- examples/ex11_prec/fdp.i
- test/tests/functions/linear_combination_function/lcf_vector.i
- test/tests/postprocessors/perf_graph_data/perf_graph.i
- modules/fluid_properties/test/tests/auxkernels/specific_enthalpy_aux.i
- test/tests/userobjects/layered_integral/average_sample.i
- modules/richards/test/tests/newton_cooling/nc02.i
- test/tests/parser/vector_range_checking/all_pass.i
- test/tests/auxkernels/vector_postprocessor_visualization/vector_postprocessor_visualization.i
- test/tests/materials/get_material_property_names/get_material_property_boundary_names.i
- test/tests/mortar/3d/non-conforming.i
- test/tests/variables/second_derivative/interface_kernels.i
- test/tests/postprocessors/element_integral_material_property/element_integral_material_property.i
- test/tests/ics/data_struct_ic/data_struct_ic_test.i
- modules/solid_mechanics/test/tests/kernels/simple_diffusion/simple_diffusion.i
- test/tests/controls/control_connection/control_connection.i
- test/tests/outputs/perf_graph/multi_app/master_full.i
- test/tests/materials/material/adv_mat_couple_test.i
- modules/fluid_properties/test/tests/ideal_gas/test2.i
- test/tests/mesh_modifiers/subdomain_bounding_box/oriented_subdomain_bounding_box_outside.i
- test/tests/markers/error_tolerance_marker/error_tolerance_marker_adapt_test.i
- test/tests/misc/check_error/function_file_test9.i
- modules/navier_stokes/test/tests/ins/RZ_cone/RZ_cone_high_reynolds.i
- test/tests/functions/pps_function/pp_function.i
- test/tests/materials/has_material/has_block_prop.i
- test/tests/kernels/2d_diffusion/2d_diffusion_test.i
- test/tests/outputs/tecplot/tecplot.i
- test/tests/mesh_modifiers/modifier_depend_order/modifier_depend_order.i
- test/tests/postprocessors/element_l2_difference/element_l2_difference.i
- test/tests/restart/pointer_restart_errors/pointer_store_error.i
- test/tests/mesh/checkpoint/checkpoint_split.i
- test/tests/outputs/iterative/iterative_steady_sequence.i
- test/tests/outputs/postprocessor/postprocessor_invalid.i
- test/tests/actions/meta_action/meta_action_test.i
- test/tests/misc/subdomain_setup/mat_prop_block.i
- modules/navier_stokes/test/tests/ins/jacobian_test/jacobian_traction_stabilized.i
- test/tests/kernels/forcing_function/forcing_function_error_check.i
- modules/chemical_reactions/test/tests/jacobian/coupled_diffreact2.i
- test/tests/outputs/format/output_test_xdr.i
- test/tests/mortar/1d/1d_nodebc_name.i
- test/tests/tag/2d_diffusion_matrix_tag_test.i
- modules/porous_flow/test/tests/newton_cooling/nc08.i
- test/tests/bcs/vectorpostprocessor/vectorpostprocessor.i
- test/tests/controls/syntax_based_naming_access/object_param.i
- test/tests/preconditioners/pbp/lots_of_variables.i
- test/tests/dgkernels/dg_block_restrict/1d_dg_block_restrict.i
- test/tests/functions/parsed/vector_function.i
- test/tests/relationship_managers/evaluable/edge_neighbors.i
- test/tests/executioners/steady_time/steady_time.i
- test/tests/misc/check_error/missing_req_par_action_obj_test.i
- test/tests/materials/discrete/recompute_block_error.i
- modules/porous_flow/test/tests/flux_limited_TVD_pflow/except02.i
- test/tests/controls/moose_base_naming_access/base_object_param.i
- test/tests/mortar/2d/conforming.i
- test/tests/postprocessors/relative_difference/relative_difference.i
- test/tests/outputs/format/pps_file_out_warn.i
- examples/ex02_kernel/ex02.i
- test/tests/outputs/variables/nemesis_hide.i
- test/tests/ics/dependency/test.i
- test/tests/userobjects/threaded_general_user_object/test.i
- modules/stochastic_tools/test/tests/distributions/johnsonsb.i
- modules/porous_flow/test/tests/relperm/corey4.i
- test/tests/postprocessors/block_nodal_pps/block_nodal_pps_test.i
- examples/ex04_bcs/neumann_bc.i
- test/tests/meshgenerators/generate_sidesets_bounding_box/multiple_boundary_ids.i
- modules/stochastic_tools/test/tests/multiapps/commandline_control/master_multiple.i
- modules/porous_flow/examples/tutorial/00.i
- examples/ex14_pps/ex14_compare_solutions_1.i
- test/tests/outputs/debug/show_top_residuals.i
- modules/porous_flow/test/tests/fluids/brine1.i
- test/tests/mesh_modifiers/transform/rotate_and_scale.i
- test/tests/materials/derivativematerialinterface/warn.i
- test/tests/kernels/ad_coupled_value/ad_coupled_value.i
- test/tests/outputs/exodus/variable_toggles.i
- test/tests/postprocessors/scale_pps/scale_pps.i
- test/tests/restrictable/api_test/boundary_restrictable.i
- test/tests/meshgenerators/mesh_extruder_generator/extrude_remap_layer1.i
- test/tests/userobjects/mat_prop_user_object/mat_prop_user_object.i
- modules/fluid_properties/test/tests/stiffened_gas/test.i
- test/tests/userobjects/element_quality_check/failure_warning.i
- test/tests/misc/check_error/missing_coupled_mat_prop_test.i
- modules/chemical_reactions/test/tests/mineral_volume_fraction/mineral.i
- test/tests/tag/2d_diffusion_dg_tag.i
- test/tests/problems/eigen_problem/ne_coupled_picard_masterT.i
- modules/stochastic_tools/test/tests/samplers/sobol/sobol.i
- test/tests/meshgenerators/mixed_dim/1d_2d_w_matl.i
- modules/tensor_mechanics/test/tests/action/two_block.i
- modules/functional_expansion_tools/test/tests/errors/invalid_order.i
- test/tests/vectorpostprocessors/vector_of_postprocessors/vector_of_postprocessors.i
- test/tests/dirackernels/point_caching/point_caching_error.i
- test/tests/mesh_modifiers/add_extra_nodeset/extra_nodeset_test.i
- modules/richards/test/tests/kernels/simple_diffusion/simple_diffusion.i
- test/tests/interfacekernels/adaptivity/adaptivity.i
- modules/richards/test/tests/darcy/ss.i
- test/tests/problems/dump_objects/add_mat_and_kernel.i
- test/tests/materials/material/three_coupled_mat_test.i
- test/tests/outputs/iterative/iterative_steady.i
- test/tests/executioners/eigen_executioners/normal_eigen_kernel.i
- test/tests/materials/piecewise_linear_interpolation_material/piecewise_linear_interpolation_material.i
- test/tests/vectorpostprocessors/elements_along_plane/2d.i
- modules/richards/test/tests/gravity_head_1/gh01.i
- test/tests/misc/check_error/vector_kernel_with_standard_var.i
- test/tests/outputs/output_dimension/output_dimension.i
- test/tests/kernels/vector_fe/coupled_scalar_vector_jacobian.i
- test/tests/outputs/exodus/exodus_nodal.i
- test/tests/outputs/exodus/exodus_enable_initial.i
- test/tests/kernels/vector_fe/vector_kernel.i
- test/tests/postprocessors/variable_inner_product/variable_inner_product.i
- test/tests/controls/time_periods/aux_scalar_kernels/enable_disable.i
- test/tests/tag/2d_diffusion_tag_matrix.i
- modules/porous_flow/test/tests/fluids/co2.i
- test/tests/materials/derivativematerialinterface/execution_order.i
- test/tests/ics/constant_ic/constant_ic_test.i
- examples/ex11_prec/smp.i
- test/tests/dirackernels/constant_point_source/1d_point_source.i
- test/tests/outputs/debug/show_var_residual_norms_debug.i
- test/tests/meshgenerators/image_subdomain_generator/image_subdomain_2d.i
- test/tests/mesh/mixed_dim/1d_3d.i
- test/tests/mesh/concentric_circle_mesh/concentric_circle_mesh.i
- test/tests/controls/time_periods/error/steady_error.i
- test/tests/meshgenerators/sidesets_bounding_box_generator/multiple_boundary_ids.i
- test/tests/outputs/postprocessor/postprocessor.i
- modules/heat_conduction/test/tests/meshed_gap_thermal_contact/meshed_annulus_thermal_contact.i
- test/tests/userobjects/internal_side_user_object/internal_side_user_object.i
- modules/porous_flow/examples/co2_intercomparison/1Dradial/properties.i
- test/tests/actions/aux_scalar_variable/aux_scalar_variable.i
- modules/porous_flow/test/tests/relperm/brooks_corey1.i
- modules/phase_field/test/tests/solution_rasterizer/diffuse.i
- test/tests/actions/setup_postprocessor_data/setup_postprocessor_data.i
- modules/porous_flow/test/tests/capillary_pressure/brooks_corey1.i
- test/tests/ics/vector_constant_ic/vector_constant_ic.i
- test/tests/materials/multiple_materials/multiple_materials_test.i
- modules/richards/test/tests/jacobian_1/jn_fu_07.i
- modules/misc/test/tests/kernels/thermo_diffusion/ad_thermo_diffusion.i
- test/tests/bcs/nodal_normals/square_quads.i
- python/chigger/tests/input/simple_diffusion.i
- test/tests/outputs/oversample/ex02_oversample.i
- test/tests/auxkernels/solution_aux/solution_aux_direct.i
- test/tests/mesh_modifiers/mesh_extruder/extruder_angle.i
- modules/heat_conduction/test/tests/heat_conduction/coupled_convective_heat_flux/const_hw.i
- test/tests/ics/component_ic/component_ic.i
- test/tests/utils/spline_interpolation/bicubic_spline_interpolation_y_normal.i
- test/tests/userobjects/layered_side_integral/layered_side_integral_test.i
- test/tests/mesh_modifiers/mesh_extruder/extruder_quad.i
- test/tests/misc/serialized_solution/uniform_refine.i
- test/tests/outputs/subdir_output/subdir_output.i
- test/tests/controls/restrict_exec_flag/sub.i
- test/tests/misc/check_error/uo_vector_pps_name_collision_test.i
- test/tests/geomsearch/3d_penetration_locator/3d_tet.i
- test/tests/outputs/debug/show_material_props.i
- modules/richards/test/tests/jacobian_1/jn01.i
- modules/phase_field/test/tests/feature_volume_vpp_test/feature_volume_vpp_test.i
- test/tests/mesh/named_entities/named_entities_test_xda.i
- test/tests/outputs/csv/csv.i
- test/tests/userobjects/layered_integral/cumulative_layered_integral.i
- test/tests/bcs/bc_preset_nodal/bc_function_preset.i
- test/tests/outputs/variables/hide_output_via_variables_block.i
- modules/combined/test/tests/linear_elasticity/linear_anisotropic_material.i
- test/tests/misc/save_in/save_in_test.i
- test/tests/restrictable/undefined_ids/undefined_boundary_bc.i
- test/tests/kernels/kernel_precompute/kernel_precompute_test.i
- test/tests/misc/check_error/incomplete_kernel_block_coverage_test.i
- modules/combined/test/tests/heat_convection/heat_convection_3d_tf_test.i
- modules/level_set/test/tests/functions/olsson_bubble/olsson_bubble.i
- test/tests/auxkernels/vector_magnitude/vector_magnitude.i
- test/tests/kernels/jxw_grad_test_dep_on_displacements/not-handling-jxw.i
- test/tests/variables/fe_hier/hier-2-1d.i
- test/tests/outputs/format/output_test_gnuplot.i
- modules/chemical_reactions/test/tests/jacobian/coupled_diffreact.i
- test/tests/outputs/console/console_print_toggles.i
- modules/tensor_mechanics/test/tests/isotropic_elasticity_tensor/bulk_modulus_shear_modulus_test.i
- test/tests/misc/no_exodiff_map/no_exodiff_map.i
- test/tests/controls/syntax_based_naming_access/system_object_param.i
- modules/functional_expansion_tools/test/tests/errors/multiple_series_duo.i
- test/tests/misc/line_source/line_source.i
- modules/richards/test/tests/jacobian_1/jn07.i
- test/tests/actions/meta_action_multiple_tasks/circle_quads.i
- modules/richards/test/tests/gravity_head_1/gh_fu_04.i
- test/tests/outputs/mesh/no_mesh_name_test.i
- modules/phase_field/test/tests/initial_conditions/ClosePackIC.i
- modules/combined/test/tests/linear_elasticity/applied_strain.i
- modules/tensor_mechanics/tutorials/basics/part_1.2.i
- test/tests/kernels/tag_errors/tag_doesnt_exist/bad_tag.i
- examples/ex01_inputfile/diffusion_pathological.i
- modules/richards/test/tests/jacobian_1/jn_fu_03.i
- test/tests/tag/tag_neumann.i
- test/tests/misc/check_error/check_dynamic_name_block_mismatch.i
- test/tests/vectorpostprocessors/line_value_sampler/line_value_sampler.i
- test/tests/mortar/3d/conforming.i
- test/tests/mesh_modifiers/rename_block/except.i
- test/tests/mesh_modifiers/assign_element_subdomain_id/quad_with_subdomainid_test.i
- test/tests/variables/fe_hier/hier-2-3d.i
- modules/phase_field/test/tests/grain_tracker_test/grain_tracker_volume_single.i
- modules/richards/test/tests/gravity_head_1/gh_fu_02.i
- test/tests/transfers/multiapp_projection_transfer/high_order_master.i
- test/tests/outputs/error/duplicate_outputs.i
- modules/tensor_mechanics/tutorials/basics/part_2.1.i
- test/tests/misc/check_error/check_dynamic_name_boundary_mismatch.i
- test/tests/vectorpostprocessors/point_value_sampler/not_found.i
- test/tests/meshgenerators/generate_sidesets_bounding_box/multiple_boundary_ids_3d.i
- test/tests/vectorpostprocessors/statistics_vector_postprocessor/statistics_vector_postprocessor.i
- modules/porous_flow/test/tests/poroperm/PermFromPoro05.i
- test/tests/kernels/jxw_grad_test_dep_on_displacements/jxw-spherical.i
- modules/stochastic_tools/test/tests/distributions/normal_direct_type_error.i
- test/tests/postprocessors/point_value/point_value.i
- test/tests/outputs/output_interface/marker.i
- test/tests/kernels/scalar_constraint/scalar_constraint_bc.i
- modules/combined/test/tests/linear_elasticity/linear_anisotropic_material_sm.i
- test/tests/outputs/misc/warehouse_access.i
- modules/porous_flow/test/tests/poroperm/PermFromPoro03.i
- test/tests/meshgenerators/sidesets_from_normals_generator/sidesets_cylinder_normals_fixed.i
- modules/chemical_reactions/test/tests/equilibrium_const/linear.i
- test/tests/misc/check_error/missing_material_prop_test.i
- test/tests/outputs/exodus/invalid_hide_variables.i
- test/tests/mesh/splitting/geometric_neighbors.i
- test/tests/tag/tag_interface_kernels.i
- modules/navier_stokes/test/tests/ins/mms/supg/supg_mms_test.i
- test/tests/controls/control_connection/alias_connection.i
- test/tests/misc/check_error/missing_active_section.i
- modules/heat_conduction/test/tests/heat_conduction/2d_quadrature_gap_heat_transfer/perfectQ8.i
- modules/richards/test/tests/gravity_head_2/gh_fu_01.i
- test/tests/postprocessors/side_flux_average/side_flux_average.i
- modules/combined/test/tests/linear_elasticity/extra_stress.i
- test/tests/misc/check_error/deprecated_param_test.i
- test/tests/dirackernels/constant_point_source/3d_point_source.i
- test/tests/constraints/nodal_constraint/nodal_constraint_test.i
- test/tests/outputs/xda_xdr/xda_xdr.i
- tutorials/darcy_thermo_mech/step02_darcy_pressure/problems/step2.i
- tutorials/darcy_thermo_mech/step02_darcy_pressure/tests/kernels/darcy_pressure/darcy_pressure.i
- test/tests/meshgenerators/generate_sidesets_bounding_box/overlapping_sidesets.i
- test/tests/relationship_managers/evaluable/evaluable.i
- modules/stochastic_tools/test/tests/multiapps/commandline_control/master_single.i
- test/tests/preconditioners/smp/smp_single_test.i
- test/tests/variables/fe_hier/hier-3-2d.i
- test/tests/mesh_modifiers/mesh_extruder/gen_extrude.i
- test/tests/functions/parsed/combined.i
- test/tests/geomsearch/penetration_locator/penetration_locator_test.i
- test/tests/bcs/bc_preset_nodal/bc_preset_nodal.i
- test/tests/ics/bounding_box_ic/bounding_box_ic_test.i
- test/tests/outputs/exodus/hide_variables.i
- test/tests/postprocessors/difference_pps/difference_depend_check.i
- test/tests/postprocessors/function_sideintegral/function_sideintegral.i
- modules/combined/examples/phase_field-mechanics/interface_stress.i
- test/tests/vectorpostprocessors/intersection_points_along_line/3d.i
- test/tests/globalparams/global_param/global_param_test.i
- modules/porous_flow/test/tests/fluids/simple_fluid.i
- test/tests/kernels/ad_value/ad_value.i
- test/tests/bcs/misc_bcs/vacuum_bc_test.i
- test/tests/dirackernels/material_point_source/material_error_check.i
- test/tests/kernels/tag_errors/tag_doesnt_exist/bad_transient.i
- test/tests/outputs/debug/show_material_props_debug.i
- test/tests/auxkernels/quotient_aux/quotient_aux.i
- modules/porous_flow/examples/flow_through_fractured_media/fine_steady.i
- test/tests/markers/error_fraction_marker/error_fraction_marker_test.i
- test/tests/mesh/no_mesh_block/no_mesh_block.i
- test/tests/multiapps/full_solve_multiapp/master.i
- test/tests/meshgenerators/mesh_extruder_generator/extrude_remap_layer2.i
test/tests/vectorpostprocessors/line_value_sampler/csv_delimiter.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[AuxVariables]
[./v]
initial_condition = 1.23456789
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[VectorPostprocessors]
[./line_sample]
type = LineValueSampler
variable = 'u v'
start_point = '0 0.5 0'
end_point = '1 0.5 0'
num_points = 11
sort_by = id
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
execute_on = 'timestep_end'
exodus = true
[./csv]
type = CSV
delimiter = ' '
precision = 5
[../]
[]
test/tests/materials/output/output_steady.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[Functions]
[./bc_func]
type = ParsedFunction
value = 0.5*y
[../]
[]
[Kernels]
[./diff]
type = CoefDiffusion
variable = u
block = 0
coef = 0.1
[../]
[]
[BCs]
[./left]
type = FunctionDirichletBC
variable = u
boundary = left
function = bc_func
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Materials]
[./k]
type = OutputTestMaterial
block = 0
outputs = all
variable = u
output_properties = 'real_property vector_property tensor_property'
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/mesh/mesh_generation/mesh_generation_test.i
###########################################################
# This is a simple test of the Mesh System. This
# test demonstrates the usage of GeneratedMesh. It
# builds a square domain on demand.
#
# @Requirement F2.10
###########################################################
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
nz = 0
zmin = 0
zmax = 0
elem_type = QUAD4
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
active = 'left right'
# Mesh Generation produces boundaries in counter-clockwise fashion
[./left]
type = DirichletBC
variable = u
boundary = 3
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 1
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/mesh_modifiers/add_side_sets_from_bounding_box/overlapping_sidesets.i
[Mesh]
type = GeneratedMesh
dim = 3
nx = 10
ny = 10
nz = 10
# This MeshModifier currently only works with ReplicatedMesh.
# For more information, refer to #2129.
parallel_type = replicated
[]
[MeshModifiers]
[./createNewSidesetOne]
type = AddSideSetsFromBoundingBox
boundary_id_old = 'bottom back left'
boundary_id_new = 10
bottom_left = '-1.1 -1.1 -1.1'
top_right = '1.1 1.1 1.1'
block_id = 0
boundary_id_overlap = true
[../]
[./createNewSidesetTwo]
type = AddSideSetsFromBoundingBox
boundary_id_old = 'right bottom'
boundary_id_new = 11
bottom_left = '-1.1 -1.1 -1.1'
top_right = '1.1 1.1 1.1'
block_id = 0
boundary_id_overlap = true
[../]
[./createNewSidesetThree]
type = AddSideSetsFromBoundingBox
boundary_id_old = 'top front'
boundary_id_new = 12
bottom_left = '-1.1 -1.1 -1.1'
top_right = '1.1 1.1 1.1'
block_id = 0
boundary_id_overlap = true
[../]
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./BCone]
type = DirichletBC
variable = u
boundary = 10
value = 1
[../]
[./BCtwo]
type = DirichletBC
variable = u
boundary = 11
value = 1
[../]
[./BCthree]
type = DirichletBC
variable = u
boundary = 12
value = 0
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
tutorials/darcy_thermo_mech/step04_velocity_aux/problems/step4.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 100
ny = 10
xmax = 0.304 # Length of test chamber
ymax = 0.0257 # Test chamber radius
[]
[Variables]
[./pressure]
[../]
[]
[AuxVariables]
[./velocity_x]
order = CONSTANT
family = MONOMIAL
[../]
[./velocity_y]
order = CONSTANT
family = MONOMIAL
[../]
[./velocity_z]
order = CONSTANT
family = MONOMIAL
[../]
[]
[Kernels]
[./darcy_pressure]
type = DarcyPressure
variable = pressure
[../]
[]
[AuxKernels]
[./velocity_x]
type = DarcyVelocity
variable = velocity_x
component = x
execute_on = timestep_end
darcy_pressure = pressure
[../]
[./velocity_y]
type = DarcyVelocity
variable = velocity_y
component = y
execute_on = timestep_end
darcy_pressure = pressure
[../]
[./velocity_z]
type = DarcyVelocity
variable = velocity_z
component = z
execute_on = timestep_end
darcy_pressure = pressure
[../]
[]
[BCs]
[./inlet]
type = DirichletBC
variable = pressure
boundary = left
value = 4000 # (Pa) From Figure 2 from paper. First data point for 1mm spheres.
[../]
[./outlet]
type = DirichletBC
variable = pressure
boundary = right
value = 0 # (Pa) Gives the correct pressure drop from Figure 2 for 1mm spheres
[../]
[]
[Materials]
[./column]
type = PackedColumn
sphere_radius = 1
[../]
[]
[Problem]
type = FEProblem
coord_type = RZ
rz_coord_axis = X
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/dirackernels/constant_point_source/constant_point_source_test.i
[Mesh]
file = square.e
uniform_refine = 4
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[./v]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[DiracKernels]
active = 'point_source'
[./point_source]
type = ConstantPointSource
variable = u
value = 1.0
point = '0.2 0.3'
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/controls/tag_based_naming_access/system_asterisk_param.i
[Mesh]
type = GeneratedMesh
dim = 2
elem_type = QUAD4
# use odd numbers so points do not fall on element boundaries
nx = 31
ny = 31
[]
[Variables]
[./diffused]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = diffused
[../]
[]
[DiracKernels]
[./test_object]
type = MaterialPointSource
point = '0.5 0.5 0'
variable = diffused
[../]
[]
[BCs]
[./bottom_diffused]
type = DirichletBC
variable = diffused
boundary = 'bottom'
value = 2
[../]
[./top_diffused]
type = DirichletBC
variable = diffused
boundary = 'top'
value = 0
[../]
[]
[Materials]
[./mat]
type = GenericConstantMaterial
prop_names = 'matp'
prop_values = '1'
block = 0
[../]
[]
[Postprocessors]
[./test_object]
type = FunctionValuePostprocessor
function = '2*(x+y)'
point = '0.5 0.5 0'
control_tags = 'tag'
[../]
[./other_point_test_object]
type = FunctionValuePostprocessor
function = '3*(x+y)'
point = '0.5 0.5 0'
control_tags = 'tag'
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
execute_on = 'timestep_end'
exodus = true
[]
[Controls]
[./point_control]
type = TestControl
test_type = 'point'
parameter = 'tag/*/point'
execute_on = 'initial'
[../]
[]
test/tests/variables/fe_hermite/hermite-3-3d.i
[Mesh]
type = GeneratedMesh
dim = 3
xmin = -1
xmax = 1
ymin = -1
ymax = 1
zmin = -1
zmax = 1
nx = 1
ny = 1
nz = 1
elem_type = HEX27
# This problem only has 1 element, so using DistributedMesh in parallel
# isn't really an option, and we don't care that much about DistributedMesh
# in serial.
parallel_type = replicated
[]
[Functions]
[./bc_fnt]
type = ParsedFunction
value = 3*y*y
[../]
[./bc_fnb]
type = ParsedFunction
value = -3*y*y
[../]
[./bc_fnl]
type = ParsedFunction
value = -3*x*x
[../]
[./bc_fnr]
type = ParsedFunction
value = 3*x*x
[../]
[./bc_fnk]
type = ParsedFunction
value = -3*z*z
[../]
[./bc_fnf]
type = ParsedFunction
value = 3*z*z
[../]
[./forcing_fn]
type = ParsedFunction
value = -6*x-6*y-6*z+(x*x*x)+(y*y*y)+(z*z*z)
[../]
[./solution]
type = ParsedGradFunction
value = (x*x*x)+(y*y*y)+(z*z*z)
grad_x = 3*x*x
grad_y = 3*y*y
grad_z = 3*z*z
[../]
[]
[Variables]
[./u]
order = THIRD
family = HERMITE
[../]
[]
[Kernels]
active = 'diff forcing reaction'
[./diff]
type = Diffusion
variable = u
[../]
[./reaction]
type = Reaction
variable = u
[../]
[./forcing]
type = BodyForce
variable = u
function = forcing_fn
[../]
[]
[BCs]
[./bc_top]
type = FunctionNeumannBC
variable = u
boundary = 'top'
function = bc_fnt
[../]
[./bc_bottom]
type = FunctionNeumannBC
variable = u
boundary = 'bottom'
function = bc_fnb
[../]
[./bc_left]
type = FunctionNeumannBC
variable = u
boundary = 'left'
function = bc_fnl
[../]
[./bc_right]
type = FunctionNeumannBC
variable = u
boundary = 'right'
function = bc_fnr
[../]
[./bc_front]
type = FunctionNeumannBC
variable = u
boundary = 'front'
function = bc_fnf
[../]
[./bc_back]
type = FunctionNeumannBC
variable = u
boundary = 'back'
function = bc_fnk
[../]
[]
[Postprocessors]
[./dofs]
type = NumDOFs
[../]
[./h]
type = AverageElementSize
[../]
[./L2error]
type = ElementL2Error
variable = u
function = solution
[../]
[./H1error]
type = ElementH1Error
variable = u
function = solution
[../]
[./H1Semierror]
type = ElementH1SemiError
variable = u
function = solution
[../]
[]
[Executioner]
type = Steady
solve_type = NEWTON
[]
[Outputs]
execute_on = 'timestep_end'
exodus = true
csv = true
[]
modules/heat_conduction/test/tests/heat_conduction/2d_quadrature_gap_heat_transfer/nonmatching.i
[Mesh]
file = nonmatching.e
[]
[Variables]
[./temp]
[../]
[]
[Kernels]
[./hc]
type = HeatConduction
variable = temp
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = temp
boundary = leftleft
value = 1000
[../]
[./right]
type = DirichletBC
variable = temp
boundary = rightright
value = 400
[../]
[]
[ThermalContact]
[./left_to_right]
slave = leftright
quadrature = true
master = rightleft
variable = temp
type = GapHeatTransfer
[../]
[]
[Materials]
[./hcm]
type = HeatConductionMaterial
block = 'left right'
specific_heat = 1
thermal_conductivity = 1
[../]
[./gap_conductance]
type = GenericConstantMaterial
prop_names = 'gap_conductance gap_conductance_dT'
boundary = 'leftright rightleft'
prop_values = '1 0'
[../]
[]
[Postprocessors]
[./left]
type = SideFluxIntegral
variable = temp
boundary = leftright
diffusivity = thermal_conductivity
[../]
[./right]
type = SideFluxIntegral
variable = temp
boundary = rightleft
diffusivity = thermal_conductivity
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/mesh/mesh_generation/disc_sector.i
# Generates a sector of a Disc Mesh between angle=Pi/4 and angle=3Pi/4
# Radius of outside circle=5
# Solves the diffusion equation with u=-5 at origin, and u=0 on outside
# as well as u=-5+r at angle=Pi/4 and u=-5+r^4/125 at angle=3Pi/4
[Mesh]
type = AnnularMesh
nr = 10
nt = 12
rmin = 0
rmax = 5
tmin = 0.785398163
tmax = 2.356194490
growth_r = 1.3
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./inner]
type = PresetBC
variable = u
value = -5.0
boundary = rmin
[../]
[./outer]
type = FunctionPresetBC
variable = u
function = 0
boundary = rmax
[../]
[./tmin]
type = FunctionPresetBC
variable = u
function = '-5.0+sqrt(x*x + y*y)'
boundary = tmin
[../]
[./tmax]
type = FunctionPresetBC
variable = u
function = '-5.0+pow(x*x + y*y, 2)/125'
boundary = tmax
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
[]
[Outputs]
exodus = true
[]
test/tests/misc/block_boundary_material_check/side_uo_check.i
[Mesh]
type = GeneratedMesh
dim = 1
[]
[Variables]
[./u]
[../]
[]
[UserObjects]
[./side_uo]
type = MatSideUserObject
mat_prop = 'foo'
boundary = 1
[../]
[]
[Problem]
type = FEProblem
solve = false
kernel_coverage_check = false
[]
[Executioner]
type = Steady
[]
[Outputs]
[]
test/tests/outputs/append_date/append_date.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
append_date = true
[./date]
type = Exodus
append_date_format = '%m-%d-%Y'
[../]
[]
modules/heat_conduction/test/tests/heat_source_bar/ad_heat_source_bar.i
# This is a simple 1D test of the volumetric heat source with material properties
# of a representative ceramic material. A bar is uniformly heated, and a temperature
# boundary condition is applied to the left side of the bar.
# Important properties of problem:
# Length: 0.01 m
# Thermal conductivity = 3.0 W/(mK)
# Specific heat = 300.0 J/K
# density = 10431.0 kg/m^3
# Prescribed temperature on left side: 600 K
# When it has reached steady state, the temperature as a function of position is:
# T = -q/(2*k) (x^2 - 2*x*length) + 600
# or
# T = -6.3333e+7 * (x^2 - 0.02*x) + 600
# on left side: T=600, on right side, T=6933.3
[Mesh]
type = GeneratedMesh
dim = 1
xmax = 0.01
nx = 20
[]
[Variables]
[./temp]
initial_condition = 300.0
[../]
[]
[ADKernels]
[./heat]
type = ADHeatConduction
variable = temp
thermal_conductivity = thermal_conductivity
[../]
[./heatsource]
type = ADMatHeatSource
material_property = volumetric_heat
variable = temp
scalar = 10
[../]
[]
[BCs]
[./lefttemp]
type = PresetBC
boundary = left
variable = temp
value = 600
[../]
[]
[Materials]
[./density]
type = GenericConstantMaterial
prop_names = 'density thermal_conductivity volumetric_heat '
prop_values = '10431.0 3.0 3.8e7'
[../]
[]
[Preconditioning]
[./full]
type = SMP
full = true
[../]
[]
[Executioner]
type = Steady
[]
[Postprocessors]
[./right]
type = SideAverageValue
variable = temp
boundary = right
[../]
[./error]
type = NodalL2Error
function = '-3.8e+8/(2*3) * (x^2 - 2*x*0.01) + 600'
variable = temp
[../]
[]
[Outputs]
execute_on = FINAL
exodus = true
[]
test/tests/meshgenerators/mixed_dim/1d_3d.i
[MeshGenerators]
[./fmg]
type = FileMeshGenerator
file = 1d_3d.e
[]
[]
[Mesh]
type = MeshGeneratorMesh
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 4
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[./bottom]
type = DirichletBC
variable = u
boundary = 100
value = 0
[../]
[./top]
type = DirichletBC
variable = u
boundary = 101
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = 1d_3d_out
exodus = true
[]
test/tests/restart/restartable_types/restartable_types2.i
###########################################################
# This is a simple test of the restart/recover capability.
# The test object "RestartableTypesChecker" is used
# to reload data from a previous simulation written out
# with the object "RestartableTypes".
#
# See "restartable_types.i"
#
# @Requirement F1.60
###########################################################
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[UserObjects]
[./restartable_types]
type = RestartableTypesChecker
[../]
[]
[Problem]
type = FEProblem
solve = false
restart_file_base = restartable_types_out_cp/LATEST
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/misc/check_error/function_file_test3.i
# Test for usage of missing function
[Mesh]
file = square.e
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[./InitialCondition]
type = FunctionIC
function = ic_function
[../]
[../]
[]
[Functions]
[./ic_function]
type = PiecewiseLinear
data_file = piecewise_linear_mixed_lengths.csv #Will generate error because length of data doesn't match on all rows
format = rows
scale_factor = 1.0
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/variables/fe_hier/hier-3-1d.i
[Mesh]
type = GeneratedMesh
dim = 1
xmin = -1
xmax = 1
nx = 5
elem_type = EDGE3
[]
[Functions]
[./bc_fnl]
type = ParsedFunction
value = -3*x*x
[../]
[./bc_fnr]
type = ParsedFunction
value = 3*x*x
[../]
[./forcing_fn]
type = ParsedFunction
value = -6*x+(x*x*x)
[../]
[./solution]
type = ParsedGradFunction
value = x*x*x
grad_x = 3*x*x
[../]
[]
[Variables]
[./u]
order = THIRD
family = HIERARCHIC
[../]
[]
[Kernels]
active = 'diff forcing reaction'
[./diff]
type = Diffusion
variable = u
[../]
[./reaction]
type = Reaction
variable = u
[../]
[./forcing]
type = BodyForce
variable = u
function = forcing_fn
[../]
[]
[BCs]
[./bc_left]
type = FunctionNeumannBC
variable = u
boundary = 'left'
function = bc_fnl
[../]
[./bc_right]
type = FunctionNeumannBC
variable = u
boundary = 'right'
function = bc_fnr
[../]
[]
[Postprocessors]
[./dofs]
type = NumDOFs
[../]
[./h]
type = AverageElementSize
[../]
[./L2error]
type = ElementL2Error
variable = u
function = solution
[../]
[./H1error]
type = ElementH1Error
variable = u
function = solution
[../]
[./H1Semierror]
type = ElementH1SemiError
variable = u
function = solution
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
execute_on = 'timestep_end'
exodus = true
csv = true
[]
test/tests/outputs/dofmap/simple.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[./v]
[../]
[]
[AuxVariables]
[./w]
[../]
[]
[Kernels]
[./diffu]
type = Diffusion
variable = u
[../]
[./diffv]
type = Diffusion
variable = v
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
execute_on = 'timestep_end'
dofmap = true
[]
test/tests/kernels/forcing_function/forcing_function_neumannbc_test.i
[Mesh]
file = square.e
uniform_refine = 4
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Functions]
active = 'forcing_func exact_func'
[./forcing_func]
type = ParsedGradFunction
value = 2
[../]
[./exact_func]
type = ParsedFunction
value = x*x
[../]
[]
[Kernels]
active = 'diff forcing'
[./diff]
type = Diffusion
variable = u
[../]
[./forcing]
type = BodyForce
variable = u
function = forcing_func
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = '1'
value = 0
[../]
[./right]
type = FunctionNeumannBC
function = exact_func
variable = u
boundary = '2'
[../]
[]
[Executioner]
type = Steady
[]
[Outputs]
execute_on = 'timestep_end'
file_base = neumannbc_out
exodus = true
[]
modules/stochastic_tools/test/tests/distributions/truncated_normal.i
[Mesh]
type = GeneratedMesh
dim = 1
nx = 1
ny = 1
[]
[Variables]
[./u]
[../]
[]
[Distributions]
[./normal_test]
type = TruncatedNormalDistribution
mean = 100
standard_deviation = 25
lower_bound = 50
upper_bound = 150
[../]
[]
[Postprocessors]
[./cdf]
type = TestDistributionPostprocessor
distribution = normal_test
value = 137.962
method = cdf
execute_on = initial
[../]
[./pdf]
type = TestDistributionPostprocessor
distribution = normal_test
value = 137.962
method = pdf
execute_on = initial
[../]
[./quantile]
type = TestDistributionPostprocessor
distribution = normal_test
value = 0.956318
method = quantile
execute_on = initial
[../]
[]
[Executioner]
type = Steady
[]
[Problem]
solve = false
kernel_coverage_check = false
[]
[Outputs]
execute_on = 'INITIAL'
csv = true
[]
modules/richards/test/tests/gravity_head_2/gh01.i
# unsaturated = true
# gravity = false
# supg = false
# transient = false
[Mesh]
type = GeneratedMesh
dim = 1
nx = 20
xmin = 0
xmax = 1
[]
[GlobalParams]
richardsVarNames_UO = PPNames
[]
[UserObjects]
[./PPNames]
type = RichardsVarNames
richards_vars = 'pwater pgas'
[../]
[./DensityWater]
type = RichardsDensityConstBulk
dens0 = 1
bulk_mod = 1.0E2
[../]
[./DensityGas]
type = RichardsDensityConstBulk
dens0 = 0.5
bulk_mod = 0.5E2
[../]
[./SeffWater]
type = RichardsSeff2waterVG
m = 0.8
al = 1
[../]
[./SeffGas]
type = RichardsSeff2gasVG
m = 0.8
al = 1
[../]
[./RelPermWater]
type = RichardsRelPermPower
simm = 0.0
n = 2
[../]
[./RelPermGas]
type = RichardsRelPermPower
simm = 0.0
n = 3
[../]
[./SatWater]
type = RichardsSat
s_res = 0.1
sum_s_res = 0.15
[../]
[./SatGas]
type = RichardsSat
s_res = 0.05
sum_s_res = 0.15
[../]
[./SUPGwater]
type = RichardsSUPGnone
[../]
[./SUPGgas]
type = RichardsSUPGnone
[../]
[]
[Variables]
[./pwater]
order = FIRST
family = LAGRANGE
[../]
[./pgas]
order = FIRST
family = LAGRANGE
[../]
[]
[ICs]
[./water_ic]
type = RandomIC
min = 0.4
max = 0.6
variable = pwater
[../]
[./gas_ic]
type = RandomIC
min = 1.4
max = 1.6
variable = pgas
[../]
[]
[Kernels]
active = 'richardsfwater richardsfgas'
[./richardstwater]
type = RichardsMassChange
variable = pwater
[../]
[./richardsfwater]
type = RichardsFlux
variable = pwater
[../]
[./richardstgas]
type = RichardsMassChange
variable = pgas
[../]
[./richardsfgas]
type = RichardsFlux
variable = pgas
[../]
[]
[AuxVariables]
[./seffgas]
[../]
[./seffwater]
[../]
[]
[AuxKernels]
[./seffgas_kernel]
type = RichardsSeffAux
pressure_vars = 'pwater pgas'
seff_UO = SeffGas
variable = seffgas
[../]
[./seffwater_kernel]
type = RichardsSeffAux
pressure_vars = 'pwater pgas'
seff_UO = SeffWater
variable = seffwater
[../]
[]
[Postprocessors]
[./mwater_init]
type = RichardsMass
variable = pwater
execute_on = timestep_begin
outputs = none
[../]
[./mgas_init]
type = RichardsMass
variable = pgas
execute_on = timestep_begin
outputs = none
[../]
[./mwater_fin]
type = RichardsMass
variable = pwater
execute_on = timestep_end
outputs = none
[../]
[./mgas_fin]
type = RichardsMass
variable = pgas
execute_on = timestep_end
outputs = none
[../]
[./mass_error_water]
type = FunctionValuePostprocessor
function = fcn_mass_error_w
outputs = none # no reason why mass should be conserved
[../]
[./mass_error_gas]
type = FunctionValuePostprocessor
function = fcn_mass_error_g
outputs = none # no reason why mass should be conserved
[../]
[./pw_left]
type = PointValue
point = '0 0 0'
variable = pwater
outputs = none
[../]
[./pw_right]
type = PointValue
point = '1 0 0'
variable = pwater
outputs = none
[../]
[./error_water]
type = FunctionValuePostprocessor
function = fcn_error_water
[../]
[./pg_left]
type = PointValue
point = '0 0 0'
variable = pgas
outputs = none
[../]
[./pg_right]
type = PointValue
point = '1 0 0'
variable = pgas
outputs = none
[../]
[./error_gas]
type = FunctionValuePostprocessor
function = fcn_error_gas
[../]
[]
[Functions]
[./fcn_mass_error_w]
type = ParsedFunction
value = 'abs(0.5*(mi-mf)/(mi+mf))'
vars = 'mi mf'
vals = 'mwater_init mwater_fin'
[../]
[./fcn_mass_error_g]
type = ParsedFunction
value = 'abs(0.5*(mi-mf)/(mi+mf))'
vars = 'mi mf'
vals = 'mgas_init mgas_fin'
[../]
[./fcn_error_water]
type = ParsedFunction
value = 'abs((p0-p1)/p1)'
vars = 'b gdens0 p0 xval p1'
vals = '1E2 -1 pw_left 1 pw_right'
[../]
[./fcn_error_gas]
type = ParsedFunction
value = 'abs((p0-p1)/p1)'
vars = 'b gdens0 p0 xval p1'
vals = '0.5E2 -0.5 pg_left 1 pg_right'
[../]
[]
[Materials]
[./rock]
type = RichardsMaterial
block = 0
mat_porosity = 0.1
mat_permeability = '1E-5 0 0 0 1E-5 0 0 0 1E-5'
density_UO = 'DensityWater DensityGas'
relperm_UO = 'RelPermWater RelPermGas'
SUPG_UO = 'SUPGwater SUPGgas'
sat_UO = 'SatWater SatGas'
seff_UO = 'SeffWater SeffGas'
viscosity = '1E-3 0.5E-3'
gravity = '0 0 0'
linear_shape_fcns = true
[../]
[]
[Preconditioning]
[./andy]
type = SMP
full = true
petsc_options_iname = '-ksp_type -pc_type -sub_pc_type -sub_pc_factor_shift_type -snes_atol -snes_rtol -snes_max_it'
petsc_options_value = 'gmres asm lu NONZERO 1E-10 1E-10 10000'
[../]
[]
[Executioner]
type = Steady
solve_type = Newton
[]
[Outputs]
execute_on = 'timestep_end'
file_base = gh01
csv = true
[]
modules/combined/test/tests/heat_conduction_patch/heat_conduction_patch_rz_quad8_test.i
#
# This problem is taken from the Abaqus verification manual:
# "1.5.8 Patch test for heat transfer elements"
#
# The temperature on the exterior nodes is -2e5+200x+100y.
#
# This gives a constant flux at all Gauss points.
#
# In addition, the temperature at all nodes follows the same formula.
#
# Node x y Temperature
# 1 1e3 0 0
# 2 1.00024e3 0 48
# 3 1.00018e3 3e-2 39
# 4 1.00004e3 2e-2 10
# 9 1.00008e3 8e-2 24
# 10 1e3 1.2e-1 12
# 14 1.00016e3 8e-2 40
# 17 1.00024e3 1.2e-1 60
[Problem]
coord_type = RZ
[]
[Mesh]#Comment
file = heat_conduction_patch_rz_quad8_test.e
[] # Mesh
[Functions]
[./temps]
type = ParsedFunction
value='-2e5+200*x+100*y'
[../]
[] # Functions
[Variables]
[./temp]
order = SECOND
family = LAGRANGE
[../]
[] # Variables
[Kernels]
[./heat_r]
type = HeatConduction
variable = temp
[../]
[] # Kernels
[BCs]
[./temps]
type = FunctionDirichletBC
variable = temp
boundary = 10
function = temps
[../]
[] # BCs
[Materials]
[./heat]
type = HeatConductionMaterial
block = 1
specific_heat = 0.116
thermal_conductivity = 4.85e-4
[../]
[./density]
type = Density
block = 1
density = 0.283
[../]
[] # Materials
[Executioner]
type = Steady
#Preconditioned JFNK (default)
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -ksp_gmres_restart'
petsc_options_value = 'lu 101'
line_search = 'none'
nl_abs_tol = 1e-11
nl_rel_tol = 1e-10
l_max_its = 20
[./Quadrature]
order = THIRD
[../]
[] # Executioner
[Outputs]
file_base = out_rz_quad8
exodus = true
[] # Outputs
test/tests/mesh_modifiers/add_side_sets_from_bounding_box/error_no_elements_in_bounding_box.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
# This MeshModifier currently only works with ReplicatedMesh.
# For more information, refer to #2129.
parallel_type = replicated
[]
[MeshModifiers]
[./createNewSidesetOne]
type = AddSideSetsFromBoundingBox
boundary_id_old = 'left bottom'
boundary_id_new = 10
bottom_left = '-0.1 -0.1 0'
top_right = '0.8 0.2 0'
block_id = 0
[../]
[./createNewSidesetTwo]
type = AddSideSetsFromBoundingBox
boundary_id_old = 'right top'
boundary_id_new = 11
bottom_left = '1.7 0.7 0'
top_right = '2.1 1.1 0'
block_id = 0
[../]
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./leftBC]
type = DirichletBC
variable = u
boundary = 10
value = 1
[../]
[./rightBC]
type = DirichletBC
variable = u
boundary = 11
value = 0
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
modules/stochastic_tools/test/tests/samplers/monte_carlo/monte_carlo_weibull.i
[Mesh]
type = GeneratedMesh
dim = 1
nx = 1
ny = 1
[]
[Variables]
[./u]
[../]
[]
[Distributions]
[./weibull]
type = BoostWeibullDistribution
scale = 1
shape = 5
[../]
[]
[Samplers]
[./sample]
type = MonteCarloSampler
n_samples = 10
distributions = 'weibull'
execute_on = 'initial timestep_end'
[../]
[]
[VectorPostprocessors]
[./data]
type = SamplerData
sampler = sample
execute_on = 'initial timestep_end'
[../]
[]
[Executioner]
type = Steady
[]
[Problem]
solve = false
kernel_coverage_check = false
[]
[Outputs]
execute_on = 'INITIAL TIMESTEP_END'
csv = true
[]
test/tests/misc/check_error/bad_bc_var_test.i
[Mesh]
file = square.e
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = foo # Test for missing variable
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/materials/material/material_test_dg.i
[Mesh]
file = sq-2blk.e
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = MONOMIAL
[./InitialCondition]
type = ConstantIC
value = 1
[../]
[../]
[]
[Functions]
active = 'forcing_fn exact_fn'
[./forcing_fn]
type = ParsedFunction
value = (x*x*x)-6.0*x
[../]
[./exact_fn]
type = ParsedGradFunction
value = (x*x*x)
grad_x = 3*x*x
grad_y = 0
[../]
[]
[Kernels]
active = 'diff abs forcing'
[./diff]
type = MatDiffusionTest
variable = u
prop_name = matp
[../]
[./abs]
type = Reaction
variable = u
[../]
[./forcing]
type = BodyForce
variable = u
function = forcing_fn
[../]
[]
[DGKernels]
active = 'dgdiff'
[./dgdiff]
type = DGDiffusion
variable = u
sigma = 6
epsilon = -1.0
diff = matp
[../]
[]
[BCs]
active = 'all'
[./all]
type = DGMDDBC
variable = u
boundary = '1 2 3 4'
function = exact_fn
prop_name = matp
sigma = 6
epsilon = -1.0
[../]
[]
[Materials]
active = 'mat_1 mat_2'
[./mat_1]
type = MTMaterial
block = 1
value = 1
[../]
[./mat_2]
type = MTMaterial
block = 2
value = 2
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out_dg
exodus = true
[]
test/tests/interfacekernels/1d_interface/ik_save_in_test.i
[Mesh]
type = GeneratedMesh
dim = 1
nx = 2
xmax = 2
[]
[MeshModifiers]
[./subdomain1]
type = SubdomainBoundingBox
bottom_left = '1.0 0 0'
block_id = 1
top_right = '2.0 1.0 0'
[../]
[./interface]
type = SideSetsBetweenSubdomains
depends_on = subdomain1
master_block = '0'
paired_block = '1'
new_boundary = 'master0_interface'
[../]
[./interface_again]
type = SideSetsBetweenSubdomains
depends_on = subdomain1
master_block = '1'
paired_block = '0'
new_boundary = 'master1_interface'
[../]
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
block = '0'
[../]
[./v]
order = FIRST
family = LAGRANGE
block = '1'
[../]
[]
[AuxVariables]
[./master_resid]
[../]
[./slave_resid]
[../]
[./master_jac]
[../]
[./slave_jac]
[../]
[]
[Kernels]
[./diff_u]
type = CoeffParamDiffusion
variable = u
D = 4
block = 0
save_in = 'master_resid'
[../]
[./diff_v]
type = CoeffParamDiffusion
variable = v
D = 2
block = 1
save_in = 'slave_resid'
[../]
[]
[InterfaceKernels]
[./interface]
type = InterfaceDiffusion
variable = u
neighbor_var = v
boundary = master0_interface
D = 4
D_neighbor = 2
save_in_var_side = 'm s'
save_in = 'master_resid slave_resid'
diag_save_in_var_side = 'm s'
diag_save_in = 'master_jac slave_jac'
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 'left'
value = 0
save_in = 'master_resid'
[../]
[./right]
type = DirichletBC
variable = v
boundary = 'right'
value = 1
save_in = 'slave_resid'
[../]
[./middle]
type = MatchedValueBC
variable = v
boundary = 'master0_interface'
v = u
save_in = 'slave_resid'
[../]
[]
[Preconditioning]
[./smp]
type = SMP
full = true
[../]
[]
[Executioner]
type = Steady
solve_type = NEWTON
[]
[Outputs]
exodus = true
print_linear_residuals = true
[]
[Debug]
show_var_residual_norms = true
[]
test/tests/misc/check_error/subdomain_restricted_kernel_mismatch.i
[Mesh]
file = rectangle.e
[]
[Variables]
active = 'u v'
[./u]
order = FIRST
family = LAGRANGE
[../]
[./v]
order = FIRST
family = LAGRANGE
block = 1
[../]
[]
[Kernels]
active = 'diff body_force'
[./diff]
type = Diffusion
variable = u
[../]
[./body_force]
type = BodyForce
variable = v
block = 2
value = 10
[../]
[]
[BCs]
active = 'right'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 1
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
# petsc_options = '-snes_mf_operator'
# petsc_options_iname = '-pc_type -pc_hypre_type'
# petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/controls/syntax_based_naming_access/param.i
[Mesh]
type = GeneratedMesh
dim = 2
elem_type = QUAD4
# use odd numbers so points do not fall on element boundaries
nx = 31
ny = 31
[]
[Variables]
[./diffused]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = diffused
[../]
[]
[DiracKernels]
[./test_object]
type = MaterialPointSource
point = '0.5 0.5 0'
variable = diffused
[../]
[]
[BCs]
[./bottom_diffused]
type = DirichletBC
variable = diffused
boundary = 'bottom'
value = 2
[../]
[./top_diffused]
type = DirichletBC
variable = diffused
boundary = 'top'
value = 0
[../]
[]
[Materials]
[./mat]
type = GenericConstantMaterial
prop_names = 'matp'
prop_values = '1'
block = 0
[../]
[]
[Postprocessors]
[./test_object]
type = FunctionValuePostprocessor
function = '2*(x+y)'
point = '0.5 0.5 0'
[../]
[./other_point_test_object]
type = FunctionValuePostprocessor
function = '3*(x+y)'
point = '0.5 0.5 0'
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
execute_on = 'timestep_end'
exodus = true
[]
[Controls]
[./point_control]
type = TestControl
test_type = 'point'
parameter = '*/*/point'
execute_on = 'initial'
[../]
[]
modules/richards/test/tests/gravity_head_2/gh03.i
# unsaturated = true
# gravity = false
# supg = true
# transient = false
[Mesh]
type = GeneratedMesh
dim = 1
nx = 20
xmin = 0
xmax = 1
[]
[GlobalParams]
richardsVarNames_UO = PPNames
[]
[UserObjects]
[./PPNames]
type = RichardsVarNames
richards_vars = 'pwater pgas'
[../]
[./DensityWater]
type = RichardsDensityConstBulk
dens0 = 1
bulk_mod = 1.0E2
[../]
[./DensityGas]
type = RichardsDensityConstBulk
dens0 = 0.5
bulk_mod = 0.5E2
[../]
[./SeffWater]
type = RichardsSeff2waterVG
m = 0.8
al = 1
[../]
[./SeffGas]
type = RichardsSeff2gasVG
m = 0.8
al = 1
[../]
[./RelPermWater]
type = RichardsRelPermPower
simm = 0.0
n = 2
[../]
[./RelPermGas]
type = RichardsRelPermPower
simm = 0.0
n = 3
[../]
[./SatWater]
type = RichardsSat
s_res = 0.1
sum_s_res = 0.15
[../]
[./SatGas]
type = RichardsSat
s_res = 0.05
sum_s_res = 0.15
[../]
[./SUPGwater]
type = RichardsSUPGstandard
p_SUPG = 1E-3
[../]
[./SUPGgas]
type = RichardsSUPGstandard
p_SUPG = 1E-3
[../]
[]
[Variables]
[./pwater]
order = FIRST
family = LAGRANGE
[../]
[./pgas]
order = FIRST
family = LAGRANGE
[../]
[]
[ICs]
[./water_ic]
type = RandomIC
min = 0.4
max = 0.6
variable = pwater
[../]
[./gas_ic]
type = RandomIC
min = 1.4
max = 1.6
variable = pgas
[../]
[]
[Kernels]
active = 'richardsfwater richardsfgas'
[./richardstwater]
type = RichardsMassChange
variable = pwater
[../]
[./richardsfwater]
type = RichardsFlux
variable = pwater
[../]
[./richardstgas]
type = RichardsMassChange
variable = pgas
[../]
[./richardsfgas]
type = RichardsFlux
variable = pgas
[../]
[]
[AuxVariables]
[./seffgas]
[../]
[./seffwater]
[../]
[]
[AuxKernels]
[./seffgas_kernel]
type = RichardsSeffAux
pressure_vars = 'pwater pgas'
seff_UO = SeffGas
variable = seffgas
[../]
[./seffwater_kernel]
type = RichardsSeffAux
pressure_vars = 'pwater pgas'
seff_UO = SeffWater
variable = seffwater
[../]
[]
[Postprocessors]
[./mwater_init]
type = RichardsMass
variable = pwater
execute_on = timestep_begin
outputs = none
[../]
[./mgas_init]
type = RichardsMass
variable = pgas
execute_on = timestep_begin
outputs = none
[../]
[./mwater_fin]
type = RichardsMass
variable = pwater
execute_on = timestep_end
outputs = none
[../]
[./mgas_fin]
type = RichardsMass
variable = pgas
execute_on = timestep_end
outputs = none
[../]
[./mass_error_water]
type = FunctionValuePostprocessor
function = fcn_mass_error_w
outputs = none # no reason why mass should be conserved
[../]
[./mass_error_gas]
type = FunctionValuePostprocessor
function = fcn_mass_error_g
outputs = none # no reason why mass should be conserved
[../]
[./pw_left]
type = PointValue
point = '0 0 0'
variable = pwater
outputs = none
[../]
[./pw_right]
type = PointValue
point = '1 0 0'
variable = pwater
outputs = none
[../]
[./error_water]
type = FunctionValuePostprocessor
function = fcn_error_water
[../]
[./pg_left]
type = PointValue
point = '0 0 0'
variable = pgas
outputs = none
[../]
[./pg_right]
type = PointValue
point = '1 0 0'
variable = pgas
outputs = none
[../]
[./error_gas]
type = FunctionValuePostprocessor
function = fcn_error_gas
[../]
[]
[Functions]
[./fcn_mass_error_w]
type = ParsedFunction
value = 'abs(0.5*(mi-mf)/(mi+mf))'
vars = 'mi mf'
vals = 'mwater_init mwater_fin'
[../]
[./fcn_mass_error_g]
type = ParsedFunction
value = 'abs(0.5*(mi-mf)/(mi+mf))'
vars = 'mi mf'
vals = 'mgas_init mgas_fin'
[../]
[./fcn_error_water]
type = ParsedFunction
value = 'abs((p0-p1)/p1)'
vars = 'b gdens0 p0 xval p1'
vals = '1E2 -1 pw_left 1 pw_right'
[../]
[./fcn_error_gas]
type = ParsedFunction
value = 'abs((p0-p1)/p1)'
vars = 'b gdens0 p0 xval p1'
vals = '0.5E2 -0.5 pg_left 1 pg_right'
[../]
[]
[Materials]
[./rock]
type = RichardsMaterial
block = 0
mat_porosity = 0.1
mat_permeability = '1E-5 0 0 0 1E-5 0 0 0 1E-5'
density_UO = 'DensityWater DensityGas'
relperm_UO = 'RelPermWater RelPermGas'
SUPG_UO = 'SUPGwater SUPGgas'
sat_UO = 'SatWater SatGas'
seff_UO = 'SeffWater SeffGas'
viscosity = '1E-3 0.5E-3'
gravity = '0 0 0'
linear_shape_fcns = true
[../]
[]
[Preconditioning]
[./andy]
type = SMP
full = true
petsc_options_iname = '-pc_factor_shift_type'
petsc_options_value = 'nonzero'
[../]
[]
[Executioner]
type = Steady
solve_type = Newton
[]
[Outputs]
execute_on = 'timestep_end'
file_base = gh03
csv = true
[]
modules/functional_expansion_tools/test/tests/errors/aux_bad_function.i
[Mesh]
type = GeneratedMesh
dim = 1
[]
[AuxVariables]
[./v]
[../]
[]
[AuxKernels]
[./this_could_be_bad]
type = FunctionSeriesToAux
function = const
variable = v
[../]
[]
[Functions]
[./const]
type = ConstantFunction
value = -1
[../]
[]
[Executioner]
type = Steady
[]
[Problem]
solve = false
[]
test/tests/misc/check_error/missing_req_par_moose_obj_test.i
[Mesh]
file = square.e
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff'
# Test missing required param (type in this case)
[./diff]
variable = u
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/materials/boundary_material/bnd_coupling_vol.i
#
# Coupling volumetric material property inside boundary restricted material
# Also bringing boundary restricted material inside another boundary restricted
# material
#
# Solving: k \Laplace u + u - f = 0
#
# u = x^2 + y^2
# k = 3, but is decomposed as k3vol = k1vol + k2vol, where k1vol = 1 and k2vol = 2
#
# Boundary material property is computed as k3bnd = k1vol + k2bnd
#
# The material properties with suffix `vol` are volumetric, the ones with suffix `bnd`
# are boundary restricted
#
[Mesh]
type = GeneratedMesh
dim = 2
xmin = 0
xmax = 1
ymin = 0
ymax = 1
nx = 4
ny = 4
elem_type = QUAD9
[]
[Functions]
[./exact_fn]
type = ParsedFunction
value = x*x+y*y
[../]
[./f_fn]
type = ParsedFunction
value = -4*3+x*x+y*y
[../]
[]
[Variables]
[./u]
family = LAGRANGE
order = SECOND
[../]
[]
[Kernels]
[./diff]
type = DiffMKernel
variable = u
offset = 0
mat_prop = k3vol
[../]
[./r]
type = Reaction
variable = u
[../]
[./ffn]
type = BodyForce
variable = u
function = f_fn
[../]
[]
[BCs]
[./all]
type = MatDivergenceBC
variable = u
prop_name = k3bnd
boundary = 'left right top bottom'
[../]
[]
[Materials]
[./k1vol]
type = GenericConstantMaterial
prop_names = 'k1vol'
prop_values = 1
block = 0
[../]
[./k2vol]
type = GenericConstantMaterial
prop_names = 'k2vol'
prop_values = 2
block = 0
[../]
[./k2bnd]
type = GenericConstantMaterial
prop_names = 'k2bnd'
prop_values = 2
boundary = 'left right top bottom'
[../]
[./k3vol]
type = SumMaterial
sum_prop_name = k3vol
mp1 = k1vol
mp2 = k2vol
block = 0
val1 = 1
val2 = 2
[../]
[./k3bnd]
type = SumMaterial
sum_prop_name = 'k3bnd'
mp1 = k1vol
mp2 = k2bnd
boundary = 'left right top bottom'
val1 = 1
val2 = 2
[../]
[]
[Postprocessors]
[./l2err]
type = ElementL2Error
variable = u
function = exact_fn
[../]
[]
[Executioner]
type = Steady
solve_type = NEWTON
petsc_options_iname = '-pc_type'
petsc_options_value = 'lu'
[]
[Outputs]
execute_on = 'timestep_end'
exodus = true
[]
tutorials/darcy_thermo_mech/step03_darcy_material/tests/kernels/darcy_pressure/darcy_pressure.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 100
ny = 10
xmax = 0.304 # Length of test chamber
ymax = 0.0257 # Test chamber radius
[]
[Variables]
[./pressure]
[../]
[]
[Kernels]
[./darcy_pressure]
type = DarcyPressure
variable = pressure
[../]
[]
[BCs]
[./inlet]
type = DirichletBC
variable = pressure
boundary = left
value = 4000 # (Pa) From Figure 2 from paper. First dot for 1mm spheres.
[../]
[./outlet]
type = DirichletBC
variable = pressure
boundary = right
value = 0 # (Pa) Gives the correct pressure drop from Figure 2 for 1mm spheres
[../]
[]
[Materials]
[./pressure]
type = GenericConstantMaterial
prop_values = '0.8451e-9 7.98e-4'
prop_names = 'permeability viscosity'
[../]
[]
[Problem]
type = FEProblem
coord_type = RZ
rz_coord_axis = X
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/kernels/jxw_grad_test_dep_on_displacements/jxw-cylindrical.i
[GlobalParams]
displacements = 'disp_r disp_z'
order = SECOND
[]
[Mesh]
type = GeneratedMesh
dim = 2
nx = 3
ny = 3
elem_type = QUAD9
[]
[Problem]
coord_type = RZ
[]
[Variables]
[./disp_r]
[../]
[./disp_z]
[../]
[./u]
order = FIRST
[../]
[./v]
[../]
[]
[Kernels]
[./disp_r]
type = Diffusion
variable = disp_r
[../]
[./disp_z]
type = Diffusion
variable = disp_z
[../]
[]
[ADKernels]
[./u]
type = ADDiffusion
variable = u
use_displaced_mesh = true
[../]
[./v]
type = ADDiffusion
variable = v
use_displaced_mesh = true
[../]
[]
[BCs]
[./u_left]
type = DirichletBC
value = 0
boundary = 'left'
variable = u
[../]
[./u_right]
type = DirichletBC
value = 1
boundary = 'right'
variable = u
[../]
[./v_left]
type = DirichletBC
value = 0
boundary = 'left'
variable = v
[../]
[./v_right]
type = DirichletBC
value = 1
boundary = 'right'
variable = v
[../]
[./disp_r_left]
type = DirichletBC
value = 0
boundary = 'left'
variable = disp_r
[../]
[./disp_r_right]
type = DirichletBC
value = 1
boundary = 'right'
variable = disp_r
[../]
[./disp_z_left]
type = DirichletBC
value = 0
boundary = 'bottom'
variable = disp_z
[../]
[./disp_z_right]
type = DirichletBC
value = 1
boundary = 'top'
variable = disp_z
[../]
[]
[Preconditioning]
[./smp]
type = SMP
full = true
[../]
[]
[Executioner]
type = Steady
solve_type = NEWTON
[]
[Outputs]
[./dofmap]
type = DOFMap
execute_on = 'initial'
[../]
exodus = true
[]
[ICs]
[./disp_r]
type = RandomIC
variable = disp_r
min = 0.01
max = 0.09
[../]
[./disp_z]
type = RandomIC
variable = disp_z
min = 0.01
max = 0.09
[../]
[./u]
type = RandomIC
variable = u
min = 0.1
max = 0.9
[../]
[./v]
type = RandomIC
variable = v
min = 0.1
max = 0.9
[../]
[]
test/tests/meshgenerators/centroid_partitioner/centroid_partitioner_mg.i
[MeshGenerators]
[./gmg]
type = GeneratedMeshGenerator
dim = 2
nx = 10
ny = 100
xmin = 0.0
xmax = 1.0
ymin = 0.0
ymax = 10.0
# The centroid partitioner orders elements based on
# the position of their centroids
partitioner = centroid
# This will order the elements based on the y value of
# their centroid. Perfect for meshes predominantly in
# one direction
centroid_partitioner_direction = y
# The centroid partitioner behaves differently depending on
# whether you are using Serial or DistributedMesh, so to get
# repeatable results, we restrict this test to using ReplicatedMesh.
parallel_type = replicated
[]
[]
[Mesh]
type = MeshGeneratorMesh
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxVariables]
[./proc_id]
order = CONSTANT
family = MONOMIAL
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[AuxKernels]
[./proc_id]
type = ProcessorIDAux
variable = proc_id
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 3
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 1
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out
[./exodus]
type = Exodus
elemental_as_nodal = true
[../]
[]
test/tests/vectorpostprocessors/nodal_value_sampler/nodal_value_sampler.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[./v]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[./diff_v]
type = Diffusion
variable = v
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[./left_v]
type = DirichletBC
variable = v
boundary = left
value = 1
[../]
[./right_v]
type = DirichletBC
variable = v
boundary = right
value = 0
[../]
[]
[VectorPostprocessors]
[./nodal_sample]
type = NodalValueSampler
variable = 'u v'
boundary = top
sort_by = x
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
execute_on = 'timestep_end'
csv = true
[]
test/tests/auxkernels/normalization_aux/normalization_aux.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
initial_condition = 1.0
[../]
[]
[AuxVariables]
[./u_normalized]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff_u]
type = Diffusion
variable = u
[../]
[]
[AuxKernels]
[./normalization_auxkernel]
type = NormalizationAux
variable = u_normalized
source_variable = u
normal_factor = 2.0
execute_on = timestep_end
# Note: 'normalization' or 'shift' are provided as CLI args
[../]
[]
[BCs]
[./left_u]
type = DirichletBC
variable = u
boundary = left
value = 1
[../]
[./right_u]
type = DirichletBC
variable = u
boundary = right
value = 2
[../]
[]
[Executioner]
type = Steady
[]
[Postprocessors]
[./unorm]
type = ElementIntegralVariablePostprocessor
variable = u
execute_on = 'initial timestep_end'
[../]
[./u_normalized_norm]
type = ElementIntegralVariablePostprocessor
variable = u_normalized
execute_on = 'initial timestep_end'
[../]
[./u0]
type = PointValue
variable = u
point = '0 0 0'
execute_on = 'initial timestep_end'
[../]
[]
[Outputs]
exodus = true
[]
test/tests/misc/check_error/checked_pointer_param_test.i
# The extra 'x' before the Mesh section below is intentional.
# We want to catch this type of error.
x[Mesh]
file = square.e
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/postprocessors/volume/sphere1D.i
# The volume of each block should be 3
[Mesh]#Comment
file = sphere1D.e
[] # Mesh
[Problem]
coord_type = RSPHERICAL
[]
[Functions]
[./fred]
type = ParsedFunction
value='200'
[../]
[] # Functions
[AuxVariables]
[./constantVar]
order = FIRST
family = LAGRANGE
[../]
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
initial_condition = 100
[../]
[] # Variables
[AuxKernels]
[./fred]
type = ConstantAux
variable = constantVar
block = 1
value = 1
[../]
[]
[ICs]
[./ic1]
type = ConstantIC
variable = constantVar
value = 1
block = 1
[../]
[]
[Kernels]
[./heat_r]
type = Diffusion
variable = u
[../]
[] # Kernels
[BCs]
[./temps]
type = FunctionDirichletBC
variable = u
boundary = 1
function = fred
[../]
[] # BCs
[Materials]
[] # Materials
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -snes_ls -ksp_gmres_restart'
petsc_options_value = 'lu basic 101'
line_search = 'none'
nl_abs_tol = 1e-11
nl_rel_tol = 1e-10
l_max_its = 20
[] # Executioner
[Postprocessors]
[./should_be_one]
type = ElementAverageValue
block = 1
variable = constantVar
execute_on = 'initial timestep_end'
[../]
[./volume1]
type = VolumePostprocessor
block = 1
execute_on = 'initial timestep_end'
[../]
[./volume2]
type = VolumePostprocessor
block = 2
execute_on = 'initial timestep_end'
[../]
[./volume3]
type = VolumePostprocessor
block = 3
execute_on = 'initial timestep_end'
[../]
[]
[Outputs]
exodus = true
[] # Output
test/tests/restrictable/undefined_ids/undefined_block_kernel.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[./kernel_with_undefined_block]
type = Diffusion
variable = u
block = 10
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/materials/material/coupled_material_test.i
[Mesh]
type = GeneratedMesh
dim = 2
xmin = 0
xmax = 1
ymin = 0
ymax = 1
nx = 10
ny = 10
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff]
type = MatDiffusionTest
variable = u
prop_name = mp1
[../]
[./conv]
type = MatConvection
variable = u
x = 1
y = 0
mat_prop = some_prop
[../]
[]
[BCs]
[./right]
type = NeumannBC
variable = u
boundary = 1
value = 1
[../]
[./left]
type = DirichletBC
variable = u
boundary = 3
value = 0
[../]
[]
[Materials]
# order is switched intentionally, so we won't get luck and dep-resolver has to do its job
[./mat2]
type = CoupledMaterial
block = 0
mat_prop = 'some_prop'
coupled_mat_prop = 'mp1'
[../]
[./mat1]
type = GenericConstantMaterial
block = 0
prop_names = 'mp1'
prop_values = '2'
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out_coupled
exodus = true
[]
modules/combined/test/tests/linear_elasticity/linear_elastic_material.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
nz = 0
xmin = 0
xmax = 50
ymin = 0
ymax = 50
zmin = 0
zmax = 0
elem_type = QUAD4
[]
[GlobalParams]
displacements = 'disp_x disp_y'
[]
[Variables]
[./diffused]
[./InitialCondition]
type = RandomIC
[../]
[../]
[./disp_x]
[../]
[./disp_y]
[../]
[]
[Modules/TensorMechanics/Master/All]
strain = SMALL
add_variables = true
generate_output = 'stress_xx stress_yy stress_zz stress_xy stress_yz stress_zx'
[]
[Kernels]
[./diff]
type = Diffusion
variable = diffused
[../]
[]
[Materials]
[./elasticity_tensor]
type = ComputeElasticityTensor
fill_method = symmetric9
#reading C_11 C_12 C_13 C_22 C_23 C_33 C_44 C_55 C_66
C_ijkl ='1.0e6 0.0 0.0 1.0e6 0.0 1.0e6 0.5e6 0.5e6 0.5e6'
[../]
[./stress]
type = ComputeLinearElasticStress
[../]
[]
[BCs]
[./bottom]
type = PresetBC
variable = diffused
boundary = '1'
value = 1
[../]
[./top]
type = PresetBC
variable = diffused
boundary = '2'
value = 0
[../]
[./disp_x_BC]
type = PresetBC
variable = disp_x
boundary = '0 2'
value = 0.5
[../]
[./disp_x_BC2]
type = PresetBC
variable = disp_x
boundary = '1 3'
value = 0.01
[../]
[./disp_y_BC]
type = PresetBC
variable = disp_y
boundary = '0 2'
value = 0.8
[../]
[./disp_y_BC2]
type = PresetBC
variable = disp_y
boundary = '1 3'
value = 0.02
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
nl_rel_tol = 1e-12
[]
[Outputs]
exodus = true
[]
test/tests/bcs/coupled_dirichlet_bc/coupled_dirichlet_bc.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[./v]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff_u]
type = Diffusion
variable = u
[../]
[./coupled_force_u]
type = CoupledForce
variable = u
v = v
[../]
[./diff_v]
type = Diffusion
variable = v
[../]
[]
[BCs]
# BCs on left
# u: u=1
# v: v=2
[./left_u]
type = DirichletBC
variable = u
boundary = 3
value = 1
[../]
[./left_v]
type = DirichletBC
variable = v
boundary = 3
value = 2
[../]
# BCs on right
# u: c*u + u^2 + v^2 = 9
# v: no flux
[./right_u]
type = CoupledDirichletBC
variable = u
boundary = 1
value = 9
v=v
[../]
[]
[Preconditioning]
[./precond]
type = SMP
# 'full = true' is required for computeOffDiagJacobian() to get
# called. If you comment this out, you should see that this test
# requires a different number of linear and nonlinear iterations.
full = true
[../]
[]
[Executioner]
type = Steady
# solve_type = 'PJFNK'
solve_type = 'NEWTON'
# Uncomment next line to disable line search. With line search enabled, you must use full=true with Newton or else it will fail.
# line_search = 'none'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
nl_rel_tol = 1e-10
l_tol = 1e-12
nl_max_its = 10
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/postprocessors/all_print_pps/all_print_pps_test.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 5
ny = 5
xmin = 0
xmax = 2
ymin = 0
ymax = 2
# Since this test prints the number of residual evaluations, its
# output strongly depends on the number of processors you run it on,
# and, apparently, the type of Mesh. To reduce this variability, we
# limit it to run with ReplicatedMesh only.
parallel_type = replicated
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 3
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 1
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'NEWTON'
[]
[Postprocessors]
[./nodes]
type = NumNodes
execute_on = 'initial timestep_end'
[../]
[./elements]
type = NumElems
execute_on = 'initial timestep_end'
[../]
[./dofs]
type = NumDOFs
execute_on = 'initial timestep_end'
[../]
[./residuals]
type = NumResidualEvaluations
execute_on = 'initial timestep_end'
[../]
[]
[Outputs]
file_base = out
exodus = false
csv = true
[]
test/tests/userobjects/element_quality_check/failure_error.i
[Mesh]
file = Quad.e
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./bottom]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./top]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[UserObjects]
[./elem_quality_check]
type = ElementQualityChecker
metric_type = STRETCH
failure_type = ERROR
upper_bound = 1.0
lower_bound = 0.5
[../]
[]
[Executioner]
type = Steady
[]
[Outputs]
exodus = true
[]
test/tests/userobjects/shape_element_user_object/shape_side_uo_jac_test.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
parallel_type = replicated
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[./pot]
[../]
[]
[Kernels]
[]
[BCs]
[./left_pot]
boundary = left
type = ExampleShapeSideIntegratedBC
variable = pot
num_user_object = num_user_object
denom_user_object = denom_user_object
v = u
Vb = 1
[../]
[]
[UserObjects]
[./num_user_object]
type = NumShapeSideUserObject
u = u
boundary = left
execute_on = 'linear nonlinear'
[../]
[./denom_user_object]
type = DenomShapeSideUserObject
u = u
boundary = left
execute_on = 'linear nonlinear'
[../]
[]
[Problem]
type = FEProblem
kernel_coverage_check = false
[]
[Preconditioning]
[./smp]
type = SMP
full = true
[../]
[]
[Executioner]
type = Steady
solve_type = NEWTON
petsc_options = '-snes_test_display'
petsc_options_iname = '-snes_type'
petsc_options_value = 'test'
[]
[Outputs]
exodus = true
perf_graph = true
[]
[ICs]
[./u]
type = RandomIC
variable = u
[../]
[./pot]
type = RandomIC
variable = pot
[../]
[]
test/tests/meshgenerators/subdomain_bounding_box_generator/oriented_subdomain_bounding_box_generator.i
[MeshGenerators]
[./gmg]
type = GeneratedMeshGenerator
dim = 3
xmin = -6
xmax = 4
nx = 10
ymin = -2
ymax = 10
ny = 12
zmin = -5
zmax = 7
nz = 12
[]
[./subdomains]
type = OrientedSubdomainBoundingBoxGenerator
input = gmg
center = '-1 4 1'
width = 5
length = 10
height = 4
width_direction = '2 1 0'
length_direction = '-1 2 2'
block_id = 10
[]
[]
[Mesh]
type = MeshGeneratorMesh
[]
[Problem]
type = FEProblem
solve = false
kernel_coverage_check = false
[]
[Variables]
[./u]
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
[]
[Outputs]
exodus = true
[]
test/tests/dirackernels/point_caching/point_caching.i
[Mesh]
type = GeneratedMesh
dim = 2
xmin = 0
xmax = 1
ymin = 0
ymax = 1
nx = 2
ny = 2
elem_type = QUAD4
uniform_refine = 4
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[DiracKernels]
active = 'point_source'
[./point_source]
type = CachingPointSource
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 3
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 1
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
exodus = true
[]
modules/porous_flow/test/tests/poroperm/PermFromPoro01.i
# Testing permeability from porosity
# Trivial test, checking calculated permeability is correct
# k = k_anisotropic * f * d^2 * phi^n / (1-phi)^m
[Mesh]
type = GeneratedMesh
dim = 1
nx = 3
xmin = 0
xmax = 3
[]
[GlobalParams]
block = 0
PorousFlowDictator = dictator
[]
[Variables]
[./pp]
[./InitialCondition]
type = ConstantIC
value = 0
[../]
[../]
[]
[Kernels]
[./flux]
type = PorousFlowAdvectiveFlux
gravity = '0 0 0'
variable = pp
[../]
[]
[BCs]
[./ptop]
type = PresetBC
variable = pp
boundary = right
value = 0
[../]
[./pbase]
type = PresetBC
variable = pp
boundary = left
value = 1
[../]
[]
[AuxVariables]
[./poro]
order = CONSTANT
family = MONOMIAL
[../]
[./perm_x]
order = CONSTANT
family = MONOMIAL
[../]
[./perm_y]
order = CONSTANT
family = MONOMIAL
[../]
[./perm_z]
order = CONSTANT
family = MONOMIAL
[../]
[]
[AuxKernels]
[./poro]
type = MaterialRealAux
property = PorousFlow_porosity_qp
variable = poro
[../]
[./perm_x]
type = MaterialRealTensorValueAux
property = PorousFlow_permeability_qp
variable = perm_x
row = 0
column = 0
[../]
[./perm_y]
type = MaterialRealTensorValueAux
property = PorousFlow_permeability_qp
variable = perm_y
row = 1
column = 1
[../]
[./perm_z]
type = MaterialRealTensorValueAux
property = PorousFlow_permeability_qp
variable = perm_z
row = 2
column = 2
[../]
[]
[Postprocessors]
[./perm_x_bottom]
type = PointValue
variable = perm_x
point = '0 0 0'
[../]
[./perm_y_bottom]
type = PointValue
variable = perm_y
point = '0 0 0'
[../]
[./perm_z_bottom]
type = PointValue
variable = perm_z
point = '0 0 0'
[../]
[./perm_x_top]
type = PointValue
variable = perm_x
point = '3 0 0'
[../]
[./perm_y_top]
type = PointValue
variable = perm_y
point = '3 0 0'
[../]
[./perm_z_top]
type = PointValue
variable = perm_z
point = '3 0 0'
[../]
[]
[UserObjects]
[./dictator]
type = PorousFlowDictator
porous_flow_vars = 'pp'
number_fluid_phases = 1
number_fluid_components = 1
[../]
[./pc]
type = PorousFlowCapillaryPressureVG
# unimportant in this fully-saturated test
m = 0.8
alpha = 1e-4
[../]
[]
[Modules]
[./FluidProperties]
[./simple_fluid]
type = SimpleFluidProperties
bulk_modulus = 2.2e9
viscosity = 1e-3
density0 = 1000
thermal_expansion = 0
[../]
[../]
[]
[Materials]
[./permeability]
type = PorousFlowPermeabilityKozenyCarman
k_anisotropy = '1 0 0 0 2 0 0 0 0.1'
poroperm_function = kozeny_carman_fd2
f = 0.1
d = 5
m = 2
n = 7
[../]
[./temperature]
type = PorousFlowTemperature
[../]
[./massfrac]
type = PorousFlowMassFraction
[../]
[./eff_fluid_pressure]
type = PorousFlowEffectiveFluidPressure
[../]
[./ppss]
type = PorousFlow1PhaseP
porepressure = pp
capillary_pressure = pc
[../]
[./simple_fluid]
type = PorousFlowSingleComponentFluid
fp = simple_fluid
phase = 0
[../]
[./porosity]
type = PorousFlowPorosity
porosity_zero = 0.1
[../]
[./relperm]
type = PorousFlowRelativePermeabilityCorey
n = 0 # unimportant in this fully-saturated situation
phase = 0
[../]
[]
[Preconditioning]
[./andy]
type = SMP
full = true
[../]
[]
[Executioner]
solve_type = Newton
type = Steady
l_tol = 1E-5
nl_abs_tol = 1E-3
nl_rel_tol = 1E-8
l_max_its = 200
nl_max_its = 400
petsc_options_iname = '-pc_type -pc_asm_overlap -sub_pc_type -ksp_type -ksp_gmres_restart'
petsc_options_value = ' asm 2 lu gmres 200'
[]
[Outputs]
csv = true
execute_on = 'timestep_end'
[]
modules/stochastic_tools/test/tests/multiapps/commandline_control/master_wrong_size.i
[Mesh]
type = GeneratedMesh
dim = 1
[]
[Problem]
type = FEProblem
solve = false
[]
[Executioner]
type = Steady
[]
[MultiApps]
[sub]
type = FullSolveMultiApp
positions = '0 0 0
1 1 1'
input_files = 'sub.i'
[]
[]
[Distributions]
[./uniform]
type = UniformDistribution
lower_bound = 5
upper_bound = 10
[../]
[]
[Samplers]
[./sample]
type = MonteCarloSampler
n_samples = 10
distributions = 'uniform'
execute_on = 'initial timestep_end'
[../]
[]
[Controls]
[cmdline]
type = MultiAppCommandLineControl
multi_app = sub
sampler = sample
arguments = 'Mesh/nx'
[]
[]
test/tests/outputs/debug/show_top_residuals_debug.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
block_id = '0 1'
block_name = 'block_zero block_one'
[]
[MeshModifiers]
[./subdomain_id]
type = AssignSubdomainID
subdomain_id = 1
[../]
[]
[Variables]
[./u]
family = LAGRANGE
order = FIRST
[../]
[./v]
family = MONOMIAL
order = CONSTANT
[../]
[./w]
family = SCALAR
order = FIRST
[../]
[]
[Kernels]
[./u_kernel]
type = Diffusion
variable = u
[../]
[./v_kernel]
type = Diffusion
variable = v
[../]
[]
[BCs]
[./u_bc]
type = DirichletBC
variable = u
value = 100
boundary = left
[../]
[./v_bc]
type = NeumannBC
variable = v
value = 100
boundary = left
[../]
[]
[ScalarKernels]
[./w_kernel]
type = AlphaCED
variable = w
value = 100
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
# For this test, we don't actually want the solution to converge because we
# want nonzero nonlinear residual entries at the end of the time step.
nl_abs_tol = 0.999
nl_rel_tol = 0.999
l_max_its = 1
petsc_options_iname = '-pc_type'
petsc_options_value = 'none'
[]
[Debug]
show_top_residuals = 10
[]
test/tests/auxkernels/error_function_aux/error_function_aux.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 20
ny = 20
[]
[Variables]
[./u]
[../]
[]
[AuxVariables]
[./element_l2_error]
# Aux field variable representing the L2 error on each element
order = CONSTANT
family = MONOMIAL
[../]
[./element_h1_error]
# Aux field variable representing the H1 error on each element
order = CONSTANT
family = MONOMIAL
[../]
[./element_l2_norm]
# Aux field variable representing the L^2 norm of the solution variable
order = CONSTANT
family = MONOMIAL
[../]
[]
[Functions]
[./exact_fn]
type = ParsedFunction
value = sin(2*pi*x)*sin(2*pi*y)
[../]
[./forcing_fn]
type = ParsedFunction
value = 8*pi^2*sin(2*pi*x)*sin(2*pi*y)
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[./ffn]
type = BodyForce
variable = u
function = forcing_fn
[../]
[]
[AuxKernels]
[./l2_norm_aux]
type = ElementLpNormAux
variable = element_l2_norm
coupled_variable = u
[../]
[./l2_error_aux]
type = ElementL2ErrorFunctionAux
variable = element_l2_error
# A function representing the exact solution for the solution
function = exact_fn
# The nonlinear variable representing the FEM solution
coupled_variable = u
[../]
[./h1_error_aux]
type = ElementH1ErrorFunctionAux
variable = element_h1_error
# A function representing the exact solution for the solution
function = exact_fn
# The nonlinear variable representing the FEM solution
coupled_variable = u
[../]
[]
[BCs]
[./all]
type = FunctionDirichletBC
variable = u
boundary = 'bottom left right top'
function = exact_fn
[../]
[]
[Postprocessors]
[./L2_error]
# The L2 norm of the error over the entire mesh. Note: this is
# *not* equal to the sum over all the elements of the L2-error
# norms.
type = ElementL2Error
variable = u
function = exact_fn
[../]
[]
[Executioner]
type = Steady
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
modules/porous_flow/test/tests/capillary_pressure/brooks_corey2.i
# Test Brooks-Corey capillary pressure curve by varying saturation over the mesh
# lambda = 2, sat_lr = 0.1, log_extension = true
[Mesh]
type = GeneratedMesh
dim = 1
nx = 500
[]
[GlobalParams]
PorousFlowDictator = dictator
[]
[Variables]
[./p0]
initial_condition = 1e6
[../]
[./s1]
[../]
[]
[AuxVariables]
[./s0aux]
family = MONOMIAL
order = CONSTANT
[../]
[./s1aux]
family = MONOMIAL
order = CONSTANT
[../]
[./p0aux]
family = MONOMIAL
order = CONSTANT
[../]
[./p1aux]
family = MONOMIAL
order = CONSTANT
[../]
[]
[AuxKernels]
[./s0]
type = PorousFlowPropertyAux
property = saturation
phase = 0
variable = s0aux
[../]
[./s1]
type = PorousFlowPropertyAux
property = saturation
phase = 1
variable = s1aux
[../]
[./p0]
type = PorousFlowPropertyAux
property = pressure
phase = 0
variable = p0aux
[../]
[./p1]
type = PorousFlowPropertyAux
property = pressure
phase = 1
variable = p1aux
[../]
[]
[Functions]
[./s1]
type = ParsedFunction
value = x
[../]
[]
[ICs]
[./s1]
type = FunctionIC
variable = s1
function = s1
[../]
[]
[Kernels]
[./p0]
type = Diffusion
variable = p0
[../]
[./s1]
type = Diffusion
variable = s1
[../]
[]
[UserObjects]
[./dictator]
type = PorousFlowDictator
porous_flow_vars = 'p0 s1'
number_fluid_phases = 2
number_fluid_components = 2
[../]
[./pc]
type = PorousFlowCapillaryPressureBC
lambda = 2
log_extension = true
pe = 1e5
sat_lr = 0.1
[../]
[]
[Materials]
[./temperature]
type = PorousFlowTemperature
[../]
[./ppss]
type = PorousFlow2PhasePS
phase0_porepressure = p0
phase1_saturation = s1
capillary_pressure = pc
[../]
[./kr0]
type = PorousFlowRelativePermeabilityVG
phase = 0
m = 0.5
[../]
[./kr1]
type = PorousFlowRelativePermeabilityCorey
phase = 1
n = 2
[../]
[]
[VectorPostprocessors]
[./vpp]
type = LineValueSampler
variable = 's0aux s1aux p0aux p1aux'
start_point = '0 0 0'
end_point = '1 0 0'
num_points = 500
sort_by = id
[../]
[]
[Executioner]
type = Steady
solve_type = NEWTON
nl_abs_tol = 1e-6
[]
[BCs]
[./sleft]
type = DirichletBC
variable = s1
value = 0
boundary = left
[../]
[./sright]
type = DirichletBC
variable = s1
value = 1
boundary = right
[../]
[]
[Outputs]
csv = true
execute_on = timestep_end
[]
modules/richards/test/tests/darcy/jac.i
# Test to show that DarcyFlux produces the correct jacobian
[GlobalParams]
variable = pressure
fluid_weight = '0 0 -1.5'
fluid_viscosity = 1
[]
[Mesh]
type = GeneratedMesh
dim = 3
nx = 1
ny = 1
nz = 1
[]
[Variables]
[./pressure]
[./InitialCondition]
type = RandomIC
block = 0
min = 0
max = 1
[../]
[../]
[]
[Kernels]
[./darcy]
type = DarcyFlux
variable = pressure
[../]
[]
[Materials]
[./solid]
type = DarcyMaterial
block = 0
mat_permeability = '1 0 0 0 2 0 0 0 3'
[../]
[]
[Preconditioning]
[./andy]
type = SMP
full = true
petsc_options_iname = '-snes_type'
petsc_options_value = 'test'
[../]
[]
[Executioner]
type = Steady
solve_type = Newton
[]
[Outputs]
execute_on = 'timestep_end'
file_base = jac
exodus = false
[]
test/tests/markers/error_fraction_marker/error_fraction_marker_no_clear_test.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
nz = 10
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Functions]
[./solution]
type = ParsedFunction
value = (exp(x)-1)/(exp(1)-1)
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[./conv]
type = Convection
variable = u
velocity = '1 0 0'
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Adaptivity]
steps = 2
marker = marker
[./Indicators]
[./error]
type = AnalyticalIndicator
variable = u
function = solution
[../]
[../]
[./Markers]
[./marker]
type = ErrorFractionMarker
indicator = error
refine = 0.3
clear_extremes = false
[../]
[../]
[]
[Outputs]
exodus = true
[]
test/tests/userobjects/element_quality_check/bypass_warning.i
[Mesh]
file = Quad.e
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./bottom]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./top]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[UserObjects]
[./elem_quality_check]
type = ElementQualityChecker
metric_type = DIAGONAL
failure_type = WARNING
[../]
[]
[Executioner]
type = Steady
[]
[Outputs]
exodus = true
[]
examples/ex19_dampers/ex19.i
[Mesh]
type = GeneratedMesh
dim = 2
xmin = 0.0
xmax = 1.0
nx = 10
ymin = 0.0
ymax = 1.0
ny = 10
[]
[Variables]
[./diffusion]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = diffusion
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = diffusion
boundary = 3
value = 3
[../]
[./right]
type = DirichletBC
variable = diffusion
boundary = 1
value = 1
[../]
[]
[Dampers]
# Use a constant damping parameter
[./diffusion_damp]
type = ConstantDamper
variable = diffusion
damping = 0.9
[../]
[]
[Executioner]
type = Steady
#Preconditioned JFNK (default)
solve_type = 'PJFNK'
[]
[Outputs]
exodus = true
[]
modules/richards/test/tests/gravity_head_1/gh04.i
# unsaturated = true
# gravity = true
# supg = false
# transient = false
[Mesh]
type = GeneratedMesh
dim = 1
nx = 1
xmin = -1
xmax = 1
[]
[BCs]
[./left]
type = DirichletBC
boundary = left
value = -1
variable = pressure
[../]
[]
[GlobalParams]
richardsVarNames_UO = PPNames
[]
[UserObjects]
[./PPNames]
type = RichardsVarNames
richards_vars = pressure
[../]
[./DensityConstBulk]
type = RichardsDensityConstBulk
dens0 = 1
bulk_mod = 1.0E3
[../]
[./SeffVG]
type = RichardsSeff1VG
m = 0.8
al = 1
[../]
[./RelPermPower]
type = RichardsRelPermPower
simm = 0.0
n = 2
[../]
[./Saturation]
type = RichardsSat
s_res = 0.1
sum_s_res = 0.1
[../]
[./SUPGnone]
type = RichardsSUPGnone
[../]
[]
[Variables]
[./pressure]
order = FIRST
family = LAGRANGE
[./InitialCondition]
type = RandomIC
block = 0
min = -1
max = 0
[../]
[../]
[]
[Kernels]
active = 'richardsf'
[./richardst]
type = RichardsMassChange
variable = pressure
[../]
[./richardsf]
type = RichardsFlux
variable = pressure
[../]
[]
[Materials]
[./rock]
type = RichardsMaterial
block = 0
mat_porosity = 0.1
mat_permeability = '1E-5 0 0 0 1E-5 0 0 0 1E-5'
density_UO = DensityConstBulk
relperm_UO = RelPermPower
SUPG_UO = SUPGnone
sat_UO = Saturation
seff_UO = SeffVG
viscosity = 1E-3
gravity = '-1 0 0'
linear_shape_fcns = true
[../]
[]
[Preconditioning]
[./andy]
type = SMP
full = true
petsc_options_iname = '-ksp_type -pc_type -snes_atol -snes_rtol -snes_max_it'
petsc_options_value = 'bcgs bjacobi 1E-15 1E-10 10000'
[../]
[]
[Executioner]
type = Steady
solve_type = Newton
[]
[Outputs]
execute_on = 'timestep_end'
file_base = gh04
exodus = true
[]
modules/combined/test/tests/gap_heat_transfer_mortar/ref-displaced.i
[Mesh]
file = 3blk.e
displacements = 'disp_x disp_y'
[]
[AuxVariables]
[./disp_x]
block = 1
[../]
[./disp_y]
block = 1
[../]
[]
[AuxKernels]
[./disp_x_kernel]
type = ConstantAux
variable = disp_x
value = 0.1
[../]
[./disp_y_kernel]
type = ConstantAux
variable = disp_y
value = 0
[../]
[]
[Variables]
[./temp]
order = FIRST
family = LAGRANGE
block = '1 2 3'
[../]
[]
[Materials]
[./left]
type = HeatConductionMaterial
block = 1
thermal_conductivity = 1000
specific_heat = 1
[../]
[./right]
type = HeatConductionMaterial
block = 2
thermal_conductivity = 500
specific_heat = 1
[../]
[./middle]
type = HeatConductionMaterial
block = 3
thermal_conductivity = 100
specific_heat = 1
[../]
[]
[Kernels]
[./hc]
type = HeatConduction
variable = temp
use_displaced_mesh = true
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = temp
boundary = 'left'
value = 1
[../]
[./right]
type = DirichletBC
variable = temp
boundary = 'right'
value = 0
[../]
[]
[Preconditioning]
[./smp]
type = SMP
full = true
[../]
[]
[Executioner]
type = Steady
solve_type = 'NEWTON'
nl_rel_tol = 1e-11
l_tol = 1e-11
[]
[Outputs]
exodus = true
[]
python/chigger/tests/input/simple_diffusion_new_var.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
uniform_refine = 2
[]
[Variables]
[./u]
[../]
[]
[AuxVariables]
[./aux]
family = MONOMIAL
order = CONSTANT
[../]
[./New_0]
[../]
[]
[AuxKernels]
[./aux_kernel]
type = FunctionAux
variable = aux
function = sin(2*pi*x)*sin(2*pi*y)
execute_on = 'initial'
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
modules/phase_field/test/tests/KKS_system/derivative_parsed_material.i
#
# This test validates the free energy material with automatic differentiation for the KKS system
#
[Mesh]
type = GeneratedMesh
dim = 2
nx = 20
ny = 20
nz = 0
xmin = 0
xmax = 1
ymin = 0
ymax = 1
zmin = 0
zmax = 0
elem_type = QUAD4
[]
[BCs]
[./left]
type = DirichletBC
variable = c1
boundary = 'left'
value = 0
[../]
[./right]
type = DirichletBC
variable = c1
boundary = 'right'
value = 1
[../]
[./top]
type = DirichletBC
variable = c2
boundary = 'top'
value = 0
[../]
[./bottom]
type = DirichletBC
variable = c2
boundary = 'bottom'
value = 1
[../]
[]
[Variables]
# concentration 1
[./c1]
order = FIRST
family = LAGRANGE
[../]
# concentration 2
[./c2]
order = FIRST
family = LAGRANGE
[../]
[]
[Materials]
[./fa]
type = DerivativeParsedMaterial
f_name = F
args = 'c1 c2'
constant_names = 'T kB'
constant_expressions = '400 .000086173324'
function = 'c1^2+100*T*kB*(c2-0.5)^3+c1^4*c2^5'
outputs = exodus
[../]
[]
[Kernels]
[./c1diff]
type = Diffusion
variable = c1
[../]
[./c2diff]
type = Diffusion
variable = c2
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
execute_on = 'timestep_end'
file_base = derivative_parsed_material
exodus = true
[]
test/tests/misc/check_error/kernel_with_aux_var.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxVariables]
[./v]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[./rea]
type = Reaction
variable = v
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'NEWTON'
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/restart/restart_diffusion/restart_diffusion_test_steady.i
[Mesh]
file = square.e
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Postprocessors]
[./unorm]
type = ElementL2Norm
variable = u
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = steady_out
exodus = true
checkpoint = true
[]
test/tests/userobjects/solution_user_object/discontinuous_value_solution_uo_p1.i
[Mesh]
type = GeneratedMesh
dim = 2
xmin = 0
xmax = 1
ymin = 0
ymax = 1
nx = 2
ny = 2
[]
[Variables]
[./u]
[../]
[]
[AuxVariables]
[./discontinuous_variable]
order = CONSTANT
family = MONOMIAL
[../]
[./continuous_variable]
order = FIRST
family = LAGRANGE
[../]
[]
[Functions]
[./discontinuous_function]
type = ParsedFunction
value = 'if(x<0.5,3,5)'
[../]
[./continuous_function]
type = ParsedFunction
value = 'if(x<0.5,x,2*x-0.5)'
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[ICs]
[./discontinuous_variable]
type = FunctionIC
variable = discontinuous_variable
function = discontinuous_function
[../]
[./continuous_variable]
type = FunctionIC
variable = continuous_variable
function = continuous_function
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./one]
type = DirichletBC
variable = u
boundary = 'right top bottom'
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
file_base = discontinuous_value_solution_uo_p1
exodus = true
[]
test/tests/mesh_modifiers/image_subdomain/image_2d.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 176
ny = 287
[]
[Variables]
[./u]
[../]
[]
[MeshModifiers]
[./image]
type = ImageSubdomain
file = kitten.png #../../functions/image_function/stack/test
threshold = 100
[../]
[]
[Problem]
type = FEProblem
solve = false
[../]
[Executioner]
type = Steady
[]
[Outputs]
execute_on = 'timestep_end'
exodus = true
[]
test/tests/materials/material/qp_material.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 3
ny = 3
elem_type = QUAD4
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left_u]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right_u]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Materials]
[./mat1]
type = QpMaterial
block = 0
outputs = all
constant_on = ELEMENT
property_name = 'zero_prop'
[../]
# The second copy of QpMaterial is not constant_on_elem.
[./mat2]
type = QpMaterial
block = 0
outputs = all
property_name = 'nonzero_prop'
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
exodus = true
[]
test/tests/misc/jacobian/inf_nan.i
[Mesh]
type = GeneratedMesh
dim = 1
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./td]
type = NanKernel
variable = u
[../]
[]
[Executioner]
type = Steady
solve_type = NEWTON
[]
modules/porous_flow/test/tests/newton_cooling/nc04.i
# Newton cooling from a bar. Heat conduction
[Mesh]
type = GeneratedMesh
dim = 2
nx = 100
ny = 1
xmin = 0
xmax = 100
ymin = 0
ymax = 1
[]
[GlobalParams]
PorousFlowDictator = dictator
[]
[UserObjects]
[./dictator]
type = PorousFlowDictator
porous_flow_vars = 'temp'
number_fluid_phases = 0
number_fluid_components = 0
[../]
[]
[Variables]
[./temp]
[../]
[]
[ICs]
[./temp]
type = FunctionIC
variable = temp
function = '2-x/100'
[../]
[]
[Kernels]
[./conduction]
type = PorousFlowHeatConduction
variable = temp
[../]
[]
[Materials]
[./temperature]
type = PorousFlowTemperature
temperature = temp
[../]
[./temperature_nodal]
type = PorousFlowTemperature
at_nodes = true
temperature = temp
[../]
[./thermal_conductivity_irrelevant]
type = PorousFlowThermalConductivityIdeal
dry_thermal_conductivity = '1E2 0 0 0 1E2 0 0 0 1E2'
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = temp
boundary = left
value = 2
[../]
[./newton]
type = PorousFlowPiecewiseLinearSink
variable = temp
boundary = right
pt_vals = '0 1 2'
multipliers = '-1 0 1'
flux_function = 1
[../]
[]
[VectorPostprocessors]
[./temp]
type = LineValueSampler
variable = temp
start_point = '0 0.5 0'
end_point = '100 0.5 0'
sort_by = x
num_points = 11
execute_on = timestep_end
[../]
[]
[Preconditioning]
[./andy]
type = SMP
full = true
petsc_options = '-snes_converged_reason'
petsc_options_iname = '-ksp_type -pc_type -sub_pc_type -snes_max_it -sub_pc_factor_shift_type -pc_asm_overlap -snes_atol -snes_rtol '
petsc_options_value = 'gmres asm lu 100 NONZERO 2 1E-14 1E-12'
[../]
[]
[Executioner]
type = Steady
[]
[Outputs]
file_base = nc04
execute_on = timestep_end
exodus = false
[./along_line]
type = CSV
execute_vector_postprocessors_on = timestep_end
[../]
[]
test/tests/problems/no_kernel_coverage_check/no_coverage_check.i
[Mesh]
file = rectangle.e
[]
[Problem]
kernel_coverage_check = false
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
block = 1
[../]
[]
[Kernels]
active = 'diff body_force'
[./diff]
type = Diffusion
variable = u
block = 1
[../]
[./body_force]
type = BodyForce
variable = u
block = 1
value = 10
[../]
[]
[BCs]
active = 'left'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 1
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
exodus = true
[]
test/tests/functions/solution_function/solution_function_grad_p1.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
xmin = 0.0
xmax = 1.0
ymin = 0.0
ymax = 1.0
parallel_type = replicated
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxVariables]
[./test_variable]
order = FIRST
family = LAGRANGE
[./InitialCondition]
type = FunctionIC
function = initial_cond_func
[../]
[../]
[]
[Functions]
[./initial_cond_func]
type = ParsedFunction
value = 2*x+4*y
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
nl_rel_tol = 1e-10
[]
[Outputs]
file_base = solution_function_grad_p1
exodus = true
[]
python/peacock/tests/input_tab/InputFileEditor/gold/fsp_test.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
[]
[Variables]
[u]
order = FIRST
family = LAGRANGE
[]
[v]
order = FIRST
family = LAGRANGE
[]
[]
[Kernels]
[diff_u]
type = Diffusion
variable = u
[]
[conv_v]
type = CoupledForce
variable = v
v = 'u'
[]
[diff_v]
type = Diffusion
variable = v
[]
[]
[BCs]
inactive = 'right_v'
[left_u]
type = DirichletBC
variable = u
boundary = '1'
value = 0
[]
[right_u]
type = DirichletBC
variable = u
boundary = '2'
value = 100
[]
[left_v]
type = DirichletBC
variable = v
boundary = '1'
value = 0
[]
[right_v]
type = DirichletBC
variable = v
boundary = '2'
value = 0
[]
[]
[Executioner]
# This is setup automatically in MOOSE (SetupPBPAction.C)
# petsc_options = '-snes_mf_operator'
# petsc_options_iname = '-pc_type'
# petsc_options_value = 'asm'
type = Steady
[]
[Preconditioning]
[FSP]
# It is the starting point of splitting
type = FSP
topsplit = 'uv' # uv should match the following block name
[uv]
# Generally speaking, there are four types of splitting we could choose
# <additive,multiplicative,symmetric_multiplicative,schur>
# An approximate solution to the original system
# | A_uu A_uv | | u | _ |f_u|
# | 0 A_vv | | v | - |f_v|
# is obtained by solving the following subsystems
# A_uu u = f_u and A_vv v = f_v
# If splitting type is specified as schur, we may also want to set more options to
# control how schur works using PETSc options
# petsc_options_iname = '-pc_fieldsplit_schur_fact_type -pc_fieldsplit_schur_precondition'
# petsc_options_value = 'full selfp'
splitting = 'u v' # u and v are the names of subsolvers
splitting_type = additive
[]
[u]
# PETSc options for this subsolver
# A prefix will be applied, so just put the options for this subsolver only
vars = 'u'
petsc_options_iname = '-pc_type -ksp_type'
petsc_options_value = ' hypre preonly'
[]
[v]
# PETSc options for this subsolver
vars = 'v'
petsc_options_iname = '-pc_type -ksp_type'
petsc_options_value = ' hypre preonly'
[]
[]
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/postprocessors/receiver_default/defaults.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Postprocessors]
[./receiver]
type = Receiver
default = 12345
execute_on = 'timestep_end initial'
[../]
[./report_old]
type = TestPostprocessor
execute_on = 'timestep_end initial'
test_type = report_old
report_name = receiver
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
modules/chemical_reactions/test/tests/jacobian/primary_convection.i
# Test the Jacobian terms for the PrimaryConvection Kernel
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
[]
[Variables]
[./pressure]
order = FIRST
family = LAGRANGE
[../]
[./a]
order = FIRST
family = LAGRANGE
[../]
[]
[ICs]
[./pressure]
type = RandomIC
variable = pressure
min = 1
max = 5
[../]
[./a]
type = RandomIC
variable = a
max = 1
min = 0
[../]
[]
[Kernels]
[./diff]
type = DarcyFluxPressure
variable = pressure
[../]
[./conv]
type = PrimaryConvection
variable = a
p = pressure
[../]
[]
[Materials]
[./porous]
type = GenericConstantMaterial
prop_names = 'diffusivity conductivity porosity'
prop_values = '1e-4 1e-4 0.2'
[../]
[]
[Executioner]
type = Steady
solve_type = NEWTON
[]
[Outputs]
perf_graph = true
[]
[Preconditioning]
[./smp]
type = SMP
full = true
[../]
[]
test/tests/userobjects/side_user_object_no_boundary_error/side_no_boundary.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Postprocessors]
[./avg]
type = SideAverageValue
variable = u
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/outputs/postprocessor/show_hide.i
# Having 2 postprocessors, putting one into hide list and the other one into show list
# We should only see the PPS that is in the show list in the output.
[Mesh]
type = GeneratedMesh
dim = 2
xmin = 0
xmax = 1
ymin = 0
ymax = 1
nx = 10
ny = 10
elem_type = QUAD4
# This test uses ElementalVariableValue postprocessors on specific
# elements, so element numbering needs to stay unchanged
allow_renumbering = false
[]
[Functions]
[./bc_fn]
type = ParsedFunction
value = x
[../]
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./all_u]
type = FunctionDirichletBC
variable = u
boundary = '1 3'
function = bc_fn
[../]
[]
[Postprocessors]
[./elem_56]
type = ElementalVariableValue
variable = u
elementid = 56
[../]
[./elem_12]
type = ElementalVariableValue
variable = u
elementid = 12
[../]
[]
[Executioner]
type = Steady
solve_type = 'NEWTON'
[]
[Outputs]
[./console]
type = Console
show = 'elem_56'
hide = 'elem_12'
[../]
[./out]
type = CSV
show = 'elem_56'
hide = 'elem_12'
[../]
[]
modules/tensor_mechanics/test/tests/CylindricalRankTwoAux/test.i
[Mesh]
type = FileMesh
file = circle.e
[]
[MeshModifiers]
[./cnode]
type = AddExtraNodeset
coord = '1000.0 0.0'
new_boundary = 10
[../]
[]
[Variables]
[./disp_x]
[../]
[./disp_y]
[../]
[]
[AuxVariables]
[./T]
[../]
[./stress_rr]
order = CONSTANT
family = MONOMIAL
[../]
[./stress_tt]
order = CONSTANT
family = MONOMIAL
[../]
[]
[ICs]
[./T_IC]
type = FunctionIC
variable = T
function = '1000-0.7*sqrt(x^2+y^2)'
[../]
[]
[Kernels]
[./TensorMechanics]
displacements = 'disp_x disp_y'
[../]
[]
[AuxKernels]
[./stress_rr]
type = CylindricalRankTwoAux
variable = stress_rr
rank_two_tensor = stress
index_j = 0
index_i = 0
center_point = '0 0 0'
[../]
[./stress_tt]
type = CylindricalRankTwoAux
variable = stress_tt
rank_two_tensor = stress
index_j = 1
index_i = 1
center_point = '0 0 0'
[../]
[]
[BCs]
[./outer_x]
type = PresetBC
variable = disp_x
boundary = 2
value = 0
[../]
[./outer_y]
type = PresetBC
variable = disp_y
boundary = '2 10'
value = 0
[../]
[]
[Materials]
[./iso_C]
type = ComputeElasticityTensor
fill_method = symmetric_isotropic
C_ijkl = '2.15e5 0.74e5'
block = 1
[../]
[./strain]
type = ComputeSmallStrain
displacements = 'disp_x disp_y'
block = 1
eigenstrain_names = eigenstrain
[../]
[./stress]
type = ComputeLinearElasticStress
block = 1
[../]
[./thermal_strain]
type= ComputeThermalExpansionEigenstrain
thermal_expansion_coeff = 1e-6
temperature = T
stress_free_temperature = 273
block = 1
eigenstrain_name = eigenstrain
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type -ksp_gmres_restart'
petsc_options_value = 'hypre boomeramg 101'
l_max_its = 30
nl_max_its = 10
nl_abs_tol = 1e-9
nl_rel_tol = 1e-14
l_tol = 1e-4
[]
[Outputs]
exodus = true
perf_graph = true
[]
test/tests/meshgenerators/generate_sidesets_bounding_box/error_no_nodes_found.i
[MeshGenerators]
[./gmg]
type = GeneratedMeshGenerator
dim = 2
nx = 10
ny = 10
#parallel_type = replicated
[]
[./createNewSidesetOne]
type = SideSetsFromBoundingBoxGenerator
input = gmg
boundary_id_old = 'right'
boundary_id_new = 11
bottom_left = '0.5 0.5 0'
top_right = '1.9 1.9 0'
block_id = 0
[]
[./createNewSidesetTwo]
type = SideSetsFromBoundingBoxGenerator
input = createNewSidesetOne
boundary_id_old = 'top right'
boundary_id_new = 10
bottom_left = '-0.1 -0.1 0'
top_right = '0.7 0.3 0'
block_id = 0
boundary_id_overlap = true
[]
[]
[Mesh]
type = MeshGeneratorMesh
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./leftBC]
type = DirichletBC
variable = u
boundary = 10
value = 1
[../]
[./rightBC]
type = DirichletBC
variable = u
boundary = 11
value = 0
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/misc/check_error/function_file_test16.i
# Test for usage of missing function
[Mesh]
file = square.e
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[./InitialCondition]
type = FunctionIC
function = ic_function
[../]
[../]
[]
[Functions]
[./ic_function]
type = PiecewiseLinear
data_file = piecewise_linear_rows_more_data.csv
xy_in_file_only = false
y_index_in_file = 3 # will generate an error because no forth row of data
scale_factor = 1.0
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/meshgenerators/sidesets_from_points_generator/sidesets_from_points.i
[MeshGenerators]
[./fmg]
type = FileMeshGenerator
file = cylinder.e
#parallel_type = replicated
[]
[./sidesets]
type = SideSetsFromPointsGenerator
input = fmg
points = '0 0 0.5
0.1 0 0
0 0 -0.5'
new_boundary = 'top side bottom'
[]
[]
[Mesh]
type = MeshGeneratorMesh
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./bottom]
type = DirichletBC
variable = u
boundary = bottom
value = 0
[../]
[./top]
type = DirichletBC
variable = u
boundary = top
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/userobjects/geometry_snap/geometrysphere.i
[Mesh]
type = GeneratedMesh
dim = 2
[]
[Variables]
[./u]
initial_condition = 1
[../]
[]
[Problem]
kernel_coverage_check = false
solve = false
[]
[Executioner]
type = Steady
[]
[UserObjects]
[./sphere]
type = GeometrySphere
boundary = 'left right top bottom'
center = '0.5 0.5 0'
radius = 0.7071
[../]
[]
[Adaptivity]
[./Markers]
[./const]
type = UniformMarker
mark = REFINE
[../]
[../]
marker = const
steps = 3
[]
[Outputs]
[./out]
type = Exodus
[../]
[]
modules/richards/test/tests/gravity_head_1/gh03.i
# unsaturated = false
# gravity = true
# supg = false
# transient = false
[Mesh]
type = GeneratedMesh
dim = 1
nx = 1
xmin = -1
xmax = 1
[]
[BCs]
[./left]
type = DirichletBC
boundary = left
value = 1
variable = pressure
[../]
[]
[GlobalParams]
richardsVarNames_UO = PPNames
[]
[UserObjects]
[./PPNames]
type = RichardsVarNames
richards_vars = pressure
[../]
[./DensityConstBulk]
type = RichardsDensityConstBulk
dens0 = 1
bulk_mod = 1.0E3
[../]
[./SeffVG]
type = RichardsSeff1VG
m = 0.8
al = 1
[../]
[./RelPermPower]
type = RichardsRelPermPower
simm = 0.0
n = 2
[../]
[./Saturation]
type = RichardsSat
s_res = 0.1
sum_s_res = 0.1
[../]
[./SUPGnone]
type = RichardsSUPGnone
[../]
[]
[Variables]
[./pressure]
order = FIRST
family = LAGRANGE
[./InitialCondition]
type = RandomIC
block = 0
min = 0
max = 1
[../]
[../]
[]
[Kernels]
active = 'richardsf'
[./richardst]
type = RichardsMassChange
variable = pressure
[../]
[./richardsf]
type = RichardsFlux
variable = pressure
[../]
[]
[Materials]
[./rock]
type = RichardsMaterial
block = 0
mat_porosity = 0.1
mat_permeability = '1E-5 0 0 0 1E-5 0 0 0 1E-5'
density_UO = DensityConstBulk
relperm_UO = RelPermPower
SUPG_UO = SUPGnone
sat_UO = Saturation
seff_UO = SeffVG
viscosity = 1E-3
gravity = '-1 0 0'
linear_shape_fcns = true
[../]
[]
[Preconditioning]
[./andy]
type = SMP
full = true
petsc_options_iname = '-ksp_type -pc_type -snes_atol -snes_rtol -snes_max_it'
petsc_options_value = 'bcgs bjacobi 1E-15 1E-10 10000'
[../]
[]
[Executioner]
type = Steady
solve_type = Newton
[]
[Outputs]
execute_on = 'timestep_end'
file_base = gh03
exodus = true
[]
modules/porous_flow/test/tests/gravity/fully_saturated_grav01c.i
# Checking that gravity head is established
# 1phase, 2-component, constant fluid-bulk, constant viscosity, constant permeability
# fully saturated with fully-saturated Kernel
# For better agreement with the analytical solution (ana_pp), just increase nx
[Mesh]
type = GeneratedMesh
dim = 1
nx = 100
xmin = -1
xmax = 0
[]
[GlobalParams]
PorousFlowDictator = dictator
[]
[Variables]
[./pp]
[./InitialCondition]
type = RandomIC
min = 0
max = 1
[../]
[../]
[./frac]
[./InitialCondition]
type = RandomIC
min = 0
max = 1
[../]
[../]
[]
[Kernels]
[./flux1]
type = PorousFlowFullySaturatedDarcyFlow
variable = pp
fluid_component = 0
gravity = '-1 0 0'
[../]
[./flux0]
type = PorousFlowFullySaturatedDarcyFlow
variable = frac
fluid_component = 1
gravity = '-1 0 0'
[../]
[]
[Functions]
[./ana_pp]
type = ParsedFunction
vars = 'g B p0 rho0'
vals = '1 1.2 0 1'
value = '-B*log(exp(-p0/B)+g*rho0*x/B)' # expected pp at base
[../]
[]
[BCs]
[./z]
type = PresetBC
variable = pp
boundary = right
value = 0
[../]
[]
[UserObjects]
[./dictator]
type = PorousFlowDictator
porous_flow_vars = 'pp frac'
number_fluid_phases = 1
number_fluid_components = 2
[../]
[]
[Modules]
[./FluidProperties]
[./simple_fluid]
type = SimpleFluidProperties
bulk_modulus = 1.2
density0 = 1
viscosity = 1
thermal_expansion = 0
[../]
[../]
[]
[Materials]
[./temperature]
type = PorousFlowTemperature
[../]
[./ppss]
type = PorousFlow1PhaseFullySaturated
porepressure = pp
[../]
[./massfrac]
type = PorousFlowMassFraction
mass_fraction_vars = frac
[../]
[./simple_fluid]
type = PorousFlowSingleComponentFluid
fp = simple_fluid
phase = 0
[../]
[./permeability]
type = PorousFlowPermeabilityConst
permeability = '1 0 0 0 2 0 0 0 3'
[../]
[]
[Postprocessors]
[./pp_base]
type = PointValue
variable = pp
point = '-1 0 0'
[../]
[./pp_analytical]
type = FunctionValuePostprocessor
function = ana_pp
point = '-1 0 0'
[../]
[]
[Preconditioning]
[./andy]
type = SMP
full = true
petsc_options_iname = '-ksp_type -pc_type -snes_atol -snes_rtol -snes_max_it -pc_factor_shift_type'
petsc_options_value = 'bcgs lu 1E-15 1E-10 10000 NONZERO'
[../]
[]
[Executioner]
type = Steady
solve_type = Newton
[]
[Outputs]
execute_on = 'timestep_end'
file_base = fully_saturated_grav01c
[./csv]
type = CSV
[../]
[]
test/tests/mesh_modifiers/add_extra_nodeset/extra_nodeset_coord_test.i
[Mesh]
file = square.e
[]
[MeshModifiers]
[./middle_node]
type = AddExtraNodeset
new_boundary = 'middle_node'
coord = '0.5 0.5'
[../]
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
active = 'left right middle'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[./middle]
type = DirichletBC
variable = u
boundary = 'middle_node'
value = -1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out
exodus = true
[]
modules/stochastic_tools/test/tests/distributions/boost_lognormal.i
[Mesh]
type = GeneratedMesh
dim = 1
nx = 1
ny = 1
[]
[Variables]
[./u]
[../]
[]
[Distributions]
[./lognormal_test]
type = BoostLognormalDistribution
location = -0.371
scale = 0.52
[../]
[]
[Postprocessors]
[./cdf]
type = TestDistributionPostprocessor
distribution = lognormal_test
value = 0.6
method = cdf
execute_on = initial
[../]
[./pdf]
type = TestDistributionPostprocessor
distribution = lognormal_test
value = 0.6
method = pdf
execute_on = initial
[../]
[./quantile]
type = TestDistributionPostprocessor
distribution = lognormal_test
value = 0.5
method = quantile
execute_on = initial
[../]
[]
[Executioner]
type = Steady
[]
[Problem]
solve = false
kernel_coverage_check = false
[]
[Outputs]
execute_on = 'INITIAL'
csv = true
[]
test/tests/misc/check_error/coupling_field_into_scalar.i
[Mesh]
type = GeneratedMesh
dim = 2
[]
[AuxVariables]
[./v]
[../]
[]
[Variables]
[./u]
[../]
[./a]
family = SCALAR
order = FIRST
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[./slm]
type = ScalarLagrangeMultiplier
variable = u
# this should trigger an error message, lambda is scalar
lambda = v
[../]
[]
[ScalarKernels]
[./alpha]
type = AlphaCED
variable = a
value = 1
[../]
[]
[BCs]
[./all]
type = DirichletBC
boundary = 'left right top bottom'
variable = u
value = 0
[../]
[]
[Executioner]
type = Steady
[]
modules/combined/test/tests/heat_conduction_patch/heat_conduction_patch_rz_test.i
#
# This problem is taken from the Abaqus verification manual:
# "1.5.8 Patch test for heat transfer elements"
#
# The temperature on the exterior nodes is -2e5+200x+100y.
#
# This gives a constant flux at all Gauss points.
#
# In addition, the temperature at all nodes follows the same formula.
#
# Node x y Temperature
# 1 1e3 0 0
# 2 1.00024e3 0 48
# 3 1.00018e3 3e-2 39
# 4 1.00004e3 2e-2 10
# 5 1.00008e3 8e-2 24
# 6 1e3 1.2e-1 12
# 7 1.00016e3 8e-2 40
# 8 1.00024e3 1.2e-1 60
[Problem]
coord_type = RZ
[]
[Mesh]#Comment
file = heat_conduction_patch_rz_test.e
[] # Mesh
[Functions]
[./temps]
type = ParsedFunction
value='-2e5+200*x+100*y'
[../]
[] # Functions
[Variables]
[./temp]
order = FIRST
family = LAGRANGE
[../]
[] # Variables
[Kernels]
[./heat_r]
type = HeatConduction
variable = temp
[../]
[] # Kernels
[BCs]
[./temps]
type = FunctionDirichletBC
variable = temp
boundary = 10
function = temps
[../]
[] # BCs
[Materials]
[./heat]
type = HeatConductionMaterial
block = 1
specific_heat = 0.116
thermal_conductivity = 4.85e-4
[../]
[./density]
type = Density
block = 1
density = 0.283
[../]
[] # Materials
[Executioner]
type = Steady
#Preconditioned JFNK (default)
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -ksp_gmres_restart'
petsc_options_value = 'lu 101'
line_search = 'none'
nl_abs_tol = 1e-11
nl_rel_tol = 1e-10
l_max_its = 20
[] # Executioner
[Outputs]
file_base = out_rz
exodus = true
[] # Outputs
test/tests/mesh_modifiers/subdomain_bounding_box/oriented_subdomain_bounding_box_inside.i
[Mesh]
type = GeneratedMesh
dim = 3
xmin = -6
xmax = 4
nx = 10
ymin = -2
ymax = 10
ny = 12
zmin = -5
zmax = 7
nz = 12
[]
[MeshModifiers]
[./subdomains]
type = OrientedSubdomainBoundingBox
center = '-1 4 1'
width = 5
length = 10
height = 4
width_direction = '2 1 0'
length_direction = '-1 2 2'
block_id = 10
location = INSIDE
[../]
[]
[Problem]
type = FEProblem
solve = false
kernel_coverage_check = false
[]
[Variables]
[./u]
[../]
[]
[Materials]
[./mat10]
type = GenericConstantMaterial
block = 10
outputs = all
prop_values = 6.24
prop_names = prop
[../]
[./mat0]
type = GenericConstantMaterial
block = 0
prop_names = prop
prop_values = 0
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
[]
[Outputs]
exodus = true
[]
modules/stochastic_tools/test/tests/distributions/normal_direct.i
[Mesh]
type = GeneratedMesh
dim = 1
nx = 1
ny = 1
[]
[Variables]
[./u]
[../]
[]
[Distributions]
[./normal_test]
type = NormalDistribution
mean = 0
standard_deviation = 1
[../]
[]
[Postprocessors]
[./cdf]
type = TestDistributionDirectPostprocessor
distribution = normal_test
value = 0
method = cdf
execute_on = initial
[../]
[./pdf]
type = TestDistributionDirectPostprocessor
distribution = normal_test
value = 0
method = pdf
execute_on = initial
[../]
[./quantile]
type = TestDistributionDirectPostprocessor
distribution = normal_test
value = 0.5
method = quantile
execute_on = initial
[../]
[]
[Executioner]
type = Steady
[]
[Problem]
solve = false
kernel_coverage_check = false
[]
[Outputs]
execute_on = 'INITIAL'
csv = true
[]
test/tests/preconditioners/smp/smp_group_test.i
###########################################################
# This test exercises the customer Preconditioner System.
# A Single Matrix Preconditioner is built using
# coupling specified by the user.
#
# @Requirement F1.40
###########################################################
[Mesh]
type = GeneratedMesh
dim = 2
xmin = 0
xmax = 1
ymin = 0
ymax = 1
nx = 10
ny = 10
elem_type = QUAD4
[]
[Variables]
[./u]
[../]
[./v]
[../]
[./p]
[../]
[./q]
[../]
[]
# Single Matrix Preconditioner
[Preconditioning]
[./SMP]
type = SMP
coupled_groups = 'u,v p,q'
[../]
[]
[Kernels]
[./diff_u]
type = Diffusion
variable = u
[../]
[./conv_u]
type = CoupledForce
variable = u
v = v
[../]
[./diff_v]
type = Diffusion
variable = v
[../]
[./diff_p]
type = Diffusion
variable = p
[../]
[./conv_p]
type = CoupledForce
variable = p
v = q
[../]
[./diff_q]
type = Diffusion
variable = q
[../]
[]
[BCs]
[./left_u]
type = DirichletBC
variable = u
boundary = 1
value = 1
[../]
[./bottom_v]
type = DirichletBC
variable = v
boundary = 0
value = 5
[../]
[./top_v]
type = DirichletBC
variable = v
boundary = 2
value = 2
[../]
[./left_p]
type = DirichletBC
variable = p
boundary = 1
value = 2
[../]
[./bottom_q]
type = DirichletBC
variable = q
boundary = 0
value = 3
[../]
[./top_q]
type = DirichletBC
variable = q
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'NEWTON'
nl_max_its = 2
[]
[Outputs]
exodus = true
[]
test/tests/auxkernels/solution_aux/aux_nonlinear_solution_adapt.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxVariables]
[./u_aux]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[AuxKernels]
[./aux_kernel]
type = FunctionAux
function = x*y
variable = u_aux
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
nl_rel_tol = 1e-10
[]
[Adaptivity]
marker = error_frac
steps = 3
[./Indicators]
[./jump_indicator]
type = GradientJumpIndicator
variable = u
[../]
[../]
[./Markers]
[./error_frac]
type = ErrorFractionMarker
indicator = jump_indicator
refine = 0.7
[../]
[../]
[]
[Outputs]
xda = true
[]
modules/phase_field/test/tests/reconstruction/EulerAngleVariables2RGBAux.i
[Mesh]
type = EBSDMesh
filename = IN100_001_28x28_Clean_Marmot.txt
[]
[UserObjects]
[./ebsd]
type = EBSDReader
[../]
[]
[AuxVariables]
[./phi1]
family = MONOMIAL
order = CONSTANT
[../]
[./phi]
family = MONOMIAL
order = CONSTANT
[../]
[./phi2]
family = MONOMIAL
order = CONSTANT
[../]
[./phase]
order = CONSTANT
family = MONOMIAL
[../]
[./symmetry]
order = CONSTANT
family = MONOMIAL
[../]
[./rgb]
order = CONSTANT
family = MONOMIAL
[../]
[]
[AuxKernels]
[./phi1_aux]
type = EBSDReaderPointDataAux
variable = phi1
ebsd_reader = ebsd
data_name = phi1
execute_on = initial
[../]
[./phi_aux]
type = EBSDReaderPointDataAux
variable = phi
ebsd_reader = ebsd
data_name = phi
execute_on = initial
[../]
[./phi2_aux]
type = EBSDReaderPointDataAux
variable = phi2
ebsd_reader = ebsd
data_name = phi2
execute_on = initial
[../]
[./phase_aux]
type = EBSDReaderPointDataAux
variable = phase
ebsd_reader = ebsd
data_name = phase
execute_on = initial
[../]
[./symmetry_aux]
type = EBSDReaderPointDataAux
variable = symmetry
ebsd_reader = ebsd
data_name = symmetry
execute_on = initial
[../]
[./rgb]
type = EulerAngleVariables2RGBAux
variable = rgb
phi1 = phi1
phi = phi
phi2 = phi2
phase = phase
symmetry = symmetry
execute_on = initial
[../]
[]
[Executioner]
type = Steady
[]
[Problem]
solve = false
kernel_coverage_check = false
[]
[Outputs]
exodus = true
show = 'rgb'
[]
modules/contact/test/tests/kernels/simple_diffusion/simple_diffusion.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
#Preconditioned JFNK (default)
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
modules/heat_conduction/test/tests/verify_against_analytical/ad_2d_steady_state_final_prob.i
# This test solves a 2D steady state heat equation
# The error is found by comparing to the analytical solution
# Note that the thermal conductivity, specific heat, and density in this problem
# Are set to 1, and need to be changed to the constants of the material being
# Analyzed
[Mesh]
type = GeneratedMesh
dim = 2
nx = 30
ny = 30
xmax = 2
ymax = 2
[]
[Variables]
[./T]
[../]
[]
[Functions]
[./analytical_sol]
type = ParsedFunction
value = 10/(sinh(pi))*sin(pi*x*0.5)*sinh(pi*y*0.5)
[../]
[./top_bound]
type = ParsedFunction
value = 10*sin(pi*x*0.5)
[../]
[]
[ADKernels]
[./HeatDiff]
type = ADHeatConduction
variable = T
thermal_conductivity = thermal_conductivity
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = T
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = T
boundary = right
value = 0
[../]
[./bottom]
type = DirichletBC
variable = T
boundary = bottom
value = 0
[../]
[./top]
type = FunctionDirichletBC
variable = T
boundary = top
function = top_bound
[../]
[]
[Materials]
[./k]
type = GenericConstantMaterial
prop_names = thermal_conductivity
prop_values = 1 # this values is changed based on the material property
block = 0
[../]
[./cp]
type = GenericConstantMaterial
prop_names = specific_heat
prop_values = 1 # this value is changed based on material properties
block = 0
[../]
[./rho]
type = GenericConstantMaterial
prop_names = density
prop_values = 1 # this values is changed based on material properties
block = 0
[../]
[]
[Postprocessors]
[./nodal_error]
type = NodalL2Error
function = 'analytical_sol'
variable = T
[../]
[./elemental_error]
type = ElementL2Error
function = 'analytical_sol'
variable = T
[../]
[]
[Executioner]
type = Steady
nl_rel_tol = 1e-12
l_tol = 1e-6
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
perf_graph = true
[]
modules/navier_stokes/test/tests/ins/velocity_channel/velocity_inletBC_no_parts.i
# This input file tests outflow boundary conditions for the incompressible NS equations.
[GlobalParams]
gravity = '0 0 0'
integrate_p_by_parts = false
[]
[Mesh]
type = GeneratedMesh
dim = 2
xmin = 0
xmax = 3.0
ymin = 0
ymax = 1.0
nx = 30
ny = 10
elem_type = QUAD9
[]
[MeshModifiers]
[./corner_node]
type = AddExtraNodeset
new_boundary = top_right
coord = '3 1'
[../]
[]
[Variables]
[./vel_x]
order = SECOND
family = LAGRANGE
[../]
[./vel_y]
order = SECOND
family = LAGRANGE
[../]
[./p]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./mass]
type = INSMass
variable = p
u = vel_x
v = vel_y
p = p
[../]
[./x_momentum_space]
type = INSMomentumLaplaceForm
variable = vel_x
u = vel_x
v = vel_y
p = p
component = 0
[../]
[./y_momentum_space]
type = INSMomentumLaplaceForm
variable = vel_y
u = vel_x
v = vel_y
p = p
component = 1
[../]
[]
[BCs]
[./x_no_slip]
type = DirichletBC
variable = vel_x
boundary = 'top bottom'
value = 0.0
[../]
[./y_no_slip]
type = DirichletBC
variable = vel_y
boundary = 'left top bottom'
value = 0.0
[../]
[./x_inlet]
type = FunctionDirichletBC
variable = vel_x
boundary = 'left'
function = 'inlet_func'
[../]
[./p_corner]
# Since the pressure is not integrated by parts in this example,
# it is only specified up to a constant by the natural outflow BC.
# Therefore, we need to pin its value at a single location.
type = DirichletBC
boundary = top_right
value = 0
variable = p
[../]
[]
[Materials]
[./const]
type = GenericConstantMaterial
block = 0
prop_names = 'rho mu'
prop_values = '1 1'
[../]
[]
[Preconditioning]
[./SMP_PJFNK]
type = SMP
full = true
solve_type = NEWTON
[../]
[]
[Executioner]
type = Steady
petsc_options_iname = '-ksp_gmres_restart -pc_type -sub_pc_type -sub_pc_factor_levels'
petsc_options_value = '300 bjacobi ilu 4'
line_search = none
nl_rel_tol = 1e-12
nl_max_its = 6
l_tol = 1e-6
l_max_its = 300
[]
[Outputs]
[./out]
type = Exodus
[../]
[]
[Functions]
[./inlet_func]
type = ParsedFunction
value = '-4 * (y - 0.5)^2 + 1'
[../]
[]
test/tests/misc/check_error/function_file_test13.i
# Test for usage of missing function
[Mesh]
file = square.e
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[./InitialCondition]
type = FunctionIC
function = ic_function
[../]
[../]
[]
[Functions]
[./ic_function]
type = PiecewiseLinear
data_file = piecewise_linear_columns_more_data.csv
format = columns
xy_in_file_only = false
x_index_in_file = 3 #Will generate error because data does not contain 4 columns
scale_factor = 1.0
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/auxkernels/solution_aux/aux_nonlinear_solution_xda.i
[Mesh]
# This test uses SolutionUserObject which doesn't work with DistributedMesh.
type = GeneratedMesh
parallel_type = replicated
dim = 2
nx = 2
ny = 2
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxVariables]
[./u_aux]
[../]
[]
[Functions]
[./u_xda_func]
type = SolutionFunction
solution = xda_u
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[AuxKernels]
[./aux_xda_kernel]
type = SolutionAux
variable = u_aux
solution = xda_u_aux
execute_on = initial
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 1
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 2
[../]
[]
[UserObjects]
[./xda_u_aux]
type = SolutionUserObject
system = aux0
mesh = aux_nonlinear_solution_out_0001_mesh.xda
es = aux_nonlinear_solution_out_0001.xda
system_variables = u_aux
execute_on = initial
[../]
[./xda_u]
type = SolutionUserObject
system = nl0
mesh = aux_nonlinear_solution_out_0001_mesh.xda
es = aux_nonlinear_solution_out_0001.xda
system_variables = u
execute_on = initial
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
nl_rel_tol = 1e-10
[]
[Outputs]
exodus = true
[]
[ICs]
[./u_func_ic]
function = u_xda_func
variable = u
type = FunctionIC
[../]
[]
test/tests/constraints/equal_value_embedded_constraint/embedded_constraint.i
###########################################################
# This is a test that demonstrates a user-defined
# constraint. It forces variables in overlapping portion of
# two blocks to have the same value
###########################################################
[Mesh]
[]
[Variables]
[phi]
order = FIRST
family = LAGRANGE
[]
[]
[Kernels]
[diffusion]
type = Diffusion
variable = phi
[]
[]
[BCs]
[top]
type = DirichletBC
variable = phi
boundary = 1
value = 10.0
[]
[bottom]
type = DirichletBC
variable = phi
boundary = 2
value = 0.0
[]
[left]
type = DirichletBC
variable = phi
boundary = 3
value = 10.0
[]
[right]
type = DirichletBC
variable = phi
boundary = 4
value = 0.0
[]
[]
[Constraints]
[equal]
type = EqualValueEmbeddedConstraint
slave = 2
master = 1
penalty = 1e3
master_variable = phi
variable = phi
[]
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type'
petsc_options_value = 'lu'
line_search = none
nl_rel_tol = 1e-15
nl_abs_tol = 1e-8
l_max_its = 100
nl_max_its = 10
[]
[Outputs]
exodus = true
print_linear_residuals = false
[]
python/peacock/tests/common/bad_mesh.i
[Mesh]
type = GeneratedMesh
dim = 20
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
# Preconditioned JFNK (default)
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/misc/check_error/coupling_itself.i
[Mesh]
type = GeneratedMesh
dim = 2
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./coupled]
type = CoupledForce
variable = u
v = u
[../]
[]
[Executioner]
type = Steady
[]
test/tests/geomsearch/2d_penetration_locator/2d_penetration_locator_test.i
[Mesh]
file = 2d_contact_test.e
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxVariables]
[./penetration]
order = FIRST
family = LAGRANGE
[../]
[./tangential_distance]
order = FIRST
family = LAGRANGE
[../]
[./normal_x]
order = FIRST
family = LAGRANGE
[../]
[./normal_y]
order = FIRST
family = LAGRANGE
[../]
[./closest_point_x]
order = FIRST
family = LAGRANGE
[../]
[./closest_point_y]
order = FIRST
family = LAGRANGE
[../]
[./element_id]
order = FIRST
family = LAGRANGE
[../]
[./side]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[AuxKernels]
[./penetrate]
type = PenetrationAux
variable = penetration
boundary = 2
paired_boundary = 3
[../]
[./penetrate2]
type = PenetrationAux
variable = penetration
boundary = 3
paired_boundary = 2
[../]
[./penetrate3]
type = PenetrationAux
variable = tangential_distance
boundary = 2
paired_boundary = 3
quantity = tangential_distance
[../]
[./penetrate4]
type = PenetrationAux
variable = tangential_distance
boundary = 3
paired_boundary = 2
quantity = tangential_distance
[../]
[./penetrate5]
type = PenetrationAux
variable = normal_x
boundary = 2
paired_boundary = 3
quantity = normal_x
[../]
[./penetrate6]
type = PenetrationAux
variable = normal_x
boundary = 3
paired_boundary = 2
quantity = normal_x
[../]
[./penetrate7]
type = PenetrationAux
variable = normal_y
boundary = 2
paired_boundary = 3
quantity = normal_y
[../]
[./penetrate8]
type = PenetrationAux
variable = normal_y
boundary = 3
paired_boundary = 2
quantity = normal_y
[../]
[./penetrate9]
type = PenetrationAux
variable = closest_point_x
boundary = 2
paired_boundary = 3
quantity = closest_point_x
[../]
[./penetrate10]
type = PenetrationAux
variable = closest_point_x
boundary = 3
paired_boundary = 2
quantity = closest_point_x
[../]
[./penetrate11]
type = PenetrationAux
variable = closest_point_y
boundary = 2
paired_boundary = 3
quantity = closest_point_y
[../]
[./penetrate12]
type = PenetrationAux
variable = closest_point_y
boundary = 3
paired_boundary = 2
quantity = closest_point_y
[../]
[./penetrate13]
type = PenetrationAux
variable = element_id
boundary = 2
paired_boundary = 3
quantity = element_id
[../]
[./penetrate14]
type = PenetrationAux
variable = element_id
boundary = 3
paired_boundary = 2
quantity = element_id
[../]
[./penetrate15]
type = PenetrationAux
variable = side
boundary = 2
paired_boundary = 3
quantity = side
[../]
[./penetrate16]
type = PenetrationAux
variable = side
boundary = 3
paired_boundary = 2
quantity = side
[../]
[]
[BCs]
active = 'block1_left block1_right block2_left block2_right'
[./block1_left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./block1_right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[./block2_left]
type = DirichletBC
variable = u
boundary = 3
value = 0
[../]
[./block2_right]
type = DirichletBC
variable = u
boundary = 4
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/postprocessors/linear_combination/linear_combination.i
# Tests the LinearCombinationPostprocessor post-processor, which computes
# a linear combination of an arbitrary number of post-processor values.
[Mesh]
type = GeneratedMesh
dim = 1
nx = 2
[]
[Problem]
solve = false
[]
[Executioner]
type = Steady
[]
[Postprocessors]
[./pp1]
# number of elements, equal to 2
type = NumElems
[../]
[./pp2]
# number of nodes, equal to 3
type = NumNodes
[../]
# post-processor value being tested; value should be the following:
# value = c1 * pp1 + c2 * pp2 + b
# = 2 * 2 + -1 * 3 + 5 = 6
[./linear_combination]
type = LinearCombinationPostprocessor
pp_names = 'pp1 pp2'
pp_coefs = '2 -1'
b = 5
[../]
[]
[Outputs]
show = linear_combination
csv = true
[]
test/tests/vectorpostprocessors/line_function_sampler/line_function_sampler.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[VectorPostprocessors]
[./func_vals]
type = LineFunctionSampler
functions = 'x+1 x^2+y^2'
start_point = '0 0 0'
end_point = '1 1 0'
num_points = 10
sort_by = id
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
csv = true
[]
test/tests/parser/active_inactive/active_inactive.i
#############################################################
# This input file demonstrates the use of the active/inactive
# block level parameters that can be used to toggle individual
# blocks on/off for every block in a MOOSE-based input file.
#
# "active" and "inactive" cannot be used within the same block
##############################################################
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
[]
[Variables]
active = 'u'
[./u]
[../]
[]
[AuxVariables]
inactive = 'aux1 aux3'
# The parameters in the inactive sections can be invalid because
# they are never parsed.
[./aux1]
type = DoesntExist
flintstones = 'fred wilma'
[../]
[./aux2]
[../]
[./aux3]
order = TENZILLION
[../]
[./aux4]
[../]
[]
[AuxKernels]
active = 'aux2 aux4'
# You can use active or inactive depending on whatever is easier
[./aux1]
type = ConstantAux
value = 1
variable = aux1
[../]
[./aux2]
type = ConstantAux
value = 2
variable = aux2
[../]
[./aux3]
type = ConstantAux
value = 3
variable = aux3
[../]
[./aux4]
type = ConstantAux
value = 4
variable = aux4
[../]
[]
[Kernels]
inactive = ''
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
inactive = ''
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
inactive = Adaptivity
[./Adaptivity]
[../]
[]
# No output so we can override several parameters and test them concurrently
test/tests/kernels/2d_diffusion/parallel_diffusion_test.i
###########################################################
# This is a simple test of the Kernel System.
# It solves the Laplacian equation on a small 2x2 grid.
# The "Diffusion" kernel is used to calculate the
# residuals of the weak form of this operator.
#
# @Requirement F3.30
###########################################################
[Mesh]
file = square.2.cpr
parallel_type = DISTRIBUTED
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'NEWTON'
[]
[Outputs]
nemesis = true
# exodus = true
[]
modules/porous_flow/test/tests/gravity/grav01b.i
# Checking that gravity head is established
# 1phase, vanGenuchten, constant and large fluid-bulk, constant viscosity, constant permeability, Corey relperm
# fully saturated
# For better agreement with the analytical solution (ana_pp), just increase nx
[Mesh]
type = GeneratedMesh
dim = 1
nx = 100
xmin = -1
xmax = 0
[]
[GlobalParams]
PorousFlowDictator = dictator
[]
[Variables]
[./pp]
[./InitialCondition]
type = RandomIC
min = 0
max = 1
[../]
[../]
[]
[Kernels]
[./flux0]
type = PorousFlowAdvectiveFlux
fluid_component = 0
variable = pp
gravity = '-1 0 0'
[../]
[]
[Functions]
[./ana_pp]
type = ParsedFunction
vars = 'g B p0 rho0'
vals = '1 1E3 0 1'
value = '-B*log(exp(-p0/B)+g*rho0*x/B)' # expected pp at base
[../]
[]
[BCs]
[./z]
type = PresetBC
variable = pp
boundary = right
value = 0
[../]
[]
[UserObjects]
[./dictator]
type = PorousFlowDictator
porous_flow_vars = 'pp'
number_fluid_phases = 1
number_fluid_components = 1
[../]
[./pc]
type = PorousFlowCapillaryPressureVG
m = 0.5
alpha = 1
[../]
[]
[Modules]
[./FluidProperties]
[./simple_fluid]
type = SimpleFluidProperties
bulk_modulus = 1e3
density0 = 1
viscosity = 1
thermal_expansion = 0
[../]
[../]
[]
[Materials]
[./temperature]
type = PorousFlowTemperature
[../]
[./ppss]
type = PorousFlow1PhaseP
porepressure = pp
capillary_pressure = pc
[../]
[./massfrac]
type = PorousFlowMassFraction
[../]
[./simple_fluid]
type = PorousFlowSingleComponentFluid
fp = simple_fluid
phase = 0
[../]
[./permeability]
type = PorousFlowPermeabilityConst
permeability = '1 0 0 0 2 0 0 0 3'
[../]
[./relperm]
type = PorousFlowRelativePermeabilityCorey
n = 1
phase = 0
[../]
[]
[Postprocessors]
[./pp_base]
type = PointValue
variable = pp
point = '-1 0 0'
[../]
[./pp_analytical]
type = FunctionValuePostprocessor
function = ana_pp
point = '-1 0 0'
[../]
[]
[Preconditioning]
active = andy
[./andy]
type = SMP
full = true
petsc_options_iname = '-ksp_type -pc_type -snes_atol -snes_rtol -snes_max_it'
petsc_options_value = 'bcgs bjacobi 1E-15 1E-10 10000'
[../]
[./check]
type = SMP
full = true
petsc_options_iname = '-ksp_type -pc_type -snes_atol -snes_rtol -snes_max_it -snes_type'
petsc_options_value = 'bcgs bjacobi 1E-15 1E-10 10000 test'
[../]
[]
[Executioner]
type = Steady
solve_type = Newton
[]
[Outputs]
execute_on = 'timestep_end'
file_base = grav01b
[./csv]
type = CSV
[../]
[]
modules/stochastic_tools/test/tests/distributions/uniform.i
[Mesh]
type = GeneratedMesh
dim = 1
nx = 1
ny = 1
[]
[Variables]
[./u]
[../]
[]
[Distributions]
[./uniform]
type = UniformDistribution
lower_bound = 5
upper_bound = 10
[../]
[]
[Postprocessors]
[./cdf]
type = TestDistributionPostprocessor
distribution = uniform
value = 7.5
method = cdf
execute_on = initial
[../]
[./pdf]
type = TestDistributionPostprocessor
distribution = uniform
value = 7.5
method = pdf
execute_on = initial
[../]
[./quantile]
type = TestDistributionPostprocessor
distribution = uniform
value = 0.5
method = quantile
execute_on = initial
[../]
[]
[Executioner]
type = Steady
[]
[Problem]
solve = false
kernel_coverage_check = false
[]
[Outputs]
execute_on = 'INITIAL'
csv = true
[]
test/tests/vectorpostprocessors/intersection_points_along_line/1d.i
[Mesh]
type = GeneratedMesh
dim = 1
nx = 10
# Ray tracing code is not yet compatible with DistributedMesh
parallel_type = replicated
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[VectorPostprocessors]
[./intersections]
type = IntersectionPointsAlongLine
start = '0.05 0 0'
end = '0.405 0 0'
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
csv = true
[]
test/tests/controls/tag_based_naming_access/object_param.i
[Mesh]
type = GeneratedMesh
dim = 2
elem_type = QUAD4
# use odd numbers so points do not fall on element boundaries
nx = 31
ny = 31
[]
[Variables]
[./diffused]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = diffused
[../]
[]
[DiracKernels]
[./test_object]
type = MaterialPointSource
point = '0.5 0.5 0'
variable = diffused
control_tags = 'tag'
[../]
[]
[BCs]
[./bottom_diffused]
type = DirichletBC
variable = diffused
boundary = 'bottom'
value = 2
[../]
[./top_diffused]
type = DirichletBC
variable = diffused
boundary = 'top'
value = 0
[../]
[]
[Materials]
[./mat]
type = GenericConstantMaterial
prop_names = 'matp'
prop_values = '1'
block = 0
[../]
[]
[Postprocessors]
[./test_object]
type = FunctionValuePostprocessor
function = '2*(x+y)'
point = '0.5 0.5 0'
control_tags = 'tag'
[../]
[./other_point_test_object]
type = FunctionValuePostprocessor
function = '3*(x+y)'
point = '0.5 0.5 0'
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
execute_on = 'timestep_end'
exodus = true
[]
[Controls]
[./point_control]
type = TestControl
test_type = 'point'
parameter = 'tag::*/point'
execute_on = 'initial'
[../]
[]
test/tests/postprocessors/postprocessor_comparison/postprocessor_comparison.i
# This tests the PostprocessorComparison post-processor, which compares two
# post-processors.
[Mesh]
type = GeneratedMesh
dim = 1
nx = 1
xmin = 0
xmax = 1
[]
[Postprocessors]
[./pp_to_compare]
type = LinearCombinationPostprocessor
pp_names = ''
pp_coefs = ''
b = 1
[../]
[./pp_comparison]
type = PostprocessorComparison
value_a = pp_to_compare
value_b = 2
comparison_type = greater_than
execute_on = 'initial'
[../]
[]
[Problem]
solve = false
[]
[Executioner]
type = Steady
[]
[Outputs]
file_base = greater_than
csv = true
show = 'pp_comparison'
execute_on = 'initial'
[]
test/tests/materials/get_material_property_names/get_material_property_any_boundary_id.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[MeshModifiers]
[./add_subdomain]
type = SubdomainBoundingBox
top_right = '1 1 0'
bottom_left = '0 0.5 0'
block_id = 100
block_name = 'top'
[../]
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Materials]
[./boundary]
type = GenericConstantMaterial
prop_names = boundary_prop
boundary = ANY_BOUNDARY_ID
prop_values = 54321
[../]
[]
[UserObjects]
[./get_material_boundary_names_test]
type = GetMaterialPropertyBoundaryBlockNamesTest
expected_names = 'ANY_BOUNDARY_ID'
property_name = 'boundary_prop'
test_type = 'boundary'
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/mesh_modifiers/add_side_sets/cylinder_normals.i
###########################################################
# This is test of the Mesh Modification System. This
# test adds sidesets to a mesh based on geometric normals
# to the faces or edges of the mesh. In this case sidesets
# are added to the top, bottom and side of a cylinder.
#
# @Requirement F2.20
###########################################################
[Mesh]
type = FileMesh
file = cylinder.e
# This MeshModifier currently only works with ReplicatedMesh.
# For more information, refer to #2129.
parallel_type = replicated
[]
# Mesh Modifiers
[MeshModifiers]
[./add_side_sets]
type = SideSetsFromNormals
normals = '0 0 1
0 1 0
0 0 -1'
# This parameter allows the normal
# to vary slightly from adjacent element
# to element so that a sidset can follow
# a curve. It is false by default.
fixed_normal = false
new_boundary = 'top side bottom'
[../]
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./bottom]
type = DirichletBC
variable = u
boundary = bottom
value = 0
[../]
[./top]
type = DirichletBC
variable = u
boundary = top
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
modules/stochastic_tools/test/tests/multiapps/commandline_control/master_wrong_num_params.i
[Mesh]
type = GeneratedMesh
dim = 1
[]
[Problem]
type = FEProblem
solve = false
[]
[Executioner]
type = Steady
[]
[Distributions]
[./uniform]
type = UniformDistribution
lower_bound = 5
upper_bound = 10
[../]
[]
[Samplers]
[./sample]
type = MonteCarloSampler
n_samples = 3
distributions = 'uniform uniform'
execute_on = 'initial timestep_end'
[../]
[]
[MultiApps]
[sub]
type = FullSolveMultiApp
positions = '0 0 0
1 1 1
2 2 2'
input_files = 'sub.i'
[]
[]
[Controls]
[cmdline]
type = MultiAppCommandLineControl
multi_app = sub
sampler = sample
param_names = 'Mesh/xmax Mesh/ymax Mesh/zmax'
[]
[]
test/tests/mesh_modifiers/assign_element_subdomain_id/tri_with_subdomainid_test.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
nz = 0
zmin = 0
zmax = 0
elem_type = TRI3
[]
[MeshModifiers]
[./subdomain_id]
type = AssignElementSubdomainID
subdomain_ids = '0 1 1 1
1 1 1 0'
[../]
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
active = 'left right'
# Mesh Generation produces boundaries in counter-clockwise fashion
[./left]
type = DirichletBC
variable = u
boundary = 3
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 1
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out_tri_subdomain_id
exodus = true
[]
test/tests/mesh/node_list_from_side_list/node_list_from_side_list.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
construct_node_list_from_side_list = false
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/markers/q_point_marker/q_point_marker.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
nz = 0
zmax = 0
elem_type = QUAD4
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Problem]
type = FEProblem
solve = false
[]
[Executioner]
type = Steady
solve_type = PJFNK
[]
[Adaptivity]
[./Markers]
[./marker]
type = QPointMarker
variable = u
[../]
[../]
[]
[Outputs]
exodus = true
[]
test/tests/materials/derivativematerialinterface/test.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 1
ny = 1
[]
[Materials]
[./provider]
type = DerivativeMaterialInterfaceTestProvider
block = 0
outputs = exodus
output_properties = 'dprop/db dprop/da d^2prop/dadb d^2prop/dadc d^3prop/dadbdc'
[../]
[./client]
type = DerivativeMaterialInterfaceTestClient
block = 0
[../]
[]
[Executioner]
type = Steady
[]
[Problem]
solve = false
[]
[Debug]
show_material_props = true
[]
[Outputs]
exodus = true
[]
test/tests/dgkernels/dg_displacement/dg_displacement.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
displacements = 'disp_x disp_y'
[]
[Variables]
[./u]
order = FIRST
family = MONOMIAL
[../]
[]
[AuxVariables]
[./disp_x]
[../]
[./disp_y]
[../]
[]
[Functions]
[./forcing_fn]
type = ParsedFunction
value = 2*pow(e,-x-(y*y))*(1-2*y*y)
[../]
[./exact_fn]
type = ParsedGradFunction
value = pow(e,-x-(y*y))
grad_x = -pow(e,-x-(y*y))
grad_y = -2*y*pow(e,-x-(y*y))
[../]
[./disp_func]
type = ParsedFunction
value = x
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[./abs]
type = Reaction
variable = u
[../]
[./forcing]
type = BodyForce
variable = u
function = forcing_fn
[../]
[]
[DGKernels]
[./dg_diff]
type = DGDiffusion
variable = u
epsilon = -1
sigma = 6
use_displaced_mesh = true
[../]
[]
[BCs]
[./all]
type = DGFunctionDiffusionDirichletBC
variable = u
boundary = '0 1 2 3'
function = exact_fn
epsilon = -1
sigma = 6
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
nl_rel_tol = 1e-10
[]
[Outputs]
execute_on = 'timestep_end'
file_base = out
exodus = true
[]
[ICs]
[./disp_x_ic]
function = disp_func
variable = disp_x
type = FunctionIC
[../]
[]
test/tests/mesh/mesh_generation/annulus.i
# Generates an Annular Mesh
# Radius of inside circle=1
# Radius of outside circle=5
# Solves the diffusion equation with
# u=0 on inside
# u=log(5) on outside
[Mesh]
type = AnnularMesh
nr = 10
nt = 12
rmin = 1
rmax = 5
growth_r = 1.3
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./inner]
type = PresetBC
variable = u
value = 0.0
boundary = rmin
[../]
[./outer]
type = FunctionPresetBC
variable = u
function = log(5)
boundary = rmax
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
[]
[Outputs]
exodus = true
[]
test/tests/transfers/multiapp_projection_transfer/high_order_sub.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 4
ny = 4
[]
[Functions]
[./test_function]
type = ParsedFunction
value = '2.5*x^2 + 0.75*y^2 + 0.15*x*y'
[../]
[]
[AuxVariables]
[./from_master]
family = monomial
order = first
[../]
[./test_var]
family = monomial
order = first
[./InitialCondition]
type = FunctionIC
function = test_function
[../]
[../]
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
[]
[Outputs]
execute_on = 'timestep_end'
exodus = true
[]
test/tests/misc/check_error/kernel_with_empty_var.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[./rea]
type = Reaction
variable = ''
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'NEWTON'
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/controls/dependency/test.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[AuxVariables]
[./a]
family = SCALAR
order = FIRST
[../]
[]
[AuxScalarKernels]
[./a_sk]
type = ConstantScalarAux
variable = a
value = 0
[../]
[]
[Kernels]
[./diff]
type = CoefDiffusion
variable = u
coef = 0.1
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
csv = true
[]
[Functions]
[./func_coef]
type = ParsedFunction
value = 1
[../]
[]
[Controls]
# We start with a = 0, control2 sets its value to 1 and then control1 will multiply it by 3,
# so the end value has to be 3. If dependecy is broken, we multiply by 3 and then set to 1,
# which is wrong
[./control1]
type = TestControl
parameter = 'AuxScalarKernels/a_sk/value'
test_type = MULT
execute_on = 'initial timestep_begin'
depends_on = control2
[../]
[./control2]
type = RealFunctionControl
parameter = 'AuxScalarKernels/a_sk/value'
function = 'func_coef'
execute_on = 'initial timestep_begin'
[../]
[]
test/tests/misc/check_error/deprecated_block_test.i
[Mesh]
file = square.e
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[DeprecatedBlock]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/misc/check_error/function_file_test17.i
# Test for usage of missing function
[Mesh]
file = square.e
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[./InitialCondition]
type = FunctionIC
function = ic_function
[../]
[../]
[]
[Functions]
[./ic_function]
type = PiecewiseLinear
data_file = piecewise_linear_rows_more_data.csv
xy_in_file_only = false
x_index_in_file = 0
y_index_in_file = 0 # will generate an error because x and y index are equal
scale_factor = 1.0
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out
exodus = true
[]
modules/phase_field/test/tests/flood_counter_aux_test/simple.i
[Mesh]
file = square_nodes.e
uniform_refine = 0
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[./v]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxVariables]
[./bubble_map0]
order = FIRST
family = LAGRANGE
[../]
[./bubble_map1]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[./diffv]
type = Diffusion
variable = v
[../]
[]
[AuxKernels]
[./mapper0]
type = FeatureFloodCountAux
variable = bubble_map0
execute_on = timestep_end
flood_counter = bubbles
map_index = 0
[../]
[./mapper1]
type = FeatureFloodCountAux
variable = bubble_map1
execute_on = timestep_end
flood_counter = bubbles
map_index = 1
[../]
[]
[BCs]
[./bott_left]
type = DirichletBC
variable = u
boundary = 1
value = 1
[../]
[./bott_right]
type = DirichletBC
variable = v
boundary = 2
value = 1
[../]
[./up_right]
type = DirichletBC
variable = u
boundary = 3
value = 1
[../]
[./up_left]
type = DirichletBC
variable = v
boundary = 4
value = 1
[../]
[./the_rest_u]
type = DirichletBC
variable = u
boundary = '5 6 7 8'
value = 0
[../]
[./the_rest_v]
type = DirichletBC
variable = v
boundary = '5 6 7 8'
value = 0
[../]
[]
[UserObjects]
[./bubbles]
use_single_map = false
type = FeatureFloodCount
variable = 'u v'
threshold = 0.3
execute_on = timestep_end
outputs = none
flood_entity_type = NODAL
[../]
[]
[Executioner]
type = Steady
[]
[Outputs]
execute_on = 'timestep_end'
exodus = true
[]
test/tests/ics/check_error/two_ics_on_same_block_global.i
[Mesh]
type = FileMesh
file = 'rectangle.e'
[]
[Variables]
[./u]
[../]
[]
[ICs]
[./block]
type = ConstantIC
variable = u
value = 2
[../]
[./block2]
type = ConstantIC
variable = u
value = 0.5
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[Executioner]
type = Steady
[]
[Outputs]
[]
modules/combined/test/tests/nodal_area/nodal_area_2D.i
[Mesh]
file = nodal_area_2D.e
[]
[Problem]
coord_type = RZ
[]
[Variables]
[./dummy]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxVariables]
[./nodal_area]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./dummy]
type = Diffusion
variable = dummy
[../]
[]
[UserObjects]
[./nodal_area]
type = NodalArea
variable = nodal_area
boundary = 1
execute_on = 'initial timestep_end'
[../]
[]
[BCs]
[./dummy]
type = DirichletBC
variable = dummy
boundary = 1
value = 100
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -ksp_gmres_restart'
petsc_options_value = 'jacobi 101'
line_search = 'none'
nl_abs_tol = 1e-11
nl_rel_tol = 1e-10
l_max_its = 20
[]
[Outputs]
exodus = true
[]
test/tests/parser/parser/active_section_test.i
[Mesh]
active = ''
file = square.e
uniform_refine = 3
[./inactive]
type = NonexistentAction
[../]
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[./InitialCondition]
type = BoundingBoxIC
x1 = 0.1
y1 = 0.1
x2 = 0.6
y2 = 0.6
inside = 2.3
outside = 4.6
[../]
[../]
[./u_aux]
order = FIRST
family = LAGRANGE
[./InitialCondition]
type = BoundingBoxIC
x1 = 0.1
y1 = 0.1
x2 = 0.6
y2 = 0.6
inside = 1.34
outside = 6.67
[../]
[../]
[]
[AuxVariables]
active = 'u_aux'
[./u_aux]
order = FIRST
family = LAGRANGE
[./InitialCondition]
type = BoundingBoxIC
x1 = 0.1
y1 = 0.1
x2 = 0.6
y2 = 0.6
inside = 1.34
outside = 6.67
[../]
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[./inactive]
type = NonexistentBC
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/outputs/exodus/exodus.i
###########################################################
# This is a simple test demonstrating the ability to create
# a user-defined output type (ExodusII format).
#
# @Requirement F1.70
###########################################################
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
execute_on = 'timestep_end'
# Demonstration of using an Exodus Outputter
[./out]
type = Exodus
[../]
[]
[Debug]
show_var_residual_norms = true
#show_actions = true
[]
test/tests/outputs/error/all_reserved.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
execute_on = 'timestep_end'
exodus = true
[./all]
type = Exodus
[../]
[]
test/tests/dirackernels/aux_scalar_variable/aux_scalar_variable.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
uniform_refine = 2
[]
[Variables]
[./u]
[../]
[]
[AuxVariables]
[./shared]
family = SCALAR
initial_condition = 2
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Postprocessors]
[./source_value]
type = ScalarVariable
variable = shared
execute_on = 'initial timestep_end'
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
hide = shared
exodus = true
[]
[DiracKernels]
[./source_0]
variable = u
shared = shared
type = ReportingConstantSource
point = '0.2 0.2'
[../]
[./source_1]
point = '0.8 0.8'
factor = 2
variable = u
shared = shared
type = ReportingConstantSource
[../]
[]
test/tests/vectorpostprocessors/csv_reader/read.i
[Mesh]
type = GeneratedMesh
dim = 1
[]
[Problem]
solve = false
[]
[Executioner]
type = Steady
[]
[UserObjects]
[./tester]
type = TestCSVReader
vectorpostprocessor = reader
vector = year
gold = '1980 1980 2011 2013'
rank = 1
[../]
[]
[VectorPostprocessors]
[./reader]
type = CSVReader
csv_file = example.csv
[../]
[]
[Outputs]
csv = true
[]
test/tests/tag/2d_diffusion_vector_tag_test.i
[Mesh]
file = square.e
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
initial_condition = 1.0
[../]
[]
[AuxVariables]
[./tag_variable1]
order = FIRST
family = LAGRANGE
[../]
[./tag_variable2]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./reaction1]
type = Reaction
variable = u
extra_vector_tags = 'vec_tag1 vec_tag2'
[../]
[./reaction2]
type = Reaction
variable = u
extra_vector_tags = 'vec_tag1 vec_tag2'
[../]
[./reaction3]
type = Reaction
variable = u
[../]
[./reaction4]
type = Reaction
variable = u
[../]
[]
[AuxKernels]
[./TagVectorAux1]
type = TagVectorAux
variable = tag_variable1
v = u
vector_tag = vec_tag1
execute_on = timestep_end
[../]
[./TagVectorAux2]
type = TagVectorAux
variable = tag_variable2
v = u
vector_tag = vec_tag2
execute_on = timestep_end
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 10
extra_vector_tags = vec_tag1
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 100
extra_vector_tags = vec_tag2
[../]
[./right1]
type = DirichletBC
variable = u
boundary = 2
value = 100
[../]
[./right2]
type = DirichletBC
variable = u
boundary = 2
value = 100
[../]
[]
[Problem]
type = TagTestProblem
extra_tag_vectors = 'vec_tag1 vec_tag2'
test_tag_vectors = 'vec_tag1 vec_tag2'
[]
[Executioner]
type = Steady
solve_type = 'NEWTON'
[]
[Outputs]
file_base = vector_tag_test_out
exodus = true
[]
test/tests/kernels/anisotropic_diffusion/aniso_diffusion.i
[Mesh]
file = mixed_block.e
uniform_refine=3
[]
[Functions]
[./top_bc]
type = ParsedFunction
value = 'x'
[../]
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff]
type = AnisotropicDiffusion
variable = u
tensor_coeff = '2 0 0
0 4 0
0 0 0'
[../]
[]
[BCs]
active = 'lower_left top'
[./lower_left]
type = DirichletBC
variable = u
boundary = '1 4'
value = 1
[../]
[./top]
type = FunctionNeumannBC
variable = u
boundary = 3
function = top_bc
[../]
[./right]
type = NeumannBC
variable = u
boundary = 2
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
exodus = true
[]
test/tests/misc/check_error/missing_function_test.i
# Test for usage of missing function
[Mesh]
file = square.e
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[./InitialCondition]
type = FunctionIC
function = missing_function #should generate error
[../]
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/userobjects/layered_average/layered_average_bounds.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[AuxVariables]
[./layered_average]
order = CONSTANT
family = MONOMIAL
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[AuxKernels]
[./layered_average]
type = SpatialUserObjectAux
variable = layered_average
execute_on = timestep_end
user_object = average
[../]
[]
[BCs]
[./top]
type = DirichletBC
variable = u
boundary = top
value = 1
[../]
[./bottom]
type = DirichletBC
variable = u
boundary = bottom
value = 0
[../]
[]
[UserObjects]
[./average]
type = LayeredAverage
variable = u
direction = y
bounds = '0 0.2 0.5 1'
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
modules/porous_flow/test/tests/thm_rehbinder/fixed_outer.i
[Mesh]
type = AnnularMesh
nr = 40
nt = 16
rmin = 0.1
rmax = 1
tmin = 0.0
tmax = 1.570796326795
growth_r = 1.1
[]
[MeshModifiers]
[./make3D]
type = MeshExtruder
bottom_sideset = bottom
top_sideset = top
extrusion_vector = '0 0 1'
num_layers = 1
[../]
[]
[GlobalParams]
displacements = 'disp_x disp_y disp_z'
PorousFlowDictator = dictator
biot_coefficient = 1.0
[]
[Variables]
[./disp_x]
[../]
[./disp_y]
[../]
[./disp_z]
[../]
[./porepressure]
[../]
[./temperature]
[../]
[]
[BCs]
[./plane_strain]
type = PresetBC
variable = disp_z
value = 0
boundary = 'top bottom'
[../]
[./ymin]
type = PresetBC
variable = disp_y
value = 0
boundary = tmin
[../]
[./xmin]
type = PresetBC
variable = disp_x
value = 0
boundary = tmax
[../]
[./cavity_temperature]
type = DirichletBC
variable = temperature
value = 1000
boundary = rmin
[../]
[./cavity_porepressure]
type = DirichletBC
variable = porepressure
value = 1E6
boundary = rmin
[../]
[./cavity_zero_effective_stress_x]
type = Pressure
component = 0
variable = disp_x
function = 1E6
boundary = rmin
use_displaced_mesh = false
[../]
[./cavity_zero_effective_stress_y]
type = Pressure
component = 1
variable = disp_y
function = 1E6
boundary = rmin
use_displaced_mesh = false
[../]
[./outer_temperature]
type = PresetBC
variable = temperature
value = 0
boundary = rmax
[../]
[./outer_pressure]
type = PresetBC
variable = porepressure
value = 0
boundary = rmax
[../]
[./fixed_outer_x]
type = PresetBC
variable = disp_x
value = 0
boundary = rmax
[../]
[./fixed_outer_y]
type = PresetBC
variable = disp_y
value = 0
boundary = rmax
[../]
[]
[AuxVariables]
[./stress_rr]
family = MONOMIAL
order = CONSTANT
[../]
[./stress_pp]
family = MONOMIAL
order = CONSTANT
[../]
[]
[AuxKernels]
[./stress_rr]
type = RankTwoScalarAux
rank_two_tensor = stress
variable = stress_rr
scalar_type = RadialStress
point1 = '0 0 0'
point2 = '0 0 1'
[../]
[./stress_pp]
type = RankTwoScalarAux
rank_two_tensor = stress
variable = stress_pp
scalar_type = HoopStress
point1 = '0 0 0'
point2 = '0 0 1'
[../]
[]
[Modules]
[./FluidProperties]
[./the_simple_fluid]
type = SimpleFluidProperties
thermal_expansion = 0.0
bulk_modulus = 1E12
viscosity = 1.0E-3
density0 = 1000.0
cv = 1000.0
cp = 1000.0
porepressure_coefficient = 0.0
[../]
[../]
[]
[PorousFlowBasicTHM]
coupling_type = ThermoHydroMechanical
multiply_by_density = false
add_stress_aux = true
porepressure = porepressure
temperature = temperature
thermal_eigenstrain_name = thermal_contribution
gravity = '0 0 0'
fp = the_simple_fluid
[]
[Materials]
[./elasticity_tensor]
type = ComputeIsotropicElasticityTensor
youngs_modulus = 1E10
poissons_ratio = 0.2
[../]
[./strain]
type = ComputeSmallStrain
eigenstrain_names = thermal_contribution
[../]
[./thermal_contribution]
type = ComputeThermalExpansionEigenstrain
temperature = temperature
thermal_expansion_coeff = 1E-6
eigenstrain_name = thermal_contribution
stress_free_temperature = 0.0
[../]
[./stress]
type = ComputeLinearElasticStress
[../]
[./porosity]
type = PorousFlowPorosityConst # only the initial value of this is ever used
porosity = 0.1
[../]
[./biot_modulus]
type = PorousFlowConstantBiotModulus
solid_bulk_compliance = 1E-10
fluid_bulk_modulus = 1E12
[../]
[./permeability]
type = PorousFlowPermeabilityConst
permeability = '1E-12 0 0 0 1E-12 0 0 0 1E-12'
[../]
[./thermal_expansion]
type = PorousFlowConstantThermalExpansionCoefficient
fluid_coefficient = 1E-6
drained_coefficient = 1E-6
[../]
[./thermal_conductivity]
type = PorousFlowThermalConductivityIdeal
dry_thermal_conductivity = '1E6 0 0 0 1E6 0 0 0 1E6'
[../]
[]
[VectorPostprocessors]
[./P]
type = LineValueSampler
start_point = '0.1 0 0'
end_point = '1.0 0 0'
num_points = 10
sort_by = x
variable = porepressure
[../]
[./T]
type = LineValueSampler
start_point = '0.1 0 0'
end_point = '1.0 0 0'
num_points = 10
sort_by = x
variable = temperature
[../]
[./U]
type = LineValueSampler
start_point = '0.1 0 0'
end_point = '1.0 0 0'
num_points = 10
sort_by = x
variable = disp_x
[../]
[]
[Preconditioning]
[./andy]
type = SMP
full = true
petsc_options_iname = '-ksp_type -pc_type -sub_pc_type -snes_rtol'
petsc_options_value = 'gmres asm lu 1E-8'
[../]
[]
[Executioner]
type = Steady
solve_type = Newton
[]
[Outputs]
file_base = fixed_outer
execute_on = timestep_end
csv = true
[]
test/tests/misc/check_error/function_file_test7.i
# Test for usage of missing function
[Mesh]
file = square.e
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[./InitialCondition]
type = FunctionIC
function = ic_function
[../]
[../]
[]
[Functions]
[./ic_function]
type = PiecewiseLinear
x = '1'
scale_factor = 1.0
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/misc/check_error/function_file_test11.i
# Test for usage of missing function
[Mesh]
file = square.e
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[./InitialCondition]
type = FunctionIC
function = ic_function
[../]
[../]
[]
[Functions]
[./ic_function]
type = PiecewiseLinear
data_file = piecewise_linear_columns_more_data.csv #Will generate error because data has more than two columns
format = columns
scale_factor = 1.0
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/variables/fe_monomial_const/monomial-const-2d.i
[Mesh]
type = GeneratedMesh
dim = 2
xmin = -1
xmax = 1
ymin = -1
ymax = 1
nx = 100
ny = 100
elem_type = QUAD4
[]
[Functions]
[./bc_fn]
type=ParsedFunction
value=0
[../]
[./bc_fnt]
type = ParsedFunction
value = 0
[../]
[./bc_fnb]
type = ParsedFunction
value = 0
[../]
[./bc_fnl]
type = ParsedFunction
value = 0
[../]
[./bc_fnr]
type = ParsedFunction
value = 0
[../]
[./forcing_fn]
# type = ParsedFunction
# value = 0
type = MTPiecewiseConst2D
[../]
[./solution]
type = MTPiecewiseConst2D
[../]
[]
[Variables]
[./u]
order = CONSTANT
family = MONOMIAL
[../]
[]
[Kernels]
active = 'diff forcing reaction'
[./diff]
type = Diffusion
variable = u
[../]
[./reaction]
type = Reaction
variable = u
[../]
[./forcing]
type = BodyForce
variable = u
function = forcing_fn
[../]
[]
[BCs]
# Note: MOOSE's DirichletBCs do not work properly with shape functions that do not
# have DOFs at the element edges. This test works because the solution
# has been designed to be zero at the boundary which is satisfied by the IC
# Ticket #1352
active = ''
[./bc_all]
type=FunctionDirichletBC
variable = u
boundary = 'top bottom left right'
function = bc_fn
[../]
[./bc_top]
type = FunctionNeumannBC
variable = u
boundary = 'top'
function = bc_fnt
[../]
[./bc_bottom]
type = FunctionNeumannBC
variable = u
boundary = 'bottom'
function = bc_fnb
[../]
[./bc_left]
type = FunctionNeumannBC
variable = u
boundary = 'left'
function = bc_fnl
[../]
[./bc_right]
type = FunctionNeumannBC
variable = u
boundary = 'right'
function = bc_fnr
[../]
[]
[Postprocessors]
[./dofs]
type = NumDOFs
[../]
[./h]
type = AverageElementSize
[../]
[./L2error]
type = ElementL2Error
variable = u
function = solution
[../]
[./H1error]
type = ElementH1Error
variable = u
function = solution
[../]
[./H1Semierror]
type = ElementH1SemiError
variable = u
function = solution
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
nl_rel_tol = 1.e-10
[./Adaptivity]
[../]
[]
[Outputs]
execute_on = 'timestep_end'
csv = true
[./out]
type = Exodus
elemental_as_nodal = true
[../]
[]
test/tests/variables/fe_hier/hier-2-2d.i
[Mesh]
type = GeneratedMesh
dim = 2
xmin = -1
xmax = 1
ymin = -1
ymax = 1
nx = 5
ny = 5
elem_type = QUAD9
[]
[Functions]
[./bc_fnt]
type = ParsedFunction
value = 2*y
[../]
[./bc_fnb]
type = ParsedFunction
value = -2*y
[../]
[./bc_fnl]
type = ParsedFunction
value = -2*x
[../]
[./bc_fnr]
type = ParsedFunction
value = 2*x
[../]
[./forcing_fn]
type = ParsedFunction
value = -4+x*x+y*y
[../]
[./solution]
type = ParsedGradFunction
value = x*x+y*y
grad_x = 2*x
grad_y = 2*y
[../]
[]
[Variables]
[./u]
order = SECOND
family = HIERARCHIC
[../]
[]
[Kernels]
active = 'diff forcing reaction'
[./diff]
type = Diffusion
variable = u
[../]
[./reaction]
type = Reaction
variable = u
[../]
[./forcing]
type = BodyForce
variable = u
function = forcing_fn
[../]
[]
[BCs]
[./bc_top]
type = FunctionNeumannBC
variable = u
boundary = 'top'
function = bc_fnt
[../]
[./bc_bottom]
type = FunctionNeumannBC
variable = u
boundary = 'bottom'
function = bc_fnb
[../]
[./bc_left]
type = FunctionNeumannBC
variable = u
boundary = 'left'
function = bc_fnl
[../]
[./bc_right]
type = FunctionNeumannBC
variable = u
boundary = 'right'
function = bc_fnr
[../]
[]
[Postprocessors]
[./dofs]
type = NumDOFs
[../]
[./h]
type = AverageElementSize
[../]
[./L2error]
type = ElementL2Error
variable = u
function = solution
[../]
[./H1error]
type = ElementH1Error
variable = u
function = solution
[../]
[./H1Semierror]
type = ElementH1SemiError
variable = u
function = solution
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
execute_on = 'timestep_end'
exodus = true
csv = true
[]
test/tests/fixedbugs/i8575/test.i
# This tests for the bug https://github.com/idaholab/moose/issues/8575.
# It makes sure that the material property dependency checking accounts for
# the fact that materials provided on "ANY_BLOCK" count as satisfying requests
# for that property on all block IDs.
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
[]
[GlobalParams]
block = 0
[]
[AddMatAndKernel]
[]
[Executioner]
type = Steady
solve_type = PJFNK
[]
test/tests/mesh_modifiers/boundingbox_nodeset/boundingbox_nodeset_inside_test.i
[Mesh]
# This MeshModifier currently only works with ReplicatedMesh.
# For more information, refer to #2129.
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
parallel_type = replicated
[]
[MeshModifiers]
[./middle_node]
type = BoundingBoxNodeSet
new_boundary = middle_node
top_right = '1.1 1.1 0'
bottom_left = '0.49 0.49 0'
[../]
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[./middle]
type = DirichletBC
variable = u
boundary = middle_node
value = -1
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
[]
[Outputs]
file_base = boundingbox_nodeset_inside_out
exodus = true
[]
test/tests/materials/material/bnd_material_test.i
[Mesh]
type = GeneratedMesh
dim = 3
xmin = 0
xmax = 1
ymin = 0
ymax = 1
zmin = 0
zmax = 1
nx = 3
ny = 3
nz = 3
[]
# Nonlinear system
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 1
[../]
[./right]
type = MTBC
variable = u
boundary = right
grad = 8
prop_name = matp
[../]
[]
# auxiliary system
[AuxVariables]
[./matp]
order = CONSTANT
family = MONOMIAL
[../]
[]
[AuxKernels]
[./prop]
type = MaterialRealAux
property = matp
variable = matp
boundary = 'left right'
[../]
[]
[Materials]
[./mat_left]
type = MTMaterial
boundary = left
[../]
[./mat_right]
type = MTMaterial
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
[./out]
type = Exodus
elemental_as_nodal = true
[../]
[]
modules/richards/test/tests/jacobian_1/jn_fu_04.i
# unsaturated = true
# gravity = true
# supg = false
# transient = false
[Mesh]
type = GeneratedMesh
dim = 3
nx = 1
ny = 1
nz = 1
xmin = -1
xmax = 1
ymin = -1
ymax = 1
zmin = -1
zmax = 1
[]
[GlobalParams]
richardsVarNames_UO = PPNames
density_UO = DensityConstBulk
relperm_UO = RelPermPower
SUPG_UO = SUPGnone
sat_UO = Saturation
seff_UO = SeffVG
[]
[UserObjects]
[./PPNames]
type = RichardsVarNames
richards_vars = pressure
[../]
[./DensityConstBulk]
type = RichardsDensityConstBulk
dens0 = 1
bulk_mod = 1.0 # notice small quantity, so the PETSc constant state works
[../]
[./SeffVG]
type = RichardsSeff1VG
m = 0.8
al = 1 # notice small quantity, so the PETSc constant state works
[../]
[./RelPermPower]
type = RichardsRelPermPower
simm = 0.2
n = 2
[../]
[./Saturation]
type = RichardsSat
s_res = 0.1
sum_s_res = 0.1
[../]
[./SUPGnone]
type = RichardsSUPGnone
[../]
[]
[Variables]
[./pressure]
order = FIRST
family = LAGRANGE
[./InitialCondition]
type = RandomIC
block = 0
min = -1
max = 0
[../]
[../]
[]
[Kernels]
active = 'richardsf'
[./richardst]
type = RichardsMassChange
variable = pressure
[../]
[./richardsf]
type = RichardsFullyUpwindFlux
variable = pressure
[../]
[]
[Materials]
[./rock]
type = RichardsMaterial
block = 0
mat_porosity = 0.1
mat_permeability = '1E-5 0 0 0 1E-5 0 0 0 1E-5'
viscosity = 1E-3
gravity = '1 2 3'
linear_shape_fcns = true
[../]
[]
[Preconditioning]
[./andy]
type = SMP
full = true
petsc_options_iname = '-ksp_type -pc_type -snes_atol -snes_rtol -snes_max_it -snes_type'
petsc_options_value = 'bcgs bjacobi 1E-15 1E-10 10000 test'
[../]
[]
[Executioner]
type = Steady
solve_type = Newton
[]
[Outputs]
execute_on = 'timestep_end'
file_base = jn04
exodus = false
[]
test/tests/mesh_modifiers/mesh_extruder/extrude_remap_layer2.i
[Mesh]
type = FileMesh
file = multiblock.e
[]
[MeshModifiers]
[./extrude]
type = MeshExtruder
num_layers = 6
extrusion_vector = '0 0 2'
bottom_sideset = 'new_bottom'
top_sideset = 'new_top'
# Remap layers
existing_subdomains = '1 2 5'
layers = '1 3 5'
new_ids = '10 12 15' # Repeat this remapping for each layer
[../]
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./bottom]
type = DirichletBC
variable = u
boundary = 'new_bottom'
value = 0
[../]
[./top]
type = DirichletBC
variable = u
boundary = 'new_top'
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
exodus = true
[]
test/tests/meshgenerators/sidesets_bounding_box_generator/error_no_side_sets_found.i
[MeshGenerators]
[./gmg]
type = GeneratedMeshGenerator
dim = 2
nx = 10
ny = 10
#parallel_type = replicated
[]
[./createNewSidesetOne]
type = SideSetsFromBoundingBoxGenerator
input = gmg
boundary_id_old = 'right'
boundary_id_new = 11
bottom_left = '-0.1 -0.1 0'
top_right = '0.9 0.9 0'
block_id = 0
[]
[]
[Mesh]
type = MeshGeneratorMesh
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./leftBC]
type = DirichletBC
variable = u
boundary = 'left'
value = 1
[../]
[./rightBC]
type = DirichletBC
variable = u
boundary = 11
value = 0
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
modules/porous_flow/test/tests/newton_cooling/nc02.i
# Newton cooling from a bar. 1-phase steady
[Mesh]
type = GeneratedMesh
dim = 2
nx = 1000
ny = 1
xmin = 0
xmax = 100
ymin = 0
ymax = 1
[]
[GlobalParams]
PorousFlowDictator = dictator
[]
[UserObjects]
[./dictator]
type = PorousFlowDictator
porous_flow_vars = 'pressure'
number_fluid_phases = 1
number_fluid_components = 1
[../]
[./pc]
type = PorousFlowCapillaryPressureVG
m = 0.8
alpha = 1e-5
[../]
[]
[Variables]
[./pressure]
[../]
[]
[ICs]
[./pressure]
type = FunctionIC
variable = pressure
function = '(2-x/100)*1E6'
[../]
[]
[Kernels]
[./flux]
type = PorousFlowAdvectiveFlux
fluid_component = 0
gravity = '0 0 0'
variable = pressure
[../]
[]
[Modules]
[./FluidProperties]
[./simple_fluid]
type = SimpleFluidProperties
bulk_modulus = 1e6
density0 = 1000
thermal_expansion = 0
viscosity = 1e-3
[../]
[../]
[]
[Materials]
[./temperature]
type = PorousFlowTemperature
[../]
[./ppss]
type = PorousFlow1PhaseP
porepressure = pressure
capillary_pressure = pc
[../]
[./massfrac]
type = PorousFlowMassFraction
[../]
[./simple_fluid]
type = PorousFlowSingleComponentFluid
fp = simple_fluid
phase = 0
[../]
[./porosity]
type = PorousFlowPorosityConst
porosity = 0.1
[../]
[./permeability]
type = PorousFlowPermeabilityConst
permeability = '1E-15 0 0 0 1E-15 0 0 0 1E-15'
[../]
[./relperm]
type = PorousFlowRelativePermeabilityCorey # irrelevant in this fully-saturated situation
n = 2
phase = 0
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = pressure
boundary = left
value = 2E6
[../]
[./newton]
type = PorousFlowPiecewiseLinearSink
variable = pressure
boundary = right
pt_vals = '0 100000 200000 300000 400000 500000 600000 700000 800000 900000 1000000 1100000 1200000 1300000 1400000 1500000 1600000 1700000 1800000 1900000 2000000'
multipliers = '0. 5.6677197748570516e-6 0.000011931518841831313 0.00001885408740732065 0.000026504708864284114 0.000034959953203725676 0.000044304443352900224 0.00005463170211001232 0.00006604508815181467 0.00007865883048198513 0.00009259917167338928 0.00010800563134618119 0.00012503240252705603 0.00014384989486488752 0.00016464644014777016 0.00018763017719085535 0.0002130311349595711 0.00024110353477682344 0.00027212833465544285 0.00030641604122040985 0.00034430981736352295'
use_mobility = false
use_relperm = false
fluid_phase = 0
flux_function = 1
[../]
[]
[VectorPostprocessors]
[./porepressure]
type = LineValueSampler
variable = pressure
start_point = '0 0.5 0'
end_point = '100 0.5 0'
sort_by = x
num_points = 20
execute_on = timestep_end
[../]
[]
[Preconditioning]
active = 'andy'
[./andy]
type = SMP
full = true
petsc_options = '-snes_converged_reason'
petsc_options_iname = '-ksp_type -pc_type -sub_pc_type -snes_max_it -sub_pc_factor_shift_type -pc_asm_overlap -snes_atol -snes_rtol '
petsc_options_value = 'gmres asm lu 100 NONZERO 2 1E-12 1E-15'
[../]
[]
[Executioner]
type = Steady
[]
[Outputs]
file_base = nc02
execute_on = timestep_end
exodus = false
[./along_line]
type = CSV
execute_vector_postprocessors_on = timestep_end
[../]
[]
test/tests/misc/jacobian/med.i
[Mesh]
file = rectangle.e
[]
[Variables]
[./u]
block = 1
[../]
[./v]
[../]
[]
[AuxVariables]
[./w]
[../]
[]
[Kernels]
[./diffu]
type = WrongJacobianDiffusion
block = 1
jfactor = 0.9
variable = u
[../]
[./diffv]
type = WrongJacobianDiffusion
jfactor = 0.7
variable = v
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
test/tests/meshgenerators/generate_extra_nodeset/generate_extra_nodeset.i
[MeshGenerators]
[./fmg]
type = FileMeshGenerator
file = square.e
[]
[./extra_nodeset]
type = ExtraNodesetGenerator
input = fmg
new_boundary = 'middle_node'
nodes = '2'
[]
[]
[Mesh]
type = MeshGeneratorMesh
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
active = 'left right middle'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[./middle]
type = DirichletBC
variable = u
boundary = 'middle_node'
value = -1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
exodus = true
file_base = out
[]
test/tests/functions/constant_function/constant_function_test.i
[Mesh]
type = GeneratedMesh
dim = 2
xmin = -1
xmax = 1
ymin = -1
ymax = 1
nx = 4
ny = 4
elem_type = QUAD4
[]
[Functions]
[./bc_fn]
type = ParsedFunction
value = 'x*x+y*y'
[../]
[./icfn]
type = ConstantFunction
value = 1
[../]
[./ffn]
type = ConstantFunction
value = -4
[../]
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[./InitialCondition]
type = FunctionIC
function = icfn
[../]
[../]
[]
[Kernels]
# Coupling of nonlinear to Aux
[./diff]
type = Diffusion
variable = u
[../]
[./force]
type = BodyForce
variable = u
function = ffn
[../]
[]
[BCs]
[./all]
type = FunctionDirichletBC
variable = u
boundary = '0 1 2 3'
function = bc_fn
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
exodus = true
[]
test/tests/postprocessors/element_l2_norm/element_l2_norm.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 3
ny = 3
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Postprocessors]
[./L2_norm]
type = ElementL2Norm
variable = u
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
csv = true
[]
modules/phase_field/test/tests/KKS_system/kks_phase_concentration.i
#
# This test validates the phase concentration calculation for the KKS system
#
[Mesh]
type = GeneratedMesh
dim = 2
nx = 20
ny = 20
nz = 0
xmin = 0
xmax = 1
ymin = 0
ymax = 1
zmin = 0
zmax = 0
elem_type = QUAD4
[]
# We set c and eta...
[BCs]
# (and ca for debugging purposes)
[./left]
type = DirichletBC
variable = c
boundary = 'left'
value = 0.1
[../]
[./right]
type = DirichletBC
variable = c
boundary = 'right'
value = 0.9
[../]
[./top]
type = DirichletBC
variable = eta
boundary = 'top'
value = 0.1
[../]
[./bottom]
type = DirichletBC
variable = eta
boundary = 'bottom'
value = 0.9
[../]
[]
[Variables]
# concentration
[./c]
order = FIRST
family = LAGRANGE
initial_condition = 0.5
[../]
# order parameter
[./eta]
order = FIRST
family = LAGRANGE
initial_condition = 0.1
[../]
# phase concentration a
[./ca]
order = FIRST
family = LAGRANGE
initial_condition = 0.2
[../]
# phase concentration b
[./cb]
order = FIRST
family = LAGRANGE
initial_condition = 0.3
[../]
[]
[Materials]
# simple toy free energy
[./fa]
type = DerivativeParsedMaterial
f_name = Fa
args = 'ca'
function = 'ca^2'
[../]
[./fb]
type = DerivativeParsedMaterial
f_name = Fb
args = 'cb'
function = '(1-cb)^2'
[../]
# h(eta)
[./h_eta]
type = SwitchingFunctionMaterial
h_order = HIGH
eta = eta
outputs = exodus
[../]
[]
[Kernels]
active = 'cdiff etadiff phaseconcentration chempot'
##active = 'cbdiff cdiff etadiff chempot'
#active = 'cadiff cdiff etadiff phaseconcentration'
##active = 'cadiff cbdiff cdiff etadiff'
[./cadiff]
type = Diffusion
variable = ca
[../]
[./cbdiff]
type = Diffusion
variable = cb
[../]
[./cdiff]
type = Diffusion
variable = c
[../]
[./etadiff]
type = Diffusion
variable = eta
[../]
# ...and solve for ca and cb
[./phaseconcentration]
type = KKSPhaseConcentration
ca = ca
variable = cb
c = c
eta = eta
[../]
[./chempot]
type = KKSPhaseChemicalPotential
variable = ca
cb = cb
fa_name = Fa
fb_namee = Fb
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
#solve_type = 'NEWTON'
[]
[Preconditioning]
active = 'full'
#active = 'mydebug'
#active = ''
[./full]
type = SMP
full = true
[../]
[./mydebug]
type = FDP
full = true
[../]
[]
[Outputs]
execute_on = 'timestep_end'
file_base = kks_phase_concentration
exodus = true
[]
test/tests/variables/fe_hermite_convergence/hermite_converge_dirichlet.i
[Mesh]
type = GeneratedMesh
dim = 2
xmin = -1
xmax = 1
ymin = -1
ymax = 1
nx = 4
ny = 4
elem_type = QUAD4
# This test will not work in parallel with DistributedMesh enabled
# due to a bug in PeriodicBCs.
parallel_type = replicated
[]
[Functions]
[./bc_fn]
type = ParsedGradFunction
value = -sin(pi*x)*sin(pi*y)
grad_x = -pi*cos(pi*x)*sin(pi*y)
grad_y = -pi*sin(pi*x)*cos(pi*y)
[../]
[./forcing_fn]
type = ParsedFunction
value = -2*pi*pi*sin(pi*x)*sin(pi*y)-sin(pi*x)*sin(pi*y)
[../]
[]
[Variables]
[./u]
order = THIRD
family = HERMITE
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[./reaction]
type = Reaction
variable = u
[../]
[./forcing]
type = BodyForce
variable = u
function = forcing_fn
[../]
[]
[BCs]
[./all]
type = FunctionPenaltyDirichletBC
variable = u
boundary = 'bottom right top left'
function = bc_fn
penalty = 1e10
[../]
[]
[Postprocessors]
[./dofs]
type = NumDOFs
[../]
[./h]
type = AverageElementSize
[../]
[./L2error]
type = ElementL2Error
variable = u
function = bc_fn
[../]
[./H1error]
type = ElementH1Error
variable = u
function = bc_fn
[../]
[./H1Semierror]
type = ElementH1SemiError
variable = u
function = bc_fn
[../]
[]
[Executioner]
type = Steady
solve_type = 'NEWTON'
# We use higher-order quadrature to ensure that the forcing function
# is integrated accurately.
[./Quadrature]
order=ELEVENTH
[../]
[]
[Adaptivity]
steps = 2
marker = uniform
[./Markers]
[./uniform]
type = UniformMarker
mark = refine
[../]
[../]
[]
[Outputs]
execute_on = 'timestep_end'
exodus = true
csv = true
print_mesh_changed_info = true
[]
test/tests/misc/check_error/scalar_aux_kernel_with_var.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxVariables]
[./v]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[./rea]
type = Reaction
variable = u
[../]
[]
[AuxScalarKernels]
[./nope]
type = ConstantScalarAux
variable = u
value = 11
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'NEWTON'
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/meshgenerators/generate_sidesets_bounding_box/overlapping_sidesets_not_found.i
[MeshGenerators]
[./gmg]
type = GeneratedMeshGenerator
dim = 3
nx = 10
ny = 10
nz = 10
[]
[./createNewSidesetOne]
type = SideSetsFromBoundingBoxGenerator
input = gmg
boundary_id_old = 'bottom top'
boundary_id_new = 11
bottom_left = '-1.1 -1.1 -1.1'
top_right = '1.1 1.1 1.1'
block_id = 0
boundary_id_overlap = true
[../]
[]
[Mesh]
type = MeshGeneratorMesh
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./BCone]
type = DirichletBC
variable = u
boundary = 'left'
value = 1
[../]
[./BCtwo]
type = DirichletBC
variable = u
boundary = 11
value = 0
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
modules/phase_field/test/tests/new_initial_conditions/PolycrystalVariables_initial_from_file.i
[Mesh]
file = prepare_mesh_out.e
[]
[Variables]
[./PolycrystalVariables]
op_num = 4
var_name_base = gr
initial_from_file = true
[../]
[]
[Executioner]
type = Steady
[]
[Problem]
kernel_coverage_check = false
solve = false
[]
[Outputs]
exodus = true
execute_on = FINAL
[]
test/tests/ics/depend_on_uo/geometric_neighbors_ic.i
# This test verifies that if an Initial Condition depends on a UO and is
# set to "initial" that it will be executed _BEFORE_ the initial condition
[Mesh]
type = GeneratedMesh
dim = 2
nx = 8
ny = 8
# We are testing geometric ghosted functors
# so we have to use distributed mesh
parallel_type = distributed
[]
[Variables]
[./ghost]
order = CONSTANT
family = MONOMIAL
[../]
[]
[ICs]
[./ghost_ic]
type = ElementUOIC
variable = ghost
element_user_object = ghost_uo
field_name = "ghosted"
field_type = long
[../]
[]
[UserObjects]
[./ghost_uo]
type = ElemSideNeighborLayersTester
execute_on = initial
element_side_neighbor_layers = 1
[../]
[]
[Executioner]
type = Steady
[]
[Outputs]
exodus = true
[]
[Problem]
solve = false
kernel_coverage_check = false
[]
python/peacock/tests/input_tab/InputTreeWriter/gold/simple_diffusion.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[u]
[]
[]
[Kernels]
[diff]
type = Diffusion
variable = u
[]
[]
[BCs]
[left]
type = DirichletBC
variable = u
boundary = 'left'
value = 0
[]
[right]
type = DirichletBC
variable = u
boundary = 'right'
value = 1
[]
[]
[Executioner]
# Preconditioned JFNK (default)
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/bcs/nodal_normals/cylinder_hexes_1st_2nd.i
# First order normals on second order mesh
[Mesh]
file = cylinder-hexes-2nd.e
[]
[Functions]
[./all_bc_fn]
type = ParsedFunction
value = x*x+y*y
[../]
[./f_fn]
type = ParsedFunction
value = -4
[../]
[]
[NodalNormals]
boundary = '1'
corner_boundary = 100
order = FIRST
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[./ffn]
type = BodyForce
variable = u
function = f_fn
[../]
[]
[BCs]
[./all]
type = FunctionDirichletBC
variable = u
boundary = '1'
function = 'all_bc_fn'
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
nl_rel_tol = 1e-13
[]
[Outputs]
execute_on = 'timestep_end'
exodus = true
[]
test/tests/postprocessors/num_vars/num_vars.i
[Mesh]
type = GeneratedMesh
dim = 2
xmin = -1
xmax = 1
ymin = -1
ymax = 1
nx = 10
ny = 10
elem_type = QUAD9
[]
[Functions]
[./forcing_fnu]
type = ParsedFunction
value = -6*(x+y)+x*x+y*y
[../]
[./forcing_fnv]
type = ParsedFunction
value = -4+x*x*x-x+y*y*y-y
[../]
[./bc_fnut]
type = ParsedFunction
value = 3*y*y-1
[../]
[./bc_fnub]
type = ParsedFunction
value = -3*y*y+1
[../]
[./bc_fnul]
type = ParsedFunction
value = -3*x*x+1
[../]
[./bc_fnur]
type = ParsedFunction
value = 3*x*x-1
[../]
[./slnu]
type = ParsedGradFunction
value = x*x*x-x+y*y*y-y
grad_x = 3*x*x-1
grad_y = 3*y*y-1
[../]
[./slnv]
type = ParsedGradFunction
value = x*x+y*y
grad_x = 2*x
grad_y = 2*y
[../]
[]
[Variables]
[./u]
order = THIRD
family = HIERARCHIC
[../]
[./v]
order = SECOND
family = LAGRANGE
[../]
[]
[Kernels]
[./diff1]
type = Diffusion
variable = u
[../]
[./test1]
type = CoupledKernelValueTest
variable = u
var2 = v
[../]
[./diff2]
type = Diffusion
variable = v
[../]
[./test2]
type = CoupledKernelValueTest
variable = v
var2 = u
[../]
[./forceu]
type = BodyForce
variable = u
function = forcing_fnu
[../]
[./forcev]
type = BodyForce
variable = v
function = forcing_fnv
[../]
[]
[BCs]
# active = 'bc_u bc_v'
# [./bc_u]
# type = FunctionDirichletBC
# variable = u
# function = slnu
# boundary = 'top left right bottom'
# [../]
[./bc_ut]
type = FunctionNeumannBC
variable = u
boundary = top
function = bc_fnut
[../]
[./bc_ub]
type = FunctionNeumannBC
variable = u
boundary = bottom
function = bc_fnub
[../]
[./bc_ul]
type = FunctionNeumannBC
variable = u
boundary = left
function = bc_fnul
[../]
[./bc_ur]
type = FunctionNeumannBC
variable = u
boundary = right
function = bc_fnur
[../]
[./bc_v]
type = FunctionDirichletBC
variable = v
function = slnv
boundary = 'top left right bottom'
[../]
[]
[Preconditioning]
[./prec]
type = SMP
full = true
[../]
[]
[Postprocessors]
active = 'num_vars'
[./dofs]
type = NumDOFs
[../]
[./h]
type = AverageElementSize
[../]
[./L2u]
type = ElementL2Error
variable = u
function = slnu
[../]
[./L2v]
type = ElementL2Error
variable = v
function = slnv
[../]
[./H1error]
type = ElementH1Error
variable = u
function = solution
[../]
[./H1Semierror]
type = ElementH1SemiError
variable = u
function = solution
[../]
[./num_vars]
type = NumVars
system = 'NL'
[../]
[]
[Executioner]
# petsc_options = '-snes_mf_operator'
type = Steady
solve_type = NEWTON
nl_rel_tol = 1e-15
[]
[Outputs]
execute_on = 'timestep_end'
csv = true
[]
test/tests/dgkernels/3d_diffusion_dg/3d_diffusion_dg_test.i
[Mesh]
type = GeneratedMesh
dim = 3
nx = 5
ny = 5
nz = 5
xmin = 0
xmax = 1
ymin = 0
ymax = 1
zmin = 0
zmax = 1
elem_type = HEX8
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = MONOMIAL
[./InitialCondition]
type = ConstantIC
value = 0.5
[../]
[../]
[]
[Functions]
active = 'forcing_fn exact_fn'
[./forcing_fn]
type = ParsedFunction
value = 2*pow(e,-x-(y*y))*(1-2*y*y)
[../]
[./exact_fn]
type = ParsedGradFunction
value = pow(e,-x-(y*y))
grad_x = -pow(e,-x-(y*y))
grad_y = -2*y*pow(e,-x-(y*y))
[../]
[]
[Kernels]
active = 'diff abs forcing'
[./diff]
type = Diffusion
variable = u
[../]
[./abs] # u * v
type = Reaction
variable = u
[../]
[./forcing]
type = BodyForce
variable = u
function = forcing_fn
[../]
[]
[DGKernels]
active = 'dg_diff'
[./dg_diff]
type = DGDiffusion
variable = u
epsilon = -1
sigma = 6
[../]
[]
[BCs]
active = 'all'
[./all]
type = DGFunctionDiffusionDirichletBC
variable = u
boundary = '0 1 2 3 4 5'
function = exact_fn
epsilon = -1
sigma = 6
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Postprocessors]
active = 'h dofs l2_err'
[./h]
type = AverageElementSize
execute_on = 'initial timestep_end'
[../]
[./dofs]
type = NumDOFs
execute_on = 'initial timestep_end'
[../]
[./l2_err]
type = ElementL2Error
variable = u
function = exact_fn
execute_on = 'initial timestep_end'
[../]
[]
[Outputs]
file_base = out
exodus = true
[]
modules/misc/test/tests/kernels/thermo_diffusion/thermo_diffusion.i
# Steady-state test for the ThermoDiffusion kernel.
#
# This test applies a constant temperature gradient to drive thermo-diffusion
# in the variable u. At steady state, the thermo-diffusion is balanced by
# diffusion due to Fick's Law, so the total flux is
#
# J = -D ( grad(u) - ( Qstar u / R ) grad(1/T) )
#
# If there are no fluxes at the boundaries, then there is no background flux and
# these two terms must balance each other everywhere:
#
# grad(u) = ( Qstar u / R ) grad(1/T)
#
# The dx can be eliminated to give
#
# d(ln u) / d(1/T) = Qstar / R
#
# This can be solved to give the profile for u as a function of temperature:
#
# u = A exp( Qstar / R T )
#
# Here, we are using simple heat conduction with Dirichlet boundaries on 0 <= x <= 1
# to give a linear profile for temperature: T = x + 1. We also need to apply one
# boundary condition on u, which is u(x=0) = 1. These conditions give:
#
# u = exp( -(Qstar/R) (x/(x+1)) )
#
# This analytical result is tracked by the aux variable "correct_u".
[Mesh]
type = GeneratedMesh
dim = 1
nx = 100
[]
[Variables]
[./u]
initial_condition = 1
[../]
[./temp]
initial_condition = 1
[../]
[]
[Kernels]
[./soret]
type = ThermoDiffusion
variable = u
temp = temp
gas_constant = 1
[../]
[./diffC]
type = Diffusion
variable = u
[../]
# Heat diffusion gives a linear temperature profile to drive the Soret diffusion.
[./diffT]
type = Diffusion
variable = temp
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 1
[../]
[./leftt]
type = DirichletBC
variable = temp
boundary = left
value = 1
[../]
[./rightt]
type = DirichletBC
variable = temp
boundary = right
value = 2
[../]
[]
[Materials]
[./fake_material]
type = GenericConstantMaterial
block = 0
prop_names = 'mass_diffusivity heat_of_transport'
prop_values = '1 1'
[../]
[]
[Executioner]
type = Steady
[]
[Postprocessors]
[./error]
type = NodalL2Error
variable = u
function = 'exp(-x/(x+1))'
[../]
[]
[Outputs]
execute_on = FINAL
exodus = true
[]
modules/fluid_properties/test/tests/interfaces/nan_interface/nan_interface.i
[Mesh]
type = GeneratedMesh
dim = 1
nx = 1
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./test_kernel]
type = NaNInterfaceTestKernel
variable = u
nan_interface_test_fp = fp
[../]
[]
[Modules]
[./FluidProperties]
[./fp]
type = NaNInterfaceTestFluidProperties
[../]
[]
[]
[Executioner]
type = Steady
[]
test/tests/constraints/coupled_tied_value_constraint/coupled_tied_value_constraint.i
[Mesh]
type = FileMesh
file = split_blocks.e
# NearestNodeLocator, which is needed by CoupledTiedValueConstraint,
# only works with ReplicatedMesh currently
parallel_type = replicated
[]
[Variables]
[./u]
block = left
[../]
[./v]
block = right
[../]
[]
[Kernels]
[./diff_u]
type = Diffusion
variable = u
block = left
[../]
[./diff_v]
type = Diffusion
variable = v
block = right
[../]
[]
[BCs]
active = 'right left'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = v
boundary = 4
value = 1
[../]
[]
[Constraints]
[./value]
type = CoupledTiedValueConstraint
variable = u
slave = 2
master = 3
master_variable = v
[../]
[]
[Preconditioning]
active = 'SMP'
[./SMP]
type = SMP
full = true
[../]
[]
[Executioner]
type = Steady
solve_type = NEWTON
l_max_its = 100
nl_max_its = 2
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/userobjects/layered_average/layered_average_interpolate.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[AuxVariables]
[./layered_average]
order = CONSTANT
family = MONOMIAL
[../]
[./nodal_layered_average]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[AuxKernels]
[./layered_average]
type = SpatialUserObjectAux
variable = layered_average
execute_on = timestep_end
user_object = average
[../]
[./nodal_layered_average]
type = SpatialUserObjectAux
variable = nodal_layered_average
execute_on = timestep_end
user_object = average
[../]
[]
[BCs]
[./top]
type = DirichletBC
variable = u
boundary = top
value = 1
[../]
[./bottom]
type = DirichletBC
variable = u
boundary = bottom
value = 0
[../]
[]
[UserObjects]
[./average]
type = LayeredAverage
variable = u
direction = y
num_layers = 19
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
modules/combined/test/tests/heat_convection/heat_convection_rz_test.i
# Test cases for convective boundary conditions. TKLarson, 11/01/11, rev. 0.
# Input file for htc_2dtest1
# TKLarson
# 11/01/11
# Revision 0
#
# Goals of this test are:
# 1) show that expected results ensue from application of convective boundary conditions
# Convective boundary condition:
# q = h*A*(Tw - Tf)
# where
# q - heat transfer rate (w)
# h - heat transfer coefficient (w/m^2-K)
# A - surface area (m^2)
# Tw - surface temperature (K)
# Tf - fluid temperature adjacent to the surface (K)
# The heat transfer coefficient (h) is input as a variable called 'rate'
# Tf is a two valued function specified by 'initial' and 'final' along with a variable
# called 'duration,' the length of time in seconds that it takes initial to linearly ramp
# to 'final.'
# The mesh for this test case is based on an ASTM standard for the so-called Brazillian Cylinder test
# (ASTM International, Standard Test Method for Splitting Tensile Strength of Cylindrical Concrete
# Specimens, C 496/C 496M-04, 2004) (because I already had a version of the model). While the
# Brazillian Cylinder test is for dynamic tensile testing of concrete, the model works for the present
# purposes. The model is 2-d RZ coordinates.
#
# Brazillian Cylinder sample dimensions:
# L = 20.3 cm, 0.203 m, (8 in)
# r = 5.08 cm, 0.0508 m, (2 in)
# Material properties are:
# density = 2405.28 km/m^3
# specific heat = 826.4 J/kg-K
# thermal conductivity 1.937 w/m-K
# alpha (thermal conductivity/(density*specific heat) is then 9.74e-7 m^2/s
#
# Initial cylinder temperature is room temperature 294.26 K (70 F)
# The initial fluid temperature is room temperature. We will ramp it to 477.6 K (400 F) in 10 minutes.
# We will use a natural convection h (284 w/m^2-K (50 BTU/hr-ft^2-F)) on all faces of the cylinder.
# This is akin to putting the cylinder in an oven (nonconvection type) and turning the oven on.
# What we expect for this problem:
# 1) Use of h = 284 should cause the cylinder to slowly warm up
# 2) The fluid temperature should rise from initial (294 K) to final (477 K) in 600 s.
# 3) 1) and 2) should cause the cylinder to become soaked at 477.6 K after sufficient time(i.e. ~ 1/2 hr).
# This is a simple thermal soak problem.
[Problem]
coord_type = RZ
[]
[Mesh] # Mesh Start
# 10cm x 20cm cylinder not so detailed mesh, 2 radial, 6 axial nodes
# Only one block (Block 1), all concrete
# Sideset 1 - top of cylinder, Sideset 2 - length of cylinder, Sideset 3 - bottom of cylinder
file = heat_convection_rz_mesh.e
[] # Mesh END
[Variables] # Variables Start
[./temp]
order = FIRST
family = LAGRANGE
initial_condition = 294.26 # Initial cylinder temperature
[../]
[] # Variables END
[Kernels] # Kernels Start
[./heat]
type = HeatConduction
variable = temp
[../]
[./heat_ie]
type = HeatConductionTimeDerivative
variable = temp
[../]
[] # Kernels END
[BCs] # Boundary Conditions Start
# Heat transfer coefficient on outer cylinder radius and ends
[./convective_clad_surface] # Convective Start
type = ConvectiveFluxBC # Convective flux, e.g. q'' = h*(Tw - Tf)
boundary = '1 2 3' # BC applied on top, along length, and bottom
variable = temp
rate = 284. # (w/m^2-K)[50 BTU/hr/-ft^2-F]
# the above h is a reasonable natural convection value
initial = 294.26 # initial ambient (lab or oven) temperature (K)
final = 477.6 # final ambient (lab or oven) temperature (K)
duration = 600. # length of time in seconds that it takes the ambient
# temperature to ramp from initial to final
[../] # Convective End
[] # BCs END
[Materials] # Materials Start
[./thermal]
type = HeatConductionMaterial
block = 1
specific_heat = 826.4
# thermal_conductivity = 1.937 # this makes alpha 9.74e-7 m^2/s
# thermal_conductivity = 19.37 # this makes alpha 9.74e-6 m^2/s
# thermal conductivity arbitrarily increased by a decade to
# make the cylinder thermally soak faster (only for the purposes
# of this test problem
thermal_conductivity = 193.7 # this makes alpha 9.74e-5 m^2/s
# thermal conductivity arbitrarily increased by 2 decade to
# make the cylinder thermally soak faster (only for the purposes
# of this test problem
[../]
[./density]
type = Density
block = 1
density = 2405.28
[../]
[] # Materials END
[Executioner] # Executioner Start
type = Transient
# type = Steady
#Preconditioned JFNK (default)
solve_type = 'PJFNK'
petsc_options = '-snes_ksp_ew '
petsc_options_iname = '-ksp_gmres_restart -pc_type -pc_hypre_type'
petsc_options_value = '70 hypre boomeramg'
l_max_its = 60
nl_rel_tol = 1e-8
nl_abs_tol = 1e-10
l_tol = 1e-5
start_time = 0.0
dt = 60.
num_steps = 20 # Total run time 1200 s
[] # Executioner END
[Outputs] # Output Start
# Output Start
file_base = out_rz
exodus = true
[] # Output END
# # Input file END
test/tests/meshgenerators/generate_sidesets_bounding_box/error_no_elements_in_bounding_box.i
[MeshGenerators]
[./gmg]
type = GeneratedMeshGenerator
dim = 2
nx = 10
ny = 10
#parallel_type = replicated
[]
[./createNewSidesetOne]
type = SideSetsFromBoundingBoxGenerator
input = gmg
boundary_id_old = 'left bottom'
boundary_id_new = 10
bottom_left = '-0.1 -0.1 0'
top_right = '0.8 0.2 0'
block_id = 0
[]
[./createNewSidesetTwo]
type = SideSetsFromBoundingBoxGenerator
input = createNewSidesetOne
boundary_id_old = 'right top'
boundary_id_new = 11
bottom_left = '1.7 0.7 0'
top_right = '2.1 1.1 0'
block_id = 0
[]
[]
[Mesh]
type = MeshGeneratorMesh
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./leftBC]
type = DirichletBC
variable = u
boundary = 10
value = 1
[../]
[./rightBC]
type = DirichletBC
variable = u
boundary = 11
value = 0
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
modules/porous_flow/test/tests/poroperm/PermFromPoro04.i
# Testing permeability from porosity
# Trivial test, checking calculated permeability is correct
# k = k_anisotropic * k
# with log k = A * phi + B
[Mesh]
type = GeneratedMesh
dim = 1
nx = 3
xmin = 0
xmax = 3
[]
[GlobalParams]
block = 0
PorousFlowDictator = dictator
[]
[Variables]
[./pp]
[./InitialCondition]
type = ConstantIC
value = 0
[../]
[../]
[]
[Kernels]
[./flux]
type = PorousFlowAdvectiveFlux
gravity = '0 0 0'
variable = pp
[../]
[]
[BCs]
[./ptop]
type = PresetBC
variable = pp
boundary = right
value = 0
[../]
[./pbase]
type = PresetBC
variable = pp
boundary = left
value = 1
[../]
[]
[AuxVariables]
[./poro]
order = CONSTANT
family = MONOMIAL
[../]
[./perm_x]
order = CONSTANT
family = MONOMIAL
[../]
[./perm_y]
order = CONSTANT
family = MONOMIAL
[../]
[./perm_z]
order = CONSTANT
family = MONOMIAL
[../]
[]
[AuxKernels]
[./poro]
type = MaterialRealAux
property = PorousFlow_porosity_qp
variable = poro
[../]
[./perm_x]
type = MaterialRealTensorValueAux
property = PorousFlow_permeability_qp
variable = perm_x
row = 0
column = 0
[../]
[./perm_y]
type = MaterialRealTensorValueAux
property = PorousFlow_permeability_qp
variable = perm_y
row = 1
column = 1
[../]
[./perm_z]
type = MaterialRealTensorValueAux
property = PorousFlow_permeability_qp
variable = perm_z
row = 2
column = 2
[../]
[]
[Postprocessors]
[./perm_x_bottom]
type = PointValue
variable = perm_x
point = '0 0 0'
[../]
[./perm_y_bottom]
type = PointValue
variable = perm_y
point = '0 0 0'
[../]
[./perm_z_bottom]
type = PointValue
variable = perm_z
point = '0 0 0'
[../]
[./perm_x_top]
type = PointValue
variable = perm_x
point = '3 0 0'
[../]
[./perm_y_top]
type = PointValue
variable = perm_y
point = '3 0 0'
[../]
[./perm_z_top]
type = PointValue
variable = perm_z
point = '3 0 0'
[../]
[]
[UserObjects]
[./dictator]
type = PorousFlowDictator
porous_flow_vars = 'pp'
number_fluid_phases = 1
number_fluid_components = 1
[../]
[./pc]
type = PorousFlowCapillaryPressureVG
# unimportant in this fully-saturated test
m = 0.8
alpha = 1e-4
[../]
[]
[Modules]
[./FluidProperties]
[./simple_fluid]
type = SimpleFluidProperties
bulk_modulus = 2.2e9
viscosity = 1e-3
density0 = 1000
thermal_expansion = 0
[../]
[../]
[]
[Materials]
[./temperature]
type = PorousFlowTemperature
[../]
[./massfrac]
type = PorousFlowMassFraction
[../]
[./eff_fluid_pressure]
type = PorousFlowEffectiveFluidPressure
[../]
[./ppss]
type = PorousFlow1PhaseP
porepressure = pp
capillary_pressure = pc
[../]
[./simple_fluid]
type = PorousFlowSingleComponentFluid
fp = simple_fluid
phase = 0
[../]
[./porosity]
type = PorousFlowPorosity
porosity_zero = 0.1
[../]
[./relperm]
type = PorousFlowRelativePermeabilityCorey
n = 0 # unimportant in this fully-saturated situation
phase = 0
[../]
[./permeability]
type = PorousFlowPermeabilityExponential
k_anisotropy = '1 0 0 0 2 0 0 0 0.1'
poroperm_function = log_k
A = 4.342945
B = -8
[../]
[]
[Preconditioning]
[./andy]
type = SMP
full = true
[../]
[]
[Executioner]
solve_type = Newton
type = Steady
l_tol = 1E-5
nl_abs_tol = 1E-3
nl_rel_tol = 1E-8
l_max_its = 200
nl_max_its = 400
petsc_options_iname = '-pc_type -pc_asm_overlap -sub_pc_type -ksp_type -ksp_gmres_restart'
petsc_options_value = ' asm 2 lu gmres 200'
[]
[Outputs]
csv = true
execute_on = 'timestep_end'
[]
modules/combined/test/tests/elasticitytensor/composite.i
# This input file is designed to test the RankTwoAux and RankFourAux
# auxkernels, which report values out of the Tensors used in materials
# properties.
[Mesh]
type = GeneratedMesh
dim = 1
nx = 20
xmax = 1
[]
[AuxVariables]
[./c]
order = FIRST
family = LAGRANGE
[./InitialCondition]
type = FunctionIC
function = x
[../]
[../]
[./C1111_aux]
order = CONSTANT
family = MONOMIAL
[../]
[./C1122_aux]
order = CONSTANT
family = MONOMIAL
[../]
[./C1133_aux]
order = CONSTANT
family = MONOMIAL
[../]
[./C3313_aux]
order = CONSTANT
family = MONOMIAL
[../]
[./dC1111_aux]
order = CONSTANT
family = MONOMIAL
[../]
[./dC1122_aux]
order = CONSTANT
family = MONOMIAL
[../]
[./dC1133_aux]
order = CONSTANT
family = MONOMIAL
[../]
[./dC3313_aux]
order = CONSTANT
family = MONOMIAL
[../]
[./d2C1111_aux]
order = CONSTANT
family = MONOMIAL
[../]
[./d2C1122_aux]
order = CONSTANT
family = MONOMIAL
[../]
[./d2C1133_aux]
order = CONSTANT
family = MONOMIAL
[../]
[./d2C3313_aux]
order = CONSTANT
family = MONOMIAL
[../]
[]
#[Kernels]
# [./diff]
# type = Diffusion
# variable = diffused
# [../]
#[]
[AuxKernels]
[./matl_C1111]
type = RankFourAux
rank_four_tensor = elasticity_tensor
index_i = 0
index_j = 0
index_k = 0
index_l = 0
variable = C1111_aux
execute_on = initial
[../]
[./matl_C1122]
type = RankFourAux
rank_four_tensor = elasticity_tensor
index_i = 0
index_j = 0
index_k = 1
index_l = 1
variable = C1122_aux
execute_on = initial
[../]
[./matl_C1133]
type = RankFourAux
rank_four_tensor = elasticity_tensor
index_i = 0
index_j = 0
index_k = 2
index_l = 2
variable = C1133_aux
execute_on = initial
[../]
[./matl_C3313]
type = RankFourAux
rank_four_tensor = elasticity_tensor
index_i = 2
index_j = 2
index_k = 0
index_l = 2
variable = C3313_aux
execute_on = initial
[../]
[./matl_dC1111]
type = RankFourAux
rank_four_tensor = delasticity_tensor/dc
index_i = 0
index_j = 0
index_k = 0
index_l = 0
variable = dC1111_aux
execute_on = initial
[../]
[./matl_dC1122]
type = RankFourAux
rank_four_tensor = delasticity_tensor/dc
index_i = 0
index_j = 0
index_k = 1
index_l = 1
variable = dC1122_aux
execute_on = initial
[../]
[./matl_dC1133]
type = RankFourAux
rank_four_tensor = delasticity_tensor/dc
index_i = 0
index_j = 0
index_k = 2
index_l = 2
variable = dC1133_aux
execute_on = initial
[../]
[./matl_dC3313]
type = RankFourAux
rank_four_tensor = delasticity_tensor/dc
index_i = 2
index_j = 2
index_k = 0
index_l = 2
variable = dC3313_aux
execute_on = initial
[../]
[./matl_d2C1111]
type = RankFourAux
rank_four_tensor = d^2elasticity_tensor/dc^2
index_i = 0
index_j = 0
index_k = 0
index_l = 0
variable = d2C1111_aux
execute_on = initial
[../]
[./matl_d2C1122]
type = RankFourAux
rank_four_tensor = d^2elasticity_tensor/dc^2
index_i = 0
index_j = 0
index_k = 1
index_l = 1
variable = d2C1122_aux
execute_on = initial
[../]
[./matl_d2C1133]
type = RankFourAux
rank_four_tensor = d^2elasticity_tensor/dc^2
index_i = 0
index_j = 0
index_k = 2
index_l = 2
variable = d2C1133_aux
execute_on = initial
[../]
[./matl_d2C3313]
type = RankFourAux
rank_four_tensor = d^2elasticity_tensor/dc^2
index_i = 2
index_j = 2
index_k = 0
index_l = 2
variable = d2C3313_aux
execute_on = initial
[../]
[]
[Materials]
[./Ca]
type = ComputeElasticityTensor
base_name = Ca
block = 0
fill_method = symmetric21
C_ijkl ='1111 .1122 1133 1123 1113 1112 2222 2233 2223 2213 2212 3333 3323 3313 3312 2323 2313 2312 1313 1312 1212'
[../]
[./Cb]
type = ComputeElasticityTensor
base_name = Cb
block = 0
fill_method = symmetric21
C_ijkl ='.1111 1122 .1133 .1123 .1113 .1112 .2222 .2233 .2223 .2213 .2212 .3333 .3323 .3313 .3312 .2323 .2313 .2312 .1313 .1312 .1212'
[../]
[./Fa]
type = DerivativeParsedMaterial
block = 0
f_name = Fa
function = c^2
args = c
[../]
[./Fb]
type = DerivativeParsedMaterial
block = 0
f_name = Fb
function = (1-c)^3
args = c
[../]
[./C]
type = CompositeElasticityTensor
block = 0
args = c
tensors = 'Ca Cb'
weights = 'Fa Fb'
[../]
[]
[Problem]
kernel_coverage_check = false
solve = false
[]
[Executioner]
type = Steady
[]
[Outputs]
exodus = true
[]
modules/phase_field/test/tests/free_energy_material/RegularSolutionFreeEnergy_const_T.i
[Mesh]
type = GeneratedMesh
dim = 1
nx = 10
xmax = 1
[]
[Variables]
[./c]
order = FIRST
family = LAGRANGE
[./InitialCondition]
type = FunctionIC
function = x
[../]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = c
[../]
[]
[BCs]
[./left]
type = FunctionDirichletBC
variable = c
boundary = left
function = x
[../]
[./right]
type = FunctionDirichletBC
variable = c
boundary = right
function = x
[../]
[]
[Materials]
[./free_energy]
type = RegularSolutionFreeEnergy
f_name = F
c = c
outputs = out
[../]
[]
[Executioner]
type = Steady
solve_type = NEWTON
l_max_its = 1
nl_max_its = 1
nl_abs_tol = 1
[]
[Outputs]
execute_on = 'timestep_end'
[./out]
type = Exodus
execute_on = timestep_end
[../]
[]
modules/stochastic_tools/test/tests/samplers/base/mpi.i
[Mesh]
type = GeneratedMesh
dim = 1
nx = 1
ny = 1
[]
[Variables]
[./u]
[../]
[]
[Distributions]
[./uniform]
type = UniformDistribution
lower_bound = 1980
upper_bound = 2017
[../]
[]
[Samplers]
[./sample]
type = MonteCarloSampler
n_samples = 10
distributions = 'uniform'
execute_on = 'initial'
[../]
[]
[UserObjects]
[./test]
type = TestSampler
sampler = sample
test_type = MPI
[../]
[]
[Executioner]
type = Steady
[]
[Problem]
solve = false
kernel_coverage_check = false
[]
[Outputs]
[]
test/tests/mesh/named_entities/name_on_the_fly.i
[Mesh]
file = three_block.e
# These names will be applied on the fly to the
# mesh so that they can be used in the input file
# In addition they will show up in the output file
block_id = '1 2 3'
block_name = 'wood steel copper'
boundary_id = '1 2'
boundary_name = 'left right'
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 'left'
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 'right'
value = 1
[../]
[]
[Materials]
active = empty
[./empty]
type = MTMaterial
block = 'wood steel copper'
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
exodus = true
[]
modules/phase_field/test/tests/boundary_intersecting_features/boundary_intersecting_features.i
[Mesh]
# ImageMesh ignores nx, xmin, xmax (and similarly for y and z) and
# tries to read them from the image file...
type = ImageMesh
dim = 2
# Be sure to choose a corresponding image name below!
# file = image001_cropped3_closing_298.png # full size, 157 Mb Exodus file!
# file = eighth_image001_cropped3_closing_298.png # 1/8
file = sixteenth_image001_cropped3_closing_298.png # 1/16
# Uncomment to maintain 1:1 ratio between number of pixels and mesh size.
# scale_to_one = false
# Uncomment to set cells_per_pixel to something other than the default value of 1.0.
# Must be <= 1.
# cells_per_pixel = .75
# To crop an image to e.g. 1/8th size, install ImageMagick and run:
# convert image001_cropped3_closing_298.png -crop 230x198+100+100 eighth_image001_cropped3_closing_298.png
# Note: Do not use 'sips' on OSX to crop! It actually interpolates
# the colors in the image instead of just cropping.
[]
[Variables]
[./u]
order = CONSTANT
family = MONOMIAL
[../]
[]
[AuxVariables]
[./grain_auxvar]
order = CONSTANT
family = MONOMIAL
[../]
[./centroids]
order = CONSTANT
family = MONOMIAL
[../]
[]
[AuxKernels]
[./nodal_flood_aux]
variable = grain_auxvar
type = FeatureFloodCountAux
flood_counter = flood_count_pp
execute_on = 'initial timestep_end'
[../]
[./centroids]
type = FeatureFloodCountAux
variable = centroids
flood_counter = flood_count_pp
field_display = CENTROID
execute_on = 'initial timestep_end'
[../]
[]
[Functions]
[./tif]
# ImageFunction gets its file range parameters from ImageMesh,
# when it is present. This prevents duplicating information in
# input files.
type = ImageFunction
# In these sample images the features we want to analyze are RED (or close to pure red). The
# background is BLUE so we can easily distinguish between the two by selecting only the red channel.
component = 0
[../]
[]
[ICs]
[./u_ic]
type = FunctionIC
function = tif
variable = u
[../]
[]
[Postprocessors]
[./flood_count_pp]
type = FeatureFloodCount
variable = u
threshold = 1.0
compute_var_to_feature_map = true
execute_on = 'initial timestep_end'
[../]
[]
[VectorPostprocessors]
[./grain_volumes]
type = FeatureVolumeVectorPostprocessor
flood_counter = flood_count_pp
execute_on = 'initial timestep_end'
[../]
[]
[Problem]
type = FEProblem
solve = false
[../]
[Executioner]
type = Steady
[]
[Outputs]
exodus = true
csv = true
[]
modules/solid_mechanics/test/tests/crack_loop/crack_loop.i
[Mesh]
file = crack_loop.e
[]
[Problem]
type = FEProblem
solve = false
[]
[UserObjects]
[./crack]
type = CrackFrontDefinition
crack_direction_method = CurvedCrackFront
boundary = 1001
[../]
[]
[Executioner]
type = Steady
[]
test/tests/constraints/nodal_constraint/nodal_constraint_displaced_test.i
[Mesh]
file = 2-lines.e
displacements = 'disp_x'
[]
[AuxVariables]
[./disp_x]
[../]
[]
[AuxKernels]
[./disp_x_ak]
type = ConstantAux
variable = disp_x
value = 1
[../]
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 1
[../]
[./right]
type = DirichletBC
variable = u
boundary = 4
value = 3
[../]
[]
[Constraints]
[./c1]
type = EqualValueNodalConstraint
variable = u
master = 0
slave = 4
penalty = 100000
use_displaced_mesh = true
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
exodus = true
[]
test/tests/misc/block_boundary_material_check/bc_check.i
[Mesh]
type = GeneratedMesh
dim = 1
[]
[Variables]
[./u]
[../]
[]
[BCs]
[./bc_left]
type = MatTestNeumannBC
variable = u
boundary = left
mat_prop = 'prop'
[../]
[]
[Problem]
type = FEProblem
solve = false
kernel_coverage_check = false
[]
[Executioner]
type = Steady
[]
[Outputs]
[]
test/tests/functions/image_function/image_2d_elemental.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 20
ny = 20
[]
[Variables]
[./u]
order = CONSTANT
family = MONOMIAL
[../]
[]
[Functions]
[./image_func]
type = ImageFunction
file_base = stack/test
file_suffix = png
# file range is parsed as a vector of unsigned. If it only has 1
# entry, only a single file is read.
file_range = '0'
[../]
[]
[ICs]
[./u_ic]
type = FunctionIC
function = image_func
variable = u
[../]
[]
[Problem]
type = FEProblem
solve = false
[../]
[Executioner]
type = Steady
[]
[Outputs]
exodus = true
[]
test/tests/markers/box_marker/box_marker_adapt_test.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
nz = 0
zmax = 0
elem_type = QUAD4
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[./top]
type = DirichletBC
variable = u
boundary = top
value = 0
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Adaptivity]
steps = 1
marker = box
[./Markers]
[./box]
bottom_left = '0.3 0.3 0'
inside = refine
top_right = '0.6 0.6 0'
outside = do_nothing
type = BoxMarker
[../]
[../]
[]
[Outputs]
exodus = true
[]
test/tests/outputs/xda/xdr.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
xdr = true
[]
modules/porous_flow/test/tests/relperm/vangenuchten2.i
# Test van Genuchten relative permeability curve by varying saturation over the mesh
# van Genuchten exponent m = 0.5 for both phases
# Phase 0 residual saturation s0r = 0.2
# Phase 1 residual saturation s1r = 0.3
[Mesh]
type = GeneratedMesh
dim = 1
nx = 100
[]
[GlobalParams]
PorousFlowDictator = dictator
[]
[Variables]
[./p0]
initial_condition = 1e6
[../]
[./s1]
[../]
[]
[AuxVariables]
[./s0aux]
family = MONOMIAL
order = CONSTANT
[../]
[./s1aux]
family = MONOMIAL
order = CONSTANT
[../]
[./kr0aux]
family = MONOMIAL
order = CONSTANT
[../]
[./kr1aux]
family = MONOMIAL
order = CONSTANT
[../]
[]
[AuxKernels]
[./s0]
type = PorousFlowPropertyAux
property = saturation
phase = 0
variable = s0aux
[../]
[./s1]
type = PorousFlowPropertyAux
property = saturation
phase = 1
variable = s1aux
[../]
[./kr0]
type = PorousFlowPropertyAux
property = relperm
phase = 0
variable = kr0aux
[../]
[./kr1]
type = PorousFlowPropertyAux
property = relperm
phase = 1
variable = kr1aux
[../]
[]
[Functions]
[./s1]
type = ParsedFunction
value = x
[../]
[]
[ICs]
[./s1]
type = FunctionIC
variable = s1
function = s1
[../]
[]
[Kernels]
[./p0]
type = Diffusion
variable = p0
[../]
[./s1]
type = Diffusion
variable = s1
[../]
[]
[UserObjects]
[./dictator]
type = PorousFlowDictator
porous_flow_vars = 'p0 s1'
number_fluid_phases = 2
number_fluid_components = 2
[../]
[./pc]
type = PorousFlowCapillaryPressureConst
pc = 0
[../]
[]
[Materials]
[./temperature]
type = PorousFlowTemperature
[../]
[./ppss]
type = PorousFlow2PhasePS
phase0_porepressure = p0
phase1_saturation = s1
capillary_pressure = pc
[../]
[./kr0]
type = PorousFlowRelativePermeabilityVG
phase = 0
m = 0.5
s_res = 0.2
sum_s_res = 0.5
[../]
[./kr1]
type = PorousFlowRelativePermeabilityVG
phase = 1
m = 0.5
s_res = 0.3
sum_s_res = 0.5
[../]
[]
[VectorPostprocessors]
[./vpp]
type = LineValueSampler
variable = 's0aux s1aux kr0aux kr1aux'
start_point = '0 0 0'
end_point = '1 0 0'
num_points = 20
sort_by = id
[../]
[]
[Executioner]
type = Steady
solve_type = NEWTON
nl_abs_tol = 1e-7
[]
[BCs]
[./sleft]
type = DirichletBC
variable = s1
value = 0
boundary = left
[../]
[./sright]
type = DirichletBC
variable = s1
value = 1
boundary = right
[../]
[]
[Outputs]
csv = true
execute_on = timestep_end
[]
modules/tensor_mechanics/examples/bridge/bridge.i
#
# Bridge linear elasticity example
#
# This example models a bridge using linear elasticity.
# It can be either steel or concrete.
# Gravity is applied
# A pressure of 0.5 MPa is also applied
#
[Mesh]
displacements = 'disp_x disp_y disp_z' #Define displacements for deformed mesh
type = FileMesh #Read in mesh from file
file = bridge.e
boundary_id = '1 2 3 4 5 6' #Assign names to boundaries to make things clearer
boundary_name = 'top left right bottom1 bottom2 bottom3'
[]
[Variables]
[./disp_x]
order = FIRST
family = LAGRANGE
[../]
[./disp_y]
order = FIRST
family = LAGRANGE
[../]
[./disp_z]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./gravity_y]
#Gravity is applied to bridge
type = Gravity
variable = disp_y
value = -9.81
[../]
[./TensorMechanics]
#Stress divergence kernels
displacements = 'disp_x disp_y disp_z'
[../]
[]
[AuxVariables]
[./von_mises]
#Dependent variable used to visualize the Von Mises stress
order = CONSTANT
family = MONOMIAL
[../]
[]
[AuxKernels]
[./von_mises_kernel]
#Calculates the von mises stress and assigns it to von_mises
type = RankTwoScalarAux
variable = von_mises
rank_two_tensor = stress
execute_on = timestep_end
scalar_type = VonMisesStress
[../]
[]
[BCs]
[./Pressure]
[./load]
#Applies the pressure
boundary = top
factor = 5e5 # Pa
disp_x = disp_x
disp_y = disp_y
disp_z = disp_z
[../]
[../]
[./anchor_x]
#Anchors the bottom and sides against deformation in the x-direction
type = PresetBC
variable = disp_x
boundary = 'left right bottom1 bottom2 bottom3'
value = 0.0
[../]
[./anchor_y]
#Anchors the bottom and sides against deformation in the y-direction
type = PresetBC
variable = disp_y
boundary = 'left right bottom1 bottom2 bottom3'
value = 0.0
[../]
[./anchor_z]
#Anchors the bottom and sides against deformation in the z-direction
type = PresetBC
variable = disp_z
boundary = 'left right bottom1 bottom2 bottom3'
value = 0.0
[../]
[]
[Materials]
active = 'density_concrete stress strain elasticity_tensor_concrete'
[./elasticity_tensor_steel]
#Creates the elasticity tensor using steel parameters
youngs_modulus = 210e9 #Pa
poissons_ratio = 0.3
type = ComputeIsotropicElasticityTensor
block = 1
[../]
[./elasticity_tensor_concrete]
#Creates the elasticity tensor using concrete parameters
youngs_modulus = 16.5e9 #Pa
poissons_ratio = 0.2
type = ComputeIsotropicElasticityTensor
block = 1
[../]
[./strain]
#Computes the strain, assuming small strains
type = ComputeSmallStrain
block = 1
displacements = 'disp_x disp_y disp_z'
[../]
[./stress]
#Computes the stress, using linear elasticity
type = ComputeLinearElasticStress
block = 1
[../]
[./density_steel]
#Defines the density of steel
type = GenericConstantMaterial
block = 1
prop_names = density
prop_values = 7850 # kg/m^3
[../]
[./density_concrete]
#Defines the density of concrete
type = GenericConstantMaterial
block = 1
prop_names = density
prop_values = 2400 # kg/m^3
[../]
[]
[Preconditioning]
[./SMP]
#Creates the entire Jacobian, for the Newton solve
type = SMP
full = true
[../]
[]
[Executioner]
#We solve a steady state problem using Newton's iteration
type = Steady
solve_type = NEWTON
nl_rel_tol = 1e-9
l_max_its = 30
l_tol = 1e-4
nl_max_its = 10
petsc_options_iname = '-pc_type -pc_hypre_type -ksp_gmres_restart'
petsc_options_value = 'hypre boomeramg 31'
[]
[Outputs]
exodus = true
perf_graph = true
[]
modules/porous_flow/test/tests/actions/addjoiner_exception.i
# Tests that including a PorousFlowJoiner material throws the
# informative deprecation warning rather than a duplicate material property error
[GlobalParams]
PorousFlowDictator = dictator
[]
[Mesh]
type = GeneratedMesh
dim = 1
[]
[Variables]
[./p0]
[../]
[./p1]
[../]
[]
[Kernels]
[./p0]
type = Diffusion
variable = p0
[../]
[./p1]
type = Diffusion
variable = p1
[../]
[]
[Materials]
[./temperature]
type = PorousFlowTemperature
at_nodes = true
[../]
[./temperature_qp]
type = PorousFlowTemperature
[../]
[./ppss]
type = PorousFlow2PhasePP
at_nodes = true
phase0_porepressure = p0
phase1_porepressure = p1
capillary_pressure = pc
[../]
[./relperm0]
type = PorousFlowRelativePermeabilityConst
at_nodes = true
kr = 0.5
phase = 0
[../]
[./relperm1]
type = PorousFlowRelativePermeabilityConst
at_nodes = true
kr = 0.8
phase = 1
[../]
[./relperm]
type = PorousFlowJoiner
at_nodes = true
material_property = PorousFlow_relative_permeability_nodal
[../]
[]
[Executioner]
type = Steady
[]
[UserObjects]
[./dictator]
type = PorousFlowDictator
porous_flow_vars = 'p0 p1'
number_fluid_phases = 2
number_fluid_components = 1
[../]
[./pc]
type = PorousFlowCapillaryPressureConst
pc = 0
[../]
[]
modules/chemical_reactions/test/tests/jacobian/coupled_convreact.i
# Test the Jacobian terms for the CoupledConvectionReactionSub Kernel
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
[]
[Variables]
[./a]
order = FIRST
family = LAGRANGE
[../]
[./b]
order = FIRST
family = LAGRANGE
[../]
[./pressure]
order = FIRST
family = LAGRANGE
[../]
[]
[ICs]
[./pressure]
type = RandomIC
variable = pressure
min = 1
max = 5
[../]
[./a]
type = RandomIC
variable = a
max = 1
min = 0
[../]
[./b]
type = RandomIC
variable = b
max = 1
min = 0
[../]
[]
[Kernels]
[./diff]
type = DarcyFluxPressure
variable = pressure
[../]
[./diff_b]
type = Diffusion
variable = b
[../]
[./a1conv]
type = CoupledConvectionReactionSub
variable = a
v = b
log_k = 2
weight = 1
sto_v = 2.5
sto_u = 2
p = pressure
[../]
[]
[Materials]
[./porous]
type = GenericConstantMaterial
prop_names = 'diffusivity conductivity porosity'
prop_values = '1e-4 1e-4 0.2'
[../]
[]
[Executioner]
type = Steady
solve_type = NEWTON
[]
[Outputs]
perf_graph = true
[]
[Preconditioning]
[./smp]
type = SMP
full = true
[../]
[]
test/tests/userobjects/user_object/uo_restart_part2.i
[Mesh]
type = GeneratedMesh
dim = 2
xmin = 0
xmax = 1
ymin = 0
ymax = 1
nx = 5
ny = 5
elem_type = QUAD4
[]
[UserObjects]
[./ud]
type = MTUserObject
[../]
[]
[Functions]
[./forcing_fn]
type = ParsedFunction
value = 2
[../]
[./exact_fn]
type = ParsedFunction
value = -x*x
[../]
[]
[Variables]
[./u]
family = LAGRANGE
order = FIRST
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
# this kernel will use the UserObject from above
[./ffn]
type = BodyForce
variable = u
function = forcing_fn
[../]
[]
[BCs]
active = 'all'
[./all]
type = FunctionDirichletBC
variable = u
function = exact_fn
boundary = '0 1 2 3'
[../]
[]
[Postprocessors]
[./ud_pps]
type = UserObjectPPS
user_object = ud
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
exodus = true
[]
[Problem]
restart_file_base = uo_restart_part1_out_restart_0001
[]
test/tests/transfers/multiapp_copy_transfer/third_monomial_to_sub/sub.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
family = MONOMIAL
order = THIRD
[../]
[]
[Problem]
type = FEProblem
solve = false
[]
[Executioner]
type = Steady
[]
[Outputs]
exodus = true
[]
test/tests/geomsearch/1d_penetration_locator/1d_penetration_locator.i
[Mesh]
file = 1d_contact.e
dim = 2
construct_side_list_from_node_list = true
[]
[Variables]
[./u]
[../]
[]
[AuxVariables]
[./gap_distance]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left_left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right_right
value = 1
[../]
[]
[AuxKernels]
[./distance]
type = PenetrationAux
variable = gap_distance
boundary = left_right
paired_boundary = right_left
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
tutorials/darcy_thermo_mech/step03_darcy_material/tests/materials/packed_column/packed_column.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 100
ny = 10
xmax = 0.304 # Length of test chamber
ymax = 0.0257 # Test chamber radius
[]
[Variables]
[./pressure]
[../]
[]
[Kernels]
[./darcy_pressure]
type = DarcyPressure
variable = pressure
# No parameters necessary because the values will come from the material system
[../]
[]
[BCs]
[./inlet]
type = DirichletBC
variable = pressure
boundary = left
value = 4000 # (Pa) From Figure 2 from paper. First dot for 1mm spheres.
[../]
[./outlet]
type = DirichletBC
variable = pressure
boundary = right
value = 0 # (Pa) Gives the correct pressure drop from Figure 2 for 1mm spheres
[../]
[]
[Materials]
[./column]
type = PackedColumn
sphere_radius = 1
[../]
[]
[Problem]
type = FEProblem
coord_type = RZ
rz_coord_axis = X
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/dgkernels/jacobian_testing/coupled_dg_jac_test.i
###########################################################
# This is a test of the off diagonal jacobian machinery of
# the Discontinuous Galerkin System.
###########################################################
[Mesh]
type = GeneratedMesh
dim = 1
nx = 2
elem_type = EDGE2
[]
[Variables]
[./u]
order = FIRST
family = MONOMIAL
[../]
[./v]
order = FIRST
family = MONOMIAL
[../]
[]
[DGKernels]
[./dg_diff]
type = DGCoupledDiffusion
variable = u
v = v
[../]
[]
[Executioner]
type = Steady
solve_type = 'NEWTON'
[]
[Preconditioning]
[./smp]
type = SMP
full = true
[../]
[]
[Problem]
kernel_coverage_check = false
[]
[ICs]
[./u]
type = RandomIC
min = 0.1
max = 0.9
variable = u
[../]
[./v]
type = RandomIC
min = 0.1
max = 0.9
variable = v
[../]
[]
modules/richards/test/tests/jacobian_1/jn_fu_06.i
# unsaturated = true
# gravity = false
# supg = true
# transient = false
[Mesh]
type = GeneratedMesh
dim = 3
nx = 1
ny = 1
nz = 1
xmin = -1
xmax = 1
ymin = -1
ymax = 1
zmin = -1
zmax = 1
[]
[GlobalParams]
richardsVarNames_UO = PPNames
density_UO = DensityConstBulk
relperm_UO = RelPermPower
SUPG_UO = SUPGstandard
sat_UO = Saturation
seff_UO = SeffVG
[]
[UserObjects]
[./PPNames]
type = RichardsVarNames
richards_vars = pressure
[../]
[./DensityConstBulk]
type = RichardsDensityConstBulk
dens0 = 1
bulk_mod = 1.0 # notice small quantity, so the PETSc constant state works
[../]
[./SeffVG]
type = RichardsSeff1VG
m = 0.8
al = 1 # notice small quantity, so the PETSc constant state works
[../]
[./RelPermPower]
type = RichardsRelPermPower
simm = 0.2
n = 2
[../]
[./Saturation]
type = RichardsSat
s_res = 0.1
sum_s_res = 0.1
[../]
[./SUPGstandard]
type = RichardsSUPGstandard
p_SUPG = 0.1
[../]
[]
[Variables]
[./pressure]
order = FIRST
family = LAGRANGE
[./InitialCondition]
type = RandomIC
block = 0
min = -1
max = 0
[../]
[../]
[]
[Kernels]
active = 'richardsf'
[./richardst]
type = RichardsMassChange
variable = pressure
[../]
[./richardsf]
type = RichardsFullyUpwindFlux
variable = pressure
[../]
[]
[Materials]
[./rock]
type = RichardsMaterial
block = 0
mat_porosity = 0.1
mat_permeability = '1E-5 0 0 0 1E-5 0 0 0 1E-5'
viscosity = 1E-3
gravity = '0 0 0'
linear_shape_fcns = true
[../]
[]
[Preconditioning]
[./andy]
type = SMP
full = true
petsc_options_iname = '-ksp_type -pc_type -snes_atol -snes_rtol -snes_max_it -snes_type'
petsc_options_value = 'bcgs bjacobi 1E-15 1E-10 10000 test'
[../]
[]
[Executioner]
type = Steady
solve_type = Newton
[]
[Outputs]
execute_on = 'timestep_end'
file_base = jn06
exodus = false
[]
test/tests/parser/param_substitution/param_substitution.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
# Here we use the GetPot "DBE" function to perform a substitution.
# The parameter "FILENAME" can either exist in this file or
# be provided on the CLI
file_base = out_${FILENAME}
[]
test/tests/meshgenerators/stitched_mesh_generator/stitched_mesh_generator2.i
[MeshGenerators]
[./fmg_left]
type = FileMeshGenerator
file = left.e
[]
[./fmg_center]
type = FileMeshGenerator
file = center.e
[]
[./fmg_right]
type = FileMeshGenerator
file = right.e
[]
[./smg]
type = StitchedMeshGenerator
inputs = 'fmg_left fmg_center fmg_right'
clear_stitched_boundary_ids = true
stitch_boundaries_pairs = 'right left;
right left'
[]
[]
[Mesh]
type = MeshGeneratorMesh
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/vectorpostprocessors/elements_along_line/1d.i
[Mesh]
type = GeneratedMesh
parallel_type = replicated # Until RayTracing.C is fixed
dim = 1
nx = 10
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[VectorPostprocessors]
[./elems]
type = ElementsAlongLine
start = '0.05 0 0'
end = '0.405 0 0'
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
csv = true
[]
modules/tensor_mechanics/test/tests/isotropic_elasticity_tensor/youngs_modulus_poissons_ratio_test.i
[Mesh]
type = GeneratedMesh
dim = 3
[]
[GlobalParams]
displacements = 'disp_x disp_y disp_z'
[]
[Variables]
[./disp_x]
[../]
[./disp_y]
[../]
[./disp_z]
[../]
[]
[AuxVariables]
[./stress_11]
order = CONSTANT
family = MONOMIAL
[../]
[]
[Modules/TensorMechanics/Master]
[./all]
strain = SMALL
add_variables = true
[../]
[]
[AuxKernels]
[./stress_11]
type = RankTwoAux
variable = stress_11
rank_two_tensor = stress
index_j = 1
index_i = 1
[../]
[]
[BCs]
[./bottom]
type = PresetBC
variable = disp_y
boundary = bottom
value = 0
[../]
[./left]
type = PresetBC
variable = disp_x
boundary = left
value = 0
[../]
[./back]
type = PresetBC
variable = disp_z
boundary = back
value = 0
[../]
[./top]
type = PresetBC
variable = disp_y
boundary = top
value = 0.001
[../]
[]
[Materials]
[./stress]
type = ComputeLinearElasticStress
[../]
[./elasticity_tensor]
type = ComputeIsotropicElasticityTensor
poissons_ratio = 0.1
youngs_modulus = 1e6
[../]
[]
[Preconditioning]
[./SMP]
type = SMP
full = true
[../]
[]
[Executioner]
type = Steady
l_max_its = 20
nl_max_its = 10
solve_type = NEWTON
[]
[Outputs]
exodus = true
[]
test/tests/mortar/3d/non-conforming-2nd-order.i
[Mesh]
file = 3d-non-conf-2nd.e
[./MortarInterfaces]
[./middle]
master = 100
slave = 101
subdomain = 1000
[../]
[../]
[]
[Functions]
[./exact_sln]
type = ParsedFunction
value = x*x+y*y+z*z
[../]
[./forcing_fn]
type = ParsedFunction
value = -6
[../]
[]
[Variables]
[./u]
order = SECOND
family = LAGRANGE
block = '1 2'
[../]
[./lm]
order = FIRST
family = LAGRANGE
block = middle
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[./ffn]
type = BodyForce
variable = u
function = forcing_fn
[../]
[]
[Constraints]
[./ced]
type = EqualValueConstraint
variable = lm
interface = middle
master_variable = u
[../]
[]
[BCs]
[./all]
type = FunctionDirichletBC
variable = u
boundary = '1 2 3 4 5 6'
function = exact_sln
[../]
[]
[Postprocessors]
[./l2_error]
type = ElementL2Error
variable = u
function = exact_sln
block = '1 2'
[../]
[]
[Preconditioning]
[./fmp]
type = SMP
full = true
[../]
[]
[Executioner]
type = Steady
solve_type = 'NEWTON'
nl_rel_tol = 1e-13
[]
[Outputs]
execute_on = 'timestep_end'
exodus = true
[]
modules/heat_conduction/test/tests/heat_conduction/2d_quadrature_gap_heat_transfer/perfect.i
[Mesh]
file = perfect.e
[]
[Variables]
[./temp]
[../]
[]
[Kernels]
[./hc]
type = HeatConduction
variable = temp
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = temp
boundary = leftleft
value = 300
[../]
[./right]
type = DirichletBC
variable = temp
boundary = rightright
value = 400
[../]
[]
[ThermalContact]
[./left_to_right]
slave = leftright
quadrature = true
master = rightleft
variable = temp
type = GapHeatTransfer
[../]
[]
[Materials]
[./hcm]
type = HeatConductionMaterial
block = 'left right'
specific_heat = 1
thermal_conductivity = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
exodus = true
[]
test/tests/misc/execute_on/execute_on_test.i
[Mesh]
type = GeneratedMesh
dim = 2
xmax = 1
ymax = 1
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[AuxVariables]
[./initial]
[../]
[./timestep_begin]
[../]
[./timestep_end]
[../]
[./nonlinear]
[../]
[./linear]
[../]
[./custom]
initial_condition = 999
[../]
[]
[AuxKernels]
[./initial]
type = CheckCurrentExecAux
variable = initial
execute_on = initial
[../]
[./timestep_begin]
type = CheckCurrentExecAux
variable = timestep_begin
execute_on = timestep_begin
[../]
[./timestep_end]
type = CheckCurrentExecAux
variable = timestep_end
execute_on = timestep_end
[../]
[./nonlinear]
type = CheckCurrentExecAux
variable = nonlinear
execute_on = nonlinear
[../]
[./linear]
type = CheckCurrentExecAux
variable = linear
execute_on = linear
[../]
[./custom]
# this kernel will be never executed by Steady, so the initial value of this variable is not going to change
type = CheckCurrentExecAux
variable = custom
execute_on = custom
[../]
[]
[Executioner]
type = Steady
[]
[Outputs]
exodus = true
[]
test/tests/outputs/format/output_test_tecplot.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
nz = 0
zmin = 0
zmax = 0
elem_type = QUAD4
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 3
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
tecplot = true
[]
test/tests/vectorpostprocessors/point_value_sampler/point_value_sampler.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[./v]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[./diff_v]
type = Diffusion
variable = v
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[./left_v]
type = DirichletBC
variable = v
boundary = left
value = 1
[../]
[./right_v]
type = DirichletBC
variable = v
boundary = right
value = 0
[../]
[]
[VectorPostprocessors]
[./point_sample]
type = PointValueSampler
variable = 'u v'
points = '0.1 0.1 0 0.23 0.4 0 0.78 0.2 0'
sort_by = x
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
execute_on = 'timestep_end'
csv = true
[]
test/tests/auxkernels/solution_aux/solution_aux_scale.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
xmin = 1
xmax = 4
ymin = 1
ymax = 3
# This test uses SolutionUserObject which doesn't work with DistributedMesh.
parallel_type = replicated
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxVariables]
[./u_aux]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[AuxKernels]
[./initial_cond_aux]
type = SolutionAux
solution = xda_soln
execute_on = initial
variable = u_aux
[../]
[]
[UserObjects]
[./xda_soln]
type = SolutionUserObject
mesh = build_out_0001_mesh.xda
es = build_out_0001.xda
system_variables = u
scale = '3 2 1'
translation = '1 1 0'
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
nl_rel_tol = 1e-10
[]
[Outputs]
exodus = true
xda = true
[]
test/tests/auxkernels/solution_aux/solution_aux.i
[Mesh]
type = FileMesh
file = square.e
# This test uses SolutionUserObject which doesn't work with DistributedMesh.
parallel_type = replicated
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxVariables]
[./u_aux]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[AuxKernels]
[./initial_cond_aux]
type = SolutionAux
solution = xda_soln
execute_on = initial
variable = u_aux
[../]
[]
[UserObjects]
[./xda_soln]
type = SolutionUserObject
mesh = build_out_0001_mesh.xda
es = build_out_0001.xda
system_variables = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
nl_rel_tol = 1e-10
[]
[Outputs]
exodus = true
[./xda]
type = XDA
[../]
[]
test/tests/misc/check_error/assertion_test.i
[Mesh]
file = square.e # Read a Mesh
[./Generation] # AND create a Mesh...
dim = 2
nx = 2
ny = 2
nz = 0
zmin = 0
zmax = 0
elem_type = QUAD4
[../]
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Materials]
active = empty
[./empty]
type = EmptyMaterial
block = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out
exodus = true
[]
modules/fluid_properties/test/tests/ideal_gas/test.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
elem_type = QUAD4
[]
[Functions]
[./f_fn]
type = ParsedFunction
value = -4
[../]
[./bc_fn]
type = ParsedFunction
value = 'x*x+y*y'
[../]
[]
[Variables]
[./u]
[../]
[]
[AuxVariables]
[./e]
initial_condition = 6232.5
[../]
[./v]
initial_condition = 0.02493
[../]
[./p]
family = MONOMIAL
order = CONSTANT
[../]
[./T]
family = MONOMIAL
order = CONSTANT
[../]
[./cp]
family = MONOMIAL
order = CONSTANT
[../]
[./cv]
family = MONOMIAL
order = CONSTANT
[../]
[./c]
family = MONOMIAL
order = CONSTANT
[../]
[./mu]
family = MONOMIAL
order = CONSTANT
[../]
[./k]
family = MONOMIAL
order = CONSTANT
[../]
[./g]
family = MONOMIAL
order = CONSTANT
[../]
[]
[AuxKernels]
[./p]
type = MaterialRealAux
variable = p
property = pressure
[../]
[./T]
type = MaterialRealAux
variable = T
property = temperature
[../]
[./cp]
type = MaterialRealAux
variable = cp
property = cp
[../]
[./cv]
type = MaterialRealAux
variable = cv
property = cv
[../]
[./c]
type = MaterialRealAux
variable = c
property = c
[../]
[./mu]
type = MaterialRealAux
variable = mu
property = mu
[../]
[./k]
type = MaterialRealAux
variable = k
property = k
[../]
[./g]
type = MaterialRealAux
variable = g
property = g
[../]
[]
[Modules]
[./FluidProperties]
[./ideal_gas]
type = IdealGasFluidProperties
gamma = 1.4
R = 8.31
[../]
[]
[]
[Materials]
[./fp_mat]
type = FluidPropertiesMaterial
e = e
v = v
fp = ideal_gas
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[./ffn]
type = BodyForce
variable = u
function = f_fn
[../]
[]
[BCs]
[./all]
type = FunctionDirichletBC
variable = u
boundary = 'left right top bottom'
function = bc_fn
[../]
[]
[Executioner]
type = Steady
solve_type = NEWTON
[]
[Outputs]
exodus = true
[]
test/tests/vectorpostprocessors/parallel_consistency/parallel_consistency.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
# To make this deterministic
[Partitioner]
type = GridPartitioner
nx = 2
ny = 1
nz = 1
[]
[]
[Variables]
[u]
[]
[]
[Kernels]
[diff]
type = Diffusion
variable = u
[]
[]
[BCs]
[left]
type = DirichletBC
variable = u
boundary = 'left'
value = 0
[]
[right]
type = DirichletBC
variable = u
boundary = 'right'
value = 1
[]
[]
[VectorPostprocessors]
[constant]
type = ConstantVectorPostprocessor
value = '3 4'
execute_on = 'TIMESTEP_END'
[]
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
execute_on = 'timestep_end'
exodus = true
[]
[AuxVariables]
[scattered]
family = MONOMIAL
order = CONSTANT
[]
[]
[AuxKernels]
[viewit]
type = VectorPostprocessorVisualizationAux
vpp = 'constant'
vector_name = value
variable = scattered
execute_on = 'TIMESTEP_END'
[]
[]
test/tests/bcs/periodic/periodic_subdomain_restricted_test.i
[Mesh]
file = rect-2blk.e
[]
[Variables]
active = 'u v'
[./u]
order = FIRST
family = LAGRANGE
block = 1
[../]
[./v]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff_u diff_v'
[./diff_u]
type = Diffusion
variable = u
block = 1
[../]
[./diff_v]
type = Diffusion
variable = v
[../]
[]
[BCs]
active = 'Periodic left_u right_u left_v right_v'
[./Periodic]
[./u]
variable = u
primary = 1
secondary = 5
translation = '0 1 0'
[../]
[./v1]
variable = v
primary = 1
secondary = 5
translation = '0 1 0'
[../]
[./v2]
variable = v
primary = 2
secondary = 4
translation = '0 1 0'
[../]
[../]
[./left_u]
type = DirichletBC
variable = u
boundary = 6
value = 0
[../]
[./right_u]
type = NeumannBC
variable = u
boundary = 8
value = 4
[../]
[./left_v]
type = DirichletBC
variable = v
boundary = 6
value = 1
[../]
[./right_v]
type = DirichletBC
variable = v
boundary = 3
value = 6
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
execute_on = 'timestep_end'
file_base = out_restrict
exodus = true
[]
test/tests/postprocessors/variable_residual_norm/variable_residual.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
xmin = -1
xmax = 1
ymin = 0
ymax = 1
elem_type = QUAD4
[]
[Variables]
[./u]
[../]
[./v]
[../]
[]
[Kernels]
[./diff_u]
type = Diffusion
variable = u
[../]
[./diff_v]
type = Diffusion
variable = v
[../]
[]
[Functions]
[./leg1]
type = ParsedFunction
value = 'x'
[../]
[./leg2]
type = ParsedFunction
value = '0.5*(3.0*x*x-1.0)'
[../]
[]
[BCs]
[./left_u]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right_u]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[./left_v]
type = DirichletBC
variable = v
boundary = 1
value = 200
[../]
[./right_v]
type = DirichletBC
variable = v
boundary = 2
value = 100
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
# this is large on purpose so we don't reduce the variable residual to machine zero
# and so that we can compare to larger numbers. This also means this test can run only
# in serial, since parallel runs yield different convergence history.
nl_rel_tol = 1e-4
[]
[Postprocessors]
[./u_res_l2]
type = VariableResidual
variable = u
[../]
[./v_res_l2]
type = VariableResidual
variable = v
[../]
[]
[Outputs]
csv = true
[./console]
type = Console
# turn this on, so we can visually compare the postprocessor value with what is computed by the Console object
all_variable_norms = true
[../]
[]
modules/stochastic_tools/test/tests/distributions/boost_weibull.i
[Mesh]
type = GeneratedMesh
dim = 1
nx = 1
ny = 1
[]
[Variables]
[./u]
[../]
[]
[Distributions]
[./weibull]
type = BoostWeibullDistribution
shape = 5
scale = 1
[../]
[]
[Postprocessors]
[./cdf]
type = TestDistributionPostprocessor
distribution = weibull
value = 1
method = cdf
execute_on = initial
[../]
[./pdf]
type = TestDistributionPostprocessor
distribution = weibull
value = 1
method = pdf
execute_on = initial
[../]
[./quantile]
type = TestDistributionPostprocessor
distribution = weibull
value = 0.63212055882856
method = quantile
execute_on = initial
[../]
[]
[Executioner]
type = Steady
[]
[Problem]
solve = false
kernel_coverage_check = false
[]
[Outputs]
execute_on = 'INITIAL'
csv = true
file_base = 'weibull_out'
[]
modules/porous_flow/test/tests/gravity/grav01c_action.i
# Checking that gravity head is established
# using the Unsaturated Action
# For better agreement with the analytical solution (ana_pp), just increase nx
[Mesh]
type = GeneratedMesh
dim = 1
nx = 100
xmin = -1
xmax = 0
[]
[GlobalParams]
PorousFlowDictator = dictator
block = 0
[]
[Variables]
[./pp]
[./InitialCondition]
type = RandomIC
min = -1
max = 1
[../]
[../]
[]
[Modules]
[./FluidProperties]
[./the_simple_fluid]
type = SimpleFluidProperties
thermal_expansion = 0.0
bulk_modulus = 2.0
viscosity = 1.0
density0 = 1.0
[../]
[../]
[]
[PorousFlowUnsaturated]
add_saturation_aux = false
add_darcy_aux = false
porepressure = pp
gravity = '-1 0 0'
fp = the_simple_fluid
van_genuchten_alpha = 1.0
van_genuchten_m = 0.5
relative_permeability_type = Corey
relative_permeability_exponent = 1.0
[]
[Functions]
[./ana_pp]
type = ParsedFunction
vars = 'g B p0 rho0'
vals = '1 2 -1 1'
value = '-B*log(exp(-p0/B)+g*rho0*x/B)' # expected pp at base
[../]
[]
[BCs]
[./z]
type = PresetBC
variable = pp
boundary = right
value = -1
[../]
[]
[Materials]
[./permeability]
type = PorousFlowPermeabilityConst
permeability = '1 0 0 0 2 0 0 0 3'
[../]
[]
[Postprocessors]
[./pp_base]
type = PointValue
variable = pp
point = '-1 0 0'
[../]
[./pp_analytical]
type = FunctionValuePostprocessor
function = ana_pp
point = '-1 0 0'
[../]
[]
[Preconditioning]
active = andy
[./andy]
type = SMP
full = true
petsc_options_iname = '-ksp_type -pc_type -snes_atol -snes_rtol -snes_max_it'
petsc_options_value = 'bcgs bjacobi 1E-15 1E-10 10000'
[../]
[]
[Executioner]
type = Steady
solve_type = Newton
[]
[Outputs]
execute_on = 'timestep_end'
file_base = grav01c_action
exodus = true
[./csv]
type = CSV
[../]
[]
test/tests/vectorpostprocessors/1d_line_sampler/1d_line_sampler.i
# Tests the ability of a line sampler to correctly sample a coincident line. In
# 1-D, it was found that sometimes only the first few elements would be found,
# due to floating point precision error in equality tests for the points. This
# test uses a mesh configuration for which this has occurred and ensures that
# the output CSV file contains all points for the LineMaterialRealSampler vector
# postprocessor.
my_xmax = 1.2
[Mesh]
type = GeneratedMesh
parallel_type = replicated # Until RayTracing.C is fixed
dim = 1
nx = 10
xmin = 0
xmax = ${my_xmax}
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Materials]
[./my_mat]
type = GenericConstantMaterial
prop_names = 'my_prop'
prop_values = 5
[../]
[]
[VectorPostprocessors]
[./my_vpp]
type = LineMaterialRealSampler
property = my_prop
start = '0 0 0'
end = '${my_xmax} 0 0'
sort_by = x
[../]
[]
[Outputs]
[./out]
type = CSV
execute_vector_postprocessors_on = 'timestep_end'
show = 'my_vpp'
precision = 5
[../]
[]
test/tests/mesh_modifiers/smooth_mesh/mesh_smoother.i
[Mesh]
type = FileMesh
file = concentric_circle_mesh_in.e
[]
[Variables]
[u]
[]
[]
[Kernels]
[diff]
type = Diffusion
variable = u
[]
[]
[BCs]
[left]
type = DirichletBC
variable = u
boundary = 'left'
value = 0
[]
[right]
type = DirichletBC
variable = u
boundary = 'right'
value = 1
[]
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
[MeshModifiers]
[smooth]
type = SmoothMesh
iterations = 5
[]
[]
modules/richards/test/tests/jacobian_1/jn_fu_02.i
# unsaturated = true
# gravity = false
# supg = false
# transient = false
[Mesh]
type = GeneratedMesh
dim = 3
nx = 1
ny = 1
nz = 1
xmin = -1
xmax = 1
ymin = -1
ymax = 1
zmin = -1
zmax = 1
[]
[GlobalParams]
richardsVarNames_UO = PPNames
density_UO = DensityConstBulk
relperm_UO = RelPermPower
SUPG_UO = SUPGnone
sat_UO = Saturation
seff_UO = SeffVG
[]
[UserObjects]
[./PPNames]
type = RichardsVarNames
richards_vars = pressure
[../]
[./DensityConstBulk]
type = RichardsDensityConstBulk
dens0 = 1
bulk_mod = 1.0 # notice small quantity, so the PETSc constant state works
[../]
[./SeffVG]
type = RichardsSeff1VG
m = 0.8
al = 1 # notice small quantity, so the PETSc constant state works
[../]
[./RelPermPower]
type = RichardsRelPermPower
simm = 0.2
n = 2
[../]
[./Saturation]
type = RichardsSat
s_res = 0.1
sum_s_res = 0.1
[../]
[./SUPGnone]
type = RichardsSUPGnone
[../]
[]
[Variables]
[./pressure]
order = FIRST
family = LAGRANGE
[./InitialCondition]
type = RandomIC
block = 0
min = -1
max = 0
[../]
[../]
[]
[Kernels]
active = 'richardsf'
[./richardst]
type = RichardsMassChange
variable = pressure
[../]
[./richardsf]
type = RichardsFullyUpwindFlux
variable = pressure
[../]
[]
[Materials]
[./rock]
type = RichardsMaterial
block = 0
mat_porosity = 0.1
mat_permeability = '1E-5 0 0 0 1E-5 0 0 0 1E-5'
viscosity = 1E-3
gravity = '0 0 0'
linear_shape_fcns = true
[../]
[]
[Preconditioning]
[./andy]
type = SMP
full = true
petsc_options_iname = '-ksp_type -pc_type -snes_atol -snes_rtol -snes_max_it -snes_type'
petsc_options_value = 'bcgs bjacobi 1E-15 1E-10 10000 test'
[../]
[]
[Executioner]
type = Steady
solve_type = Newton
[]
[Outputs]
execute_on = 'timestep_end'
file_base = jn02
exodus = false
[]
test/tests/meshgenerators/rename_block_generator/rename_block1.i
[MeshGenerators]
[./gmg]
type = GeneratedMeshGenerator
dim = 3
nx = 2
ny = 2
nz = 2
xmin = -1
xmax = 1
ymin = -1
ymax = 1
zmin = -1
zmax = 1
[]
[./subdomain0]
type = SubdomainBoundingBoxGenerator
input = gmg
block_id = 1
bottom_left = '-1 -1 -1'
top_right = '0 0 0'
[]
[./re_id]
type = RenameBlockGenerator
input = subdomain0
old_block_id = '0 1'
new_block_id = '2 3'
[]
[./rename_no_effect]
type = RenameBlockGenerator
input = re_id
old_block_id = '5 0 1'
new_block_name = 'five zero one'
[]
[./rename]
type = RenameBlockGenerator
input = rename_no_effect
old_block_id = '2'
new_block_name = 'two_was_zero'
[]
[./rename_block2]
type = RenameBlockGenerator
input = rename
old_block_name = 'two_was_zero'
new_block_name = 'simply_two'
[]
[./rename_blockID3]
type = RenameBlockGenerator
input = rename_block2
old_block_id = '3'
new_block_name = 'three'
[]
[./three_to_4]
type = RenameBlockGenerator
input = rename_blockID3
old_block_name = 'three'
new_block_id = 4
[]
[]
[Mesh]
type = MeshGeneratorMesh
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./bottom]
type = DirichletBC
variable = u
boundary = bottom
value = 0
[../]
[./top]
type = DirichletBC
variable = u
boundary = top
value = 0
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/meshgenerators/concentric_circle_mesh_generator/concentric_circle_mesh2.i
[MeshGenerators]
[./ccmg]
type = ConcentricCircleMeshGenerator
num_sectors = 6
radii = '0.2546 0.3368 0.3600 0.3818 0.3923 0.4025 0.4110 0.4750'
rings = '10 6 4 4 4 2 2 6 10'
inner_mesh_fraction = 0.6
has_outer_square = on
pitch = 1.42063
#portion = left_half
preserve_volumes = off
[]
[]
[Mesh]
type = MeshGeneratorMesh
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
[]
[Outputs]
exodus = true
[]
examples/ex10_aux/ex10.i
[Mesh]
file = car.e
[]
[Variables]
[./diffused]
order = FIRST
family = LAGRANGE
[../]
[]
# Here is the AuxVariables section where we declare the variables that
# will hold the AuxKernel calcuations. The declaration syntax is very
# similar to that of the regular variables section
[AuxVariables]
[./nodal_aux]
order = FIRST
family = LAGRANGE
[../]
[./element_aux]
order = CONSTANT
family = MONOMIAL
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = diffused
[../]
[]
# Here is the AuxKernels section where we enable the AuxKernels, link
# them to our AuxVariables, set coupling parameters, and set input parameters
[AuxKernels]
[./nodal_example]
type = ExampleAux
variable = nodal_aux
value = 3.0
coupled = diffused
[../]
[./element_example]
type = ExampleAux
variable = element_aux
value = 4.0
coupled = diffused
[../]
[]
[BCs]
[./bottom]
type = DirichletBC
variable = diffused
boundary = 'bottom'
value = 0
[../]
[./top]
type = DirichletBC
variable = diffused
boundary = 'top'
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
execute_on = 'timestep_end'
exodus = true
[]
test/tests/tag/2d_diffusion_tag_vector.i
[Mesh]
file = square.e
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxVariables]
[./tag_variable1]
order = FIRST
family = LAGRANGE
[../]
[./tag_variable2]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
extra_vector_tags = 'vec_tag1 vec_tag2'
[../]
[]
[AuxKernels]
[./TagVectorAux1]
type = TagVectorAux
variable = tag_variable1
v = u
vector_tag = vec_tag1
execute_on = timestep_end
[../]
[./TagVectorAux2]
type = TagVectorAux
variable = tag_variable2
v = u
vector_tag = vec_tag2
execute_on = timestep_end
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
extra_vector_tags = vec_tag1
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
extra_vector_tags = vec_tag2
[../]
[]
[Problem]
type = FEProblem
extra_tag_vectors = 'vec_tag1 vec_tag2'
[]
[Executioner]
type = Steady
solve_type = 'NEWTON'
[]
[Outputs]
file_base = tag_vector_out
exodus = true
[]
test/tests/misc/check_error/aux_kernel_with_var.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxVariables]
[./v]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[./rea]
type = Reaction
variable = u
[../]
[]
[AuxKernels]
[./nope]
type = SelfAux
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'NEWTON'
[]
[Outputs]
file_base = out
exodus = true
[]
modules/fluid_properties/test/tests/two_phase_fluid_properties_independent/test.i
# Tests the TwoPhaseFluidPropertiesIndependent class, which takes the names
# of 2 single-phase fluid properties independently. This test uses a dummy
# aux to make sure that the single-phase fluid properties can be recovered
# from the 2-phase fluid properties. A modification to this test checks that
# an error results if one tries to call a 2-phase fluid properties interface
# using this class, which is designed to ensure that the 2 phases are independent.
[Mesh]
type = GeneratedMesh
dim = 1
nx = 1
[]
[Problem]
solve = false
[]
[AuxVariables]
[./p]
initial_condition = 1e5
[../]
[./T]
initial_condition = 300
[../]
[./rho_avg]
[../]
[]
[Modules]
[./FluidProperties]
# rho1 = 1.149425287 kg/m^3
[./fp1]
type = IdealGasFluidProperties
gamma = 1.4
R = 290
[../]
# rho2 = 0.6666666667 kg/m^3
[./fp2]
type = IdealGasFluidProperties
gamma = 1.2
R = 500
[../]
[./fp_2phase]
type = TwoPhaseFluidPropertiesIndependent
fp_liquid = fp1
fp_vapor = fp2
[../]
[]
[]
[AuxKernels]
# correct value (0.5*(rho1 + rho2)) should be: 0.90804597685 kg/m^3
[./rho_avg_aux]
type = TwoPhaseAverageDensityAux
variable = rho_avg
p = p
T = T
fp_2phase = fp_2phase
execute_on = 'initial'
[../]
[]
[Postprocessors]
[./rho_avg_value]
type = NodalVariableValue
variable = rho_avg
nodeid = 0
[../]
[]
[Executioner]
type = Steady
[]
[Outputs]
execute_on = 'timestep_end'
csv = true
[]
test/tests/kernels/ad_coupled_value/ad_aux_coupled_value.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 4
ny = 4
[]
[Variables]
[./u]
[../]
[]
[AuxVariables]
[v]
initial_condition = 2
[]
[exact]
[]
[]
[ICs]
[exact]
type = FunctionIC
function = 'x*(2-x)'
variable = exact
[]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[ADKernels]
[./ad_coupled_value]
type = ADCoupledValueTest
variable = u
v = v
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'Newton'
[]
[Outputs]
exodus = true
[]
test/tests/misc/check_error/coupling_scalar_into_field.i
[Mesh]
type = GeneratedMesh
dim = 2
[]
[Variables]
[./u]
[../]
[./a]
family = SCALAR
order = FIRST
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[./coupled]
type = CoupledForce
variable = u
# this should trigger an error message, 'v' should a field variable
v = a
[../]
[]
[ScalarKernels]
[./alpha]
type = AlphaCED
variable = a
value = 1
[../]
[]
[BCs]
[./all]
type = DirichletBC
boundary = 'left right top bottom'
variable = u
value = 0
[../]
[]
[Executioner]
type = Steady
[]
test/tests/ics/check_error/two_ics_on_same_boundary.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[ICs]
[./left]
type = ConstantIC
variable = u
boundary = left
value = 0.5
[../]
[./left2]
type = ConstantIC
variable = u
boundary = left
value = 2
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
[]
[Outputs]
[]
test/tests/misc/stop_for_debugger/stop_for_debugger.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Problem]
type = FEProblem
solve = false
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/multiapps/initial_failure/sub.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Problem]
type = FailingProblem
# time_step is set to two if there is no AMR by Steady at the end of its execute.
fail_step = 1
[]
[Executioner]
type = Steady
[]
[Outputs]
exodus = true
[]
test/tests/bcs/nodal_normals/cylinder_hexes_2nd.i
[Mesh]
file = cylinder-hexes-2nd.e
[]
[Functions]
[./all_bc_fn]
type = ParsedFunction
value = x*x+y*y
[../]
[./f_fn]
type = ParsedFunction
value = -4
[../]
[]
[NodalNormals]
boundary = '1'
corner_boundary = 100
order = SECOND
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[./ffn]
type = BodyForce
variable = u
function = f_fn
[../]
[]
[BCs]
[./all]
type = FunctionDirichletBC
variable = u
boundary = '1'
function = 'all_bc_fn'
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
nl_rel_tol = 1e-13
[]
[Outputs]
execute_on = 'timestep_end'
exodus = true
[]
test/tests/meshgenerators/generate_extra_nodeset/generate_extra_nodeset_coord.i
[MeshGenerators]
[./fmg]
type = FileMeshGenerator
file = square.e
[]
[./extra_nodeset]
type = ExtraNodesetGenerator
input = fmg
new_boundary = 'middle_node'
coord = '0.5 0.5'
[]
[]
[Mesh]
type = MeshGeneratorMesh
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
active = 'left right middle'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[./middle]
type = DirichletBC
variable = u
boundary = 'middle_node'
value = -1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
exodus = true
file_base = out_coord
[]
test/tests/dgkernels/2d_diffusion_dg/2d_diffusion_dg_test.i
###########################################################
# This is a test of the Discontinuous Galerkin System.
# Discontinous basis functions are used (Monomials) and
# a the Laplacian DGKernel contributes to the
# internal edges around each element. Jumps are allowed
# by penalized by this method.
#
# @Requirement F3.60
###########################################################
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
# xmin = -1
# xmax = 1
# ymin = -1
# ymax = 1
xmin = 0
xmax = 1
ymin = 0
ymax = 1
elem_type = QUAD4
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = MONOMIAL
[./InitialCondition]
type = ConstantIC
value = 1
[../]
[../]
[]
[Functions]
active = 'forcing_fn exact_fn'
[./forcing_fn]
type = ParsedFunction
# function = -4.0+(x*x)+(y*y)
# function = x
# function = (x*x)-2.0
value = 2*pow(e,-x-(y*y))*(1-2*y*y)
# function = (x*x*x)-6.0*x
[../]
[./exact_fn]
type = ParsedGradFunction
# function = x
# grad_x = 1
# grad_y = 0
# function = (x*x)+(y*y)
# grad_x = 2*x
# grad_y = 2*y
# function = (x*x)
# grad_x = 2*x
# grad_y = 0
value = pow(e,-x-(y*y))
grad_x = -pow(e,-x-(y*y))
grad_y = -2*y*pow(e,-x-(y*y))
# function = (x*x*x)
# grad_x = 3*x*x
# grad_y = 0
[../]
[]
[Kernels]
active = 'diff abs forcing'
[./diff]
type = Diffusion
variable = u
[../]
[./abs] # u * v
type = Reaction
variable = u
[../]
[./forcing]
type = BodyForce
variable = u
function = forcing_fn
[../]
[]
[DGKernels]
active = 'dg_diff'
[./dg_diff]
type = DGDiffusion
variable = u
epsilon = -1
sigma = 6
[../]
[]
[BCs]
active = 'all'
[./all]
type = DGFunctionDiffusionDirichletBC
variable = u
boundary = '0 1 2 3'
function = exact_fn
epsilon = -1
sigma = 6
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
# petsc_options = '-snes_mf'
# petsc_options_iname = '-pc_type -pc_hypre_type'
# petsc_options_value = 'hypre boomeramg'
# petsc_options = '-snes_mf'
# max_r_steps = 2
[./Adaptivity]
steps = 2
refine_fraction = 1.0
coarsen_fraction = 0
max_h_level = 8
[../]
nl_rel_tol = 1e-10
# nl_rel_tol = 1e-12
[]
[Postprocessors]
active = 'h dofs l2_err'
[./h]
type = AverageElementSize
[../]
[./dofs]
type = NumDOFs
[../]
[./l2_err]
type = ElementL2Error
variable = u
function = exact_fn
[../]
[]
[Outputs]
file_base = out
exodus = true
csv = true
[]
test/tests/misc/check_error/override_name_variable_test.i
# Two non-linear variables with the same name
[Mesh]
type = GeneratedMesh
dim = 2
xmin = 0
xmax = 1
ymin = 0
ymax = 1
nx = 5
ny = 5
elem_type = QUAD9
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
# Note this section is a repeat of the one above
[./u]
order = SECOND
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 3
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/outputs/oversample/ex02_adapt.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
nz = 0
zmax = 0
elem_type = QUAD9
[]
[Variables]
[./diffused]
order = SECOND
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = diffused
[../]
[]
[DiracKernels]
[./foo]
variable = diffused
type = ConstantPointSource
value = 1
point = '0.3 0.3 0.0'
[../]
[]
[BCs]
[./all]
type = DirichletBC
variable = diffused
boundary = 'bottom left right top'
value = 0.0
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
[]
[Adaptivity]
max_h_level = 2
initial_steps = 2
marker = marker
steps = 2
initial_marker = marker
[./Indicators]
[./indicator]
type = GradientJumpIndicator
variable = diffused
[../]
[../]
[./Markers]
[./marker]
type = ErrorFractionMarker
indicator = indicator
refine = 0.5
[../]
[../]
[]
[Outputs]
execute_on = 'timestep_end'
exodus = true
[./os2]
type = Exodus
refinements = 2
[../]
[./os4]
type = Exodus
refinements = 4
[../]
[]
test/tests/mesh/patterned_mesh/mesh_tester.i
[Mesh]
type = FileMesh
file = patterned_mesh_in.e
dim = 2
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = MatCoefDiffusion
variable = u
conductivity = conductivity
[../]
[]
[BCs]
[./top]
type = DirichletBC
variable = u
boundary = 3
value = 1
[../]
[./bottom]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[]
[Materials]
[./mat1]
type = GenericConstantMaterial
block = 1
prop_names = conductivity
prop_values = 100
[../]
[./mat2]
type = GenericConstantMaterial
block = 2
prop_names = conductivity
prop_values = 1e-4
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
modules/phase_field/test/tests/MultiSmoothCircleIC/test_problem.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 20
ny = 20
xmin = 0
xmax = 50
ymin = 0
ymax = 50
elem_type = QUAD4
[]
[Variables]
[./c]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxVariables]
[./features]
order = CONSTANT
family = MONOMIAL
[../]
[./ghosts]
order = CONSTANT
family = MONOMIAL
[../]
[./halos]
order = CONSTANT
family = MONOMIAL
[../]
[./proc_id]
order = CONSTANT
family = MONOMIAL
[../]
[]
[ICs]
[./c]
type = LatticeSmoothCircleIC
variable = c
invalue = 1.0
outvalue = 0.0001
circles_per_side = '2 2'
pos_variation = 10.0
radius = 8.0
int_width = 5.0
radius_variation_type = uniform
avoid_bounds = false
[../]
[]
[BCs]
[./Periodic]
[./c]
variable = c
auto_direction = 'x y'
[../]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = c
[../]
[]
[AuxKernels]
[./features]
type = FeatureFloodCountAux
variable = features
execute_on = 'initial timestep_end'
flood_counter = features
[../]
[./ghosts]
type = FeatureFloodCountAux
variable = ghosts
field_display = GHOSTED_ENTITIES
execute_on = 'initial timestep_end'
flood_counter = features
[../]
[./halos]
type = FeatureFloodCountAux
variable = halos
field_display = HALOS
execute_on = 'initial timestep_end'
flood_counter = features
[../]
[./proc_id]
type = ProcessorIDAux
variable = proc_id
execute_on = 'initial timestep_end'
[../]
[]
[Postprocessors]
[./features]
type = FeatureFloodCount
variable = c
flood_entity_type = ELEMENTAL
execute_on = 'initial timestep_end'
[../]
[]
[Problem]
type = FEProblem
solve = false
[]
[Executioner]
type = Steady
[]
[Outputs]
exodus = true
[]
test/tests/kernels/diffusion_with_hanging_node/simple_diffusion.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 1
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Preconditioning]
[./pre]
type = SMP
full = true
[../]
[]
[Executioner]
type = Steady
solve_type = 'NEWTON'
petsc_options = '-pc_svd_monitor -ksp_view_pmat'
petsc_options_iname = '-pc_type'
petsc_options_value = 'svd'
[]
[Outputs]
exodus = true
[]
[Adaptivity]
marker = box
max_h_level = 1
initial_steps = 1
[./Markers]
[./box]
type = BoxMarker
bottom_left = '0.5 0 0'
top_right = '1 1 0'
inside = 'refine'
outside = 'do_nothing'
[../]
[../]
[]
test/tests/markers/block_restricted/marker_block.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
xmax = 5
ymax = 5
[]
[MeshModifiers]
[./lower_block]
type = SubdomainBoundingBox
top_right = '5 3 0'
bottom_left = '0 0 0'
block_id = 0
[../]
[./upper_block]
type = SubdomainBoundingBox
top_right = '5 5 0'
bottom_left = '0 3 0'
block_id = 1
[../]
[]
[Adaptivity]
initial_steps = 2
initial_marker = marker
[./Markers]
[./marker]
type = UniformMarker
block = 0
mark = REFINE
[../]
[../]
[]
[Variables]
[./u]
initial_condition = 0
[../]
[]
[Problem]
type = FEProblem
solve = false
[]
[Executioner]
type = Steady
[]
[Outputs]
exodus = true
[]
modules/fluid_properties/test/tests/brine/brine_tabulated.i
# Test BrineFluidProperties calculations of density, viscosity and thermal
# conductivity with a TabulatedFluidProperties water.
#
# Experimental density values from Pitzer et al, "Thermodynamic properties
# of aqueous sodium chloride solution", Journal of Physical and Chemical
# Reference Data, 13, 1-102 (1984)
#
# Experimental viscosity values from Phillips et al, "Viscosity of NaCl and
# other solutions up to 350C and 50MPa pressures", LBL-11586 (1980)
#
# Thermal conductivity values from Ozbek and Phillips, "Thermal conductivity of
# aqueous NaCl solutions from 20C to 330C", LBL-9086 (1980)
#
# --------------------------------------------------------------
# Pressure (Mpa) | 20 | 20 | 40
# Temperature (C) | 50 | 200 | 200
# NaCl molality (mol/kg) | 2 | 2 | 5
# NaCl mass fraction (kg/kg) | 0.1047 | 0.1047 | 0.2261
# --------------------------------------------------------------
# Expected values
# --------------------------------------------------------------
# Density (kg/m^3) | 1068.52 | 959.27 | 1065.58
# Viscosity (1e-6Pa.s) | 679.8 | 180.0 | 263.1
# Thermal conductivity (W/m/K) | 0.630 | 0.649 | 0.633
# --------------------------------------------------------------
# Calculated values
# --------------------------------------------------------------
# Density (kg/m^3) | 1067.18 | 958.68 | 1065.46
# Viscosity (1e-6 Pa.s) | 681.1 | 181.98 | 266.1
# Thermal conductivity (W/m/K) | 0.637 | 0.662 | 0.658
# --------------------------------------------------------------
#
# All results are within expected accuracy
[Mesh]
type = GeneratedMesh
dim = 2
nx = 3
ny = 1
xmax = 3
# This test uses ElementalVariableValue postprocessors on specific
# elements, so element numbering needs to stay unchanged
allow_renumbering = false
[]
[Variables]
[./dummy]
[../]
[]
[AuxVariables]
[./pressure]
family = MONOMIAL
order = CONSTANT
[../]
[./temperature]
family = MONOMIAL
order = CONSTANT
[../]
[./xnacl]
family = MONOMIAL
order = CONSTANT
[../]
[./density]
family = MONOMIAL
order = CONSTANT
[../]
[./enthalpy]
family = MONOMIAL
order = CONSTANT
[../]
[./internal_energy]
family = MONOMIAL
order = CONSTANT
[../]
[]
[Functions]
[./pic]
type = ParsedFunction
value = 'if(x<2,20e6, 40e6)'
[../]
[./tic]
type = ParsedFunction
value = 'if(x<1, 323.15, 473.15)'
[../]
[./xic]
type = ParsedFunction
value = 'if(x<2,0.1047, 0.2261)'
[../]
[]
[ICs]
[./p_ic]
type = FunctionIC
function = pic
variable = pressure
[../]
[./t_ic]
type = FunctionIC
function = tic
variable = temperature
[../]
[./x_ic]
type = FunctionIC
function = xic
variable = xnacl
[../]
[]
[AuxKernels]
[./density]
type = MaterialRealAux
variable = density
property = density
[../]
[./enthalpy]
type = MaterialRealAux
variable = enthalpy
property = enthalpy
[../]
[./internal_energy]
type = MaterialRealAux
variable = internal_energy
property = e
[../]
[]
[Modules]
[./FluidProperties]
[./water]
type = Water97FluidProperties
[../]
[./water_tab]
type = TabulatedFluidProperties
fp = water
save_file = false
[../]
[./brine]
type = BrineFluidProperties
water_fp = water_tab
[../]
[../]
[]
[Materials]
[./fp_mat]
type = MultiComponentFluidPropertiesMaterialPT
pressure = pressure
temperature = temperature
xmass = xnacl
fp = brine
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = dummy
[../]
[]
[Executioner]
type = Steady
solve_type = NEWTON
[]
[Postprocessors]
[./density0]
type = ElementalVariableValue
variable = density
elementid = 0
[../]
[./density1]
type = ElementalVariableValue
variable = density
elementid = 1
[../]
[./density2]
type = ElementalVariableValue
variable = density
elementid = 2
[../]
[./enthalpy0]
type = ElementalVariableValue
variable = enthalpy
elementid = 0
[../]
[./enthalpy1]
type = ElementalVariableValue
variable = enthalpy
elementid = 1
[../]
[./enthalpy2]
type = ElementalVariableValue
variable = enthalpy
elementid = 2
[../]
[./e0]
type = ElementalVariableValue
variable = internal_energy
elementid = 0
[../]
[./e1]
type = ElementalVariableValue
variable = internal_energy
elementid = 1
[../]
[./e2]
type = ElementalVariableValue
variable = internal_energy
elementid = 2
[../]
[]
[Outputs]
csv = true
file_base = brine_out
[]
python/peacock/tests/common/simple_diffusion.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
# Preconditioned JFNK (default)
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
modules/stochastic_tools/test/tests/multiapps/commandline_control/sub.i
[Mesh]
type = GeneratedMesh
dim = 1
[]
[Variables]
[u]
initial_condition = 1980
[]
[]
[Problem]
type = FEProblem
solve = false
[]
[Executioner]
type = Steady
[]
[Postprocessors]
[size]
type = AverageElementSize
execute_on = 'initial'
[]
[]
[Outputs]
csv = true
[]
python/peacock/tests/common/fsp_test.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
[]
[Variables]
active = 'u v'
[./u]
order = FIRST
family = LAGRANGE
[../]
[./v]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff_u conv_v diff_v'
[./diff_u]
type = Diffusion
variable = u
[../]
[./conv_v]
type = CoupledForce
variable = v
v = u
[../]
[./diff_v]
type = Diffusion
variable = v
[../]
[]
[BCs]
active = 'left_u right_u left_v'
[./left_u]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right_u]
type = DirichletBC
variable = u
boundary = 2
value = 100
[../]
[./left_v]
type = DirichletBC
variable = v
boundary = 1
value = 0
[../]
[./right_v]
type = DirichletBC
variable = v
boundary = 2
value = 0
[../]
[]
[Executioner]
type = Steady
# This is setup automatically in MOOSE (SetupPBPAction.C)
# petsc_options = '-snes_mf_operator'
# petsc_options_iname = '-pc_type'
# petsc_options_value = 'asm'
[]
[Preconditioning]
active = 'FSP'
[./FSP]
type = FSP
# It is the starting point of splitting
topsplit = 'uv' # uv should match the following block name
[./uv]
splitting = 'u v' # u and v are the names of subsolvers
# Generally speaking, there are four types of splitting we could choose
# <additive,multiplicative,symmetric_multiplicative,schur>
splitting_type = additive
# An approximate solution to the original system
# | A_uu A_uv | | u | _ |f_u|
# | 0 A_vv | | v | - |f_v|
# is obtained by solving the following subsystems
# A_uu u = f_u and A_vv v = f_v
# If splitting type is specified as schur, we may also want to set more options to
# control how schur works using PETSc options
# petsc_options_iname = '-pc_fieldsplit_schur_fact_type -pc_fieldsplit_schur_precondition'
# petsc_options_value = 'full selfp'
[../]
[./u]
vars = 'u'
# PETSc options for this subsolver
# A prefix will be applied, so just put the options for this subsolver only
petsc_options_iname = '-pc_type -ksp_type'
petsc_options_value = ' hypre preonly'
[../]
[./v]
vars = 'v'
# PETSc options for this subsolver
petsc_options_iname = '-pc_type -ksp_type'
petsc_options_value = ' hypre preonly'
[../]
[../]
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/outputs/gmv/gmv.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
gmv = true
[]
test/tests/markers/box_marker/box_marker_test.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
nz = 0
zmax = 0
elem_type = QUAD4
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Adaptivity]
[./Markers]
[./box]
type = BoxMarker
bottom_left = '0.3 0.3 0'
top_right = '0.6 0.6 0'
inside = refine
outside = do_nothing
[../]
[../]
[]
[Outputs]
exodus = true
[]
test/tests/parser/cli_argument/cli_arg_test.i
[Mesh]
file = square.e
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 9999 # Override this value
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Materials]
active = empty
[./empty]
type = MTMaterial
block = 9999 # Override this value
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/actions/get_actions/test_get_actions.i
[Mesh]
file = square.e
uniform_refine = 4
[]
[TestGetActions]
[]
[Variables]
[./convected]
[../]
[./diffused]
[../]
[]
[Kernels]
# intentionally give a name the same as material names
[./mat1]
type = Diffusion
variable = convected
[../]
[./diff_u]
type = Diffusion
variable = diffused
[../]
[]
[BCs]
active = 'left_convected right_convected left_diffused right_diffused'
[./left_convected]
type = DirichletBC
variable = convected
boundary = '1'
value = 0
[../]
[./right_convected]
type = DirichletBC
variable = convected
boundary = '2'
value = 1
[../]
[./left_diffused]
type = DirichletBC
variable = diffused
boundary = '1'
value = 0
[../]
[./right_diffused]
type = DirichletBC
variable = diffused
boundary = '2'
value = 1
[../]
[]
[Materials]
[./mat4]
type = RandomMaterial
block = 1
[../]
[./mat3]
type = MTMaterial
block = 1
[../]
[./mat1]
type = GenericConstantMaterial
prop_names = prop1
prop_values = 1.0
block = 1
[../]
[./mat2]
type = CoupledMaterial
mat_prop = prop2
coupled_mat_prop = prop1
block = 1
[../]
[]
[Executioner]
type = Steady
[]
[Outputs]
execute_on = 'timestep_end'
[]
test/tests/preconditioners/pcside/diffusionCG.i
[Mesh]
file = square.e
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = PenaltyDirichletBC
penalty = 1e9
variable = u
boundary = 1
value = 0
[../]
[./right]
type = PenaltyDirichletBC
penalty = 1e9
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type -ksp_type -ksp_norm_type'
petsc_options_value = 'hypre boomeramg cg preconditioned'
# We are using preconditioned norm because of PenaltyDirichletBC
[]
[Outputs]
file_base = out
exodus = true
[]
modules/phase_field/test/tests/reconstruction/1phase_reconstruction.i
#
# In this test we set the initial condition of a set of order parameters
# by pulling out the grain data from given EBSD data file ignoring the phase completely.
#
[Problem]
type = FEProblem
solve = false
kernel_coverage_check = false
[]
# The following sections are extracted in the documentation in
# moose/docs/content/modules/phase_field/ICs/EBSD.md
[Mesh]
# Create a mesh representing the EBSD data
type = EBSDMesh
filename = IN100_001_28x28_Marmot.txt
[]
[GlobalParams]
# Define the number and names of the order parameters used to represent the grains
op_num = 4
var_name_base = gr
[]
[UserObjects]
[./ebsd_reader]
# Read in the EBSD data. Uses the filename given in the mesh block.
type = EBSDReader
[../]
[./ebsd]
type = PolycrystalEBSD
coloring_algorithm = bt
ebsd_reader = ebsd_reader
output_adjacency_matrix = true
[../]
[./grain_tracker]
type = GrainTracker
# For displaying HALO fields
compute_halo_maps = true
# Link in the ebsd userobject here so that grain tracker can extract info from it
polycrystal_ic_uo = ebsd
[../]
[]
[Variables]
[./PolycrystalVariables]
# Create all the order parameters
order = FIRST
family = LAGRANGE
[../]
[]
[ICs]
[./PolycrystalICs]
[./PolycrystalColoringIC]
# Uses the data from the user object 'ebsd' to initialize the variables for all the order parameters.
polycrystal_ic_uo = ebsd
[../]
[../]
[]
#ENDDOC - End of the file section that is included in the documentation. Do not change this line!
[GlobalParams]
execute_on = 'initial'
family = MONOMIAL
order = CONSTANT
[]
[AuxVariables]
[./PHI1]
[../]
[./PHI]
[../]
[./PHI2]
[../]
[./GRAIN]
[../]
[./unique_grains]
[../]
[./var_indices]
[../]
[./halo0]
[../]
[./halo1]
[../]
[./halo2]
[../]
[./halo3]
[../]
[]
[AuxKernels]
[./phi1_aux]
type = EBSDReaderPointDataAux
variable = PHI1
ebsd_reader = ebsd_reader
data_name = 'phi1'
[../]
[./phi_aux]
type = EBSDReaderPointDataAux
variable = PHI
ebsd_reader = ebsd_reader
data_name = 'phi'
[../]
[./phi2_aux]
type = EBSDReaderPointDataAux
variable = PHI2
ebsd_reader = ebsd_reader
data_name = 'phi2'
[../]
[./grain_aux]
type = EBSDReaderPointDataAux
variable = GRAIN
ebsd_reader = ebsd_reader
data_name = 'feature_id'
[../]
[./unique_grains]
type = FeatureFloodCountAux
variable = unique_grains
flood_counter = grain_tracker
field_display = UNIQUE_REGION
[../]
[./var_indices]
type = FeatureFloodCountAux
variable = var_indices
flood_counter = grain_tracker
field_display = VARIABLE_COLORING
[../]
[./halo0]
type = FeatureFloodCountAux
variable = halo0
map_index = 0
field_display = HALOS
flood_counter = grain_tracker
[../]
[./halo1]
type = FeatureFloodCountAux
variable = halo1
map_index = 1
field_display = HALOS
flood_counter = grain_tracker
[../]
[./halo2]
type = FeatureFloodCountAux
variable = halo2
map_index = 2
field_display = HALOS
flood_counter = grain_tracker
[../]
[./halo3]
type = FeatureFloodCountAux
variable = halo3
map_index = 3
field_display = HALOS
flood_counter = grain_tracker
[../]
[]
[Executioner]
type = Steady
[]
[Outputs]
exodus = true
[]
test/tests/misc/check_error/constraint_with_aux_var.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxVariables]
[./v]
[../]
[]
[Constraints]
[./nope]
type = CoupledTiedValueConstraint
variable = v
slave = 2
master = 3
master_variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'NEWTON'
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/ics/random_ic_test/random_ic_test.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 50
ny = 50
[]
[Variables]
[u]
order = FIRST
family = LAGRANGE
[]
[]
[AuxVariables]
[u_aux]
order = FIRST
family = LAGRANGE
[]
[]
[ICs]
[u]
type = RandomIC
legacy_generator = false
variable = u
[]
[u_aux]
type = RandomIC
legacy_generator = false
variable = u_aux
[]
[]
[Kernels]
[diff]
type = Diffusion
variable = u
[]
[]
[BCs]
[left]
type = DirichletBC
variable = u
boundary = 3
value = 0
[]
[right]
type = DirichletBC
variable = u
boundary = 1
value = 1
[]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/kernels/coupled_kernel_grad/coupled_kernel_grad_test.i
[Mesh]
type = GeneratedMesh
dim = 2
xmin = -1
xmax = 1
ymin = -1
ymax = 1
nx = 10
ny = 10
elem_type = QUAD9
[]
[Functions]
[./forcing_fnu]
type = ParsedFunction
value = -5.8*(x+y)+x*x*x-x+y*y*y-y
[../]
[./forcing_fnv]
type = ParsedFunction
value = -4
[../]
[./slnu]
type = ParsedGradFunction
value = x*x*x-x+y*y*y-y
grad_x = 3*x*x-1
grad_y = 3*y*y-1
[../]
[./slnv]
type = ParsedGradFunction
value = x*x+y*y
grad_x = 2*x
grad_y = 2*y
[../]
#NeumannBC functions
[./bc_fnut]
type = ParsedFunction
value = 3*y*y-1
[../]
[./bc_fnub]
type = ParsedFunction
value = -3*y*y+1
[../]
[./bc_fnul]
type = ParsedFunction
value = -3*x*x+1
[../]
[./bc_fnur]
type = ParsedFunction
value = 3*x*x-1
[../]
[]
[Variables]
[./u]
order = THIRD
family = HIERARCHIC
[../]
[./v]
order = SECOND
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff1 diff2 test1 forceu forcev react'
[./diff1]
type = Diffusion
variable = u
[../]
[./test1]
type = CoupledKernelGradTest
variable = u
var2 = v
vel = '0.1 0.1'
[../]
[./diff2]
type = Diffusion
variable = v
[../]
[./react]
type = Reaction
variable = u
[../]
[./forceu]
type = BodyForce
variable = u
function = forcing_fnu
[../]
[./forcev]
type = BodyForce
variable = v
function = forcing_fnv
[../]
[]
[BCs]
active = 'bc_u_tb bc_v bc_ul bc_ur bc_ut bc_ub'
[./bc_u]
type = FunctionPenaltyDirichletBC
variable = u
function = slnu
boundary = 'left right top bottom'
penalty = 1e6
[../]
[./bc_v]
type = FunctionDirichletBC
variable = v
function = slnv
boundary = 'left right top bottom'
[../]
[./bc_u_lr]
type = FunctionPenaltyDirichletBC
variable = u
function = slnu
boundary = 'left right top bottom'
penalty = 1e6
[../]
[./bc_u_tb]
type = CoupledKernelGradBC
variable = u
var2 = v
vel = '0.1 0.1'
boundary = 'top bottom left right'
[../]
[./bc_ul]
type = FunctionNeumannBC
variable = u
function = bc_fnul
boundary = 'left'
[../]
[./bc_ur]
type = FunctionNeumannBC
variable = u
function = bc_fnur
boundary = 'right'
[../]
[./bc_ut]
type = FunctionNeumannBC
variable = u
function = bc_fnut
boundary = 'top'
[../]
[./bc_ub]
type = FunctionNeumannBC
variable = u
function = bc_fnub
boundary = 'bottom'
[../]
[]
[Preconditioning]
active = ' '
[./prec]
type = SMP
full = true
[../]
[]
[Postprocessors]
active='L2u L2v'
[./dofs]
type = NumDOFs
[../]
[./h]
type = AverageElementSize
[../]
[./L2u]
type = ElementL2Error
variable = u
function = slnu
[../]
[./L2v]
type = ElementL2Error
variable = v
function = slnv
[../]
[./H1error]
type = ElementH1Error
variable = u
function = solution
[../]
[./H1Semierror]
type = ElementH1SemiError
variable = u
function = solution
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
# petsc_options = '-snes'
nl_rel_tol = 1e-15
nl_abs_tol = 1e-13
[]
[Outputs]
execute_on = 'timestep_end'
exodus = true
csv = true
[]
modules/phase_field/test/tests/MultiPhase/multibarrierfunction.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 50
ny = 50
nz = 0
xmin = 0
xmax = 20
ymin = 0
ymax = 20
elem_type = QUAD4
[]
[AuxVariables]
[./eta1]
order = FIRST
family = LAGRANGE
[./InitialCondition]
type = SmoothCircleIC
x1 = 7.0
y1 = 10.0
radius = 5.0
invalue = 0.9
outvalue = 0.1
int_width = 2.0
[../]
[../]
[./eta2]
order = FIRST
family = LAGRANGE
[./InitialCondition]
type = SmoothCircleIC
x1 = 13.0
y1 = 10.0
radius = 5.0
invalue = 0.9
outvalue = 0.1
int_width = 2.0
[../]
[../]
[]
[BCs]
[./Periodic]
[./All]
auto_direction = 'x y'
[../]
[../]
[]
[Materials]
[./multibarrier]
type = MultiBarrierFunctionMaterial
etas = 'eta1 eta2'
function_name = g
outputs = exodus
[../]
[]
[Executioner]
type = Steady
solve_type = 'NEWTON'
[]
[Problem]
solve = false
[]
[Outputs]
exodus = true
[]
test/tests/misc/check_error/uo_pps_name_collision_test.i
[Mesh]
type = GeneratedMesh
dim = 2
xmin = 0
xmax = 1
ymin = 0
ymax = 1
nx = 5
ny = 5
elem_type = QUAD4
[]
[UserObjects]
[./ud]
type = MTUserObject
scalar = 2
vector = '9 7 5'
[../]
[]
[Functions]
[./forcing_fn]
type = ParsedFunction
value = -2
[../]
[./exact_fn]
type = ParsedFunction
value = x*x
[../]
[]
[Variables]
[./u]
family = LAGRANGE
order = FIRST
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[./ffn]
type = UserObjectKernel
variable = u
user_object = ud
[]
[]
[BCs]
[./all]
type = FunctionDirichletBC
variable = u
function = exact_fn
boundary = '0 1 2 3'
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Postprocessors]
[./ud]
type = NumDOFs
[]
[]
[Outputs]
execute_on = 'timestep_end'
file_base = out
exodus = true
[]
modules/porous_flow/test/tests/capillary_pressure/vangenuchten2.i
# Test van Genuchten relative permeability curve by varying saturation over the mesh
# van Genuchten exponent m = 0.5 for both phases
# No residual saturation in either phase
[Mesh]
type = GeneratedMesh
dim = 1
nx = 500
[]
[GlobalParams]
PorousFlowDictator = dictator
[]
[Variables]
[./p0]
initial_condition = 1e6
[../]
[./s1]
[../]
[]
[AuxVariables]
[./s0aux]
family = MONOMIAL
order = CONSTANT
[../]
[./s1aux]
family = MONOMIAL
order = CONSTANT
[../]
[./p0aux]
family = MONOMIAL
order = CONSTANT
[../]
[./p1aux]
family = MONOMIAL
order = CONSTANT
[../]
[]
[AuxKernels]
[./s0]
type = PorousFlowPropertyAux
property = saturation
phase = 0
variable = s0aux
[../]
[./s1]
type = PorousFlowPropertyAux
property = saturation
phase = 1
variable = s1aux
[../]
[./p0]
type = PorousFlowPropertyAux
property = pressure
phase = 0
variable = p0aux
[../]
[./p1]
type = PorousFlowPropertyAux
property = pressure
phase = 1
variable = p1aux
[../]
[]
[Functions]
[./s1]
type = ParsedFunction
value = x
[../]
[]
[ICs]
[./s1]
type = FunctionIC
variable = s1
function = s1
[../]
[]
[Kernels]
[./p0]
type = Diffusion
variable = p0
[../]
[./s1]
type = Diffusion
variable = s1
[../]
[]
[UserObjects]
[./dictator]
type = PorousFlowDictator
porous_flow_vars = 'p0 s1'
number_fluid_phases = 2
number_fluid_components = 2
[../]
[./pc]
type = PorousFlowCapillaryPressureVG
alpha = 1e-5
m = 0.5
sat_lr = 0.1
log_extension = true
[../]
[]
[Materials]
[./temperature]
type = PorousFlowTemperature
[../]
[./ppss]
type = PorousFlow2PhasePS
phase0_porepressure = p0
phase1_saturation = s1
capillary_pressure = pc
[../]
[./kr0]
type = PorousFlowRelativePermeabilityVG
phase = 0
m = 0.5
[../]
[./kr1]
type = PorousFlowRelativePermeabilityCorey
phase = 1
n = 2
[../]
[]
[VectorPostprocessors]
[./vpp]
type = LineValueSampler
variable = 's0aux s1aux p0aux p1aux'
start_point = '0 0 0'
end_point = '1 0 0'
num_points = 500
sort_by = id
[../]
[]
[Executioner]
type = Steady
solve_type = NEWTON
nl_abs_tol = 1e-6
[]
[BCs]
[./sleft]
type = DirichletBC
variable = s1
value = 0
boundary = left
[../]
[./sright]
type = DirichletBC
variable = s1
value = 1
boundary = right
[../]
[]
[Outputs]
csv = true
execute_on = timestep_end
[]
modules/phase_field/test/tests/KKS_system/bug.i
#
# This test validates the phase concentration calculation for the KKS system
#
[Mesh]
type = GeneratedMesh
dim = 2
nx = 20
ny = 20
nz = 0
xmin = 0
xmax = 1
ymin = 0
ymax = 1
zmin = 0
zmax = 0
elem_type = QUAD4
[]
# We set u
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 'left'
value = 0.1
[../]
[./right]
type = DirichletBC
variable = u
boundary = 'right'
value = 0.9
[../]
[]
[Variables]
# primary variable
[./u]
order = FIRST
family = LAGRANGE
[../]
# secondary variable
[./v]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./udiff]
type = Diffusion
variable = u
[../]
[./valgebra]
type = AlgebraDebug
variable = v
v = u
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
#solve_type = 'NEWTON'
[]
#[Preconditioning]
# [./mydebug]
# type = FDP
# full = true
# [../]
#[]
[Outputs]
execute_on = 'timestep_end'
file_base = bug
exodus = true
[]
test/tests/indicators/depend_material/depend_material.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Adaptivity]
[./Indicators]
[./indicator]
type = MaterialTestIndicator
property = 'prop'
[../]
[../]
[]
[Materials]
[./mat]
type = GenericFunctionMaterial
prop_names = 'prop'
prop_values = 'func'
[../]
[]
[Functions]
[./func]
type = ParsedFunction
value = 'if(y<0.5,1980,1949)'
[../]
[]
[Problem]
type = FEProblem
solve = false
[]
[Executioner]
type = Steady
[]
[Outputs]
exodus = true
[]
modules/heat_conduction/test/tests/heat_conduction/2d_quadrature_gap_heat_transfer/gap_conductivity_property.i
[Mesh]
file = perfect.e
[]
[Variables]
[./temp]
[../]
[]
[AuxVariables]
[./gap_conductivity]
order = CONSTANT
family = MONOMIAL
[../]
[]
[Kernels]
[./hc]
type = HeatConduction
variable = temp
[../]
[]
[AuxKernels]
[./gap_conductivity]
type = MaterialRealAux
boundary = leftright
property = gap_conductivity
variable = gap_conductivity
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = temp
boundary = leftleft
value = 300
[../]
[./right]
type = DirichletBC
variable = temp
boundary = rightright
value = 400
[../]
[]
[ThermalContact]
[./left_to_right]
slave = leftright
quadrature = true
master = rightleft
variable = temp
type = GapHeatTransfer
gap_conductivity = 3.0
[../]
[]
[Materials]
[./hcm]
type = HeatConductionMaterial
block = 'left right'
specific_heat = 1
thermal_conductivity = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
exodus = true
[]
modules/phase_field/test/tests/initial_conditions/MultiBoundingBoxIC1D.i
[Mesh]
type = GeneratedMesh
dim = 1
nx = 20
[]
[Variables]
[./c1]
order = FIRST
family = LAGRANGE
[../]
[./c2]
order = FIRST
family = LAGRANGE
[../]
[]
[ICs]
[./c1]
type = MultiBoundingBoxIC
corners = '0.1 0 0 0.8 0 0 0.3 0 0'
opposite_corners = '0.2 0 0 0.6 0 0 0.4 0 0'
inside = '1.0'
outside = 0.1
variable = c1
[../]
[./c2]
type = MultiBoundingBoxIC
corners = '0.1 0 0 0.8 0 0 0.3 0 0'
opposite_corners = '0.2 0 0 0.4 0 0 0.5 0 0'
inside = '1.0 2.0 3.0'
outside = 0.1
variable = c2
[../]
[]
[Executioner]
type = Steady
[]
[Problem]
solve = false
kernel_coverage_check = false
[]
[Outputs]
exodus = true
[]
test/tests/misc/check_error/multi_precond_test.i
[Mesh]
file = square.e
# init_unif_refine = 6
[]
[Preconditioning]
active = 'PBP FDP'
[./PBP]
type = PBP
solve_order = 'u v'
preconditioner = 'LU LU'
off_diag_row = 'v'
off_diag_column = 'u'
[../]
[./FDP]
type = FDP
off_diag_row = 'v'
off_diag_column = 'u'
[../]
[]
[Variables]
active = 'u v'
[./u]
order = FIRST
family = LAGRANGE
[../]
[./v]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff_u conv_v diff_v'
[./diff_u]
type = Diffusion
variable = u
[../]
[./conv_v]
type = CoupledForce
variable = v
v = u
[../]
[./diff_v]
type = Diffusion
variable = v
[../]
[]
[BCs]
active = 'left_u right_u left_v'
[./left_u]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right_u]
type = DirichletBC
variable = u
boundary = 2
value = 100
[../]
[./left_v]
type = DirichletBC
variable = v
boundary = 1
value = 0
[../]
[./right_v]
type = DirichletBC
variable = v
boundary = 2
value = 0
[../]
[]
[Executioner]
type = Steady
l_max_its = 1
nl_max_its = 1
solve_type = JFNK
[]
[Outputs]
file_base = pbp_out
exodus = true
[]
modules/tensor_mechanics/test/tests/stress_recovery/stress_concentration/stress_concentration.i
[GlobalParams]
displacements = 'disp_x disp_y'
[]
[Mesh]
type = FileMesh
file = geo.msh
[]
[Variables]
[disp_x]
[]
[disp_y]
[]
[]
[AuxVariables]
[stress_xx]
order = CONSTANT
family = MONOMIAL
[]
[stress_yy]
order = CONSTANT
family = MONOMIAL
[]
[stress_xx_recovered]
[]
[stress_yy_recovered]
[]
[]
[AuxKernels]
[stress_xx]
type = RankTwoAux
rank_two_tensor = stress
variable = stress_xx
index_i = 0
index_j = 0
execute_on = 'timestep_end'
[]
[stress_yy]
type = RankTwoAux
rank_two_tensor = stress
variable = stress_yy
index_i = 1
index_j = 1
execute_on = 'timestep_end'
[]
[stress_xx_recovered]
type = RankTwoAux
rank_two_tensor = stress
variable = stress_xx_recovered
patch_polynomial_order = SECOND
index_i = 0
index_j = 0
execute_on = 'timestep_end'
[]
[stress_yy_recovered]
type = RankTwoAux
rank_two_tensor = stress
variable = stress_yy_recovered
patch_polynomial_order = SECOND
index_i = 1
index_j = 1
execute_on = 'timestep_end'
[]
[]
[Kernels]
[solid_x]
type = StressDivergenceTensors
variable = disp_x
component = 0
[]
[solid_y]
type = StressDivergenceTensors
variable = disp_y
component = 1
[]
[]
[Materials]
[strain]
type = ComputeSmallStrain
[]
[Cijkl]
type = ComputeIsotropicElasticityTensor
poissons_ratio = 0.3
youngs_modulus = 2.1e+5
[]
[stress]
type = ComputeLinearElasticStress
[]
[]
[BCs]
[top_xdisp]
type = FunctionPresetBC
variable = disp_y
boundary = 'top'
function = 0
[]
[top_ydisp]
type = FunctionPresetBC
variable = disp_y
boundary = 'top'
function = 0.01
[]
[bottom_xdisp]
type = FunctionPresetBC
variable = disp_x
boundary = 'bottom'
function = 0
[]
[bottom_ydisp]
type = FunctionPresetBC
variable = disp_y
boundary = 'bottom'
function = 0
[]
[]
[Preconditioning]
[smp]
type = SMP
full = true
ksp_norm = default
[]
[]
[Executioner]
type = Steady
solve_type = NEWTON
petsc_options_iname = '-ksp_type -pc_type'
petsc_options_value = 'preonly lu'
nl_rel_tol = 1e-14
l_max_its = 100
nl_max_its = 30
[]
[Outputs]
interval = 1
exodus = true
print_linear_residuals = false
[]
test/tests/mesh/mixed_dim/1d_2d_w_matl.i
# Using different mesh file where 1D elements will come before 2D ones.
# This is important for testing the robustness of re-initializing materials
[Mesh]
file = 1d_2d-2.e
# Mixed-dimension meshes don't seem to work with DistributedMesh. The
# program hangs, I can't get a useful stack trace when I attach to
# it. See also #2130.
parallel_type = replicated
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff]
type = MatDiffusionTest
variable = u
prop_name = matp
[../]
[]
[Materials]
[./mat1]
type = MTMaterial
block = '1 2'
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 4
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[./bottom]
type = DirichletBC
variable = u
boundary = 100
value = 0
[../]
[./top]
type = DirichletBC
variable = u
boundary = 101
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
exodus = true
[]
modules/combined/test/tests/heat_conduction_ortho/heat_conduction_ortho.i
#
# Three independent cubes are thermally loaded, one in x, one in y, and one in z.
# Each direction has a different thermal conductivity, resulting in a different
# temperature at the side with the Neumann bc.
#
# For x: 100/1000 = 1e-1
# For y: 100/100 = 1e+0
# for z: 100/10 = 1e+1
#
[Mesh]#Comment
file = heat_conduction_ortho.e
[] # Mesh
[Variables]
[./temp]
order = FIRST
family = LAGRANGE
[../]
[] # Variables
[Kernels]
[./heat]
type = AnisoHeatConduction
variable = temp
[../]
[] # Kernels
[BCs]
[./temps]
type = DirichletBC
variable = temp
boundary = 1
value = 0
[../]
[./neum]
type = NeumannBC
variable = temp
boundary = 2
value = 100
[../]
[] # BCs
[Materials]
[./heat]
type = AnisoHeatConductionMaterial
block = 1
specific_heat = 0.116
thermal_conductivity_x_pp = tcx
thermal_conductivity_y_pp = tcy
thermal_conductivity_z_pp = tcz
[../]
[./density]
type = Density
block = 1
density = 0.283
[../]
[] # Materials
[Executioner]
type = Steady
#Preconditioned JFNK (default)
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -ksp_gmres_restart'
petsc_options_value = 'lu 101'
line_search = 'none'
nl_abs_tol = 1e-11
nl_rel_tol = 1e-10
l_max_its = 20
[] # Executioner
[Outputs]
exodus = true
hide = 'tcx tcy tcz'
[] # Outputs
[Postprocessors]
[./tcx]
type = FunctionValuePostprocessor
function = 1000
outputs = none
execute_on = 'initial timestep_end'
[../]
[./tcy]
type = FunctionValuePostprocessor
function = 100
outputs = none
execute_on = 'initial timestep_end'
[../]
[./tcz]
type = FunctionValuePostprocessor
function = 10
outputs = none
execute_on = 'initial timestep_end'
[../]
[]
test/tests/restart/pointer_restart_errors/pointer_load_error.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[UserObjects]
[./restartable_types]
type = PointerLoadError
[../]
[]
[Problem]
type = FEProblem
solve = false
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
checkpoint = true
[]
test/tests/auxkernels/linear_combination/test.i
# All tested logic is in the aux system
# The non-linear problem is unrelated
[Mesh]
type = GeneratedMesh
dim = 1
xmin = -1
xmax = 1
nx = 10
[]
[Functions]
[./v1_func]
type = ParsedFunction
value = (1-x)/2
[../]
[./v2_func]
type = ParsedFunction
value = (1+x)/2
[../]
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxVariables]
[./lc]
[../]
[./v1]
[../]
[./v2]
[../]
[./w1]
[../]
[./w2]
[../]
[]
[ICs]
[./v1_ic]
type = FunctionIC
variable = v1
function = v1_func
[../]
[./v2_ic]
type = FunctionIC
variable = v2
function = v2_func
[../]
[./w1_ic]
type = ConstantIC
variable = w1
value = 0.3
[../]
[./w2_ic]
type = ConstantIC
variable = w2
value = 0.5
[../]
[]
[AuxKernels]
[./lc-aux]
type = ParsedAux
variable = lc
function = 'v1*w1+v2*w2'
args = 'v1 w1 v2 w2'
execute_on = 'timestep_end'
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 1
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 2
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
[./out]
type = Exodus
[../]
[]
tutorials/darcy_thermo_mech/step04_velocity_aux/tests/auxkernels/velocity_aux/velocity_aux.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
[]
[Variables]
[./pressure]
[../]
[]
[AuxVariables]
[./velocity_x]
order = CONSTANT
family = MONOMIAL
[../]
[]
[AuxKernels]
[./velocity_x]
type = DarcyVelocity
variable = velocity_x
component = x
execute_on = timestep_end
darcy_pressure = pressure
[../]
[]
[Functions]
[./pressure_ic_func]
type = ParsedFunction
value = 2000*x*y*x*y
[../]
[]
[ICs]
[./pressure_ic]
type = FunctionIC
variable = pressure
function = pressure_ic_func
[../]
[]
[Problem]
type = FEProblem
coord_type = RZ
rz_coord_axis = X
solve = false
[]
[Materials]
[./pressure]
type = GenericConstantMaterial
prop_values = '0.8451e-9 7.98e-4'
prop_names = 'permeability viscosity'
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/outputs/perf_graph/perf_graph.i
[Mesh]
type = GeneratedMesh
dim = 3
nx = 20
ny = 20
nz = 20
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Postprocessors]
[./num_dofs]
type = NumElems
[../]
[../]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
# perf_graph = true
[./pgraph]
type = PerfGraphOutput
level = 1
heaviest_branch = true
heaviest_sections = 10
[]
[]
test/tests/postprocessors/side_integral/side_integral_test.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
xmin = 0
xmax = 4
ymin = 0
ymax = 1
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 3
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 1
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Postprocessors]
[./integral]
type = SideIntegralVariablePostprocessor
boundary = 0
variable = u
[../]
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/postprocessors/vector_postprocessor_comparison/vector_postprocessor_comparison.i
# This tests the VectorPostprocessorComparison post-processor, which takes two
# vector post-processors and compares them.
[Mesh]
type = GeneratedMesh
dim = 1
nx = 3
xmin = 0
xmax = 2
[]
[Functions]
# Sampled values will be [2, 2, 2]
[./a_fn]
type = ConstantFunction
value = 2
[../]
# Sampled values will be [0, 1, 2]
[./b_fn]
type = ParsedFunction
value = 'x'
[../]
[]
[VectorPostprocessors]
[./a_vpp]
type = LineFunctionSampler
functions = 'a_fn'
num_points = 3
start_point = '0 0 0'
end_point = '2 0 0'
sort_by = x
execute_on = 'initial'
[../]
[./b_vpp]
type = LineFunctionSampler
functions = 'b_fn'
num_points = 3
start_point = '0 0 0'
end_point = '2 0 0'
sort_by = x
execute_on = 'initial'
[../]
[]
[Postprocessors]
[./vpp_comparison]
type = VectorPostprocessorComparison
vectorpostprocessor_a = a_vpp
vectorpostprocessor_b = b_vpp
vector_name_a = a_fn
vector_name_b = b_fn
comparison_type = greater_than_equals
execute_on = 'initial'
[../]
[]
[Problem]
solve = false
[]
[Executioner]
type = Steady
[]
[Outputs]
file_base = greater_than_equals
csv = true
show = 'vpp_comparison'
execute_on = 'initial'
[]
modules/phase_field/test/tests/mesh/mortarperiodic.i
[Mesh]
type = MortarPeriodicMesh
dim = 3
nx = 3
ny = 2
nz = 4
xmin = 0.3
xmax = 1.2
ymin = 0.1
ymax = 0.9
zmin = 0.2
zmax = 1.1
periodic_directions = 'x y z'
[]
[AuxVariables]
[./ax]
[./InitialCondition]
type = FunctionIC
function = x
[../]
[../]
[./ay]
[./InitialCondition]
type = FunctionIC
function = y
[../]
[../]
[]
[Executioner]
type = Steady
[]
[Problem]
solve = false
kernel_coverage_check = false
[]
[Outputs]
exodus = true
[]
modules/tensor_mechanics/test/tests/interface_stress/multi.i
[Mesh]
type = GeneratedMesh
dim = 3
nx = 10
ny = 10
nz = 10
xmax = 1
ymax = 1
zmax = 1
xmin = -1
ymin = -1
zmin = -1
[]
[GlobalParams]
order = CONSTANT
family = MONOMIAL
rank_two_tensor = extra_stress
[]
[Functions]
[./sphere1]
type = ParsedFunction
value = 'r:=sqrt(x^2+y^2+z^2); if(r>1,0,1-3*r^2+2*r^3)'
[../]
[./sphere2]
type = ParsedFunction
value = 'r:=sqrt(x^2+y^2+z^2); 0.5-0.5*if(r>1,0,1-3*r^2+2*r^3)'
[../]
[]
[Variables]
[./dummy]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = dummy
[../]
[]
[AuxVariables]
[./eta1]
[./InitialCondition]
type = FunctionIC
function = sphere1
[../]
order = FIRST
family = LAGRANGE
[../]
[./eta2]
[./InitialCondition]
type = FunctionIC
function = sphere2
[../]
order = FIRST
family = LAGRANGE
[../]
[./s00]
[../]
[./s01]
[../]
[./s02]
[../]
[./s10]
[../]
[./s11]
[../]
[./s12]
[../]
[./s20]
[../]
[./s21]
[../]
[./s22]
[../]
[]
[AuxKernels]
[./s00]
type = RankTwoAux
variable = s00
index_i = 0
index_j = 0
[../]
[./s01]
type = RankTwoAux
variable = s01
index_i = 0
index_j = 1
[../]
[./s02]
type = RankTwoAux
variable = s02
index_i = 0
index_j = 2
[../]
[./s10]
type = RankTwoAux
variable = s10
index_i = 1
index_j = 0
[../]
[./s11]
type = RankTwoAux
variable = s11
index_i = 1
index_j = 1
[../]
[./s12]
type = RankTwoAux
variable = s12
index_i = 1
index_j = 2
[../]
[./s20]
type = RankTwoAux
variable = s20
index_i = 2
index_j = 0
[../]
[./s21]
type = RankTwoAux
variable = s21
index_i = 2
index_j = 1
[../]
[./s22]
type = RankTwoAux
variable = s22
index_i = 2
index_j = 2
[../]
[]
[Materials]
[./interface]
type = ComputeInterfaceStress
v = 'eta1 eta2'
stress = '1.0 2.0'
op_range = '1.0 0.5'
[../]
[]
[Executioner]
type = Steady
[]
[Outputs]
exodus = true
file_base = test_out
execute_on = timestep_end
hide = 'dummy eta1 eta2'
[]
test/tests/preconditioners/multi_cycle_hypre/multi_cycle_hypre.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
uniform_refine = 2
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
# This option appears to modify the behavior in PETSc 3.6.0
petsc_options = '-pc_hypre_boomeramg_print_statistics'
petsc_options_iname = '-pc_type -pc_hypre_type -pc_hypre_boomeramg_tol -pc_hypre_boomeramg_max_iter'
petsc_options_value = 'hypre boomeramg 1e-4 20'
[]
[Outputs]
exodus = true
[]
test/tests/materials/material/adv_mat_couple_test2.i
[Mesh]
file = rectangle.e
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff body_force'
[./diff]
type = Diffusion
variable = u
[../]
[./body_force]
type = BodyForce
variable = u
block = 1
value = 10
[../]
[]
[BCs]
active = 'right'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 1
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Materials]
[./mat_3]
type = GenericConstantMaterial
prop_names = 'prop3'
prop_values = '300'
block = '1 2'
[../]
[./mat_2]
type = CoupledMaterial
mat_prop = 'prop2'
coupled_mat_prop = 'prop3'
block = '1 2'
[../]
[./mat_1]
type = CoupledMaterial2
mat_prop = 'prop1'
coupled_mat_prop1 = 'prop2'
coupled_mat_prop2 = 'prop3'
block = '1 2'
[../]
[]
[Executioner]
type = Steady
# solve_type = 'PJFNK'
# preconditioner = 'ILU'
solve_type = 'PJFNK'
# petsc_options_iname = '-pc_type -pc_hypre_type'
# petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
file_base = out_adv_coupled2
exodus = true
[]
test/tests/mesh/stitched_mesh/stitched_mesh.i
[Mesh]
type = StitchedMesh
files = 'left.e center.e right.e'
stitch_boundaries = 'right left right left'
parallel_type = 'replicated'
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/auxkernels/aux_nodal_scalar_kernel/aux_nodal_scalar_kernel.i
[Mesh]
type = GeneratedMesh
dim = 1
xmin = 0
xmax = 1
nx = 10
parallel_type = replicated
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 0
value = 1
[../]
[./right]
type = DirichletBC
variable = u
boundary = 1
value = 2
[../]
[]
[AuxVariables]
[./bc_sum]
family = SCALAR
order = FIRST
[../]
[]
[AuxScalarKernels]
[./sk]
type = SumNodalValuesAux
variable = bc_sum
nodes = '0 10'
sum_var = u
[../]
[]
[Postprocessors]
[./sum]
type = ScalarVariable
variable = bc_sum
[../]
[]
[Executioner]
type = Steady
[]
[Outputs]
exodus = true
hide = bc_sum
[]
test/tests/indicators/laplacian_jump_indicator/biharmonic.i
[GlobalParams]
# Parameters used by Functions.
vars = 'c'
vals = '50'
[]
[Mesh]
type = GeneratedMesh
dim = 2
xmin = -.5
xmax = .5
ymin = -.5
ymax = .5
nx = 10
ny = 10
[]
[Variables]
[./u]
order = THIRD
family = HERMITE
[../]
[]
[Kernels]
[./biharmonic]
type = Biharmonic
variable = u
[../]
[./body_force]
type = BodyForce
variable = u
function = forcing_func
[../]
[]
[BCs]
active = 'all_value all_flux'
[./all_value]
type = FunctionPenaltyDirichletBC
variable = u
boundary = 'left right top bottom'
function = u_func
penalty = 1e10
[../]
[./all_flux]
type = FunctionPenaltyFluxBC
variable = u
boundary = 'left right top bottom'
function = u_func
penalty = 1e10
[../]
[./all_laplacian]
type = BiharmonicLapBC
variable = u
boundary = 'left right top bottom'
laplacian_function = lapu_func
[../]
[]
[Adaptivity]
[./Indicators]
[./error]
type = LaplacianJumpIndicator
variable = u
scale_by_flux_faces = true
[../]
[../]
[]
[Executioner]
type = Steady
# Note: the unusually tight tolerances here are due to the penalty
# BCs (currently the only way of accurately Dirichlet boundary
# conditions on Hermite elements in MOOSE).
nl_rel_tol = 1.e-15
l_tol = 1.e-15
# We have exact Jacobians
solve_type = 'NEWTON'
# Use 6x6 quadrature to ensure the forcing function is integrated
# accurately.
[./Quadrature]
type = GAUSS
order = ELEVENTH
[../]
[]
[Functions]
[./u_func]
type = ParsedGradFunction
value = 'exp(-c*(x^2+y^2))'
grad_x = '-2*c*exp(-c*(x^2+y^2))*x'
grad_y = '-2*c*exp(-c*(x^2+y^2))*y'
[../]
[./lapu_func]
type = ParsedFunction
value = '4*c*(c*(x^2+y^2) - 1)*exp(-c*(x^2+y^2))'
[../]
[./forcing_func]
type = ParsedFunction
value = '16*c^2*(c^2*(x^2+y^2)^2 - 4*c*(x^2+y^2) + 2)*exp(-c*(x^2+y^2))'
[../]
[]
[Postprocessors]
[./l2_error]
type = ElementL2Error
variable = u
function = u_func
[../]
[./h1_error]
type = ElementH1Error
variable = u
function = u_func
[../]
[]
[Outputs]
exodus = true
[]
test/tests/utils/spline_interpolation/bicubic_spline_interpolation_x_normal.i
[Mesh]
type = GeneratedMesh
dim = 3
nx = 1 # needed to ensure Z is the problem dimension
ny = 4
nz = 4
ymax = 4
zmax = 4
[]
[Functions]
[./yx1]
type = ParsedFunction
value = '3*y^2'
[../]
[./yx2]
type = ParsedFunction
value = '6*z^2'
[../]
[./spline_fn]
type = BicubicSplineFunction
normal_component = 'x'
x1 = '0 2 4'
x2 = '0 2 4 6'
y = '0 16 128 432 8 24 136 440 64 80 192 496'
yx11 = '0 0 0 0'
yx1n = '48 48 48 48'
yx21 = '0 0 0'
yx2n = '216 216 216'
yx1 = 'yx1'
yx2 = 'yx2'
[../]
[./u_func]
type = ParsedFunction
value = 'y^3 + 2*z^3'
[../]
[./u2_forcing_func]
type = ParsedFunction
value = '-6*y - 12*z'
[../]
[]
[Variables]
[./u]
[../]
[]
[AuxVariables]
[./bi_func_value]
order = FIRST
family = LAGRANGE
[../]
[./y_deriv]
order = FIRST
family = LAGRANGE
[../]
[./z_deriv]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxKernels]
[./bi_func_value]
type = FunctionAux
variable = bi_func_value
function = spline_fn
[../]
[./deriv_1]
type = FunctionDerivativeAux
function = spline_fn
variable = y_deriv
component = 2
[../]
[./deriv_2]
type = FunctionDerivativeAux
function = spline_fn
variable = z_deriv
component = 3
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[./body_force]
type = BodyForce
variable = u
function = u2_forcing_func
[../]
[]
[BCs]
[./sides]
type = FunctionDirichletBC
variable = u
boundary = 'left right front back'
function = u_func
[../]
[]
[Postprocessors]
[./nodal_l2_err_spline]
type = NodalL2Error
variable = u
function = spline_fn
execute_on = 'initial timestep_end'
[../]
[./nodal_l2_err_analytic]
type = NodalL2Error
variable = u
function = u_func
execute_on = 'initial timestep_end'
[../]
[./y_deriv_err_analytic]
type = NodalL2Error
variable = y_deriv
function = yx1
execute_on = 'initial timestep_end'
[../]
[./z_deriv_err_analytic]
type = NodalL2Error
variable = z_deriv
function = yx2
execute_on = 'initial timestep_end'
[../]
[]
[Executioner]
type = Steady
solve_type = NEWTON
nl_rel_tol = 1e-12
[]
[Outputs]
exodus = true
[]
test/tests/misc/check_error/function_file_test8.i
# Test for usage of missing function
[Mesh]
file = square.e
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[./InitialCondition]
type = FunctionIC
function = ic_function
[../]
[../]
[]
[Functions]
[./ic_function]
type = PiecewiseLinear
xy_data = '1 2 3'
scale_factor = 1.0
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/mesh_modifiers/rename_block/rename2.i
[Mesh]
type = GeneratedMesh
dim = 3
nx = 2
ny = 2
nz = 2
xmin = -1
xmax = 1
ymin = -1
ymax = 1
zmin = -1
zmax = 1
[]
# Mesh Modifiers
[MeshModifiers]
[./sbb1]
type = SubdomainBoundingBox
block_id = 1
bottom_left = '-1 -1 -1'
top_right = '0 0 0'
[../]
[./sbb2]
type = SubdomainBoundingBox
block_id = 2
bottom_left = '0 -1 -1'
top_right = '1 0 0'
[../]
[./sbb3]
type = SubdomainBoundingBox
block_id = 3
bottom_left = '-1 0 -1'
top_right = '0 1 0'
[../]
[./sbb4]
type = SubdomainBoundingBox
block_id = 4
bottom_left = '0 0 -1'
top_right = '1 1 0'
[../]
[./sbb5]
type = SubdomainBoundingBox
block_id = 5
bottom_left = '-1 -1 0'
top_right = '0 0 1'
[../]
[./sbb6]
type = SubdomainBoundingBox
block_id = 6
bottom_left = '0 -1 0'
top_right = '1 0 1'
[../]
[./sbb7]
type = SubdomainBoundingBox
block_id = 7
bottom_left = '-1 0 0'
top_right = '0 1 1'
[../]
[./sbb8]
type = SubdomainBoundingBox
block_id = 8
bottom_left = '0 0 0'
top_right = '1 1 1'
[../]
[./re0]
type = RenameBlock
old_block_id = '12345 1 2 3 4'
new_block_name = 'nill one two three four'
depends_on = 'sbb1 sbb2 sbb3 sbb4 sbb5 sbb6 sbb7 sbb8'
[../]
[./re1]
type = RenameBlock
old_block_id = '12345 1 2'
new_block_name = 'nill one_and_two one_and_two'
depends_on = re0
[../]
[./does_nothing_there_is_no_block_2_now]
type = RenameBlock
old_block_id = 2
new_block_id = 9
depends_on = re1
[../]
[./re2]
type = RenameBlock
old_block_id = '1 2 3 4 5 8'
new_block_id = '1 12345 4 4 4 7' # note this makes block_id=4 have name "three", since the first occurance of new_block_id=4 has name "three"
depends_on = does_nothing_there_is_no_block_2_now
[../]
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./bottom]
type = DirichletBC
variable = u
boundary = bottom
value = 0
[../]
[./top]
type = DirichletBC
variable = u
boundary = top
value = 0
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/materials/material_dependency/diff_kernel_aux_mat_dep.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 1
ny = 1
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = MatDiffusionTest
variable = u
prop_name = 'diff'
[../]
[]
[AuxKernels]
[./error]
type = ElementLpNormAux
variable = error
coupled_variable = u
[../]
[]
[AuxVariables]
[./error]
family = MONOMIAL
order = FIRST
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Materials]
[./call_me_mat]
type = IncrementMaterial
prop_names = 'diff'
prop_values = '1'
block = 0
outputs = exodus
output_properties = 'mat_prop'
[../]
[]
[Executioner]
type = Steady
# This test counts the number of residual evaluations that
# may slightly change from a PETSc version to another.
# For instance, starts from PETSc-3.8.4, the number of
# residual evaluating is reduced by one in a linear solver
# for each Newton iteration. This change causes this test
# fail. It better to restrict the test
# count the residual evaluations in the nonlinear level only.
solve_type = 'NEWTON'
petsc_options_iname = '-pc_type'
petsc_options_value = 'lu'
[]
[Outputs]
exodus = true
[]
modules/phase_field/test/tests/initial_conditions/MultiBoundingBoxIC3D.i
[Mesh]
type = GeneratedMesh
dim = 3
nx = 10
ny = 10
nz = 10
[]
[Variables]
[./c1]
order = FIRST
family = LAGRANGE
[../]
[./c2]
order = FIRST
family = LAGRANGE
[../]
[]
[ICs]
[./c1]
type = MultiBoundingBoxIC
corners = '0.1 0.0 0.1 0.8 0.5 0.0 0.0 1.0 0.4'
opposite_corners = '0.5 0.5 0.6 0.2 0.9 0.4 0.4 0.6 1.0'
inside = '1.0'
outside = 0.1
variable = c1
[../]
[./c2]
type = MultiBoundingBoxIC
corners = '0.1 0.0 0.1 0.8 0.5 0.0 0.3 0.2 0.4'
opposite_corners = '0.8 0.5 0.6 0.2 0.9 0.4 0.7 0.9 1.0'
inside = '1.0 2.0 3.0'
outside = 0.1
variable = c2
[../]
[]
[Executioner]
type = Steady
[]
[Problem]
solve = false
kernel_coverage_check = false
[]
[Outputs]
exodus = true
[]
test/tests/markers/expected_error/displaced_error.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 4
ny = 4
uniform_refine = 1
[]
[GlobalParams]
displacements = 'disp_x disp_y'
[]
[AuxVariables]
[./disp_x]
[../]
[./disp_y]
[../]
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[]
[Executioner]
type = Steady
[]
[Adaptivity]
[./Markers]
[./test]
type = UniformMarker
# this triggers the expected error
use_displaced_mesh = true
mark = DONT_MARK
[../]
[../]
[]
test/tests/postprocessors/difference_pps/difference_pps.i
[Mesh]
type = GeneratedMesh
dim = 2
xmin = 0
xmax = 1
ymin = 0
ymax = 1
nx = 2
ny = 2
[]
[AuxVariables]
[./v]
[../]
[]
[Variables]
[./u]
[../]
[]
[ICs]
[./u_ic]
type = ConstantIC
variable = u
value = 2
[../]
[]
[AuxKernels]
[./one]
type = ConstantAux
variable = v
value = 1
execute_on = 'initial timestep_end'
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Postprocessors]
[./u_avg]
type = ElementAverageValue
variable = u
execute_on = 'initial timestep_end'
[../]
[./v_avg]
type = ElementAverageValue
variable = v
execute_on = 'initial timestep_end'
[../]
[./diff]
type = DifferencePostprocessor
value1 = v_avg
value2 = u_avg
execute_on = 'initial timestep_end'
[../]
[]
[Executioner]
type = Steady
[]
[Outputs]
exodus = true
[]
test/tests/variables/mixed_order_variables/mixed_order_variables_test.i
# FIRST order nodal variables on SECOND order grid
#
[Mesh]
type = GeneratedMesh
dim = 2
xmin = -1
xmax = 1
ymin = -1
ymax = 1
nx = 10
ny = 10
elem_type = QUAD9
[]
[Functions]
[./force_fn]
type = ParsedFunction
value = -4
[../]
[./exact_fn]
type = ParsedFunction
value = (x*x)+(y*y)
[../]
[./aux_fn]
type = ParsedFunction
value = (1-x*x)*(1-y*y)
[../]
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[./ffn]
type = BodyForce
variable = u
function = force_fn
[../]
[]
[BCs]
[./all]
type = FunctionDirichletBC
variable = u
boundary = '0 1 2 3'
function = exact_fn
[../]
[]
[AuxVariables]
[./aux1]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxKernels]
[./ak1]
type = FunctionAux
variable = aux1
function = aux_fn
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/transfers/from_full_solve/master.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
# This test currently diffs when run in parallel with DistributedMesh enabled,
# most likely due to the fact that CONSTANT MONOMIALS are currently not written
# out correctly in this case. For more information, see #2122.
parallel_type = replicated
[]
[Variables]
[./u]
[../]
[]
[AuxVariables]
[./from_full]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
[MultiApps]
[./full_solve]
type = FullSolveMultiApp
app_type = MooseTestApp
execute_on = initial
positions = '0 0 0'
input_files = sub.i
[../]
[]
[Transfers]
[./from_full]
type = MultiAppNearestNodeTransfer
direction = from_multiapp
multi_app = full_solve
source_variable = u
variable = from_full
[../]
[]
test/tests/outputs/misc/default_names.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[./oversample]
type = Exodus
refinements = 1
[../]
[]
test/tests/bcs/second_deriv/test_lap_bc.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 1
ny = 1
xmin = -1
xmax = 1
ymin = -1
ymax = 1
elem_type = QUAD9
[]
[Variables]
[./u]
order = SECOND
family = LAGRANGE
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[./ffn]
type = BodyForce
variable = u
function = force_fn
[../]
[]
[Functions]
[./left_bc_func]
type = ParsedFunction
value = '1+y*y'
[../]
[./top_bc_func]
type = ParsedFunction
value = '1+x*x'
[../]
[./bottom_bc_func]
type = ParsedFunction
value = '1+x*x'
[../]
[./force_fn]
type = ParsedFunction
value = -4
[../]
[]
[BCs]
[./left]
type = FunctionDirichletBC
variable = u
boundary = left
function = left_bc_func
[../]
[./bottom]
type = FunctionDirichletBC
variable = u
boundary = bottom
function = bottom_bc_func
[../]
[./top]
type = FunctionDirichletBC
variable = u
boundary = top
function = top_bc_func
[../]
[./right_test]
type = TestLapBC
variable = u
boundary = right
[../]
[]
[Executioner]
type = Steady
solve_type = 'NEWTON'
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/actions/debug_block/debug_print_actions_test.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
nz = 0
zmin = 0
zmax = 0
elem_type = QUAD4
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 0
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
[]
[Debug]
show_actions = true
show_top_residuals = 5
[]
modules/stochastic_tools/test/tests/distributions/logistic.i
[Mesh]
type = GeneratedMesh
dim = 1
nx = 1
ny = 1
[]
[Variables]
[./u]
[../]
[]
[Distributions]
[./logistic_test]
type = LogisticDistribution
location = 1
shape = 1
[../]
[]
[Postprocessors]
[./cdf]
type = TestDistributionPostprocessor
distribution = logistic_test
value = 1.5
method = cdf
execute_on = initial
[../]
[./pdf]
type = TestDistributionPostprocessor
distribution = logistic_test
value = 1.5
method = pdf
execute_on = initial
[../]
[./quantile]
type = TestDistributionPostprocessor
distribution = logistic_test
value = 0.5
method = quantile
execute_on = initial
[../]
[]
[Executioner]
type = Steady
[]
[Problem]
solve = false
kernel_coverage_check = false
[]
[Outputs]
execute_on = 'INITIAL'
csv = true
[]
test/tests/misc/check_error/coupling_nonexistent_field.i
[Mesh]
type = GeneratedMesh
dim = 2
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./coupled]
type = CoupledForce
variable = u
# 'a' does not exist -> error
v = a
[../]
[]
[Executioner]
type = Steady
[]
modules/misc/test/tests/kernels/diffusion/ad_2d_steady_state_final_prob.i
# This test solves a 2D steady state heat equation
# The error is found by comparing to the analytical solution
# Note that the thermal conductivity, specific heat, and density in this problem
# Are set to 1, and need to be changed to the constants of the material being
# Analyzed
[Mesh]
type = GeneratedMesh
dim = 2
nx = 30
ny = 30
xmax = 2
ymax = 2
[]
[Variables]
[./T]
[../]
[]
[ADKernels]
[./HeatDiff]
type = ADMatDiffusion
variable = T
diffusivity = diffusivity
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = T
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = T
boundary = right
value = 0
[../]
[./bottom]
type = DirichletBC
variable = T
boundary = bottom
value = 0
[../]
[./top]
type = FunctionDirichletBC
variable = T
boundary = top
function = '10*sin(pi*x*0.5)'
[../]
[]
[Materials]
[./k]
type = GenericConstantMaterial
prop_names = diffusivity
prop_values = 1
[../]
[]
[Postprocessors]
[./nodal_error]
type = NodalL2Error
function = '10/(sinh(pi))*sin(pi*x*0.5)*sinh(pi*y*0.5)'
variable = T
outputs = console
[../]
[./elemental_error]
type = ElementL2Error
function = '10/(sinh(pi))*sin(pi*x*0.5)*sinh(pi*y*0.5)'
variable = T
outputs = console
[../]
[]
[Preconditioning]
[./full]
type = SMP
full = true
[../]
[]
[Executioner]
type = Steady
[]
[Outputs]
exodus = true
[]
modules/porous_flow/test/tests/relperm/corey3.i
# Test Corey relative permeability curve by varying saturation over the mesh
# Residual saturation of phase 0: s0r = 0.2
# Residual saturation of phase 1: s1r = 0.3
[Mesh]
type = GeneratedMesh
dim = 1
nx = 20
[]
[GlobalParams]
PorousFlowDictator = dictator
[]
[Variables]
[./p0]
initial_condition = 1e6
[../]
[./s1]
family = LAGRANGE
order = FIRST
[../]
[]
[AuxVariables]
[./s0aux]
family = MONOMIAL
order = CONSTANT
[../]
[./s1aux]
family = MONOMIAL
order = CONSTANT
[../]
[./kr0aux]
family = MONOMIAL
order = CONSTANT
[../]
[./kr1aux]
family = MONOMIAL
order = CONSTANT
[../]
[]
[AuxKernels]
[./s0]
type = PorousFlowPropertyAux
property = saturation
phase = 0
variable = s0aux
[../]
[./s1]
type = PorousFlowPropertyAux
property = saturation
phase = 1
variable = s1aux
[../]
[./kr0]
type = PorousFlowPropertyAux
property = relperm
phase = 0
variable = kr0aux
[../]
[./kr1]
type = PorousFlowPropertyAux
property = relperm
phase = 1
variable = kr1aux
[../]
[]
[Functions]
[./s1]
type = ParsedFunction
value = x
[../]
[]
[ICs]
[./s1]
type = FunctionIC
variable = s1
function = s1
[../]
[]
[Kernels]
[./p0]
type = Diffusion
variable = p0
[../]
[./s1]
type = Diffusion
variable = s1
[../]
[]
[UserObjects]
[./dictator]
type = PorousFlowDictator
porous_flow_vars = 'p0 s1'
number_fluid_phases = 2
number_fluid_components = 2
[../]
[./pc]
type = PorousFlowCapillaryPressureConst
pc = 0
[../]
[]
[Materials]
[./temperature]
type = PorousFlowTemperature
[../]
[./ppss]
type = PorousFlow2PhasePS
phase0_porepressure = p0
phase1_saturation = s1
capillary_pressure = pc
[../]
[./kr0]
type = PorousFlowRelativePermeabilityCorey
phase = 0
n = 2
s_res = 0.2
sum_s_res = 0.5
[../]
[./kr1]
type = PorousFlowRelativePermeabilityCorey
phase = 1
n = 2
s_res = 0.3
sum_s_res = 0.5
[../]
[]
[VectorPostprocessors]
[./vpp]
type = LineValueSampler
variable = 's0aux s1aux kr0aux kr1aux'
start_point = '0 0 0'
end_point = '1 0 0'
num_points = 20
sort_by = id
[../]
[]
[Executioner]
type = Steady
solve_type = NEWTON
nl_abs_tol = 1e-8
[]
[BCs]
[./sleft]
type = DirichletBC
variable = s1
value = 0
boundary = left
[../]
[./sright]
type = DirichletBC
variable = s1
value = 1
boundary = right
[../]
[]
[Outputs]
csv = true
execute_on = timestep_end
[]
modules/chemical_reactions/test/tests/jacobian/coupled_convreact2.i
# Test the Jacobian terms for the CoupledConvectionReactionSub Kernel using
# activity coefficients not equal to unity
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
[]
[Variables]
[./a]
order = FIRST
family = LAGRANGE
[../]
[./b]
order = FIRST
family = LAGRANGE
[../]
[./pressure]
order = FIRST
family = LAGRANGE
[../]
[]
[ICs]
[./pressure]
type = RandomIC
variable = pressure
min = 1
max = 5
[../]
[./a]
type = RandomIC
variable = a
max = 1
min = 0
[../]
[./b]
type = RandomIC
variable = b
max = 1
min = 0
[../]
[]
[Kernels]
[./diff]
type = DarcyFluxPressure
variable = pressure
[../]
[./diff_b]
type = Diffusion
variable = b
[../]
[./a1conv]
type = CoupledConvectionReactionSub
variable = a
v = b
log_k = 2
weight = 1
sto_v = 2.5
sto_u = 2
p = pressure
gamma_eq = 2
gamma_u = 2.5
gamma_v = 1.5
[../]
[]
[Materials]
[./porous]
type = GenericConstantMaterial
prop_names = 'diffusivity conductivity porosity'
prop_values = '1e-4 1e-4 0.2'
[../]
[]
[Executioner]
type = Steady
solve_type = NEWTON
[]
[Outputs]
perf_graph = true
[]
[Preconditioning]
[./smp]
type = SMP
full = true
[../]
[]
modules/porous_flow/test/tests/thermal_conductivity/ThermalCondPorosity01.i
# Trivial test of PorousFlowThermalConductivityFromPorosity
# Porosity = 0.1
# Solid thermal conductivity = 3
# Fluid thermal conductivity = 2
# Expected porous medium thermal conductivity = 3 * (1 - 0.1) + 2 * 0.1 = 2.9
[Mesh]
type = GeneratedMesh
dim = 3
xmin = 0
xmax = 1
ymin = 0
ymax = 1
zmin = -1
zmax = 0
nx = 1
ny = 1
nz = 1
# This test uses ElementalVariableValue postprocessors on specific
# elements, so element numbering needs to stay unchanged
allow_renumbering = false
[]
[GlobalParams]
PorousFlowDictator = dictator
[]
[Modules]
[./FluidProperties]
[./simple_fluid]
type = SimpleFluidProperties
[../]
[../]
[]
[Variables]
[./temp]
initial_condition = 1
[../]
[./pp]
initial_condition = 0
[../]
[]
[Kernels]
[./heat_conduction]
type = PorousFlowHeatConduction
variable = temp
[../]
[./dummy]
type = Diffusion
variable = pp
[../]
[]
[BCs]
[./temp]
type = PresetBC
variable = temp
boundary = 'front back'
value = 1
[../]
[./pp]
type = PresetBC
variable = pp
boundary = 'front back'
value = 0
[../]
[]
[AuxVariables]
[./lambda_x]
order = CONSTANT
family = MONOMIAL
[../]
[./lambda_y]
order = CONSTANT
family = MONOMIAL
[../]
[./lambda_z]
order = CONSTANT
family = MONOMIAL
[../]
[]
[AuxKernels]
[./lambda_x]
type = MaterialRealTensorValueAux
property = PorousFlow_thermal_conductivity_qp
row = 0
column = 0
variable = lambda_x
[../]
[./lambda_y]
type = MaterialRealTensorValueAux
property = PorousFlow_thermal_conductivity_qp
row = 1
column = 1
variable = lambda_y
[../]
[./lambda_z]
type = MaterialRealTensorValueAux
property = PorousFlow_thermal_conductivity_qp
row = 2
column = 2
variable = lambda_z
[../]
[]
[Postprocessors]
[./lambda_x]
type = ElementalVariableValue
elementid = 0
variable = lambda_x
execute_on = 'timestep_end'
[../]
[./lambda_y]
type = ElementalVariableValue
elementid = 0
variable = lambda_y
execute_on = 'timestep_end'
[../]
[./lambda_z]
type = ElementalVariableValue
elementid = 0
variable = lambda_z
execute_on = 'timestep_end'
[../]
[]
[UserObjects]
[./dictator]
type = PorousFlowDictator
porous_flow_vars = 'pp temp'
number_fluid_phases = 1
number_fluid_components = 1
[../]
[]
[Materials]
[./temperature]
type = PorousFlowTemperature
temperature = temp
[../]
[./ppss_qp]
type = PorousFlow1PhaseFullySaturated
porepressure = pp
[../]
[./simple_fluid]
type = PorousFlowSingleComponentFluid
fp = simple_fluid
phase = 0
[../]
[./porosity_qp]
type = PorousFlowPorosityConst
porosity = 0.1
[../]
[./lambda]
type = PorousFlowThermalConductivityFromPorosity
lambda_s = '3 0 0 0 3 0 0 0 3'
lambda_f = '2 0 0 0 2 0 0 0 2'
[../]
[]
[Preconditioning]
[./andy]
type = SMP
full = true
[../]
[]
[Executioner]
solve_type = Newton
type = Steady
[]
[Outputs]
file_base = ThermalCondPorosity01
csv = true
execute_on = 'timestep_end'
[]
test/tests/auxkernels/element_length/element_length.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 100
[]
[AuxVariables]
[./min]
[../]
[./max]
order = CONSTANT
family = MONOMIAL
[../]
[]
[AuxKernels]
[./min]
type = ElementLengthAux
variable = min
method = min
execute_on = initial
[../]
[./max]
type = ElementLengthAux
variable = max
method = max
execute_on = initial
[../]
[../]
[Problem]
type = FEProblem
solve = false
[]
[Executioner]
type = Steady
[]
[Outputs]
execute_on = 'TIMESTEP_END'
exodus = true
[]
test/tests/parser/parser_dependency/parse_depend_mixed_test.i
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[Outputs]
file_base = 2d_diffusion_out
exodus = true
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Mesh]
file = square.e
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
examples/ex05_amr/ex05.i
[Mesh]
file = cube-hole.e
[]
# This is where mesh adaptivity magic happens:
[Adaptivity]
marker = errorfrac # this specifies which marker from 'Markers' subsection to use
steps = 2 # run adaptivity 2 times, recomputing solution, indicators, and markers each time
# Use an indicator to compute an error-estimate for each element:
[./Indicators]
# create an indicator computing an error metric for the convected variable
[./error] # arbitrary, use-chosen name
type = GradientJumpIndicator
variable = convected
outputs = none
[../]
[../]
# Create a marker that determines which elements to refine/coarsen based on error estimates
# from an indicator:
[./Markers]
[./errorfrac] # arbitrary, use-chosen name (must match 'marker=...' name above
type = ErrorFractionMarker
indicator = error # use the 'error' indicator specified above
refine = 0.5 # split/refine elements in the upper half of the indicator error range
coarsen = 0 # don't do any coarsening
outputs = none
[../]
[../]
[]
[Variables]
[./convected]
order = FIRST
family = LAGRANGE
[../]
[./diffused]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./example_diff]
type = ExampleCoefDiffusion
variable = convected
coef = 0.125
[../]
[./conv]
type = ExampleConvection
variable = convected
some_variable = diffused
[../]
[./diff]
type = Diffusion
variable = diffused
[../]
[]
[BCs]
# convected=0 on all vertical sides except the right (x-max)
[./cylinder_convected]
type = DirichletBC
variable = convected
boundary = inside
value = 1
[../]
[./exterior_convected]
type = DirichletBC
variable = convected
boundary = 'left top bottom'
value = 0
[../]
[./left_diffused]
type = DirichletBC
variable = diffused
boundary = left
value = 0
[../]
[./right_diffused]
type = DirichletBC
variable = diffused
boundary = right
value = 10
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
l_tol = 1e-3
nl_rel_tol = 1e-12
[]
[Outputs]
execute_on = 'timestep_end'
exodus = true
[]
modules/richards/test/tests/jacobian_1/jn_fu_08.i
# unsaturated = true
# gravity = true
# supg = true
# transient = false
[Mesh]
type = GeneratedMesh
dim = 3
nx = 1
ny = 1
nz = 1
xmin = -1
xmax = 1
ymin = -1
ymax = 1
zmin = -1
zmax = 1
[]
[GlobalParams]
richardsVarNames_UO = PPNames
density_UO = DensityConstBulk
relperm_UO = RelPermPower
SUPG_UO = SUPGstandard
sat_UO = Saturation
seff_UO = SeffVG
[]
[UserObjects]
[./PPNames]
type = RichardsVarNames
richards_vars = pressure
[../]
[./DensityConstBulk]
type = RichardsDensityConstBulk
dens0 = 1
bulk_mod = 1.0 # notice small quantity, so the PETSc constant state works
[../]
[./SeffVG]
type = RichardsSeff1VG
m = 0.8
al = 1 # notice small quantity, so the PETSc constant state works
[../]
[./RelPermPower]
type = RichardsRelPermPower
simm = 0.2
n = 2
[../]
[./Saturation]
type = RichardsSat
s_res = 0.1
sum_s_res = 0.1
[../]
[./SUPGstandard]
type = RichardsSUPGstandard
p_SUPG = 0.1
[../]
[]
[Variables]
[./pressure]
order = FIRST
family = LAGRANGE
[./InitialCondition]
type = RandomIC
block = 0
min = -1
max = 0
[../]
[../]
[]
[Kernels]
active = 'richardsf'
[./richardst]
type = RichardsMassChange
variable = pressure
[../]
[./richardsf]
type = RichardsFullyUpwindFlux
variable = pressure
[../]
[]
[Materials]
[./rock]
type = RichardsMaterial
block = 0
mat_porosity = 0.1
mat_permeability = '1E-5 0 0 0 1E-5 0 0 0 1E-5'
viscosity = 1E-3
gravity = '1 2 3'
linear_shape_fcns = true
[../]
[]
[Preconditioning]
[./andy]
type = SMP
full = true
petsc_options_iname = '-ksp_type -pc_type -snes_atol -snes_rtol -snes_max_it -snes_type'
petsc_options_value = 'bcgs bjacobi 1E-15 1E-10 10000 test'
[../]
[]
[Executioner]
type = Steady
solve_type = Newton
[]
[Outputs]
execute_on = 'timestep_end'
file_base = jn08
exodus = false
[]
test/tests/outputs/console/console_warning.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[./v]
[../]
[]
[AuxVariables]
[./aux0]
order = SECOND
family = SCALAR
[../]
[./aux1]
family = SCALAR
initial_condition = 5
[../]
[./aux2]
family = SCALAR
initial_condition = 10
[../]
[]
[Kernels]
[./diff_u]
type = Diffusion
variable = u
[../]
[./diff_v]
type = CoefDiffusion
variable = v
coef = 2
[../]
[]
[BCs]
[./right_u]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[./left_u]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right_v]
type = DirichletBC
variable = v
boundary = right
value = 3
[../]
[./left_v]
type = DirichletBC
variable = v
boundary = left
value = 2
[../]
[]
[Postprocessors]
[./num_vars]
type = NumVars
system = 'NL'
[../]
[./num_aux]
type = NumVars
system = 'AUX'
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
execute_on = 'timestep_end'
[./screen]
type = Console
[../]
[./screen2]
type = Console
[../]
[./screen3]
type = Console
[../]
[]
[ICs]
[./aux0_IC]
variable = aux0
values = '12 13'
type = ScalarComponentIC
[../]
[]
modules/heat_conduction/test/tests/heat_conduction/3d_quadrature_gap_heat_transfer/second.i
[Mesh]
file = nonmatching.e
second_order = true
[]
[Variables]
[./temp]
order = SECOND
[../]
[]
[Kernels]
[./hc]
type = HeatConduction
variable = temp
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = temp
boundary = leftleft
value = 1000
[../]
[./right]
type = DirichletBC
variable = temp
boundary = rightright
value = 400
[../]
[]
[ThermalContact]
[./left_to_right]
slave = leftright
quadrature = true
master = rightleft
variable = temp
type = GapHeatTransfer
order = SECOND
[../]
[]
[Materials]
[./hcm]
type = HeatConductionMaterial
block = 'left right'
specific_heat = 1
thermal_conductivity = 1
[../]
[]
[Postprocessors]
[./left]
type = SideFluxIntegral
variable = temp
boundary = leftright
diffusivity = thermal_conductivity
[../]
[./right]
type = SideFluxIntegral
variable = temp
boundary = rightleft
diffusivity = thermal_conductivity
[../]
[]
[Executioner]
type = Steady
#Preconditioned JFNK (default)
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
modules/stochastic_tools/test/tests/samplers/monte_carlo/monte_carlo_uniform.i
[Mesh]
type = GeneratedMesh
dim = 1
nx = 1
ny = 1
[]
[Variables]
[./u]
[../]
[]
[Distributions]
[./uniform]
type = UniformDistribution
lower_bound = 1
upper_bound = 7
[../]
[]
[Samplers]
[./sample]
type = MonteCarloSampler
n_samples = 10
distributions = 'uniform'
execute_on = 'initial timestep_end'
[../]
[]
[VectorPostprocessors]
[./data]
type = SamplerData
sampler = sample
execute_on = 'initial timestep_end'
[../]
[]
[Executioner]
type = Steady
[]
[Problem]
solve = false
kernel_coverage_check = false
[]
[Outputs]
execute_on = 'INITIAL TIMESTEP_END'
csv = true
[]
test/tests/meshgenerators/adapt/initial_adaptivity_mg_test.i
[MeshGenerators]
[./gmg]
type = GeneratedMeshGenerator
dim = 2
xmin = -1
xmax = 1
ymin = -1
ymax = 1
nx = 2
ny = 2
elem_type = QUAD9
[]
[]
[Mesh]
type = MeshGeneratorMesh
[]
[Functions]
[./exact_fn]
type = ParsedFunction
value = x*x+y*y
[../]
[./ffn]
type = ParsedFunction
value = -4
[../]
[]
[Variables]
[./u]
order = SECOND
family = LAGRANGE
[./InitialCondition]
type = BoundingBoxIC
x1 = -2
y1 = -2
x2 = 0
y2 = 2
inside = 1
outside = 0
[../]
[../]
[]
[Kernels]
[./udiff]
type = Diffusion
variable = u
[../]
[./forcing_fn]
type = BodyForce
variable = u
function = ffn
[../]
[]
[BCs]
[./all]
type = FunctionDirichletBC
variable = u
boundary = '0 1 2 3'
function = exact_fn
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[./Adaptivity]
initial_adaptivity = 5
refine_fraction = 0.2
coarsen_fraction = 0.3
max_h_level = 4
[../]
[]
[Outputs]
exodus = true
[]
modules/porous_flow/test/tests/flux_limited_TVD_pflow/except03.i
# Exception test: fe_family specified but not fe_order
[Mesh]
type = GeneratedMesh
dim = 1
[]
[GlobalParams]
gravity = '1 2 3'
PorousFlowDictator = dictator
[]
[Variables]
[./pp]
[../]
[./tracer]
[../]
[]
[Modules]
[./FluidProperties]
[./the_simple_fluid]
type = SimpleFluidProperties
[../]
[../]
[]
[PorousFlowUnsaturated]
porepressure = pp
mass_fraction_vars = tracer
fp = the_simple_fluid
[]
[UserObjects]
[./advective_flux_calculator]
type = PorousFlowAdvectiveFluxCalculatorSaturated
fe_family = Lagrange
[../]
[]
[Materials]
[./permeability]
type = PorousFlowPermeabilityConst
permeability = '1 0 0 0 2 0 0 0 3'
[../]
[]
[Executioner]
type = Steady
solve_type = Newton
[]
test/tests/markers/uniform_marker/uniform_marker.i
###########################################################
# This is a test of the Mesh Marker System. It marks
# elements with flags indicating whether they should be
# refined, coarsened, or left alone. This system
# has the ability to use the Mesh Indicator System.
#
# @Requirement F2.50
###########################################################
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
# Mesh Marker System
[Adaptivity]
[./Markers]
[./uniform]
type = UniformMarker
mark = refine
[../]
[../]
[]
[Outputs]
exodus = true
[]
test/tests/vectorpostprocessors/elements_along_plane/3d.i
[Mesh]
type = GeneratedMesh
dim = 3
nx = 10
ny = 10
nz = 10
# Our CSV diffs here depend on a fixed element id numbering
allow_renumbering = false
parallel_type = replicated
[]
[Problem]
solve = false
[]
[VectorPostprocessors]
[./elems]
type = ElementsAlongPlane
point = '0.525 0.525 0.0'
normal = '1.0 1.0 0.0'
[../]
[]
[Executioner]
type = Steady
[]
[Outputs]
csv = true
[]
test/tests/meshgenerators/image_subdomain_generator/image_subdomain_3d.i
[MeshGenerators]
[./gmg]
type = GeneratedMeshGenerator
dim = 3
nx = 20
ny = 20
nz = 20
[]
[./image]
type = ImageSubdomainGenerator
input = gmg
file_base = stack/test
file_suffix = png
threshold = 2.7e4
[]
[]
[Mesh]
type = MeshGeneratorMesh
[]
[Variables]
[./u]
[../]
[]
[Problem]
type = FEProblem
solve = false
[../]
[Executioner]
type = Steady
[]
[Outputs]
exodus = true
execute_on = 'timestep_end'
[]
test/tests/vectorpostprocessors/elements_along_plane/1d.i
[Mesh]
type = GeneratedMesh
dim = 1
nx = 10
# Our CSV diffs here depend on a fixed element id numbering
allow_renumbering = false
parallel_type = replicated
[]
[Problem]
solve = false
[]
[VectorPostprocessors]
[./elems]
type = ElementsAlongPlane
point = '0.55 0.0 0.0'
normal = '1.0 0.0 0.0'
[../]
[]
[Executioner]
type = Steady
[]
[Outputs]
csv = true
[]
test/tests/geomsearch/2d_interior_boundary_penetration_locator/2d_interior_boundary_penetration_locator.i
[Mesh]
type = FileMesh
file = meshed_gap.e
dim = 2
[]
[Variables]
[./u]
[../]
[]
[AuxVariables]
[./gap_distance]
[../]
[./gap_value]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 4
value = 1
[../]
[]
[AuxKernels]
[./penetration]
type = PenetrationAux
variable = gap_distance
boundary = 2
paired_boundary = 3
[../]
[./gap_value]
type = GapValueAux
variable = gap_value
boundary = 2
paired_variable = u
paired_boundary = 3
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/materials/discrete/recompute_warning.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 1
[]
[MeshModifiers]
[./left_domain]
type = SubdomainBoundingBox
bottom_left = '0 0 0'
top_right = '0.5 1 0'
block_id = 10
[../]
[]
[Variables]
[./u]
initial_condition = 2
[../]
[]
[Kernels]
[./diff]
type = MatDiffusionTest
variable = u
prop_name = 'p'
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 2
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 3
[../]
[]
[Materials]
[./recompute_props]
type = GenericConstantMaterial
prop_names = 'f f_prime'
prop_values = '22 24'
block = 0
compute = true # the default, but should trigger a warning because newton is calling getMaterial on this
[../]
[./newton]
type = NewtonMaterial
block = 0
outputs = all
f_name = 'f'
f_prime_name = 'f_prime'
p_name = 'p'
material = recompute_props
max_iterations = 0
[../]
[./left]
type = GenericConstantMaterial
prop_names = 'f f_prime p'
prop_values = '1 0.5 1.2345'
block = 10
outputs = all
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
print_linear_residuals = true
perf_graph = true
[]
test/tests/vectorpostprocessors/late_declaration_vector_postprocessor/late_declaration_vector_postprocessor.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[VectorPostprocessors]
[./constant]
type = LateDeclarationVectorPostprocessor
value = '1.5 2.7'
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
execute_on = 'initial timestep_end'
csv = true
[]
test/tests/materials/discrete/recompute2.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 1
[]
[MeshModifiers]
[./left_domain]
type = SubdomainBoundingBox
bottom_left = '0 0 0'
top_right = '0.5 1 0'
block_id = 10
[../]
[]
[Variables]
[./u]
initial_condition = 2
[../]
[]
[Kernels]
[./diff]
type = MatDiffusionTest
variable = u
prop_name = 'p'
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 2
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 3
[../]
[]
[Materials]
[./recompute_props]
type = RecomputeMaterial
block = 0
f_name = 'f'
f_prime_name = 'f_prime'
p_name = 'p'
outputs = all
output_properties = 'f f_prime p'
constant = 3
compute = false # make this material "discrete"
[../]
[./newton]
type = NewtonMaterial
block = 0
outputs = all
f_name = 'f'
f_prime_name = 'f_prime'
p_name = 'p'
material = 'recompute_props'
[../]
[./left]
type = GenericConstantMaterial
prop_names = 'f f_prime p'
prop_values = '1 0.5 1.2345'
block = 10
outputs = all
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
print_linear_residuals = true
perf_graph = true
[]
modules/porous_flow/test/tests/flux_limited_TVD_pflow/except01.i
# Exception test: phase number too big
[Mesh]
type = GeneratedMesh
dim = 1
[]
[GlobalParams]
gravity = '1 2 3'
PorousFlowDictator = dictator
[]
[Variables]
[./pp]
[../]
[./tracer]
[../]
[]
[Modules]
[./FluidProperties]
[./the_simple_fluid]
type = SimpleFluidProperties
[../]
[../]
[]
[PorousFlowUnsaturated]
porepressure = pp
mass_fraction_vars = tracer
fp = the_simple_fluid
[]
[UserObjects]
[./advective_flux_calculator]
type = PorousFlowAdvectiveFluxCalculatorSaturated
phase = 2
[../]
[]
[Materials]
[./permeability]
type = PorousFlowPermeabilityConst
permeability = '1 0 0 0 2 0 0 0 3'
[../]
[]
[Executioner]
type = Steady
solve_type = Newton
[]
test/tests/problems/custom_fe_problem/custom_fe_problem_test.i
[Mesh]
type = GeneratedMesh
dim = 2
xmin = 0
xmax = 1
ymin = 0
ymax = 1
nx = 4
ny = 4
elem_type = QUAD4
[]
[Problem]
type = MooseTestProblem
name = 'MOOSE Test problem'
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
exodus = true
[]
test/tests/bcs/penalty_dirichlet_bc/penalty_dirichlet_bc_test.i
[Mesh]
type = GeneratedMesh
dim = 2
xmin = -1
xmax = 1
ymin = -1
ymax = 1
nx = 10
ny = 10
elem_type = QUAD9
[]
[Functions]
[./forcing_fn]
type = ParsedFunction
value = -2*(x*x+y*y-2)+(1-x*x)*(1-y*y)
[../]
[./solution]
type = ParsedGradFunction
value = (1-x*x)*(1-y*y)
grad_x = 2*(x*y*y-x)
grad_y = 2*(x*x*y-y)
[../]
[]
[Variables]
[./u]
order = SECOND
family = HIERARCHIC
[../]
[]
[Kernels]
active = 'diff forcing reaction'
[./diff]
type = Diffusion
variable = u
[../]
[./reaction]
type = Reaction
variable = u
[../]
[./forcing]
type = BodyForce
variable = u
function = forcing_fn
[../]
[]
[BCs]
active = 'bc_all'
[./bc_all]
type = PenaltyDirichletBC
variable = u
value = 0
boundary = 'top left right bottom'
penalty = 1e5
[../]
[]
[Postprocessors]
[./dofs]
type = NumDOFs
[../]
[./h]
type = AverageElementSize
[../]
[./L2error]
type = ElementL2Error
variable = u
function = solution
[../]
[./H1error]
type = ElementH1Error
variable = u
function = solution
[../]
[./H1Semierror]
type = ElementH1SemiError
variable = u
function = solution
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
nl_rel_tol = 1e-14
[]
[Outputs]
execute_on = 'timestep_end'
exodus = true
csv = true
[]
test/tests/misc/save_in/save_in_soln_var_err_test.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxVariables]
[./saved]
[../]
[./bc_saved]
[../]
[./accumulated]
[../]
[./diag_saved]
[../]
[./bc_diag_saved]
[../]
[./saved_dirichlet]
[../]
[./diag_saved_dirichlet]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
save_in = 'u saved accumulated saved_dirichlet'
diag_save_in = 'diag_saved diag_saved_dirichlet'
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
save_in = saved_dirichlet
diag_save_in = diag_saved_dirichlet
[../]
[./nbc]
type = NeumannBC
variable = u
boundary = right
value = 1
save_in = 'bc_saved accumulated'
diag_save_in = bc_diag_saved
[../]
[]
[Postprocessors]
[./left_flux]
type = NodalSum
variable = saved
boundary = 1
[../]
[./saved_norm]
type = NodalL2Norm
variable = saved
execute_on = timestep_end
block = 0
[../]
[./saved_dirichlet_norm]
type = NodalL2Norm
variable = saved_dirichlet
execute_on = timestep_end
block = 0
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/mesh_modifiers/add_side_sets_from_bounding_box/multiple_boundary_ids.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
# This MeshModifier currently only works with ReplicatedMesh.
# For more information, refer to #2129.
parallel_type = replicated
[]
[MeshModifiers]
[./createNewSidesetOne]
type = AddSideSetsFromBoundingBox
boundary_id_old = 'left bottom'
boundary_id_new = 10
bottom_left = '-0.1 -0.1 0'
top_right = '0.2 0.9 0'
block_id = 0
[../]
[./createNewSidesetTwo]
type = AddSideSetsFromBoundingBox
boundary_id_old = 'right'
boundary_id_new = 11
bottom_left = '0.5 0.5 0'
top_right = '1.1 1.1 0'
block_id = 0
[../]
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./leftBC]
type = DirichletBC
variable = u
boundary = 10
value = 1
[../]
[./rightBC]
type = DirichletBC
variable = u
boundary = 11
value = 0
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/meshgenerators/mesh_extruder_generator/extrude_quad.i
[MeshGenerators]
[./fmg]
type = FileMeshGenerator
file = chimney_quad.e
[]
[./extrude]
type = MeshExtruderGenerator
input = fmg
num_layers = 20
extrusion_vector = '0 1e-2 0'
bottom_sideset = 'new_bottom'
top_sideset = 'new_top'
[]
[]
[Mesh]
type = MeshGeneratorMesh
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./bottom]
type = DirichletBC
variable = u
boundary = 'new_bottom'
value = 0
[../]
[./top]
type = DirichletBC
variable = u
boundary = 'new_top'
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out_quad
exodus = true
[]
test/tests/meshgenerators/patterned_mesh_generator/patterned_mesh_generator.i
[MeshGenerators]
[./fmg]
type = FileMeshGenerator
file = quad_mesh.e
[]
[./fmg2]
type = FileMeshGenerator
file = tri_mesh.e
[]
[./pmg]
type = PatternedMeshGenerator
inputs = 'fmg fmg2'
pattern = '0 0 0 0 0 0 0 0 0 0 0 0 0 0 ;
0 1 1 0 0 0 0 0 0 0 0 1 1 0 ;
0 1 1 1 0 0 0 0 0 0 1 1 1 0 ;
0 1 0 1 1 0 0 0 0 1 1 0 1 0 ;
0 1 0 0 1 1 0 0 1 1 0 0 1 0 ;
0 1 0 0 0 1 1 1 1 0 0 0 1 0 ;
0 1 0 0 0 0 1 1 0 0 0 0 1 0 ;
0 1 0 0 0 0 0 0 0 0 0 0 1 0 ;
0 1 0 0 0 0 0 0 0 0 0 0 1 0 ;
0 1 0 0 0 0 0 0 0 0 0 0 1 0 ;
0 1 0 0 0 0 0 0 0 0 0 0 1 0 ;
0 0 0 0 0 0 0 0 0 0 0 0 0 0'
bottom_boundary = 1
right_boundary = 2
top_boundary = 3
left_boundary = 4
[]
[]
[Mesh]
type = MeshGeneratorMesh
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = MatCoefDiffusion
variable = u
conductivity = conductivity
[../]
[]
[BCs]
[./top]
type = DirichletBC
variable = u
boundary = 3
value = 1
[../]
[./bottom]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[]
[Materials]
[./mat1]
type = GenericConstantMaterial
block = 1
prop_names = conductivity
prop_values = 100
[../]
[./mat2]
type = GenericConstantMaterial
block = 2
prop_names = conductivity
prop_values = 1e-4
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/markers/value_range_marker/value_range_marker_test.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
nz = 0
zmax = 0
elem_type = QUAD4
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Adaptivity]
[./Markers]
[./marker]
type = ValueRangeMarker
lower_bound = 0.3
upper_bound = 0.6
buffer_size = 0.1
variable = u
third_state = DO_NOTHING
[../]
[./inverted_marker]
type = ValueRangeMarker
invert = true
lower_bound = 0.3
upper_bound = 0.6
buffer_size = 0.1
variable = u
third_state = DO_NOTHING
[../]
[../]
[]
[Outputs]
exodus = true
[]
test/tests/transfers/multiapp_copy_transfer/second_lagrange_to_sub/sub.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
elem_type = QUAD9
[]
[Variables]
[./u]
order = SECOND
family = LAGRANGE
[../]
[]
[Problem]
type = FEProblem
solve = false
[]
[Executioner]
type = Steady
[]
[Outputs]
exodus = true
[]
test/tests/preconditioners/pbp/pbp_adapt_test.i
[Mesh]
type = GeneratedMesh
dim = 2
xmin = -1
xmax = 1
ymin = -1
ymax = 1
nx = 2
ny = 2
elem_type = QUAD4
[]
[Variables]
active = 'u v'
[./u]
order = FIRST
family = LAGRANGE
[../]
[./v]
order = FIRST
family = LAGRANGE
[../]
[]
[Functions]
[./forcing_fn]
type = ParsedFunction
value = -4
[../]
[./exact_fn]
type = ParsedFunction
value = ((x*x)+(y*y))
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[./ffn]
type = BodyForce
variable = u
function = forcing_fn
[../]
[./conv_v]
type = CoupledForce
variable = v
v = u
[../]
[./diff_v]
type = Diffusion
variable = v
[../]
[]
[BCs]
[./all]
type = FunctionDirichletBC
variable = u
boundary = '0 1 2 3'
function = exact_fn
[../]
[./left_v]
type = DirichletBC
variable = v
boundary = 1
value = 0
[../]
[./right_v]
type = DirichletBC
variable = v
boundary = 2
value = 0
[../]
[]
[Postprocessors]
[./l2_err]
type = ElementL2Error
variable = u
function = exact_fn
[../]
[]
[Preconditioning]
[./PBP]
type = PBP
solve_order = 'u v'
preconditioner = 'AMG ASM'
off_diag_row = 'v'
off_diag_column = 'u'
[../]
[]
[Executioner]
type = Steady
solve_type = JFNK
[./Adaptivity]
steps = 3
coarsen_fraction = 0.1
refine_fraction = 0.2
max_h_level = 5
[../]
[]
[Outputs]
execute_on = 'timestep_end'
file_base = out_pbp_adapt
print_mesh_changed_info = true
exodus = true
[]
test/tests/bcs/nodal_normals/circle_quads.i
[Mesh]
file = circle-quads.e
[]
[Functions]
[./all_bc_fn]
type = ParsedFunction
value = x*x+y*y
[../]
[./f_fn]
type = ParsedFunction
value = -4
[../]
[./analytical_normal_x]
type = ParsedFunction
value = x
[../]
[./analytical_normal_y]
type = ParsedFunction
value = y
[../]
[]
[NodalNormals]
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[./ffn]
type = BodyForce
variable = u
function = f_fn
[../]
[]
[BCs]
[./all]
type = FunctionDirichletBC
variable = u
boundary = '1'
function = 'all_bc_fn'
[../]
[]
[Postprocessors]
[./nx_pps]
type = NodalL2Error
variable = nodal_normal_x
boundary = '1'
function = analytical_normal_x
[../]
[./ny_pps]
type = NodalL2Error
variable = nodal_normal_y
boundary = '1'
function = analytical_normal_y
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
nl_rel_tol = 1e-13
[]
[Outputs]
execute_on = 'timestep_end'
exodus = true
[]
test/tests/misc/check_error/bad_number.i
[Mesh]
type = GeneratedMesh
dim = 1
nx = 10
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1.2eE
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/tag/tag_ad_kernels.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[ADKernels]
[./diff]
type = ADDiffusion
variable = u
extra_matrix_tags = 'mat_tag1 mat_tag2'
extra_vector_tags = 'vec_tag1 vec_tag2'
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
extra_matrix_tags = 'mat_tag1 mat_tag2'
extra_vector_tags = 'vec_tag1'
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
extra_matrix_tags = 'mat_tag1 mat_tag2'
extra_vector_tags = 'vec_tag1'
[../]
[]
[Preconditioning]
[./smp]
type = SMP
full = true
[../]
[]
[Problem]
type = TagTestProblem
test_tag_vectors = 'nontime residual vec_tag1 vec_tag2'
test_tag_matrices = 'mat_tag1 mat_tag2'
extra_tag_matrices = 'mat_tag1 mat_tag2'
extra_tag_vectors = 'vec_tag1 vec_tag2'
[]
[Executioner]
type = Steady
solve_type = 'Newton'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
l_tol = 1e-10
nl_rel_tol = 1e-9
nl_max_its = 1
[]
[Outputs]
exodus = true
[]
test/tests/misc/check_error/function_file_test2.i
# Test for usage of missing function
[Mesh]
file = square.e
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[./InitialCondition]
type = FunctionIC
function = ic_function
[../]
[../]
[]
[Functions]
[./ic_function]
type = PiecewiseLinear
data_file = piecewise_linear_rows.csv #Will generate error because data is expected in columns
format = columns
scale_factor = 1.0
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/vectorpostprocessors/material_vector_postprocessor/boundary-err.i
# check that simulation terminates with an error when trying to use the
# postprocessor on a boundary material.
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Materials]
[./mat]
type = GenericConstantMaterial
prop_names = 'prop1 prop2 prop3'
prop_values = '1 2 42'
boundary = 'left'
[../]
[]
[VectorPostprocessors]
[./vpp]
type = MaterialVectorPostprocessor
material = 'mat'
elem_ids = '3 4 7 42 88'
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
execute_on = 'initial timestep_end'
csv = true
[]
test/tests/preconditioners/smp/smp_single_adapt_test.i
#
# This is not very strong test since the problem being solved is linear, so the difference between
# full Jacobian and block diagonal preconditioner is not that big
#
[Mesh]
type = GeneratedMesh
dim = 2
xmin = 0
xmax = 1
ymin = 0
ymax = 1
nx = 5
ny = 5
elem_type = QUAD4
[]
[Functions]
[./exact_v]
type = ParsedFunction
value = sin(pi*x)*sin(pi*y)
[../]
[./force_fn_v]
type = ParsedFunction
value = 2*pi*pi*sin(pi*x)*sin(pi*y)
[../]
[]
[Variables]
active = 'u v'
[./u]
order = FIRST
family = LAGRANGE
[../]
[./v]
order = FIRST
family = LAGRANGE
[../]
[]
[Preconditioning]
[./SMP]
type = SMP
off_diag_row = 'u'
off_diag_column = 'v'
[../]
[]
[Kernels]
[./diff_u]
type = Diffusion
variable = u
[../]
[./conv_u]
type = CoupledForce
variable = u
v = v
[../]
[./diff_v]
type = Diffusion
variable = v
[../]
[./ffn_v]
type = BodyForce
variable = v
function = force_fn_v
[../]
[]
[BCs]
[./left_u]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right_u]
type = DirichletBC
variable = u
boundary = 3
value = 1
[../]
[./all_v]
type = FunctionDirichletBC
variable = v
boundary = '0 1 2 3'
function = exact_v
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[./Adaptivity]
steps = 3
coarsen_fraction = 0.1
refine_fraction = 0.2
max_h_level = 5
[../]
[]
[Outputs]
exodus = true
print_mesh_changed_info = true
[]
modules/navier_stokes/test/tests/scalar_adr/supg/2d_advection_error_testing.i
ax=1
ay=1
[GlobalParams]
u = ${ax}
v = ${ay}
p = 0
tau_type = mod
transient_term = true
[]
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
xmax = 1
ymax = 1
elem_type = QUAD9
[]
[Variables]
[./c]
family = LAGRANGE
order = SECOND
[../]
[]
[Kernels]
[./adv]
type = Advection
variable = c
forcing_func = 'ffn'
[../]
[]
[BCs]
[./all]
type = FunctionDirichletBC
variable = c
boundary = 'left right top bottom'
function = 'c_func'
[../]
[]
[Materials]
[./mat]
type = GenericConstantMaterial
prop_names = 'mu rho'
prop_values = '0 1'
[../]
[]
[Functions]
[./ffn]
type = ParsedFunction
value = '${ax}*(0.14*pi*y*cos(0.2*pi*x*y) + 0.2*pi*cos(0.5*pi*x)) + ${ay}*(0.14*pi*x*cos(0.2*pi*x*y) + 0.4*pi*cos(pi*y))'
[../]
[./c_func]
type = ParsedFunction
value = '0.4*sin(0.5*pi*x) + 0.4*sin(pi*y) + 0.7*sin(0.2*pi*x*y) + 0.5'
[../]
[./cx_func]
type = ParsedFunction
value = '0.14*pi*y*cos(0.2*pi*x*y) + 0.2*pi*cos(0.5*pi*x)'
[../]
[]
# [Executioner]
# type = Steady
# petsc_options_iname = '-pc_type -pc_factor_shift_type'
# petsc_options_value = 'lu NONZERO'
# []
[Executioner]
type = Transient
num_steps = 10
petsc_options = '-snes_converged_reason -ksp_converged_reason -snes_view'
petsc_options_iname = '-pc_type -pc_factor_shift_type -pc_factor_mat_solver_package'
petsc_options_value = 'lu NONZERO superlu_dist'
line_search = 'none'
nl_rel_tol = 1e-8
nl_abs_tol = 1e-12
nl_max_its = 10
l_tol = 1e-6
l_max_its = 10
[./TimeStepper]
dt = .05
type = IterationAdaptiveDT
cutback_factor = 0.4
growth_factor = 1.2
optimal_iterations = 20
[../]
[]
[Outputs]
[./exodus]
type = Exodus
[../]
[./csv]
type = CSV
[../]
[]
[Postprocessors]
[./L2c]
type = ElementL2Error
variable = c
function = c_func
outputs = 'console csv'
execute_on = 'timestep_end'
[../]
[./L2cx]
type = ElementL2Error
variable = cx
function = cx_func
outputs = 'console csv'
execute_on = 'timestep_end'
[../]
[]
[AuxVariables]
[./cx]
family = MONOMIAL
order = FIRST
[../]
[]
[AuxKernels]
[./cx_aux]
type = VariableGradientComponent
component = x
variable = cx
gradient_variable = c
[../]
[]
modules/porous_flow/test/tests/capillary_pressure/vangenuchten3.i
# Test van Genuchten relative permeability curve by varying saturation over the mesh
# van Genuchten exponent m = 0.5 for both phases
# No residual saturation in either phase
[Mesh]
type = GeneratedMesh
dim = 1
nx = 500
[]
[GlobalParams]
PorousFlowDictator = dictator
[]
[Variables]
[./p0]
initial_condition = 1e6
[../]
[./s1]
[../]
[]
[AuxVariables]
[./s0aux]
family = MONOMIAL
order = CONSTANT
[../]
[./s1aux]
family = MONOMIAL
order = CONSTANT
[../]
[./p0aux]
family = MONOMIAL
order = CONSTANT
[../]
[./p1aux]
family = MONOMIAL
order = CONSTANT
[../]
[]
[AuxKernels]
[./s0]
type = PorousFlowPropertyAux
property = saturation
phase = 0
variable = s0aux
[../]
[./s1]
type = PorousFlowPropertyAux
property = saturation
phase = 1
variable = s1aux
[../]
[./p0]
type = PorousFlowPropertyAux
property = pressure
phase = 0
variable = p0aux
[../]
[./p1]
type = PorousFlowPropertyAux
property = pressure
phase = 1
variable = p1aux
[../]
[]
[Functions]
[./s1]
type = ParsedFunction
value = x
[../]
[]
[ICs]
[./s1]
type = FunctionIC
variable = s1
function = s1
[../]
[]
[Kernels]
[./p0]
type = Diffusion
variable = p0
[../]
[./s1]
type = Diffusion
variable = s1
[../]
[]
[UserObjects]
[./dictator]
type = PorousFlowDictator
porous_flow_vars = 'p0 s1'
number_fluid_phases = 2
number_fluid_components = 2
[../]
[./pc]
type = PorousFlowCapillaryPressureVG
alpha = 1e-5
m = 0.5
sat_lr = 0.1
s_scale = 0.8
log_extension = false
[../]
[]
[Materials]
[./temperature]
type = PorousFlowTemperature
[../]
[./ppss]
type = PorousFlow2PhasePS
phase0_porepressure = p0
phase1_saturation = s1
capillary_pressure = pc
[../]
[./kr0]
type = PorousFlowRelativePermeabilityVG
phase = 0
m = 0.5
[../]
[./kr1]
type = PorousFlowRelativePermeabilityCorey
phase = 1
n = 2
[../]
[]
[VectorPostprocessors]
[./vpp]
type = LineValueSampler
variable = 's0aux s1aux p0aux p1aux'
start_point = '0 0 0'
end_point = '1 0 0'
num_points = 500
sort_by = id
[../]
[]
[Executioner]
type = Steady
solve_type = NEWTON
nl_abs_tol = 1e-6
[]
[BCs]
[./sleft]
type = DirichletBC
variable = s1
value = 0
boundary = left
[../]
[./sright]
type = DirichletBC
variable = s1
value = 1
boundary = right
[../]
[]
[Outputs]
csv = true
execute_on = timestep_end
[]
modules/tensor_mechanics/test/tests/dynamics/linear_constraint/disp_mid.i
# Constraining slave nodes to move a linear combination of master nodes
#
# The test consists of a 2D rectangular block divided into two Quad elements
# (along its height) which have different material properties.
# A displacement of 2 m is applied to the top surface of the block in x direction and the
# bottom surface is held fixed.
# The nodes of the interface between the two elements will tend to move as
# dictated by the material models of the two elements.
# LinearNodalConstraint forces the interface nodes to move as a linear combination
# of the nodes on the top and bottom of the block.
# master node ids and the corresponding weights are taken as input by the LinearNodalConstraint
# along with the slave node set or slave node ids.
# The constraint can be applied using either penalty or kinematic formulation.
# In this example, the final x displacement of the top surface is 2m and bottom surface is 0m.
# Therefore, the final x displacement of the interface nodes would be 0.25*top+0.75*bottom = 0.5m
[Mesh]
file=rect_mid.e
[]
[Variables]
[./disp_x]
[../]
[./disp_y]
[../]
[]
[Kernels]
[./TensorMechanics]
displacements = 'disp_x disp_y'
[../]
[]
[BCs]
[./top_2x]
type = DirichletBC
variable = disp_x
boundary = 10
value = 2.0
[../]
[./top_2y]
type = DirichletBC
variable = disp_y
boundary = 10
value = 0.0
[../]
[./bottom_1]
type = DirichletBC
variable = disp_y
boundary = 1
value = 0.0
[../]
[./bottom_2]
type = DirichletBC
variable = disp_x
boundary = 1
value = 0.0
[../]
[]
[Materials]
[./Elasticity_tensor_1]
type = ComputeElasticityTensor
block = 1
fill_method = 'symmetric_isotropic'
C_ijkl = '400. 200.'
[../]
[./strain_1]
type = ComputeSmallStrain
block = 1
displacements = 'disp_x disp_y'
[../]
[./stress_1]
type = ComputeLinearElasticStress
block = 1
[../]
[./density_1]
type = GenericConstantMaterial
block = 1
prop_names = 'density'
prop_values = '10.'
[../]
[./Elasticity_tensor_2]
type = ComputeElasticityTensor
block = 2
fill_method = 'symmetric_isotropic'
C_ijkl = '1000. 500.'
[../]
[./strain_2]
type = ComputeSmallStrain
block = 2
displacements = 'disp_x disp_y'
[../]
[./stress_2]
type = ComputeLinearElasticStress
block = 2
[../]
[./density_2]
type = GenericConstantMaterial
block = 2
prop_names = 'density'
prop_values = '10.'
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = ''
petsc_options_value = ''
line_search = 'none'
[]
[Constraints]
[./disp_x_1]
type = LinearNodalConstraint
variable = disp_x
master = '0 5'
weights = '0.25 0.75'
# slave_node_set = '2'
slave_node_ids = '2 3'
penalty = 1e8
formulation = kinematic
[../]
[./disp_y_1]
type = LinearNodalConstraint
variable = disp_y
master = '0 5'
weights = '0.25 0.75'
# slave_node_set = '2'
slave_node_ids = '2 3'
penalty = 1e8
formulation = kinematic
[../]
[]
[Postprocessors]
[./_dt]
type = TimestepSize
[../]
[./disp_1]
type = NodalVariableValue
nodeid = 0
variable = disp_x
[../]
[./disp_2]
type = NodalVariableValue
nodeid = 1
variable = disp_x
[../]
[./disp_3]
type = NodalVariableValue
nodeid = 2
variable = disp_x
[../]
[./disp_4]
type = NodalVariableValue
nodeid = 3
variable = disp_x
[../]
[./disp_5]
type = NodalVariableValue
nodeid = 4
variable = disp_x
[../]
[./disp_6]
type = NodalVariableValue
nodeid = 5
variable = disp_x
[../]
[]
[Outputs]
exodus = true
print_linear_residuals = true
perf_graph = true
[./console]
type = Console
output_linear = true
[../]
[]
test/tests/outputs/console/console.i
###########################################################
# This test exercises console Output control. Various
# controls are implemented using this input file including
# turning off color, changing Postprocessor output,
# toggling the performance logging, and verifying
# simulation information on the console.
#
# @Requirement U1.40
###########################################################
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[./v]
[../]
[]
[AuxVariables]
[./aux0]
order = SECOND
family = SCALAR
[../]
[./aux1]
family = SCALAR
initial_condition = 5
[../]
[./aux2]
family = SCALAR
initial_condition = 10
[../]
[]
[Kernels]
[./diff_u]
type = Diffusion
variable = u
[../]
[./diff_v]
type = CoefDiffusion
variable = v
coef = 2
[../]
[]
[BCs]
[./right_u]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[./left_u]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right_v]
type = DirichletBC
variable = v
boundary = right
value = 3
[../]
[./left_v]
type = DirichletBC
variable = v
boundary = left
value = 2
[../]
[]
[Postprocessors]
[./num_vars]
type = NumVars
system = 'NL'
[../]
[./num_aux]
type = NumVars
system = 'AUX'
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
execute_on = 'timestep_end'
color = false
[./screen]
type = Console
fit_mode = 40
[../]
[]
[ICs]
[./aux0_IC]
variable = aux0
values = '12 13'
type = ScalarComponentIC
[../]
[]
modules/richards/test/tests/jacobian_1/jn05.i
# unsaturated = false
# gravity = false
# supg = true
# transient = false
[Mesh]
type = GeneratedMesh
dim = 3
nx = 1
ny = 1
nz = 1
xmin = -1
xmax = 1
ymin = -1
ymax = 1
zmin = -1
zmax = 1
[]
[GlobalParams]
richardsVarNames_UO = PPNames
[]
[UserObjects]
[./PPNames]
type = RichardsVarNames
richards_vars = pressure
[../]
[./DensityConstBulk]
type = RichardsDensityConstBulk
dens0 = 1
bulk_mod = 1.0 # notice small quantity, so the PETSc constant state works
[../]
[./SeffVG]
type = RichardsSeff1VG
m = 0.8
al = 1 # notice small quantity, so the PETSc constant state works
[../]
[./RelPermPower]
type = RichardsRelPermPower
simm = 0.2
n = 2
[../]
[./Saturation]
type = RichardsSat
s_res = 0.1
sum_s_res = 0.1
[../]
[./SUPGstandard]
type = RichardsSUPGstandard
p_SUPG = 0.1
[../]
[]
[Variables]
[./pressure]
order = FIRST
family = LAGRANGE
[./InitialCondition]
type = RandomIC
block = 0
min = 0
max = 1
[../]
[../]
[]
[Kernels]
active = 'richardsf'
[./richardst]
type = RichardsMassChange
variable = pressure
[../]
[./richardsf]
type = RichardsFlux
variable = pressure
[../]
[]
[Materials]
[./rock]
type = RichardsMaterial
block = 0
mat_porosity = 0.1
mat_permeability = '1E-5 0 0 0 1E-5 0 0 0 1E-5'
density_UO = DensityConstBulk
relperm_UO = RelPermPower
SUPG_UO = SUPGstandard
sat_UO = Saturation
seff_UO = SeffVG
viscosity = 1E-3
gravity = '0 0 0'
linear_shape_fcns = true
[../]
[]
[Preconditioning]
[./andy]
type = SMP
full = true
petsc_options_iname = '-ksp_type -pc_type -snes_atol -snes_rtol -snes_max_it -snes_type'
petsc_options_value = 'bcgs bjacobi 1E-15 1E-10 10000 test'
[../]
[]
[Executioner]
type = Steady
solve_type = Newton
[]
[Outputs]
execute_on = 'timestep_end'
file_base = jn05
exodus = false
[]
test/tests/auxkernels/grad_component/grad_component.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[AuxVariables]
[./grad_u_x]
order = CONSTANT
family = MONOMIAL
[../]
[./grad_u_y]
order = CONSTANT
family = MONOMIAL
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[AuxKernels]
[./grad_u_x_aux]
type = VariableGradientComponent
variable = grad_u_x
component = x
gradient_variable = u
[../]
[./grad_u_y_aux]
type = VariableGradientComponent
variable = grad_u_y
component = y
gradient_variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
modules/solid_mechanics/test/tests/solid_mech_cube/solid_mech_cube_test.i
#Run with 4 procs
[Mesh]
file = cube.e
[]
[Variables]
[./x_disp]
order = FIRST
family = LAGRANGE
[../]
[./y_disp]
order = FIRST
family = LAGRANGE
[../]
[./z_disp]
order = FIRST
family = LAGRANGE
[../]
[]
[SolidMechanics]
[./solid]
disp_x = x_disp
disp_y = y_disp
disp_z = z_disp
[../]
[]
[BCs]
[./y_force]
type = NeumannBC
variable = y_disp
boundary = 2
value = -1.0
[../]
[./left]
type = DirichletBC
variable = x_disp
boundary = 3
value = 0.0
[../]
[./bottom]
type = DirichletBC
variable = y_disp
boundary = 1
value = 0.0
[../]
[]
[Materials]
[./constant]
type = LinearIsotropicMaterial
block = 1
youngs_modulus = 1e6
poissons_ratio = .3
disp_x = x_disp
disp_y = y_disp
disp_z = z_disp
[../]
[]
[Executioner]
type = Steady #Transient
solve_type = PJFNK
l_max_its = 100
# start_time = 0.0
# num_steps = 4
# dt = 0.000005
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/constraints/tied_value_constraint/tied_value_constraint_test.i
# [Debug]
# show_top_residuals = 5
# []
[Mesh]
type = FileMesh
file = constraint_test.e
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
# active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
# active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 4
value = 1
[../]
[]
[Constraints]
[./value]
type = TiedValueConstraint
variable = u
slave = 2
master = 3
master_variable = u
[../]
[]
[Preconditioning]
# active = 'FDP'
active = ''
[./FDP]
# full = true
# off_diag_row = 'v'
# off_diag_column = 'u'
type = FDP
[../]
[]
[Executioner]
# l_tol = 1e-1
# l_tol = 1e-
# nl_rel_tol = 1e-14
type = Steady
solve_type = NEWTON
l_max_its = 100
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/dirackernels/point_caching/point_caching_uniform_refinement.i
[Mesh]
type = GeneratedMesh
dim = 2
xmin = 0
xmax = 1
ymin = 0
ymax = 1
nx = 2
ny = 2
elem_type = QUAD4
uniform_refine = 2
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[DiracKernels]
active = 'point_source'
[./point_source]
type = CachingPointSource
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 3
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 1
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Adaptivity]
steps = 2
marker = uniform
[./Markers]
[./uniform]
type = UniformMarker
mark = refine
[../]
[../]
[]
[Outputs]
execute_on = 'timestep_end'
exodus = true
[]
test/tests/markers/value_threshold_marker/value_threshold_marker_test.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
nz = 0
zmax = 0
elem_type = QUAD4
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Adaptivity]
[./Markers]
[./marker]
type = ValueThresholdMarker
coarsen = 0.3
variable = u
refine = 0.7
[../]
[./inverted_marker]
type = ValueThresholdMarker
invert = true
coarsen = 0.7
refine = 0.3
variable = u
third_state = DO_NOTHING
[../]
[../]
[]
[Outputs]
exodus = true
[]
modules/combined/test/tests/gap_heat_transfer_mortar/gap_heat_transfer_mortar.i
[Mesh]
file = 2blk-gap.e
[./MortarInterfaces]
[./middle]
master = 100
slave = 101
subdomain = 1000
[../]
[../]
[]
[Variables]
[./temp]
order = FIRST
family = LAGRANGE
block = '1 2'
[../]
[./lm]
order = FIRST
family = LAGRANGE
block = '1000'
[../]
[]
[Materials]
[./left]
type = HeatConductionMaterial
block = 1
thermal_conductivity = 1000
specific_heat = 1
[../]
[./right]
type = HeatConductionMaterial
block = 2
thermal_conductivity = 500
specific_heat = 1
[../]
[]
[Kernels]
[./hc]
type = HeatConduction
variable = temp
use_displaced_mesh = false
block = '1 2'
[../]
[]
[Constraints]
[./ced]
type = GapConductanceConstraint
variable = lm
interface = middle
master_variable = temp
k = 100
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = temp
boundary = 'left'
value = 1
[../]
[./right]
type = DirichletBC
variable = temp
boundary = 'right'
value = 0
[../]
[]
[Preconditioning]
[./fmp]
type = SMP
full = true
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
nl_rel_tol = 1e-11
[]
[Outputs]
exodus = true
[]
test/tests/kernels/tag_errors/no_tags/no_tags.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
vector_tags = ''
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/misc/check_error/bad_kernel_var_test.i
[Mesh]
file = square.e
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = foo # Test for missing variable
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/misc/deprecation/deprecation.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
test/tests/postprocessors/point_value/point_value_error.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Postprocessors]
[./value]
type = PointValue
variable = u
point = '14.371 .41 0'
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/auxkernels/solution_aux/solution_aux_exodus_elem_map.i
[Mesh]
file = elem_map.e
# The SolutionUserObject uses the copy_nodal_solution() capability
# of the Exodus reader, and therefore won't work if the initial mesh
# has been renumbered (it will be reunumbered if you are running with
# DistributedMesh in parallel). Hence, we restrict this test to run with
# ReplicatedMesh only.
parallel_type = replicated
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
initial_condition = 0.0
[../]
[]
[AuxVariables]
[./matid]
order = CONSTANT
family = MONOMIAL
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[AuxKernels]
[./matid]
type = SolutionAux
solution = soln
variable = matid
scale_factor = 1.0
[../]
[]
[UserObjects]
[./soln]
type = SolutionUserObject
mesh = elem_map.e
system_variables = MatID
timestep = LATEST
[../]
[]
[BCs]
[./stuff]
type = DirichletBC
variable = u
boundary = '1'
value = 1.0
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
execute_on = 'timestep_end'
exodus = true
[]
modules/combined/test/tests/heat_conduction_patch/heat_conduction_patch_hex20_test.i
#
# This problem is taken from the Abaqus verification manual:
# "1.5.8 Patch test for heat transfer elements"
#
# The temperature on the exterior nodes is 200x+100y+200z.
#
# This gives a constant flux at all Gauss points.
#
# In addition, the temperature at all nodes follows the same formula.
#
# Node x y z Temperature
# 1 1.000E+00 0.000E+00 1.000E+00 4.0000E+02
# 2 6.770E-01 3.050E-01 6.830E-01 3.0250E+02
# 3 3.200E-01 1.860E-01 6.430E-01 2.1120E+02
# 4 0.000E+00 0.000E+00 1.000E+00 2.0000E+02
# 5 1.000E+00 1.000E+00 1.000E+00 5.0000E+02
# 6 7.880E-01 6.930E-01 6.440E-01 3.5570E+02
# 7 1.650E-01 7.450E-01 7.020E-01 2.4790E+02
# 8 0.000E+00 1.000E+00 1.000E+00 3.0000E+02
# 9 8.385E-01 1.525E-01 8.415E-01 3.5125E+02
# 10 4.985E-01 2.455E-01 6.630E-01 2.5685E+02
# 11 1.600E-01 9.300E-02 8.215E-01 2.0560E+02
# 12 5.000E-01 0.000E+00 1.000E+00 3.0000E+02
# 13 1.000E+00 5.000E-01 1.000E+00 4.5000E+02
# 14 7.325E-01 4.990E-01 6.635E-01 3.2910E+02
# 15 2.425E-01 4.655E-01 6.725E-01 2.2955E+02
# 16 0.000E+00 5.000E-01 1.000E+00 2.5000E+02
# 17 8.940E-01 8.465E-01 8.220E-01 4.2785E+02
# 18 4.765E-01 7.190E-01 6.730E-01 3.0180E+02
# 19 8.250E-02 8.725E-01 8.510E-01 2.7395E+02
# 20 5.000E-01 1.000E+00 1.000E+00 4.0000E+02
# 21 1.000E+00 0.000E+00 0.000E+00 2.0000E+02
# 22 0.000E+00 0.000E+00 0.000E+00 0.0000E+00
# 23 8.260E-01 2.880E-01 2.880E-01 2.5160E+02
# 24 2.490E-01 3.420E-01 1.920E-01 1.2240E+02
# 25 1.000E+00 0.000E+00 5.000E-01 3.0000E+02
# 26 5.000E-01 0.000E+00 0.000E+00 1.0000E+02
# 27 0.000E+00 0.000E+00 5.000E-01 1.0000E+02
# 28 9.130E-01 1.440E-01 1.440E-01 2.2580E+02
# 29 1.245E-01 1.710E-01 9.600E-02 6.1200E+01
# 30 7.515E-01 2.965E-01 4.855E-01 2.7705E+02
# 31 5.375E-01 3.150E-01 2.400E-01 1.8700E+02
# 32 2.845E-01 2.640E-01 4.175E-01 1.6680E+02
# 33 2.730E-01 7.500E-01 2.300E-01 1.7560E+02
# 34 0.000E+00 1.000E+00 0.000E+00 1.0000E+02
# 35 2.610E-01 5.460E-01 2.110E-01 1.4900E+02
# 36 0.000E+00 5.000E-01 0.000E+00 5.0000E+01
# 37 2.190E-01 7.475E-01 4.660E-01 2.1175E+02
# 38 1.365E-01 8.750E-01 1.150E-01 1.3780E+02
# 39 0.000E+00 1.000E+00 5.000E-01 2.0000E+02
# 40 8.500E-01 6.490E-01 2.630E-01 2.8750E+02
# 41 8.380E-01 4.685E-01 2.755E-01 2.6955E+02
# 42 8.190E-01 6.710E-01 4.535E-01 3.2160E+02
# 43 5.615E-01 6.995E-01 2.465E-01 2.3155E+02
# 44 1.000E+00 1.000E+00 0.000E+00 3.0000E+02
# 45 1.000E+00 5.000E-01 0.000E+00 2.5000E+02
# 46 1.000E+00 1.000E+00 5.000E-01 4.0000E+02
# 47 9.250E-01 8.245E-01 1.315E-01 2.9375E+02
# 48 5.000E-01 1.000E+00 0.000E+00 2.0000E+02
[Mesh]#Comment
file = heat_conduction_patch_hex20_test.e
[] # Mesh
[Functions]
[./temps]
type = ParsedFunction
value='200*x+100*y+200*z'
[../]
[] # Functions
[Variables]
[./temp]
order = SECOND
family = LAGRANGE
[../]
[] # Variables
[Kernels]
[./heat_r]
type = HeatConduction
variable = temp
[../]
[] # Kernels
[BCs]
[./temps]
type = FunctionDirichletBC
variable = temp
boundary = 10
function = temps
[../]
[] # BCs
[Materials]
[./heat]
type = HeatConductionMaterial
block = 1
specific_heat = 0.116
thermal_conductivity = 4.85e-4
[../]
[./density]
type = Density
block = 1
density = 0.283
[../]
[] # Materials
[Executioner]
type = Steady
#Preconditioned JFNK (default)
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -ksp_gmres_restart'
petsc_options_value = 'lu 101'
line_search = 'none'
nl_abs_tol = 1e-11
nl_rel_tol = 1e-10
l_max_its = 20
[./Quadrature]
order = THIRD
[../]
[] # Executioner
[Outputs]
file_base = out_hex20
exodus = true
[] # Output
test/tests/mesh/adapt/initial_adaptivity_test.i
[Mesh]
type = GeneratedMesh
dim = 2
xmin = -1
xmax = 1
ymin = -1
ymax = 1
nx = 2
ny = 2
elem_type = QUAD9
[]
[Functions]
[./exact_fn]
type = ParsedFunction
value = x*x+y*y
[../]
[./ffn]
type = ParsedFunction
value = -4
[../]
[]
[Variables]
[./u]
order = SECOND
family = LAGRANGE
[./InitialCondition]
type = BoundingBoxIC
x1 = -2
y1 = -2
x2 = 0
y2 = 2
inside = 1
outside = 0
[../]
[../]
[]
[Kernels]
[./udiff]
type = Diffusion
variable = u
[../]
[./forcing_fn]
type = BodyForce
variable = u
function = ffn
[../]
[]
[BCs]
[./all]
type = FunctionDirichletBC
variable = u
boundary = '0 1 2 3'
function = exact_fn
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[./Adaptivity]
initial_adaptivity = 5
refine_fraction = 0.2
coarsen_fraction = 0.3
max_h_level = 4
[../]
[]
[Outputs]
exodus = true
[]
test/tests/meshgenerators/generate_subdomain_id/generate_subdomain_id.i
[MeshGenerators]
[./gmg]
type = GeneratedMeshGenerator
dim = 2
nx = 10
ny = 10
[]
[./generate_id]
type = SubdomainIDGenerator
input = gmg
subdomain_id = 3
[]
[]
[Mesh]
type = MeshGeneratorMesh
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Problem]
type = FEProblem
solve = false
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/bcs/1d_neumann/1d_neumann.i
[Mesh]
type = GeneratedMesh
dim = 1
nx = 10
construct_side_list_from_node_list = true
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = NeumannBC
variable = u
boundary = right
value = 2
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/misc/test_harness_tester/2d_diffusion_test.i
[Mesh]
file = square.e
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out
exodus = true
[]
modules/porous_flow/test/tests/relperm/corey1.i
# Test Corey relative permeability curve by varying saturation over the mesh
# Corey exponent n = 1 for both phases (linear residual saturation)
# No residual saturation in either phase
[Mesh]
type = GeneratedMesh
dim = 1
nx = 20
[]
[GlobalParams]
PorousFlowDictator = dictator
[]
[Variables]
[./p0]
initial_condition = 1e6
[../]
[./s1]
[../]
[]
[AuxVariables]
[./s0aux]
family = MONOMIAL
order = CONSTANT
[../]
[./s1aux]
family = MONOMIAL
order = CONSTANT
[../]
[./kr0aux]
family = MONOMIAL
order = CONSTANT
[../]
[./kr1aux]
family = MONOMIAL
order = CONSTANT
[../]
[]
[AuxKernels]
[./s0]
type = PorousFlowPropertyAux
property = saturation
phase = 0
variable = s0aux
[../]
[./s1]
type = PorousFlowPropertyAux
property = saturation
phase = 1
variable = s1aux
[../]
[./kr0]
type = PorousFlowPropertyAux
property = relperm
phase = 0
variable = kr0aux
[../]
[./kr1]
type = PorousFlowPropertyAux
property = relperm
phase = 1
variable = kr1aux
[../]
[]
[Functions]
[./s1]
type = ParsedFunction
value = x
[../]
[]
[ICs]
[./s1]
type = FunctionIC
variable = s1
function = s1
[../]
[]
[Kernels]
[./p0]
type = Diffusion
variable = p0
[../]
[./s1]
type = Diffusion
variable = s1
[../]
[]
[UserObjects]
[./dictator]
type = PorousFlowDictator
porous_flow_vars = 'p0 s1'
number_fluid_phases = 2
number_fluid_components = 2
[../]
[./pc]
type = PorousFlowCapillaryPressureConst
pc = 0
[../]
[]
[Materials]
[./temperature]
type = PorousFlowTemperature
[../]
[./ppss]
type = PorousFlow2PhasePS
phase0_porepressure = p0
phase1_saturation = s1
capillary_pressure = pc
[../]
[./kr0]
type = PorousFlowRelativePermeabilityCorey
phase = 0
n = 1
[../]
[./kr1]
type = PorousFlowRelativePermeabilityCorey
phase = 1
n = 1
[../]
[]
[VectorPostprocessors]
[./vpp]
type = LineValueSampler
variable = 's0aux s1aux kr0aux kr1aux'
start_point = '0 0 0'
end_point = '1 0 0'
num_points = 20
sort_by = id
[../]
[]
[Executioner]
type = Steady
solve_type = NEWTON
nl_abs_tol = 1e-8
[]
[BCs]
[./sleft]
type = DirichletBC
variable = s1
value = 0
boundary = left
[../]
[./sright]
type = DirichletBC
variable = s1
value = 1
boundary = right
[../]
[]
[Outputs]
csv = true
execute_on = timestep_end
[]
test/tests/quadrature/gauss_lobatto/gauss_lobatto.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 1
ny = 1
nz = 0
elem_type = QUAD4
[]
[Postprocessors]
[./num_elem_qps]
type = NumElemQPs
block = 0
[../]
[]
[Problem]
type = FEProblem
solve = false
[]
[Executioner]
type = Steady
# In 1D, 5th-order Gauss-Lobatto quadrature has 4 points, so in 2D
# it should have 16.
[./Quadrature]
type = GAUSS_LOBATTO
order = FIFTH
[../]
[]
[Outputs]
execute_on = 'timestep_end'
exodus = false
csv = true
[]
test/tests/mesh_modifiers/add_side_sets/cylinder_points.i
[Mesh]
type = FileMesh
file = cylinder.e
# This MeshModifier currently only works with ReplicatedMesh.
# For more information, refer to #2129.
parallel_type = replicated
[]
# Mesh Modifiers
[MeshModifiers]
[./add_side_sets]
type = SideSetsFromPoints
points = '0 0 0.5
0.1 0 0
0 0 -0.5'
new_boundary = 'top side bottom'
[../]
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./bottom]
type = DirichletBC
variable = u
boundary = bottom
value = 0
[../]
[./top]
type = DirichletBC
variable = u
boundary = top
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/kernels/scalar_constraint/scalar_constraint_kernel_disp.i
#
# This test is identical to scalar_constraint_kernel.i, but it everything is evaluated on the displaced mesh
#
[GlobalParams]
use_displaced_mesh = true
[]
[Mesh]
type = GeneratedMesh
dim = 2
xmin = -1
xmax = 1
ymin = -1
ymax = 1
nx = 2
ny = 2
elem_type = QUAD9
displacements = 'disp_x disp_y'
[]
[Functions]
[./exact_fn]
type = ParsedFunction
value = 'x*x+y*y'
[../]
[./ffn]
type = ParsedFunction
value = -4
[../]
[./bottom_bc_fn]
type = ParsedFunction
value = -2*y
[../]
[./right_bc_fn]
type = ParsedFunction
value = 2*x
[../]
[./top_bc_fn]
type = ParsedFunction
value = 2*y
[../]
[./left_bc_fn]
type = ParsedFunction
value = -2*x
[../]
[]
[AuxVariables]
[./disp_x]
family = LAGRANGE
order = SECOND
[../]
[./disp_y]
family = LAGRANGE
order = SECOND
[../]
[]
[AuxKernels]
[./disp_x_ak]
type = ConstantAux
variable = disp_x
value = 0
[../]
[./disp_y_ak]
type = ConstantAux
variable = disp_y
value = 0
[../]
[]
# NL
[Variables]
[./u]
family = LAGRANGE
order = SECOND
[../]
[./lambda]
family = SCALAR
order = FIRST
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[./ffnk]
type = BodyForce
variable = u
function = ffn
[../]
[./sk_lm]
type = ScalarLagrangeMultiplier
variable = u
lambda = lambda
[../]
[]
[ScalarKernels]
[./constraint]
type = PostprocessorCED
variable = lambda
pp_name = pp
value = 2.666666666666666
# overrride the global setting, scalar kernels do not live on a mesh
use_displaced_mesh = false
[../]
[]
[BCs]
[./bottom]
type = FunctionNeumannBC
variable = u
boundary = '0'
function = bottom_bc_fn
[../]
[./right]
type = FunctionNeumannBC
variable = u
boundary = '1'
function = right_bc_fn
[../]
[./top]
type = FunctionNeumannBC
variable = u
boundary = '2'
function = top_bc_fn
[../]
[./left]
type = FunctionNeumannBC
variable = u
boundary = '3'
function = left_bc_fn
[../]
[]
[Postprocessors]
[./pp]
type = ElementIntegralVariablePostprocessor
variable = u
execute_on = linear
[../]
[./l2_err]
type = ElementL2Error
variable = u
function = exact_fn
execute_on = 'initial timestep_end'
[../]
[]
[Preconditioning]
[./pc]
type = SMP
full = true
solve_type = 'PJFNK'
[../]
[]
[Executioner]
type = Steady
nl_rel_tol = 1e-14
l_tol = 1e-7
[]
[Outputs]
exodus = true
hide = lambda
[]
test/tests/functions/image_function/moose_logo_test_2D.i
[Problem]
solve = false
[]
[Mesh]
type = ImageMesh
cells_per_pixel = 1
dim = 2
file = moose_logo_small.png
[]
[Variables]
[./original]
family = MONOMIAL
order = CONSTANT
[../]
[./scaled]
family = MONOMIAL
order = CONSTANT
[../]
[./shifted]
family = MONOMIAL
order = CONSTANT
[../]
[]
[Functions]
[./image]
type = ImageFunction
file = moose_logo_small.png
[../]
[./image_scale]
type = ImageFunction
file = moose_logo_small.png
scale = 0.00392156862
[../]
[./image_shift]
type = ImageFunction
file = moose_logo_small.png
shift = -127.5
[../]
[]
[ICs]
[./original_IC]
type = FunctionIC
function = image
variable = original
[../]
[./scaled_IC]
type = FunctionIC
function = image_scale
variable = scaled
[../]
[./shifted_IC]
type = FunctionIC
function = image_shift
variable = shifted
[../]
[]
[Executioner]
type = Steady
[]
[Outputs]
exodus = true
[]
test/tests/ics/boundary_ic/boundary_ic.i
[Mesh]
type = GeneratedMesh
dim = 2
xmin = 0
xmax = 1
ymin = 0
ymax = 1
nx = 4
ny = 4
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[ICs]
[./u_ic]
type = ConstantIC
variable = u
block = 0
value = -1
[../]
[./u_ic_bnd]
type = ConstantIC
variable = u
boundary = 'left right'
value = -2
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'NEWTON'
[]
[Outputs]
exodus = true
[]
test/tests/postprocessors/nodal_sum/nodal_sum.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
[]
[MeshModifiers]
[./left]
type = SubdomainBoundingBox
bottom_left = '0 0 0'
top_right = '0.5 1 0'
block_id = 100
[../]
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Postprocessors]
[./nodal_sum]
type = NodalSum
variable = u
execute_on = 'initial timestep_end'
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
csv = true
[]
modules/richards/test/tests/jacobian_1/jn04.i
# unsaturated = true
# gravity = true
# supg = false
# transient = false
[Mesh]
type = GeneratedMesh
dim = 3
nx = 1
ny = 1
nz = 1
xmin = -1
xmax = 1
ymin = -1
ymax = 1
zmin = -1
zmax = 1
[]
[GlobalParams]
richardsVarNames_UO = PPNames
[]
[UserObjects]
[./PPNames]
type = RichardsVarNames
richards_vars = pressure
[../]
[./DensityConstBulk]
type = RichardsDensityConstBulk
dens0 = 1
bulk_mod = 1.0 # notice small quantity, so the PETSc constant state works
[../]
[./SeffVG]
type = RichardsSeff1VG
m = 0.8
al = 1 # notice small quantity, so the PETSc constant state works
[../]
[./RelPermPower]
type = RichardsRelPermPower
simm = 0.2
n = 2
[../]
[./Saturation]
type = RichardsSat
s_res = 0.1
sum_s_res = 0.1
[../]
[./SUPGnone]
type = RichardsSUPGnone
[../]
[]
[Variables]
[./pressure]
order = FIRST
family = LAGRANGE
[./InitialCondition]
type = RandomIC
block = 0
min = -1
max = 0
[../]
[../]
[]
[Kernels]
active = 'richardsf'
[./richardst]
type = RichardsMassChange
variable = pressure
[../]
[./richardsf]
type = RichardsFlux
variable = pressure
[../]
[]
[Materials]
[./rock]
type = RichardsMaterial
block = 0
mat_porosity = 0.1
mat_permeability = '1E-5 0 0 0 1E-5 0 0 0 1E-5'
density_UO = DensityConstBulk
relperm_UO = RelPermPower
SUPG_UO = SUPGnone
sat_UO = Saturation
seff_UO = SeffVG
viscosity = 1E-3
gravity = '1 2 3'
linear_shape_fcns = true
[../]
[]
[Preconditioning]
[./andy]
type = SMP
full = true
petsc_options_iname = '-ksp_type -pc_type -snes_atol -snes_rtol -snes_max_it -snes_type'
petsc_options_value = 'bcgs bjacobi 1E-15 1E-10 10000 test'
[../]
[]
[Executioner]
type = Steady
solve_type = Newton
[]
[Outputs]
execute_on = 'timestep_end'
file_base = jn04
exodus = false
[]
modules/porous_flow/test/tests/flux_limited_TVD_pflow/except05.i
# Exception test: Dictator cannot determine the FEType and it is not properly specified in the AdvectiveFluxCalculator
[Mesh]
type = GeneratedMesh
dim = 1
[]
[GlobalParams]
gravity = '1 2 3'
PorousFlowDictator = dictator
[]
[Variables]
[./pp]
[../]
[./tracer]
[../]
[./cm]
family = Monomial
order = constant
[../]
[]
[Kernels]
[./cm]
type = Diffusion
variable = cm
[../]
[]
[Modules]
[./FluidProperties]
[./the_simple_fluid]
type = SimpleFluidProperties
[../]
[../]
[]
[PorousFlowUnsaturated]
porepressure = pp
mass_fraction_vars = tracer
fp = the_simple_fluid
[]
[UserObjects]
[./dummy_dictator]
type = PorousFlowDictator
porous_flow_vars = 'pp cm'
number_fluid_phases = 1
number_fluid_components = 2
[../]
[./advective_flux_calculator]
type = PorousFlowAdvectiveFluxCalculatorSaturated
PorousFlowDictator = dummy_dictator
[../]
[]
[Materials]
[./permeability]
type = PorousFlowPermeabilityConst
permeability = '1 0 0 0 2 0 0 0 3'
[../]
[]
[Executioner]
type = Steady
solve_type = Newton
[]
test/tests/variables/fe_hier/hier-3-3d.i
[Mesh]
type = GeneratedMesh
dim = 3
xmin = -1
xmax = 1
ymin = -1
ymax = 1
zmin = -1
zmax = 1
nx = 1
ny = 1
nz = 1
elem_type = HEX27
# This problem only has 1 element, so using DistributedMesh in parallel
# isn't really an option, and we don't care that much about DistributedMesh
# in serial.
parallel_type = replicated
[]
[Functions]
[./bc_fnt]
type = ParsedFunction
value = 3*y*y
[../]
[./bc_fnb]
type = ParsedFunction
value = -3*y*y
[../]
[./bc_fnl]
type = ParsedFunction
value = -3*x*x
[../]
[./bc_fnr]
type = ParsedFunction
value = 3*x*x
[../]
[./bc_fnk]
type = ParsedFunction
value = -3*z*z
[../]
[./bc_fnf]
type = ParsedFunction
value = 3*z*z
[../]
[./forcing_fn]
type = ParsedFunction
value = -6*x-6*y-6*z+(x*x*x)+(y*y*y)+(z*z*z)
[../]
[./solution]
type = ParsedGradFunction
value = (x*x*x)+(y*y*y)+(z*z*z)
grad_x = 3*x*x
grad_y = 3*y*y
grad_z = 3*z*z
[../]
[]
[Variables]
[./u]
order = THIRD
family = HIERARCHIC
[../]
[]
[Kernels]
active = 'diff forcing reaction'
[./diff]
type = Diffusion
variable = u
[../]
[./reaction]
type = Reaction
variable = u
[../]
[./forcing]
type = BodyForce
variable = u
function = forcing_fn
[../]
[]
[BCs]
[./bc_top]
type = FunctionNeumannBC
variable = u
boundary = 'top'
function = bc_fnt
[../]
[./bc_bottom]
type = FunctionNeumannBC
variable = u
boundary = 'bottom'
function = bc_fnb
[../]
[./bc_left]
type = FunctionNeumannBC
variable = u
boundary = 'left'
function = bc_fnl
[../]
[./bc_right]
type = FunctionNeumannBC
variable = u
boundary = 'right'
function = bc_fnr
[../]
[./bc_front]
type = FunctionNeumannBC
variable = u
boundary = 'front'
function = bc_fnf
[../]
[./bc_back]
type = FunctionNeumannBC
variable = u
boundary = 'back'
function = bc_fnk
[../]
[]
[Postprocessors]
[./dofs]
type = NumDOFs
[../]
[./h]
type = AverageElementSize
[../]
[./L2error]
type = ElementL2Error
variable = u
function = solution
[../]
[./H1error]
type = ElementH1Error
variable = u
function = solution
[../]
[./H1Semierror]
type = ElementH1SemiError
variable = u
function = solution
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
execute_on = 'timestep_end'
exodus = true
csv = true
[]
modules/porous_flow/test/tests/fluids/ideal_gas.i
# Example of using the IdealGasFluidPropertiesPT userobject to provide fluid
# properties for an ideal gas. Use values for hydrogen (H2) at 1 MPa and 50 C.
#
# Input values:
# Cv = 10260 J/kg/K
# Cp = 14400 J/kg/K
# M = 2.01588e-3 kg/mol
# viscosity = 9.4393e-6 Pa.s
#
# Expected output:
# density = 750.2854 kg/m^3
# internal energy = 3315.52e3 J/kg
# enthalpy = 4653.36e3 J/kg
[Mesh]
type = GeneratedMesh
dim = 1
nx = 1
[]
[GlobalParams]
PorousFlowDictator = dictator
[]
[UserObjects]
[./dictator]
type = PorousFlowDictator
porous_flow_vars = 'pp'
number_fluid_phases = 1
number_fluid_components = 1
[../]
[]
[Variables]
[./pp]
initial_condition = 1e6
[../]
[]
[Kernels]
[./dummy]
type = Diffusion
variable = pp
[../]
[]
[AuxVariables]
[./temp]
initial_condition = 50.0
[../]
[]
[Modules]
[./FluidProperties]
[./idealgas]
type = IdealGasFluidPropertiesPT
molar_mass = 2.01588e-3
cv = 10260
cp = 14400
viscosity = 9.4393e-6
[../]
[../]
[]
[Materials]
[./temperature]
type = PorousFlowTemperature
at_nodes = false
temperature = temp
[../]
[./ppss]
type = PorousFlow1PhaseFullySaturated
at_nodes = false
porepressure = pp
[../]
[./idealgass]
type = PorousFlowSingleComponentFluid
at_nodes = false
temperature_unit = Celsius
fp = idealgas
phase = 0
[../]
[]
[Executioner]
type = Steady
solve_type = Newton
[]
[Postprocessors]
[./pressure]
type = ElementIntegralVariablePostprocessor
variable = pp
[../]
[./temperature]
type = ElementIntegralVariablePostprocessor
variable = temp
[../]
[./density]
type = ElementIntegralMaterialProperty
mat_prop = 'PorousFlow_fluid_phase_density_qp0'
[../]
[./viscosity]
type = ElementIntegralMaterialProperty
mat_prop = 'PorousFlow_viscosity_qp0'
[../]
[./internal_energy]
type = ElementIntegralMaterialProperty
mat_prop = 'PorousFlow_fluid_phase_internal_energy_qp0'
[../]
[./enthalpy]
type = ElementIntegralMaterialProperty
mat_prop = 'PorousFlow_fluid_phase_enthalpy_qp0'
[../]
[]
[Outputs]
execute_on = 'timestep_end'
file_base = ideal_gas
csv = true
[]
modules/fluid_properties/test/tests/methane/methane.i
# Test MethaneFluidProperties
# Reference data from Irvine Jr, T. F. and Liley, P. E. (1984) Steam and
# Gas Tables with Computer Equations
#
# For temperature = 350K, the fluid properties should be:
# density = 55.13 kg/m^3
# viscosity = 0.01276 mPa.s
# cp = 2.375 kJ/kg/K
# h = 708.5 kJ/kg
# s = 11.30 kJ/kg/K
# c = 481.7 m/s
# k = 0.04113 W/m/K
[Mesh]
type = GeneratedMesh
dim = 2
nx = 1
ny = 1
[]
[Variables]
[./dummy]
[../]
[]
[AuxVariables]
[./pressure]
family = MONOMIAL
order = CONSTANT
initial_condition = 10.0e6
[../]
[./temperature]
family = MONOMIAL
order = CONSTANT
initial_condition = 350
[../]
[./density]
family = MONOMIAL
order = CONSTANT
[../]
[./viscosity]
family = MONOMIAL
order = CONSTANT
[../]
[./cp]
family = MONOMIAL
order = CONSTANT
[../]
[./cv]
family = MONOMIAL
order = CONSTANT
[../]
[./internal_energy]
family = MONOMIAL
order = CONSTANT
[../]
[./enthalpy]
family = MONOMIAL
order = CONSTANT
[../]
[./entropy]
family = MONOMIAL
order = CONSTANT
[../]
[./thermal_cond]
family = MONOMIAL
order = CONSTANT
[../]
[./c]
family = MONOMIAL
order = CONSTANT
[../]
[]
[AuxKernels]
[./density]
type = MaterialRealAux
variable = density
property = density
[../]
[./viscosity]
type = MaterialRealAux
variable = viscosity
property = viscosity
[../]
[./cp]
type = MaterialRealAux
variable = cp
property = cp
[../]
[./cv]
type = MaterialRealAux
variable = cv
property = cv
[../]
[./e]
type = MaterialRealAux
variable = internal_energy
property = e
[../]
[./enthalpy]
type = MaterialRealAux
variable = enthalpy
property = h
[../]
[./entropy]
type = MaterialRealAux
variable = entropy
property = s
[../]
[./thermal_cond]
type = MaterialRealAux
variable = thermal_cond
property = k
[../]
[./c]
type = MaterialRealAux
variable = c
property = c
[../]
[]
[Modules]
[./FluidProperties]
[./methane]
type = MethaneFluidProperties
[../]
[]
[]
[Materials]
[./fp_mat]
type = FluidPropertiesMaterialPT
pressure = pressure
temperature = temperature
fp = methane
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = dummy
[../]
[]
[Executioner]
type = Steady
solve_type = NEWTON
[]
[Outputs]
exodus = true
[]
test/tests/auxkernels/vectorpostprocessor/vectorpostprocessor.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[AuxVariables]
[./vpp_0]
order = CONSTANT
family = MONOMIAL
[../]
[./vpp_1]
order = CONSTANT
family = MONOMIAL
[../]
[./vpp_2]
order = CONSTANT
family = MONOMIAL
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[AuxKernels]
[./vpp_0]
type = VectorPostprocessorAux
variable = vpp_0
index = 0
vector = value
vpp = constant
[../]
[./vpp_1]
type = VectorPostprocessorAux
variable = vpp_1
index = 1
vector = value
vpp = constant
[../]
[./vpp_2]
type = VectorPostprocessorAux
variable = vpp_2
index = 2
vector = value
vpp = constant
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[VectorPostprocessors]
[./constant]
type = ConstantVectorPostprocessor
value = '1.2 3.4 9.6'
execute_on = initial
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/indicators/analytical_indicator/analytical_indicator_test.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
nz = 10
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Functions]
[./solution]
type = ParsedFunction
value = (exp(x)-1)/(exp(1)-1)
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[./conv]
type = Convection
variable = u
velocity = '1 0 0'
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Adaptivity]
[./Indicators]
[./error]
type = AnalyticalIndicator
variable = u
function = solution
[../]
[../]
[]
[Outputs]
exodus = true
[]
test/tests/mesh/distributed_generated_mesh/distributed_generated_mesh.i
# Note: The gold files for this test were generated using GeneratedMesh
[Mesh]
#type = GeneratedMesh
type = DistributedGeneratedMesh
nx = 10
ny = 10
nz = 10
dim = 3
verbose = false
[]
[Variables]
[u]
[]
[]
[AuxVariables]
[x]
[]
[]
[Kernels]
[diff]
type = Diffusion
variable = u
[]
[]
[AuxKernels]
[f]
type = FunctionAux
variable = x
function = x
[]
[]
[BCs]
[left]
type = DirichletBC
variable = u
boundary = 'left'
value = 0
[]
[right]
type = DirichletBC
variable = u
boundary = 'right'
value = 1
[]
[]
[Problem]
solve = false
type = FEProblem
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
# exodus = true
perf_graph = true
[]
modules/richards/test/tests/jacobian_1/jn03.i
# unsaturated = false
# gravity = true
# supg = false
# transient = false
[Mesh]
type = GeneratedMesh
dim = 3
nx = 1
ny = 1
nz = 1
xmin = -1
xmax = 1
ymin = -1
ymax = 1
zmin = -1
zmax = 1
[]
[GlobalParams]
richardsVarNames_UO = PPNames
[]
[UserObjects]
[./PPNames]
type = RichardsVarNames
richards_vars = pressure
[../]
[./DensityConstBulk]
type = RichardsDensityConstBulk
dens0 = 1
bulk_mod = 1.0 # notice small quantity, so the PETSc constant state works
[../]
[./SeffVG]
type = RichardsSeff1VG
m = 0.8
al = 1 # notice small quantity, so the PETSc constant state works
[../]
[./RelPermPower]
type = RichardsRelPermPower
simm = 0.2
n = 2
[../]
[./Saturation]
type = RichardsSat
s_res = 0.1
sum_s_res = 0.1
[../]
[./SUPGnone]
type = RichardsSUPGnone
[../]
[]
[Variables]
[./pressure]
order = FIRST
family = LAGRANGE
[./InitialCondition]
type = RandomIC
block = 0
min = 0
max = 1
[../]
[../]
[]
[Kernels]
active = 'richardsf'
[./richardst]
type = RichardsMassChange
variable = pressure
[../]
[./richardsf]
type = RichardsFlux
variable = pressure
[../]
[]
[Materials]
[./rock]
type = RichardsMaterial
block = 0
mat_porosity = 0.1
mat_permeability = '1E-5 0 0 0 1E-5 0 0 0 1E-5'
density_UO = DensityConstBulk
relperm_UO = RelPermPower
SUPG_UO = SUPGnone
sat_UO = Saturation
seff_UO = SeffVG
viscosity = 1E-3
gravity = '1 2 3'
linear_shape_fcns = true
[../]
[]
[Preconditioning]
[./andy]
type = SMP
full = true
petsc_options_iname = '-ksp_type -pc_type -snes_atol -snes_rtol -snes_max_it -snes_type'
petsc_options_value = 'bcgs bjacobi 1E-15 1E-10 10000 test'
[../]
[]
[Executioner]
type = Steady
solve_type = Newton
[]
[Outputs]
execute_on = 'timestep_end'
file_base = jn03
exodus = false
[]
test/tests/misc/check_error/scalar_dot_integrity_check.i
# Test that coupling a time derivative of a scalar variable (ScalarDotCouplingAux) and
# using a Steady executioner errors out
[Mesh]
type = GeneratedMesh
dim = 2
[]
[Functions]
[./a_fn]
type = ParsedFunction
value = t
[../]
[]
[AuxVariables]
[./v]
[../]
[./a]
family = SCALAR
order = FIRST
[../]
[]
[AuxScalarKernels]
[./a_sak]
type = FunctionScalarAux
variable = a
function = a_fn
[../]
[]
[AuxKernels]
[./ak_v]
type = ScalarDotCouplingAux
variable = v
v = a
[../]
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./td]
type = TimeDerivative
variable = u
[../]
[]
[Executioner]
type = Steady
[]
test/tests/auxkernels/nodal_aux_var/multi_update_var_test.i
[Mesh]
type = GeneratedMesh
dim = 2
xmin = 0
xmax = 1
ymin = 0
ymax = 1
nx = 2
ny = 2
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxVariables]
[./tt]
order = FIRST
family = LAGRANGE
initial_condition = 0
[../]
[./ten]
order = FIRST
family = LAGRANGE
initial_condition = 1
[../]
[./2k]
order = FIRST
family = LAGRANGE
initial_condition = 2
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[AuxKernels]
[./do-no-1]
variable = ten
type = SelfAux
[../]
[./do-no-2]
variable = 2k
type = SelfAux
[../]
[./all]
variable = tt
type = MultipleUpdateAux
u = u
var1 = ten
var2 = 2k
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 3
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out_multi_var
exodus = true
[]
examples/ex15_actions/ex15.i
[Mesh]
file = square.e
uniform_refine = 4
[]
[Variables]
[./convected]
order = FIRST
family = LAGRANGE
[../]
[./diffused]
order = FIRST
family = LAGRANGE
[../]
[]
#This is our new custom Convection Diffusion "Meta" block
#that adds multiple kernels into our simulation
#Convection and Diffusion kernels on the first variable
#Diffusion kernel on the second variable
#The Convection kernel is coupled to the Diffusion kernel on the second variable
[ConvectionDiffusion]
variables = 'convected diffused'
[]
[BCs]
[./left_convected]
type = DirichletBC
variable = convected
boundary = 'left'
value = 0
[../]
[./right_convected]
type = DirichletBC
variable = convected
boundary = 'right'
value = 1
some_var = diffused
[../]
[./left_diffused]
type = DirichletBC
variable = diffused
boundary = 'left'
value = 0
[../]
[./right_diffused]
type = DirichletBC
variable = diffused
boundary = 'right'
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
execute_on = 'timestep_end'
exodus = true
[]
test/tests/kernels/coupled_kernel_value/coupled_kernel_value_test.i
[Mesh]
type = GeneratedMesh
dim = 2
xmin = -1
xmax = 1
ymin = -1
ymax = 1
nx = 10
ny = 10
elem_type = QUAD9
[]
[Functions]
[./forcing_fnu]
type = ParsedFunction
value = -6*(x+y)+x*x+y*y
[../]
[./forcing_fnv]
type = ParsedFunction
value = -4+x*x*x-x+y*y*y-y
[../]
[./bc_fnut]
type = ParsedFunction
value = 3*y*y-1
[../]
[./bc_fnub]
type = ParsedFunction
value = -3*y*y+1
[../]
[./bc_fnul]
type = ParsedFunction
value = -3*x*x+1
[../]
[./bc_fnur]
type = ParsedFunction
value = 3*x*x-1
[../]
[./slnu]
type = ParsedGradFunction
value = x*x*x-x+y*y*y-y
grad_x = 3*x*x-1
grad_y = 3*y*y-1
[../]
[./slnv]
type = ParsedGradFunction
value = x*x+y*y
grad_x = 2*x
grad_y = 2*y
[../]
[]
[Variables]
[./u]
order = THIRD
family = HIERARCHIC
[../]
[./v]
order = SECOND
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff1 diff2 test1 test2 forceu forcev'
[./diff1]
type = Diffusion
variable = u
[../]
[./test1]
type = CoupledKernelValueTest
variable = u
var2 = v
[../]
[./diff2]
type = Diffusion
variable = v
[../]
[./test2]
type = CoupledKernelValueTest
variable = v
var2 = u
[../]
[./forceu]
type = BodyForce
variable = u
function = forcing_fnu
[../]
[./forcev]
type = BodyForce
variable = v
function = forcing_fnv
[../]
[]
[BCs]
# active = 'bc_u bc_v'
# [./bc_u]
# type = FunctionDirichletBC
# variable = u
# function = slnu
# boundary = 'top left right bottom'
# [../]
[./bc_ut]
type = FunctionNeumannBC
variable = u
boundary = 'top'
function = bc_fnut
[../]
[./bc_ub]
type = FunctionNeumannBC
variable = u
boundary = 'bottom'
function = bc_fnub
[../]
[./bc_ul]
type = FunctionNeumannBC
variable = u
boundary = 'left'
function = bc_fnul
[../]
[./bc_ur]
type = FunctionNeumannBC
variable = u
boundary = 'right'
function = bc_fnur
[../]
[./bc_v]
type = FunctionDirichletBC
variable = v
function = slnv
boundary = 'top left right bottom'
[../]
[]
[Preconditioning]
[./prec]
type = SMP
full = true
[../]
[]
[Postprocessors]
active='L2u L2v'
[./dofs]
type = NumDOFs
[../]
[./h]
type = AverageElementSize
[../]
[./L2u]
type = ElementL2Error
variable = u
function = slnu
[../]
[./L2v]
type = ElementL2Error
variable = v
function = slnv
[../]
[./H1error]
type = ElementH1Error
variable = u
function = solution
[../]
[./H1Semierror]
type = ElementH1SemiError
variable = u
function = solution
[../]
[]
[Executioner]
type = Steady
# petsc_options = '-snes_mf_operator'
solve_type = 'NEWTON'
nl_rel_tol = 1e-15
[]
[Outputs]
execute_on = 'timestep_end'
exodus = true
csv = true
[]
test/tests/postprocessors/mms_slope/mms_slope_test.i
[Mesh]
file = square.e
# do not use uniform refine, we are using adaptive refining
# uniform_refine = 6
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Functions]
active = 'forcing_func u_func'
[./forcing_func]
type = ParsedFunction
value = alpha*alpha*pi*pi*sin(alpha*pi*x)
vars = 'alpha'
vals = '4'
[../]
[./u_func]
type = ParsedGradFunction
value = sin(alpha*pi*x)
grad_x = alpha*pi*sin(alpha*pi*x)
vars = 'alpha'
vals = '4'
[../]
[]
[Kernels]
active = 'diff forcing'
[./diff]
type = Diffusion
variable = u
[../]
[./forcing]
type = BodyForce
variable = u
function = forcing_func
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = '1'
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = '2'
value = 0
[../]
[]
[Executioner]
type = Steady
solve_type = NEWTON
nl_abs_tol = 1e-14
[./Adaptivity]
# if the refine fraction is 1 it will refine every element
# remember < 1 means only refine that percentage of elements
refine_fraction = 1
steps = 6
# do not coarsen at all
coarsen_fraction = 0
# maximum level of refinement steps, make sure this is > max_r_steps
max_h_level = 10
# leave this as is
error_estimator = KellyErrorEstimator
[../]
[]
# print l2 and h1 errors from the Postprocessors too so I can compare
[Postprocessors]
active = 'l2_error h1_error dofs'
# active = ' '
[./l2_error]
type = ElementL2Error
variable = u
function = u_func
[../]
[./h1_error]
type = ElementH1Error
variable = u
function = u_func
[../]
[./dofs]
type = NumDOFs
[../]
[]
[Outputs]
execute_on = 'timestep_end'
file_base = out
exodus = true
[]
test/tests/preconditioners/pbp/pbp_test_options.i
[Mesh]
file = square.e
# init_unif_refine = 6
[]
[Variables]
active = 'u v'
[./u]
order = FIRST
family = LAGRANGE
[../]
[./v]
order = FIRST
family = LAGRANGE
[../]
[]
[Preconditioning]
active = 'PBP'
[./PBP]
type = PBP
solve_order = 'u v'
preconditioner = 'LU LU'
off_diag_row = 'v'
off_diag_column = 'u'
petsc_options = '' # Test petsc options in PBP block
[../]
[]
[Kernels]
active = 'diff_u conv_v diff_v'
[./diff_u]
type = Diffusion
variable = u
[../]
[./conv_v]
type = CoupledForce
variable = v
v = u
[../]
[./diff_v]
type = Diffusion
variable = v
[../]
[]
[BCs]
active = 'left_u right_u left_v'
[./left_u]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right_u]
type = DirichletBC
variable = u
boundary = 2
value = 100
[../]
[./left_v]
type = DirichletBC
variable = v
boundary = 1
value = 0
[../]
[./right_v]
type = DirichletBC
variable = v
boundary = 2
value = 0
[../]
[]
[Executioner]
type = Steady
l_max_its = 1
nl_max_its = 1
solve_type = JFNK
[]
[Outputs]
file_base = out_dummy
exodus = true
[]
test/tests/meshgenerators/sidesets_bounding_box_generator/error_no_nodes_found.i
[MeshGenerators]
[./gmg]
type = GeneratedMeshGenerator
dim = 2
nx = 10
ny = 10
#parallel_type = replicated
[]
[./createNewSidesetOne]
type = SideSetsFromBoundingBoxGenerator
input = gmg
boundary_id_old = 'right'
boundary_id_new = 11
bottom_left = '0.5 0.5 0'
top_right = '1.9 1.9 0'
block_id = 0
[]
[./createNewSidesetTwo]
type = SideSetsFromBoundingBoxGenerator
input = createNewSidesetOne
boundary_id_old = 'top right'
boundary_id_new = 10
bottom_left = '-0.1 -0.1 0'
top_right = '0.7 0.3 0'
block_id = 0
boundary_id_overlap = true
[]
[]
[Mesh]
type = MeshGeneratorMesh
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./leftBC]
type = DirichletBC
variable = u
boundary = 10
value = 1
[../]
[./rightBC]
type = DirichletBC
variable = u
boundary = 11
value = 0
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
modules/porous_flow/test/tests/fluids/h2o.i
# Test the density and viscosity calculated by the water Material
# Region 1 density
# Pressure 80 MPa
# Temperature 300K (26.85C)
# Water density should equal 1.0 / 0.971180894e-3 = 1029.7 kg/m^3 (IAPWS IF97)
# Water viscosity should equal 0.00085327 Pa.s (NIST webbook)
# Results are within expected accuracy
[Mesh]
type = GeneratedMesh
dim = 1
nx = 1
[]
[GlobalParams]
PorousFlowDictator = dictator
[]
[UserObjects]
[./dictator]
type = PorousFlowDictator
porous_flow_vars = 'pp'
number_fluid_phases = 1
number_fluid_components = 1
[../]
[]
[Variables]
[./pp]
initial_condition = 80e6
[../]
[]
[Kernels]
[./dummy]
type = Diffusion
variable = pp
[../]
[]
[AuxVariables]
[./temp]
initial_condition = 300.0
[../]
[]
[Materials]
[./temperature]
type = PorousFlowTemperature
at_nodes = false
temperature = temp
[../]
[./ppss]
type = PorousFlow1PhaseFullySaturated
at_nodes = false
porepressure = pp
[../]
[./water]
type = PorousFlowSingleComponentFluid
at_nodes = false
temperature_unit = Kelvin
fp = water
phase = 0
[../]
[]
[Modules]
[./FluidProperties]
[./water]
type = Water97FluidProperties
[../]
[../]
[]
[Executioner]
type = Steady
solve_type = Newton
[]
[Postprocessors]
[./pressure]
type = ElementIntegralVariablePostprocessor
variable = pp
[../]
[./temperature]
type = ElementIntegralVariablePostprocessor
variable = temp
[../]
[./density]
type = ElementIntegralMaterialProperty
mat_prop = 'PorousFlow_fluid_phase_density_qp0'
[../]
[./viscosity]
type = ElementIntegralMaterialProperty
mat_prop = 'PorousFlow_viscosity_qp0'
[../]
[]
[Outputs]
execute_on = 'timestep_end'
file_base = h2o
csv = true
[]
test/tests/mesh/nemesis/nemesis_repartitioning_test.i
[Mesh]
file = cylinder/cylinder.e
nemesis = true
# leaving skip_partitioning off lets us exodiff against a gold
# standard generated with default libMesh settings
# skip_partitioning = true
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Postprocessors]
[./elem_avg]
type = ElementAverageValue
variable = u
[../]
[]
[Executioner]
type = Steady
solve_type = 'NEWTON'
[./Adaptivity]
steps = 1
refine_fraction = 0.1
coarsen_fraction = 0.1
max_h_level = 2
[../]
nl_rel_tol = 1e-6
[]
[Outputs]
file_base = repartitioned
nemesis = true
[]
modules/heat_conduction/test/tests/heat_conduction/coupled_convective_heat_flux/coupled_convective_heat_flux.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Functions]
[./T_infinity_fn]
type = ParsedFunction
value = (x*x+y*y)+500
[../]
[./Hw_fn]
type = ParsedFunction
value = ((1-x)*(1-x)+(1-y)*(1-y))+1000
[../]
[]
[Variables]
[./u]
[../]
[]
[AuxVariables]
[./T_infinity]
[../]
[./Hw]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[./force]
type = BodyForce
variable = u
value = 1000
[../]
[]
[AuxKernels]
[./T_infinity_ak]
type = FunctionAux
variable = T_infinity
function = T_infinity_fn
execute_on = initial
[../]
[./Hw_ak]
type = FunctionAux
variable = Hw
function = Hw_fn
execute_on = initial
[../]
[]
[BCs]
[./right]
type = CoupledConvectiveHeatFluxBC
variable = u
boundary = right
htc = Hw
T_infinity = T_infinity
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/meshgenerators/generate_sidesets_bounding_box/error_no_side_sets_found.i
[MeshGenerators]
[./gmg]
type = GeneratedMeshGenerator
dim = 2
nx = 10
ny = 10
#parallel_type = replicated
[]
[./createNewSidesetOne]
type = SideSetsFromBoundingBoxGenerator
input = gmg
boundary_id_old = 'right'
boundary_id_new = 11
bottom_left = '-0.1 -0.1 0'
top_right = '0.9 0.9 0'
block_id = 0
[]
[]
[Mesh]
type = MeshGeneratorMesh
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./leftBC]
type = DirichletBC
variable = u
boundary = 'left'
value = 1
[../]
[./rightBC]
type = DirichletBC
variable = u
boundary = 11
value = 0
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/meshgenerators/transform_generator/rotate_and_scale.i
[MeshGenerators]
[./fmg]
type = FileMeshGenerator
file = cylinder.e
[]
[./rotate]
type = TransformGenerator
input = fmg
transform = ROTATE
vector_value = '0 90 0'
[]
[./scale]
type = TransformGenerator
input = rotate
transform = SCALE
vector_value ='1e2 1e2 1e2'
[]
[]
[Mesh]
type = MeshGeneratorMesh
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
exodus = true
[]
test/tests/outputs/oversample/oversample.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
[./out]
type = Exodus
refinements = 2
position = '1 1 0'
[../]
[]
test/tests/vectorpostprocessors/side_value_sampler/side_value_sampler.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
parallel_type = replicated
[]
[Variables]
[./u]
[../]
[./v]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[./diff_v]
type = Diffusion
variable = v
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[./left_v]
type = DirichletBC
variable = v
boundary = left
value = 1
[../]
[./right_v]
type = DirichletBC
variable = v
boundary = right
value = 0
[../]
[]
[VectorPostprocessors]
[./side_sample]
type = SideValueSampler
variable = 'u v'
boundary = top
sort_by = x
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
execute_on = 'timestep_end'
[./vpp_csv]
type = CSV
[../]
[]
test/tests/vectorpostprocessors/csv_reader/transfer/master.i
[Mesh]
type = GeneratedMesh
parallel_type = 'replicated'
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[MultiApps]
[./master]
type = FullSolveMultiApp
input_files = 'sub.i'
execute_on = initial
[../]
[]
[Transfers]
[./transfer]
type = MultiAppUserObjectTransfer
multi_app = master
direction = to_multiapp
user_object = data
variable = aux
[../]
[]
[VectorPostprocessors]
[./data]
type = CSVReader
csv_file = 'xsexample.csv'
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/auxkernels/nearest_node_value/nearest_node_value.i
[Mesh]
file = nonmatching.e
dim = 2
[]
[Variables]
[./u]
[../]
[]
[AuxVariables]
[./nearest_node_value]
block = left
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./bottom]
type = DirichletBC
variable = u
boundary = 'leftbottom rightbottom'
value = 0
[../]
[./top]
type = DirichletBC
variable = u
boundary = 'lefttop righttop'
value = 1
[../]
[]
[AuxKernels]
[./nearest_node_value]
type = NearestNodeValueAux
variable = nearest_node_value
boundary = leftright
paired_variable = u
paired_boundary = rightleft
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/mesh/centroid_partitioner/centroid_partitioner_test.i
###########################################################
# This test exercises the parallel computation aspect of
# the framework. A Centroid partitioner is used to split
# the mesh into chunks for several processors along a
# vector (y-axis).
#
# @Requirement F2.30
###########################################################
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 100
xmin = 0.0
xmax = 1.0
ymin = 0.0
ymax = 10.0
# The centroid partitioner orders elements based on
# the position of their centroids
partitioner = centroid
# This will order the elements based on the y value of
# their centroid. Perfect for meshes predominantly in
# one direction
centroid_partitioner_direction = y
# The centroid partitioner behaves differently depending on
# whether you are using Serial or DistributedMesh, so to get
# repeatable results, we restrict this test to using ReplicatedMesh.
parallel_type = replicated
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxVariables]
[./proc_id]
order = CONSTANT
family = MONOMIAL
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[AuxKernels]
[./proc_id]
type = ProcessorIDAux
variable = proc_id
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 3
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 1
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out
[./exodus]
type = Exodus
elemental_as_nodal = true
[../]
[]
test/tests/outputs/nemesis/nemesis.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
execute_on = 'timestep_end'
nemesis = true
[]
test/tests/meshgenerators/generate_bounding_box_nodeset/boundingbox_nodeset_inside.i
[MeshGenerators]
[./gmg]
type = GeneratedMeshGenerator
dim = 2
nx = 2
ny = 2
#parallel_type = replicated
[]
[./nodeset]
type = BoundingBoxNodeSetGenerator
input = gmg
new_boundary = middle_node
top_right = '1.1 1.1 0'
bottom_left = '0.49 0.49 0'
[]
[]
[Mesh]
type = MeshGeneratorMesh
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[./middle]
type = DirichletBC
variable = u
boundary = middle_node
value = -1
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
[]
[Outputs]
exodus = true
[]
modules/phase_field/test/tests/initial_conditions/ClosePackIC_3D.i
[Mesh]
type = GeneratedMesh
dim = 3
nx = 5
ny = 5
nz = 5
xmax = 0.5
ymax = .5
zmax = 0.5
uniform_refine = 3
[]
[Variables]
[./u]
[../]
[]
[AuxVariables]
[./phi]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Problem]
type = FEProblem
solve = false
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
execute_on = 'timestep_end'
exodus = true
[]
[ICs]
[./close_pack]
radius = 0.1
outvalue = 0
variable = phi
invalue = 1
type = ClosePackIC
[../]
[]
modules/fluid_properties/test/tests/brine/brine.i
# Test BrineFluidProperties calculations of density, viscosity and thermal
# conductivity
#
# Experimental density values from Pitzer et al, "Thermodynamic properties
# of aqueous sodium chloride solution", Journal of Physical and Chemical
# Reference Data, 13, 1-102 (1984)
#
# Experimental viscosity values from Phillips et al, "Viscosity of NaCl and
# other solutions up to 350C and 50MPa pressures", LBL-11586 (1980)
#
# Thermal conductivity values from Ozbek and Phillips, "Thermal conductivity of
# aqueous NaCl solutions from 20C to 330C", LBL-9086 (1980)
#
# --------------------------------------------------------------
# Pressure (Mpa) | 20 | 20 | 40
# Temperature (C) | 50 | 200 | 200
# NaCl molality (mol/kg) | 2 | 2 | 5
# NaCl mass fraction (kg/kg) | 0.1047 | 0.1047 | 0.2261
# --------------------------------------------------------------
# Expected values
# --------------------------------------------------------------
# Density (kg/m^3) | 1068.52 | 959.27 | 1065.58
# Viscosity (1e-6Pa.s) | 679.8 | 180.0 | 263.1
# Thermal conductivity (W/m/K) | 0.630 | 0.649 | 0.633
# --------------------------------------------------------------
# Calculated values
# --------------------------------------------------------------
# Density (kg/m^3) | 1067.18 | 958.68 | 1065.46
# Viscosity (1e-6 Pa.s) | 681.1 | 181.98 | 266.1
# Thermal conductivity (W/m/K) | 0.637 | 0.662 | 0.658
# --------------------------------------------------------------
#
# All results are within expected accuracy
[Mesh]
type = GeneratedMesh
dim = 2
nx = 3
ny = 1
xmax = 3
# This test uses ElementalVariableValue postprocessors on specific
# elements, so element numbering needs to stay unchanged
allow_renumbering = false
[]
[Variables]
[./dummy]
[../]
[]
[AuxVariables]
[./pressure]
family = MONOMIAL
order = CONSTANT
[../]
[./temperature]
family = MONOMIAL
order = CONSTANT
[../]
[./xnacl]
family = MONOMIAL
order = CONSTANT
[../]
[./density]
family = MONOMIAL
order = CONSTANT
[../]
[./enthalpy]
family = MONOMIAL
order = CONSTANT
[../]
[./internal_energy]
family = MONOMIAL
order = CONSTANT
[../]
[]
[Functions]
[./pic]
type = ParsedFunction
value = 'if(x<2,20e6, 40e6)'
[../]
[./tic]
type = ParsedFunction
value = 'if(x<1, 323.15, 473.15)'
[../]
[./xic]
type = ParsedFunction
value = 'if(x<2,0.1047, 0.2261)'
[../]
[]
[ICs]
[./p_ic]
type = FunctionIC
function = pic
variable = pressure
[../]
[./t_ic]
type = FunctionIC
function = tic
variable = temperature
[../]
[./x_ic]
type = FunctionIC
function = xic
variable = xnacl
[../]
[]
[AuxKernels]
[./density]
type = MaterialRealAux
variable = density
property = density
[../]
[./enthalpy]
type = MaterialRealAux
variable = enthalpy
property = enthalpy
[../]
[./internal_energy]
type = MaterialRealAux
variable = internal_energy
property = e
[../]
[]
[Modules]
[./FluidProperties]
[./brine]
type = BrineFluidProperties
[../]
[../]
[]
[Materials]
[./fp_mat]
type = MultiComponentFluidPropertiesMaterialPT
pressure = pressure
temperature = temperature
xmass = xnacl
fp = brine
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = dummy
[../]
[]
[Executioner]
type = Steady
solve_type = NEWTON
[]
[Postprocessors]
[./density0]
type = ElementalVariableValue
variable = density
elementid = 0
[../]
[./density1]
type = ElementalVariableValue
variable = density
elementid = 1
[../]
[./density2]
type = ElementalVariableValue
variable = density
elementid = 2
[../]
[./enthalpy0]
type = ElementalVariableValue
variable = enthalpy
elementid = 0
[../]
[./enthalpy1]
type = ElementalVariableValue
variable = enthalpy
elementid = 1
[../]
[./enthalpy2]
type = ElementalVariableValue
variable = enthalpy
elementid = 2
[../]
[./e0]
type = ElementalVariableValue
variable = internal_energy
elementid = 0
[../]
[./e1]
type = ElementalVariableValue
variable = internal_energy
elementid = 1
[../]
[./e2]
type = ElementalVariableValue
variable = internal_energy
elementid = 2
[../]
[]
[Outputs]
csv = true
[]
test/tests/mesh/periodic_node_map/test.i
[Mesh]
type = GeneratedMesh
nx = 4
ny = 4
nz = 4
[../]
[Variables]
[./c]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = c
[../]
[]
[BCs]
[./Periodic]
[./all]
[../]
[../]
[]
[UserObjects]
[./test]
type = PeriodicNodeMapTester
v = c
execute_on = 'INITIAL'
[../]
[]
[Executioner]
type = Steady
nl_abs_step_tol = 1e-9
[]
[Outputs]
perf_graph = true
[]
test/tests/ics/hermite_ic/hermite_ic.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
order = THIRD
family = HERMITE
[../]
[]
[Functions]
[./afunc]
type = ParsedFunction
value = x^2
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
[ICs]
[./func_ic]
function = afunc
variable = u
type = FunctionIC
[../]
[]
test/tests/mesh/gmsh_bcs/gmsh_bc_test.i
[Mesh]
file = plate_hole.msh
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 12
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 10
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
execute_on = 'timestep_end'
exodus = true
[]
test/tests/materials/derivativematerialinterface/const.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 1
ny = 1
[]
[AuxVariables]
[./dummy]
[../]
[]
[Materials]
[./provider]
type = DerivativeMaterialInterfaceTestProvider
block = 0
[../]
[./client]
type = DerivativeMaterialInterfaceTestClient
prop_name = prop
block = 0
outputs = exodus
[../]
[./client2]
type = DerivativeMaterialInterfaceTestClient
prop_name = 1.0
block = 0
outputs = exodus
[../]
[./dummy]
type = GenericConstantMaterial
prop_names = prop
block = 0
prop_values = 0
[../]
[]
[Executioner]
type = Steady
[]
[Problem]
solve = false
[]
[Outputs]
exodus = true
[]
test/tests/transfers/multiapp_copy_transfer/constant_monomial_to_sub/sub.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
family = MONOMIAL
order = CONSTANT
[../]
[]
[Problem]
type = FEProblem
solve = false
[]
[Executioner]
type = Steady
[]
[Outputs]
exodus = true
[]
modules/porous_flow/examples/flow_through_fractured_media/fine_thick_fracture_steady.i
# Using a single-dimensional mesh
# Steady-state porepressure distribution along a fracture in a porous matrix
# This is used to initialise the transient solute-transport simulation
[Mesh]
type = FileMesh
# The gold mesh is used to reduce the number of large files in the MOOSE repository.
# The porepressure is not read from the gold mesh
file = 'gold/fine_thick_fracture_steady_out.e'
block_id = '1 2 3'
block_name = 'fracture matrix1 matrix2'
boundary_id = '1 2'
boundary_name = 'bottom top'
[]
[GlobalParams]
PorousFlowDictator = dictator
gravity = '0 0 0'
[]
[Variables]
[./pp]
[../]
[]
[ICs]
[./pp]
type = ConstantIC
variable = pp
value = 1e6
[../]
[]
[BCs]
[./ptop]
type = PresetBC
variable = pp
boundary = top
value = 1e6
[../]
[./pbottom]
type = PresetBC
variable = pp
boundary = bottom
value = 1.002e6
[../]
[]
[Kernels]
[./adv0]
type = PorousFlowAdvectiveFlux
fluid_component = 0
variable = pp
[../]
[]
[UserObjects]
[./dictator]
type = PorousFlowDictator
porous_flow_vars = 'pp'
number_fluid_phases = 1
number_fluid_components = 1
[../]
[]
[Modules]
[./FluidProperties]
[./simple_fluid]
type = SimpleFluidProperties
bulk_modulus = 2e9
density0 = 1000
thermal_expansion = 0
viscosity = 1e-3
[../]
[../]
[]
[Materials]
[./temperature]
type = PorousFlowTemperature
[../]
[./ppss]
type = PorousFlow1PhaseFullySaturated
porepressure = pp
[../]
[./massfrac]
type = PorousFlowMassFraction
[../]
[./simple_fluid]
type = PorousFlowSingleComponentFluid
fp = simple_fluid
phase = 0
[../]
[./relp]
type = PorousFlowRelativePermeabilityConst
phase = 0
[../]
[./permeability1]
type = PorousFlowPermeabilityConst
permeability = '3e-8 0 0 0 3e-8 0 0 0 3e-8' # the true permeability is used without scaling by aperture
block = 'fracture'
[../]
[./permeability2]
type = PorousFlowPermeabilityConst
permeability = '1e-20 0 0 0 1e-20 0 0 0 1e-20'
block = 'matrix1 matrix2'
[../]
[]
[Preconditioning]
active = basic
[./mumps_is_best_for_parallel_jobs]
type = SMP
full = true
petsc_options_iname = '-pc_type -pc_factor_mat_solver_package'
petsc_options_value = ' lu mumps'
[../]
[./basic]
type = SMP
full = true
petsc_options_iname = '-ksp_type -pc_type -sub_pc_type -sub_pc_factor_shift_type -pc_asm_overlap'
petsc_options_value = 'gmres asm lu NONZERO 2 '
[../]
[]
[Executioner]
type = Steady
solve_type = NEWTON
# controls for nonlinear iterations
nl_abs_tol = 1e-9
nl_rel_tol = 1e-10
[]
[Outputs]
exodus = true
execute_on = 'timestep_end'
[]
modules/xfem/test/tests/single_var_constraint_2d/equal_value.i
[GlobalParams]
order = FIRST
family = LAGRANGE
[]
[Mesh]
type = GeneratedMesh
dim = 2
nx = 5
ny = 1
xmin = 0.0
xmax = 1.0
ymin = 0.0
ymax = 1.0
elem_type = QUAD4
[]
[XFEM]
qrule = volfrac
output_cut_plane = true
[]
[UserObjects]
[./line_seg_cut_uo]
type = LineSegmentCutUserObject
cut_data = '0.5 1.0 0.5 0.0'
[../]
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[Constraints]
[./xfem_constraint]
type = XFEMEqualValueAtInterface
geometric_cut_userobject = 'line_seg_cut_uo'
use_displaced_mesh = false
variable = u
value = 1
alpha = 1e5
[../]
[]
[BCs]
# Define boundary conditions
[./left_u]
type = DirichletBC
variable = u
boundary = 3
value = 1
[../]
[./right_u]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
line_search = 'none'
l_tol = 1e-3
nl_max_its = 15
nl_rel_tol = 1e-10
nl_abs_tol = 1e-10
[]
[Outputs]
interval = 1
execute_on = timestep_end
exodus = true
perf_graph = true
[./console]
type = Console
output_linear = true
[../]
[]
test/tests/mesh/custom_partitioner/custom_linear_partitioner_test.i
###########################################################
# This is a test of the custom partitioner system. It
# demonstrates the usage of a linear partitioner on the
# elements of a mesh.
#
# @Requirement F2.30
###########################################################
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 100
xmin = 0.0
xmax = 1.0
ymin = 0.0
ymax = 10.0
# Custom linear partitioner
[./Partitioner]
type = LibmeshPartitioner
partitioner = linear
[../]
parallel_type = replicated
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxVariables]
[./proc_id]
order = CONSTANT
family = MONOMIAL
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[AuxKernels]
[./proc_id]
type = ProcessorIDAux
variable = proc_id
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 3
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 1
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = custom_linear_partitioner_test_out
[./exodus]
type = Exodus
elemental_as_nodal = true
[../]
[]
modules/tensor_mechanics/test/tests/ad_elastic/green-lagrange.i
[Mesh]
type = GeneratedMesh
dim = 3
nx = 3
ny = 3
nz = 4
[]
[GlobalParams]
displacements = 'disp_x disp_y disp_z'
[]
[Variables]
[./disp_x]
[../]
[./disp_y]
[../]
[./disp_z]
[../]
[]
[ADKernels]
[./stress_x]
type = ADStressDivergenceTensors
component = 0
variable = disp_x
[../]
[./stress_y]
type = ADStressDivergenceTensors
component = 1
variable = disp_y
[../]
[./stress_z]
type = ADStressDivergenceTensors
component = 2
variable = disp_z
[../]
[]
[BCs]
[./symmy]
type = PresetBC
variable = disp_y
boundary = back
value = 0
[../]
[./symmx]
type = PresetBC
variable = disp_x
boundary = back
value = 0
[../]
[./symmz]
type = PresetBC
variable = disp_z
boundary = back
value = 0
[../]
[./tdisp]
type = PresetBC
variable = disp_z
boundary = front
value = 0.3
[../]
[]
[Materials]
[./elasticity]
type = ComputeIsotropicElasticityTensor
poissons_ratio = 0.45
youngs_modulus = 1
[../]
[]
[ADMaterials]
[./strain]
type = ADComputeGreenLagrangeStrain
[../]
[./stress]
type = ADComputeLinearElasticStress
[../]
[]
[Preconditioning]
[./smp]
type = SMP
full = true
[../]
[]
[Executioner]
type = Steady
solve_type = 'NEWTON'
[]
[Outputs]
execute_on = 'FINAL'
exodus = true
[]
test/tests/mesh/subdomain_partitioner/subdomain_partitioner.i
[Mesh]
file = test_subdomain_partitioner.e
[./Partitioner]
type = LibmeshPartitioner
partitioner = subdomain_partitioner
blocks = '1 2 3 4; 1001 1002 1003 1004'
[../]
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxVariables]
[./proc_id]
order = CONSTANT
family = MONOMIAL
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[AuxKernels]
[./proc_id]
type = ProcessorIDAux
variable = proc_id
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = subdomain_partitioner_out
[./exodus]
type = Exodus
elemental_as_nodal = true
[../]
[]
test/tests/meshgenerators/mesh_extruder_generator/extrude_angle.i
[MeshGenerators]
[./fmg]
type = FileMeshGenerator
file = chimney_quad.e
[]
[./extrude]
type = MeshExtruderGenerator
input = fmg
num_layers = 20
extrusion_vector = '1e-2 1e-2 0'
bottom_sideset = '10'
top_sideset = '20'
[]
[]
[Mesh]
type = MeshGeneratorMesh
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./bottom]
type = DirichletBC
variable = u
boundary = 10
value = 0
[../]
[./top]
type = DirichletBC
variable = u
boundary = 20
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out_quad_angle
exodus = true
[]
modules/richards/test/tests/jacobian_1/jn02.i
# unsaturated = true
# gravity = false
# supg = false
# transient = false
[Mesh]
type = GeneratedMesh
dim = 3
nx = 1
ny = 1
nz = 1
xmin = -1
xmax = 1
ymin = -1
ymax = 1
zmin = -1
zmax = 1
[]
[GlobalParams]
richardsVarNames_UO = PPNames
[]
[UserObjects]
[./PPNames]
type = RichardsVarNames
richards_vars = pressure
[../]
[./DensityConstBulk]
type = RichardsDensityConstBulk
dens0 = 1
bulk_mod = 1.0 # notice small quantity, so the PETSc constant state works
[../]
[./SeffVG]
type = RichardsSeff1VG
m = 0.8
al = 1 # notice small quantity, so the PETSc constant state works
[../]
[./RelPermPower]
type = RichardsRelPermPower
simm = 0.2
n = 2
[../]
[./Saturation]
type = RichardsSat
s_res = 0.1
sum_s_res = 0.1
[../]
[./SUPGnone]
type = RichardsSUPGnone
[../]
[]
[Variables]
[./pressure]
order = FIRST
family = LAGRANGE
[./InitialCondition]
type = RandomIC
block = 0
min = -1
max = 0
[../]
[../]
[]
[Kernels]
active = 'richardsf'
[./richardst]
type = RichardsMassChange
variable = pressure
[../]
[./richardsf]
type = RichardsFlux
variable = pressure
[../]
[]
[Materials]
[./rock]
type = RichardsMaterial
block = 0
mat_porosity = 0.1
mat_permeability = '1E-5 0 0 0 1E-5 0 0 0 1E-5'
density_UO = DensityConstBulk
relperm_UO = RelPermPower
SUPG_UO = SUPGnone
sat_UO = Saturation
seff_UO = SeffVG
viscosity = 1E-3
gravity = '0 0 0'
linear_shape_fcns = true
[../]
[]
[Preconditioning]
[./andy]
type = SMP
full = true
petsc_options_iname = '-ksp_type -pc_type -snes_atol -snes_rtol -snes_max_it -snes_type'
petsc_options_value = 'bcgs bjacobi 1E-15 1E-10 10000 test'
[../]
[]
[Executioner]
type = Steady
solve_type = Newton
[]
[Outputs]
execute_on = 'timestep_end'
file_base = jn02
exodus = false
[]
test/tests/misc/check_error/missing_var_in_kernel_test.i
[Mesh]
file = square.e
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
# Test error message for missing variable param.
[./diff]
type = Diffusion
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out
exodus = true
[]
examples/ex07_ics/steady.i
[Mesh]
file = half-cone.e
[]
[Variables]
[./diffused]
order = FIRST
family = LAGRANGE
# Use the initial Condition block underneath the variable
# for which we want to apply this initial condition
[./InitialCondition]
type = ExampleIC
coefficient = 2.0
[../]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = diffused
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = diffused
boundary = 'top'
value = 2
[../]
[./right]
type = DirichletBC
variable = diffused
boundary = 'bottom'
value = 8
[../]
[]
[Executioner]
type = Steady
#Preconditioned JFNK (default)
solve_type = 'PJFNK'
[]
[Outputs]
# Request that we output the initial condition so we can inspect
# the values with our visualization tool
exodus = true
[]
test/tests/mesh_modifiers/add_side_sets/cylinder_normals_fixed.i
[Mesh]
type = FileMesh
file = cylinder.e
# This MeshModifier currently only works with ReplicatedMesh.
# For more information, refer to #2129.
parallel_type = replicated
[]
# Mesh Modifiers
[MeshModifiers]
[./add_side_sets]
type = SideSetsFromNormals
normals = '0 1 0
0 -1 0'
new_boundary = 'front back'
# This parameter makes it so that we won't
# adjust the normal for each adjacent element.
fixed_normal = true
variance = 0.5
[../]
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./front]
type = DirichletBC
variable = u
boundary = front
value = 0
[../]
[./back]
type = DirichletBC
variable = u
boundary = back
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
modules/level_set/test/tests/kernels/advection/advection_mms.i
[Mesh]
type = GeneratedMesh
dim = 1
xmin = 0
xmax = 12
nx = 48
[]
[Adaptivity]
steps = 5
marker = marker
[./Markers]
[./marker]
type = UniformMarker
mark = REFINE
[../]
[../]
[]
[Variables]
[./phi]
[../]
[]
[AuxVariables]
[./v_x]
initial_condition = 2
[../]
[]
[BCs]
[./left]
type = FunctionDirichletBC
boundary = 'left'
function = phi_exact
variable = phi
[../]
[]
[Functions]
[./phi_exact]
type = ParsedFunction
value = 'a*sin(pi*x/b)*cos(pi*x)'
vars = 'a b'
vals = '2 12'
[../]
[./phi_mms]
type = ParsedFunction
value = '-2*pi*a*sin(pi*x)*sin(pi*x/b) + 2*pi*a*cos(pi*x)*cos(pi*x/b)/b'
vars = 'a b'
vals = '2 12'
[../]
[]
[Kernels]
[./phi_advection]
type = LevelSetAdvection
variable = phi
velocity_x = v_x
[../]
[./phi_forcing]
type = BodyForce
variable = phi
function = phi_mms
[../]
[]
[Postprocessors]
[./error]
type = ElementL2Error
function = phi_exact
variable = phi
[../]
[./h]
type = AverageElementSize
[../]
[]
[VectorPostprocessors]
active = ''
[./results]
type = LineValueSampler
variable = phi
start_point = '0 0 0'
end_point = '12 0 0'
num_points = 500
sort_by = x
[../]
[]
[Executioner]
type = Steady
nl_rel_tol = 1e-10
solve_type = NEWTON
# A steady-state pure advection problem is numerically challenging,
# it has a zero diagonal in the Jabocian matrix. The following solver
# settings seem to reliably solve this problem.
petsc_options_iname = '-pc_type -pc_factor_mat_solver_package'
petsc_options_value = 'lu superlu_dist'
[]
[Outputs]
execute_on = 'TIMESTEP_END'
csv = true
[]
test/tests/variables/multiblock_restricted_var/multiblock_restricted_var_test.i
[Mesh]
file = cake_layers.e
[]
[Variables]
[./v1]
block = 2
[../]
[./v2]
block = 4
[../]
[./w]
[../]
[]
[Kernels]
[./diff_v1]
type = Diffusion
variable = v1
block = 2
[../]
[./diff_v2]
type = Diffusion
variable = v2
block = 4
[../]
[./diff_w]
type = Diffusion
variable = w
[../]
[]
[BCs]
[./left_w]
type = DirichletBC
variable = w
boundary = left
value = 0
[../]
[./right_w]
type = DirichletBC
variable = w
boundary = right
value = 1
[../]
[./left_v1]
type = DirichletBC
variable = v1
boundary = left_bottom
value = 0
[../]
[./right_v1]
type = DirichletBC
variable = v1
boundary = right_bottom
value = 1
[../]
[./left_v2]
type = DirichletBC
variable = v2
boundary = left_top
value = 0
[../]
[./right_v2]
type = DirichletBC
variable = v2
boundary = right_top
value = 1
[../]
[]
[Preconditioning]
[./smp_full]
type = SMP
full = true
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
modules/porous_flow/test/tests/relperm/unity.i
# Test perfectly mobile relative permeability curve by varying saturation over the mesh
[Mesh]
type = GeneratedMesh
dim = 1
nx = 20
[]
[GlobalParams]
PorousFlowDictator = dictator
[]
[Variables]
[./p0]
initial_condition = 1e6
[../]
[./s1]
[../]
[]
[AuxVariables]
[./s0aux]
family = MONOMIAL
order = CONSTANT
[../]
[./s1aux]
family = MONOMIAL
order = CONSTANT
[../]
[./kr0aux]
family = MONOMIAL
order = CONSTANT
[../]
[./kr1aux]
family = MONOMIAL
order = CONSTANT
[../]
[]
[AuxKernels]
[./s0]
type = PorousFlowPropertyAux
property = saturation
phase = 0
variable = s0aux
[../]
[./s1]
type = PorousFlowPropertyAux
property = saturation
phase = 1
variable = s1aux
[../]
[./kr0]
type = PorousFlowPropertyAux
property = relperm
phase = 0
variable = kr0aux
[../]
[./kr1]
type = PorousFlowPropertyAux
property = relperm
phase = 1
variable = kr1aux
[../]
[]
[Functions]
[./s1]
type = ParsedFunction
value = x
[../]
[]
[ICs]
[./s1]
type = FunctionIC
variable = s1
function = s1
[../]
[]
[Kernels]
[./p0]
type = Diffusion
variable = p0
[../]
[./s1]
type = Diffusion
variable = s1
[../]
[]
[UserObjects]
[./dictator]
type = PorousFlowDictator
porous_flow_vars = 'p0 s1'
number_fluid_phases = 2
number_fluid_components = 2
[../]
[./pc]
type = PorousFlowCapillaryPressureConst
pc = 0
[../]
[]
[Materials]
[./temperature]
type = PorousFlowTemperature
[../]
[./ppss]
type = PorousFlow2PhasePS
phase0_porepressure = p0
phase1_saturation = s1
capillary_pressure = pc
[../]
[./kr0]
type = PorousFlowRelativePermeabilityConst
phase = 0
[../]
[./kr1]
type = PorousFlowRelativePermeabilityConst
phase = 1
[../]
[]
[VectorPostprocessors]
[./vpp]
type = LineValueSampler
variable = 's0aux s1aux kr0aux kr1aux'
start_point = '0 0 0'
end_point = '1 0 0'
num_points = 20
sort_by = id
[../]
[]
[Executioner]
type = Steady
solve_type = NEWTON
nl_abs_tol = 1e-8
[]
[BCs]
[./sleft]
type = DirichletBC
variable = s1
value = 0
boundary = left
[../]
[./sright]
type = DirichletBC
variable = s1
value = 1
boundary = right
[../]
[]
[Outputs]
csv = true
execute_on = timestep_end
[]
test/tests/misc/block_user_object_check/coupled_check.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 5
[]
[MeshModifiers]
[./left_block]
type = SubdomainBoundingBox
block_id = 1
bottom_left = '0 0 0'
top_right = '0.5 1 0'
[../]
[./right_block]
type = SubdomainBoundingBox
block_id = 2
bottom_left = '0.5 0 0'
top_right = '1 1 0'
[../]
[]
[Variables]
[./var_0]
[../]
[./var_1]
block = 1
initial_condition = 100
[../]
[./var_2]
block = 2
initial_condition = 200
[../]
[]
[Kernels]
[./obj]
type = CoupledConvection
variable = var_0
velocity_vector = var_1
#block = 1 # this is being tested
[../]
[]
[Problem]
type = FEProblem
kernel_coverage_check = true
solve = false
[]
[Executioner]
type = Steady
[]
test/tests/mesh_modifiers/add_side_sets_from_bounding_box/error_boundary_number.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
# This MeshModifier currently only works with ReplicatedMesh.
# For more information, refer to #2129.
parallel_type = replicated
[]
[MeshModifiers]
[./createNewSidesetOne]
type = AddSideSetsFromBoundingBox
boundary_id_old = 'right'
boundary_id_new = 11
bottom_left = '0.5 0.5 0'
top_right = '1.9 1.9 0'
block_id = 0
[../]
[./createNewSidesetTwo]
type = AddSideSetsFromBoundingBox
boundary_id_old = 'left'
boundary_id_new = 10
bottom_left = '-0.1 -0.1 0'
top_right = '0.3 0.3 0'
block_id = 0
boundary_id_overlap = true
[../]
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./leftBC]
type = DirichletBC
variable = u
boundary = 10
value = 1
[../]
[./rightBC]
type = DirichletBC
variable = u
boundary = 11
value = 0
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/bcs/function_dirichlet_bc/function_dirichlet_bc_test.i
###########################################################
# This is a test of Boundary Condition System. The
# FunctionDirichletBC is used to contribute the residuals
# to the boundary term operators in the weak form.
#
# @Requirement F3.40
###########################################################
[Mesh]
file = square.e
uniform_refine = 4
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Functions]
active = 'ff_1 ff_2 forcing_func bc_func'
[./ff_1]
type = ParsedFunction
value = alpha*alpha*pi
vars = 'alpha'
vals = '16'
[../]
[./ff_2]
type = ParsedFunction
value = pi*sin(alpha*pi*x)
vars = 'alpha'
vals = '16'
[../]
[./forcing_func]
type = CompositeFunction
functions = 'ff_1 ff_2'
[../]
[./bc_func]
type = ParsedFunction
value = sin(alpha*pi*x)
vars = 'alpha'
vals = '16'
[../]
[]
[Kernels]
active = 'diff forcing'
[./diff]
type = Diffusion
variable = u
[../]
[./forcing]
type = BodyForce
variable = u
function = forcing_func
[../]
[]
[BCs]
active = 'all'
# Boundary Condition System
[./all]
type = FunctionDirichletBC
variable = u
boundary = '1 2'
function = bc_func
[../]
[]
[Executioner]
type = Steady
nl_rel_tol = 1e-12
[]
[Outputs]
execute_on = 'timestep_end'
file_base = out
exodus = true
[]
test/tests/restart/restart_diffusion/exodus_refined_restart_1_test.i
[Mesh]
file = square.e
uniform_refine = 2
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = exodus_refined_restart_1
exodus = true
[]
examples/ex13_functions/ex13.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 100
ny = 100
xmin = 0.0
xmax = 1.0
ymin = 0.0
ymax = 1.0
[]
[Variables]
[./forced]
order = FIRST
family = LAGRANGE
[../]
[]
[Functions]
# A ParsedFunction allows us to supply analytic expressions
# directly in the input file
[./bc_func]
type = ParsedFunction
value = sin(alpha*pi*x)
vars = 'alpha'
vals = '16'
[../]
# This function is an actual compiled function
# We could have used ParsedFunction for this as well
[./forcing_func]
type = ExampleFunction
alpha = 16
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = forced
[../]
# This Kernel can take a function name to use
[./forcing]
type = BodyForce
variable = forced
function = forcing_func
[../]
[]
[BCs]
# The BC can take a function name to use
[./all]
type = FunctionDirichletBC
variable = forced
boundary = 'bottom right top left'
function = bc_func
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
execute_on = 'timestep_end'
exodus = true
[]
python/peacock/tests/common/simple_diffusion2.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[MeshModifiers]
[./new_block]
type = SubdomainBoundingBox
bottom_left = '0.25 0.25 0'
top_right = '0.75 0.75 0'
block_id = 1980
[../]
[]
[Variables]
[./not_u]
[../]
[]
[AuxVariables]
[./aux]
initial_condition = 1980
[../]
[./u]
initial_condition = 624
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = not_u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = not_u
boundary = left
value = 4
[../]
[./right]
type = DirichletBC
variable = not_u
boundary = right
value = 6
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
modules/combined/test/tests/eigenstrain/inclusion.i
# This test allows comparison of simulation and analytical solution for a misfitting precipitate
# using ComputeVariableEigenstrain for the simulation and the InclusionProperties material
# for the analytical solution. Increasing mesh resolution will improve agreement.
[Mesh]
type = GeneratedMesh
dim = 2
nx = 40
ny = 40
xmax = 1.5
ymax = 1.5
elem_type = QUAD4
[]
[GlobalParams]
displacements = 'disp_x disp_y'
[]
[Variables]
[./disp_x]
order = FIRST
family = LAGRANGE
[../]
[./disp_y]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./TensorMechanics]
[../]
[]
[AuxVariables]
[./s11_aux]
order = CONSTANT
family = MONOMIAL
[../]
[./s12_aux]
order = CONSTANT
family = MONOMIAL
[../]
[./s22_aux]
order = CONSTANT
family = MONOMIAL
[../]
[./s11_an]
order = CONSTANT
family = MONOMIAL
[../]
[./s12_an]
order = CONSTANT
family = MONOMIAL
[../]
[./s22_an]
order = CONSTANT
family = MONOMIAL
[../]
[./e11_aux]
order = CONSTANT
family = MONOMIAL
[../]
[./e12_aux]
order = CONSTANT
family = MONOMIAL
[../]
[./e22_aux]
order = CONSTANT
family = MONOMIAL
[../]
[./e11_an]
order = CONSTANT
family = MONOMIAL
[../]
[./e12_an]
order = CONSTANT
family = MONOMIAL
[../]
[./e22_an]
order = CONSTANT
family = MONOMIAL
[../]
[./fel_an]
order = CONSTANT
family = MONOMIAL
[../]
[./c]
[../]
[]
[AuxKernels]
[./matl_s11]
type = RankTwoAux
rank_two_tensor = stress
index_i = 0
index_j = 0
variable = s11_aux
[../]
[./matl_s12]
type = RankTwoAux
rank_two_tensor = stress
index_i = 0
index_j = 1
variable = s12_aux
[../]
[./matl_s22]
type = RankTwoAux
rank_two_tensor = stress
index_i = 1
index_j = 1
variable = s22_aux
[../]
[./matl_s11_an]
type = RankTwoAux
rank_two_tensor = stress_an
index_i = 0
index_j = 0
variable = s11_an
[../]
[./matl_s12_an]
type = RankTwoAux
rank_two_tensor = stress_an
index_i = 0
index_j = 1
variable = s12_an
[../]
[./matl_s22_an]
type = RankTwoAux
rank_two_tensor = stress_an
index_i = 1
index_j = 1
variable = s22_an
[../]
[./matl_e11]
type = RankTwoAux
rank_two_tensor = total_strain
index_i = 0
index_j = 0
variable = e11_aux
[../]
[./matl_e12]
type = RankTwoAux
rank_two_tensor = total_strain
index_i = 0
index_j = 1
variable = e12_aux
[../]
[./matl_e22]
type = RankTwoAux
rank_two_tensor = total_strain
index_i = 1
index_j = 1
variable = e22_aux
[../]
[./matl_e11_an]
type = RankTwoAux
rank_two_tensor = strain_an
index_i = 0
index_j = 0
variable = e11_an
[../]
[./matl_e12_an]
type = RankTwoAux
rank_two_tensor = strain_an
index_i = 0
index_j = 1
variable = e12_an
[../]
[./matl_e22_an]
type = RankTwoAux
rank_two_tensor = strain_an
index_i = 1
index_j = 1
variable = e22_an
[../]
[./matl_fel_an]
type = MaterialRealAux
variable = fel_an
property = fel_an_mat
[../]
[]
[Materials]
[./elasticity_tensor]
type = ComputeElasticityTensor
block = 0
C_ijkl = '1 1'
fill_method = symmetric_isotropic
[../]
[./stress]
type = ComputeLinearElasticStress
block = 0
[../]
[./var_dependence]
type = DerivativeParsedMaterial
block = 0
function = 0.005*c^2
args = c
outputs = exodus
output_properties = 'var_dep'
f_name = var_dep
enable_jit = true
derivative_order = 2
[../]
[./eigenstrain]
type = ComputeVariableEigenstrain
block = 0
eigen_base = '1 1 0 0 0 0'
prefactor = var_dep
args = c
eigenstrain_name = eigenstrain
[../]
[./strain]
type = ComputeSmallStrain
block = 0
displacements = 'disp_x disp_y'
eigenstrain_names = eigenstrain
[../]
[./analytical]
type = InclusionProperties
a = 0.1
b = 0.1
lambda = 1
mu = 1
misfit_strains = '0.005 0.005'
strain_name = strain_an
stress_name = stress_an
energy_name = fel_an_mat
[../]
[]
[BCs]
active = 'left_x bottom_y'
[./bottom_y]
type = PresetBC
variable = disp_y
boundary = bottom
value = 0
[../]
[./left_x]
type = PresetBC
variable = disp_x
boundary = left
value = 0
[../]
[]
[Preconditioning]
[./SMP]
type = SMP
full = true
[../]
[]
[Executioner]
type = Steady
solve_type = NEWTON
petsc_options_iname = '-pc_type -pc_hypre_type -ksp_gmres_restart'
petsc_options_value = 'hypre boomeramg 31'
l_max_its = 30
nl_max_its = 10
nl_rel_tol = 1.0e-10
[]
[Outputs]
exodus = true
[]
[ICs]
[./c_IC]
int_width = 0.075
x1 = 0
y1 = 0
radius = 0.1
outvalue = 0
variable = c
invalue = 1
type = SmoothCircleIC
[../]
[]
test/tests/postprocessors/element_integral/element_integral_test.i
[Mesh]
file = square.e
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Postprocessors]
[./integral]
type = ElementIntegralVariablePostprocessor
variable = u
[../]
[]
[Outputs]
file_base = out
exodus = false
csv = true
[]
test/tests/meshgenerators/generate_element_subdomain_id/quad_with_subdomainid.i
[MeshGenerators]
[./gmg]
type = GeneratedMeshGenerator
dim = 2
nx = 2
ny = 2
nz = 0
zmin = 0
zmax = 0
elem_type = QUAD4
[]
[./subdomain_id]
type = ElementSubdomainIDGenerator
input = gmg
subdomain_ids = '0 1
1 1'
[../]
[]
[Mesh]
type = MeshGeneratorMesh
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
active = 'left right'
# Mesh Generation produces boundaries in counter-clockwise fashion
[./left]
type = DirichletBC
variable = u
boundary = 3
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 1
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out_quad_subdomain_id
exodus = true
[]
test/tests/outputs/format/output_test_tecplot_binary.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
nz = 0
zmin = 0
zmax = 0
elem_type = QUAD4
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 3
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
[./out]
type = Tecplot
binary = true
[../]
[]
test/tests/userobjects/layered_side_integral/layered_side_average.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 6
ny = 6
nz = 6
[]
[Variables]
[./u]
[../]
[]
[AuxVariables]
[./layered_side_average]
order = CONSTANT
family = MONOMIAL
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./bottom]
type = DirichletBC
variable = u
boundary = bottom
value = 0
[../]
[./top]
type = DirichletBC
variable = u
boundary = top
value = 1
[../]
[]
[AuxKernels]
[./lsia]
type = SpatialUserObjectAux
variable = layered_side_average
boundary = right
user_object = layered_side_average
[../]
[]
[UserObjects]
[./layered_side_average]
type = LayeredSideAverage
direction = y
num_layers = 3
variable = u
execute_on = linear
boundary = right
[../]
[]
[Executioner]
type = Steady
[]
[Outputs]
exodus = true
[]
test/tests/misc/check_error/bad_kernel_action.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
# Note: the BadKernels syntax is set up to incorrectly call addIndicator()
# when it should actually call addKernel() to test that we can detect when
# people call the wrong FEProblem methods in their Actions.
[BadKernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/mesh/mesh_generation/disc.i
# Generates a Disc Mesh
# Radius of outside circle=5
# Solves the diffusion equation with u=-5 at origin, and u=0 on outside
[Mesh]
type = AnnularMesh
nr = 10
nt = 12
rmin = 0
rmax = 5
growth_r = 1.3
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./inner]
type = PresetBC
variable = u
value = -5.0
boundary = rmin
[../]
[./outer]
type = PresetBC
variable = u
value = 0.0
boundary = rmax
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
[]
[Outputs]
exodus = true
[]
test/tests/misc/check_error/subdomain_restricted_auxkernel_mismatch.i
[Mesh]
file = rectangle.e
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxVariables]
[./foo]
order = FIRST
family = LAGRANGE
block = 1
[../]
[]
[Kernels]
active = 'diff body_force'
[./diff]
type = Diffusion
variable = u
[../]
[./body_force]
type = BodyForce
variable = u
block = 1
value = 10
[../]
[]
[AuxKernels]
[./foo]
type = ConstantAux
variable = foo
value = 1
block = 2
[../]
[]
[BCs]
active = 'right'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 1
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
# petsc_options = '-snes_mf_operator'
# petsc_options_iname = '-pc_type -pc_hypre_type'
# petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/bcs/ad_bcs/vector_ad_bc.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
family = LAGRANGE_VEC
[../]
[]
[ADKernels]
[./diff]
type = ADVectorDiffusion
variable = u
[../]
[]
[ADBCs]
[./left]
type = ADLagrangeVecFunctionDirichletBC
variable = u
boundary = left
x_exact_soln = '1'
y_exact_soln = '1'
[../]
[./right]
type = ADVectorRobinBC
variable = u
boundary = right
[../]
[]
[Executioner]
type = Steady
solve_type = 'NEWTON'
[]
[Outputs]
exodus = true
[]
tutorials/darcy_thermo_mech/step01_diffusion/tests/bcs/diffusion/diffusion.i
[Mesh]
type = GeneratedMesh # Can generate simple lines, rectangles and rectangular prisms
dim = 2 # Dimension of the mesh
nx = 20 # Number of elements in the x direction
ny = 4 # Number of elements in the y direction
xmax = 0.304 # Length of test chamber
ymax = 0.0257 # Test chamber radius
[]
[Variables]
[./pressure]
#Adds a Linear Lagrange variable by default
[../]
[]
[Kernels]
[./diff]
type = Diffusion # A Laplacian operator
variable = pressure # Operate on the "pressure" variable from above
[../]
[]
[BCs]
[./inlet]
type = DirichletBC # Simple u=value BC
variable = pressure
boundary = left # Name of a sideset in the mesh
value = 4000 # (Pa) From Figure 2 from paper. First dot for 1mm spheres.
[../]
[./outlet]
type = DirichletBC
variable = pressure
boundary = right
value = 0 # (Pa) Gives the correct pressure drop from Figure 2 for 1mm spheres
[../]
[]
[Problem]
type = FEProblem # This is the "normal" type of Finite Element Problem in MOOSE
coord_type = RZ # Axisymmetric RZ
rz_coord_axis = X # Which axis the symmetry is around
[]
[Executioner]
type = Steady # Steady state problem
solve_type = PJFNK #Preconditioned Jacobian Free Newton Krylov
petsc_options_iname = '-pc_type -pc_hypre_type' #Matches with the values below
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true # Output Exodus format
[]
modules/porous_flow/test/tests/relperm/brooks_corey2.i
# Test Brooks-Corey relative permeability curve by varying saturation over the mesh
# Exponent lambda = 2 for both phases
# Residual saturation of phase 0: s0r = 0.2
# Residual saturation of phase 1: s1r = 0.3
[Mesh]
type = GeneratedMesh
dim = 1
nx = 20
[]
[GlobalParams]
PorousFlowDictator = dictator
[]
[Variables]
[./p0]
initial_condition = 1e6
[../]
[./s1]
[../]
[]
[AuxVariables]
[./s0aux]
family = MONOMIAL
order = CONSTANT
[../]
[./s1aux]
family = MONOMIAL
order = CONSTANT
[../]
[./kr0aux]
family = MONOMIAL
order = CONSTANT
[../]
[./kr1aux]
family = MONOMIAL
order = CONSTANT
[../]
[]
[AuxKernels]
[./s0]
type = PorousFlowPropertyAux
property = saturation
phase = 0
variable = s0aux
[../]
[./s1]
type = PorousFlowPropertyAux
property = saturation
phase = 1
variable = s1aux
[../]
[./kr0]
type = PorousFlowPropertyAux
property = relperm
phase = 0
variable = kr0aux
[../]
[./kr1]
type = PorousFlowPropertyAux
property = relperm
phase = 1
variable = kr1aux
[../]
[]
[Functions]
[./s1]
type = ParsedFunction
value = x
[../]
[]
[ICs]
[./s1]
type = FunctionIC
variable = s1
function = s1
[../]
[]
[Kernels]
[./p0]
type = Diffusion
variable = p0
[../]
[./s1]
type = Diffusion
variable = s1
[../]
[]
[UserObjects]
[./dictator]
type = PorousFlowDictator
porous_flow_vars = 'p0 s1'
number_fluid_phases = 2
number_fluid_components = 2
[../]
[./pc]
type = PorousFlowCapillaryPressureConst
pc = 0
[../]
[]
[Materials]
[./temperature]
type = PorousFlowTemperature
[../]
[./ppss]
type = PorousFlow2PhasePS
phase0_porepressure = p0
phase1_saturation = s1
capillary_pressure = pc
[../]
[./kr0]
type = PorousFlowRelativePermeabilityBC
phase = 0
lambda = 2
s_res = 0.2
sum_s_res = 0.5
[../]
[./kr1]
type = PorousFlowRelativePermeabilityBC
phase = 1
lambda = 2
nw_phase = true
s_res = 0.3
sum_s_res = 0.5
[../]
[]
[VectorPostprocessors]
[./vpp]
type = LineValueSampler
variable = 's0aux s1aux kr0aux kr1aux'
start_point = '0 0 0'
end_point = '1 0 0'
num_points = 20
sort_by = id
[../]
[]
[Executioner]
type = Steady
solve_type = NEWTON
nl_abs_tol = 1e-8
[]
[BCs]
[./sleft]
type = DirichletBC
variable = s1
value = 0
boundary = left
[../]
[./sright]
type = DirichletBC
variable = s1
value = 1
boundary = right
[../]
[]
[Outputs]
csv = true
execute_on = timestep_end
[]
test/tests/kernels/ad_simple_diffusion/ad_simple_diffusion.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[ADKernels]
[./diff]
type = ADDiffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Preconditioning]
[./smp]
type = SMP
full = true
[../]
[]
[Executioner]
type = Steady
# Preconditioned JFNK (default)
solve_type = 'Newton'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
l_tol = 1e-10
nl_rel_tol = 1e-9
nl_max_its = 1
[]
[Outputs]
exodus = true
[]
test/tests/mesh/distributed_generated_mesh_bias/distributed_generated_mesh_bias.i
inactive = 'MeshModifiers'
[Mesh]
type = DistributedGeneratedMesh
nx = 10
ny = 10
dim = 2
bias_x = 1.5
[]
[Variables]
[u]
[]
[]
[Kernels]
[diff]
type = Diffusion
variable = u
[]
[]
[BCs]
[left]
type = DirichletBC
variable = u
boundary = 'left'
value = 0
[]
[right]
type = DirichletBC
variable = u
boundary = 'right'
value = 1
[]
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
[MeshModifiers]
[]
test/tests/kernels/adv_diff_reaction/adv_diff_reaction_test.i
[Mesh]
dim = 2
file = Mesh24.e
[]
[Variables]
active = 'phi'
[./phi]
order = SECOND
family = LAGRANGE
[../]
[]
[Kernels]
active = 'advection diffusion source'
[./advection]
type = Advection0
variable = phi
Au = 10.
Bu = -6.
Cu = 5.
Av = 10.
Bv = 8.
Cv = -1.
[../]
[./diffusion]
type = Diffusion0
variable = phi
Ak = 10.
Bk = 0.1
Ck = 0.1
[../]
[./source]
type = ForcingFunctionXYZ0
variable = phi
omega0 = 2.
A0 = 1.
B0 = 1.2
C0 = 0.8
Au = 10.
Bu = -6.
Cu = 5.
Av = 10.
Bv = 8.
Cv = -1.
Ak = 10.
Bk = 0.1
Ck = 0.1
[../]
[]
[BCs]
active = 'btm_sca rgt_sca top_sca lft_sca'
[./btm_sca]
type = DirichletBCfuncXYZ0
variable = phi
boundary = 1
omega0 = 2.
A0 = 1.
B0 = 1.2
C0 = 0.8
[../]
[./rgt_sca]
type = DirichletBCfuncXYZ0
variable = phi
boundary = 2
omega0 = 2.
A0 = 1.
B0 = 1.2
C0 = 0.8
[../]
[./top_sca]
type = DirichletBCfuncXYZ0
variable = phi
boundary = 3
omega0 = 2.
A0 = 1.
B0 = 1.2
C0 = 0.8
[../]
[./lft_sca]
type = DirichletBCfuncXYZ0
variable = phi
boundary = 4
omega0 = 2.
A0 = 1.
B0 = 1.2
C0 = 0.8
[../]
[]
[Executioner]
type = Steady
nl_rel_tol = 1.e-10
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_factor_levels -pc_factor_mat_ordering_type'
petsc_options_value = 'ilu 20 rcm'
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/misc/check_error/function_file_test5.i
# Test for usage of missing function
[Mesh]
file = square.e
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[./InitialCondition]
type = FunctionIC
function = ic_function
[../]
[../]
[]
[Functions]
[./ic_function]
type = PiecewiseLinear
data_file = dummy
xy_data = '1 2'
scale_factor = 1.0
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/outputs/output_interface/indicator.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Adaptivity]
[./Indicators]
[./indicator_0]
type = GradientJumpIndicator
variable = u
outputs = indicators
[../]
[./indicator_1]
type = GradientJumpIndicator
variable = u
outputs = indicators
[../]
[../]
[]
[Outputs]
[./indicators]
type = Exodus
[../]
[./no_indicators]
type = Exodus
[../]
[]
modules/richards/test/tests/jacobian_1/jn06.i
# unsaturated = true
# gravity = false
# supg = true
# transient = false
[Mesh]
type = GeneratedMesh
dim = 3
nx = 1
ny = 1
nz = 1
xmin = -1
xmax = 1
ymin = -1
ymax = 1
zmin = -1
zmax = 1
[]
[GlobalParams]
richardsVarNames_UO = PPNames
[]
[UserObjects]
[./PPNames]
type = RichardsVarNames
richards_vars = pressure
[../]
[./DensityConstBulk]
type = RichardsDensityConstBulk
dens0 = 1
bulk_mod = 1.0 # notice small quantity, so the PETSc constant state works
[../]
[./SeffVG]
type = RichardsSeff1VG
m = 0.8
al = 1 # notice small quantity, so the PETSc constant state works
[../]
[./RelPermPower]
type = RichardsRelPermPower
simm = 0.2
n = 2
[../]
[./Saturation]
type = RichardsSat
s_res = 0.1
sum_s_res = 0.1
[../]
[./SUPGstandard]
type = RichardsSUPGstandard
p_SUPG = 0.1
[../]
[]
[Variables]
[./pressure]
order = FIRST
family = LAGRANGE
[./InitialCondition]
type = RandomIC
block = 0
min = -1
max = 0
[../]
[../]
[]
[Kernels]
active = 'richardsf'
[./richardst]
type = RichardsMassChange
variable = pressure
[../]
[./richardsf]
type = RichardsFlux
variable = pressure
[../]
[]
[Materials]
[./rock]
type = RichardsMaterial
block = 0
mat_porosity = 0.1
mat_permeability = '1E-5 0 0 0 1E-5 0 0 0 1E-5'
density_UO = DensityConstBulk
relperm_UO = RelPermPower
SUPG_UO = SUPGstandard
sat_UO = Saturation
seff_UO = SeffVG
viscosity = 1E-3
gravity = '0 0 0'
linear_shape_fcns = true
[../]
[]
[Preconditioning]
[./andy]
type = SMP
full = true
petsc_options_iname = '-ksp_type -pc_type -snes_atol -snes_rtol -snes_max_it -snes_type'
petsc_options_value = 'bcgs bjacobi 1E-15 1E-10 10000 test'
[../]
[]
[Executioner]
type = Steady
solve_type = Newton
[]
[Outputs]
execute_on = 'timestep_end'
file_base = jn06
exodus = false
[]
test/tests/outputs/tecplot/tecplot_binary.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
[./out]
type = Tecplot
binary = true
[../]
[]
test/tests/mesh_modifiers/add_side_sets_from_bounding_box/error_no_side_sets_found.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
# This MeshModifier currently only works with ReplicatedMesh.
# For more information, refer to #2129.
parallel_type = replicated
[]
[MeshModifiers]
[./createNewSidesetOne]
type = AddSideSetsFromBoundingBox
boundary_id_old = 'right'
boundary_id_new = 11
bottom_left = '-0.1 -0.1 0'
top_right = '0.9 0.9 0'
block_id = 0
[../]
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./leftBC]
type = DirichletBC
variable = u
boundary = 'left'
value = 1
[../]
[./rightBC]
type = DirichletBC
variable = u
boundary = 11
value = 0
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/kernels/material_derivatives/material_derivatives_test.i
###########################################################
# This is a test of the material derivatives test kernel.
###########################################################
[Mesh]
type = GeneratedMesh
dim = 1
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[./v]
order = FIRST
family = LAGRANGE
[../]
[]
[Functions]
[./u_IC_fn]
type = ParsedFunction
value = 'x'
[../]
[./v_IC_fn]
type = ParsedFunction
value = 'sin(x)'
[../]
[]
[ICs]
[./u_IC]
type = FunctionIC
variable = u
function = u_IC_fn
[../]
[./v_IC]
type = FunctionIC
variable = v
function = v_IC_fn
[../]
[]
[Kernels]
[./test_kernel]
type = MaterialDerivativeTestKernel
variable = u
args = 'u v'
material_property = material_derivative_test_property
[../]
# add a dummy kernel for v to prevent singular Jacobian
[./dummy_kernel]
type = Diffusion
variable = v
[../]
[]
[Materials]
[./material_derivative_test_material]
type = MaterialDerivativeTestMaterial
var1 = u
var2 = v
[../]
[]
[Preconditioning]
[./smp]
type = SMP
full = true
solve_type = newton
petsc_options_iname = '-snes_type -snes_test_err'
petsc_options_value = 'test 1e-10'
[../]
[]
[Executioner]
type = Steady
[]
test/tests/auxkernels/element_aux_var/element_high_order_aux_test.i
[Mesh]
file = square.e
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxVariables]
[./high_order]
order = NINTH
family = MONOMIAL
[../]
[./one]
order = CONSTANT
family = MONOMIAL
[../]
[]
[Kernels]
# Coupling of nonlinear to Aux
[./diff]
type = Diffusion
variable = u
[../]
[./force]
type = CoupledForce
variable = u
v = one
[../]
[]
[AuxKernels]
[./coupled_high_order]
variable = high_order
type = CoupledAux
value = 2
operator = +
coupled = u
execute_on = 'initial timestep_end'
[../]
[./constant]
variable = one
type = ConstantAux
value = 1
execute_on = 'initial timestep_end'
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Postprocessors]
[./int2_u]
type = ElementL2Norm
variable = u
execute_on = 'initial timestep_end'
[../]
[./int2_ho]
type = ElementL2Norm
variable = high_order
execute_on = 'initial timestep_end'
[../]
[./int_u]
type = ElementIntegralVariablePostprocessor
variable = u
execute_on = 'initial timestep_end'
[../]
[./int_ho]
type = ElementIntegralVariablePostprocessor
variable = high_order
execute_on = 'initial timestep_end'
[../]
[]
[Outputs]
[./ex_out]
type = Exodus
file_base = ho
elemental_as_nodal = true
[../]
[]
modules/combined/test/tests/linear_elasticity/tensor.i
# This input file is designed to test the RankTwoAux and RankFourAux
# auxkernels, which report values out of the Tensors used in materials
# properties.
[GlobalParams]
displacements = 'disp_x disp_y'
[]
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
nz = 0
xmin = 0
xmax = 2
ymin = 0
ymax = 2
zmin = 0
zmax = 0
elem_type = QUAD4
[]
[Variables]
[./diffused]
[./InitialCondition]
type = RandomIC
[../]
[../]
[./disp_x]
[../]
[./disp_y]
[../]
[]
[AuxVariables]
[./C11]
order = CONSTANT
family = MONOMIAL
[../]
[./C12]
order = CONSTANT
family = MONOMIAL
[../]
[./C13]
order = CONSTANT
family = MONOMIAL
[../]
[./C14]
order = CONSTANT
family = MONOMIAL
[../]
[./C15]
order = CONSTANT
family = MONOMIAL
[../]
[./C16]
order = CONSTANT
family = MONOMIAL
[../]
[./C22]
order = CONSTANT
family = MONOMIAL
[../]
[./C23]
order = CONSTANT
family = MONOMIAL
[../]
[./C24]
order = CONSTANT
family = MONOMIAL
[../]
[./C25]
order = CONSTANT
family = MONOMIAL
[../]
[./C26]
order = CONSTANT
family = MONOMIAL
[../]
[./C33]
order = CONSTANT
family = MONOMIAL
[../]
[./C34]
order = CONSTANT
family = MONOMIAL
[../]
[./C35]
order = CONSTANT
family = MONOMIAL
[../]
[./C36]
order = CONSTANT
family = MONOMIAL
[../]
[./C44]
order = CONSTANT
family = MONOMIAL
[../]
[./C45]
order = CONSTANT
family = MONOMIAL
[../]
[./C46]
order = CONSTANT
family = MONOMIAL
[../]
[./C55]
order = CONSTANT
family = MONOMIAL
[../]
[./C56]
order = CONSTANT
family = MONOMIAL
[../]
[./C66]
order = CONSTANT
family = MONOMIAL
[../]
[]
[Modules/TensorMechanics/Master/All]
strain = SMALL
add_variables = true
generate_output = 'stress_xx stress_yy stress_zz stress_xy stress_yz stress_zx'
[]
[Kernels]
[./diff]
type = Diffusion
variable = diffused
[../]
[]
[AuxKernels]
[./matl_C11]
type = RankFourAux
rank_four_tensor = elasticity_tensor
index_i = 0
index_j = 0
index_k = 0
index_l = 0
variable = C11
[../]
[./matl_C12]
type = RankFourAux
rank_four_tensor = elasticity_tensor
index_i = 0
index_j = 0
index_k = 1
index_l = 1
variable = C12
[../]
[./matl_C13]
type = RankFourAux
rank_four_tensor = elasticity_tensor
index_i = 0
index_j = 0
index_k = 2
index_l = 2
variable = C13
[../]
[./matl_C14]
type = RankFourAux
rank_four_tensor = elasticity_tensor
index_i = 0
index_j = 0
index_k = 1
index_l = 2
variable = C14
[../]
[./matl_C15]
type = RankFourAux
rank_four_tensor = elasticity_tensor
index_i = 0
index_j = 0
index_k = 0
index_l = 2
variable = C15
[../]
[./matl_C16]
type = RankFourAux
rank_four_tensor = elasticity_tensor
index_i = 0
index_j = 0
index_k = 0
index_l = 1
variable = C16
[../]
[./matl_C22]
type = RankFourAux
rank_four_tensor = elasticity_tensor
index_i = 1
index_j = 1
index_k = 1
index_l = 1
variable = C22
[../]
[./matl_C23]
type = RankFourAux
rank_four_tensor = elasticity_tensor
index_i = 1
index_j = 1
index_k = 2
index_l = 2
variable = C23
[../]
[./matl_C24]
type = RankFourAux
rank_four_tensor = elasticity_tensor
index_i = 1
index_j = 1
index_k = 1
index_l = 2
variable = C24
[../]
[./matl_C25]
type = RankFourAux
rank_four_tensor = elasticity_tensor
index_i = 1
index_j = 1
index_k = 0
index_l = 2
variable = C25
[../]
[./matl_C26]
type = RankFourAux
rank_four_tensor = elasticity_tensor
index_i = 1
index_j = 1
index_k = 0
index_l = 1
variable = C26
[../]
[./matl_C33]
type = RankFourAux
rank_four_tensor = elasticity_tensor
index_i = 2
index_j = 2
index_k = 2
index_l = 2
variable = C33
[../]
[./matl_C34]
type = RankFourAux
rank_four_tensor = elasticity_tensor
index_i = 2
index_j = 2
index_k = 1
index_l = 2
variable = C34
[../]
[./matl_C35]
type = RankFourAux
rank_four_tensor = elasticity_tensor
index_i = 2
index_j = 2
index_k = 0
index_l = 2
variable = C35
[../]
[./matl_C36]
type = RankFourAux
rank_four_tensor = elasticity_tensor
index_i = 2
index_j = 2
index_k = 0
index_l = 1
variable = C36
[../]
[./matl_C44]
type = RankFourAux
rank_four_tensor = elasticity_tensor
index_i = 1
index_j = 2
index_k = 1
index_l = 2
variable = C44
[../]
[./matl_C45]
type = RankFourAux
rank_four_tensor = elasticity_tensor
index_i = 1
index_j = 2
index_k = 0
index_l = 2
variable = C45
[../]
[./matl_C46]
type = RankFourAux
rank_four_tensor = elasticity_tensor
index_i = 1
index_j = 2
index_k = 0
index_l = 1
variable = C46
[../]
[./matl_C55]
type = RankFourAux
rank_four_tensor = elasticity_tensor
index_i = 0
index_j = 2
index_k = 0
index_l = 2
variable = C55
[../]
[./matl_C56]
type = RankFourAux
rank_four_tensor = elasticity_tensor
index_i = 0
index_j = 2
index_k = 0
index_l = 1
variable = C56
[../]
[./matl_C66]
type = RankFourAux
rank_four_tensor = elasticity_tensor
index_i = 0
index_j = 1
index_k = 0
index_l = 1
variable = C66
[../]
[]
[Materials]
[./elasticity_tensor]
type = ComputeElasticityTensor
fill_method = symmetric21
C_ijkl ='1111 1122 1133 1123 1113 1112 2222 2233 2223 2213 2212 3333 3323 3313 3312 2323 2313 2312 1313 1312 1212'
[../]
[./stress]
type = ComputeLinearElasticStress
[../]
[]
[BCs]
[./bottom]
type = PresetBC
variable = diffused
boundary = '1'
value = 1
[../]
[./top]
type = PresetBC
variable = diffused
boundary = '2'
value = 0
[../]
[./disp_x_BC]
type = PresetBC
variable = disp_x
boundary = '0 2'
value = 0.5
[../]
[./disp_x_BC2]
type = PresetBC
variable = disp_x
boundary = '1 3'
value = 0.01
[../]
[./disp_y_BC]
type = PresetBC
variable = disp_y
boundary = '0 2'
value = 0.8
[../]
[./disp_y_BC2]
type = PresetBC
variable = disp_y
boundary = '1 3'
value = 0.02
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
exodus = true
[]
modules/tensor_mechanics/test/tests/action/two_coord.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 16
ny = 8
xmin = -1
xmax = 1
[]
[MeshModifiers]
[./block1]
type = SubdomainBoundingBox
block_id = 1
bottom_left = '-1 0 0'
top_right = '0 1 0'
[../]
[./block2]
type = SubdomainBoundingBox
block_id = 2
bottom_left = '0 0 0'
top_right = '1 1 0'
[../]
[]
[Problem]
coord_type = 'XYZ RZ'
block = '1 2'
[]
[GlobalParams]
displacements = 'disp_x disp_y'
[]
[Modules/TensorMechanics/Master]
active = 'block1 block2'
[./error]
strain = SMALL
add_variables = true
[../]
[./block1]
strain = SMALL
add_variables = true
block = 1
[../]
[./block2]
strain = SMALL
add_variables = true
block = 2
[../]
[]
[AuxVariables]
[./vmstress]
order = CONSTANT
family = MONOMIAL
[../]
[]
[AuxKernels]
[./vmstress]
type = RankTwoScalarAux
rank_two_tensor = total_strain
variable = vmstress
scalar_type = VonMisesStress
execute_on = timestep_end
[../]
[]
[Materials]
[./elasticity_tensor]
type = ComputeIsotropicElasticityTensor
youngs_modulus = 1e10
poissons_ratio = 0.345
[../]
[./_elastic_stress]
type = ComputeLinearElasticStress
block = '1 2'
[../]
[]
[BCs]
[./topx]
type = PresetBC
boundary = 'top'
variable = disp_x
value = 0.0
[../]
[./topy]
type = PresetBC
boundary = 'top'
variable = disp_y
value = 0.0
[../]
[./bottomx]
type = PresetBC
boundary = 'bottom'
variable = disp_x
value = 0.0
[../]
[./bottomy]
type = PresetBC
boundary = 'bottom'
variable = disp_y
value = 0.05
[../]
[]
[Debug]
show_var_residual_norms = true
[]
[Executioner]
type = Steady
petsc_options_iname = '-ksp_gmres_restart -pc_type -pc_hypre_type -pc_hypre_boomeramg_max_iter'
petsc_options_value = ' 201 hypre boomeramg 10'
line_search = 'none'
nl_rel_tol = 5e-9
nl_abs_tol = 1e-10
nl_max_its = 15
l_tol = 1e-3
l_max_its = 50
[]
[Outputs]
exodus = true
[]
test/tests/preconditioners/pbp/pbp_test.i
[Mesh]
file = square.e
# init_unif_refine = 6
[]
[Variables]
active = 'u v'
[./u]
order = FIRST
family = LAGRANGE
[../]
[./v]
order = FIRST
family = LAGRANGE
[../]
[]
[Preconditioning]
active = 'PBP'
[./PBP]
type = PBP
solve_order = 'u v'
preconditioner = 'LU LU'
off_diag_row = 'v'
off_diag_column = 'u'
petsc_options = '' # Test petsc options in PBP block
[../]
[]
[Kernels]
active = 'diff_u conv_v diff_v'
[./diff_u]
type = Diffusion
variable = u
[../]
[./conv_v]
type = CoupledForce
variable = v
v = u
[../]
[./diff_v]
type = Diffusion
variable = v
[../]
[]
[BCs]
active = 'left_u right_u left_v'
[./left_u]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right_u]
type = DirichletBC
variable = u
boundary = 2
value = 100
[../]
[./left_v]
type = DirichletBC
variable = v
boundary = 1
value = 0
[../]
[./right_v]
type = DirichletBC
variable = v
boundary = 2
value = 0
[../]
[]
[Executioner]
type = Steady
l_max_its = 10
nl_max_its = 10
solve_type = JFNK
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/functions/function_ic/function_ic_test.i
[Mesh]
file = square.e
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[./InitialCondition]
type = FunctionIC
function = initial_cond_func
[../]
[../]
[]
[AuxVariables]
active = 'u_aux'
[./u_aux]
order = FIRST
family = LAGRANGE
[./InitialCondition]
type = FunctionIC
function = initial_cond_func
[../]
[../]
[]
[Functions]
[./initial_cond_func]
type = ParsedFunction
value = x+2
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
nl_rel_tol = 1e-10
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/problems/action_custom_fe_problem/action_custom_fe_problem_test.i
# This test demonstrates that a Problem can be created through an Action (possibly associated with
# special syntax), that may or may not even have a type specified.
# See the custom "TestProblem" block below.
[Mesh]
type = GeneratedMesh
dim = 2
xmin = 0
xmax = 1
ymin = 0
ymax = 1
nx = 4
ny = 4
elem_type = QUAD4
[]
[TestProblem]
# Creates a custom problem through a meta-action.
name = 'MOOSE Action Test problem'
[]
[Variables]
[u]
order = FIRST
family = LAGRANGE
[]
[]
[Kernels]
[diff]
type = Diffusion
variable = u
[]
[]
[BCs]
[left]
type = DirichletBC
variable = u
boundary = left
value = 0
[]
[right]
type = DirichletBC
variable = u
boundary = right
value = 1
[]
[]
[Executioner]
type = Steady
[]
test/tests/misc/save_in/diag_save_in_soln_var_err_test.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxVariables]
[./saved]
[../]
[./bc_saved]
[../]
[./accumulated]
[../]
[./diag_saved]
[../]
[./bc_diag_saved]
[../]
[./saved_dirichlet]
[../]
[./diag_saved_dirichlet]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
save_in = 'saved accumulated saved_dirichlet'
diag_save_in = 'u diag_saved diag_saved_dirichlet'
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
save_in = saved_dirichlet
diag_save_in = diag_saved_dirichlet
[../]
[./nbc]
type = NeumannBC
variable = u
boundary = right
value = 1
save_in = 'bc_saved accumulated'
diag_save_in = bc_diag_saved
[../]
[]
[Postprocessors]
[./left_flux]
type = NodalSum
variable = saved
boundary = 1
[../]
[./saved_norm]
type = NodalL2Norm
variable = saved
execute_on = timestep_end
block = 0
[../]
[./saved_dirichlet_norm]
type = NodalL2Norm
variable = saved_dirichlet
execute_on = timestep_end
block = 0
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/kernels/vector_fe/lagrange_vec_1d.i
# This example reproduces the libmesh vector_fe example 1 results
[Mesh]
type = GeneratedMesh
dim = 1
nx = 15
xmin = -1
elem_type = EDGE3
[]
[Variables]
[./u]
family = LAGRANGE_VEC
order = SECOND
[../]
[]
[Kernels]
[./diff]
type = VectorDiffusion
variable = u
[../]
[./body_force]
type = VectorBodyForce
variable = u
function_x = 'ffx'
[../]
[]
[BCs]
[./bnd]
type = LagrangeVecFunctionDirichletBC
variable = u
x_exact_soln = 'x_exact_sln'
boundary = 'left right'
[../]
[]
[Functions]
[./x_exact_sln]
type = ParsedFunction
value = 'cos(.5*pi*x)'
[../]
[./ffx]
type = ParsedFunction
value = '.25*pi*pi*cos(.5*pi*x)'
[../]
[]
[Preconditioning]
[./pre]
type = SMP
[../]
[]
[Executioner]
type = Steady
solve_type = NEWTON
[]
[Outputs]
exodus = true
[]
modules/stochastic_tools/test/tests/distributions/normal.i
[Mesh]
type = GeneratedMesh
dim = 1
nx = 1
ny = 1
[]
[Variables]
[./u]
[../]
[]
[Distributions]
[./normal_test]
type = NormalDistribution
mean = 0
standard_deviation = 1
[../]
[]
[Postprocessors]
[./cdf]
type = TestDistributionPostprocessor
distribution = normal_test
value = 0
method = cdf
execute_on = initial
[../]
[./pdf]
type = TestDistributionPostprocessor
distribution = normal_test
value = 0
method = pdf
execute_on = initial
[../]
[./quantile]
type = TestDistributionPostprocessor
distribution = normal_test
value = 0.5
method = quantile
execute_on = initial
[../]
[]
[Executioner]
type = Steady
[]
[Problem]
solve = false
kernel_coverage_check = false
[]
[Outputs]
execute_on = 'INITIAL'
csv = true
[]
test/tests/misc/check_error/steady_no_converge.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1e10
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
l_max_its = 10
[]
[Outputs]
exodus = true
[]
test/tests/mesh_modifiers/rename_block/rename1.i
[Mesh]
type = GeneratedMesh
dim = 3
nx = 2
ny = 2
nz = 2
xmin = -1
xmax = 1
ymin = -1
ymax = 1
zmin = -1
zmax = 1
[]
# Mesh Modifiers
[MeshModifiers]
[./sbb0]
type = SubdomainBoundingBox
block_id = 1
bottom_left = '-1 -1 -1'
top_right = '0 0 0'
[../]
[./re_id]
type = RenameBlock
old_block_id = '0 1'
new_block_id = '2 3'
depends_on = sbb0
[../]
[./rename_no_effect]
type = RenameBlock
old_block_id = '5 0 1'
new_block_name = 'five zero one'
depends_on = re_id
[../]
[./rename]
type = RenameBlock
old_block_id = '2'
new_block_name = 'two_was_zero'
depends_on = rename_no_effect
[../]
[./rename_block2]
type = RenameBlock
old_block_name = 'two_was_zero'
new_block_name = 'simply_two'
depends_on = rename
[../]
[./rename_blockID_3]
type = RenameBlock
old_block_id = '3'
new_block_name = 'three'
depends_on = rename_block2
[../]
[./three_to_4]
type = RenameBlock
old_block_name = 'three'
new_block_id = 4
depends_on = rename_blockID_3
[../]
[./another_no_effect]
type = RenameBlock
old_block_id = 3
new_block_name = 'there_is_no_block_id_3_now'
depends_on = three_to_4
[../]
[./should_not_do_anything]
type = RenameBlock
old_block_name = 'five'
new_block_id = '4'
depends_on = another_no_effect
[../]
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./bottom]
type = DirichletBC
variable = u
boundary = bottom
value = 0
[../]
[./top]
type = DirichletBC
variable = u
boundary = top
value = 0
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
modules/combined/test/tests/multiphase_mechanics/twophasestress.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 20
ny = 20
xmin = 0
xmax = 2
ymin = 0
ymax = 2
elem_type = QUAD4
[]
[GlobalParams]
displacements = 'disp_x disp_y'
[]
[Variables]
[./disp_x]
[../]
[./disp_y]
[../]
[]
[AuxVariables]
[./eta]
[./InitialCondition]
type = FunctionIC
function = 'x/2'
[../]
[../]
[./e11_aux]
order = CONSTANT
family = MONOMIAL
[../]
[]
[AuxKernels]
[./matl_e11]
type = RankTwoAux
rank_two_tensor = stress
index_i = 0
index_j = 0
variable = e11_aux
[../]
[]
[Kernels]
[./TensorMechanics]
[../]
[]
[Materials]
[./elasticity_tensor_A]
type = ComputeElasticityTensor
base_name = A
fill_method = symmetric9
C_ijkl = '1e6 1e5 1e5 1e6 0 1e6 .4e6 .2e6 .5e6'
[../]
[./strain_A]
type = ComputeSmallStrain
base_name = A
eigenstrain_names = eigenstrain
[../]
[./stress_A]
type = ComputeLinearElasticStress
base_name = A
[../]
[./eigenstrain_A]
type = ComputeEigenstrain
base_name = A
eigen_base = '0.1 0.05 0 0 0 0.01'
prefactor = -1
eigenstrain_name = eigenstrain
[../]
[./elasticity_tensor_B]
type = ComputeElasticityTensor
base_name = B
fill_method = symmetric9
C_ijkl = '1e6 0 0 1e6 0 1e6 .5e6 .5e6 .5e6'
[../]
[./strain_B]
type = ComputeSmallStrain
base_name = B
eigenstrain_names = 'B_eigenstrain'
[../]
[./stress_B]
type = ComputeLinearElasticStress
base_name = B
[../]
[./eigenstrain_B]
type = ComputeEigenstrain
base_name = B
eigen_base = '0.1 0.05 0 0 0 0.01'
prefactor = -1
eigenstrain_name = 'B_eigenstrain'
[../]
[./switching]
type = SwitchingFunctionMaterial
eta = eta
[../]
[./combined]
type = TwoPhaseStressMaterial
base_A = A
base_B = B
[../]
[]
[BCs]
[./bottom_y]
type = PresetBC
variable = disp_y
boundary = 'bottom'
value = 0
[../]
[./left_x]
type = PresetBC
variable = disp_x
boundary = 'left'
value = 0
[../]
[]
[Preconditioning]
[./SMP]
type = SMP
full = true
[../]
[]
[Executioner]
type = Steady
solve_type = 'NEWTON'
[]
[Outputs]
execute_on = 'timestep_end'
exodus = true
[]
test/tests/outputs/postprocessor/postprocessor_console.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[./v]
[../]
[]
[Kernels]
[./diff_u]
type = Diffusion
variable = u
[../]
[./diff_v]
type = CoefDiffusion
variable = v
coef = 2
[../]
[]
[BCs]
[./right_u]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[./left_u]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right_v]
type = DirichletBC
variable = v
boundary = right
value = 3
[../]
[./left_v]
type = DirichletBC
variable = v
boundary = left
value = 2
[../]
[]
[Postprocessors]
[./var1]
type = NumVars
system = 'NL'
[../]
[./var2]
type = NumVars
system = 'NL'
outputs = 'console'
execute_on = 'timestep_begin timestep_end'
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
execute_on = 'timestep_end'
csv = true
[]
test/tests/problems/no_material_coverage_check/no_material_coverage_check.i
[Mesh]
file = rectangle.e
[]
[Problem]
material_coverage_check = false
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[./body_force]
type = BodyForce
variable = u
block = 1
value = 10
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 1
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Materials]
[./mat1]
type = GenericConstantMaterial
block = 1
prop_names = 'diff1'
prop_values = '1'
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
exodus = true
[]
test/tests/outputs/exodus/exodus_input.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
[./out]
type = Exodus
execute_input_on = final
execute_on = 'initial timestep_end'
[../]
[]
test/tests/mesh/nemesis/nemesis_test.i
###########################################################
# This test exercises the parallel computation aspect of
# the framework. Seperate input mesh files are read on
# different processors and separate output files are
# produced on different processors.
#
# @Requirement P1.10
###########################################################
[Mesh]
file = cylinder/cylinder.e
nemesis = true
# This option lets us exodiff against a gold standard generated
# without repartitioning
skip_partitioning = true
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxVariables]
[./aux_elem]
order = CONSTANT
family = MONOMIAL
[../]
[./aux_nodal]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxKernels]
[./aux_elem]
type = CoupledAux
variable = aux_elem
operator = '*'
value = 1
coupled = u
[../]
[./aux_nodal]
type = CoupledAux
variable = aux_nodal
operator = '*'
value = 1
coupled = u
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Postprocessors]
[./elem_avg]
type = ElementAverageValue
variable = u
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
file_base = out
nemesis = true
[]
test/tests/auxkernels/solution_aux/aux_nonlinear_solution.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxVariables]
[./u_aux]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[AuxKernels]
[./aux_kernel]
type = FunctionAux
function = x*y
variable = u_aux
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
nl_rel_tol = 1e-10
[]
[Outputs]
exodus = true
xda = true
[./xdr]
type = XDR
[../]
[]
test/tests/outputs/console/console_no_outputs_block.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
examples/ex02_kernel/ex02_oversample.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
nz = 0
zmax = 0
elem_type = QUAD9
[]
[Variables]
[./diffused]
order = SECOND
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = diffused
[../]
[]
[DiracKernels]
[./foo]
variable = diffused
type = ConstantPointSource
value = 1
point = '0.3 0.3 0.0'
[../]
[]
[BCs]
[./all]
type = DirichletBC
variable = diffused
boundary = 'bottom left right top'
value = 0.0
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
execute_on = 'timestep_end'
exodus = true
[./refine_2]
type = Exodus
file_base = oversample_2
refinements = 2
[../]
[./refine_4]
type = Exodus
file_base = oversample_4
refinements = 4
[../]
[]
test/tests/materials/has_material/has_boundary_prop.i
[Mesh]
type = FileMesh
file = rectangle.e
[]
[Variables]
[./u]
[../]
[]
[Kernels]
active = 'u_diff'
[./u_diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 1
[../]
[./right]
type = MatTestNeumannBC
variable = u
boundary = 2
mat_prop = 'right_bc'
has_check = true
[../]
[]
[Materials]
[./right_bc]
type = GenericConstantMaterial
boundary = 2
prop_names = 'right_bc'
prop_values = '2.0'
[../]
[./other]
type = GenericConstantMaterial
boundary = 1
prop_names = 'other_value'
prop_values = '1.0'
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
execute_on = 'timestep_end'
exodus = true
[]
test/tests/misc/check_error/missing_material_prop_test2.i
[Mesh]
file = rectangle.e
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff_km_kernel]
type = DiffMKernel
variable = u
mat_prop = diff1
[../]
[./body_force]
type = BodyForce
variable = u
block = 1
value = 10
[../]
[]
[BCs]
active = 'right'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 1
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Materials]
[./mat11]
type = GenericConstantMaterial
block = 1
prop_names = 'diff1'
prop_values = '1'
[../]
[./mat12]
type = GenericConstantMaterial
block = 1
prop_names = 'diff2'
prop_values = '1'
[../]
[./mat22]
type = GenericConstantMaterial
block = 2
prop_names = 'diff2'
prop_values = '1'
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out
exodus = true
[]
[Debug]
show_material_props = true
[]
test/tests/transfers/multiapp_copy_transfer/linear_lagrange_to_sub/sub.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[Problem]
type = FEProblem
solve = false
[]
[Executioner]
type = Steady
[]
[Outputs]
exodus = true
[]
examples/ex14_pps/ex14_compare_solutions_2.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 11
ny = 11
xmin = 0.0
xmax = 1.0
ymin = 0.0
ymax = 1.0
[]
[Variables]
[./forced]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = forced
[../]
[./forcing]
type = BodyForce
variable = forced
function = 'x*x+y*y' # Any object expecting a function name can also receive a ParsedFunction string
[../]
[]
[BCs]
[./all]
type = DirichletBC
variable = forced
boundary = 'bottom right top left'
value = 0
[../]
[]
[UserObjects]
[./fine_solution]
# Read in the fine grid solution
type = SolutionUserObject
system_variables = forced
mesh = ex14_compare_solutions_1_out_0000_mesh.xda
es = ex14_compare_solutions_1_out_0000.xda
[../]
[]
[Functions]
[./fine_function]
# Create a Function out of the fine grid solution
# Note: This references the SolutionUserObject above
type = SolutionFunction
solution = fine_solution
[../]
[]
[Executioner]
type = Steady
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[./Quadrature]
# The integration of the error happens on the coarse mesh
# To reduce integration error of the finer solution we can
# raise the integration order.
# Note: This will slow down the calculation a bit
order = SIXTH
[../]
[]
[Postprocessors]
[./error]
# Compute the error between the computed solution and the fine-grid solution
type = ElementL2Error
variable = forced
function = fine_function
[../]
[]
[Outputs]
execute_on = 'timestep_end'
exodus = true
[]
test/tests/ics/check_error/two_ics_on_same_block.i
[Mesh]
type = FileMesh
file = 'rectangle.e'
[]
[Variables]
[./u]
[../]
[]
[ICs]
[./block]
type = ConstantIC
variable = u
block = 1
value = 0.5
[../]
[./block2]
type = ConstantIC
variable = u
block = 1
value = 2
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[Executioner]
type = Steady
[]
[Outputs]
[]
test/tests/markers/marker/standard_marker_test.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
nz = 0
zmin = 0
zmax = 0
elem_type = QUAD4
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Adaptivity]
[./Markers]
[./test]
type = StandardMarker
field_name = marker
indicator_field = dummy
[../]
[../]
[]
[Outputs]
file_base = out
exodus = true
[]
[Debug]
show_actions = true
[]
test/tests/variables/previous_newton_iteration/test.i
[Mesh]
type = GeneratedMesh
dim = 2
xmin = -1
xmax = 1
ymin = -1
ymax = 1
nx = 2
ny = 2
elem_type = QUAD9
[]
[Functions]
[./v_fn]
type = ParsedFunction
value = -4+(x*x+y*y)+1
[../]
[./left_u_bc_fn]
type = ParsedFunction
value = -2*x
[../]
[./top_u_bc_fn]
type = ParsedFunction
value = 2*y
[../]
[./right_u_bc_fn]
type = ParsedFunction
value = 2*x
[../]
[./bottom_u_bc_fn]
type = ParsedFunction
value = -2*y
[../]
[]
[AuxVariables]
[./a]
order = SECOND
[../]
[./v]
order = SECOND
[../]
[]
[AuxKernels]
[./ak_a]
type = QuotientAux
variable = a
numerator = v
denominator = u
[../]
[./ak_v]
type = FunctionAux
variable = v
function = v_fn
[../]
[]
[Variables]
[./u]
order = SECOND
[../]
[]
[ICs]
[./u_ic]
type = ConstantIC
variable = u
value = 1
[../]
[]
[Kernels]
[./diff_u]
type = Diffusion
variable = u
[../]
[./react]
type = Reaction
variable = u
[../]
[./cv_u]
type = CoupledForceLagged
variable = u
v = v
[../]
[]
[BCs]
[./u_bc_left]
type = FunctionNeumannBC
variable = u
boundary = 'left'
function = left_u_bc_fn
[../]
[./u_bc_top]
type = FunctionNeumannBC
variable = u
boundary = 'top'
function = top_u_bc_fn
[../]
[./u_bc_right]
type = FunctionNeumannBC
variable = u
boundary = 'right'
function = right_u_bc_fn
[../]
[./u_bc_bottom]
type = FunctionNeumannBC
variable = u
boundary = 'bottom'
function = bottom_u_bc_fn
[../]
[]
[Preconditioning]
[./pc]
type = SMP
full = true
solve_type = PJFNK
[../]
[]
[Executioner]
type = Steady
# to get multiple NL iterations
l_tol = 1e-3
nl_rel_tol = 1e-10
[]
[Outputs]
[./out]
type = Exodus
execute_on = 'nonlinear'
[../]
[]
modules/fluid_properties/test/tests/auxkernels/stagnation_temperature_aux.i
[Mesh]
type = GeneratedMesh
dim = 1
nx = 2
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxVariables]
[./specific_internal_energy]
[../]
[./specific_volume]
[../]
[./velocity]
[../]
[./stagnation_temperature]
[../]
[]
[Kernels]
[./diff_u]
type = Diffusion
variable = u
[../]
[]
[AuxKernels]
[./specific_internal_energy_ak]
type = ConstantAux
variable = specific_internal_energy
value = 1026.2e3
[../]
[./specific_volume_ak]
type = ConstantAux
variable = specific_volume
value = 0.0012192
[../]
[./velocity_ak]
type = ConstantAux
variable = velocity
value = 10.0
[../]
[./stagnation_temperature_ak]
type = StagnationTemperatureAux
variable = stagnation_temperature
e = specific_internal_energy
v = specific_volume
vel = velocity
fp = eos
[../]
[]
[Modules]
[./FluidProperties]
[./eos]
type = StiffenedGasFluidProperties
gamma = 2.35
q = -1167e3
q_prime = 0.0
p_inf = 1e9
cv = 1816.0
[../]
[]
[]
[BCs]
[./left_u]
type = DirichletBC
variable = u
boundary = 0
value = 1
[../]
[./right_u]
type = DirichletBC
variable = u
boundary = 1
value = 2
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
exodus = true
[]
modules/navier_stokes/test/tests/ins/pressure_channel/open_bc_pressure_BC_fieldSplit.i
# This input file tests Dirichlet pressure in/outflow boundary conditions for the incompressible NS equations.
[GlobalParams]
gravity = '0 0 0'
[]
[Mesh]
type = GeneratedMesh
dim = 2
xmin = 0
xmax = 3.0
ymin = 0
ymax = 1.0
nx = 30
ny = 10
elem_type = QUAD9
[]
[Variables]
[./vel_x]
order = SECOND
family = LAGRANGE
[../]
[./vel_y]
order = SECOND
family = LAGRANGE
[../]
[./p]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./mass]
type = INSMass
variable = p
u = vel_x
v = vel_y
p = p
[../]
[./x_momentum_space]
type = INSMomentumLaplaceForm
variable = vel_x
u = vel_x
v = vel_y
p = p
component = 0
integrate_p_by_parts = false
[../]
[./y_momentum_space]
type = INSMomentumLaplaceForm
variable = vel_y
u = vel_x
v = vel_y
p = p
component = 1
integrate_p_by_parts = false
[../]
[]
[BCs]
[./x_no_slip]
type = DirichletBC
variable = vel_x
boundary = 'top bottom'
value = 0.0
[../]
[./y_no_slip]
type = DirichletBC
variable = vel_y
boundary = 'left top bottom'
value = 0.0
[../]
[./inlet_p]
type = DirichletBC
variable = p
boundary = left
value = 1.0
[../]
[./outlet_p]
type = DirichletBC
variable = p
boundary = right
value = 0.0
[../]
[]
[Materials]
[./const]
type = GenericConstantMaterial
block = 0
prop_names = 'rho mu'
prop_values = '1 1'
[../]
[]
[Preconditioning]
active = FSP
[./FSP]
type = FSP
# It is the starting point of splitting
topsplit = 'up' # 'up' should match the following block name
[./up]
splitting = 'u p' # 'u' and 'p' are the names of subsolvers
splitting_type = schur
# Splitting type is set as schur, because the pressure part of Stokes-like systems
# is not diagonally dominant. CAN NOT use additive, multiplicative and etc.
# Original system:
# | A B | | u | = | f_u |
# | C 0 | | p | | f_v |
# is factorized into
# |I 0 | | A 0| | I A^{-1}B | | u | = | f_u |
# |CA^{-1} I | | 0 -S| | 0 I | | p | | f_v |
# S = CA^{-1}B
# The preconditioning is accomplished via the following steps
# (1) p^{(0)} = f_v - CA^{-1}f_u,
# (2) p = (-S)^{-1} p^{(0)}
# (3) u = A^{-1}(f_u-Bp)
petsc_options_iname = '-pc_fieldsplit_schur_fact_type -pc_fieldsplit_schur_precondition'
petsc_options_value = 'full selfp'
# Factorization type here is full, which means we approximate the original system
# exactly. There are three other options:
# diag:
# | A 0|
# | 0 -S|
# lower:
# |I 0 |
# |CA^{-1} -S |
# upper:
# | I A^{-1}B |
# | 0 -S |
# The preconditioning matrix is set as selfp, which means we explicitly form a
# matrix \hat{S} = C(diag(A))^{-1}B. We do not compute the inverse of A, but instead, we compute
# the inverse of diag(A).
[../]
[./u]
vars = 'vel_x vel_y'
# PETSc options for this subsolver
# A prefix will be applied, so just put the options for this subsolver only
petsc_options_iname = '-pc_type -ksp_type -ksp_rtol'
petsc_options_value = ' hypre gmres 1e-4'
# Specify options to solve A^{-1} in the steps (1), (2) and (3).
# Solvers for A^{-1} could be different in different steps. We could
# choose in the following pressure block.
[../]
[./p]
vars = 'p'
# PETSc options for this subsolver in the step (2)
petsc_options_iname = '-pc_type -ksp_type -ksp_rtol'
petsc_options_value = ' jacobi gmres 1e-4'
# Use -inner_ksp_type and -inner_pc_type to override A^{-1} in the step (2)
# Use -lower_ksp_type and -lower_pc_type to override A^{-1} in the step (1)
[../]
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
nl_rel_tol = 1e-12
nl_max_its = 6
l_tol = 1e-6
l_max_its = 300
[]
[Outputs]
file_base = open_bc_out_pressure_BC_fieldSplit
exodus = true
[]
test/tests/auxkernels/nodal_aux_var/multi_update_elem_var_test.i
[Mesh]
type = GeneratedMesh
dim = 2
xmin = 0
xmax = 1
ymin = 0
ymax = 1
nx = 2
ny = 2
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxVariables]
[./tt]
order = CONSTANT
family = MONOMIAL
initial_condition = 100
[../]
[./ten]
order = CONSTANT
family = MONOMIAL
initial_condition = 1
[../]
[./2k]
order = CONSTANT
family = MONOMIAL
initial_condition = 2
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[AuxKernels]
[./all]
variable = tt
type = MultipleUpdateElemAux
vars = 'ten 2k'
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 3
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out_multi_elem_var
exodus = true
[]
test/tests/dirackernels/point_caching/point_caching_adaptive_refinement.i
[Mesh]
type = GeneratedMesh
dim = 2
xmin = 0
xmax = 1
ymin = 0
ymax = 1
nx = 2
ny = 2
elem_type = QUAD4
uniform_refine = 2
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[DiracKernels]
active = 'point_source'
[./point_source]
type = CachingPointSource
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 3
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 1
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Adaptivity]
steps = 3
marker = 'combo'
[./Markers]
[./combo]
# In a real problem you would want to mark based on an error
# indicator, but we want this test to run consistently in
# parallel, so we just mark elements within a box for
# refinement. The boxes here are based on the 8x8
# uniformly-refined initial grid.
type = ComboMarker
markers = 'box1 box2 box3'
[../]
[./box1]
type = BoxMarker
bottom_left = '0.125 0.625 0'
top_right = '0.375 0.875 0'
inside = refine
outside = dont_mark
[../]
[./box2]
type = BoxMarker
bottom_left = '0.625 0.625 0'
top_right = '0.875 0.875 0'
inside = refine
outside = dont_mark
[../]
[./box3]
type = BoxMarker
bottom_left = '0.625 0.125 0'
top_right = '0.875 0.375 0'
inside = refine
outside = dont_mark
[../]
[../]
[]
[Outputs]
execute_on = 'timestep_end'
exodus = true
[]
test/tests/auxkernels/diffusion_flux/diffusion_flux.i
[Mesh]
type = GeneratedMesh # Can generate simple lines, rectangles and rectangular prisms
dim = 2 # Dimension of the mesh
nx = 10 # Number of elements in the x direction
ny = 10 # Number of elements in the y direction
xmax = 1.0
ymax = 1.0
[]
[Variables]
[./T]
[../]
[]
[AuxVariables]
[./flux_x]
order = FIRST
family = MONOMIAL
[../]
[./flux_y]
order = FIRST
family = MONOMIAL
[../]
[]
[Kernels]
[./diff]
type = MatDiffusionTest # A Laplacian operator
variable = T
prop_name = 'thermal_conductivity'
[../]
[]
[AuxKernels]
[./flux_x]
type = DiffusionFluxAux
diffusivity = 'thermal_conductivity'
variable = flux_x
diffusion_variable = T
component = x
[../]
[./flux_y]
type = DiffusionFluxAux
diffusivity = 'thermal_conductivity'
variable = flux_y
diffusion_variable = T
component = y
[../]
[]
[BCs]
[./inlet]
type = DirichletBC # Simple u=value BC
variable = T
boundary = left
value = 4000 # K
[../]
[./outlet]
type = DirichletBC
variable = T
boundary = right
value = 400 # K
[../]
[]
[Materials]
[./k]
type = GenericConstantMaterial
prop_names = 'thermal_conductivity'
prop_values = '10' # in W/mK
[../]
[]
[VectorPostprocessors]
[./line_sample]
type = LineValueSampler
variable = 'T flux_x flux_y'
start_point = '0 0. 0'
end_point = '1.0 0. 0'
num_points = 11
sort_by = id
[../]
[]
[Executioner]
type = Steady # Steady state problem
solve_type = PJFNK #Preconditioned Jacobian Free Newton Krylov
nl_rel_tol = 1e-12
petsc_options_iname = '-pc_type -pc_hypre_type' #Matches with the values below
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true # Output Exodus format
execute_on = 'initial timestep_end'
csv = true
[]
modules/functional_expansion_tools/test/tests/errors/missing_series_duo_axis.i
[Mesh]
type = GeneratedMesh
dim = 3
[]
[Functions]
[./series]
type = FunctionSeries
series_type = CylindricalDuo
orders = '0 1'
physical_bounds = '-1.0 1.0 0.0 0.0 1'
disc = Zernike
[../]
[]
[Executioner]
type = Steady
[]
[Problem]
solve = false
[]
test/tests/kernels/vector_fe/lagrange_vec.i
# This example reproduces the libmesh vector_fe example 1 results
[Mesh]
type = GeneratedMesh
dim = 2
nx = 15
ny = 15
xmin = -1
ymin = -1
elem_type = QUAD9
[]
[Variables]
[./u]
family = LAGRANGE_VEC
order = SECOND
[../]
[]
[Kernels]
[./diff]
type = VectorDiffusion
variable = u
[../]
[./body_force]
type = VectorBodyForce
variable = u
function_x = 'ffx'
function_y = 'ffy'
[../]
[]
[BCs]
[./bnd]
type = LagrangeVecFunctionDirichletBC
variable = u
x_exact_soln = 'x_exact_sln'
y_exact_soln = 'y_exact_sln'
z_exact_soln = '0'
boundary = 'left right top bottom'
[../]
[]
[Functions]
[./x_exact_sln]
type = ParsedFunction
value = 'cos(.5*pi*x)*sin(.5*pi*y)'
[../]
[./y_exact_sln]
type = ParsedFunction
value = 'sin(.5*pi*x)*cos(.5*pi*y)'
[../]
[./ffx]
type = ParsedFunction
value = '.5*pi*pi*cos(.5*pi*x)*sin(.5*pi*y)'
[../]
[./ffy]
type = ParsedFunction
value = '.5*pi*pi*sin(.5*pi*x)*cos(.5*pi*y)'
[../]
[]
[Preconditioning]
[./pre]
type = SMP
[../]
[]
[Executioner]
type = Steady
[]
[Outputs]
exodus = true
[]
test/tests/outputs/debug/show_top_residuals_nonlinear_only.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[./debug] # This is only a test, this should be turned on via the [Debug] block
type = TopResidualDebugOutput
num_residuals = 1
execute_on = nonlinear
[../]
[]
test/tests/geomsearch/2d_penetration_locator/2d_triangle.i
[Mesh]
file = nonmatching_tri.e
dim = 2
construct_side_list_from_node_list = true
[]
[Variables]
[./u]
[../]
[]
[AuxVariables]
[./gap_distance]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = leftleft
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = rightright
value = 1
[../]
[]
[AuxKernels]
[./distance]
type = PenetrationAux
variable = gap_distance
boundary = leftright
paired_boundary = rightleft
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
modules/tensor_mechanics/tutorials/basics/part_1.1.i
#Tensor Mechanics tutorial: the basics
#Step 1, part 1
#2D simulation of uniaxial tension with linear elasticity
[GlobalParams]
displacements = 'disp_x disp_y'
[]
[Mesh]
file = necking_quad4.e
[]
[Modules/TensorMechanics/Master]
[./block1]
strain = SMALL #Small linearized strain, automatically set to XY coordinates
add_variables = true #Add the variables from the displacement string in GlobalParams
[../]
[]
[Materials]
[./elasticity_tensor]
type = ComputeIsotropicElasticityTensor
youngs_modulus = 2.1e5
poissons_ratio = 0.3
[../]
[./stress]
type = ComputeLinearElasticStress
[../]
[]
[BCs]
[./left]
type = PresetBC
variable = disp_x
boundary = left
value = 0.0
[../]
[./bottom]
type = PresetBC
variable = disp_y
boundary = bottom
value = 0.0
[../]
[./top]
type = PresetBC
variable = disp_y
boundary = top
value = 0.05
[../]
[]
[Preconditioning]
[./SMP]
type = SMP
full = true
[../]
[]
[Executioner]
type = Steady
solve_type = 'NEWTON'
petsc_options = '-snes_ksp_ew'
petsc_options_iname = '-pc_type -sub_pc_type -pc_asm_overlap -ksp_gmres_restart'
petsc_options_value = 'asm lu 1 101'
[]
[Outputs]
exodus = true
perf_graph = true
[]
modules/porous_flow/test/tests/poroperm/PermFromPoro02.i
# Testing permeability from porosity
# Trivial test, checking calculated permeability is correct
# k = k_anisotropic * k0 * (1-phi0)^m/phi0^n * phi^n/(1-phi)^m
[Mesh]
type = GeneratedMesh
dim = 1
nx = 3
xmin = 0
xmax = 3
[]
[GlobalParams]
block = 0
PorousFlowDictator = dictator
[]
[Variables]
[./pp]
[./InitialCondition]
type = ConstantIC
value = 0
[../]
[../]
[]
[Kernels]
[./flux]
type = PorousFlowAdvectiveFlux
gravity = '0 0 0'
variable = pp
[../]
[]
[BCs]
[./ptop]
type = PresetBC
variable = pp
boundary = right
value = 0
[../]
[./pbase]
type = PresetBC
variable = pp
boundary = left
value = 1
[../]
[]
[AuxVariables]
[./poro]
order = CONSTANT
family = MONOMIAL
[../]
[./perm_x]
order = CONSTANT
family = MONOMIAL
[../]
[./perm_y]
order = CONSTANT
family = MONOMIAL
[../]
[./perm_z]
order = CONSTANT
family = MONOMIAL
[../]
[]
[AuxKernels]
[./poro]
type = MaterialRealAux
property = PorousFlow_porosity_qp
variable = poro
[../]
[./perm_x]
type = MaterialRealTensorValueAux
property = PorousFlow_permeability_qp
variable = perm_x
row = 0
column = 0
[../]
[./perm_y]
type = MaterialRealTensorValueAux
property = PorousFlow_permeability_qp
variable = perm_y
row = 1
column = 1
[../]
[./perm_z]
type = MaterialRealTensorValueAux
property = PorousFlow_permeability_qp
variable = perm_z
row = 2
column = 2
[../]
[]
[Postprocessors]
[./perm_x_bottom]
type = PointValue
variable = perm_x
point = '0 0 0'
[../]
[./perm_y_bottom]
type = PointValue
variable = perm_y
point = '0 0 0'
[../]
[./perm_z_bottom]
type = PointValue
variable = perm_z
point = '0 0 0'
[../]
[./perm_x_top]
type = PointValue
variable = perm_x
point = '3 0 0'
[../]
[./perm_y_top]
type = PointValue
variable = perm_y
point = '3 0 0'
[../]
[./perm_z_top]
type = PointValue
variable = perm_z
point = '3 0 0'
[../]
[]
[UserObjects]
[./dictator]
type = PorousFlowDictator
porous_flow_vars = 'pp'
number_fluid_phases = 1
number_fluid_components = 1
[../]
[./pc]
type = PorousFlowCapillaryPressureVG
# unimportant in this fully-saturated test
m = 0.8
alpha = 1e-4
[../]
[]
[Modules]
[./FluidProperties]
[./simple_fluid]
type = SimpleFluidProperties
bulk_modulus = 2.2e9
viscosity = 1e-3
density0 = 1000
thermal_expansion = 0
[../]
[../]
[]
[Materials]
[./permeability]
type = PorousFlowPermeabilityKozenyCarman
k_anisotropy = '1 0 0 0 2 0 0 0 0.1'
poroperm_function = kozeny_carman_phi0
k0 = 1e-10
phi0 = 0.05
m = 2
n = 7
[../]
[./temperature]
type = PorousFlowTemperature
[../]
[./massfrac]
type = PorousFlowMassFraction
[../]
[./eff_fluid_pressure]
type = PorousFlowEffectiveFluidPressure
[../]
[./ppss]
type = PorousFlow1PhaseP
porepressure = pp
capillary_pressure = pc
[../]
[./simple_fluid]
type = PorousFlowSingleComponentFluid
fp = simple_fluid
phase = 0
[../]
[./porosity]
type = PorousFlowPorosity
porosity_zero = 0.1
[../]
[./relperm]
type = PorousFlowRelativePermeabilityCorey
n = 0 # unimportant in this fully-saturated situation
phase = 0
[../]
[]
[Preconditioning]
[./andy]
type = SMP
full = true
[../]
[]
[Executioner]
solve_type = Newton
type = Steady
l_tol = 1E-5
nl_abs_tol = 1E-3
nl_rel_tol = 1E-8
l_max_its = 200
nl_max_its = 400
petsc_options_iname = '-pc_type -pc_asm_overlap -sub_pc_type -ksp_type -ksp_gmres_restart'
petsc_options_value = ' asm 2 lu gmres 200'
[]
[Outputs]
csv = true
execute_on = 'timestep_end'
[]
examples/ex17_dirac/ex17.i
[Mesh]
file = 3-4-torus.e
[]
[Variables]
[./diffused]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = diffused
[../]
[]
[DiracKernels]
[./example_point_source]
type = ExampleDirac
variable = diffused
value = 1.0
point = '-2.1 -5.08 0.7'
[../]
[]
[BCs]
[./right]
type = DirichletBC
variable = diffused
boundary = 'right'
value = 0
[../]
[./left]
type = DirichletBC
variable = diffused
boundary = 'left'
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
execute_on = 'timestep_end'
exodus = true
[]
test/tests/dgkernels/2d_diffusion_dg/dg_stateful.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
xmin = 0
xmax = 1
ymin = 0
ymax = 1
elem_type = QUAD4
[]
[Variables]
[./u]
order = FIRST
family = MONOMIAL
[./InitialCondition]
type = ConstantIC
value = 1
[../]
[../]
[]
[Functions]
[./forcing_fn]
type = ParsedFunction
value = 2*pow(e,-x-(y*y))*(1-2*y*y)
[../]
[./exact_fn]
type = ParsedGradFunction
value = pow(e,-x-(y*y))
grad_x = -pow(e,-x-(y*y))
grad_y = -2*y*pow(e,-x-(y*y))
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[./abs]
type = Reaction
variable = u
[../]
[./forcing]
type = BodyForce
variable = u
function = forcing_fn
[../]
[]
[DGKernels]
[./dg_diff]
type = DGDiffusion
variable = u
epsilon = -1
sigma = 6
[../]
[]
[BCs]
[./all]
type = DGFunctionDiffusionDirichletBC
variable = u
boundary = '0 1 2 3'
function = exact_fn
epsilon = -1
sigma = 6
[../]
[]
[Materials]
[./stateful]
type = StatefulMaterial
initial_diffusivity = 1
boundary = 'left'
[../]
[./general]
type = GenericConstantMaterial
block = '0'
prop_names = 'dummy'
prop_values = '1'
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
nl_rel_tol = 1e-10
[]
python/peacock/tests/input_tab/InputTree/gold/simple_diffusion_vp.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[u]
[]
[]
[Kernels]
[diff]
type = Diffusion
variable = u
[]
[]
[BCs]
[left]
type = DirichletBC
variable = u
boundary = 'left'
value = 0
[]
[right]
type = DirichletBC
variable = u
boundary = 'right'
value = 1
[]
[]
[Executioner]
# Preconditioned JFNK (default)
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
[VectorPostprocessors]
[foo]
type = LineValueSampler
num_points = 10
end_point = '1 0 0'
start_point = '0 0 0'
[]
[]
test/tests/meshgenerators/sidesets_bounding_box_generator/overlapping_sidesets_not_found.i
[MeshGenerators]
[./gmg]
type = GeneratedMeshGenerator
dim = 3
nx = 10
ny = 10
nz = 10
[]
[./createNewSidesetOne]
type = SideSetsFromBoundingBoxGenerator
input = gmg
boundary_id_old = 'bottom top'
boundary_id_new = 11
bottom_left = '-1.1 -1.1 -1.1'
top_right = '1.1 1.1 1.1'
block_id = 0
boundary_id_overlap = true
[../]
[]
[Mesh]
type = MeshGeneratorMesh
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./BCone]
type = DirichletBC
variable = u
boundary = 'left'
value = 1
[../]
[./BCtwo]
type = DirichletBC
variable = u
boundary = 11
value = 0
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
modules/richards/test/tests/gravity_head_1/gh02.i
# unsaturated = true
# gravity = false
# supg = false
# transient = false
[Mesh]
type = GeneratedMesh
dim = 1
nx = 1
xmin = -1
xmax = 1
[]
[BCs]
[./left]
type = DirichletBC
boundary = left
value = -1
variable = pressure
[../]
[]
[GlobalParams]
richardsVarNames_UO = PPNames
[]
[UserObjects]
[./PPNames]
type = RichardsVarNames
richards_vars = pressure
[../]
[./DensityConstBulk]
type = RichardsDensityConstBulk
dens0 = 1
bulk_mod = 1.0E3
[../]
[./SeffVG]
type = RichardsSeff1VG
m = 0.8
al = 1
[../]
[./RelPermPower]
type = RichardsRelPermPower
simm = 0.0
n = 2
[../]
[./Saturation]
type = RichardsSat
s_res = 0.1
sum_s_res = 0.1
[../]
[./SUPGnone]
type = RichardsSUPGnone
[../]
[]
[Variables]
[./pressure]
order = FIRST
family = LAGRANGE
[./InitialCondition]
type = RandomIC
block = 0
min = -1
max = 0
[../]
[../]
[]
[Kernels]
active = 'richardsf'
[./richardst]
type = RichardsMassChange
variable = pressure
[../]
[./richardsf]
type = RichardsFlux
variable = pressure
[../]
[]
[Materials]
[./rock]
type = RichardsMaterial
block = 0
mat_porosity = 0.1
mat_permeability = '1E-5 0 0 0 1E-5 0 0 0 1E-5'
density_UO = DensityConstBulk
relperm_UO = RelPermPower
SUPG_UO = SUPGnone
sat_UO = Saturation
seff_UO = SeffVG
viscosity = 1E-3
gravity = '0 0 0'
linear_shape_fcns = true
[../]
[]
[Preconditioning]
[./andy]
type = SMP
full = true
petsc_options_iname = '-ksp_type -pc_type -snes_atol -snes_rtol -snes_max_it'
petsc_options_value = 'bcgs bjacobi 1E-15 1E-10 10000'
[../]
[]
[Executioner]
type = Steady
solve_type = Newton
[]
[Outputs]
execute_on = 'timestep_end'
file_base = gh02
exodus = true
[]
test/tests/misc/check_error/dot_integrity_check.i
# Test that coupling a time derivative of a variable (DotCouplingKernel) and using a Steady executioner
# errors out
[Mesh]
type = GeneratedMesh
dim = 2
[]
[Variables]
[./v]
[../]
[./u]
[../]
[]
[Kernels]
[./diff_v]
type = CoefDiffusion
variable = u
coef = 0.5
[../]
[./conv_v]
type = DotCouplingKernel
variable = v
v = u
[../]
[]
[Executioner]
type = Steady
[]
modules/porous_flow/test/tests/flux_limited_TVD_pflow/except04.i
# Exception test: fe_order specified but not fe_family
[Mesh]
type = GeneratedMesh
dim = 1
[]
[GlobalParams]
gravity = '1 2 3'
PorousFlowDictator = dictator
[]
[Variables]
[./pp]
[../]
[./tracer]
[../]
[]
[Modules]
[./FluidProperties]
[./the_simple_fluid]
type = SimpleFluidProperties
[../]
[../]
[]
[PorousFlowUnsaturated]
porepressure = pp
mass_fraction_vars = tracer
fp = the_simple_fluid
[]
[UserObjects]
[./advective_flux_calculator]
type = PorousFlowAdvectiveFluxCalculatorSaturated
fe_order = First
[../]
[]
[Materials]
[./permeability]
type = PorousFlowPermeabilityConst
permeability = '1 0 0 0 2 0 0 0 3'
[../]
[]
[Executioner]
type = Steady
solve_type = Newton
[]
modules/combined/test/tests/heat_convection/heat_convection_rz_tf_test.i
# Test cases for convective boundary conditions. TKLarson, 11/01/11, rev. 0.
# Input file for htc_2dtest0
# TKLarson
# 11/01/11
# Revision 0
#
# Goals of this test are:
# 1) show that the 'fluid' temperature for convective boundary condition
# is behaving as expected/desired
# 2) show that expected results ensue from application of convective boundary conditions
# Convective boundary condition:
# q = h*A*(Tw - Tf)
# where
# q - heat transfer rate (w)
# h - heat transfer coefficient (w/m^2-K)
# A - surface area (m^2)
# Tw - surface temperature (K)
# Tf - fluid temperature adjacent to the surface (K)
# The heat transfer coefficient (h) is input as a variable called 'rate'
# Tf is a two valued function specified by 'initial' and 'final' along with a variable
# called 'duration,' the length of time in seconds that it takes initial to linearly ramp
# to 'final.'
# The mesh for this test case is based on an ASTM standard for the so-called Brazillian Cylinder test
# (ASTM International, Standard Test Method for Splitting Tensile Strength of Cylindrical Concrete
# Specimens, C 496/C 496M-04, 2004) (because I already had a version of the model). While the
# Brazillian Cylinder test is for dynamic tensile testing of concrete, the model works for the present
# purposes. The model is 2-d RZ coordinates.
#
# Brazillian Cylinder sample dimensions:
# L = 20.3 cm, 0.203 m, (8 in)
# r = 5.08 cm, 0.0508 m, (2 in)
# Material properties are:
# density = 2405.28 km/m^3
# specific heat = 826.4 J/kg-K
# thermal conductivity 1.937 w/m-K
# alpha (thermal conductivity/(density*specific heat) is then 9.74e-7 m^2/s
#
# Initial cylinder temperature is room temperature 294.26 K (70 F)
# The initial fluid temperature is room temperature. We will ramp it to 477.6 K (400 F) in 10 minutes.
# We will use a very large h (1000000) to make the surface temperature mimick the fluid temperature.
# What we expect for this problem:
# 1) Use of h = 1000000 should cause the cylinder surface temperature to track the fluid temperature
# 2) The fluid temperature should rise from initial (294.26 K) to final (477.6 K) in 600 s.
# 3) 1) and 2) should prove that the Tf boundary condition is ramping as desired.
# Note, we do the above because there is no way to plot a variable that is not on a mesh node!
[Problem]
coord_type = RZ
[]
[Mesh] # Mesh Start
# 10cm x 20cm cylinder not so detailed mesh, 2 radial, 6 axial nodes
# Only one block (Block 1), all concrete
# Sideset 1 - top of cylinder, Sideset 2 - length of cylinder, Sideset 3 - bottom of cylinder
file = heat_convection_rz_mesh.e
[] # Mesh END
[Variables] # Variables Start
[./temp]
order = FIRST
family = LAGRANGE
initial_condition = 294.26 # Initial cylinder temperature
[../]
[] # Variables END
[Kernels] # Kernels Start
[./heat]
type = HeatConduction
variable = temp
[../]
[./heat_ie]
type = HeatConductionTimeDerivative
variable = temp
[../]
[] # Kernels END
[BCs] # Boundary Conditions Start
# Heat transfer coefficient on outer cylinder radius and ends
[./convective_clad_surface] # Convective Start
type = ConvectiveFluxBC # Convective flux, e.g. q'' = h*(Tw - Tf)
boundary = '1 2 3' # BC applied on top, along length, and bottom
variable = temp
rate = 1000000. # convective heat transfer coefficient (w/m^2-K)[176000 "]
# # the above h is ~ infinity for present purposes
initial = 294.26 # initial ambient (lab or oven) temperature (K)
final = 477.6 # final ambient (lab or oven) temperature (K)
duration = 600. # length of time in seconds that it takes the ambient
# temperature to ramp from initial to final
[../] # Convective End
[] # BCs END
[Materials] # Materials Start
[./thermal]
type = HeatConductionMaterial
block = 1
specific_heat = 826.4
thermal_conductivity = 1.937 # this makes alpha 9.74e-7 m^2/s
[../]
[./density]
type = Density
block = 1
density = 2405.28
[../]
[] # Materials END
[Executioner] # Executioner Start
type = Transient
# type = Steady
#Preconditioned JFNK (default)
solve_type = 'PJFNK'
petsc_options = '-snes_ksp_ew '
petsc_options_iname = '-ksp_gmres_restart -pc_type -pc_hypre_type'
petsc_options_value = '70 hypre boomeramg'
l_max_its = 60
nl_rel_tol = 1e-8
nl_abs_tol = 1e-10
l_tol = 1e-5
start_time = 0.0
dt = 60.
num_steps = 20 # Total run time 1200 s
[] # Executioner END
[Outputs] # Output Start
# Output Start
file_base = out_rz_tf
exodus = true
[] # Output END
# # Input file END
test/tests/indicators/gradient_jump_indicator/gradient_jump_indicator_test.i
###########################################################
# This is a test of the Mesh Indicator System. It computes
# a user-defined "error" for each element in the Mesh.
#
# This test has been verified to give the same error
# calculation as the libMesh kelly_error_estimator. If
# this test is diffing... the diff is wrong!
#
# @Requirement F2.40
###########################################################
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
nz = 10
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Functions]
[./solution]
type = ParsedFunction
value = (exp(x)-1)/(exp(1)-1)
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[./conv]
type = Convection
variable = u
velocity = '1 0 0'
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
# Mesh Indicator System
[Adaptivity]
[./Indicators]
[./error]
type = GradientJumpIndicator
variable = u
[../]
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
exodus = true
[]
modules/navier_stokes/test/tests/ins/velocity_channel/velocity_inletBC_by_parts.i
# This input file tests outflow boundary conditions for the incompressible NS equations.
[GlobalParams]
gravity = '0 0 0'
integrate_p_by_parts = true
[]
[Mesh]
type = GeneratedMesh
dim = 2
xmin = 0
xmax = 3.0
ymin = 0
ymax = 1.0
nx = 30
ny = 10
elem_type = QUAD9
[]
[Variables]
[./vel_x]
order = SECOND
family = LAGRANGE
[../]
[./vel_y]
order = SECOND
family = LAGRANGE
[../]
[./p]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./mass]
type = INSMass
variable = p
u = vel_x
v = vel_y
p = p
[../]
[./x_momentum_space]
type = INSMomentumLaplaceForm
variable = vel_x
u = vel_x
v = vel_y
p = p
component = 0
[../]
[./y_momentum_space]
type = INSMomentumLaplaceForm
variable = vel_y
u = vel_x
v = vel_y
p = p
component = 1
[../]
[]
[BCs]
[./x_no_slip]
type = DirichletBC
variable = vel_x
boundary = 'top bottom'
value = 0.0
[../]
[./y_no_slip]
type = DirichletBC
variable = vel_y
boundary = 'left top bottom'
value = 0.0
[../]
[./x_inlet]
type = FunctionDirichletBC
variable = vel_x
boundary = 'left'
function = 'inlet_func'
[../]
[]
[Materials]
[./const]
type = GenericConstantMaterial
block = 0
prop_names = 'rho mu'
prop_values = '1 1'
[../]
[]
[Preconditioning]
[./SMP_PJFNK]
type = SMP
full = true
solve_type = NEWTON
[../]
[]
[Executioner]
type = Steady
petsc_options_iname = '-ksp_gmres_restart -pc_type -sub_pc_type -sub_pc_factor_levels'
petsc_options_value = '300 bjacobi ilu 4'
line_search = none
nl_rel_tol = 1e-12
nl_max_its = 6
l_tol = 1e-6
l_max_its = 300
[]
[Outputs]
[./out]
type = Exodus
[../]
[]
[Functions]
[./inlet_func]
type = ParsedFunction
value = '-4 * (y - 0.5)^2 + 1'
[../]
[]
test/tests/misc/check_error/interface_kernel_with_aux_var.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxVariables]
[./v]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[./rea]
type = Reaction
variable = u
[../]
[]
[InterfaceKernels]
[./nope]
type = InterfaceDiffusion
variable = v
neighbor_var = u
boundary = 'left'
D = 4
D_neighbor = 2
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'NEWTON'
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/userobjects/internal_side_user_object/internal_side_user_object_two_materials.i
[Mesh]
type = GeneratedMesh
dim = 2
xmin = -1
ymin = -1
xmax = 1
ymax = 1
nx = 2
ny = 2
elem_type = QUAD4
[]
[MeshModifiers]
[./subdomain_id]
type = AssignElementSubdomainID
subdomain_ids = '0 1
1 1'
[../]
[]
[Functions]
[./fn_exact]
type = ParsedFunction
value = 'x*x+y*y'
[../]
[./ffn]
type = ParsedFunction
value = -4
[../]
[]
[UserObjects]
[./isuo]
type = InsideUserObject
variable = u
diffusivity = diffusivity
execute_on = 'initial timestep_end'
[../]
[]
[Variables]
[./u]
family = LAGRANGE
order = FIRST
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[./ffn]
type = BodyForce
variable = u
function = ffn
[../]
[]
[BCs]
[./all]
type = FunctionDirichletBC
variable = u
boundary = '0 1 2 3'
function = fn_exact
[../]
[]
[Materials]
[./stateful1]
type = StatefulMaterial
block = 0
initial_diffusivity = 1
[../]
[./stateful2]
type = StatefulMaterial
block = 1
initial_diffusivity = 2
[../]
[]
[Postprocessors]
[./value]
type = InsideValuePPS
user_object = isuo
[../]
[]
[Executioner]
type = Steady
[]
[Outputs]
exodus = true
[]
test/tests/multiapps/command_line/master_wrong_size.i
[Mesh]
type = GeneratedMesh
dim = 1
[]
[Problem]
type = FEProblem
solve = false
[]
[Executioner]
type = Steady
[]
[MultiApps]
[sub]
type = FullSolveMultiApp
positions = '0 0 0
1 1 1'
input_files = 'sub.i'
cli_args = 'Mesh/xmax=1.1 Mesh/xmax=1.2 Mesh/xmax=1.3'
[]
[]
test/tests/materials/var_coupling/var_stateful_coupling.i
# Test for making sure that a coupled variable can be used inside of initQpStatefulProperties
# of a Material object.
[Mesh]
type = GeneratedMesh
dim = 2
nx = 3
ny = 3
[]
[Variables]
[./u]
[../]
[]
[ICs]
[./u_ic]
type = ConstantIC
value = 1.2345
variable = u
[../]
[]
[Materials]
[./coupling_u]
type = VarCouplingMaterial
var = u
declare_old = true
outputs = exodus
[../]
[]
[Problem]
solve = false
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
execute_on = 'TIMESTEP_END'
exodus = true
hide = 'u'
[]
test/tests/auxkernels/solution_aux/output_error.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
xmin = 1
xmax = 4
ymin = 1
ymax = 3
# This test uses SolutionUserObject which doesn't work with DistributedMesh.
parallel_type = replicated
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxVariables]
[./u_aux]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[AuxKernels]
[./initial_cond_aux]
type = SolutionAux
solution = xda_soln
execute_on = initial
variable = u_aux
[../]
[]
[UserObjects]
[./xda_soln]
type = SolutionUserObject
mesh = build_out_0001_mesh.xda
es = build_out_0001.xda
system_variables = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
nl_rel_tol = 1e-10
[]
[Outputs]
exodus = true
xda = true
[]
test/tests/interfacekernels/1d_interface/coupled_value_coupled_flux.i
[Mesh]
type = GeneratedMesh
dim = 1
nx = 10
xmax = 2
[]
[MeshModifiers]
[./subdomain1]
type = SubdomainBoundingBox
bottom_left = '1.0 0 0'
block_id = 1
top_right = '2.0 1.0 0'
[../]
[./interface]
type = SideSetsBetweenSubdomains
depends_on = subdomain1
master_block = '0'
paired_block = '1'
new_boundary = 'master0_interface'
[../]
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
block = '0'
[../]
[./v]
order = FIRST
family = LAGRANGE
block = '1'
[../]
[]
[Kernels]
[./diff_u]
type = CoeffParamDiffusion
variable = u
D = 4
block = 0
[../]
[./diff_v]
type = CoeffParamDiffusion
variable = v
D = 2
block = 1
[../]
[]
[InterfaceKernels]
active = 'interface'
[./interface]
type = InterfaceDiffusion
variable = u
neighbor_var = v
boundary = master0_interface
D = 'D'
D_neighbor = 'D'
[../]
[./penalty_interface]
type = PenaltyInterfaceDiffusion
variable = u
neighbor_var = v
boundary = master0_interface
penalty = 1e6
[../]
[]
[BCs]
active = 'left right middle'
[./left]
type = DirichletBC
variable = u
boundary = 'left'
value = 1
[../]
[./right]
type = DirichletBC
variable = v
boundary = 'right'
value = 0
[../]
[./middle]
type = MatchedValueBC
variable = v
boundary = 'master0_interface'
v = u
[../]
[]
[Materials]
[./stateful]
type = StatefulMaterial
initial_diffusivity = 1
boundary = master0_interface
[../]
[./block0]
type = GenericConstantMaterial
block = '0'
prop_names = 'D'
prop_values = '4'
[../]
[./block1]
type = GenericConstantMaterial
block = '1'
prop_names = 'D'
prop_values = '2'
[../]
[]
[Preconditioning]
[./smp]
type = SMP
full = true
[../]
[]
[Executioner]
type = Steady
solve_type = NEWTON
[]
[Outputs]
exodus = true
print_linear_residuals = true
[]
[Debug]
show_var_residual_norms = true
[]
test/tests/meshgenerators/sidesets_bounding_box_generator/multiple_boundary_ids_3d.i
[MeshGenerators]
[./gmg]
type = GeneratedMeshGenerator
dim = 3
nx = 10
ny = 10
nz = 10
#parallel_type = replicated
[]
[./createNewSidesetOne]
type = SideSetsFromBoundingBoxGenerator
input = gmg
boundary_id_old = 'left bottom front'
boundary_id_new = 10
bottom_left = '-0.1 -0.1 -0.1'
top_right = '0.1 0.2 0.3'
block_id = 0
[]
[./createNewSidesetTwo]
type = SideSetsFromBoundingBoxGenerator
input = createNewSidesetOne
boundary_id_old = 'right top back'
boundary_id_new = 11
bottom_left = '0.6 0.7 0.8'
top_right = '1.1 1.1 1.1'
block_id = 0
[]
[./createNewSidesetThree]
type = SideSetsFromBoundingBoxGenerator
input = createNewSidesetTwo
boundary_id_old = 'left top back'
boundary_id_new = 12
bottom_left = '-0.1 0.9 0.9'
top_right = '0.1 1.1 1.1'
block_id = 0
[]
[./createNewSidesetFour]
type = SideSetsFromBoundingBoxGenerator
input = createNewSidesetThree
boundary_id_old = 'front'
boundary_id_new = 13
bottom_left = '0.4 0.4 0.9'
top_right = '0.6 0.6 1.1'
block_id = 0
[../]
[]
[Mesh]
type = MeshGeneratorMesh
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./firstBC]
type = DirichletBC
variable = u
boundary = 10
value = 1
[../]
[./secondBC]
type = DirichletBC
variable = u
boundary = 11
value = 0
[../]
[./thirdBC]
type = DirichletBC
variable = u
boundary = 12
value = 0
[../]
[./fourthBC]
type = DirichletBC
variable = u
boundary = 13
value = 0.5
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/functions/solution_function/solution_function_grad_p2.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
xmin = 0.0
xmax = 1.0
ymin = 0.0
ymax = 1.0
parallel_type = replicated
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxVariables]
[./test_variable_x]
order = FIRST
family = LAGRANGE
[../]
[./test_variable_y]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxKernels]
[./test_variable_x_aux]
type = FunctionGradAux
variable = test_variable_x
dimension_index = x
function = solution_function
[../]
[./test_variable_y_aux]
type = FunctionGradAux
variable = test_variable_y
dimension_index = y
function = solution_function
[../]
[]
[UserObjects]
[./ex_soln]
type = SolutionUserObject
system_variables = test_variable
mesh = solution_function_grad_p1.e
[../]
[]
[Functions]
[./solution_function]
type = SolutionFunction
solution = ex_soln
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
nl_rel_tol = 1e-10
[]
[Outputs]
file_base = solution_function_grad_p2
exodus = true
[]
test/tests/mesh/high_order_elems/high_order_elems.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
modules/combined/test/tests/nodal_area/nodal_area_3D.i
[Mesh]
file = nodal_area_3D.e
[]
[Variables]
[./dummy]
[../]
[]
[AuxVariables]
[./nodal_area]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./dummy]
type = Diffusion
variable = dummy
[../]
[]
[UserObjects]
[./nodal_area]
type = NodalArea
variable = nodal_area
boundary = 1
execute_on = 'initial timestep_end'
[../]
[]
[BCs]
[./dummy]
type = DirichletBC
variable = dummy
boundary = 1
value = 100
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -ksp_gmres_restart'
petsc_options_value = 'jacobi 101'
line_search = 'none'
nl_abs_tol = 1e-11
nl_rel_tol = 1e-10
l_max_its = 20
[]
[Outputs]
exodus = true
[]
test/tests/problems/eigen_problem/ne_coupled_picard_sub.i
[Mesh]
type = GeneratedMesh
dim = 2
xmin = 0
xmax = 10
ymin = 0
ymax = 10
elem_type = QUAD4
nx = 8
ny = 8
[]
[Variables]
[./T]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxVariables]
[./power]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff_T]
type = Diffusion
variable = T
[../]
[./src_T]
type = CoupledForce
variable = T
v = power
[../]
[]
[BCs]
[./homogeneousT]
type = DirichletBC
variable = T
boundary = '0 1 2 3'
value = 0
[../]
[]
[Executioner]
type = Steady
[]
test/tests/utils/mffd/mffd_test.i
[Mesh]
type = GeneratedMesh
dim = 1
nx = 1
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 'left'
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 'right'
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
mffd_type = 'ds'
[]
modules/combined/test/tests/heat_convection/heat_convection_3d_test.i
# Test cases for convective boundary conditions.
# Input file for htc_3dtest1
# TKLarson
# 11/02/11
# Revision 0
#
# Goals of this test are:
# 1) show that the 'fluid' temperature for convective boundary condition
# is behaving as expected/desired
# 2) show that expected results ensue from application of convective boundary conditions
# Convective boundary condition:
# q = h*A*(Tw - Tf)
# where
# q - heat transfer rate (w)
# h - heat transfer coefficient (w/m^2-K)
# A - surface area (m^2)
# Tw - surface temperature (K)
# Tf - fluid temperature adjacent to the surface (K)
# The heat transfer coefficient (h) is input as a variable called 'rate'
# Tf is a two valued function specified by 'initial' and 'final' along with a variable
# called 'duration,' the length of time in seconds that it takes initial to linearly ramp
# to 'final.'
# The mesh for this test case is concocted from an ASTM standard for the so-called Brazillian Cylinder test
# (ASTM International, Standard Test Method for Splitting Tensile Strength of Cylindrical Concrete
# Specimens, C 496/C 496M-04, 2004). I turned a cylinder model into a rectangular parallelpiped,
# because I already had the cylinder model.
# The model is 3-d xyz coordinates.
#
# Brazillian Parallelpiped sample dimensions:
# z = 10.3 cm, 0.103 m, (4 in)
# y = 5.08 cm, 0.0508 m, (2 in)
# x = 5.08 cm, 0.0508 m, (2 in)
# Material properties are:
# density = 2405.28 km/m^3
# specific heat = 826.4 J/kg-K
# thermal conductivity 1.937 w/m-K
# alpha (thermal conductivity/(density*specific heat) is then 9.74e-7 m^2/s
#
# Initial parallelpiped temperature is room temperature 294.26 K (70 F)
# The initial fluid temperature is room temperature. We will ramp it to 477.6 K (400 F) in 10 minutes.
# We will use an h representative of natural convection conditions as the boundary condition for all sides
# on the parallelpiped. Akin to putting the object in an oven and turning the oven on.
# This is essentially a thermal soak.
#
# What we expect for this problem:
# 1) Use of h = 284 w/m^2-K (50 BTU/hr-ft^2-F) should cause the parallelpiped to slowly heat up to 477K.
# 2) The fluid temperature should rise from initial (294.26 K) to final (477.6 K) in 600 s.
# 3) 1) and 2) should show the convective BC is working as desired.
#
[Mesh] # Mesh Start
# 5cm x 5cm x 10cm parallelpiped not so detailed mesh, 4 elements each end, 8 elements each long face
# Only one block (Block 1), all concrete
# Sideset definitions:
# 1 - xy plane at z=0,
# 2 - xy plane at z=-0.103,
# 3 - xz plane at y=0,
# 4 - yz plane at x=0,
# 5 - xz plane at y=0.0508,
# 6 - yz plane at x=0.0508
file = heat_convection_3d_mesh.e
#
[] # Mesh END
[Variables] # Variables Start
[./temp]
order = FIRST
family = LAGRANGE
initial_condition = 294.26 # Initial parallelpiped temperature
[../]
[] # Variables END
[Kernels] # Kernels Start
[./heat]
# type = HeatConductionRZ
type = HeatConduction
variable = temp
[../]
[./heat_ie]
# type = HeatConductionTimeDerivativeRZ
type = HeatConductionTimeDerivative
variable = temp
[../]
[] # Kernels END
[BCs] # Boundary Conditions Start
# Heat transfer coefficient on outer parallelpiped radius and ends
[./convective_clad_surface] # Convective Start
# type = ConvectiveFluxRZ # Convective flux, e.g. q'' = h*(Tw - Tf)
type = ConvectiveFluxBC # Convective flux, e.g. q'' = h*(Tw - Tf)
boundary = '1 2 3 4 5 6' # BC applied on top, along length, and bottom
variable = temp
rate = 284. # convective heat transfer coefficient (w/m^2-K)[50 BTU/hr-ft^2-F]
initial = 294.26 # initial ambient (lab or oven) temperature (K)
final = 477.6 # final ambient (lab or oven) temperature (K)
duration = 600. # length of time in seconds that it takes the ambient
# temperature to ramp from initial to final
[../] # Convective End
[] # BCs END
[Materials] # Materials Start
[./thermal]
type = HeatConductionMaterial
block = 1
specific_heat = 826.4
#thermal_conductivity = 1.937 # this makes alpha 9.74e-7 m^2/s
thermal_conductivity = 193.7 # this makes alpha 9.74e-5 m^2/s
# above conductivity arbitrarily increased by 2 decades to make the
# object soak faster for the present purposes
[../]
[./density]
type = Density
block = 1
density = 2405.28
[../]
[] # Materials END
[Executioner] # Executioner Start
type = Transient
# type = Steady
#Preconditioned JFNK (default)
solve_type = 'PJFNK'
petsc_options = '-snes_ksp_ew '
petsc_options_iname = '-ksp_gmres_restart -pc_type -pc_hypre_type'
petsc_options_value = '70 hypre boomeramg'
l_max_its = 60
nl_rel_tol = 1e-8
nl_abs_tol = 1e-10
l_tol = 1e-5
start_time = 0.0
dt = 60.
num_steps = 20 # Total run time 1200 s
[] # Executioner END
[Outputs] # Output Start
# Output Start
file_base = out_3d
exodus = true
[] # Output END
# # Input file END
test/tests/meshgenerators/rename_block_generator/rename_block2.i
[MeshGenerators]
[./gmg]
type = GeneratedMeshGenerator
dim = 3
nx = 2
ny = 2
nz = 2
xmin = -1
xmax = 1
ymin = -1
ymax = 1
zmin = -1
zmax = 1
[]
[./sbb1]
type = SubdomainBoundingBoxGenerator
input = gmg
block_id = 1
bottom_left = '-1 -1 -1'
top_right = '0 0 0'
[]
[./sbb2]
type = SubdomainBoundingBoxGenerator
input = sbb1
block_id = 2
bottom_left = '0 -1 -1'
top_right = '1 0 0'
[]
[./sbb3]
type = SubdomainBoundingBoxGenerator
input = sbb2
block_id = 3
bottom_left = '-1 0 -1'
top_right = '0 1 0'
[]
[./sbb4]
type = SubdomainBoundingBoxGenerator
input = sbb3
block_id = 4
bottom_left = '0 0 -1'
top_right = '1 1 0'
[]
[./sbb5]
type = SubdomainBoundingBoxGenerator
input = sbb4
block_id = 5
bottom_left = '-1 -1 0'
top_right = '0 0 1'
[]
[./sbb6]
type = SubdomainBoundingBoxGenerator
input = sbb5
block_id = 6
bottom_left = '0 -1 0'
top_right = '1 0 1'
[]
[./sbb7]
type = SubdomainBoundingBoxGenerator
input = sbb6
block_id = 7
bottom_left = '-1 0 0'
top_right = '0 1 1'
[]
[./sbb8]
type = SubdomainBoundingBoxGenerator
input = sbb7
block_id = 8
bottom_left = '0 0 0'
top_right = '1 1 1'
[]
[./re0]
type = RenameBlockGenerator
input = sbb8
old_block_id = '12345 1 2 3 4'
new_block_name = 'nill one two three four'
[]
[./re1]
type = RenameBlockGenerator
old_block_id = '12345 1 2'
new_block_name = 'nill one_and_two one_and_two'
input = re0
[]
[./does_nothing_there_is_no_block_2_now]
type = RenameBlockGenerator
old_block_id = 2
new_block_id = 9
input = re1
[]
[./re2]
type = RenameBlockGenerator
old_block_id = '1 2 3 4 5 8'
new_block_id = '1 12345 4 4 4 7' # note this makes block_id=4 have name "three", since the first occurance of new_block_id=4 has name "three"
input = does_nothing_there_is_no_block_2_now
[../]
[]
[Mesh]
type = MeshGeneratorMesh
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./bottom]
type = DirichletBC
variable = u
boundary = bottom
value = 0
[../]
[./top]
type = DirichletBC
variable = u
boundary = top
value = 0
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/variables/high_order_monomial/high_order_monomial.i
###########################################################
# This is a simple test demonstrating the use of the
# Higher order monomial variable type.
#
# @Requirement F3.10
###########################################################
[Mesh]
type = GeneratedMesh
dim = 2
nx = 20
ny = 20
[]
[Variables]
[./u]
[../]
[]
# Monomial variable types
[AuxVariables]
[./first]
family = MONOMIAL
[../]
[./second]
order = SECOND
family = MONOMIAL
[../]
[./third]
order = THIRD
family = MONOMIAL
[../]
[]
[Functions]
[./first]
type = ParsedFunction
value = 1+2*x+2*y
[../]
[./second]
type = ParsedFunction
value = 1+2*x+4*x*x+2*y+4*y*y+4*x*y
[../]
[./third]
type = ParsedFunction
value = 1+2*x+4*x*x+8*x*x*x+2*y+4*y*y+8*y*y*y+4*x*y+8*x*x*y
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[AuxKernels]
[./first]
type = FunctionAux
variable = first
function = first
execute_on = timestep_end
[../]
[./second]
type = FunctionAux
variable = second
function = second
execute_on = timestep_end
[../]
[./third]
type = FunctionAux
variable = third
function = third
execute_on = timestep_end
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Postprocessors]
[./first_error]
type = ElementL2Error
variable = first
function = first
execute_on = 'initial timestep_end'
[../]
[./second_error]
type = ElementL2Error
variable = second
function = second
execute_on = 'initial timestep_end'
[../]
[./third_error]
type = ElementL2Error
variable = third
function = third
execute_on = 'initial timestep_end'
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/mesh_modifiers/assign_element_subdomain_id/quad_with_elementid_subdomainid_test.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
nz = 0
zmin = 0
zmax = 0
elem_type = QUAD4
[]
[MeshModifiers]
[./subdomain_id]
type = AssignElementSubdomainID
element_ids = '1 2 3'
subdomain_ids = '1 1 1'
[../]
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
active = 'left right'
# Mesh Generation produces boundaries in counter-clockwise fashion
[./left]
type = DirichletBC
variable = u
boundary = 3
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 1
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out_quad_subdomain_id
exodus = true
[]
modules/navier_stokes/test/tests/ins/lid_driven/lid_driven_stabilized.i
[GlobalParams]
gravity = '0 0 0'
laplace = true
integrate_p_by_parts = true
family = LAGRANGE
order = FIRST
# There are multiple types of stabilization possible in incompressible
# Navier Stokes. The user can specify supg = true to apply streamline
# upwind petrov-galerkin stabilization to the momentum equations. This
# is most useful for high Reynolds numbers, e.g. when inertial effects
# dominate over viscous effects. The user can also specify pspg = true
# to apply pressure stabilized petrov-galerkin stabilization to the mass
# equation. PSPG is a form of Galerkin Least Squares. This stabilization
# allows equal order interpolations to be used for pressure and velocity.
# Finally, the alpha parameter controls the amount of stabilization.
# For PSPG, decreasing alpha leads to increased accuracy but may induce
# spurious oscillations in the pressure field. Some numerical experiments
# suggest that alpha between .1 and 1 may be optimal for accuracy and
# robustness.
supg = true
pspg = true
alpha = 1e-1
[]
[Mesh]
type = GeneratedMesh
dim = 2
xmin = 0
xmax = 1.0
ymin = 0
ymax = 1.0
nx = 64
ny = 64
elem_type = QUAD4
[]
[MeshModifiers]
[./corner_node]
type = AddExtraNodeset
new_boundary = 'pinned_node'
nodes = '0'
[../]
[]
[Variables]
[./vel_x]
[../]
[./vel_y]
[../]
[./p]
[../]
[]
[Kernels]
# mass
[./mass]
type = INSMass
variable = p
u = vel_x
v = vel_y
p = p
[../]
# x-momentum, space
[./x_momentum_space]
type = INSMomentumLaplaceForm
variable = vel_x
u = vel_x
v = vel_y
p = p
component = 0
[../]
# y-momentum, space
[./y_momentum_space]
type = INSMomentumLaplaceForm
variable = vel_y
u = vel_x
v = vel_y
p = p
component = 1
[../]
[]
[BCs]
[./x_no_slip]
type = DirichletBC
variable = vel_x
boundary = 'bottom right left'
value = 0.0
[../]
[./lid]
type = FunctionDirichletBC
variable = vel_x
boundary = 'top'
function = 'lid_function'
[../]
[./y_no_slip]
type = DirichletBC
variable = vel_y
boundary = 'bottom right top left'
value = 0.0
[../]
[./pressure_pin]
type = DirichletBC
variable = p
boundary = 'pinned_node'
value = 0
[../]
[]
[Materials]
[./const]
type = GenericConstantMaterial
block = 0
prop_names = 'rho mu'
prop_values = '1 1'
[../]
[]
[Functions]
[./lid_function]
# We pick a function that is exactly represented in the velocity
# space so that the Dirichlet conditions are the same regardless
# of the mesh spacing.
type = ParsedFunction
value = '4*x*(1-x)'
[../]
[]
[Preconditioning]
[./SMP]
type = SMP
full = true
solve_type = 'NEWTON'
[../]
[]
[Executioner]
type = Steady
petsc_options_iname = '-pc_type -pc_asm_overlap -sub_pc_type -sub_pc_factor_levels'
petsc_options_value = 'asm 2 ilu 4'
line_search = 'none'
nl_rel_tol = 1e-12
nl_abs_tol = 1e-13
nl_max_its = 6
l_tol = 1e-6
l_max_its = 500
[]
[Outputs]
exodus = true
[]
modules/level_set/test/tests/transfers/copy_solution/sub.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[Executioner]
type = Steady
[]
[Problem]
kernel_coverage_check = false
[]
[Outputs]
exodus = true
[]
test/tests/misc/save_in/dg_save_in_test.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 9
ny = 9
elem_type = QUAD4
[]
[Variables]
[./u]
order = FIRST
family = MONOMIAL
[./InitialCondition]
type = ConstantIC
value = 1
[../]
[../]
[]
[AuxVariables]
[./tot_resid]
order = FIRST
family = MONOMIAL
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
save_in = 'tot_resid'
[../]
[./forcing]
type = BodyForce
variable = u
function = 1
save_in = 'tot_resid'
[../]
[]
[DGKernels]
[./dg_diff]
type = DGDiffusion
variable = u
epsilon = -1
sigma = 6
save_in = 'tot_resid'
[../]
[]
[BCs]
[./robin]
type = RobinBC
boundary = 'left right top bottom'
variable = u
save_in = 'tot_resid'
[../]
[]
[Executioner]
type = Steady
solve_type = 'NEWTON'
nl_rel_tol = 1e-10
[]
[Outputs]
exodus = true
[]
test/tests/misc/block_boundary_material_check/dgkernel_check_boundary.i
[Mesh]
type = GeneratedMesh
dim = 1
[]
[Variables]
[./u]
[../]
[]
[DGKernels]
[./dg]
type = MatDGKernel
mat_prop = 'foo'
variable = u
boundary = 1
[../]
[]
[Problem]
type = FEProblem
solve = false
kernel_coverage_check = false
[]
[Executioner]
type = Steady
[]
[Outputs]
[]
modules/porous_flow/test/tests/gravity/fully_saturated_grav01a.i
# Checking that gravity head is established
# 1phase, constant fluid-bulk, constant viscosity, constant permeability
# fully saturated
# For better agreement with the analytical solution (ana_pp), just increase nx
[Mesh]
type = GeneratedMesh
dim = 1
nx = 100
xmin = -1
xmax = 0
[]
[GlobalParams]
PorousFlowDictator = dictator
[]
[Variables]
[./pp]
[./InitialCondition]
type = RandomIC
min = 0
max = 1
[../]
[../]
[]
[Kernels]
[./flux0]
type = PorousFlowFullySaturatedDarcyBase
variable = pp
gravity = '-1 0 0'
[../]
[]
[Functions]
[./ana_pp]
type = ParsedFunction
vars = 'g B p0 rho0'
vals = '1 1.2 0 1'
value = '-B*log(exp(-p0/B)+g*rho0*x/B)' # expected pp at base
[../]
[]
[BCs]
[./z]
type = PresetBC
variable = pp
boundary = right
value = 0
[../]
[]
[UserObjects]
[./dictator]
type = PorousFlowDictator
porous_flow_vars = 'pp'
number_fluid_phases = 1
number_fluid_components = 1
[../]
[]
[Modules]
[./FluidProperties]
[./simple_fluid]
type = SimpleFluidProperties
bulk_modulus = 1.2
density0 = 1
viscosity = 1
thermal_expansion = 0
[../]
[../]
[]
[Materials]
[./temperature]
type = PorousFlowTemperature
[../]
[./ppss]
type = PorousFlow1PhaseFullySaturated
porepressure = pp
[../]
[./massfrac]
type = PorousFlowMassFraction
[../]
[./simple_fluid]
type = PorousFlowSingleComponentFluid
fp = simple_fluid
phase = 0
[../]
[./permeability]
type = PorousFlowPermeabilityConst
permeability = '1 0 0 0 2 0 0 0 3'
[../]
[]
[Postprocessors]
[./pp_base]
type = PointValue
variable = pp
point = '-1 0 0'
[../]
[./pp_analytical]
type = FunctionValuePostprocessor
function = ana_pp
point = '-1 0 0'
[../]
[]
[Preconditioning]
active = andy
[./andy]
type = SMP
full = true
petsc_options_iname = '-ksp_type -pc_type -snes_atol -snes_rtol -snes_max_it'
petsc_options_value = 'bcgs bjacobi 1E-15 1E-10 10000'
[../]
[./check]
type = SMP
full = true
petsc_options_iname = '-ksp_type -pc_type -snes_atol -snes_rtol -snes_max_it -snes_type'
petsc_options_value = 'bcgs bjacobi 1E-15 1E-10 10000 test'
[../]
[]
[Executioner]
type = Steady
solve_type = Newton
[]
[Outputs]
execute_on = 'timestep_end'
file_base = fully_saturated_grav01a
[./csv]
type = CSV
[../]
[]
test/tests/functions/parsed/steady.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
initial_condition = 2
[../]
[]
[Functions]
[./right_bc]
type = ParsedFunction
value = a+1
vals = left_avg
vars = a
[../]
[./left_bc]
type = ParsedFunction
value = a
vals = left_avg
vars = a
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = FunctionDirichletBC
variable = u
boundary = left
function = left_bc
[../]
[./right]
type = FunctionDirichletBC
variable = u
boundary = 'right right'
function = right_bc
[../]
[]
[Postprocessors]
[./left_avg]
type = SideAverageValue
variable = u
execute_on = initial
boundary = left
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
modules/heat_conduction/test/tests/heat_conduction/3d_quadrature_gap_heat_transfer/nonmatching.i
[Mesh]
file = nonmatching.e
[]
[Variables]
[./temp]
[../]
[]
[Kernels]
[./hc]
type = HeatConduction
variable = temp
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = temp
boundary = leftleft
value = 1000
[../]
[./right]
type = DirichletBC
variable = temp
boundary = rightright
value = 400
[../]
[]
[ThermalContact]
[./left_to_right]
slave = leftright
quadrature = true
master = rightleft
variable = temp
type = GapHeatTransfer
[../]
[]
[Materials]
[./hcm]
type = HeatConductionMaterial
block = 'left right'
specific_heat = 1
thermal_conductivity = 1
[../]
[]
[Postprocessors]
[./left]
type = SideFluxIntegral
variable = temp
boundary = leftright
diffusivity = thermal_conductivity
[../]
[./right]
type = SideFluxIntegral
variable = temp
boundary = rightleft
diffusivity = thermal_conductivity
[../]
[]
[Executioner]
type = Steady
#Preconditioned JFNK (default)
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/userobjects/nearest_point_layered_average/nearest_point_layered_average.i
[Mesh]
type = GeneratedMesh
dim = 3
nx = 10
ny = 10
nz = 10
[]
[Variables]
[./u]
[../]
[]
[AuxVariables]
[./np_layered_average]
order = CONSTANT
family = MONOMIAL
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[AuxKernels]
[./np_layered_average]
type = SpatialUserObjectAux
variable = np_layered_average
execute_on = timestep_end
user_object = npla
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./one]
type = DirichletBC
variable = u
boundary = 'right back top'
value = 1
[../]
[]
[UserObjects]
[./npla]
type = NearestPointLayeredAverage
direction = y
num_layers = 10
variable = u
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
test/tests/dirackernels/material_point_source/material_point_source.i
[Mesh]
type = GeneratedMesh
dim = 2
xmin = 0
xmax = 1
ymin = 0
ymax = 1
nx = 2
ny = 2
elem_type = QUAD4
uniform_refine = 4
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[DiracKernels]
[./material_source]
type = MaterialPointSource
variable = u
point = '0.2 0.3 0.0'
material_prop = 'matp'
prop_state = 'current'
[../]
[]
[Materials]
[./xmat]
# MTMaterial provides 'matp', value is the 'shift' added to the x-coordinate
# when computing the Material property value.
type = MTMaterial
block = '0'
value = 0.
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 'left'
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 'right'
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/misc/check_error/nan_test.i
[Mesh]
file = square.e
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./nan]
type = NanKernel
variable = u
[../]
[]
[BCs]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out
exodus = true
[]
modules/heat_conduction/test/tests/verify_against_analytical/2d_steady_state_final_prob.i
# This test solves a 2D steady state heat equation
# The error is found by comparing to the analytical solution
# Note that the thermal conductivity, specific heat, and density in this problem
# Are set to 1, and need to be changed to the constants of the material being
# Analyzed
[Mesh]
type = GeneratedMesh
dim = 2
nx = 30
ny = 30
xmax = 2
ymax = 2
[]
[Variables]
[./T]
[../]
[]
[Functions]
[./analytical_sol]
type = ParsedFunction
value = 10/(sinh(pi))*sin(pi*x*0.5)*sinh(pi*y*0.5)
[../]
[./top_bound]
type = ParsedFunction
value = 10*sin(pi*x*0.5)
[../]
[]
[Kernels]
active = 'HeatDiff'
[./HeatDiff]
type = HeatConduction
variable = T
[../]
[./HeatTdot]
type = HeatConductionTimeDerivative
variable = T
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = T
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = T
boundary = right
value = 0
[../]
[./bottom]
type = DirichletBC
variable = T
boundary = bottom
value = 0
[../]
[./top]
type = FunctionDirichletBC
variable = T
boundary = top
function = top_bound
[../]
[]
[Materials]
[./k]
type = GenericConstantMaterial
prop_names = thermal_conductivity
prop_values = 1 # this values is changed based on the material property
block = 0
[../]
[./cp]
type = GenericConstantMaterial
prop_names = specific_heat
prop_values = 1 # this value is changed based on material properties
block = 0
[../]
[./rho]
type = GenericConstantMaterial
prop_names = density
prop_values = 1 # this values is changed based on material properties
block = 0
[../]
[]
[Postprocessors]
[./nodal_error]
type = NodalL2Error
function = 'analytical_sol'
variable = T
[../]
[./elemental_error]
type = ElementL2Error
function = 'analytical_sol'
variable = T
[../]
[]
[Executioner]
type = Steady
nl_rel_tol = 1e-12
l_tol = 1e-6
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
perf_graph = true
[]
modules/richards/test/tests/jacobian_1/jn08.i
# unsaturated = true
# gravity = true
# supg = true
# transient = false
[Mesh]
type = GeneratedMesh
dim = 3
nx = 1
ny = 1
nz = 1
xmin = -1
xmax = 1
ymin = -1
ymax = 1
zmin = -1
zmax = 1
[]
[GlobalParams]
richardsVarNames_UO = PPNames
[]
[UserObjects]
[./PPNames]
type = RichardsVarNames
richards_vars = pressure
[../]
[./DensityConstBulk]
type = RichardsDensityConstBulk
dens0 = 1
bulk_mod = 1.0 # notice small quantity, so the PETSc constant state works
[../]
[./SeffVG]
type = RichardsSeff1VG
m = 0.8
al = 1 # notice small quantity, so the PETSc constant state works
[../]
[./RelPermPower]
type = RichardsRelPermPower
simm = 0.2
n = 2
[../]
[./Saturation]
type = RichardsSat
s_res = 0.1
sum_s_res = 0.1
[../]
[./SUPGstandard]
type = RichardsSUPGstandard
p_SUPG = 0.1
[../]
[]
[Variables]
[./pressure]
order = FIRST
family = LAGRANGE
[./InitialCondition]
type = RandomIC
block = 0
min = -1
max = 0
[../]
[../]
[]
[Kernels]
active = 'richardsf'
[./richardst]
type = RichardsMassChange
variable = pressure
[../]
[./richardsf]
type = RichardsFlux
variable = pressure
[../]
[]
[Materials]
[./rock]
type = RichardsMaterial
block = 0
mat_porosity = 0.1
mat_permeability = '1E-5 0 0 0 1E-5 0 0 0 1E-5'
density_UO = DensityConstBulk
relperm_UO = RelPermPower
SUPG_UO = SUPGstandard
sat_UO = Saturation
seff_UO = SeffVG
viscosity = 1E-3
gravity = '1 2 3'
linear_shape_fcns = true
[../]
[]
[Preconditioning]
[./andy]
type = SMP
full = true
petsc_options_iname = '-ksp_type -pc_type -snes_atol -snes_rtol -snes_max_it -snes_type'
petsc_options_value = 'bcgs bjacobi 1E-15 1E-10 10000 test'
[../]
[]
[Executioner]
type = Steady
solve_type = Newton
[]
[Outputs]
execute_on = 'timestep_end'
file_base = jn08
exodus = false
[]
test/tests/postprocessors/element_l2_error_pps/element_l2_error_pp_test.i
###########################################################
# This is a simple test of the Postprocessor System. This
# test uses a forcing function and the MMS to verify
# correctness of the implementation.
# Grid adaptivity is applied at successively finer grids
# to verify the correct slope of the measure of error
# against the analytical solution.
#
# @Requirement F6.10
###########################################################
[Mesh]
type = GeneratedMesh
dim = 2
nx = 3
ny = 3
xmin = 0
xmax = 2
ymin = 0
ymax = 2
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Functions]
active = 'forcing_func u_func'
[./forcing_func]
type = ParsedFunction
value = alpha*alpha*pi*pi*sin(alpha*pi*x)
vars = 'alpha'
vals = '4'
[../]
[./u_func]
type = ParsedFunction
value = sin(alpha*pi*x)
vars = 'alpha'
vals = '4'
[../]
[]
[Kernels]
active = 'diff forcing'
[./diff]
type = Diffusion
variable = u
[../]
[./forcing]
type = BodyForce
variable = u
function = forcing_func
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = '1'
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = '3'
value = 0
[../]
[]
[Executioner]
type = Steady
[./Adaptivity]
refine_fraction = 1.0
coarsen_fraction = 0.0
max_h_level = 10
steps = 4
[../]
[]
# Postprocessor System
[Postprocessors]
[./integral]
type = ElementL2Error
variable = u
function = u_func
execute_on = 'initial timestep_end'
[../]
[]
[Outputs]
file_base = out
exodus = false
csv = true
[]
test/tests/preconditioners/fsp/fsp_test.i
[Mesh]
file = square.e
[]
[Variables]
active = 'u v'
[./u]
order = FIRST
family = LAGRANGE
[../]
[./v]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff_u conv_v diff_v'
[./diff_u]
type = Diffusion
variable = u
[../]
[./conv_v]
type = CoupledForce
variable = v
v = u
[../]
[./diff_v]
type = Diffusion
variable = v
[../]
[]
[BCs]
active = 'left_u right_u left_v'
[./left_u]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right_u]
type = DirichletBC
variable = u
boundary = 2
value = 100
[../]
[./left_v]
type = DirichletBC
variable = v
boundary = 1
value = 0
[../]
[./right_v]
type = DirichletBC
variable = v
boundary = 2
value = 0
[../]
[]
[Executioner]
type = Steady
# This is setup automatically in MOOSE (SetupPBPAction.C)
# petsc_options = '-snes_mf_operator'
# petsc_options_iname = '-pc_type'
# petsc_options_value = 'asm'
[]
[Preconditioning]
active = 'FSP'
[./FSP]
type = FSP
# It is the starting point of splitting
topsplit = 'uv' # 'uv' should match the following block name
[./uv]
splitting = 'u v' # 'u' and 'v' are the names of subsolvers
# Generally speaking, there are four types of splitting we could choose
# <additive,multiplicative,symmetric_multiplicative,schur>
splitting_type = additive
# An approximate solution to the original system
# | A_uu A_uv | | u | _ |f_u|
# | 0 A_vv | | v | - |f_v|
# is obtained by solving the following subsystems
# A_uu u = f_u and A_vv v = f_v
# If splitting type is specified as schur, we may also want to set more options to
# control how schur works using PETSc options
# petsc_options_iname = '-pc_fieldsplit_schur_fact_type -pc_fieldsplit_schur_precondition'
# petsc_options_value = 'full selfp'
[../]
[./u]
vars = 'u'
# PETSc options for this subsolver
# A prefix will be applied, so just put the options for this subsolver only
petsc_options_iname = '-pc_type -ksp_type'
petsc_options_value = ' hypre preonly'
[../]
[./v]
vars = 'v'
# PETSc options for this subsolver
petsc_options_iname = '-pc_type -ksp_type'
petsc_options_value = ' hypre preonly'
[../]
[../]
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/outputs/format/output_test_nemesis.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
nz = 0
zmin = 0
zmax = 0
elem_type = QUAD4
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 3
value = 1
[../]
[]
[Postprocessors]
[./avg_block]
type = ElementAverageValue
variable = u
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out
nemesis = 1
[]
test/tests/auxkernels/bounds/bounds_test.i
[Mesh]
type = GeneratedMesh
dim = 2
xmin = 0
xmax = 1
ymin = 0
ymax = 1
nx = 10
ny = 10
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[./v]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxVariables]
[./bounds_dummy]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff_u]
type = Diffusion
variable = u
[../]
[./diff_v]
type = Diffusion
variable = v
[../]
[]
[BCs]
[./left_u]
type = DirichletBC
variable = u
boundary = 3
value = 0
[../]
[./right_u]
type = DirichletBC
variable = u
boundary = 1
value = 1
[../]
[./left_v]
type = DirichletBC
variable = v
boundary = 3
value = 0
[../]
[./right_v]
type = DirichletBC
variable = v
boundary = 1
value = 1
[../]
[]
[Bounds]
[./u_bounds]
type = BoundsAux
variable = bounds_dummy
bounded_variable = u
upper = 1
lower = 0
[../]
[./v_bounds]
type = BoundsAux
variable = bounds_dummy
bounded_variable = v
upper = 3
lower = -1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/outputs/csv/csv_sort.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[./v]
[../]
[]
[AuxVariables]
[./aux0]
order = SECOND
family = SCALAR
[../]
[./aux1]
family = SCALAR
initial_condition = 5
[../]
[./aux2]
family = SCALAR
initial_condition = 10
[../]
[]
[Kernels]
[./diff_u]
type = Diffusion
variable = u
[../]
[./diff_v]
type = CoefDiffusion
variable = v
coef = 2
[../]
[]
[BCs]
[./right_u]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[./left_u]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right_v]
type = DirichletBC
variable = v
boundary = right
value = 3
[../]
[./left_v]
type = DirichletBC
variable = v
boundary = left
value = 2
[../]
[]
[Postprocessors]
[./num_vars]
type = NumVars
system = 'NL'
[../]
[./num_aux]
type = NumVars
system = 'AUX'
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
execute_on = 'timestep_end'
[./out]
type = CSV
sort_columns = true
[../]
[]
[ICs]
[./aux0_IC]
variable = aux0
values = '12 13'
type = ScalarComponentIC
[../]
[]
modules/tensor_mechanics/test/tests/action/two_block_new.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 4
ny = 4
[]
[MeshModifiers]
[./block1]
type = SubdomainBoundingBox
block_id = 1
bottom_left = '0 0 0'
top_right = '0.5 1 0'
[../]
[./block2]
type = SubdomainBoundingBox
block_id = 2
bottom_left = '0.5 0 0'
top_right = '1 1 0'
[../]
[]
[GlobalParams]
displacements = 'disp_x disp_y'
[]
[Modules/TensorMechanics/Master]
# parameters that apply to all subblocks are specified at this level. They
# can be overwritten in the subblocks.
add_variables = true
strain = FINITE
generate_output = 'stress_xx'
[./block1]
# the `block` parameter is only valid insde a subblock.
block = 1
[../]
[./block2]
block = 2
# the `additional_generate_output` parameter is also only valid inside a
# subblock. Values specified here are appended to the `generate_output`
# parameter values.
additional_generate_output = 'strain_yy'
[../]
[]
[AuxVariables]
[./stress_theta]
order = CONSTANT
family = MONOMIAL
[../]
[./strain_theta]
order = CONSTANT
family = MONOMIAL
[../]
[]
[AuxKernels]
[./stress_theta]
type = RankTwoAux
rank_two_tensor = stress
index_i = 2
index_j = 2
variable = stress_theta
execute_on = timestep_end
[../]
[./strain_theta]
type = RankTwoAux
rank_two_tensor = total_strain
index_i = 2
index_j = 2
variable = strain_theta
execute_on = timestep_end
[../]
[]
[Materials]
[./elasticity_tensor]
type = ComputeIsotropicElasticityTensor
youngs_modulus = 1e10
poissons_ratio = 0.345
[../]
[./_elastic_stress1]
type = ComputeFiniteStrainElasticStress
block = 1
[../]
[./_elastic_stress2]
type = ComputeFiniteStrainElasticStress
block = 2
[../]
[]
[BCs]
[./left]
type = PresetBC
boundary = 'left'
variable = disp_x
value = 0.0
[../]
[./top]
type = PresetBC
boundary = 'top'
variable = disp_y
value = 0.0
[../]
[./right]
type = PresetBC
boundary = 'right'
variable = disp_x
value = 0.01
[../]
[./bottom]
type = PresetBC
boundary = 'bottom'
variable = disp_y
value = 0.01
[../]
[]
[Debug]
show_var_residual_norms = true
[]
[Executioner]
type = Steady
petsc_options_iname = '-ksp_gmres_restart -pc_type -pc_hypre_type -pc_hypre_boomeramg_max_iter'
petsc_options_value = ' 201 hypre boomeramg 10'
line_search = 'none'
nl_rel_tol = 5e-9
nl_abs_tol = 1e-10
nl_max_its = 15
l_tol = 1e-3
l_max_its = 50
[]
[Outputs]
exodus = true
[]
modules/heat_conduction/test/tests/heat_conduction/2d_quadrature_gap_heat_transfer/perfectQ9.i
[GlobalParams]
order = SECOND
[]
[Mesh]
file = perfectQ9.e
[]
[Variables]
[./temp]
[../]
[]
[Kernels]
[./hc]
type = HeatConduction
variable = temp
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = temp
boundary = leftleft
value = 300
[../]
[./right]
type = DirichletBC
variable = temp
boundary = rightright
value = 400
[../]
[]
[ThermalContact]
[./left_to_right]
slave = leftright
quadrature = true
master = rightleft
variable = temp
type = GapHeatTransfer
[../]
[]
[Materials]
[./hcm]
type = HeatConductionMaterial
block = 'left right'
specific_heat = 1
thermal_conductivity = 1
[../]
[]
[Executioner]
type = Steady
#Preconditioned JFNK (default)
solve_type = 'PJFNK'
[./Quadrature]
order = THIRD
[../]
[]
[Outputs]
exodus = true
[]
test/tests/misc/check_error/dirac_kernel_with_aux_var.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxVariables]
[./v]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[./rea]
type = Reaction
variable = u
[../]
[]
[DiracKernels]
[./nope]
type = CachingPointSource
variable = v
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'NEWTON'
[]
[Outputs]
file_base = out
exodus = true
[]
modules/fluid_properties/test/tests/water/water.i
# Example of using Water97FluidProperties module in Region 1 by recovering the values
# in Table 5 of Revised Release on the IAPWS Industrial Formulation 1997 for the
# Thermodynamic Properties of Water and Steam
[Mesh]
type = GeneratedMesh
dim = 2
nx = 3
xmax = 3
# This test uses ElementalVariableValue postprocessors on specific
# elements, so element numbering needs to stay unchanged
allow_renumbering = false
[]
[Variables]
[./dummy]
[../]
[]
[AuxVariables]
[./pressure]
order = CONSTANT
family = MONOMIAL
[../]
[./temperature]
order = CONSTANT
family = MONOMIAL
[../]
[./rho]
family = MONOMIAL
order = CONSTANT
[../]
[./v]
family = MONOMIAL
order = CONSTANT
[../]
[./e]
family = MONOMIAL
order = CONSTANT
[../]
[./h]
family = MONOMIAL
order = CONSTANT
[../]
[./s]
family = MONOMIAL
order = CONSTANT
[../]
[./cp]
family = MONOMIAL
order = CONSTANT
[../]
[./cv]
family = MONOMIAL
order = CONSTANT
[../]
[./c]
family = MONOMIAL
order = CONSTANT
[../]
[./mu]
family = MONOMIAL
order = CONSTANT
[../]
[./k]
family = MONOMIAL
order = CONSTANT
[../]
[]
[Functions]
[./tic]
type = ParsedFunction
value = 'if(x<2, 300, 500)'
[../]
[./pic]
type = ParsedFunction
value = 'if(x<1,3e6, if(x<2, 80e6, 3e6))'
[../]
[]
[ICs]
[./p_ic]
type = FunctionIC
function = pic
variable = pressure
[../]
[./t_ic]
type = FunctionIC
function = tic
variable = temperature
[../]
[]
[AuxKernels]
[./rho]
type = MaterialRealAux
variable = rho
property = density
[../]
[./v]
type = ParsedAux
args = rho
function = 1/rho
variable = v
[../]
[./e]
type = MaterialRealAux
variable = e
property = e
[../]
[./h]
type = MaterialRealAux
variable = h
property = h
[../]
[./s]
type = MaterialRealAux
variable = s
property = s
[../]
[./cp]
type = MaterialRealAux
variable = cp
property = cp
[../]
[./cv]
type = MaterialRealAux
variable = cv
property = cv
[../]
[./c]
type = MaterialRealAux
variable = c
property = c
[../]
[./mu]
type = MaterialRealAux
variable = mu
property = viscosity
[../]
[./k]
type = MaterialRealAux
variable = k
property = k
[../]
[]
[Modules]
[./FluidProperties]
[./water]
type = Water97FluidProperties
[../]
[../]
[]
[Materials]
[./fp_mat]
type = FluidPropertiesMaterialPT
pressure = pressure
temperature = temperature
fp = water
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = dummy
[../]
[]
[Postprocessors]
[./density0]
type = ElementalVariableValue
variable = rho
elementid = 0
[../]
[./density1]
type = ElementalVariableValue
variable = rho
elementid = 1
[../]
[./density2]
type = ElementalVariableValue
variable = rho
elementid = 2
[../]
[./v0]
type = ElementalVariableValue
variable = v
elementid = 0
[../]
[./v1]
type = ElementalVariableValue
variable = v
elementid = 1
[../]
[./v2]
type = ElementalVariableValue
variable = v
elementid = 2
[../]
[./e0]
type = ElementalVariableValue
variable = e
elementid = 0
[../]
[./e1]
type = ElementalVariableValue
variable = e
elementid = 1
[../]
[./e2]
type = ElementalVariableValue
variable = e
elementid = 2
[../]
[./h0]
type = ElementalVariableValue
variable = h
elementid = 0
[../]
[./h1]
type = ElementalVariableValue
variable = h
elementid = 1
[../]
[./h2]
type = ElementalVariableValue
variable = h
elementid = 2
[../]
[./s0]
type = ElementalVariableValue
variable = s
elementid = 0
[../]
[./s1]
type = ElementalVariableValue
variable = s
elementid = 1
[../]
[./s2]
type = ElementalVariableValue
variable = s
elementid = 2
[../]
[./cp0]
type = ElementalVariableValue
variable = cp
elementid = 0
[../]
[./cp1]
type = ElementalVariableValue
variable = cp
elementid = 1
[../]
[./cp2]
type = ElementalVariableValue
variable = cp
elementid = 2
[../]
[./cv0]
type = ElementalVariableValue
variable = cv
elementid = 0
[../]
[./cv1]
type = ElementalVariableValue
variable = cv
elementid = 1
[../]
[./cv2]
type = ElementalVariableValue
variable = cv
elementid = 2
[../]
[./c0]
type = ElementalVariableValue
variable = c
elementid = 0
[../]
[./c1]
type = ElementalVariableValue
variable = c
elementid = 1
[../]
[./c2]
type = ElementalVariableValue
variable = c
elementid = 2
[../]
[./mu0]
type = ElementalVariableValue
variable = mu
elementid = 0
[../]
[./mu1]
type = ElementalVariableValue
variable = mu
elementid = 1
[../]
[./mu2]
type = ElementalVariableValue
variable = mu
elementid = 2
[../]
[./k0]
type = ElementalVariableValue
variable = k
elementid = 0
[../]
[./k1]
type = ElementalVariableValue
variable = k
elementid = 1
[../]
[./k2]
type = ElementalVariableValue
variable = k
elementid = 2
[../]
[]
[Executioner]
type = Steady
solve_type = NEWTON
[]
[Outputs]
csv = true
[]
test/tests/geomsearch/quadrature_penetration_locator/quadrature_penetration_locator.i
[Mesh]
file = 2dcontact_collide.e
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxVariables]
[./penetration]
order = CONSTANT
family = MONOMIAL
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[AuxKernels]
[./penetration]
type = PenetrationAux
variable = penetration
boundary = 2
paired_boundary = 3
[../]
[]
[BCs]
[./block1_left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./block1_right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[./block2_left]
type = DirichletBC
variable = u
boundary = 3
value = 0
[../]
[./block2_right]
type = DirichletBC
variable = u
boundary = 4
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
exodus = true
[]
test/tests/postprocessors/side_average_value/side_average_value_test.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
xmin = 0
xmax = 2
ymin = 0
ymax = 1
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 3
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 1
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Postprocessors]
[./average]
type = SideAverageValue
boundary = 0
variable = u
[../]
[]
[Outputs]
file_base = out
exodus = true
[]
modules/richards/test/tests/gravity_head_2/gh04.i
# unsaturated = true
# gravity = true
# supg = true
# transient = false
[Mesh]
type = GeneratedMesh
dim = 1
nx = 20
xmin = 0
xmax = 1
[]
[GlobalParams]
richardsVarNames_UO = PPNames
[]
[UserObjects]
[./PPNames]
type = RichardsVarNames
richards_vars = 'pwater pgas'
[../]
[./DensityWater]
type = RichardsDensityConstBulk
dens0 = 1
bulk_mod = 1.0E2
[../]
[./DensityGas]
type = RichardsDensityConstBulk
dens0 = 0.5
bulk_mod = 0.5E2
[../]
[./SeffWater]
type = RichardsSeff2waterVG
m = 0.8
al = 1
[../]
[./SeffGas]
type = RichardsSeff2gasVG
m = 0.8
al = 1
[../]
[./RelPermWater]
type = RichardsRelPermPower
simm = 0.0
n = 2
[../]
[./RelPermGas]
type = RichardsRelPermPower
simm = 0.0
n = 3
[../]
[./SatWater]
type = RichardsSat
s_res = 0.1
sum_s_res = 0.15
[../]
[./SatGas]
type = RichardsSat
s_res = 0.05
sum_s_res = 0.15
[../]
[./SUPGwater]
type = RichardsSUPGstandard
p_SUPG = 1E-3
[../]
[./SUPGgas]
type = RichardsSUPGstandard
p_SUPG = 1E-3
[../]
[]
[Variables]
[./pwater]
order = FIRST
family = LAGRANGE
[../]
[./pgas]
order = FIRST
family = LAGRANGE
[../]
[]
[ICs]
# get nonconvergence if initial condition is too crazy
[./water_ic]
type = FunctionIC
function = '1-x/2'
variable = pwater
[../]
[./gas_ic]
type = FunctionIC
function = '4-x/5'
variable = pgas
[../]
[]
[Kernels]
active = 'richardsfwater richardsfgas'
[./richardstwater]
type = RichardsMassChange
variable = pwater
[../]
[./richardsfwater]
type = RichardsFlux
variable = pwater
[../]
[./richardstgas]
type = RichardsMassChange
variable = pgas
[../]
[./richardsfgas]
type = RichardsFlux
variable = pgas
[../]
[]
[AuxVariables]
[./seffgas]
[../]
[./seffwater]
[../]
[]
[AuxKernels]
[./seffgas_kernel]
type = RichardsSeffAux
pressure_vars = 'pwater pgas'
seff_UO = SeffGas
variable = seffgas
[../]
[./seffwater_kernel]
type = RichardsSeffAux
pressure_vars = 'pwater pgas'
seff_UO = SeffWater
variable = seffwater
[../]
[]
[Postprocessors]
[./pw_left]
type = PointValue
point = '0 0 0'
variable = pwater
outputs = none
[../]
[./pw_right]
type = PointValue
point = '1 0 0'
variable = pwater
outputs = none
[../]
[./error_water]
type = FunctionValuePostprocessor
function = fcn_error_water
[../]
[./pg_left]
type = PointValue
point = '0 0 0'
variable = pgas
outputs = none
[../]
[./pg_right]
type = PointValue
point = '1 0 0'
variable = pgas
outputs = none
[../]
[./error_gas]
type = FunctionValuePostprocessor
function = fcn_error_gas
[../]
[]
[Functions]
[./fcn_error_water]
type = ParsedFunction
value = 'abs((-b*log(-(gdens0*xval+(-b*exp(-p0/b)))/b)-p1)/p1)'
vars = 'b gdens0 p0 xval p1'
vals = '1E2 -1 pw_left 1 pw_right'
[../]
[./fcn_error_gas]
type = ParsedFunction
value = 'abs((-b*log(-(gdens0*xval+(-b*exp(-p0/b)))/b)-p1)/p1)'
vars = 'b gdens0 p0 xval p1'
vals = '0.5E2 -0.5 pg_left 1 pg_right'
[../]
[]
[Materials]
[./rock]
type = RichardsMaterial
block = 0
mat_porosity = 0.1
mat_permeability = '1E-5 0 0 0 1E-5 0 0 0 1E-5'
density_UO = 'DensityWater DensityGas'
relperm_UO = 'RelPermWater RelPermGas'
SUPG_UO = 'SUPGwater SUPGgas'
sat_UO = 'SatWater SatGas'
seff_UO = 'SeffWater SeffGas'
viscosity = '1E-3 0.5E-3'
gravity = '-1 0 0'
linear_shape_fcns = true
[../]
[]
[Preconditioning]
[./andy]
type = SMP
full = true
petsc_options_iname = '-ksp_type -pc_type -sub_pc_type -sub_pc_factor_shift_type -snes_atol -snes_rtol -snes_max_it'
petsc_options_value = 'gmres asm lu NONZERO 1E-10 1E-10 10000'
[../]
[]
[Executioner]
type = Steady
solve_type = Newton
[]
[Outputs]
execute_on = 'timestep_end'
file_base = gh04
csv = true
[]
stork/test/tests/kernels/simple_diffusion/simple_diffusion.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
python/peacock/tests/input_tab/InputTree/gold/fsp_test.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
[]
[Variables]
[u]
order = FIRST
family = LAGRANGE
[]
[v]
order = FIRST
family = LAGRANGE
[]
[]
[Kernels]
[diff_u]
type = Diffusion
variable = u
[]
[conv_v]
type = CoupledForce
variable = v
v = 'u'
[]
[diff_v]
type = Diffusion
variable = v
[]
[]
[BCs]
inactive = 'right_v'
[left_u]
type = DirichletBC
variable = u
boundary = '1'
value = 0
[]
[right_u]
type = DirichletBC
variable = u
boundary = '2'
value = 100
[]
[left_v]
type = DirichletBC
variable = v
boundary = '1'
value = 0
[]
[right_v]
type = DirichletBC
variable = v
boundary = '2'
value = 0
[]
[]
[Executioner]
# This is setup automatically in MOOSE (SetupPBPAction.C)
# petsc_options = '-snes_mf_operator'
# petsc_options_iname = '-pc_type'
# petsc_options_value = 'asm'
type = Steady
[]
[Preconditioning]
[FSP]
# It is the starting point of splitting
type = FSP
topsplit = 'uv' # uv should match the following block name
[uv]
# Generally speaking, there are four types of splitting we could choose
# <additive,multiplicative,symmetric_multiplicative,schur>
# An approximate solution to the original system
# | A_uu A_uv | | u | _ |f_u|
# | 0 A_vv | | v | - |f_v|
# is obtained by solving the following subsystems
# A_uu u = f_u and A_vv v = f_v
# If splitting type is specified as schur, we may also want to set more options to
# control how schur works using PETSc options
# petsc_options_iname = '-pc_fieldsplit_schur_fact_type -pc_fieldsplit_schur_precondition'
# petsc_options_value = 'full selfp'
splitting = 'u v' # u and v are the names of subsolvers
splitting_type = additive
[]
[u]
# PETSc options for this subsolver
# A prefix will be applied, so just put the options for this subsolver only
vars = 'u'
petsc_options_iname = '-pc_type -ksp_type'
petsc_options_value = ' hypre preonly'
[]
[v]
# PETSc options for this subsolver
vars = 'v'
petsc_options_iname = '-pc_type -ksp_type'
petsc_options_value = ' hypre preonly'
[]
[]
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/vectorpostprocessors/elements_along_line/3d.i
[Mesh]
type = GeneratedMesh
parallel_type = replicated # Until RayTracing.C is fixed
dim = 3
nx = 10
ny = 10
nz = 10
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[VectorPostprocessors]
[./elems]
type = ElementsAlongLine
start = '0.05 0.05 0.05'
end = '0.05 0.05 0.405'
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
csv = true
[]
modules/richards/test/tests/pressure_pulse/pp_fu_01.i
# investigating pressure pulse in 1D with 1 phase
# steadystate
[Mesh]
type = GeneratedMesh
dim = 1
nx = 10
xmin = 0
xmax = 100
[]
[GlobalParams]
richardsVarNames_UO = PPNames
density_UO = DensityConstBulk
relperm_UO = RelPermPower
SUPG_UO = SUPGstandard
sat_UO = Saturation
seff_UO = SeffVG
[]
[UserObjects]
[./PPNames]
type = RichardsVarNames
richards_vars = pressure
[../]
[./DensityConstBulk]
type = RichardsDensityConstBulk
dens0 = 1000
bulk_mod = 2E9
[../]
[./SeffVG]
type = RichardsSeff1VG
m = 0.8
al = 1E-5
[../]
[./RelPermPower]
type = RichardsRelPermPower
simm = 0.0
n = 2
[../]
[./Saturation]
type = RichardsSat
s_res = 0.0
sum_s_res = 0.0
[../]
[./SUPGstandard]
type = RichardsSUPGstandard
p_SUPG = 1E3
[../]
[]
[Variables]
[./pressure]
order = FIRST
family = LAGRANGE
initial_condition = 2E6
[../]
[]
[BCs]
[./left]
type = DirichletBC
boundary = left
value = 3E6
variable = pressure
[../]
[]
[AuxVariables]
[./Seff1VG_Aux]
[../]
[]
[Kernels]
active = 'richardsf'
[./richardst]
type = RichardsMassChange
variable = pressure
[../]
[./richardsf]
type = RichardsFullyUpwindFlux
variable = pressure
[../]
[]
[AuxKernels]
[./Seff1VG_AuxK]
type = RichardsSeffAux
variable = Seff1VG_Aux
seff_UO = SeffVG
pressure_vars = pressure
[../]
[]
[Materials]
[./rock]
type = RichardsMaterial
block = 0
mat_porosity = 0.1
mat_permeability = '1E-15 0 0 0 1E-15 0 0 0 1E-15'
viscosity = 1E-3
gravity = '0 0 0'
linear_shape_fcns = true
[../]
[]
[Preconditioning]
[./andy]
type = SMP
full = true
petsc_options_iname = '-ksp_type -pc_type -snes_atol -snes_rtol -snes_max_it'
petsc_options_value = 'bcgs bjacobi 1E-15 1E-10 10000'
[../]
[]
[Executioner]
type = Steady
solve_type = Newton
[]
[Outputs]
execute_on = 'timestep_end'
file_base = pp_fu_01
exodus = true
[]
modules/richards/test/tests/pressure_pulse/pp_fu_21.i
# investigating pressure pulse in 1D with 2 phase
# steadystate
[Mesh]
type = GeneratedMesh
dim = 1
nx = 10
xmin = 0
xmax = 100
[]
[GlobalParams]
richardsVarNames_UO = PPNames
density_UO = 'DensityWater DensityGas'
relperm_UO = 'RelPermWater RelPermGas'
SUPG_UO = 'SUPGwater SUPGgas'
sat_UO = 'SatWater SatGas'
seff_UO = 'SeffWater SeffGas'
[]
[UserObjects]
[./PPNames]
type = RichardsVarNames
richards_vars = 'pwater pgas'
[../]
[./DensityWater]
type = RichardsDensityConstBulk
dens0 = 1000
bulk_mod = 2E9
[../]
[./DensityGas]
type = RichardsDensityConstBulk
dens0 = 1
bulk_mod = 2E6
[../]
[./SeffWater]
type = RichardsSeff2waterVG
m = 0.8
al = 1E-5
[../]
[./SeffGas]
type = RichardsSeff2gasVG
m = 0.8
al = 1E-5
[../]
[./RelPermWater]
type = RichardsRelPermPower
simm = 0.0
n = 2
[../]
[./RelPermGas]
type = RichardsRelPermPower
simm = 0.0
n = 3
[../]
[./SatWater]
type = RichardsSat
s_res = 0.0
sum_s_res = 0.0
[../]
[./SatGas]
type = RichardsSat
s_res = 0.0
sum_s_res = 0.0
[../]
[./SUPGwater]
type = RichardsSUPGstandard
p_SUPG = 1E3
[../]
[./SUPGgas]
type = RichardsSUPGstandard
p_SUPG = 1E3
[../]
[]
[Variables]
[./pwater]
order = FIRST
family = LAGRANGE
[../]
[./pgas]
order = FIRST
family = LAGRANGE
[../]
[]
[ICs]
[./water_ic]
type = ConstantIC
value = 2E6
variable = pwater
[../]
[./gas_ic]
type = ConstantIC
value = 2E6
variable = pgas
[../]
[]
[BCs]
[./left]
type = DirichletBC
boundary = left
value = 3E6
variable = pwater
[../]
[./left_gas]
type = DirichletBC
boundary = left
value = 3E6
variable = pgas
[../]
[]
[AuxVariables]
[./Seff1VG_Aux]
[../]
[]
[Kernels]
active = 'richardsfwater richardsfgas pconstraint'
[./richardstwater]
type = RichardsMassChange
variable = pwater
[../]
[./richardsfwater]
type = RichardsFullyUpwindFlux
variable = pwater
[../]
[./richardstgas]
type = RichardsMassChange
variable = pgas
[../]
[./richardsfgas]
type = RichardsFullyUpwindFlux
variable = pgas
[../]
[./pconstraint]
type = RichardsPPenalty
variable = pgas
a = 1E-8
lower_var = pwater
[../]
[]
[AuxKernels]
[./Seff1VG_AuxK]
type = RichardsSeffAux
variable = Seff1VG_Aux
seff_UO = SeffWater
pressure_vars = 'pwater pgas'
[../]
[]
[Materials]
[./rock]
type = RichardsMaterial
block = 0
mat_porosity = 0.1
mat_permeability = '1E-15 0 0 0 1E-15 0 0 0 1E-15'
viscosity = '1E-3 1E-5'
gravity = '0 0 0'
linear_shape_fcns = true
[../]
[]
[Preconditioning]
[./andy]
type = SMP
full = true
petsc_options_iname = '-pc_factor_shift_type'
petsc_options_value = 'nonzero'
[../]
[]
[Executioner]
type = Steady
solve_type = Newton
nl_rel_tol = 1.e-10
nl_max_its = 10
[]
[Outputs]
execute_on = 'timestep_end'
file_base = pp_fu_21
exodus = true
[]
modules/functional_expansion_tools/test/tests/standard_use/neglect_invalid_enum.i
[Mesh]
type = GeneratedMesh
dim = 1
xmin = -1
xmax = 1
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diffusion]
type = Diffusion
variable = u
[../]
[]
[Functions]
[./series]
type = FunctionSeries
series_type = Cartesian
x = Legendre
disc = Zernike
orders = '0'
physical_bounds = '-1 1'
[../]
[]
[Executioner]
type = Steady
[]
test/tests/meshgenerators/generate_element_subdomain_id/tri_with_subdomainid.i
[MeshGenerators]
[./gmg]
type = GeneratedMeshGenerator
dim = 2
nx = 2
ny = 2
nz = 0
zmin = 0
zmax = 0
elem_type = TRI3
[]
[./subdomain_id]
type = ElementSubdomainIDGenerator
input = gmg
subdomain_ids = '0 1 1 1
1 1 1 0'
[]
[]
[Mesh]
type = MeshGeneratorMesh
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
active = 'left right'
# Mesh Generation produces boundaries in counter-clockwise fashion
[./left]
type = DirichletBC
variable = u
boundary = 3
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 1
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
exodus = true
[]
modules/phase_field/test/tests/feature_flood_test/parallel_feature_count.i
[Mesh]
type = ImageMesh
dim = 2
file = spiral_16x16.png
scale_to_one = false
[]
[Variables]
[./u]
order = CONSTANT
family = MONOMIAL
[../]
[]
[AuxVariables]
[./feature]
order = CONSTANT
family = MONOMIAL
[../]
[./proc_id]
order = CONSTANT
family = MONOMIAL
[../]
[./feature_ghost]
order = CONSTANT
family = MONOMIAL
[../]
[]
[AuxKernels]
[./nodal_flood_aux]
type = FeatureFloodCountAux
variable = feature
flood_counter = flood_count_pp
execute_on = 'initial timestep_end'
[../]
[./proc_id]
type = ProcessorIDAux
variable = proc_id
execute_on = 'initial timestep_end'
[../]
[./ghost]
type = FeatureFloodCountAux
variable = feature_ghost
field_display = GHOSTED_ENTITIES
flood_counter = flood_count_pp
execute_on = 'initial timestep_end'
[../]
[]
[Functions]
[./tif]
type = ImageFunction
component = 0
[../]
[]
[ICs]
[./u_ic]
type = FunctionIC
function = tif
variable = u
[../]
[]
[Postprocessors]
[./flood_count_pp]
type = FeatureFloodCount
variable = u
threshold = 1.0
execute_on = 'initial timestep_end'
[../]
[]
[Problem]
type = FEProblem
solve = false
[]
[Executioner]
type = Steady
[]
[Outputs]
csv = true
[]
test/tests/mesh_modifiers/add_side_sets_from_bounding_box/multiple_boundary_ids_3d.i
[Mesh]
type = GeneratedMesh
dim = 3
nx = 10
ny = 10
nz = 10
# This MeshModifier currently only works with ReplicatedMesh.
# For more information, refer to #2129.
parallel_type = replicated
[]
[MeshModifiers]
[./createNewSidesetOne]
type = AddSideSetsFromBoundingBox
boundary_id_old = 'left bottom front'
boundary_id_new = 10
bottom_left = '-0.1 -0.1 -0.1'
top_right = '0.1 0.2 0.3'
block_id = 0
[../]
[./createNewSidesetTwo]
type = AddSideSetsFromBoundingBox
boundary_id_old = 'right top back'
boundary_id_new = 11
bottom_left = '0.6 0.7 0.8'
top_right = '1.1 1.1 1.1'
block_id = 0
[../]
[./createNewSidesetThree]
type = AddSideSetsFromBoundingBox
boundary_id_old = 'left top back'
boundary_id_new = 12
bottom_left = '-0.1 0.9 0.9'
top_right = '0.1 1.1 1.1'
block_id = 0
[../]
[./createNewSidesetFour]
type = AddSideSetsFromBoundingBox
boundary_id_old = 'front'
boundary_id_new = 13
bottom_left = '0.4 0.4 0.9'
top_right = '0.6 0.6 1.1'
block_id = 0
[../]
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./firstBC]
type = DirichletBC
variable = u
boundary = 10
value = 1
[../]
[./secondBC]
type = DirichletBC
variable = u
boundary = 11
value = 0
[../]
[./thirdBC]
type = DirichletBC
variable = u
boundary = 12
value = 0
[../]
[./fourthBC]
type = DirichletBC
variable = u
boundary = 13
value = 0.5
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
exodus = true
[]
modules/porous_flow/test/tests/newton_cooling/nc06.i
# Newton cooling from a bar. 1-phase and heat, steady
[Mesh]
type = GeneratedMesh
dim = 2
nx = 100
ny = 1
xmin = 0
xmax = 100
ymin = 0
ymax = 1
[]
[GlobalParams]
PorousFlowDictator = dictator
[]
[UserObjects]
[./dictator]
type = PorousFlowDictator
porous_flow_vars = 'pressure temp'
number_fluid_phases = 1
number_fluid_components = 1
[../]
[./pc]
type = PorousFlowCapillaryPressureVG
m = 0.8
alpha = 1e-5
[../]
[]
[Variables]
[./pressure]
[../]
[./temp]
[../]
[]
[ICs]
# have to start these reasonably close to their steady-state values
[./pressure]
type = FunctionIC
variable = pressure
function = '(2-x/100)*1E6'
[../]
[./temperature]
type = FunctionIC
variable = temp
function = 100+0.1*x
[../]
[]
[Kernels]
[./flux]
type = PorousFlowAdvectiveFlux
fluid_component = 0
gravity = '0 0 0'
variable = pressure
[../]
[./heat_advection]
type = PorousFlowHeatAdvection
gravity = '0 0 0'
variable = temp
[../]
[]
[Modules]
[./FluidProperties]
[./simple_fluid]
type = SimpleFluidProperties
bulk_modulus = 1e6
density0 = 1000
thermal_expansion = 0
viscosity = 1e-3
cv = 1e6
porepressure_coefficient = 0
[../]
[../]
[]
[Materials]
[./temperature]
type = PorousFlowTemperature
temperature = temp
[../]
[./ppss]
type = PorousFlow1PhaseP
porepressure = pressure
capillary_pressure = pc
[../]
[./massfrac]
type = PorousFlowMassFraction
[../]
[./simple_fluid]
type = PorousFlowSingleComponentFluid
fp = simple_fluid
phase = 0
[../]
[./permeability]
type = PorousFlowPermeabilityConst
permeability = '1E-15 0 0 0 1E-15 0 0 0 1E-15'
[../]
[./relperm]
type = PorousFlowRelativePermeabilityCorey # irrelevant in this fully-saturated situation
n = 2
phase = 0
[../]
[]
[BCs]
[./leftp]
type = DirichletBC
variable = pressure
boundary = left
value = 2E6
[../]
[./leftt]
type = DirichletBC
variable = temp
boundary = left
value = 100
[../]
[./newtonp]
type = PorousFlowPiecewiseLinearSink
variable = pressure
boundary = right
pt_vals = '0 100000 200000 300000 400000 500000 600000 700000 800000 900000 1000000 1100000 1200000 1300000 1400000 1500000 1600000 1700000 1800000 1900000 2000000'
multipliers = '0. 5.6677197748570516e-6 0.000011931518841831313 0.00001885408740732065 0.000026504708864284114 0.000034959953203725676 0.000044304443352900224 0.00005463170211001232 0.00006604508815181467 0.00007865883048198513 0.00009259917167338928 0.00010800563134618119 0.00012503240252705603 0.00014384989486488752 0.00016464644014777016 0.00018763017719085535 0.0002130311349595711 0.00024110353477682344 0.00027212833465544285 0.00030641604122040985 0.00034430981736352295'
use_mobility = false
use_relperm = false
fluid_phase = 0
flux_function = 1
[../]
[./newton]
type = PorousFlowPiecewiseLinearSink
variable = temp
boundary = right
pt_vals = '0 100000 200000 300000 400000 500000 600000 700000 800000 900000 1000000 1100000 1200000 1300000 1400000 1500000 1600000 1700000 1800000 1900000 2000000'
multipliers = '0. 5.6677197748570516e-6 0.000011931518841831313 0.00001885408740732065 0.000026504708864284114 0.000034959953203725676 0.000044304443352900224 0.00005463170211001232 0.00006604508815181467 0.00007865883048198513 0.00009259917167338928 0.00010800563134618119 0.00012503240252705603 0.00014384989486488752 0.00016464644014777016 0.00018763017719085535 0.0002130311349595711 0.00024110353477682344 0.00027212833465544285 0.00030641604122040985 0.00034430981736352295'
use_mobility = false
use_relperm = false
use_internal_energy = true
fluid_phase = 0
flux_function = 1
[../]
[]
[VectorPostprocessors]
[./porepressure]
type = LineValueSampler
variable = pressure
start_point = '0 0.5 0'
end_point = '100 0.5 0'
sort_by = x
num_points = 11
execute_on = timestep_end
[../]
[./temperature]
type = LineValueSampler
variable = temp
start_point = '0 0.5 0'
end_point = '100 0.5 0'
sort_by = x
num_points = 11
execute_on = timestep_end
[../]
[]
[Preconditioning]
[./andy]
type = SMP
full = true
petsc_options = '-snes_converged_reason'
petsc_options_iname = '-ksp_type -pc_type -sub_pc_type -snes_max_it -sub_pc_factor_shift_type -pc_asm_overlap -snes_atol -snes_rtol '
petsc_options_value = 'gmres asm lu 100 NONZERO 2 1E-8 1E-15'
[../]
[]
[Executioner]
type = Steady
solve_type = Newton
[]
[Outputs]
file_base = nc06
execute_on = timestep_end
exodus = true
[./along_line]
type = CSV
execute_vector_postprocessors_on = timestep_end
[../]
[]
test/tests/dgkernels/adaptivity/adaptivity.i
# This input file is used for two tests:
# 1) Check that DGKernels work with mesh adaptivity
# 2) Error out when DGKernels are used with adaptivity
# and stateful material prpoerties
[Mesh]
type = GeneratedMesh
dim = 3
nx = 2
ny = 2
nz = 2
parallel_type = 'replicated'
[]
[Variables]
[./u]
order = FIRST
family = MONOMIAL
[./InitialCondition]
type = ConstantIC
value = 1
[../]
[../]
[]
[Functions]
[./forcing_fn]
type = ParsedFunction
value = (x*x*x)-6.0*x
[../]
[./bc_fn]
type = ParsedFunction
value = (x*x*x)
[../]
[]
[Kernels]
[./diff]
type = MatDiffusionTest
variable = u
prop_name = diffusivity
[../]
[./abs]
type = Reaction
variable = u
[../]
[./forcing]
type = BodyForce
variable = u
function = forcing_fn
[../]
[]
[DGKernels]
[./dgdiff]
type = DGDiffusion
variable = u
sigma = 6
epsilon = -1.0
diff = diffusivity
[../]
[]
[BCs]
active = 'all'
[./all]
type = DGMDDBC
variable = u
boundary = '1 2 3 4'
function = bc_fn
prop_name = diffusivity
sigma = 6
epsilon = -1.0
[../]
[]
[Materials]
active = 'constant'
[./stateful]
type = StatefulTest
prop_names = 'diffusivity'
prop_values = '1'
[../]
[./constant]
type = GenericConstantMaterial
prop_names = 'diffusivity'
prop_values = '1'
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Adaptivity]
marker = 'marker'
steps = 1
[./Indicators]
[./error]
type = GradientJumpIndicator
variable = u
[../]
[../]
[./Markers]
[./marker]
type = ErrorFractionMarker
coarsen = 0.5
indicator = error
refine = 0.5
[../]
[../]
[]
[Outputs]
exodus = true
[]
test/tests/misc/check_error/multiple_bad_ic_test.i
[Mesh]
file = sq-2blk.e
uniform_refine = 1
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxVariables]
[./u_aux]
order = FIRST
family = LAGRANGE
[../]
[]
[ICs]
[./ic_u_1]
type = ConstantIC
variable = u
value = 42
block = '1'
[../]
[./ic_u_2]
type = ConstantIC
variable = u
value = 24
# Oops - can't have two ICs on the same block
[../]
[./ic_u_aux_1]
type = ConstantIC
variable = u_aux
value = 6.25
block = '1'
[../]
[./ic_u_aux_2]
type = ConstantIC
variable = u_aux
value = 9.99
block = '2'
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
nl_rel_tol = 1e-10
[]
[Outputs]
exodus = true
[]
test/tests/utils/spline_interpolation/bicubic_spline_interpolation.i
[Mesh]
type = GeneratedMesh
dim = 3
nz = 1
nx = 4
ny = 4
xmax = 4
ymax = 4
[]
[Functions]
[./yx1]
type = ParsedFunction
value = '3*x^2'
[../]
[./yx2]
type = ParsedFunction
value = '6*y^2'
[../]
[./spline_fn]
type = BicubicSplineFunction
x1 = '0 2 4'
x2 = '0 2 4 6'
y = '0 16 128 432 8 24 136 440 64 80 192 496'
yx11 = '0 0 0 0'
yx1n = '48 48 48 48'
yx21 = '0 0 0'
yx2n = '216 216 216'
yx1 = 'yx1'
yx2 = 'yx2'
[../]
[./u_func]
type = ParsedFunction
value = 'x^3 + 2*y^3'
[../]
[./u2_forcing_func]
type = ParsedFunction
value = '-6*x - 12*y'
[../]
[]
[Variables]
[./u]
[../]
[]
[AuxVariables]
[./bi_func_value]
order = FIRST
family = LAGRANGE
[../]
[./x_deriv]
order = FIRST
family = LAGRANGE
[../]
[./y_deriv]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxKernels]
[./bi_func_value]
type = FunctionAux
variable = bi_func_value
function = spline_fn
[../]
[./deriv_1]
type = FunctionDerivativeAux
function = spline_fn
variable = x_deriv
component = 1
[../]
[./deriv_2]
type = FunctionDerivativeAux
function = spline_fn
variable = y_deriv
component = 2
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[./body_force]
type = BodyForce
variable = u
function = u2_forcing_func
[../]
[]
[BCs]
[./sides]
type = FunctionDirichletBC
variable = u
boundary = '0 1 2 3'
function = u_func
[../]
[]
[Postprocessors]
[./nodal_l2_err_spline]
type = NodalL2Error
variable = u
function = spline_fn
execute_on = 'initial timestep_end'
[../]
[./nodal_l2_err_analytic]
type = NodalL2Error
variable = u
function = u_func
execute_on = 'initial timestep_end'
[../]
[./x_deriv_err_analytic]
type = NodalL2Error
variable = x_deriv
function = yx1
execute_on = 'initial timestep_end'
[../]
[./y_deriv_err_analytic]
type = NodalL2Error
variable = y_deriv
function = yx2
execute_on = 'initial timestep_end'
[../]
[]
[Executioner]
type = Steady
solve_type = NEWTON
[]
[Outputs]
exodus = true
[]
test/tests/outputs/oversample/oversample_file.i
[Mesh]
type = FileMesh
file = square.e
dim = 2
uniform_refine = 1
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = PJFNK
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
execute_on = 'timestep_end'
[./exodus]
type = Exodus
refinements = 1
file_base = exodus_oversample_custom_name
[../]
[]
test/tests/geomsearch/3d_penetration_locator/3d_penetration_locator_test.i
[Mesh]
file = 3d_penetration_test.e
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxVariables]
[./penetration]
order = FIRST
family = LAGRANGE
[../]
[./tangential_distance]
order = FIRST
family = LAGRANGE
[../]
[./normal_x]
order = FIRST
family = LAGRANGE
[../]
[./normal_y]
order = FIRST
family = LAGRANGE
[../]
[./normal_z]
order = FIRST
family = LAGRANGE
[../]
[./closest_point_x]
order = FIRST
family = LAGRANGE
[../]
[./closest_point_y]
order = FIRST
family = LAGRANGE
[../]
[./closest_point_z]
order = FIRST
family = LAGRANGE
[../]
[./element_id]
order = FIRST
family = LAGRANGE
[../]
[./side]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[AuxKernels]
[./penetrate]
type = PenetrationAux
variable = penetration
boundary = 2
paired_boundary = 3
[../]
[./penetrate2]
type = PenetrationAux
variable = penetration
boundary = 3
paired_boundary = 2
[../]
[./penetrate3]
type = PenetrationAux
variable = tangential_distance
boundary = 2
paired_boundary = 3
quantity = tangential_distance
[../]
[./penetrate4]
type = PenetrationAux
variable = tangential_distance
boundary = 3
paired_boundary = 2
quantity = tangential_distance
[../]
[./penetrate5]
type = PenetrationAux
variable = normal_x
boundary = 2
paired_boundary = 3
quantity = normal_x
[../]
[./penetrate6]
type = PenetrationAux
variable = normal_x
boundary = 3
paired_boundary = 2
quantity = normal_x
[../]
[./penetrate7]
type = PenetrationAux
variable = normal_y
boundary = 2
paired_boundary = 3
quantity = normal_y
[../]
[./penetrate8]
type = PenetrationAux
variable = normal_y
boundary = 3
paired_boundary = 2
quantity = normal_y
[../]
[./penetrate9]
type = PenetrationAux
variable = normal_z
boundary = 2
paired_boundary = 3
quantity = normal_z
[../]
[./penetrate10]
type = PenetrationAux
variable = normal_z
boundary = 3
paired_boundary = 2
quantity = normal_z
[../]
[./penetrate11]
type = PenetrationAux
variable = closest_point_x
boundary = 2
paired_boundary = 3
quantity = closest_point_x
[../]
[./penetrate12]
type = PenetrationAux
variable = closest_point_x
boundary = 3
paired_boundary = 2
quantity = closest_point_x
[../]
[./penetrate13]
type = PenetrationAux
variable = closest_point_y
boundary = 2
paired_boundary = 3
quantity = closest_point_y
[../]
[./penetrate14]
type = PenetrationAux
variable = closest_point_y
boundary = 3
paired_boundary = 2
quantity = closest_point_y
[../]
[./penetrate15]
type = PenetrationAux
variable = closest_point_z
boundary = 2
paired_boundary = 3
quantity = closest_point_z
[../]
[./penetrate16]
type = PenetrationAux
variable = closest_point_z
boundary = 3
paired_boundary = 2
quantity = closest_point_z
[../]
[./penetrate17]
type = PenetrationAux
variable = element_id
boundary = 2
paired_boundary = 3
quantity = element_id
[../]
[./penetrate18]
type = PenetrationAux
variable = element_id
boundary = 3
paired_boundary = 2
quantity = element_id
[../]
[./penetrate19]
type = PenetrationAux
variable = side
boundary = 2
paired_boundary = 3
quantity = side
[../]
[./penetrate20]
type = PenetrationAux
variable = side
boundary = 3
paired_boundary = 2
quantity = side
[../]
[]
[BCs]
active = 'block1_left block1_right block2_left block2_right'
[./block1_left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./block1_right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[./block2_left]
type = DirichletBC
variable = u
boundary = 3
value = 0
[../]
[./block2_right]
type = DirichletBC
variable = u
boundary = 4
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
file_base = out
exodus = true
[]
test/tests/auxkernels/nodal_aux_var/nodal_sort_test.i
[Mesh]
file = square.e
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[AuxVariables]
[./one]
order = FIRST
family = LAGRANGE
initial_condition = 0
[../]
[./two]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[AuxKernels]
# Intentionally out of order to test sorting capabiilties
active = 'one two'
[./two]
variable = two
type = CoupledAux
value = 2
operator = '/'
coupled = one
[../]
[./one]
variable = one
type = ConstantAux
value = 1
[../]
[./five]
type = ConstantAux
variable = five
boundary = '1 2'
value = 5
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
[./out]
type = Exodus
elemental_as_nodal = true
[../]
[]
test/tests/misc/check_error/check_dynamic_name_block.i
[Mesh]
file = three_block.e
# These names will be applied on the fly to the
# mesh so they can be used in the input file
# In addition they will show up in the input file
block_id = '1 2 3'
block_name = 'wood steel wood' # Can't have duplicate names
boundary_id = '1 2'
boundary_name = 'left right'
[]
[Variables]
active = 'u'
[./u]
order = FIRST
family = LAGRANGE
[../]
[]
[Kernels]
active = 'diff'
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
active = 'left right'
[./left]
type = DirichletBC
variable = u
boundary = 'left'
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 'right'
value = 1
[../]
[]
[Materials]
active = empty
[./empty]
type = MTMaterial
block = 'wood steel'
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
[]
[Outputs]
exodus = true
[]
test/tests/ics/function_ic/parsed_function.i
#
# Test the automatically generated gradients in ParsedFunction and the gradient pass-through in FunctionIC
# OLD MOOSE behavior was for parsed_function to behave the sam eas parsed_zerograd_function
# NEW MOOSE behavior is for parsed_function to behave the same as parsed_grad_function
#
[Mesh]
type = GeneratedMesh
dim = 2
xmin = 0
xmax = 3.141
ymin = 0
ymax = 3.141
nx = 10
ny = 10
[]
[Variables]
[./u]
order = THIRD
family = HERMITE
[../]
[]
[Functions]
[./parsed_function]
type = ParsedFunction
value = 'sin(x)-cos(y/2)'
[../]
[./parsed_grad_function]
type =ParsedGradFunction
value = 'sin(x)-cos(y/2)'
grad_x = 'cos(x)'
grad_y = 'sin(y/2)/2'
[../]
[./parsed_zerograd_function]
type = ParsedGradFunction
value = 'sin(x)-cos(y/2)'
grad_x = '0'
grad_y = '0'
[../]
[]
[ICs]
[./u_ic]
type = FunctionIC
variable = 'u'
function = parsed_function
[../]
[]
[Executioner]
type = Steady
[]
[Problem]
solve = false
[]
[Outputs]
file_base = parsed
[./OverSampling]
type = Exodus
refinements = 3
[../]
[]
test/tests/misc/check_error/kernel_with_vector_var.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 2
ny = 2
[]
[Variables]
[./u]
order = FIRST
family = LAGRANGE_VEC
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = 1
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = 2
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'NEWTON'
[]
[Outputs]
file_base = out
exodus = true
[]
modules/richards/test/tests/gravity_head_2/gh02.i
# unsaturated = true
# gravity = true
# supg = false
# transient = false
[Mesh]
type = GeneratedMesh
dim = 1
nx = 20
xmin = 0
xmax = 1
[]
[GlobalParams]
richardsVarNames_UO = PPNames
[]
[UserObjects]
[./PPNames]
type = RichardsVarNames
richards_vars = 'pwater pgas'
[../]
[./DensityWater]
type = RichardsDensityConstBulk
dens0 = 1
bulk_mod = 1.0E2
[../]
[./DensityGas]
type = RichardsDensityConstBulk
dens0 = 0.5
bulk_mod = 0.5E2
[../]
[./SeffWater]
type = RichardsSeff2waterVG
m = 0.8
al = 1
[../]
[./SeffGas]
type = RichardsSeff2gasVG
m = 0.8
al = 1
[../]
[./RelPermWater]
type = RichardsRelPermPower
simm = 0.0
n = 2
[../]
[./RelPermGas]
type = RichardsRelPermPower
simm = 0.0
n = 3
[../]
[./SatWater]
type = RichardsSat
s_res = 0.1
sum_s_res = 0.15
[../]
[./SatGas]
type = RichardsSat
s_res = 0.05
sum_s_res = 0.15
[../]
[./SUPGwater]
type = RichardsSUPGnone
[../]
[./SUPGgas]
type = RichardsSUPGnone
[../]
[]
[Variables]
[./pwater]
order = FIRST
family = LAGRANGE
[../]
[./pgas]
order = FIRST
family = LAGRANGE
[../]
[]
[ICs]
# get nonconvergence if initial condition is too crazy
[./water_ic]
type = FunctionIC
function = pwater_initial
variable = pwater
[../]
[./gas_ic]
type = FunctionIC
function = pgas_initial
variable = pgas
[../]
[]
[Kernels]
active = 'richardsfwater richardsfgas'
[./richardstwater]
type = RichardsMassChange
variable = pwater
[../]
[./richardsfwater]
type = RichardsFlux
variable = pwater
[../]
[./richardstgas]
type = RichardsMassChange
variable = pgas
[../]
[./richardsfgas]
type = RichardsFlux
variable = pgas
[../]
[]
[AuxVariables]
[./seffgas]
[../]
[./seffwater]
[../]
[]
[AuxKernels]
[./seffgas_kernel]
type = RichardsSeffAux
pressure_vars = 'pwater pgas'
seff_UO = SeffGas
variable = seffgas
[../]
[./seffwater_kernel]
type = RichardsSeffAux
pressure_vars = 'pwater pgas'
seff_UO = SeffWater
variable = seffwater
[../]
[]
[Postprocessors]
[./mwater_init]
type = RichardsMass
variable = pwater
execute_on = timestep_begin
outputs = none
[../]
[./mgas_init]
type = RichardsMass
variable = pgas
execute_on = timestep_begin
outputs = none
[../]
[./mwater_fin]
type = RichardsMass
variable = pwater
execute_on = timestep_end
outputs = none
[../]
[./mgas_fin]
type = RichardsMass
variable = pgas
execute_on = timestep_end
outputs = none
[../]
[./mass_error_water]
type = FunctionValuePostprocessor
function = fcn_mass_error_w
outputs = none # no reason why mass should be conserved
[../]
[./mass_error_gas]
type = FunctionValuePostprocessor
function = fcn_mass_error_g
outputs = none # no reason why mass should be conserved
[../]
[./pw_left]
type = PointValue
point = '0 0 0'
variable = pwater
outputs = none
[../]
[./pw_right]
type = PointValue
point = '1 0 0'
variable = pwater
outputs = none
[../]
[./error_water]
type = FunctionValuePostprocessor
function = fcn_error_water
[../]
[./pg_left]
type = PointValue
point = '0 0 0'
variable = pgas
outputs = none
[../]
[./pg_right]
type = PointValue
point = '1 0 0'
variable = pgas
outputs = none
[../]
[./error_gas]
type = FunctionValuePostprocessor
function = fcn_error_gas
[../]
[]
[Functions]
[./pwater_initial]
type = ParsedFunction
value = 1-x/2
[../]
[./pgas_initial]
type = ParsedFunction
value = 2-x/5
[../]
[./fcn_mass_error_w]
type = ParsedFunction
value = 'abs(0.5*(mi-mf)/(mi+mf))'
vars = 'mi mf'
vals = 'mwater_init mwater_fin'
[../]
[./fcn_mass_error_g]
type = ParsedFunction
value = 'abs(0.5*(mi-mf)/(mi+mf))'
vars = 'mi mf'
vals = 'mgas_init mgas_fin'
[../]
[./fcn_error_water]
type = ParsedFunction
value = 'abs((-b*log(-(gdens0*xval+(-b*exp(-p0/b)))/b)-p1)/p1)'
vars = 'b gdens0 p0 xval p1'
vals = '1E2 -1 pw_left 1 pw_right'
[../]
[./fcn_error_gas]
type = ParsedFunction
value = 'abs((-b*log(-(gdens0*xval+(-b*exp(-p0/b)))/b)-p1)/p1)'
vars = 'b gdens0 p0 xval p1'
vals = '0.5E2 -0.5 pg_left 1 pg_right'
[../]
[]
[Materials]
[./rock]
type = RichardsMaterial
block = 0
mat_porosity = 0.1
mat_permeability = '1E-5 0 0 0 1E-5 0 0 0 1E-5'
density_UO = 'DensityWater DensityGas'
relperm_UO = 'RelPermWater RelPermGas'
SUPG_UO = 'SUPGwater SUPGgas'
sat_UO = 'SatWater SatGas'
seff_UO = 'SeffWater SeffGas'
viscosity = '1E-3 0.5E-3'
gravity = '-1 0 0'
linear_shape_fcns = true
[../]
[]
[Preconditioning]
[./andy]
type = SMP
full = true
petsc_options_iname = '-ksp_type -pc_type -sub_pc_type -sub_pc_factor_shift_type -snes_atol -snes_rtol -snes_max_it'
petsc_options_value = 'gmres asm lu NONZERO 1E-10 1E-10 10000'
[../]
[]
[Executioner]
type = Steady
solve_type = Newton
[]
[Outputs]
execute_on = 'timestep_end'
file_base = gh02
csv = true
[]
test/tests/postprocessors/side_pps/side_pps_multi_bnd_test.i
#
# Tests elemental PPS running on multiple blocks
#
[Mesh]
type = StripeMesh
dim = 2
xmin = 0
xmax = 1
ymin = 0
ymax = 1
nx = 3
ny = 3
elem_type = QUAD4
stripes = 3
# StripeMesh currently only works correctly with ReplicatedMesh.
parallel_type = replicated
[]
[Functions]
[./forcing_fn]
type = ParsedFunction
value = x*(y+1)
[../]
[]
[Variables]
[./u]
family = MONOMIAL
order = CONSTANT
[../]
[]
[Kernels]
[./uv]
type = Reaction
variable = u
[../]
[./fv]
type = BodyForce
variable = u
function = forcing_fn
[../]
[]
[Postprocessors]
[./int_0_1]
type = SideIntegralVariablePostprocessor
variable = u
boundary = '0 1'
[../]
[]
[Executioner]
type = Steady
[]
[Outputs]
execute_on = 'timestep_end'
[./out]
type = Exodus
elemental_as_nodal = true
[../]
[]
test/tests/outputs/nemesis/nemesis_elemental.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 4
ny = 4
[]
[Variables]
[./u]
[../]
[]
[AuxVariables]
[./proc_id]
order = CONSTANT
family = MONOMIAL
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[AuxKernels]
[./proc_id]
type = ProcessorIDAux
variable = proc_id
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
execute_on = 'timestep_end'
nemesis = true
[]
test/tests/vectorpostprocessors/work_balance/work_balance.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 10
ny = 10
partitioner = linear
[]
[Variables]
[./u]
[../]
[]
[AuxVariables]
[./someaux]
[../]
[./otheraux]
family = MONOMIAL
order = CONSTANT
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[VectorPostprocessors]
[./nl_wb]
type = WorkBalance
execute_on = initial
system = nl
[]
[./aux_wb]
type = WorkBalance
execute_on = initial
system = aux
[]
[./all_wb]
type = WorkBalance
execute_on = initial
system = all
[]
[]
[Outputs]
csv = true
[]
test/tests/postprocessors/area_pp/area_pp.i
[Mesh]
type = GeneratedMesh
dim = 2
nx = 4
ny = 4
xmax = 1.2
ymax = 2.3
[]
[Variables]
[./u]
[../]
[]
[Kernels]
[./diff]
type = Diffusion
variable = u
[../]
[]
[BCs]
[./left]
type = DirichletBC
variable = u
boundary = left
value = 0
[../]
[./right]
type = DirichletBC
variable = u
boundary = right
value = 1
[../]
[]
[Postprocessors]
[./right]
type = AreaPostprocessor
boundary = 'right'
execute_on = 'initial timestep_end'
[../]
[./bottom]
type = AreaPostprocessor
boundary = 'bottom'
execute_on = 'initial timestep_end'
[../]
[./all]
type = AreaPostprocessor
boundary = 'left right bottom top'
execute_on = 'initial timestep_end'
[../]
[]
[Executioner]
type = Steady
solve_type = 'PJFNK'
petsc_options_iname = '-pc_type -pc_hypre_type'
petsc_options_value = 'hypre boomeramg'
[]
[Outputs]
csv = true
[]