SCALE-RM
|
module PROCESS More...
Functions/Subroutines | |
subroutine, public | prc_mpistart (comm) |
Start MPI. More... | |
subroutine, public | prc_universal_setup (comm, nprocs, ismaster) |
setup MPI in universal communicator More... | |
subroutine, public | prc_global_setup (abortall, comm) |
setup MPI in global communicator More... | |
subroutine, public | prc_local_setup (comm, myrank, ismaster) |
Setup MPI in local communicator. More... | |
subroutine, public | prc_singlecom_setup (comm, nprocs, myrank, ismaster) |
Setup MPI single communicator (not use universal-global-local setting) More... | |
subroutine, public | prc_errhandler_setup (use_fpm, master) |
Setup MPI error handler. More... | |
subroutine, public | prc_abort |
Abort Process. More... | |
subroutine, public | prc_mpifinish |
Stop MPI peacefully. More... | |
subroutine, public | prc_mpisplit (ORG_COMM, NUM_DOMAIN, PRC_DOMAINS, CONF_FILES, LOG_SPLIT, bulk_split, color_reorder, INTRA_COMM, inter_parent, inter_child, fname_local) |
MPI Communicator Split. More... | |
subroutine, public | prc_mpibarrier |
Barrier MPI. More... | |
real(dp) function, public | prc_mpitime () |
Get MPI time. More... | |
subroutine, public | prc_mpitimestat (avgvar, maxvar, minvar, maxidx, minidx, var) |
Calc global statistics for timer. More... | |
subroutine, public | prc_set_file_closer (routine) |
Variables | |
integer, parameter, public | prc_masterrank = 0 |
master process in each communicator More... | |
integer, parameter, public | prc_domain_nlim = 10000 |
max depth of domains More... | |
integer, parameter, public | prc_comm_null = MPI_COMM_NULL |
integer, public | prc_universal_comm_world = -1 |
original communicator More... | |
integer, public | prc_universal_myrank = -1 |
myrank in universal communicator More... | |
integer, public | prc_universal_nprocs = -1 |
process num in universal communicator More... | |
logical, public | prc_universal_ismaster = .false. |
master process in universal communicator? More... | |
integer, public | prc_universal_jobid = 0 |
my job ID in universal communicator More... | |
integer, public | prc_global_comm_world = -1 |
global communicator More... | |
integer, public | prc_global_myrank = -1 |
myrank in global communicator More... | |
integer, public | prc_global_nprocs = -1 |
process num in global communicator More... | |
logical, public | prc_global_ismaster = .false. |
master process in global communicator? More... | |
integer, public | prc_global_domainid = 0 |
my domain ID in global communicator More... | |
integer, dimension(prc_domain_nlim+1), public | prc_global_root |
root processes in global members More... | |
integer, public | prc_local_comm_world = -1 |
local communicator More... | |
integer, public | prc_nprocs = 1 |
myrank in local communicator More... | |
integer, public | prc_myrank = 0 |
process num in local communicator More... | |
logical, public | prc_ismaster = .false. |
master process in local communicator? More... | |
logical, public | prc_mpi_alive = .false. |
MPI is alive? More... | |
integer, public | prc_universal_handler |
error handler in universal communicator More... | |
integer, public | prc_abort_comm_world |
communicator for aborting More... | |
integer, public | prc_abort_handler |
error handler communicator for aborting More... | |
module PROCESS
subroutine, public scale_prc::prc_mpistart | ( | integer, intent(out) | comm | ) |
Start MPI.
Definition at line 121 of file scale_prc.F90.
References prc_abort_comm_world, and prc_mpi_alive.
Referenced by scale::scale_init(), scalerm(), scalerm_init(), and scalerm_pp().
subroutine, public scale_prc::prc_universal_setup | ( | integer, intent(in) | comm, |
integer, intent(out) | nprocs, | ||
logical, intent(out) | ismaster | ||
) |
setup MPI in universal communicator
Definition at line 146 of file scale_prc.F90.
References prc_masterrank, prc_universal_comm_world, prc_universal_ismaster, prc_universal_myrank, and prc_universal_nprocs.
Referenced by scalerm(), scalerm_init(), and scalerm_pp().
subroutine, public scale_prc::prc_global_setup | ( | logical, intent(in) | abortall, |
integer, intent(in) | comm | ||
) |
setup MPI in global communicator
Definition at line 184 of file scale_prc.F90.
References prc_global_comm_world, prc_global_ismaster, prc_global_myrank, prc_global_nprocs, and prc_masterrank.
Referenced by scalerm(), scalerm_init(), and scalerm_pp().
subroutine, public scale_prc::prc_local_setup | ( | integer, intent(in) | comm, |
integer, intent(out) | myrank, | ||
logical, intent(out) | ismaster | ||
) |
Setup MPI in local communicator.
Definition at line 219 of file scale_prc.F90.
References prc_ismaster, prc_local_comm_world, prc_masterrank, prc_myrank, and prc_nprocs.
Referenced by mod_rm_driver::rm_driver(), and mod_rm_prep::rm_prep().
subroutine, public scale_prc::prc_singlecom_setup | ( | integer, intent(in) | comm, |
integer, intent(out) | nprocs, | ||
integer, intent(out) | myrank, | ||
logical, intent(out) | ismaster | ||
) |
Setup MPI single communicator (not use universal-global-local setting)
Definition at line 252 of file scale_prc.F90.
References prc_abort_comm_world, prc_global_comm_world, prc_global_ismaster, prc_global_myrank, prc_global_nprocs, prc_ismaster, prc_local_comm_world, prc_masterrank, prc_myrank, prc_nprocs, prc_universal_comm_world, prc_universal_ismaster, prc_universal_myrank, and prc_universal_nprocs.
Referenced by scale::scale_init().
subroutine, public scale_prc::prc_errhandler_setup | ( | logical, intent(in) | use_fpm, |
logical, intent(in) | master | ||
) |
Setup MPI error handler.
Definition at line 301 of file scale_prc.F90.
References prc_abort(), prc_abort_comm_world, prc_abort_handler, prc_universal_handler, prc_universal_ismaster, scale_sigvars::sigabrt, scale_sigvars::sigfpe, scale_sigvars::sigint, scale_sigvars::sigquit, scale_sigvars::sigsegv, scale_sigvars::sigterm, and scale_sigvars::sigvars_get_all().
Referenced by scale::scale_init(), scalerm(), scalerm_init(), and scalerm_pp().
subroutine, public scale_prc::prc_abort | ( | ) |
Abort Process.
Definition at line 338 of file scale_prc.F90.
References prc_mpi_alive, and prc_universal_comm_world.
Referenced by mod_admin_restart::admin_restart_setup(), mod_admin_time::admin_time_setup(), mod_admin_versioncheck::admin_versioncheck(), scale_atmos_adiabat::atmos_adiabat_cape_3d(), scale_atmos_adiabat::atmos_adiabat_liftparcel_3d(), mod_atmos_admin::atmos_admin_getscheme(), mod_atmos_admin::atmos_admin_setup(), mod_atmos_bnd_driver::atmos_boundary_driver_set(), mod_atmos_bnd_driver::atmos_boundary_driver_setup(), mod_atmos_bnd_driver::atmos_boundary_driver_update(), mod_atmos_bnd_driver::atmos_boundary_set_file(), mod_atmos_bnd_driver::atmos_boundary_set_online(), mod_atmos_dyn_driver::atmos_dyn_driver_setup(), scale_atmos_dyn_common::atmos_dyn_filter_setup(), scale_atmos_dyn_fvm_flux::atmos_dyn_fvm_flux_setup(), scale_atmos_dyn::atmos_dyn_setup(), scale_atmos_dyn_tinteg_large_euler::atmos_dyn_tinteg_large_euler_setup(), scale_atmos_dyn_tinteg_large_rk3::atmos_dyn_tinteg_large_rk3_setup(), scale_atmos_dyn_tinteg_large::atmos_dyn_tinteg_large_setup(), scale_atmos_dyn_tinteg_short_rk3::atmos_dyn_tinteg_short_rk3_setup(), scale_atmos_dyn_tinteg_short_rk4::atmos_dyn_tinteg_short_rk4_setup(), scale_atmos_dyn_tinteg_short::atmos_dyn_tinteg_short_setup(), scale_atmos_dyn_tinteg_tracer_euler::atmos_dyn_tinteg_tracer_euler_setup(), scale_atmos_dyn_tinteg_tracer_rk3::atmos_dyn_tinteg_tracer_rk3_setup(), scale_atmos_dyn_tinteg_tracer::atmos_dyn_tinteg_tracer_setup(), scale_atmos_dyn_tstep_large_fvm_heve::atmos_dyn_tstep_large_fvm_heve_setup(), scale_atmos_dyn_tstep_large::atmos_dyn_tstep_large_setup(), scale_atmos_dyn_tstep_short_fvm_heve::atmos_dyn_tstep_short_fvm_heve_regist(), scale_atmos_dyn_tstep_short_fvm_hevi::atmos_dyn_tstep_short_fvm_hevi_regist(), scale_atmos_dyn_tstep_short_fvm_hivi::atmos_dyn_tstep_short_fvm_hivi_regist(), scale_atmos_dyn_tstep_short_fvm_hivi::atmos_dyn_tstep_short_fvm_hivi_setup(), scale_atmos_dyn_tstep_short::atmos_dyn_tstep_short_regist(), scale_atmos_dyn_tstep_tracer_fvm_heve::atmos_dyn_tstep_tracer_fvm_heve_setup(), scale_atmos_dyn_tstep_tracer::atmos_dyn_tstep_tracer_setup(), mod_atmos_dyn_vars::atmos_dyn_vars_restart_read(), mod_atmos_dyn_vars::atmos_dyn_vars_setup(), scale_atmos_grid_cartesc::atmos_grid_cartesc_generate(), scale_atmos_grid_cartesc_index::atmos_grid_cartesc_index_setup(), scale_atmos_grid_cartesc_metric::atmos_grid_cartesc_metric_rotcoef(), scale_atmos_grid_cartesc_metric::atmos_grid_cartesc_metric_setup(), scale_atmos_grid_cartesc_real::atmos_grid_cartesc_real_setup(), scale_atmos_grid_cartesc_real::atmos_grid_cartesc_real_update_z(), scale_atmos_grid_cartesc::atmos_grid_cartesc_setup(), scale_atmos_grid_icoa_index::atmos_grid_icoa_index_setup(), scale_atmos_hydrometeor::atmos_hydrometeor_regist(), scale_atmos_hydrometeor::atmos_hydrometeor_setup(), scale_atmos_hydrostatic::atmos_hydrostatic_buildrho_1d(), scale_atmos_hydrostatic::atmos_hydrostatic_buildrho_atmos_0d(), scale_atmos_hydrostatic::atmos_hydrostatic_buildrho_atmos_1d(), scale_atmos_hydrostatic::atmos_hydrostatic_buildrho_atmos_rev_1d(), scale_atmos_hydrostatic::atmos_hydrostatic_buildrho_bytemp_3d(), scale_atmos_hydrostatic::atmos_hydrostatic_buildrho_bytemp_atmos_rev_1d(), scale_atmos_hydrostatic::atmos_hydrostatic_setup(), mod_atmos_phy_ae_driver::atmos_phy_ae_driver_calc_tendency(), mod_atmos_phy_ae_driver::atmos_phy_ae_driver_setup(), mod_atmos_phy_ae_driver::atmos_phy_ae_driver_tracer_setup(), scale_atmos_phy_ae_kajino13::atmos_phy_ae_kajino13_setup(), scale_atmos_phy_ae_kajino13::atmos_phy_ae_kajino13_tracer_setup(), mod_atmos_phy_ae_vars::atmos_phy_ae_vars_setup(), mod_atmos_phy_bl_driver::atmos_phy_bl_driver_tracer_setup(), mod_atmos_phy_bl_vars::atmos_phy_bl_vars_setup(), mod_atmos_phy_ch_driver::atmos_phy_ch_driver_tracer_setup(), scale_atmos_phy_ch_rn222::atmos_phy_ch_rn222_setup(), mod_atmos_phy_ch_vars::atmos_phy_ch_vars_setup(), scale_atmos_phy_cp_common::atmos_phy_cp_common_setup(), mod_atmos_phy_cp_driver::atmos_phy_cp_driver_setup(), scale_atmos_phy_cp_kf::atmos_phy_cp_kf_setup(), scale_atmos_phy_cp_kf::atmos_phy_cp_kf_tendency(), mod_atmos_phy_cp_vars::atmos_phy_cp_vars_setup(), mod_atmos_phy_mp_driver::atmos_phy_mp_driver_qhyd2qtrc(), mod_atmos_phy_mp_driver::atmos_phy_mp_driver_setup(), mod_atmos_phy_mp_driver::atmos_phy_mp_driver_tracer_setup(), scale_atmos_phy_mp_kessler::atmos_phy_mp_kessler_setup(), scale_atmos_phy_mp_common::atmos_phy_mp_negative_fixer(), scale_atmos_phy_mp_common::atmos_phy_mp_saturation_adjustment_3d(), scale_atmos_phy_mp_sn14::atmos_phy_mp_sn14_qhyd2qtrc(), scale_atmos_phy_mp_sn14::atmos_phy_mp_sn14_setup(), scale_atmos_phy_mp_suzuki10::atmos_phy_mp_suzuki10_qhyd2qtrc(), scale_atmos_phy_mp_suzuki10::atmos_phy_mp_suzuki10_setup(), scale_atmos_phy_mp_suzuki10::atmos_phy_mp_suzuki10_tracer_setup(), scale_atmos_phy_mp_tomita08::atmos_phy_mp_tomita08_setup(), mod_atmos_phy_mp_vars::atmos_phy_mp_vars_setup(), mod_atmos_phy_rd_driver::atmos_phy_rd_driver_setup(), scale_atmos_phy_rd_mstrnx::atmos_phy_rd_mstrnx_flux(), scale_atmos_phy_rd_mstrnx::atmos_phy_rd_mstrnx_setup(), scale_atmos_phy_rd_offline::atmos_phy_rd_offline_flux(), scale_atmos_phy_rd_offline::atmos_phy_rd_offline_setup(), scale_atmos_phy_rd_profile::atmos_phy_rd_profile_setup(), scale_atmos_phy_rd_profile::atmos_phy_rd_profile_setup_zgrid(), mod_atmos_phy_rd_vars::atmos_phy_rd_vars_setup(), scale_atmos_phy_sf_bulk::atmos_phy_sf_bulk_setup(), scale_atmos_phy_sf_const::atmos_phy_sf_const_setup(), mod_atmos_phy_sf_driver::atmos_phy_sf_driver_setup(), mod_atmos_phy_sf_vars::atmos_phy_sf_vars_setup(), scale_atmos_phy_tb_d1980::atmos_phy_tb_d1980_config(), scale_atmos_phy_tb_d1980::atmos_phy_tb_d1980_setup(), scale_atmos_phy_tb_dns::atmos_phy_tb_dns_config(), scale_atmos_phy_tb_dns::atmos_phy_tb_dns_setup(), mod_atmos_phy_tb_driver::atmos_phy_tb_driver_tracer_setup(), scale_atmos_phy_tb_smg::atmos_phy_tb_smg_setup(), mod_atmos_phy_tb_vars::atmos_phy_tb_vars_setup(), scale_atmos_refstate::atmos_refstate_read(), scale_atmos_refstate::atmos_refstate_setup(), scale_atmos_saturation::atmos_saturation_moist_conversion_dens_all_0d(), scale_atmos_saturation::atmos_saturation_pote_1d(), scale_atmos_saturation::atmos_saturation_setup(), scale_atmos_saturation::atmos_saturation_tdew_liq_1d(), scale_atmos_sfc_ch_rn222::atmos_sfc_ch_rn222_land_flux(), scale_atmos_sfc_ch_rn222::atmos_sfc_ch_rn222_setup(), scale_atmos_solarins::atmos_solarins_setup(), mod_atmos_vars::atmos_vars_get_diagnostic_1d(), mod_atmos_vars::atmos_vars_get_diagnostic_2d(), mod_atmos_vars::atmos_vars_get_diagnostic_3d(), mod_atmos_vars::atmos_vars_monitor(), mod_atmos_vars::atmos_vars_restart_open(), mod_atmos_vars::atmos_vars_restart_read(), mod_atmos_vars::atmos_vars_setup(), scale_bulkflux::bulkflux_setup(), scale_land_phy_snow_ky90::calculationmo(), scale_calendar::calendar_cfunits2sec(), scale_calendar::calendar_sec2unit(), scale_calendar::calendar_setup(), scale_calendar::calendar_unit2sec(), scale_debug::check(), mod_cnv2d::cnv2d(), mod_cnv2d::cnv2d_setup(), mod_cnvlanduse::cnvlanduse(), mod_cnvlanduse::cnvlanduse_setup(), mod_cnvtopo::cnvtopo(), mod_cnvtopo::cnvtopo_setup(), scale_comm_cartesc_nest::comm_cartesc_nest_domain_relate(), scale_comm_cartesc_nest::comm_cartesc_nest_domain_shape(), scale_comm_cartesc_nest::comm_cartesc_nest_intercomm_nestdown_3d(), scale_comm_cartesc_nest::comm_cartesc_nest_issuer_of_receive_3d(), scale_comm_cartesc_nest::comm_cartesc_nest_issuer_of_wait_3d(), scale_comm_cartesc_nest::comm_cartesc_nest_nestdown(), scale_comm_cartesc_nest::comm_cartesc_nest_recv_cancel(), scale_comm_cartesc_nest::comm_cartesc_nest_recvwait_issue(), scale_comm_cartesc_nest::comm_cartesc_nest_setup(), scale_comm_cartesc_nest::comm_cartesc_nest_test(), scale_comm_cartesc_nest::comm_cartesc_nest_waitall(), scale_comm_icoa::comm_data_transfer_dp(), scale_comm_icoa::comm_data_transfer_nopl(), scale_comm_icoa::comm_data_transfer_sp(), scale_comm_icoa::comm_setup(), scale_comm_cartesc::comm_vars8_init(), scale_comm_cartesc::comm_vars_init(), scale_const::const_setup(), mod_convert::convert(), mod_convert::convert_setup(), mod_copytopo::copytopo(), mod_cpl_admin::cpl_admin_setup(), scale_cpl_phy_sfc_skin::cpl_phy_sfc_skin(), scale_cpl_phy_sfc_skin::cpl_phy_sfc_skin_setup(), mod_cpl_vars::cpl_vars_setup(), scale_file::file_add_associatedvariable(), scale_file::file_attach_buffer(), scale_file_cartesc::file_cartesc_create(), scale_file_cartesc::file_cartesc_def_var(), scale_file_cartesc::file_cartesc_read_1d(), scale_file_cartesc::file_cartesc_read_auto_2d(), scale_file_cartesc::file_cartesc_read_auto_3d(), scale_file_cartesc::file_cartesc_read_var_2d(), scale_file_cartesc::file_cartesc_read_var_3d(), scale_file_cartesc::file_cartesc_read_var_4d(), scale_file_cartesc::file_cartesc_setup(), scale_file_cartesc::file_cartesc_write_var_1d(), scale_file_cartesc::file_cartesc_write_var_2d(), scale_file_cartesc::file_cartesc_write_var_3d(), scale_file_cartesc::file_cartesc_write_var_3d_t(), scale_file_cartesc::file_cartesc_write_var_4d(), scale_file::file_close(), scale_file::file_create(), scale_file::file_def_associatedcoordinate(), scale_file::file_def_axis(), scale_file::file_def_variable(), scale_file::file_detach_buffer(), scale_file::file_enddef(), scale_file_external_input_cartesc::file_external_input_cartesc_setup(), scale_file_external_input::file_external_input_regist(), scale_file_external_input::file_external_input_setup(), scale_file_external_input::file_external_input_update_1d(), scale_file_external_input::file_external_input_update_3d(), scale_file::file_flush(), scale_file::file_get_dimlength(), scale_file::file_get_stepsize(), scale_file_history_cartesc::file_history_cartesc_truncate_1d(), scale_file_history_cartesc::file_history_cartesc_truncate_3d(), scale_file_history::file_history_finalize(), scale_file_history::file_history_in_0d(), scale_file_history::file_history_in_1d(), scale_file_history::file_history_in_2d(), scale_file_history::file_history_in_3d(), scale_file_history::file_history_query_id(), scale_file_history::file_history_reg(), scale_file_history::file_history_set_associatedcoordinate_1d(), scale_file_history::file_history_set_associatedcoordinate_2d(), scale_file_history::file_history_set_associatedcoordinate_3d(), scale_file_history::file_history_set_attribute_double(), scale_file_history::file_history_set_attribute_float(), scale_file_history::file_history_set_attribute_int(), scale_file_history::file_history_set_attribute_text(), scale_file_history::file_history_set_axis(), scale_file_history::file_history_set_dim(), scale_file_history::file_history_setup(), scale_file::file_make_fname(), scale_file::file_set_option(), scale_file_tiledata::file_tiledata_get_data_int1(), scale_file_tiledata::file_tiledata_get_data_real(), scale_file_tiledata::file_tiledata_get_info(), scale_file_tiledata::file_tiledata_read_catalog_file(), scale_file_tiledata::file_tiledata_read_data_int1_int(), scale_file_tiledata::file_tiledata_read_data_int2_int(), scale_file_tiledata::file_tiledata_read_data_int2_real(), scale_file_tiledata::file_tiledata_read_data_int4_int(), scale_file_tiledata::file_tiledata_read_data_int4_real(), scale_file_tiledata::file_tiledata_read_data_real4_int(), scale_file_tiledata::file_tiledata_read_data_real4_real(), scale_file_tiledata::file_tiledata_read_data_real8_real(), scale_filter::filter_hyperdiff_3d(), mod_mkinit::flux_setup(), scale_interp::interp_div_block(), scale_interp::interp_domain_compatibility(), scale_interp::interp_factor2d(), scale_interp::interp_factor3d(), scale_interp::interp_search_horiz_struct(), scale_interp::interp_setup(), mod_lake_admin::lake_admin_setup(), mod_land_admin::land_admin_setup(), mod_land_driver::land_driver_setup(), scale_land_dyn_bucket::land_dyn_bucket(), scale_land_dyn_bucket::land_dyn_bucket_setup(), scale_land_grid_cartesc_index::land_grid_cartesc_index_setup(), scale_land_grid_cartesc::land_grid_cartesc_setup(), scale_land_grid_icoa_index::land_grid_icoa_index_setup(), scale_land_grid_icoa::land_grid_icoa_setup(), mod_realinput::land_interporation(), scale_land_phy_matsiro::land_phy_matsiro_setup(), scale_land_phy_snow_ky90::land_phy_snow_ky90(), scale_land_phy_snow_ky90::land_phy_snow_ky90_setup(), mod_mkinit::land_setup(), mod_land_vars::land_vars_restart_read(), mod_land_vars::land_vars_setup(), mod_land_vars::land_vars_total(), scale_landuse::landuse_fillhalo(), scale_landuse::landuse_setup(), scale_atmos_dyn_tstep_short_fvm_hivi::make_matrix(), scale_mapprojection::mapprojection_get_attributes(), scale_mapprojection::mapprojection_setup(), mod_mkinit::mkinit(), mod_mkinit::mkinit_setup(), mod_mktopo::mktopo(), mod_mktopo::mktopo_setup(), scale_monitor::monitor_reg(), scale_monitor::monitor_setup(), scale_monitor::monitor_write(), scale_atmos_phy_mp_sn14::nucleation_kij(), mod_ocean_admin::ocean_admin_setup(), mod_ocean_driver::ocean_driver_setup(), scale_ocean_dyn_offline::ocean_dyn_offline(), scale_ocean_dyn_offline::ocean_dyn_offline_setup(), scale_ocean_dyn_slab::ocean_dyn_slab(), scale_ocean_dyn_slab::ocean_dyn_slab_setup(), scale_ocean_grid_cartesc_index::ocean_grid_cartesc_index_setup(), scale_ocean_grid_cartesc::ocean_grid_cartesc_setup(), scale_ocean_grid_icoa_index::ocean_grid_icoa_index_setup(), scale_ocean_grid_icoa::ocean_grid_icoa_setup(), scale_ocean_phy_albedo::ocean_phy_albedo_const_setup(), scale_ocean_phy_albedo::ocean_phy_albedo_seaice_setup(), scale_ocean_phy_ice_simple::ocean_phy_ice_setup(), scale_ocean_phy_ice_simple::ocean_phy_ice_simple(), scale_ocean_phy_roughness::ocean_phy_roughness_const_setup(), scale_ocean_phy_roughness_miller92::ocean_phy_roughness_miller92_setup(), scale_ocean_phy_roughness_moon07::ocean_phy_roughness_moon07_setup(), scale_ocean_phy_roughness::ocean_phy_roughness_seaice_setup(), scale_ocean_phy_roughness::ocean_phy_roughness_setup(), scale_ocean_phy_tc::ocean_phy_tc_seaice_setup(), mod_mkinit::ocean_setup(), mod_ocean_vars::ocean_vars_restart_read(), mod_ocean_vars::ocean_vars_setup(), mod_realinput_grads::parentatmosinputgrads(), mod_realinput_grads::parentatmossetupgrads(), mod_realinput_wrfarw::parentatmossetupwrfarw(), mod_realinput_grads::parentlandinputgrads(), mod_realinput_grads::parentlandsetupgrads(), mod_realinput_wrfarw::parentlandsetupwrfarw(), mod_realinput_grads::parentoceaninputgrads(), mod_realinput_grads::parentoceansetupgrads(), mod_realinput_wrfarw::parentoceansetupwrfarw(), scale_prc_cartesc::prc_cartesc_setup(), prc_errhandler_setup(), scale_prc_icoa::prc_icoa_rgn_generate(), scale_prc_icoa::prc_icoa_setup(), prc_mpisplit(), scale_prof::prof_setup(), scale_random::random_setup(), mod_realinput_grads::read_namelist(), mod_mkinit::read_sounding(), mod_realinput::realinput_atmos(), mod_realinput::realinput_surface(), mod_mkinit::rect_setup(), mod_realinput::replace_misval_map(), mod_rm_driver::rm_driver(), scalerm(), scalerm_init(), scalerm_pp(), scale_file_cartesc::set_dimension(), scale_atmos_dyn_tstep_short_fvm_hivi::solve_bicgstab(), scale_atmos_dyn_tstep_short_fvm_hevi::solve_direct(), scale_statistics::statistics_setup(), scale_statistics::statistics_total_2d(), scale_statistics::statistics_total_3d(), mod_mkinit::tke_setup(), scale_topography::topo_fillhalo(), scale_topography::topo_setup(), scale_tracer::tracer_regist(), mod_urban_admin::urban_admin_setup(), mod_urban_driver::urban_driver_setup(), scale_urban_dyn_kusaka01::urban_dyn_kusaka01(), scale_urban_dyn_kusaka01::urban_dyn_kusaka01_setup(), scale_urban_grid_cartesc_index::urban_grid_cartesc_index_setup(), scale_urban_grid_cartesc::urban_grid_cartesc_setup(), scale_urban_grid_icoa_index::urban_grid_icoa_index_setup(), scale_urban_grid_icoa::urban_grid_icoa_setup(), mod_mkinit::urban_setup(), mod_urban_vars::urban_vars_restart_read(), mod_urban_vars::urban_vars_setup(), mod_user::user_setup(), mod_user::user_update(), scale_debug::valcheck_1d(), scale_debug::valcheck_2d(), scale_debug::valcheck_3d(), scale_comm_cartesc::vars8_2d_mpi(), scale_comm_cartesc::vars8_3d_mpi(), scale_comm_cartesc::vars_2d_mpi(), scale_comm_cartesc::vars_3d_mpi_pc(), and scale_comm_cartesc::vars_init_mpi_pc().
subroutine, public scale_prc::prc_mpifinish | ( | ) |
Stop MPI peacefully.
Definition at line 354 of file scale_prc.F90.
References scale_fpm::fpm_alive, scale_fpm::fpm_polling(), scale_io::io_fid_conf, scale_io::io_fid_log, scale_io::io_fid_stdout, scale_io::io_l, prc_abort_handler, prc_global_comm_world, prc_local_comm_world, prc_mpi_alive, prc_universal_comm_world, and prc_universal_handler.
Referenced by scale::scale_finalize(), scalerm(), scalerm_init(), scalerm_pp(), and scale_comm_icoa::suf().
subroutine, public scale_prc::prc_mpisplit | ( | integer, intent(in) | ORG_COMM, |
integer, intent(in) | NUM_DOMAIN, | ||
integer, dimension(:), intent(in) | PRC_DOMAINS, | ||
character(len=*), dimension(:), intent(in) | CONF_FILES, | ||
logical, intent(in) | LOG_SPLIT, | ||
logical, intent(in) | bulk_split, | ||
logical, intent(in) | color_reorder, | ||
integer, intent(out) | INTRA_COMM, | ||
integer, intent(out) | inter_parent, | ||
integer, intent(out) | inter_child, | ||
character(len=h_long), intent(out) | fname_local | ||
) |
MPI Communicator Split.
Definition at line 416 of file scale_prc.F90.
References prc_abort(), prc_domain_nlim, prc_global_root, prc_masterrank, prc_universal_ismaster, and prc_universal_jobid.
Referenced by scalerm(), scalerm_init(), and scalerm_pp().
subroutine, public scale_prc::prc_mpibarrier | ( | ) |
Barrier MPI.
Definition at line 798 of file scale_prc.F90.
References prc_local_comm_world, and prc_mpi_alive.
Referenced by scale_prof::prof_rapend(), and scale_prof::prof_rapstart().
real(dp) function, public scale_prc::prc_mpitime | ( | ) |
Get MPI time.
Definition at line 813 of file scale_prc.F90.
References prc_mpi_alive.
Referenced by mod_admin_time::admin_time_advance(), mod_admin_time::admin_time_checkstate(), mod_admin_time::admin_time_setup(), scale_prof::prof_rapend(), and scale_prof::prof_rapstart().
subroutine, public scale_prc::prc_mpitimestat | ( | real(dp), dimension(:), intent(out) | avgvar, |
real(dp), dimension(:), intent(out) | maxvar, | ||
real(dp), dimension(:), intent(out) | minvar, | ||
integer, dimension(:), intent(out) | maxidx, | ||
integer, dimension(:), intent(out) | minidx, | ||
real(dp), dimension(:), intent(in) | var | ||
) |
Calc global statistics for timer.
[out] | avgvar | average |
[out] | maxvar | maximum |
[out] | minvar | minimum |
[out] | maxidx | index of maximum |
[out] | minidx | index of minimum |
[in] | var | values for statistics |
Definition at line 835 of file scale_prc.F90.
References scale_fpm::fpm_alive, scale_fpm::fpm_polling(), scale_io::io_fid_conf, scale_io::io_fid_log, scale_io::io_fid_stdout, scale_io::io_l, prc_abort_comm_world, prc_global_domainid, prc_global_myrank, prc_global_nprocs, prc_ismaster, prc_local_comm_world, prc_mpi_alive, prc_myrank, prc_nprocs, prc_universal_jobid, prc_universal_myrank, and prc_universal_nprocs.
Referenced by scale_prof::prof_rapreport().
subroutine, public scale_prc::prc_set_file_closer | ( | procedure(closer) | routine | ) |
Definition at line 972 of file scale_prc.F90.
Referenced by scale_file::file_setup().
integer, parameter, public scale_prc::prc_masterrank = 0 |
master process in each communicator
Definition at line 65 of file scale_prc.F90.
Referenced by scale_atmos_phy_mp_suzuki10::atmos_phy_mp_suzuki10_setup(), scale_comm_cartesc::comm_bcast_1d(), scale_comm_cartesc::comm_bcast_2d(), scale_comm_cartesc::comm_bcast_3d(), scale_comm_cartesc::comm_bcast_4d(), scale_comm_cartesc::comm_bcast_character(), scale_comm_cartesc::comm_bcast_int_1d(), scale_comm_cartesc::comm_bcast_int_2d(), scale_comm_cartesc::comm_bcast_int_scr(), scale_comm_cartesc::comm_bcast_logical_scr(), scale_comm_cartesc::comm_bcast_scr(), scale_comm_cartesc::comm_gather_2d(), scale_comm_cartesc::comm_gather_3d(), scale_file_history_cartesc::file_history_cartesc_setup(), scale_prc_cartesc::prc_cartesc_setup(), prc_global_setup(), prc_local_setup(), prc_mpisplit(), prc_singlecom_setup(), and prc_universal_setup().
integer, parameter, public scale_prc::prc_domain_nlim = 10000 |
max depth of domains
Definition at line 66 of file scale_prc.F90.
Referenced by prc_mpisplit(), scalerm(), scalerm_init(), and scalerm_pp().
integer, parameter, public scale_prc::prc_comm_null = MPI_COMM_NULL |
Definition at line 67 of file scale_prc.F90.
Referenced by scale_file::file_get_aggregate().
integer, public scale_prc::prc_universal_comm_world = -1 |
original communicator
Definition at line 70 of file scale_prc.F90.
Referenced by prc_abort(), scale_prc_cartesc::prc_cartesc_setup(), scale_prc_icoa::prc_icoa_setup(), prc_mpifinish(), prc_singlecom_setup(), and prc_universal_setup().
integer, public scale_prc::prc_universal_myrank = -1 |
myrank in universal communicator
Definition at line 71 of file scale_prc.F90.
Referenced by scale_prc_cartesc::prc_cartesc_setup(), scale_prc_icoa::prc_icoa_setup(), prc_mpitimestat(), prc_singlecom_setup(), and prc_universal_setup().
integer, public scale_prc::prc_universal_nprocs = -1 |
process num in universal communicator
Definition at line 72 of file scale_prc.F90.
Referenced by scale_prc_cartesc::prc_cartesc_setup(), scale_prc_icoa::prc_icoa_setup(), prc_mpitimestat(), prc_singlecom_setup(), and prc_universal_setup().
logical, public scale_prc::prc_universal_ismaster = .false. |
master process in universal communicator?
Definition at line 73 of file scale_prc.F90.
Referenced by mod_admin_time::admin_time_checkstate(), scale_prc_cartesc::prc_cartesc_setup(), prc_errhandler_setup(), scale_prc_icoa::prc_icoa_setup(), prc_mpisplit(), prc_singlecom_setup(), and prc_universal_setup().
integer, public scale_prc::prc_universal_jobid = 0 |
my job ID in universal communicator
Definition at line 75 of file scale_prc.F90.
Referenced by prc_mpisplit(), and prc_mpitimestat().
integer, public scale_prc::prc_global_comm_world = -1 |
global communicator
Definition at line 78 of file scale_prc.F90.
Referenced by scale_comm_cartesc_nest::comm_cartesc_nest_disconnect(), scale_prc_cartesc::prc_cartesc_setup(), prc_global_setup(), scale_prc_icoa::prc_icoa_setup(), prc_mpifinish(), and prc_singlecom_setup().
integer, public scale_prc::prc_global_myrank = -1 |
myrank in global communicator
Definition at line 79 of file scale_prc.F90.
Referenced by scale_prc_cartesc::prc_cartesc_setup(), prc_global_setup(), scale_prc_icoa::prc_icoa_setup(), prc_mpitimestat(), and prc_singlecom_setup().
integer, public scale_prc::prc_global_nprocs = -1 |
process num in global communicator
Definition at line 80 of file scale_prc.F90.
Referenced by scale_prc_cartesc::prc_cartesc_setup(), prc_global_setup(), scale_prc_icoa::prc_icoa_setup(), prc_mpitimestat(), and prc_singlecom_setup().
logical, public scale_prc::prc_global_ismaster = .false. |
master process in global communicator?
Definition at line 81 of file scale_prc.F90.
Referenced by scale_prc_cartesc::prc_cartesc_setup(), prc_global_setup(), scale_prc_icoa::prc_icoa_setup(), and prc_singlecom_setup().
integer, public scale_prc::prc_global_domainid = 0 |
my domain ID in global communicator
Definition at line 83 of file scale_prc.F90.
Referenced by scale_comm_cartesc_nest::comm_cartesc_nest_setup(), and prc_mpitimestat().
integer, dimension(prc_domain_nlim+1), public scale_prc::prc_global_root |
root processes in global members
Definition at line 84 of file scale_prc.F90.
Referenced by prc_mpisplit(), scalerm(), scalerm_init(), and scalerm_pp().
integer, public scale_prc::prc_local_comm_world = -1 |
local communicator
Definition at line 87 of file scale_prc.F90.
Referenced by scale_comm_icoa::comm_data_transfer_dp(), scale_comm_icoa::comm_data_transfer_nopl(), scale_comm_icoa::comm_data_transfer_sp(), scale_comm_cartesc::comm_setup(), scale_comm_icoa::comm_setup(), scale_comm_icoa::comm_stat_avg_dp(), scale_comm_icoa::comm_stat_avg_sp(), scale_comm_icoa::comm_stat_max_dp(), scale_comm_icoa::comm_stat_max_sp(), scale_comm_icoa::comm_stat_min_dp(), scale_comm_icoa::comm_stat_min_sp(), scale_comm_icoa::comm_stat_sum_dp(), scale_comm_icoa::comm_stat_sum_eachlayer_dp(), scale_comm_icoa::comm_stat_sum_eachlayer_sp(), scale_comm_icoa::comm_stat_sum_sp(), scale_comm_icoa::comm_var_dp(), scale_comm_icoa::comm_var_sp(), scale_file::file_get_aggregate(), scale_prc_cartesc::prc_cartesc_setup(), scale_prc_icoa::prc_icoa_setup(), prc_local_setup(), prc_mpibarrier(), prc_mpifinish(), prc_mpitimestat(), prc_singlecom_setup(), scale_statistics::statistics_horizontal_max_2d(), scale_statistics::statistics_horizontal_max_3d(), scale_statistics::statistics_horizontal_mean_2d(), scale_statistics::statistics_horizontal_mean_3d(), scale_statistics::statistics_horizontal_min_2d(), and scale_statistics::statistics_horizontal_min_3d().
integer, public scale_prc::prc_nprocs = 1 |
myrank in local communicator
Definition at line 88 of file scale_prc.F90.
Referenced by scale_atmos_grid_cartesc_real::atmos_grid_cartesc_real_setup(), scale_atmos_grid_cartesc_real::atmos_grid_cartesc_real_update_z(), scale_comm_cartesc_nest::comm_cartesc_nest_domain_shape(), scale_comm_icoa::comm_setup(), scale_comm_icoa::comm_stat_avg_dp(), scale_comm_icoa::comm_stat_avg_sp(), scale_comm_icoa::comm_stat_max_dp(), scale_comm_icoa::comm_stat_max_sp(), scale_comm_icoa::comm_stat_min_dp(), scale_comm_icoa::comm_stat_min_sp(), scale_comm_icoa::comm_stat_sum_dp(), scale_comm_icoa::comm_stat_sum_eachlayer_dp(), scale_comm_icoa::comm_stat_sum_eachlayer_sp(), scale_comm_icoa::comm_stat_sum_sp(), scale_prc_cartesc::prc_cartesc_setup(), scale_prc_icoa::prc_icoa_setup(), prc_local_setup(), prc_mpitimestat(), prc_singlecom_setup(), scale_prof::prof_rapreport(), scale_statistics::statistics_detail_2d(), and scale_statistics::statistics_detail_3d().
integer, public scale_prc::prc_myrank = 0 |
process num in local communicator
Definition at line 89 of file scale_prc.F90.
Referenced by mod_admin_time::admin_time_setup(), scale_atmos_grid_cartesc::atmos_grid_cartesc_allocate(), scale_atmos_grid_cartesc::atmos_grid_cartesc_generate(), scale_atmos_grid_cartesc_index::atmos_grid_cartesc_index_setup(), mod_atmos_vars::atmos_vars_monitor(), mod_atmos_vars::atmos_vars_restart_check(), scale_comm_cartesc_nest::comm_cartesc_nest_domain_relate(), scale_comm_cartesc_nest::comm_cartesc_nest_domain_shape(), scale_comm_cartesc_nest::comm_cartesc_nest_issuer_of_receive_3d(), scale_comm_icoa::comm_setup(), mod_copytopo::copytopo(), scale_cpl_phy_sfc_skin::cpl_phy_sfc_skin(), scale_atmos_phy_mp_sn14::debug_tem_kij(), scale_file_cartesc::file_cartesc_create(), scale_file_cartesc::file_cartesc_open(), scale_file_cartesc::file_cartesc_setup(), scale_file_cartesc::file_cartesc_write_axes(), scale_file_cartesc::file_cartesc_write_var_1d(), scale_file_cartesc::file_cartesc_write_var_2d(), scale_file_cartesc::file_cartesc_write_var_3d(), scale_file_cartesc::file_cartesc_write_var_3d_t(), scale_file_cartesc::file_cartesc_write_var_4d(), scale_file_external_input::file_external_input_regist(), scale_file_external_input::file_external_input_update_3d(), scale_file_history_cartesc::file_history_cartesc_set_pres(), scale_file_history_cartesc::file_history_cartesc_setup(), scale_file_history_cartesc::file_history_cartesc_truncate_3d(), scale_land_grid_cartesc::land_grid_cartesc_setup(), scale_land_grid_icoa::land_grid_icoa_setup(), scale_monitor::monitor_finalize(), scale_monitor::monitor_write(), scale_ocean_grid_cartesc::ocean_grid_cartesc_setup(), scale_ocean_grid_icoa::ocean_grid_icoa_setup(), scale_prc_cartesc::prc_cartesc_setup(), scale_prc_icoa::prc_icoa_rgn_generate(), scale_prc_icoa::prc_icoa_setup(), prc_local_setup(), prc_mpitimestat(), prc_singlecom_setup(), scale_random::random_setup(), scale_statistics::statistics_detail_2d(), scale_statistics::statistics_total_2d(), scale_statistics::statistics_total_3d(), scale_comm_icoa::suf(), scale_urban_dyn_kusaka01::urban_dyn_kusaka01(), scale_urban_grid_cartesc::urban_grid_cartesc_setup(), scale_urban_grid_icoa::urban_grid_icoa_setup(), scale_debug::valcheck_1d(), scale_debug::valcheck_2d(), and scale_debug::valcheck_3d().
logical, public scale_prc::prc_ismaster = .false. |
master process in local communicator?
Definition at line 90 of file scale_prc.F90.
Referenced by mod_admin_time::admin_time_advance(), scale_atmos_grid_cartesc_real::atmos_grid_cartesc_real_update_z(), scale_atmos_phy_mp_suzuki10::atmos_phy_mp_suzuki10_setup(), scale_atmos_sfc_ch_rn222::atmos_sfc_ch_rn222_setup(), scale_comm_cartesc_nest::comm_cartesc_nest_domain_shape(), scale_comm_cartesc_nest::comm_cartesc_nest_setup(), scale_file_cartesc::file_cartesc_write_axes(), scale_monitor::monitor_write(), scale_prc_cartesc::prc_cartesc_setup(), scale_prc_icoa::prc_icoa_setup(), prc_local_setup(), prc_mpitimestat(), prc_singlecom_setup(), scale_prof::prof_rapreport(), and mod_realinput::realinput_surface().
logical, public scale_prc::prc_mpi_alive = .false. |
MPI is alive?
Definition at line 93 of file scale_prc.F90.
Referenced by prc_abort(), scale_prc_cartesc::prc_cartesc_setup(), prc_mpibarrier(), prc_mpifinish(), prc_mpistart(), prc_mpitime(), and prc_mpitimestat().
integer, public scale_prc::prc_universal_handler |
error handler in universal communicator
Definition at line 94 of file scale_prc.F90.
Referenced by prc_errhandler_setup(), and prc_mpifinish().
integer, public scale_prc::prc_abort_comm_world |
communicator for aborting
Definition at line 95 of file scale_prc.F90.
Referenced by scale_prc_cartesc::prc_cartesc_setup(), prc_errhandler_setup(), scale_prc_icoa::prc_icoa_setup(), prc_mpistart(), prc_mpitimestat(), and prc_singlecom_setup().
integer, public scale_prc::prc_abort_handler |
error handler communicator for aborting
Definition at line 96 of file scale_prc.F90.
Referenced by prc_errhandler_setup(), and prc_mpifinish().