682 KiB
682 KiB
Tristan Hoellinger
Institut d'Astrophysique de Paris
tristan.hoellinger@iap.fr
In [1]:
# pyright: reportWildcardImportFromLibrary=false
from wip3m import *
In [2]:
workdir = ROOT_PATH + "results/"
output_path = OUTPUT_PATH
# STANDARD PARAMETERS:
L = 32 # Box size in Mpc/h
N = 32 # Density grid size
Np = 32 # Number of dark matter particles per spatial dimension
Npm = 64 # PM grid size
n_Tiles = 8 # Make sure Npm/n_Tiles >= 6
force = force_hard = True
run_id = "notebook12"
TimeStepDistribution = 3 # 0: constant, 1: log, 2: exp, 3: custom
# nsteps = 0 # not used for TimeStepDistribution=3
In [3]:
# Automatic reloading of modules
%load_ext autoreload
%autoreload 2
from os.path import isfile
from pathlib import Path
import numpy as np
from pysbmy.power import PowerSpectrum
from pysbmy.field import read_field
from pysbmy.timestepping import StandardTimeStepping, P3MTimeStepping
from wip3m.tools import get_k_max, generate_sim_params, generate_white_noise_Field, run_simulation
from wip3m.params import params_CONCEPT_kmax_missing, cosmo_small_to_full_dict, z2a, BASELINE_SEEDPHASE
from wip3m.plot_utils import * # type: ignore
In [4]:
corner = 0.0
RedshiftLPT = 19.0
RedshiftFCs = 0.0
ai = z2a(RedshiftLPT)
af = z2a(RedshiftFCs)
k_max = get_k_max(L, N) # k_max in h/Mpc
print(f"k_max = {k_max}")
# cosmo = params_planck_kmax_missing.copy()
cosmo = params_CONCEPT_kmax_missing.copy()
cosmo["k_max"] = k_max
wd = workdir + run_id + "/"
simdir = output_path + run_id + "/"
gravpotdir = simdir + "gravpot/"
momentadir = simdir + "p_res/"
logdir = simdir + "logs/"
if force_hard:
import shutil
if Path(simdir).exists():
shutil.rmtree(simdir)
if Path(wd).exists():
shutil.rmtree(wd)
Path(wd).mkdir(parents=True, exist_ok=True)
Path(gravpotdir).mkdir(parents=True, exist_ok=True)
Path(momentadir).mkdir(parents=True, exist_ok=True)
Path(logdir).mkdir(parents=True, exist_ok=True)
input_white_noise_file = simdir + "input_white_noise.h5"
input_seed_phase_file = simdir + "seed"
ICs_path = simdir + "initial_density.h5"
simpath = simdir
# Path to the input matter power spectrum (generated later)
input_power_file = simdir + "input_power.h5"
# Paths to the time step logs
OutputTimestepsLog = simdir + "timesteps_log.txt"
# Path to the output gravitational potential field
OutputGravitationalPotentialBase = gravpotdir + "gp"
# Path to the output momenta field
OutputMomentaBase = momentadir + "p"
k_max = 5.442
Generate the parameter files¶
In [5]:
common_params = {
"Np": Np,
"N": N,
"L": L,
"corner0": corner,
"corner1": corner,
"corner2": corner,
"h": cosmo["h"],
"Omega_m": cosmo["Omega_m"],
"Omega_b": cosmo["Omega_b"],
"n_s": cosmo["n_s"],
"sigma8": cosmo["sigma8"],
}
lpt_params = common_params.copy()
lpt_params["method"] = "lpt"
lpt_params["InputPowerSpectrum"] = input_power_file
lpt_params["ICsMode"] = 1
lpt_params["InputWhiteNoise"] = input_white_noise_file
p3m_fit_coeffs = P3M_FIT_COEFFS_DEFAULT_2NP
fac_dyn = DEFAULT_FAC_DYN_CUSTOM_COLA
fac_hubble = DEFAULT_FAC_H_CUSTOM_COLA
fac_bend = DEFAULT_FAC_BEND
sub_bend1 = DEFAULT_SUB_BEND1_COLA
sub_bend2 = DEFAULT_SUB_BEND2_COLA
fac_p3m_fit = DEFAULT_FAC_P3M_FIT
da_early = DEFAULT_DA_MAX_EARLY_CUSTOM
p3m_params = common_params.copy()
p3m_params["method"] = "p3m"
p3m_params["EvolutionMode"] = 7 # 7: COLA with P3M force evaluation
p3m_params["TimeStepDistribution"] = 3
p3m_params["ai"] = ai
p3m_params["af"] = af
p3m_params["RedshiftLPT"] = RedshiftLPT
p3m_params["RedshiftFCs"] = RedshiftFCs
p3m_params["Npm"] = Npm
p3m_params["n_Tiles"] = n_Tiles
p3m_params["RunForceDiagnostic"] = False
p3m_params["PrintOutputTimestepsLog"] = True
p3m_params["OutputTimestepsLog"] = OutputTimestepsLog
p3m_params["cosmo_dict"] = cosmo
p3m_params["fac_dyn_custom"] = fac_dyn
p3m_params["fac_H_custom"] = fac_hubble
p3m_params["fac_bend"] = fac_bend
p3m_params["sub_bend1"] = sub_bend1
p3m_params["sub_bend2"] = sub_bend2
p3m_params["fac_p3m_fit"] = fac_p3m_fit
p3m_params["da_max_early_custom"] = da_early
p3m_params["da_max_late_custom"] = DEFAULT_DA_MAX_LATE_CUSTOM # da_late
p3m_params["p3m_fit_coeffs"] = p3m_fit_coeffs
p3m_params["use_p3m_fit"] = True
p3m_params["WriteGravPot"] = True
p3m_params["OutputGravitationalPotentialBase"] = OutputGravitationalPotentialBase
p3m_params["WriteReferenceFrame"] = True
p3m_params["OutputMomentaBase"] = OutputMomentaBase
file_ext = None
In [6]:
reset_plotting() # Default style for Simbelmynë
generate_sim_params(lpt_params, ICs_path, wd, simdir, None, force)
generate_sim_params(p3m_params, ICs_path, wd, simdir, file_ext, force)
setup_plotting() # Reset plotting style for this project
[15:14:41|INFO ]|(wip3m.tools) Generating parameter file... [15:14:41|STATUS ]|Writing parameter file in '/Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook12/example_lpt.sbmy'... [15:14:41|STATUS ]|Writing parameter file in '/Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook12/example_lpt.sbmy' done. [15:14:41|INFO ]|(wip3m.tools) Parameter file written to /Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook12/example_lpt.sbmy [15:14:41|INFO ]|(wip3m.tools) Time-stepping distribution file: /Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook12/ts_p3m.h5 [15:14:41|STATUS ]|Write custom timestepping configuration in '/Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook12/ts_p3m.h5'... [15:14:41|STATUS ]|Write custom timestepping configuration in '/Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook12/ts_p3m.h5' done. [15:14:41|INFO ]|(wip3m.tools) TS.ai = 0.050000, TS.af = 1.000000, TS.nsteps = 74 [15:14:41|STATUS ]|Read timestepping configuration in '/Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook12/ts_p3m.h5'... [15:14:41|STATUS ]|Read timestepping configuration in '/Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook12/ts_p3m.h5' done. [15:14:42|INFO ]|(wip3m.tools) Generating parameter file... [15:14:42|STATUS ]|Writing parameter file in '/Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook12/example_p3m.sbmy'... [15:14:42|STATUS ]|Writing parameter file in '/Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook12/example_p3m.sbmy' done. [15:14:42|INFO ]|(wip3m.tools) Parameter file written to /Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook12/example_p3m.sbmy
In [7]:
TSpath = wd + file_ext + "_ts_p3m.h5" if file_ext else wd + "ts_p3m.h5"
if TimeStepDistribution in [0, 1, 2]:
TS = StandardTimeStepping.read(TSpath)
aiDrift = TS.aiDrift
nsteps = TS.nsteps
elif TimeStepDistribution == 3:
TS = P3MTimeStepping.read(TSpath)
aiDrift = TS.aiDrift
nsteps = TS.nsteps
else:
raise ValueError(f"Invalid TimeStepDistribution: {TimeStepDistribution}")
[15:14:42|STATUS ]|Read custom timestepping configuration in '/Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook12/ts_p3m.h5'... [15:14:42|STATUS ]|Read custom timestepping configuration in '/Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook12/ts_p3m.h5' done.
Generate the initial phase¶
In [8]:
generate_white_noise_Field(
L=L,
size=N,
corner=corner,
seedphase=BASELINE_SEEDPHASE,
fname_whitenoise=input_white_noise_file,
seedname_whitenoise=input_seed_phase_file,
force_phase=force,
)
Generating the input power spectrum¶
In [9]:
# If cosmo["WhichSpectrum"] == "class", then classy is required.
if not isfile(input_power_file) or force:
Pk = PowerSpectrum(L, L, L, N, N, N, cosmo_small_to_full_dict(cosmo))
Pk.write(input_power_file)
[15:14:42|STATUS ]|Setting up Fourier grid... [15:14:42|STATUS ]|Setting up Fourier grid done. [15:14:42|STATUS ]|Computing normalization of the power spectrum... [15:14:42|STATUS ]|Write power spectrum in data file '/Users/hoellinger/WIP3M/notebook12/input_power.h5'... [15:14:42|STATUS ]|Computing normalization of the power spectrum done. [15:14:42|STATUS ]|Computing power spectrum... [15:14:42|STATUS ]|Computing power spectrum done. [15:14:42|DIAGNOSTIC]==|L0=32, L1=32, L2=32 [15:14:42|DIAGNOSTIC]==|N0=32, N1=32, N2=32, N2_HC=17, N_HC=17408, NUM_MODES=464 [15:14:42|STATUS ]|Write power spectrum in data file '/Users/hoellinger/WIP3M/notebook12/input_power.h5' done.
Running the simulations¶
In [10]:
run_simulation("lpt", lpt_params, wd, logdir)
[15:14:42|COMMAND ]|simbelmyne /Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook12/example_lpt.sbmy /Users/hoellinger/WIP3M/notebook12/logs/lpt.txt [15:14:42|INFO ]| [15:14:42|INFO ]| .-~~-.--. [15:14:42|INFO ]| : ) [15:14:42|INFO ]| .~ ~ -.\ /.- ~~ . [15:14:42|INFO ]| > `. .' < [15:14:42|INFO ]| ( .- -. ) [15:14:42|INFO ]| `- -.-~ `- -' ~-.- -' [15:14:42|INFO ]| ( : ) _ _ .-: ___________________________________ [15:14:42|INFO ]| ~--. : .--~ .-~ .-~ } SIMBELMYNË [15:14:42|INFO ]| ~-.-^-.-~ \_ .~ .-~ .~ (c) Florent Leclercq 2012 - SBMY_YEAR [15:14:42|INFO ]| \ ' \ '_ _ -~ ___________________________________ [15:14:42|INFO ]| `.`. // [15:14:42|INFO ]| . - ~ ~-.__`.`-.// [15:14:42|INFO ]| .-~ . - ~ }~ ~ ~-.~-. [15:14:42|INFO ]| .' .-~ .-~ :/~-.~-./: [15:14:42|INFO ]| /_~_ _ . - ~ ~-.~-._ [15:14:42|INFO ]| ~-.< [15:14:42|INFO ]| [15:14:42|INFO ]|2025-06-24 15:14:42: Starting SIMBELMYNË, commit hash 15f03ec44e13086a2d9c19f9742a0c06ec9b9a46 [15:14:42|STATUS ]|Reading parameter file in '/Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook12/example_lpt.sbmy'... [15:14:42|STATUS ]|Reading parameter file in '/Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook12/example_lpt.sbmy' done. [15:14:42|MODULE ]|ModuleLPT: Initializing snapshot... [15:14:42|MODULE ]|ModuleLPT: Initializing snapshot done. [15:14:42|TIMER ]|LPT snapshot initialization: 0.000 CPU - 0.000 wallclock seconds used. [15:14:42|MODULE ]|ModuleLPT: Returning initial conditions... [15:14:42|STATUS ]==|Reading field in '/Users/hoellinger/WIP3M/notebook12/input_white_noise.h5'... [15:14:42|STATUS ]==|Reading field in '/Users/hoellinger/WIP3M/notebook12/input_white_noise.h5' done. [15:14:42|STATUS ]==|Reading power spectrum... [15:14:42|STATUS ]====|Reading power spectrum in '/Users/hoellinger/WIP3M/notebook12/input_power.h5'... [15:14:42|STATUS ]====|Reading power spectrum in '/Users/hoellinger/WIP3M/notebook12/input_power.h5' done. [15:14:42|STATUS ]==|Reading power spectrum done. [15:14:42|STATUS ]==|Generating Gaussian random field (using 8 cores)... [15:14:42|STATUS ]==|Generating Gaussian random field (using 8 cores) done. [15:14:42|STATUS ]==|Writing field to '/Users/hoellinger/WIP3M/notebook12/initial_density.h5'... [15:14:42|STATUS ]==|Writing field to '/Users/hoellinger/WIP3M/notebook12/initial_density.h5' done. [15:14:42|MODULE ]|ModuleLPT: Returning initial conditions done. [15:14:42|TIMER ]|LPT initial conditions: 0.003 CPU - 0.002 wallclock seconds used. [15:14:42|MODULE ]|ModuleLPT: Evolving with Lagrangian perturbation theory (using 8 cores)... [15:14:42|STATUS ]==|Computing Lagrangian potentials, periodic boundary conditions (using 8 cores)... [15:14:42|STATUS ]==|Computing Lagrangian potentials, periodic boundary conditions (using 8 cores) done. [15:14:42|STATUS ]==|Computing Lagrangian displacement field (using 8 cores)... [15:14:42|STATUS ]==|Computing Lagrangian displacement field (using 8 cores) done. [15:14:42|STATUS ]==|Changing velocities of particles... [15:14:42|STATUS ]==|Changing velocities of particles done. [15:14:42|STATUS ]==|Displacing particles... [15:14:42|STATUS ]==|Displacing particles done. [15:14:42|MODULE ]|ModuleLPT: Evolving with Lagrangian perturbation theory (using 8 cores) done. [15:14:42|TIMER ]|LPT evolution: 0.049 CPU - 0.016 wallclock seconds used. [15:14:42|MODULE ]|ModuleLPT: Computing outputs... [15:14:42|STATUS ]==|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:42|STATUS ]==|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:42|STATUS ]==|Writing field to '/Users/hoellinger/WIP3M/notebook12/lpt_density.h5'... [15:14:42|STATUS ]==|Writing field to '/Users/hoellinger/WIP3M/notebook12/lpt_density.h5' done. [15:14:42|STATUS ]==|Writing header in '/Users/hoellinger/WIP3M/notebook12/lpt_particles.gadget3'... [15:14:42|STATUS ]==|Writing header in '/Users/hoellinger/WIP3M/notebook12/lpt_particles.gadget3' done. [15:14:42|STATUS ]==|Writing snapshot in '/Users/hoellinger/WIP3M/notebook12/lpt_particles.gadget3' (32768 particles)... [15:14:42|STATUS ]====|Writing block: 'POS '... [15:14:42|STATUS ]====|Writing block: 'POS ' done. [15:14:42|STATUS ]====|Writing block: 'VEL '... [15:14:42|STATUS ]====|Writing block: 'VEL ' done. [15:14:42|STATUS ]====|Writing block: 'ID '... [15:14:42|STATUS ]====|Writing block: 'ID ' done. [15:14:42|STATUS ]==|Writing snapshot in '/Users/hoellinger/WIP3M/notebook12/lpt_particles.gadget3' done. [15:14:42|MODULE ]|ModuleLPT: Computing outputs done. [15:14:42|TIMER ]|LPT output: 0.016 CPU - 0.004 wallclock seconds used. [15:14:42|TIMER ]|ModuleLPT: 0.068 CPU - 0.023 wallclock seconds used. [15:14:42|TIMER ]|Simbelmynë: 0.069 CPU - 0.023 wallclock seconds used. [15:14:42|INFO ]|Everything done successfully, exiting.
In [11]:
run_simulation("p3m", p3m_params, wd, logdir)
[15:14:42|COMMAND ]|simbelmyne /Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook12/example_p3m.sbmy /Users/hoellinger/WIP3M/notebook12/logs/p3m.txt [15:14:42|INFO ]| [15:14:42|INFO ]| .-~~-.--. [15:14:42|INFO ]| : ) [15:14:42|INFO ]| .~ ~ -.\ /.- ~~ . [15:14:42|INFO ]| > `. .' < [15:14:42|INFO ]| ( .- -. ) [15:14:42|INFO ]| `- -.-~ `- -' ~-.- -' [15:14:42|INFO ]| ( : ) _ _ .-: ___________________________________ [15:14:42|INFO ]| ~--. : .--~ .-~ .-~ } SIMBELMYNË [15:14:42|INFO ]| ~-.-^-.-~ \_ .~ .-~ .~ (c) Florent Leclercq 2012 - SBMY_YEAR [15:14:42|INFO ]| \ ' \ '_ _ -~ ___________________________________ [15:14:42|INFO ]| `.`. // [15:14:42|INFO ]| . - ~ ~-.__`.`-.// [15:14:42|INFO ]| .-~ . - ~ }~ ~ ~-.~-. [15:14:42|INFO ]| .' .-~ .-~ :/~-.~-./: [15:14:42|INFO ]| /_~_ _ . - ~ ~-.~-._ [15:14:42|INFO ]| ~-.< [15:14:42|INFO ]| [15:14:42|INFO ]|2025-06-24 15:14:42: Starting SIMBELMYNË, commit hash 15f03ec44e13086a2d9c19f9742a0c06ec9b9a46 [15:14:42|STATUS ]|Reading parameter file in '/Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook12/example_p3m.sbmy'... [15:14:42|STATUS ]|Reading parameter file in '/Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook12/example_p3m.sbmy' done. [15:14:42|MODULE ]|ModuleLPT: Initializing snapshot... [15:14:42|MODULE ]|ModuleLPT: Initializing snapshot done. [15:14:42|TIMER ]|LPT snapshot initialization: 0.000 CPU - 0.000 wallclock seconds used. [15:14:42|MODULE ]|ModuleLPT: Returning initial conditions... [15:14:42|STATUS ]==|Reading field in '/Users/hoellinger/WIP3M/notebook12/initial_density.h5'... [15:14:42|STATUS ]==|Reading field in '/Users/hoellinger/WIP3M/notebook12/initial_density.h5' done. [15:14:42|MODULE ]|ModuleLPT: Returning initial conditions done. [15:14:42|TIMER ]|LPT initial conditions: 0.000 CPU - 0.000 wallclock seconds used. [15:14:42|MODULE ]|ModuleLPT: Evolving with Lagrangian perturbation theory (using 8 cores)... [15:14:42|STATUS ]==|Computing Lagrangian potentials, periodic boundary conditions (using 8 cores)... [15:14:42|STATUS ]==|Computing Lagrangian potentials, periodic boundary conditions (using 8 cores) done. [15:14:42|STATUS ]==|Computing Lagrangian displacement field (using 8 cores)... [15:14:42|STATUS ]==|Computing Lagrangian displacement field (using 8 cores) done. [15:14:42|STATUS ]==|Changing velocities of particles... [15:14:42|STATUS ]==|Changing velocities of particles done. [15:14:42|STATUS ]==|Displacing particles... [15:14:42|STATUS ]==|Displacing particles done. [15:14:42|MODULE ]|ModuleLPT: Evolving with Lagrangian perturbation theory (using 8 cores) done. [15:14:42|TIMER ]|LPT evolution: 0.048 CPU - 0.016 wallclock seconds used. [15:14:42|TIMER ]|ModuleLPT: 0.049 CPU - 0.016 wallclock seconds used. [15:14:42|MODULE ]|ModuleP3M: Evolving with P3M... [15:14:42|STATUS ]==|Read timestepping configuration in '/Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook12/ts_p3m.h5'... [15:14:42|STATUS ]==|Read timestepping configuration in '/Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook12/ts_p3m.h5' done. [15:14:42|STATUS ]==|OutputForceDiagnostic: force_diagnostic.csv [15:14:42|STATUS ]==|OutputSnapshotsBase: particles_ [15:14:42|STATUS ]==|ModulePMCOLA: L_minus operator: changing reference frame before COLA evolution... [15:14:42|STATUS ]==|ModulePMCOLA: L_minus operator: changing reference frame before COLA evolution done. [15:14:42|STATUS ]==|ModuleP3M: Begin COLA+P3M step 1/74, time_kick:0.050000, time_drift=0.050000. [15:14:42|STATUS ]====|ModuleP3M: Compute time step limiters for step 1/74 done. [15:14:42|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:42|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:42|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:42|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:42|STATUS ]====|Kicking particles (using 8 cores)... [15:14:42|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:42|STATUS ]====|Drifting particles (using 8 cores)... [15:14:42|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:42|STATUS ]==|ModuleP3M: End COLA+P3M step 1/74, time_kick:0.051250, time_drift=0.052500. [15:14:42|TIMER ]==|Step 1/74: Density: 0.009 CPU - 0.002 wallclock seconds used. [15:14:42|TIMER ]==|Step 1/74: Potential: 0.009 CPU - 0.003 wallclock seconds used. [15:14:42|TIMER ]==|Step 1/74: Accelerations (long-range): 0.064 CPU - 0.014 wallclock seconds used. [15:14:42|TIMER ]==|Step 1/74: Accelerations (short-range): 0.235 CPU - 0.040 wallclock seconds used. [15:14:42|TIMER ]==|Step 1/74: Kick: 0.006 CPU - 0.001 wallclock seconds used. [15:14:42|TIMER ]==|Step 1/74: Drift: 0.002 CPU - 0.001 wallclock seconds used. [15:14:42|TIMER ]==|Step 1/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:42|TIMER ]==|Step 1/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:42|TIMER ]==|Step 1/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:42|TIMER ]==|Step 1/74: Total Evolution: 0.325 CPU - 0.061 wallclock seconds used. [15:14:42|STATUS ]==|ModuleP3M: Begin COLA+P3M step 2/74, time_kick:0.051250, time_drift=0.052500. [15:14:42|STATUS ]====|ModuleP3M: Compute time step limiters for step 2/74 done. [15:14:42|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:42|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:42|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:42|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:42|STATUS ]====|Kicking particles (using 8 cores)... [15:14:42|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:42|STATUS ]====|Drifting particles (using 8 cores)... [15:14:42|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:42|STATUS ]==|ModuleP3M: End COLA+P3M step 2/74, time_kick:0.053813, time_drift=0.055063. [15:14:42|TIMER ]==|Step 2/74: Density: 0.009 CPU - 0.002 wallclock seconds used. [15:14:42|TIMER ]==|Step 2/74: Potential: 0.008 CPU - 0.003 wallclock seconds used. [15:14:42|TIMER ]==|Step 2/74: Accelerations (long-range): 0.064 CPU - 0.014 wallclock seconds used. [15:14:42|TIMER ]==|Step 2/74: Accelerations (short-range): 0.254 CPU - 0.039 wallclock seconds used. [15:14:42|TIMER ]==|Step 2/74: Kick: 0.005 CPU - 0.002 wallclock seconds used. [15:14:42|TIMER ]==|Step 2/74: Drift: 0.001 CPU - 0.001 wallclock seconds used. [15:14:42|TIMER ]==|Step 2/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:42|TIMER ]==|Step 2/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:42|TIMER ]==|Step 2/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:42|TIMER ]==|Step 2/74: Total Evolution: 0.342 CPU - 0.060 wallclock seconds used. [15:14:42|STATUS ]==|ModuleP3M: Begin COLA+P3M step 3/74, time_kick:0.053813, time_drift=0.055063. [15:14:42|STATUS ]====|ModuleP3M: Compute time step limiters for step 3/74 done. [15:14:42|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:42|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:42|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:42|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:42|STATUS ]====|Kicking particles (using 8 cores)... [15:14:42|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:42|STATUS ]====|Drifting particles (using 8 cores)... [15:14:42|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:42|STATUS ]==|ModuleP3M: End COLA+P3M step 3/74, time_kick:0.056503, time_drift=0.057753. [15:14:42|TIMER ]==|Step 3/74: Density: 0.011 CPU - 0.003 wallclock seconds used. [15:14:42|TIMER ]==|Step 3/74: Potential: 0.008 CPU - 0.003 wallclock seconds used. [15:14:42|TIMER ]==|Step 3/74: Accelerations (long-range): 0.060 CPU - 0.015 wallclock seconds used. [15:14:42|TIMER ]==|Step 3/74: Accelerations (short-range): 0.244 CPU - 0.038 wallclock seconds used. [15:14:42|TIMER ]==|Step 3/74: Kick: 0.005 CPU - 0.001 wallclock seconds used. [15:14:42|TIMER ]==|Step 3/74: Drift: 0.001 CPU - 0.001 wallclock seconds used. [15:14:42|TIMER ]==|Step 3/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:42|TIMER ]==|Step 3/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:42|TIMER ]==|Step 3/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:42|TIMER ]==|Step 3/74: Total Evolution: 0.329 CPU - 0.060 wallclock seconds used. [15:14:42|STATUS ]==|ModuleP3M: Begin COLA+P3M step 4/74, time_kick:0.056503, time_drift=0.057753. [15:14:42|STATUS ]====|ModuleP3M: Compute time step limiters for step 4/74 done. [15:14:42|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:42|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:42|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:42|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:42|STATUS ]====|ModuleP3M: Writing gravitational potential to /Users/hoellinger/WIP3M/notebook12/gravpot/gp_nforce3.h5. [15:14:42|STATUS ]====|Writing field to '/Users/hoellinger/WIP3M/notebook12/gravpot/gp_nforce3.h5'... [15:14:42|STATUS ]====|Writing field to '/Users/hoellinger/WIP3M/notebook12/gravpot/gp_nforce3.h5' done. [15:14:42|STATUS ]====|Kicking particles (using 8 cores)... [15:14:43|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:43|STATUS ]====|Drifting particles (using 8 cores)... [15:14:43|STATUS ]======|Writing field to '/Users/hoellinger/WIP3M/notebook12/p_res/p3.h5'... [15:14:43|STATUS ]======|Writing field to '/Users/hoellinger/WIP3M/notebook12/p_res/p3.h5' done. [15:14:43|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:43|STATUS ]==|ModuleP3M: End COLA+P3M step 4/74, time_kick:0.059328, time_drift=0.060578. [15:14:43|TIMER ]==|Step 4/74: Density: 0.011 CPU - 0.003 wallclock seconds used. [15:14:43|TIMER ]==|Step 4/74: Potential: 0.009 CPU - 0.003 wallclock seconds used. [15:14:43|TIMER ]==|Step 4/74: Accelerations (long-range): 0.061 CPU - 0.021 wallclock seconds used. [15:14:43|TIMER ]==|Step 4/74: Accelerations (short-range): 0.257 CPU - 0.063 wallclock seconds used. [15:14:43|TIMER ]==|Step 4/74: Kick: 0.006 CPU - 0.002 wallclock seconds used. [15:14:43|TIMER ]==|Step 4/74: Drift: 0.001 CPU - 0.001 wallclock seconds used. [15:14:43|TIMER ]==|Step 4/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:43|TIMER ]==|Step 4/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:43|TIMER ]==|Step 4/74: Outputs: 0.001 CPU - 0.001 wallclock seconds used. [15:14:43|TIMER ]==|Step 4/74: Total Evolution: 0.346 CPU - 0.094 wallclock seconds used. [15:14:43|STATUS ]==|ModuleP3M: Begin COLA+P3M step 5/74, time_kick:0.059328, time_drift=0.060578. [15:14:43|STATUS ]====|ModuleP3M: Compute time step limiters for step 5/74 done. [15:14:43|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:43|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:43|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:43|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:43|STATUS ]====|ModuleP3M: Writing gravitational potential to /Users/hoellinger/WIP3M/notebook12/gravpot/gp_nforce4.h5. [15:14:43|STATUS ]====|Writing field to '/Users/hoellinger/WIP3M/notebook12/gravpot/gp_nforce4.h5'... [15:14:43|STATUS ]====|Writing field to '/Users/hoellinger/WIP3M/notebook12/gravpot/gp_nforce4.h5' done. [15:14:43|STATUS ]====|Kicking particles (using 8 cores)... [15:14:43|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:43|STATUS ]====|Drifting particles (using 8 cores)... [15:14:43|STATUS ]======|Writing field to '/Users/hoellinger/WIP3M/notebook12/p_res/p4.h5'... [15:14:43|STATUS ]======|Writing field to '/Users/hoellinger/WIP3M/notebook12/p_res/p4.h5' done. [15:14:43|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:43|STATUS ]==|ModuleP3M: End COLA+P3M step 5/74, time_kick:0.062295, time_drift=0.063545. [15:14:43|TIMER ]==|Step 5/74: Density: 0.012 CPU - 0.003 wallclock seconds used. [15:14:43|TIMER ]==|Step 5/74: Potential: 0.009 CPU - 0.004 wallclock seconds used. [15:14:43|TIMER ]==|Step 5/74: Accelerations (long-range): 0.063 CPU - 0.020 wallclock seconds used. [15:14:43|TIMER ]==|Step 5/74: Accelerations (short-range): 0.253 CPU - 0.061 wallclock seconds used. [15:14:43|TIMER ]==|Step 5/74: Kick: 0.006 CPU - 0.002 wallclock seconds used. [15:14:43|TIMER ]==|Step 5/74: Drift: 0.002 CPU - 0.001 wallclock seconds used. [15:14:43|TIMER ]==|Step 5/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:43|TIMER ]==|Step 5/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:43|TIMER ]==|Step 5/74: Outputs: 0.001 CPU - 0.001 wallclock seconds used. [15:14:43|TIMER ]==|Step 5/74: Total Evolution: 0.346 CPU - 0.092 wallclock seconds used. [15:14:43|STATUS ]==|ModuleP3M: Begin COLA+P3M step 6/74, time_kick:0.062295, time_drift=0.063545. [15:14:43|STATUS ]====|ModuleP3M: Compute time step limiters for step 6/74 done. [15:14:43|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:43|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:43|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:43|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:43|STATUS ]====|Kicking particles (using 8 cores)... [15:14:43|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:43|STATUS ]====|Drifting particles (using 8 cores)... [15:14:43|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:43|STATUS ]==|ModuleP3M: End COLA+P3M step 6/74, time_kick:0.065409, time_drift=0.066659. [15:14:43|TIMER ]==|Step 6/74: Density: 0.010 CPU - 0.003 wallclock seconds used. [15:14:43|TIMER ]==|Step 6/74: Potential: 0.010 CPU - 0.003 wallclock seconds used. [15:14:43|TIMER ]==|Step 6/74: Accelerations (long-range): 0.064 CPU - 0.017 wallclock seconds used. [15:14:43|TIMER ]==|Step 6/74: Accelerations (short-range): 0.249 CPU - 0.054 wallclock seconds used. [15:14:43|TIMER ]==|Step 6/74: Kick: 0.006 CPU - 0.002 wallclock seconds used. [15:14:43|TIMER ]==|Step 6/74: Drift: 0.002 CPU - 0.002 wallclock seconds used. [15:14:43|TIMER ]==|Step 6/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:43|TIMER ]==|Step 6/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:43|TIMER ]==|Step 6/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:43|TIMER ]==|Step 6/74: Total Evolution: 0.340 CPU - 0.081 wallclock seconds used. [15:14:43|STATUS ]==|ModuleP3M: Begin COLA+P3M step 7/74, time_kick:0.065409, time_drift=0.066659. [15:14:43|STATUS ]====|ModuleP3M: Compute time step limiters for step 7/74 done. [15:14:43|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:43|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:43|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:43|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:43|STATUS ]====|Kicking particles (using 8 cores)... [15:14:43|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:43|STATUS ]====|Drifting particles (using 8 cores)... [15:14:43|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:43|STATUS ]==|ModuleP3M: End COLA+P3M step 7/74, time_kick:0.068680, time_drift=0.069930. [15:14:43|TIMER ]==|Step 7/74: Density: 0.012 CPU - 0.003 wallclock seconds used. [15:14:43|TIMER ]==|Step 7/74: Potential: 0.009 CPU - 0.003 wallclock seconds used. [15:14:43|TIMER ]==|Step 7/74: Accelerations (long-range): 0.061 CPU - 0.017 wallclock seconds used. [15:14:43|TIMER ]==|Step 7/74: Accelerations (short-range): 0.255 CPU - 0.056 wallclock seconds used. [15:14:43|TIMER ]==|Step 7/74: Kick: 0.006 CPU - 0.002 wallclock seconds used. [15:14:43|TIMER ]==|Step 7/74: Drift: 0.002 CPU - 0.001 wallclock seconds used. [15:14:43|TIMER ]==|Step 7/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:43|TIMER ]==|Step 7/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:43|TIMER ]==|Step 7/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:43|TIMER ]==|Step 7/74: Total Evolution: 0.344 CPU - 0.083 wallclock seconds used. [15:14:43|STATUS ]==|ModuleP3M: Begin COLA+P3M step 8/74, time_kick:0.068680, time_drift=0.069930. [15:14:43|STATUS ]====|ModuleP3M: Compute time step limiters for step 8/74 done. [15:14:43|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:43|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:43|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:43|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:43|STATUS ]====|ModuleP3M: Writing gravitational potential to /Users/hoellinger/WIP3M/notebook12/gravpot/gp_nforce7.h5. [15:14:43|STATUS ]====|Writing field to '/Users/hoellinger/WIP3M/notebook12/gravpot/gp_nforce7.h5'... [15:14:43|STATUS ]====|Writing field to '/Users/hoellinger/WIP3M/notebook12/gravpot/gp_nforce7.h5' done. [15:14:43|STATUS ]====|Kicking particles (using 8 cores)... [15:14:43|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:43|STATUS ]====|Drifting particles (using 8 cores)... [15:14:43|STATUS ]======|Writing field to '/Users/hoellinger/WIP3M/notebook12/p_res/p7.h5'... [15:14:43|STATUS ]======|Writing field to '/Users/hoellinger/WIP3M/notebook12/p_res/p7.h5' done. [15:14:43|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:43|STATUS ]==|ModuleP3M: End COLA+P3M step 8/74, time_kick:0.072114, time_drift=0.073364. [15:14:43|TIMER ]==|Step 8/74: Density: 0.013 CPU - 0.003 wallclock seconds used. [15:14:43|TIMER ]==|Step 8/74: Potential: 0.009 CPU - 0.003 wallclock seconds used. [15:14:43|TIMER ]==|Step 8/74: Accelerations (long-range): 0.058 CPU - 0.015 wallclock seconds used. [15:14:43|TIMER ]==|Step 8/74: Accelerations (short-range): 0.233 CPU - 0.054 wallclock seconds used. [15:14:43|TIMER ]==|Step 8/74: Kick: 0.006 CPU - 0.002 wallclock seconds used. [15:14:43|TIMER ]==|Step 8/74: Drift: 0.002 CPU - 0.001 wallclock seconds used. [15:14:43|TIMER ]==|Step 8/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:43|TIMER ]==|Step 8/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:43|TIMER ]==|Step 8/74: Outputs: 0.001 CPU - 0.001 wallclock seconds used. [15:14:43|TIMER ]==|Step 8/74: Total Evolution: 0.322 CPU - 0.080 wallclock seconds used. [15:14:43|STATUS ]==|ModuleP3M: Begin COLA+P3M step 9/74, time_kick:0.072114, time_drift=0.073364. [15:14:43|STATUS ]====|ModuleP3M: Compute time step limiters for step 9/74 done. [15:14:43|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:43|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:43|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:43|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:43|STATUS ]====|Kicking particles (using 8 cores)... [15:14:43|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:43|STATUS ]====|Drifting particles (using 8 cores)... [15:14:43|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:43|STATUS ]==|ModuleP3M: End COLA+P3M step 9/74, time_kick:0.075720, time_drift=0.076970. [15:14:43|TIMER ]==|Step 9/74: Density: 0.013 CPU - 0.003 wallclock seconds used. [15:14:43|TIMER ]==|Step 9/74: Potential: 0.008 CPU - 0.003 wallclock seconds used. [15:14:43|TIMER ]==|Step 9/74: Accelerations (long-range): 0.057 CPU - 0.015 wallclock seconds used. [15:14:43|TIMER ]==|Step 9/74: Accelerations (short-range): 0.249 CPU - 0.049 wallclock seconds used. [15:14:43|TIMER ]==|Step 9/74: Kick: 0.005 CPU - 0.002 wallclock seconds used. [15:14:43|TIMER ]==|Step 9/74: Drift: 0.001 CPU - 0.001 wallclock seconds used. [15:14:43|TIMER ]==|Step 9/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:43|TIMER ]==|Step 9/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:43|TIMER ]==|Step 9/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:43|TIMER ]==|Step 9/74: Total Evolution: 0.334 CPU - 0.072 wallclock seconds used. [15:14:43|STATUS ]==|ModuleP3M: Begin COLA+P3M step 10/74, time_kick:0.075720, time_drift=0.076970. [15:14:43|STATUS ]====|ModuleP3M: Compute time step limiters for step 10/74 done. [15:14:43|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:43|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:43|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:43|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:43|STATUS ]====|Kicking particles (using 8 cores)... [15:14:43|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:43|STATUS ]====|Drifting particles (using 8 cores)... [15:14:43|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:43|STATUS ]==|ModuleP3M: End COLA+P3M step 10/74, time_kick:0.079506, time_drift=0.080756. [15:14:43|TIMER ]==|Step 10/74: Density: 0.007 CPU - 0.004 wallclock seconds used. [15:14:43|TIMER ]==|Step 10/74: Potential: 0.010 CPU - 0.006 wallclock seconds used. [15:14:43|TIMER ]==|Step 10/74: Accelerations (long-range): 0.065 CPU - 0.021 wallclock seconds used. [15:14:43|TIMER ]==|Step 10/74: Accelerations (short-range): 0.265 CPU - 0.070 wallclock seconds used. [15:14:43|TIMER ]==|Step 10/74: Kick: 0.007 CPU - 0.002 wallclock seconds used. [15:14:43|TIMER ]==|Step 10/74: Drift: 0.002 CPU - 0.001 wallclock seconds used. [15:14:43|TIMER ]==|Step 10/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:43|TIMER ]==|Step 10/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:43|TIMER ]==|Step 10/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:43|TIMER ]==|Step 10/74: Total Evolution: 0.356 CPU - 0.104 wallclock seconds used. [15:14:43|STATUS ]==|ModuleP3M: Begin COLA+P3M step 11/74, time_kick:0.079506, time_drift=0.080756. [15:14:43|STATUS ]====|ModuleP3M: Compute time step limiters for step 11/74 done. [15:14:43|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:43|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:43|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:43|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:43|STATUS ]====|Kicking particles (using 8 cores)... [15:14:43|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:43|STATUS ]====|Drifting particles (using 8 cores)... [15:14:43|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:43|STATUS ]==|ModuleP3M: End COLA+P3M step 11/74, time_kick:0.083481, time_drift=0.084731. [15:14:43|TIMER ]==|Step 11/74: Density: 0.014 CPU - 0.003 wallclock seconds used. [15:14:43|TIMER ]==|Step 11/74: Potential: 0.009 CPU - 0.003 wallclock seconds used. [15:14:43|TIMER ]==|Step 11/74: Accelerations (long-range): 0.061 CPU - 0.037 wallclock seconds used. [15:14:43|TIMER ]==|Step 11/74: Accelerations (short-range): 0.251 CPU - 0.161 wallclock seconds used. [15:14:43|TIMER ]==|Step 11/74: Kick: 0.006 CPU - 0.004 wallclock seconds used. [15:14:43|TIMER ]==|Step 11/74: Drift: 0.002 CPU - 0.001 wallclock seconds used. [15:14:43|TIMER ]==|Step 11/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:43|TIMER ]==|Step 11/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:43|TIMER ]==|Step 11/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:43|TIMER ]==|Step 11/74: Total Evolution: 0.343 CPU - 0.210 wallclock seconds used. [15:14:43|STATUS ]==|ModuleP3M: Begin COLA+P3M step 12/74, time_kick:0.083481, time_drift=0.084731. [15:14:43|STATUS ]====|ModuleP3M: Compute time step limiters for step 12/74 done. [15:14:43|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:43|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:43|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:43|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:43|STATUS ]====|Kicking particles (using 8 cores)... [15:14:43|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:43|STATUS ]====|Drifting particles (using 8 cores)... [15:14:43|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:43|STATUS ]==|ModuleP3M: End COLA+P3M step 12/74, time_kick:0.087655, time_drift=0.088905. [15:14:43|TIMER ]==|Step 12/74: Density: 0.008 CPU - 0.003 wallclock seconds used. [15:14:43|TIMER ]==|Step 12/74: Potential: 0.011 CPU - 0.005 wallclock seconds used. [15:14:43|TIMER ]==|Step 12/74: Accelerations (long-range): 0.063 CPU - 0.015 wallclock seconds used. [15:14:43|TIMER ]==|Step 12/74: Accelerations (short-range): 0.259 CPU - 0.061 wallclock seconds used. [15:14:43|TIMER ]==|Step 12/74: Kick: 0.006 CPU - 0.001 wallclock seconds used. [15:14:43|TIMER ]==|Step 12/74: Drift: 0.002 CPU - 0.001 wallclock seconds used. [15:14:43|TIMER ]==|Step 12/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:43|TIMER ]==|Step 12/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:43|TIMER ]==|Step 12/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:43|TIMER ]==|Step 12/74: Total Evolution: 0.349 CPU - 0.086 wallclock seconds used. [15:14:43|STATUS ]==|ModuleP3M: Begin COLA+P3M step 13/74, time_kick:0.087655, time_drift=0.088905. [15:14:43|STATUS ]====|ModuleP3M: Compute time step limiters for step 13/74 done. [15:14:43|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:43|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:43|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:43|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:43|STATUS ]====|Kicking particles (using 8 cores)... [15:14:43|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:43|STATUS ]====|Drifting particles (using 8 cores)... [15:14:43|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:43|STATUS ]==|ModuleP3M: End COLA+P3M step 13/74, time_kick:0.092038, time_drift=0.093288. [15:14:43|TIMER ]==|Step 13/74: Density: 0.011 CPU - 0.002 wallclock seconds used. [15:14:43|TIMER ]==|Step 13/74: Potential: 0.009 CPU - 0.003 wallclock seconds used. [15:14:43|TIMER ]==|Step 13/74: Accelerations (long-range): 0.060 CPU - 0.015 wallclock seconds used. [15:14:43|TIMER ]==|Step 13/74: Accelerations (short-range): 0.256 CPU - 0.052 wallclock seconds used. [15:14:43|TIMER ]==|Step 13/74: Kick: 0.005 CPU - 0.001 wallclock seconds used. [15:14:43|TIMER ]==|Step 13/74: Drift: 0.001 CPU - 0.001 wallclock seconds used. [15:14:43|TIMER ]==|Step 13/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:43|TIMER ]==|Step 13/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:43|TIMER ]==|Step 13/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:43|TIMER ]==|Step 13/74: Total Evolution: 0.343 CPU - 0.075 wallclock seconds used. [15:14:43|STATUS ]==|ModuleP3M: Begin COLA+P3M step 14/74, time_kick:0.092038, time_drift=0.093288. [15:14:43|STATUS ]====|ModuleP3M: Compute time step limiters for step 14/74 done. [15:14:43|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:43|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:43|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:43|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:43|STATUS ]====|Kicking particles (using 8 cores)... [15:14:44|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:44|STATUS ]====|Drifting particles (using 8 cores)... [15:14:44|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:44|STATUS ]==|ModuleP3M: End COLA+P3M step 14/74, time_kick:0.096640, time_drift=0.097890. [15:14:44|TIMER ]==|Step 14/74: Density: 0.009 CPU - 0.003 wallclock seconds used. [15:14:44|TIMER ]==|Step 14/74: Potential: 0.008 CPU - 0.003 wallclock seconds used. [15:14:44|TIMER ]==|Step 14/74: Accelerations (long-range): 0.064 CPU - 0.015 wallclock seconds used. [15:14:44|TIMER ]==|Step 14/74: Accelerations (short-range): 0.254 CPU - 0.045 wallclock seconds used. [15:14:44|TIMER ]==|Step 14/74: Kick: 0.006 CPU - 0.002 wallclock seconds used. [15:14:44|TIMER ]==|Step 14/74: Drift: 0.001 CPU - 0.001 wallclock seconds used. [15:14:44|TIMER ]==|Step 14/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:44|TIMER ]==|Step 14/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:44|TIMER ]==|Step 14/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:44|TIMER ]==|Step 14/74: Total Evolution: 0.342 CPU - 0.068 wallclock seconds used. [15:14:44|STATUS ]==|ModuleP3M: Begin COLA+P3M step 15/74, time_kick:0.096640, time_drift=0.097890. [15:14:44|STATUS ]====|ModuleP3M: Compute time step limiters for step 15/74 done. [15:14:44|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:44|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:44|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:44|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:44|STATUS ]====|Kicking particles (using 8 cores)... [15:14:44|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:44|STATUS ]====|Drifting particles (using 8 cores)... [15:14:44|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:44|STATUS ]==|ModuleP3M: End COLA+P3M step 15/74, time_kick:0.101471, time_drift=0.102721. [15:14:44|TIMER ]==|Step 15/74: Density: 0.011 CPU - 0.003 wallclock seconds used. [15:14:44|TIMER ]==|Step 15/74: Potential: 0.010 CPU - 0.003 wallclock seconds used. [15:14:44|TIMER ]==|Step 15/74: Accelerations (long-range): 0.061 CPU - 0.017 wallclock seconds used. [15:14:44|TIMER ]==|Step 15/74: Accelerations (short-range): 0.268 CPU - 0.052 wallclock seconds used. [15:14:44|TIMER ]==|Step 15/74: Kick: 0.006 CPU - 0.002 wallclock seconds used. [15:14:44|TIMER ]==|Step 15/74: Drift: 0.001 CPU - 0.001 wallclock seconds used. [15:14:44|TIMER ]==|Step 15/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:44|TIMER ]==|Step 15/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:44|TIMER ]==|Step 15/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:44|TIMER ]==|Step 15/74: Total Evolution: 0.357 CPU - 0.078 wallclock seconds used. [15:14:44|STATUS ]==|ModuleP3M: Begin COLA+P3M step 16/74, time_kick:0.101471, time_drift=0.102721. [15:14:44|STATUS ]====|ModuleP3M: Compute time step limiters for step 16/74 done. [15:14:44|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:44|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:44|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:44|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:44|STATUS ]====|Kicking particles (using 8 cores)... [15:14:44|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:44|STATUS ]====|Drifting particles (using 8 cores)... [15:14:44|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:44|STATUS ]==|ModuleP3M: End COLA+P3M step 16/74, time_kick:0.106545, time_drift=0.107795. [15:14:44|TIMER ]==|Step 16/74: Density: 0.012 CPU - 0.003 wallclock seconds used. [15:14:44|TIMER ]==|Step 16/74: Potential: 0.008 CPU - 0.003 wallclock seconds used. [15:14:44|TIMER ]==|Step 16/74: Accelerations (long-range): 0.061 CPU - 0.016 wallclock seconds used. [15:14:44|TIMER ]==|Step 16/74: Accelerations (short-range): 0.255 CPU - 0.052 wallclock seconds used. [15:14:44|TIMER ]==|Step 16/74: Kick: 0.006 CPU - 0.002 wallclock seconds used. [15:14:44|TIMER ]==|Step 16/74: Drift: 0.002 CPU - 0.001 wallclock seconds used. [15:14:44|TIMER ]==|Step 16/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:44|TIMER ]==|Step 16/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:44|TIMER ]==|Step 16/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:44|TIMER ]==|Step 16/74: Total Evolution: 0.344 CPU - 0.077 wallclock seconds used. [15:14:44|STATUS ]==|ModuleP3M: Begin COLA+P3M step 17/74, time_kick:0.106545, time_drift=0.107795. [15:14:44|STATUS ]====|ModuleP3M: Compute time step limiters for step 17/74 done. [15:14:44|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:44|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:44|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:44|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:44|STATUS ]====|Kicking particles (using 8 cores)... [15:14:44|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:44|STATUS ]====|Drifting particles (using 8 cores)... [15:14:44|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:44|STATUS ]==|ModuleP3M: End COLA+P3M step 17/74, time_kick:0.111872, time_drift=0.113122. [15:14:44|TIMER ]==|Step 17/74: Density: 0.012 CPU - 0.003 wallclock seconds used. [15:14:44|TIMER ]==|Step 17/74: Potential: 0.008 CPU - 0.003 wallclock seconds used. [15:14:44|TIMER ]==|Step 17/74: Accelerations (long-range): 0.061 CPU - 0.017 wallclock seconds used. [15:14:44|TIMER ]==|Step 17/74: Accelerations (short-range): 0.258 CPU - 0.050 wallclock seconds used. [15:14:44|TIMER ]==|Step 17/74: Kick: 0.006 CPU - 0.002 wallclock seconds used. [15:14:44|TIMER ]==|Step 17/74: Drift: 0.002 CPU - 0.001 wallclock seconds used. [15:14:44|TIMER ]==|Step 17/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:44|TIMER ]==|Step 17/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:44|TIMER ]==|Step 17/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:44|TIMER ]==|Step 17/74: Total Evolution: 0.347 CPU - 0.075 wallclock seconds used. [15:14:44|STATUS ]==|ModuleP3M: Begin COLA+P3M step 18/74, time_kick:0.111872, time_drift=0.113122. [15:14:44|STATUS ]====|ModuleP3M: Compute time step limiters for step 18/74 done. [15:14:44|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:44|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:44|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:44|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:44|STATUS ]====|Kicking particles (using 8 cores)... [15:14:44|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:44|STATUS ]====|Drifting particles (using 8 cores)... [15:14:44|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:44|STATUS ]==|ModuleP3M: End COLA+P3M step 18/74, time_kick:0.117466, time_drift=0.118716. [15:14:44|TIMER ]==|Step 18/74: Density: 0.011 CPU - 0.004 wallclock seconds used. [15:14:44|TIMER ]==|Step 18/74: Potential: 0.009 CPU - 0.004 wallclock seconds used. [15:14:44|TIMER ]==|Step 18/74: Accelerations (long-range): 0.062 CPU - 0.024 wallclock seconds used. [15:14:44|TIMER ]==|Step 18/74: Accelerations (short-range): 0.258 CPU - 0.064 wallclock seconds used. [15:14:44|TIMER ]==|Step 18/74: Kick: 0.006 CPU - 0.002 wallclock seconds used. [15:14:44|TIMER ]==|Step 18/74: Drift: 0.002 CPU - 0.001 wallclock seconds used. [15:14:44|TIMER ]==|Step 18/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:44|TIMER ]==|Step 18/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:44|TIMER ]==|Step 18/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:44|TIMER ]==|Step 18/74: Total Evolution: 0.348 CPU - 0.098 wallclock seconds used. [15:14:44|STATUS ]==|ModuleP3M: Begin COLA+P3M step 19/74, time_kick:0.117466, time_drift=0.118716. [15:14:44|STATUS ]====|ModuleP3M: Compute time step limiters for step 19/74 done. [15:14:44|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:44|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:44|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:44|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:44|STATUS ]====|Kicking particles (using 8 cores)... [15:14:44|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:44|STATUS ]====|Drifting particles (using 8 cores)... [15:14:44|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:44|STATUS ]==|ModuleP3M: End COLA+P3M step 19/74, time_kick:0.123339, time_drift=0.124589. [15:14:44|TIMER ]==|Step 19/74: Density: 0.007 CPU - 0.003 wallclock seconds used. [15:14:44|TIMER ]==|Step 19/74: Potential: 0.009 CPU - 0.003 wallclock seconds used. [15:14:44|TIMER ]==|Step 19/74: Accelerations (long-range): 0.064 CPU - 0.038 wallclock seconds used. [15:14:44|TIMER ]==|Step 19/74: Accelerations (short-range): 0.249 CPU - 0.074 wallclock seconds used. [15:14:44|TIMER ]==|Step 19/74: Kick: 0.007 CPU - 0.004 wallclock seconds used. [15:14:44|TIMER ]==|Step 19/74: Drift: 0.002 CPU - 0.001 wallclock seconds used. [15:14:44|TIMER ]==|Step 19/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:44|TIMER ]==|Step 19/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:44|TIMER ]==|Step 19/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:44|TIMER ]==|Step 19/74: Total Evolution: 0.340 CPU - 0.123 wallclock seconds used. [15:14:44|STATUS ]==|ModuleP3M: Begin COLA+P3M step 20/74, time_kick:0.123339, time_drift=0.124589. [15:14:44|STATUS ]====|ModuleP3M: Compute time step limiters for step 20/74 done. [15:14:44|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:44|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:44|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:44|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:44|STATUS ]====|Kicking particles (using 8 cores)... [15:14:44|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:44|STATUS ]====|Drifting particles (using 8 cores)... [15:14:44|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:44|STATUS ]==|ModuleP3M: End COLA+P3M step 20/74, time_kick:0.129506, time_drift=0.130756. [15:14:44|TIMER ]==|Step 20/74: Density: 0.008 CPU - 0.006 wallclock seconds used. [15:14:44|TIMER ]==|Step 20/74: Potential: 0.012 CPU - 0.006 wallclock seconds used. [15:14:44|TIMER ]==|Step 20/74: Accelerations (long-range): 0.067 CPU - 0.019 wallclock seconds used. [15:14:44|TIMER ]==|Step 20/74: Accelerations (short-range): 0.266 CPU - 0.065 wallclock seconds used. [15:14:44|TIMER ]==|Step 20/74: Kick: 0.007 CPU - 0.004 wallclock seconds used. [15:14:44|TIMER ]==|Step 20/74: Drift: 0.002 CPU - 0.001 wallclock seconds used. [15:14:44|TIMER ]==|Step 20/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:44|TIMER ]==|Step 20/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:44|TIMER ]==|Step 20/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:44|TIMER ]==|Step 20/74: Total Evolution: 0.361 CPU - 0.100 wallclock seconds used. [15:14:44|STATUS ]==|ModuleP3M: Begin COLA+P3M step 21/74, time_kick:0.129506, time_drift=0.130756. [15:14:44|STATUS ]====|ModuleP3M: Compute time step limiters for step 21/74 done. [15:14:44|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:44|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:44|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:44|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:44|STATUS ]====|Kicking particles (using 8 cores)... [15:14:44|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:44|STATUS ]====|Drifting particles (using 8 cores)... [15:14:44|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:44|STATUS ]==|ModuleP3M: End COLA+P3M step 21/74, time_kick:0.135982, time_drift=0.137232. [15:14:44|TIMER ]==|Step 21/74: Density: 0.014 CPU - 0.003 wallclock seconds used. [15:14:44|TIMER ]==|Step 21/74: Potential: 0.010 CPU - 0.003 wallclock seconds used. [15:14:44|TIMER ]==|Step 21/74: Accelerations (long-range): 0.063 CPU - 0.014 wallclock seconds used. [15:14:44|TIMER ]==|Step 21/74: Accelerations (short-range): 0.252 CPU - 0.042 wallclock seconds used. [15:14:44|TIMER ]==|Step 21/74: Kick: 0.006 CPU - 0.002 wallclock seconds used. [15:14:44|TIMER ]==|Step 21/74: Drift: 0.002 CPU - 0.001 wallclock seconds used. [15:14:44|TIMER ]==|Step 21/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:44|TIMER ]==|Step 21/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:44|TIMER ]==|Step 21/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:44|TIMER ]==|Step 21/74: Total Evolution: 0.347 CPU - 0.065 wallclock seconds used. [15:14:44|STATUS ]==|ModuleP3M: Begin COLA+P3M step 22/74, time_kick:0.135982, time_drift=0.137232. [15:14:44|STATUS ]====|ModuleP3M: Compute time step limiters for step 22/74 done. [15:14:44|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:44|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:44|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:44|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:44|STATUS ]====|Kicking particles (using 8 cores)... [15:14:44|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:44|STATUS ]====|Drifting particles (using 8 cores)... [15:14:44|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:44|STATUS ]==|ModuleP3M: End COLA+P3M step 22/74, time_kick:0.142781, time_drift=0.144031. [15:14:44|TIMER ]==|Step 22/74: Density: 0.015 CPU - 0.003 wallclock seconds used. [15:14:44|TIMER ]==|Step 22/74: Potential: 0.008 CPU - 0.003 wallclock seconds used. [15:14:44|TIMER ]==|Step 22/74: Accelerations (long-range): 0.063 CPU - 0.013 wallclock seconds used. [15:14:44|TIMER ]==|Step 22/74: Accelerations (short-range): 0.267 CPU - 0.040 wallclock seconds used. [15:14:44|TIMER ]==|Step 22/74: Kick: 0.006 CPU - 0.001 wallclock seconds used. [15:14:44|TIMER ]==|Step 22/74: Drift: 0.002 CPU - 0.001 wallclock seconds used. [15:14:44|TIMER ]==|Step 22/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:44|TIMER ]==|Step 22/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:44|TIMER ]==|Step 22/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:44|TIMER ]==|Step 22/74: Total Evolution: 0.361 CPU - 0.060 wallclock seconds used. [15:14:44|STATUS ]==|ModuleP3M: Begin COLA+P3M step 23/74, time_kick:0.142781, time_drift=0.144031. [15:14:44|STATUS ]====|ModuleP3M: Compute time step limiters for step 23/74 done. [15:14:44|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:44|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:44|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:44|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:44|STATUS ]====|Kicking particles (using 8 cores)... [15:14:44|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:44|STATUS ]====|Drifting particles (using 8 cores)... [15:14:44|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:44|STATUS ]==|ModuleP3M: End COLA+P3M step 23/74, time_kick:0.149920, time_drift=0.151170. [15:14:44|TIMER ]==|Step 23/74: Density: 0.010 CPU - 0.002 wallclock seconds used. [15:14:44|TIMER ]==|Step 23/74: Potential: 0.009 CPU - 0.003 wallclock seconds used. [15:14:44|TIMER ]==|Step 23/74: Accelerations (long-range): 0.064 CPU - 0.013 wallclock seconds used. [15:14:44|TIMER ]==|Step 23/74: Accelerations (short-range): 0.254 CPU - 0.039 wallclock seconds used. [15:14:44|TIMER ]==|Step 23/74: Kick: 0.006 CPU - 0.001 wallclock seconds used. [15:14:44|TIMER ]==|Step 23/74: Drift: 0.002 CPU - 0.001 wallclock seconds used. [15:14:44|TIMER ]==|Step 23/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:44|TIMER ]==|Step 23/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:44|TIMER ]==|Step 23/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:44|TIMER ]==|Step 23/74: Total Evolution: 0.345 CPU - 0.059 wallclock seconds used. [15:14:44|STATUS ]==|ModuleP3M: Begin COLA+P3M step 24/74, time_kick:0.149920, time_drift=0.151170. [15:14:44|STATUS ]====|ModuleP3M: Compute time step limiters for step 24/74 done. [15:14:44|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:44|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:44|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:44|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:44|STATUS ]====|ModuleP3M: Writing gravitational potential to /Users/hoellinger/WIP3M/notebook12/gravpot/gp_nforce23.h5. [15:14:44|STATUS ]====|Writing field to '/Users/hoellinger/WIP3M/notebook12/gravpot/gp_nforce23.h5'... [15:14:44|STATUS ]====|Writing field to '/Users/hoellinger/WIP3M/notebook12/gravpot/gp_nforce23.h5' done. [15:14:44|STATUS ]====|Kicking particles (using 8 cores)... [15:14:44|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:44|STATUS ]====|Drifting particles (using 8 cores)... [15:14:44|STATUS ]======|Writing field to '/Users/hoellinger/WIP3M/notebook12/p_res/p23.h5'... [15:14:44|STATUS ]======|Writing field to '/Users/hoellinger/WIP3M/notebook12/p_res/p23.h5' done. [15:14:44|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:44|STATUS ]==|ModuleP3M: End COLA+P3M step 24/74, time_kick:0.157416, time_drift=0.158666. [15:14:44|TIMER ]==|Step 24/74: Density: 0.010 CPU - 0.002 wallclock seconds used. [15:14:44|TIMER ]==|Step 24/74: Potential: 0.009 CPU - 0.003 wallclock seconds used. [15:14:44|TIMER ]==|Step 24/74: Accelerations (long-range): 0.062 CPU - 0.013 wallclock seconds used. [15:14:44|TIMER ]==|Step 24/74: Accelerations (short-range): 0.261 CPU - 0.045 wallclock seconds used. [15:14:44|TIMER ]==|Step 24/74: Kick: 0.006 CPU - 0.001 wallclock seconds used. [15:14:44|TIMER ]==|Step 24/74: Drift: 0.001 CPU - 0.001 wallclock seconds used. [15:14:44|TIMER ]==|Step 24/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:44|TIMER ]==|Step 24/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:44|TIMER ]==|Step 24/74: Outputs: 0.001 CPU - 0.001 wallclock seconds used. [15:14:44|TIMER ]==|Step 24/74: Total Evolution: 0.350 CPU - 0.066 wallclock seconds used. [15:14:44|STATUS ]==|ModuleP3M: Begin COLA+P3M step 25/74, time_kick:0.157416, time_drift=0.158666. [15:14:44|STATUS ]====|ModuleP3M: Compute time step limiters for step 25/74 done. [15:14:44|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:44|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:44|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:44|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:44|STATUS ]====|Kicking particles (using 8 cores)... [15:14:44|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:44|STATUS ]====|Drifting particles (using 8 cores)... [15:14:44|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:44|STATUS ]==|ModuleP3M: End COLA+P3M step 25/74, time_kick:0.165286, time_drift=0.166536. [15:14:44|TIMER ]==|Step 25/74: Density: 0.011 CPU - 0.002 wallclock seconds used. [15:14:44|TIMER ]==|Step 25/74: Potential: 0.009 CPU - 0.003 wallclock seconds used. [15:14:44|TIMER ]==|Step 25/74: Accelerations (long-range): 0.062 CPU - 0.014 wallclock seconds used. [15:14:44|TIMER ]==|Step 25/74: Accelerations (short-range): 0.255 CPU - 0.038 wallclock seconds used. [15:14:44|TIMER ]==|Step 25/74: Kick: 0.006 CPU - 0.001 wallclock seconds used. [15:14:44|TIMER ]==|Step 25/74: Drift: 0.001 CPU - 0.001 wallclock seconds used. [15:14:44|TIMER ]==|Step 25/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:44|TIMER ]==|Step 25/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:44|TIMER ]==|Step 25/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:44|TIMER ]==|Step 25/74: Total Evolution: 0.344 CPU - 0.059 wallclock seconds used. [15:14:44|STATUS ]==|ModuleP3M: Begin COLA+P3M step 26/74, time_kick:0.165286, time_drift=0.166536. [15:14:44|STATUS ]====|ModuleP3M: Compute time step limiters for step 26/74 done. [15:14:44|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:44|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:44|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:44|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:44|STATUS ]====|Kicking particles (using 8 cores)... [15:14:45|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:45|STATUS ]====|Drifting particles (using 8 cores)... [15:14:45|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:45|STATUS ]==|ModuleP3M: End COLA+P3M step 26/74, time_kick:0.173551, time_drift=0.174801. [15:14:45|TIMER ]==|Step 26/74: Density: 0.010 CPU - 0.003 wallclock seconds used. [15:14:45|TIMER ]==|Step 26/74: Potential: 0.009 CPU - 0.003 wallclock seconds used. [15:14:45|TIMER ]==|Step 26/74: Accelerations (long-range): 0.061 CPU - 0.014 wallclock seconds used. [15:14:45|TIMER ]==|Step 26/74: Accelerations (short-range): 0.260 CPU - 0.040 wallclock seconds used. [15:14:45|TIMER ]==|Step 26/74: Kick: 0.006 CPU - 0.001 wallclock seconds used. [15:14:45|TIMER ]==|Step 26/74: Drift: 0.002 CPU - 0.001 wallclock seconds used. [15:14:45|TIMER ]==|Step 26/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:45|TIMER ]==|Step 26/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:45|TIMER ]==|Step 26/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:45|TIMER ]==|Step 26/74: Total Evolution: 0.348 CPU - 0.061 wallclock seconds used. [15:14:45|STATUS ]==|ModuleP3M: Begin COLA+P3M step 27/74, time_kick:0.173551, time_drift=0.174801. [15:14:45|STATUS ]====|ModuleP3M: Compute time step limiters for step 27/74 done. [15:14:45|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:45|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:45|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:45|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:45|STATUS ]====|Kicking particles (using 8 cores)... [15:14:45|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:45|STATUS ]====|Drifting particles (using 8 cores)... [15:14:45|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:45|STATUS ]==|ModuleP3M: End COLA+P3M step 27/74, time_kick:0.182228, time_drift=0.183478. [15:14:45|TIMER ]==|Step 27/74: Density: 0.013 CPU - 0.003 wallclock seconds used. [15:14:45|TIMER ]==|Step 27/74: Potential: 0.008 CPU - 0.003 wallclock seconds used. [15:14:45|TIMER ]==|Step 27/74: Accelerations (long-range): 0.062 CPU - 0.015 wallclock seconds used. [15:14:45|TIMER ]==|Step 27/74: Accelerations (short-range): 0.248 CPU - 0.047 wallclock seconds used. [15:14:45|TIMER ]==|Step 27/74: Kick: 0.006 CPU - 0.002 wallclock seconds used. [15:14:45|TIMER ]==|Step 27/74: Drift: 0.002 CPU - 0.004 wallclock seconds used. [15:14:45|TIMER ]==|Step 27/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:45|TIMER ]==|Step 27/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:45|TIMER ]==|Step 27/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:45|TIMER ]==|Step 27/74: Total Evolution: 0.337 CPU - 0.073 wallclock seconds used. [15:14:45|STATUS ]==|ModuleP3M: Begin COLA+P3M step 28/74, time_kick:0.182228, time_drift=0.183478. [15:14:45|STATUS ]====|ModuleP3M: Compute time step limiters for step 28/74 done. [15:14:45|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:45|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:45|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:45|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:45|STATUS ]====|Kicking particles (using 8 cores)... [15:14:45|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:45|STATUS ]====|Drifting particles (using 8 cores)... [15:14:45|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:45|STATUS ]==|ModuleP3M: End COLA+P3M step 28/74, time_kick:0.191340, time_drift=0.192590. [15:14:45|TIMER ]==|Step 28/74: Density: 0.011 CPU - 0.003 wallclock seconds used. [15:14:45|TIMER ]==|Step 28/74: Potential: 0.009 CPU - 0.003 wallclock seconds used. [15:14:45|TIMER ]==|Step 28/74: Accelerations (long-range): 0.058 CPU - 0.018 wallclock seconds used. [15:14:45|TIMER ]==|Step 28/74: Accelerations (short-range): 0.249 CPU - 0.047 wallclock seconds used. [15:14:45|TIMER ]==|Step 28/74: Kick: 0.006 CPU - 0.002 wallclock seconds used. [15:14:45|TIMER ]==|Step 28/74: Drift: 0.001 CPU - 0.005 wallclock seconds used. [15:14:45|TIMER ]==|Step 28/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:45|TIMER ]==|Step 28/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:45|TIMER ]==|Step 28/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:45|TIMER ]==|Step 28/74: Total Evolution: 0.335 CPU - 0.077 wallclock seconds used. [15:14:45|STATUS ]==|ModuleP3M: Begin COLA+P3M step 29/74, time_kick:0.191340, time_drift=0.192590. [15:14:45|STATUS ]====|ModuleP3M: Compute time step limiters for step 29/74 done. [15:14:45|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:45|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:45|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:45|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:45|STATUS ]====|Kicking particles (using 8 cores)... [15:14:45|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:45|STATUS ]====|Drifting particles (using 8 cores)... [15:14:45|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:45|STATUS ]==|ModuleP3M: End COLA+P3M step 29/74, time_kick:0.200907, time_drift=0.202157. [15:14:45|TIMER ]==|Step 29/74: Density: 0.022 CPU - 0.003 wallclock seconds used. [15:14:45|TIMER ]==|Step 29/74: Potential: 0.008 CPU - 0.003 wallclock seconds used. [15:14:45|TIMER ]==|Step 29/74: Accelerations (long-range): 0.063 CPU - 0.013 wallclock seconds used. [15:14:45|TIMER ]==|Step 29/74: Accelerations (short-range): 0.315 CPU - 0.044 wallclock seconds used. [15:14:45|TIMER ]==|Step 29/74: Kick: 0.006 CPU - 0.001 wallclock seconds used. [15:14:45|TIMER ]==|Step 29/74: Drift: 0.002 CPU - 0.001 wallclock seconds used. [15:14:45|TIMER ]==|Step 29/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:45|TIMER ]==|Step 29/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:45|TIMER ]==|Step 29/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:45|TIMER ]==|Step 29/74: Total Evolution: 0.416 CPU - 0.066 wallclock seconds used. [15:14:45|STATUS ]==|ModuleP3M: Begin COLA+P3M step 30/74, time_kick:0.200907, time_drift=0.202157. [15:14:45|STATUS ]====|ModuleP3M: Compute time step limiters for step 30/74 done. [15:14:45|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:45|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:45|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:45|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:45|STATUS ]====|Kicking particles (using 8 cores)... [15:14:45|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:45|STATUS ]====|Drifting particles (using 8 cores)... [15:14:45|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:45|STATUS ]==|ModuleP3M: End COLA+P3M step 30/74, time_kick:0.210952, time_drift=0.212202. [15:14:45|TIMER ]==|Step 30/74: Density: 0.015 CPU - 0.003 wallclock seconds used. [15:14:45|TIMER ]==|Step 30/74: Potential: 0.008 CPU - 0.003 wallclock seconds used. [15:14:45|TIMER ]==|Step 30/74: Accelerations (long-range): 0.063 CPU - 0.012 wallclock seconds used. [15:14:45|TIMER ]==|Step 30/74: Accelerations (short-range): 0.271 CPU - 0.039 wallclock seconds used. [15:14:45|TIMER ]==|Step 30/74: Kick: 0.006 CPU - 0.001 wallclock seconds used. [15:14:45|TIMER ]==|Step 30/74: Drift: 0.001 CPU - 0.001 wallclock seconds used. [15:14:45|TIMER ]==|Step 30/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:45|TIMER ]==|Step 30/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:45|TIMER ]==|Step 30/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:45|TIMER ]==|Step 30/74: Total Evolution: 0.364 CPU - 0.059 wallclock seconds used. [15:14:45|STATUS ]==|ModuleP3M: Begin COLA+P3M step 31/74, time_kick:0.210952, time_drift=0.212202. [15:14:45|STATUS ]====|ModuleP3M: Compute time step limiters for step 31/74 done. [15:14:45|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:45|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:45|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:45|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:45|STATUS ]====|Kicking particles (using 8 cores)... [15:14:45|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:45|STATUS ]====|Drifting particles (using 8 cores)... [15:14:45|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:45|STATUS ]==|ModuleP3M: End COLA+P3M step 31/74, time_kick:0.221500, time_drift=0.222750. [15:14:45|TIMER ]==|Step 31/74: Density: 0.018 CPU - 0.003 wallclock seconds used. [15:14:45|TIMER ]==|Step 31/74: Potential: 0.009 CPU - 0.003 wallclock seconds used. [15:14:45|TIMER ]==|Step 31/74: Accelerations (long-range): 0.063 CPU - 0.013 wallclock seconds used. [15:14:45|TIMER ]==|Step 31/74: Accelerations (short-range): 0.269 CPU - 0.040 wallclock seconds used. [15:14:45|TIMER ]==|Step 31/74: Kick: 0.006 CPU - 0.001 wallclock seconds used. [15:14:45|TIMER ]==|Step 31/74: Drift: 0.001 CPU - 0.001 wallclock seconds used. [15:14:45|TIMER ]==|Step 31/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:45|TIMER ]==|Step 31/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:45|TIMER ]==|Step 31/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:45|TIMER ]==|Step 31/74: Total Evolution: 0.365 CPU - 0.060 wallclock seconds used. [15:14:45|STATUS ]==|ModuleP3M: Begin COLA+P3M step 32/74, time_kick:0.221500, time_drift=0.222750. [15:14:45|STATUS ]====|ModuleP3M: Compute time step limiters for step 32/74 done. [15:14:45|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:45|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:45|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:45|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:45|STATUS ]====|Kicking particles (using 8 cores)... [15:14:45|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:45|STATUS ]====|Drifting particles (using 8 cores)... [15:14:45|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:45|STATUS ]==|ModuleP3M: End COLA+P3M step 32/74, time_kick:0.232575, time_drift=0.233825. [15:14:45|TIMER ]==|Step 32/74: Density: 0.011 CPU - 0.002 wallclock seconds used. [15:14:45|TIMER ]==|Step 32/74: Potential: 0.008 CPU - 0.002 wallclock seconds used. [15:14:45|TIMER ]==|Step 32/74: Accelerations (long-range): 0.065 CPU - 0.012 wallclock seconds used. [15:14:45|TIMER ]==|Step 32/74: Accelerations (short-range): 0.261 CPU - 0.043 wallclock seconds used. [15:14:45|TIMER ]==|Step 32/74: Kick: 0.006 CPU - 0.001 wallclock seconds used. [15:14:45|TIMER ]==|Step 32/74: Drift: 0.001 CPU - 0.001 wallclock seconds used. [15:14:45|TIMER ]==|Step 32/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:45|TIMER ]==|Step 32/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:45|TIMER ]==|Step 32/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:45|TIMER ]==|Step 32/74: Total Evolution: 0.352 CPU - 0.062 wallclock seconds used. [15:14:45|STATUS ]==|ModuleP3M: Begin COLA+P3M step 33/74, time_kick:0.232575, time_drift=0.233825. [15:14:45|STATUS ]====|ModuleP3M: Compute time step limiters for step 33/74 done. [15:14:45|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:45|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:45|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:45|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:45|STATUS ]====|Kicking particles (using 8 cores)... [15:14:45|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:45|STATUS ]====|Drifting particles (using 8 cores)... [15:14:45|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:45|STATUS ]==|ModuleP3M: End COLA+P3M step 33/74, time_kick:0.244203, time_drift=0.245453. [15:14:45|TIMER ]==|Step 33/74: Density: 0.014 CPU - 0.003 wallclock seconds used. [15:14:45|TIMER ]==|Step 33/74: Potential: 0.008 CPU - 0.003 wallclock seconds used. [15:14:45|TIMER ]==|Step 33/74: Accelerations (long-range): 0.064 CPU - 0.014 wallclock seconds used. [15:14:45|TIMER ]==|Step 33/74: Accelerations (short-range): 0.279 CPU - 0.041 wallclock seconds used. [15:14:45|TIMER ]==|Step 33/74: Kick: 0.005 CPU - 0.001 wallclock seconds used. [15:14:45|TIMER ]==|Step 33/74: Drift: 0.001 CPU - 0.001 wallclock seconds used. [15:14:45|TIMER ]==|Step 33/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:45|TIMER ]==|Step 33/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:45|TIMER ]==|Step 33/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:45|TIMER ]==|Step 33/74: Total Evolution: 0.372 CPU - 0.062 wallclock seconds used. [15:14:45|STATUS ]==|ModuleP3M: Begin COLA+P3M step 34/74, time_kick:0.244203, time_drift=0.245453. [15:14:45|STATUS ]====|ModuleP3M: Compute time step limiters for step 34/74 done. [15:14:45|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:45|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:45|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:45|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:45|STATUS ]====|Kicking particles (using 8 cores)... [15:14:45|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:45|STATUS ]====|Drifting particles (using 8 cores)... [15:14:45|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:45|STATUS ]==|ModuleP3M: End COLA+P3M step 34/74, time_kick:0.256413, time_drift=0.257663. [15:14:45|TIMER ]==|Step 34/74: Density: 0.022 CPU - 0.003 wallclock seconds used. [15:14:45|TIMER ]==|Step 34/74: Potential: 0.008 CPU - 0.002 wallclock seconds used. [15:14:45|TIMER ]==|Step 34/74: Accelerations (long-range): 0.060 CPU - 0.014 wallclock seconds used. [15:14:45|TIMER ]==|Step 34/74: Accelerations (short-range): 0.274 CPU - 0.040 wallclock seconds used. [15:14:45|TIMER ]==|Step 34/74: Kick: 0.006 CPU - 0.001 wallclock seconds used. [15:14:45|TIMER ]==|Step 34/74: Drift: 0.002 CPU - 0.001 wallclock seconds used. [15:14:45|TIMER ]==|Step 34/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:45|TIMER ]==|Step 34/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:45|TIMER ]==|Step 34/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:45|TIMER ]==|Step 34/74: Total Evolution: 0.372 CPU - 0.061 wallclock seconds used. [15:14:45|STATUS ]==|ModuleP3M: Begin COLA+P3M step 35/74, time_kick:0.256413, time_drift=0.257663. [15:14:45|STATUS ]====|ModuleP3M: Compute time step limiters for step 35/74 done. [15:14:45|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:45|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:45|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:45|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:45|STATUS ]====|Kicking particles (using 8 cores)... [15:14:45|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:45|STATUS ]====|Drifting particles (using 8 cores)... [15:14:45|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:45|STATUS ]==|ModuleP3M: End COLA+P3M step 35/74, time_kick:0.269234, time_drift=0.270484. [15:14:45|TIMER ]==|Step 35/74: Density: 0.010 CPU - 0.002 wallclock seconds used. [15:14:45|TIMER ]==|Step 35/74: Potential: 0.008 CPU - 0.003 wallclock seconds used. [15:14:45|TIMER ]==|Step 35/74: Accelerations (long-range): 0.059 CPU - 0.013 wallclock seconds used. [15:14:45|TIMER ]==|Step 35/74: Accelerations (short-range): 0.275 CPU - 0.042 wallclock seconds used. [15:14:45|TIMER ]==|Step 35/74: Kick: 0.006 CPU - 0.001 wallclock seconds used. [15:14:45|TIMER ]==|Step 35/74: Drift: 0.001 CPU - 0.001 wallclock seconds used. [15:14:45|TIMER ]==|Step 35/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:45|TIMER ]==|Step 35/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:45|TIMER ]==|Step 35/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:45|TIMER ]==|Step 35/74: Total Evolution: 0.360 CPU - 0.063 wallclock seconds used. [15:14:45|STATUS ]==|ModuleP3M: Begin COLA+P3M step 36/74, time_kick:0.269234, time_drift=0.270484. [15:14:45|STATUS ]====|ModuleP3M: Compute time step limiters for step 36/74 done. [15:14:45|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:45|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:45|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:45|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:45|STATUS ]====|Kicking particles (using 8 cores)... [15:14:45|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:45|STATUS ]====|Drifting particles (using 8 cores)... [15:14:45|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:45|STATUS ]==|ModuleP3M: End COLA+P3M step 36/74, time_kick:0.282696, time_drift=0.283946. [15:14:45|TIMER ]==|Step 36/74: Density: 0.012 CPU - 0.002 wallclock seconds used. [15:14:45|TIMER ]==|Step 36/74: Potential: 0.009 CPU - 0.002 wallclock seconds used. [15:14:45|TIMER ]==|Step 36/74: Accelerations (long-range): 0.057 CPU - 0.014 wallclock seconds used. [15:14:45|TIMER ]==|Step 36/74: Accelerations (short-range): 0.275 CPU - 0.043 wallclock seconds used. [15:14:45|TIMER ]==|Step 36/74: Kick: 0.005 CPU - 0.001 wallclock seconds used. [15:14:45|TIMER ]==|Step 36/74: Drift: 0.001 CPU - 0.001 wallclock seconds used. [15:14:45|TIMER ]==|Step 36/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:45|TIMER ]==|Step 36/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:45|TIMER ]==|Step 36/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:45|TIMER ]==|Step 36/74: Total Evolution: 0.359 CPU - 0.063 wallclock seconds used. [15:14:45|STATUS ]==|ModuleP3M: Begin COLA+P3M step 37/74, time_kick:0.282696, time_drift=0.283946. [15:14:45|STATUS ]====|ModuleP3M: Compute time step limiters for step 37/74 done. [15:14:45|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:45|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:45|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:45|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:45|STATUS ]====|Kicking particles (using 8 cores)... [15:14:45|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:45|STATUS ]====|Drifting particles (using 8 cores)... [15:14:45|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:45|STATUS ]==|ModuleP3M: End COLA+P3M step 37/74, time_kick:0.296831, time_drift=0.298081. [15:14:45|TIMER ]==|Step 37/74: Density: 0.012 CPU - 0.003 wallclock seconds used. [15:14:45|TIMER ]==|Step 37/74: Potential: 0.009 CPU - 0.003 wallclock seconds used. [15:14:45|TIMER ]==|Step 37/74: Accelerations (long-range): 0.063 CPU - 0.012 wallclock seconds used. [15:14:45|TIMER ]==|Step 37/74: Accelerations (short-range): 0.269 CPU - 0.043 wallclock seconds used. [15:14:45|TIMER ]==|Step 37/74: Kick: 0.006 CPU - 0.001 wallclock seconds used. [15:14:45|TIMER ]==|Step 37/74: Drift: 0.001 CPU - 0.001 wallclock seconds used. [15:14:45|TIMER ]==|Step 37/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:45|TIMER ]==|Step 37/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:45|TIMER ]==|Step 37/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:45|TIMER ]==|Step 37/74: Total Evolution: 0.360 CPU - 0.062 wallclock seconds used. [15:14:45|STATUS ]==|ModuleP3M: Begin COLA+P3M step 38/74, time_kick:0.296831, time_drift=0.298081. [15:14:45|STATUS ]====|ModuleP3M: Compute time step limiters for step 38/74 done. [15:14:45|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:45|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:45|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:45|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:45|STATUS ]====|Kicking particles (using 8 cores)... [15:14:45|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:45|STATUS ]====|Drifting particles (using 8 cores)... [15:14:45|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:45|STATUS ]==|ModuleP3M: End COLA+P3M step 38/74, time_kick:0.311672, time_drift=0.312922. [15:14:45|TIMER ]==|Step 38/74: Density: 0.022 CPU - 0.004 wallclock seconds used. [15:14:45|TIMER ]==|Step 38/74: Potential: 0.008 CPU - 0.003 wallclock seconds used. [15:14:45|TIMER ]==|Step 38/74: Accelerations (long-range): 0.062 CPU - 0.013 wallclock seconds used. [15:14:45|TIMER ]==|Step 38/74: Accelerations (short-range): 0.284 CPU - 0.045 wallclock seconds used. [15:14:45|TIMER ]==|Step 38/74: Kick: 0.006 CPU - 0.001 wallclock seconds used. [15:14:45|TIMER ]==|Step 38/74: Drift: 0.002 CPU - 0.001 wallclock seconds used. [15:14:45|TIMER ]==|Step 38/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:45|TIMER ]==|Step 38/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:45|TIMER ]==|Step 38/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:45|TIMER ]==|Step 38/74: Total Evolution: 0.384 CPU - 0.066 wallclock seconds used. [15:14:45|STATUS ]==|ModuleP3M: Begin COLA+P3M step 39/74, time_kick:0.311672, time_drift=0.312922. [15:14:45|STATUS ]====|ModuleP3M: Compute time step limiters for step 39/74 done. [15:14:45|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:45|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:45|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:45|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:45|STATUS ]====|Kicking particles (using 8 cores)... [15:14:46|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:46|STATUS ]====|Drifting particles (using 8 cores)... [15:14:46|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:46|STATUS ]==|ModuleP3M: End COLA+P3M step 39/74, time_kick:0.327256, time_drift=0.328506. [15:14:46|TIMER ]==|Step 39/74: Density: 0.012 CPU - 0.002 wallclock seconds used. [15:14:46|TIMER ]==|Step 39/74: Potential: 0.008 CPU - 0.002 wallclock seconds used. [15:14:46|TIMER ]==|Step 39/74: Accelerations (long-range): 0.060 CPU - 0.013 wallclock seconds used. [15:14:46|TIMER ]==|Step 39/74: Accelerations (short-range): 0.291 CPU - 0.045 wallclock seconds used. [15:14:46|TIMER ]==|Step 39/74: Kick: 0.006 CPU - 0.001 wallclock seconds used. [15:14:46|TIMER ]==|Step 39/74: Drift: 0.001 CPU - 0.001 wallclock seconds used. [15:14:46|TIMER ]==|Step 39/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:46|TIMER ]==|Step 39/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:46|TIMER ]==|Step 39/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:46|TIMER ]==|Step 39/74: Total Evolution: 0.379 CPU - 0.065 wallclock seconds used. [15:14:46|STATUS ]==|ModuleP3M: Begin COLA+P3M step 40/74, time_kick:0.327256, time_drift=0.328506. [15:14:46|STATUS ]====|ModuleP3M: Compute time step limiters for step 40/74 done. [15:14:46|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:46|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:46|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:46|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:46|STATUS ]====|Kicking particles (using 8 cores)... [15:14:46|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:46|STATUS ]====|Drifting particles (using 8 cores)... [15:14:46|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:46|STATUS ]==|ModuleP3M: End COLA+P3M step 40/74, time_kick:0.343618, time_drift=0.344868. [15:14:46|TIMER ]==|Step 40/74: Density: 0.019 CPU - 0.003 wallclock seconds used. [15:14:46|TIMER ]==|Step 40/74: Potential: 0.008 CPU - 0.003 wallclock seconds used. [15:14:46|TIMER ]==|Step 40/74: Accelerations (long-range): 0.059 CPU - 0.014 wallclock seconds used. [15:14:46|TIMER ]==|Step 40/74: Accelerations (short-range): 0.296 CPU - 0.046 wallclock seconds used. [15:14:46|TIMER ]==|Step 40/74: Kick: 0.005 CPU - 0.001 wallclock seconds used. [15:14:46|TIMER ]==|Step 40/74: Drift: 0.001 CPU - 0.001 wallclock seconds used. [15:14:46|TIMER ]==|Step 40/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:46|TIMER ]==|Step 40/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:46|TIMER ]==|Step 40/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:46|TIMER ]==|Step 40/74: Total Evolution: 0.389 CPU - 0.067 wallclock seconds used. [15:14:46|STATUS ]==|ModuleP3M: Begin COLA+P3M step 41/74, time_kick:0.343618, time_drift=0.344868. [15:14:46|STATUS ]====|ModuleP3M: Compute time step limiters for step 41/74 done. [15:14:46|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:46|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:46|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:46|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:46|STATUS ]====|Kicking particles (using 8 cores)... [15:14:46|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:46|STATUS ]====|Drifting particles (using 8 cores)... [15:14:46|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:46|STATUS ]==|ModuleP3M: End COLA+P3M step 41/74, time_kick:0.360799, time_drift=0.362049. [15:14:46|TIMER ]==|Step 41/74: Density: 0.010 CPU - 0.002 wallclock seconds used. [15:14:46|TIMER ]==|Step 41/74: Potential: 0.008 CPU - 0.002 wallclock seconds used. [15:14:46|TIMER ]==|Step 41/74: Accelerations (long-range): 0.058 CPU - 0.020 wallclock seconds used. [15:14:46|TIMER ]==|Step 41/74: Accelerations (short-range): 0.278 CPU - 0.064 wallclock seconds used. [15:14:46|TIMER ]==|Step 41/74: Kick: 0.006 CPU - 0.003 wallclock seconds used. [15:14:46|TIMER ]==|Step 41/74: Drift: 0.001 CPU - 0.001 wallclock seconds used. [15:14:46|TIMER ]==|Step 41/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:46|TIMER ]==|Step 41/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:46|TIMER ]==|Step 41/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:46|TIMER ]==|Step 41/74: Total Evolution: 0.360 CPU - 0.093 wallclock seconds used. [15:14:46|STATUS ]==|ModuleP3M: Begin COLA+P3M step 42/74, time_kick:0.360799, time_drift=0.362049. [15:14:46|STATUS ]====|ModuleP3M: Compute time step limiters for step 42/74 done. [15:14:46|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:46|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:46|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:46|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:46|STATUS ]====|Kicking particles (using 8 cores)... [15:14:46|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:46|STATUS ]====|Drifting particles (using 8 cores)... [15:14:46|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:46|STATUS ]==|ModuleP3M: End COLA+P3M step 42/74, time_kick:0.378839, time_drift=0.380089. [15:14:46|TIMER ]==|Step 42/74: Density: 0.008 CPU - 0.010 wallclock seconds used. [15:14:46|TIMER ]==|Step 42/74: Potential: 0.009 CPU - 0.029 wallclock seconds used. [15:14:46|TIMER ]==|Step 42/74: Accelerations (long-range): 0.069 CPU - 0.027 wallclock seconds used. [15:14:46|TIMER ]==|Step 42/74: Accelerations (short-range): 0.296 CPU - 0.106 wallclock seconds used. [15:14:46|TIMER ]==|Step 42/74: Kick: 0.007 CPU - 0.004 wallclock seconds used. [15:14:46|TIMER ]==|Step 42/74: Drift: 0.002 CPU - 0.001 wallclock seconds used. [15:14:46|TIMER ]==|Step 42/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:46|TIMER ]==|Step 42/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:46|TIMER ]==|Step 42/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:46|TIMER ]==|Step 42/74: Total Evolution: 0.390 CPU - 0.179 wallclock seconds used. [15:14:46|STATUS ]==|ModuleP3M: Begin COLA+P3M step 43/74, time_kick:0.378839, time_drift=0.380089. [15:14:46|STATUS ]====|ModuleP3M: Compute time step limiters for step 43/74 done. [15:14:46|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:46|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:46|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:46|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:46|STATUS ]====|Kicking particles (using 8 cores)... [15:14:46|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:46|STATUS ]====|Drifting particles (using 8 cores)... [15:14:46|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:46|STATUS ]==|ModuleP3M: End COLA+P3M step 43/74, time_kick:0.397781, time_drift=0.399031. [15:14:46|TIMER ]==|Step 43/74: Density: 0.007 CPU - 0.004 wallclock seconds used. [15:14:46|TIMER ]==|Step 43/74: Potential: 0.008 CPU - 0.007 wallclock seconds used. [15:14:46|TIMER ]==|Step 43/74: Accelerations (long-range): 0.066 CPU - 0.020 wallclock seconds used. [15:14:46|TIMER ]==|Step 43/74: Accelerations (short-range): 0.296 CPU - 0.064 wallclock seconds used. [15:14:46|TIMER ]==|Step 43/74: Kick: 0.008 CPU - 0.004 wallclock seconds used. [15:14:46|TIMER ]==|Step 43/74: Drift: 0.002 CPU - 0.002 wallclock seconds used. [15:14:46|TIMER ]==|Step 43/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:46|TIMER ]==|Step 43/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:46|TIMER ]==|Step 43/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:46|TIMER ]==|Step 43/74: Total Evolution: 0.387 CPU - 0.102 wallclock seconds used. [15:14:46|STATUS ]==|ModuleP3M: Begin COLA+P3M step 44/74, time_kick:0.397781, time_drift=0.399031. [15:14:46|STATUS ]====|ModuleP3M: Compute time step limiters for step 44/74 done. [15:14:46|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:46|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:46|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:46|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:46|STATUS ]====|Kicking particles (using 8 cores)... [15:14:46|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:46|STATUS ]====|Drifting particles (using 8 cores)... [15:14:46|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:46|STATUS ]==|ModuleP3M: End COLA+P3M step 44/74, time_kick:0.417670, time_drift=0.418920. [15:14:46|TIMER ]==|Step 44/74: Density: 0.010 CPU - 0.004 wallclock seconds used. [15:14:46|TIMER ]==|Step 44/74: Potential: 0.011 CPU - 0.005 wallclock seconds used. [15:14:46|TIMER ]==|Step 44/74: Accelerations (long-range): 0.063 CPU - 0.015 wallclock seconds used. [15:14:46|TIMER ]==|Step 44/74: Accelerations (short-range): 0.303 CPU - 0.057 wallclock seconds used. [15:14:46|TIMER ]==|Step 44/74: Kick: 0.006 CPU - 0.002 wallclock seconds used. [15:14:46|TIMER ]==|Step 44/74: Drift: 0.001 CPU - 0.001 wallclock seconds used. [15:14:46|TIMER ]==|Step 44/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:46|TIMER ]==|Step 44/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:46|TIMER ]==|Step 44/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:46|TIMER ]==|Step 44/74: Total Evolution: 0.394 CPU - 0.084 wallclock seconds used. [15:14:46|STATUS ]==|ModuleP3M: Begin COLA+P3M step 45/74, time_kick:0.417670, time_drift=0.418920. [15:14:46|STATUS ]====|ModuleP3M: Compute time step limiters for step 45/74 done. [15:14:46|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:46|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:46|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:46|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:46|STATUS ]====|Kicking particles (using 8 cores)... [15:14:46|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:46|STATUS ]====|Drifting particles (using 8 cores)... [15:14:46|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:46|STATUS ]==|ModuleP3M: End COLA+P3M step 45/74, time_kick:0.437670, time_drift=0.438920. [15:14:46|TIMER ]==|Step 45/74: Density: 0.011 CPU - 0.004 wallclock seconds used. [15:14:46|TIMER ]==|Step 45/74: Potential: 0.009 CPU - 0.004 wallclock seconds used. [15:14:46|TIMER ]==|Step 45/74: Accelerations (long-range): 0.060 CPU - 0.015 wallclock seconds used. [15:14:46|TIMER ]==|Step 45/74: Accelerations (short-range): 0.308 CPU - 0.068 wallclock seconds used. [15:14:46|TIMER ]==|Step 45/74: Kick: 0.006 CPU - 0.002 wallclock seconds used. [15:14:46|TIMER ]==|Step 45/74: Drift: 0.002 CPU - 0.001 wallclock seconds used. [15:14:46|TIMER ]==|Step 45/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:46|TIMER ]==|Step 45/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:46|TIMER ]==|Step 45/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:46|TIMER ]==|Step 45/74: Total Evolution: 0.396 CPU - 0.094 wallclock seconds used. [15:14:46|STATUS ]==|ModuleP3M: Begin COLA+P3M step 46/74, time_kick:0.437670, time_drift=0.438920. [15:14:46|STATUS ]====|ModuleP3M: Compute time step limiters for step 46/74 done. [15:14:46|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:46|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:46|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:46|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:46|STATUS ]====|Kicking particles (using 8 cores)... [15:14:46|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:46|STATUS ]====|Drifting particles (using 8 cores)... [15:14:46|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:46|STATUS ]==|ModuleP3M: End COLA+P3M step 46/74, time_kick:0.457670, time_drift=0.458920. [15:14:46|TIMER ]==|Step 46/74: Density: 0.011 CPU - 0.004 wallclock seconds used. [15:14:46|TIMER ]==|Step 46/74: Potential: 0.012 CPU - 0.007 wallclock seconds used. [15:14:46|TIMER ]==|Step 46/74: Accelerations (long-range): 0.061 CPU - 0.016 wallclock seconds used. [15:14:46|TIMER ]==|Step 46/74: Accelerations (short-range): 0.319 CPU - 0.068 wallclock seconds used. [15:14:46|TIMER ]==|Step 46/74: Kick: 0.007 CPU - 0.003 wallclock seconds used. [15:14:46|TIMER ]==|Step 46/74: Drift: 0.001 CPU - 0.001 wallclock seconds used. [15:14:46|TIMER ]==|Step 46/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:46|TIMER ]==|Step 46/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:46|TIMER ]==|Step 46/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:46|TIMER ]==|Step 46/74: Total Evolution: 0.412 CPU - 0.099 wallclock seconds used. [15:14:46|STATUS ]==|ModuleP3M: Begin COLA+P3M step 47/74, time_kick:0.457670, time_drift=0.458920. [15:14:46|STATUS ]====|ModuleP3M: Compute time step limiters for step 47/74 done. [15:14:46|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:46|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:46|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:46|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:46|STATUS ]====|Kicking particles (using 8 cores)... [15:14:47|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:47|STATUS ]====|Drifting particles (using 8 cores)... [15:14:47|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:47|STATUS ]==|ModuleP3M: End COLA+P3M step 47/74, time_kick:0.477670, time_drift=0.478920. [15:14:47|TIMER ]==|Step 47/74: Density: 0.014 CPU - 0.005 wallclock seconds used. [15:14:47|TIMER ]==|Step 47/74: Potential: 0.008 CPU - 0.003 wallclock seconds used. [15:14:47|TIMER ]==|Step 47/74: Accelerations (long-range): 0.062 CPU - 0.015 wallclock seconds used. [15:14:47|TIMER ]==|Step 47/74: Accelerations (short-range): 0.329 CPU - 0.072 wallclock seconds used. [15:14:47|TIMER ]==|Step 47/74: Kick: 0.006 CPU - 0.002 wallclock seconds used. [15:14:47|TIMER ]==|Step 47/74: Drift: 0.002 CPU - 0.001 wallclock seconds used. [15:14:47|TIMER ]==|Step 47/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:47|TIMER ]==|Step 47/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:47|TIMER ]==|Step 47/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:47|TIMER ]==|Step 47/74: Total Evolution: 0.422 CPU - 0.099 wallclock seconds used. [15:14:47|STATUS ]==|ModuleP3M: Begin COLA+P3M step 48/74, time_kick:0.477670, time_drift=0.478920. [15:14:47|STATUS ]====|ModuleP3M: Compute time step limiters for step 48/74 done. [15:14:47|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:47|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:47|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:47|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:47|STATUS ]====|Kicking particles (using 8 cores)... [15:14:47|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:47|STATUS ]====|Drifting particles (using 8 cores)... [15:14:47|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:47|STATUS ]==|ModuleP3M: End COLA+P3M step 48/74, time_kick:0.497670, time_drift=0.498920. [15:14:47|TIMER ]==|Step 48/74: Density: 0.010 CPU - 0.003 wallclock seconds used. [15:14:47|TIMER ]==|Step 48/74: Potential: 0.010 CPU - 0.005 wallclock seconds used. [15:14:47|TIMER ]==|Step 48/74: Accelerations (long-range): 0.063 CPU - 0.015 wallclock seconds used. [15:14:47|TIMER ]==|Step 48/74: Accelerations (short-range): 0.322 CPU - 0.068 wallclock seconds used. [15:14:47|TIMER ]==|Step 48/74: Kick: 0.006 CPU - 0.002 wallclock seconds used. [15:14:47|TIMER ]==|Step 48/74: Drift: 0.002 CPU - 0.001 wallclock seconds used. [15:14:47|TIMER ]==|Step 48/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:47|TIMER ]==|Step 48/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:47|TIMER ]==|Step 48/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:47|TIMER ]==|Step 48/74: Total Evolution: 0.413 CPU - 0.093 wallclock seconds used. [15:14:47|STATUS ]==|ModuleP3M: Begin COLA+P3M step 49/74, time_kick:0.497670, time_drift=0.498920. [15:14:47|STATUS ]====|ModuleP3M: Compute time step limiters for step 49/74 done. [15:14:47|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:47|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:47|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:47|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:47|STATUS ]====|Kicking particles (using 8 cores)... [15:14:47|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:47|STATUS ]====|Drifting particles (using 8 cores)... [15:14:47|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:47|STATUS ]==|ModuleP3M: End COLA+P3M step 49/74, time_kick:0.517670, time_drift=0.518920. [15:14:47|TIMER ]==|Step 49/74: Density: 0.012 CPU - 0.003 wallclock seconds used. [15:14:47|TIMER ]==|Step 49/74: Potential: 0.010 CPU - 0.004 wallclock seconds used. [15:14:47|TIMER ]==|Step 49/74: Accelerations (long-range): 0.062 CPU - 0.014 wallclock seconds used. [15:14:47|TIMER ]==|Step 49/74: Accelerations (short-range): 0.329 CPU - 0.067 wallclock seconds used. [15:14:47|TIMER ]==|Step 49/74: Kick: 0.006 CPU - 0.002 wallclock seconds used. [15:14:47|TIMER ]==|Step 49/74: Drift: 0.001 CPU - 0.001 wallclock seconds used. [15:14:47|TIMER ]==|Step 49/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:47|TIMER ]==|Step 49/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:47|TIMER ]==|Step 49/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:47|TIMER ]==|Step 49/74: Total Evolution: 0.421 CPU - 0.090 wallclock seconds used. [15:14:47|STATUS ]==|ModuleP3M: Begin COLA+P3M step 50/74, time_kick:0.517670, time_drift=0.518920. [15:14:47|STATUS ]====|ModuleP3M: Compute time step limiters for step 50/74 done. [15:14:47|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:47|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:47|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:47|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:47|STATUS ]====|Kicking particles (using 8 cores)... [15:14:47|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:47|STATUS ]====|Drifting particles (using 8 cores)... [15:14:47|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:47|STATUS ]==|ModuleP3M: End COLA+P3M step 50/74, time_kick:0.537670, time_drift=0.538920. [15:14:47|TIMER ]==|Step 50/74: Density: 0.012 CPU - 0.003 wallclock seconds used. [15:14:47|TIMER ]==|Step 50/74: Potential: 0.009 CPU - 0.006 wallclock seconds used. [15:14:47|TIMER ]==|Step 50/74: Accelerations (long-range): 0.066 CPU - 0.020 wallclock seconds used. [15:14:47|TIMER ]==|Step 50/74: Accelerations (short-range): 0.332 CPU - 0.069 wallclock seconds used. [15:14:47|TIMER ]==|Step 50/74: Kick: 0.006 CPU - 0.002 wallclock seconds used. [15:14:47|TIMER ]==|Step 50/74: Drift: 0.001 CPU - 0.001 wallclock seconds used. [15:14:47|TIMER ]==|Step 50/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:47|TIMER ]==|Step 50/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:47|TIMER ]==|Step 50/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:47|TIMER ]==|Step 50/74: Total Evolution: 0.427 CPU - 0.101 wallclock seconds used. [15:14:47|STATUS ]==|ModuleP3M: Begin COLA+P3M step 51/74, time_kick:0.537670, time_drift=0.538920. [15:14:47|STATUS ]====|ModuleP3M: Compute time step limiters for step 51/74 done. [15:14:47|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:47|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:47|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:47|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:47|STATUS ]====|Kicking particles (using 8 cores)... [15:14:47|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:47|STATUS ]====|Drifting particles (using 8 cores)... [15:14:47|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:47|STATUS ]==|ModuleP3M: End COLA+P3M step 51/74, time_kick:0.557670, time_drift=0.558920. [15:14:47|TIMER ]==|Step 51/74: Density: 0.010 CPU - 0.004 wallclock seconds used. [15:14:47|TIMER ]==|Step 51/74: Potential: 0.011 CPU - 0.004 wallclock seconds used. [15:14:47|TIMER ]==|Step 51/74: Accelerations (long-range): 0.062 CPU - 0.016 wallclock seconds used. [15:14:47|TIMER ]==|Step 51/74: Accelerations (short-range): 0.341 CPU - 0.076 wallclock seconds used. [15:14:47|TIMER ]==|Step 51/74: Kick: 0.006 CPU - 0.002 wallclock seconds used. [15:14:47|TIMER ]==|Step 51/74: Drift: 0.002 CPU - 0.001 wallclock seconds used. [15:14:47|TIMER ]==|Step 51/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:47|TIMER ]==|Step 51/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:47|TIMER ]==|Step 51/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:47|TIMER ]==|Step 51/74: Total Evolution: 0.433 CPU - 0.104 wallclock seconds used. [15:14:47|STATUS ]==|ModuleP3M: Begin COLA+P3M step 52/74, time_kick:0.557670, time_drift=0.558920. [15:14:47|STATUS ]====|ModuleP3M: Compute time step limiters for step 52/74 done. [15:14:47|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:47|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:47|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:47|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:47|STATUS ]====|Kicking particles (using 8 cores)... [15:14:47|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:47|STATUS ]====|Drifting particles (using 8 cores)... [15:14:47|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:47|STATUS ]==|ModuleP3M: End COLA+P3M step 52/74, time_kick:0.577670, time_drift=0.578920. [15:14:47|TIMER ]==|Step 52/74: Density: 0.010 CPU - 0.003 wallclock seconds used. [15:14:47|TIMER ]==|Step 52/74: Potential: 0.011 CPU - 0.004 wallclock seconds used. [15:14:47|TIMER ]==|Step 52/74: Accelerations (long-range): 0.064 CPU - 0.022 wallclock seconds used. [15:14:47|TIMER ]==|Step 52/74: Accelerations (short-range): 0.342 CPU - 0.078 wallclock seconds used. [15:14:47|TIMER ]==|Step 52/74: Kick: 0.006 CPU - 0.003 wallclock seconds used. [15:14:47|TIMER ]==|Step 52/74: Drift: 0.001 CPU - 0.001 wallclock seconds used. [15:14:47|TIMER ]==|Step 52/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:47|TIMER ]==|Step 52/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:47|TIMER ]==|Step 52/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:47|TIMER ]==|Step 52/74: Total Evolution: 0.433 CPU - 0.111 wallclock seconds used. [15:14:47|STATUS ]==|ModuleP3M: Begin COLA+P3M step 53/74, time_kick:0.577670, time_drift=0.578920. [15:14:47|STATUS ]====|ModuleP3M: Compute time step limiters for step 53/74 done. [15:14:47|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:47|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:47|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:47|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:47|STATUS ]====|Kicking particles (using 8 cores)... [15:14:47|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:47|STATUS ]====|Drifting particles (using 8 cores)... [15:14:47|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:47|STATUS ]==|ModuleP3M: End COLA+P3M step 53/74, time_kick:0.597670, time_drift=0.598920. [15:14:47|TIMER ]==|Step 53/74: Density: 0.012 CPU - 0.003 wallclock seconds used. [15:14:47|TIMER ]==|Step 53/74: Potential: 0.008 CPU - 0.004 wallclock seconds used. [15:14:47|TIMER ]==|Step 53/74: Accelerations (long-range): 0.064 CPU - 0.018 wallclock seconds used. [15:14:47|TIMER ]==|Step 53/74: Accelerations (short-range): 0.346 CPU - 0.077 wallclock seconds used. [15:14:47|TIMER ]==|Step 53/74: Kick: 0.006 CPU - 0.002 wallclock seconds used. [15:14:47|TIMER ]==|Step 53/74: Drift: 0.002 CPU - 0.001 wallclock seconds used. [15:14:47|TIMER ]==|Step 53/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:47|TIMER ]==|Step 53/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:47|TIMER ]==|Step 53/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:47|TIMER ]==|Step 53/74: Total Evolution: 0.438 CPU - 0.105 wallclock seconds used. [15:14:47|STATUS ]==|ModuleP3M: Begin COLA+P3M step 54/74, time_kick:0.597670, time_drift=0.598920. [15:14:47|STATUS ]====|ModuleP3M: Compute time step limiters for step 54/74 done. [15:14:47|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:47|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:47|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:47|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:47|STATUS ]====|Kicking particles (using 8 cores)... [15:14:47|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:47|STATUS ]====|Drifting particles (using 8 cores)... [15:14:47|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:47|STATUS ]==|ModuleP3M: End COLA+P3M step 54/74, time_kick:0.617670, time_drift=0.618920. [15:14:47|TIMER ]==|Step 54/74: Density: 0.016 CPU - 0.003 wallclock seconds used. [15:14:47|TIMER ]==|Step 54/74: Potential: 0.008 CPU - 0.003 wallclock seconds used. [15:14:47|TIMER ]==|Step 54/74: Accelerations (long-range): 0.062 CPU - 0.017 wallclock seconds used. [15:14:47|TIMER ]==|Step 54/74: Accelerations (short-range): 0.356 CPU - 0.081 wallclock seconds used. [15:14:47|TIMER ]==|Step 54/74: Kick: 0.007 CPU - 0.002 wallclock seconds used. [15:14:47|TIMER ]==|Step 54/74: Drift: 0.002 CPU - 0.001 wallclock seconds used. [15:14:47|TIMER ]==|Step 54/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:47|TIMER ]==|Step 54/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:47|TIMER ]==|Step 54/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:47|TIMER ]==|Step 54/74: Total Evolution: 0.451 CPU - 0.107 wallclock seconds used. [15:14:47|STATUS ]==|ModuleP3M: Begin COLA+P3M step 55/74, time_kick:0.617670, time_drift=0.618920. [15:14:47|STATUS ]====|ModuleP3M: Compute time step limiters for step 55/74 done. [15:14:47|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:47|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:47|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:47|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:47|STATUS ]====|Kicking particles (using 8 cores)... [15:14:48|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:48|STATUS ]====|Drifting particles (using 8 cores)... [15:14:48|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:48|STATUS ]==|ModuleP3M: End COLA+P3M step 55/74, time_kick:0.637670, time_drift=0.638920. [15:14:48|TIMER ]==|Step 55/74: Density: 0.015 CPU - 0.003 wallclock seconds used. [15:14:48|TIMER ]==|Step 55/74: Potential: 0.009 CPU - 0.003 wallclock seconds used. [15:14:48|TIMER ]==|Step 55/74: Accelerations (long-range): 0.062 CPU - 0.014 wallclock seconds used. [15:14:48|TIMER ]==|Step 55/74: Accelerations (short-range): 0.355 CPU - 0.074 wallclock seconds used. [15:14:48|TIMER ]==|Step 55/74: Kick: 0.006 CPU - 0.001 wallclock seconds used. [15:14:48|TIMER ]==|Step 55/74: Drift: 0.001 CPU - 0.001 wallclock seconds used. [15:14:48|TIMER ]==|Step 55/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:48|TIMER ]==|Step 55/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:48|TIMER ]==|Step 55/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:48|TIMER ]==|Step 55/74: Total Evolution: 0.448 CPU - 0.096 wallclock seconds used. [15:14:48|STATUS ]==|ModuleP3M: Begin COLA+P3M step 56/74, time_kick:0.637670, time_drift=0.638920. [15:14:48|STATUS ]====|ModuleP3M: Compute time step limiters for step 56/74 done. [15:14:48|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:48|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:48|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:48|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:48|STATUS ]====|Kicking particles (using 8 cores)... [15:14:48|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:48|STATUS ]====|Drifting particles (using 8 cores)... [15:14:48|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:48|STATUS ]==|ModuleP3M: End COLA+P3M step 56/74, time_kick:0.657670, time_drift=0.658920. [15:14:48|TIMER ]==|Step 56/74: Density: 0.012 CPU - 0.003 wallclock seconds used. [15:14:48|TIMER ]==|Step 56/74: Potential: 0.008 CPU - 0.003 wallclock seconds used. [15:14:48|TIMER ]==|Step 56/74: Accelerations (long-range): 0.063 CPU - 0.015 wallclock seconds used. [15:14:48|TIMER ]==|Step 56/74: Accelerations (short-range): 0.370 CPU - 0.076 wallclock seconds used. [15:14:48|TIMER ]==|Step 56/74: Kick: 0.006 CPU - 0.002 wallclock seconds used. [15:14:48|TIMER ]==|Step 56/74: Drift: 0.002 CPU - 0.001 wallclock seconds used. [15:14:48|TIMER ]==|Step 56/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:48|TIMER ]==|Step 56/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:48|TIMER ]==|Step 56/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:48|TIMER ]==|Step 56/74: Total Evolution: 0.462 CPU - 0.099 wallclock seconds used. [15:14:48|STATUS ]==|ModuleP3M: Begin COLA+P3M step 57/74, time_kick:0.657670, time_drift=0.658920. [15:14:48|STATUS ]====|ModuleP3M: Compute time step limiters for step 57/74 done. [15:14:48|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:48|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:48|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:48|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:48|STATUS ]====|Kicking particles (using 8 cores)... [15:14:48|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:48|STATUS ]====|Drifting particles (using 8 cores)... [15:14:48|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:48|STATUS ]==|ModuleP3M: End COLA+P3M step 57/74, time_kick:0.677670, time_drift=0.678920. [15:14:48|TIMER ]==|Step 57/74: Density: 0.017 CPU - 0.003 wallclock seconds used. [15:14:48|TIMER ]==|Step 57/74: Potential: 0.008 CPU - 0.003 wallclock seconds used. [15:14:48|TIMER ]==|Step 57/74: Accelerations (long-range): 0.060 CPU - 0.014 wallclock seconds used. [15:14:48|TIMER ]==|Step 57/74: Accelerations (short-range): 0.376 CPU - 0.135 wallclock seconds used. [15:14:48|TIMER ]==|Step 57/74: Kick: 0.006 CPU - 0.001 wallclock seconds used. [15:14:48|TIMER ]==|Step 57/74: Drift: 0.001 CPU - 0.001 wallclock seconds used. [15:14:48|TIMER ]==|Step 57/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:48|TIMER ]==|Step 57/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:48|TIMER ]==|Step 57/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:48|TIMER ]==|Step 57/74: Total Evolution: 0.469 CPU - 0.157 wallclock seconds used. [15:14:48|STATUS ]==|ModuleP3M: Begin COLA+P3M step 58/74, time_kick:0.677670, time_drift=0.678920. [15:14:48|STATUS ]====|ModuleP3M: Compute time step limiters for step 58/74 done. [15:14:48|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:48|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:48|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:48|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:48|STATUS ]====|Kicking particles (using 8 cores)... [15:14:48|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:48|STATUS ]====|Drifting particles (using 8 cores)... [15:14:48|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:48|STATUS ]==|ModuleP3M: End COLA+P3M step 58/74, time_kick:0.697670, time_drift=0.698920. [15:14:48|TIMER ]==|Step 58/74: Density: 0.011 CPU - 0.004 wallclock seconds used. [15:14:48|TIMER ]==|Step 58/74: Potential: 0.010 CPU - 0.003 wallclock seconds used. [15:14:48|TIMER ]==|Step 58/74: Accelerations (long-range): 0.063 CPU - 0.014 wallclock seconds used. [15:14:48|TIMER ]==|Step 58/74: Accelerations (short-range): 0.367 CPU - 0.089 wallclock seconds used. [15:14:48|TIMER ]==|Step 58/74: Kick: 0.006 CPU - 0.002 wallclock seconds used. [15:14:48|TIMER ]==|Step 58/74: Drift: 0.003 CPU - 0.001 wallclock seconds used. [15:14:48|TIMER ]==|Step 58/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:48|TIMER ]==|Step 58/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:48|TIMER ]==|Step 58/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:48|TIMER ]==|Step 58/74: Total Evolution: 0.460 CPU - 0.113 wallclock seconds used. [15:14:48|STATUS ]==|ModuleP3M: Begin COLA+P3M step 59/74, time_kick:0.697670, time_drift=0.698920. [15:14:48|STATUS ]====|ModuleP3M: Compute time step limiters for step 59/74 done. [15:14:48|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:48|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:48|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:48|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:48|STATUS ]====|Kicking particles (using 8 cores)... [15:14:48|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:48|STATUS ]====|Drifting particles (using 8 cores)... [15:14:48|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:48|STATUS ]==|ModuleP3M: End COLA+P3M step 59/74, time_kick:0.717670, time_drift=0.718920. [15:14:48|TIMER ]==|Step 59/74: Density: 0.010 CPU - 0.003 wallclock seconds used. [15:14:48|TIMER ]==|Step 59/74: Potential: 0.010 CPU - 0.004 wallclock seconds used. [15:14:48|TIMER ]==|Step 59/74: Accelerations (long-range): 0.061 CPU - 0.015 wallclock seconds used. [15:14:48|TIMER ]==|Step 59/74: Accelerations (short-range): 0.385 CPU - 0.088 wallclock seconds used. [15:14:48|TIMER ]==|Step 59/74: Kick: 0.006 CPU - 0.002 wallclock seconds used. [15:14:48|TIMER ]==|Step 59/74: Drift: 0.002 CPU - 0.001 wallclock seconds used. [15:14:48|TIMER ]==|Step 59/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:48|TIMER ]==|Step 59/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:48|TIMER ]==|Step 59/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:48|TIMER ]==|Step 59/74: Total Evolution: 0.474 CPU - 0.111 wallclock seconds used. [15:14:48|STATUS ]==|ModuleP3M: Begin COLA+P3M step 60/74, time_kick:0.717670, time_drift=0.718920. [15:14:48|STATUS ]====|ModuleP3M: Compute time step limiters for step 60/74 done. [15:14:48|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:48|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:48|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:48|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:48|STATUS ]====|Kicking particles (using 8 cores)... [15:14:48|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:48|STATUS ]====|Drifting particles (using 8 cores)... [15:14:48|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:48|STATUS ]==|ModuleP3M: End COLA+P3M step 60/74, time_kick:0.737670, time_drift=0.738920. [15:14:48|TIMER ]==|Step 60/74: Density: 0.011 CPU - 0.003 wallclock seconds used. [15:14:48|TIMER ]==|Step 60/74: Potential: 0.009 CPU - 0.003 wallclock seconds used. [15:14:48|TIMER ]==|Step 60/74: Accelerations (long-range): 0.060 CPU - 0.014 wallclock seconds used. [15:14:48|TIMER ]==|Step 60/74: Accelerations (short-range): 0.392 CPU - 0.096 wallclock seconds used. [15:14:48|TIMER ]==|Step 60/74: Kick: 0.006 CPU - 0.002 wallclock seconds used. [15:14:48|TIMER ]==|Step 60/74: Drift: 0.001 CPU - 0.001 wallclock seconds used. [15:14:48|TIMER ]==|Step 60/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:48|TIMER ]==|Step 60/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:48|TIMER ]==|Step 60/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:48|TIMER ]==|Step 60/74: Total Evolution: 0.479 CPU - 0.117 wallclock seconds used. [15:14:48|STATUS ]==|ModuleP3M: Begin COLA+P3M step 61/74, time_kick:0.737670, time_drift=0.738920. [15:14:48|STATUS ]====|ModuleP3M: Compute time step limiters for step 61/74 done. [15:14:48|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:48|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:48|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:48|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:48|STATUS ]====|Kicking particles (using 8 cores)... [15:14:48|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:48|STATUS ]====|Drifting particles (using 8 cores)... [15:14:48|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:48|STATUS ]==|ModuleP3M: End COLA+P3M step 61/74, time_kick:0.757670, time_drift=0.758920. [15:14:48|TIMER ]==|Step 61/74: Density: 0.008 CPU - 0.003 wallclock seconds used. [15:14:48|TIMER ]==|Step 61/74: Potential: 0.012 CPU - 0.004 wallclock seconds used. [15:14:48|TIMER ]==|Step 61/74: Accelerations (long-range): 0.062 CPU - 0.013 wallclock seconds used. [15:14:48|TIMER ]==|Step 61/74: Accelerations (short-range): 0.416 CPU - 0.120 wallclock seconds used. [15:14:48|TIMER ]==|Step 61/74: Kick: 0.006 CPU - 0.001 wallclock seconds used. [15:14:48|TIMER ]==|Step 61/74: Drift: 0.002 CPU - 0.001 wallclock seconds used. [15:14:48|TIMER ]==|Step 61/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:48|TIMER ]==|Step 61/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:48|TIMER ]==|Step 61/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:48|TIMER ]==|Step 61/74: Total Evolution: 0.505 CPU - 0.142 wallclock seconds used. [15:14:48|STATUS ]==|ModuleP3M: Begin COLA+P3M step 62/74, time_kick:0.757670, time_drift=0.758920. [15:14:49|STATUS ]====|ModuleP3M: Compute time step limiters for step 62/74 done. [15:14:49|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:49|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:49|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:49|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:49|STATUS ]====|Kicking particles (using 8 cores)... [15:14:49|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:49|STATUS ]====|Drifting particles (using 8 cores)... [15:14:49|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:49|STATUS ]==|ModuleP3M: End COLA+P3M step 62/74, time_kick:0.777670, time_drift=0.778920. [15:14:49|TIMER ]==|Step 62/74: Density: 0.011 CPU - 0.003 wallclock seconds used. [15:14:49|TIMER ]==|Step 62/74: Potential: 0.008 CPU - 0.003 wallclock seconds used. [15:14:49|TIMER ]==|Step 62/74: Accelerations (long-range): 0.062 CPU - 0.013 wallclock seconds used. [15:14:49|TIMER ]==|Step 62/74: Accelerations (short-range): 0.403 CPU - 0.089 wallclock seconds used. [15:14:49|TIMER ]==|Step 62/74: Kick: 0.006 CPU - 0.001 wallclock seconds used. [15:14:49|TIMER ]==|Step 62/74: Drift: 0.001 CPU - 0.001 wallclock seconds used. [15:14:49|TIMER ]==|Step 62/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:49|TIMER ]==|Step 62/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:49|TIMER ]==|Step 62/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:49|TIMER ]==|Step 62/74: Total Evolution: 0.491 CPU - 0.109 wallclock seconds used. [15:14:49|STATUS ]==|ModuleP3M: Begin COLA+P3M step 63/74, time_kick:0.777670, time_drift=0.778920. [15:14:49|STATUS ]====|ModuleP3M: Compute time step limiters for step 63/74 done. [15:14:49|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:49|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:49|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:49|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:49|STATUS ]====|Kicking particles (using 8 cores)... [15:14:49|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:49|STATUS ]====|Drifting particles (using 8 cores)... [15:14:49|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:49|STATUS ]==|ModuleP3M: End COLA+P3M step 63/74, time_kick:0.797670, time_drift=0.798920. [15:14:49|TIMER ]==|Step 63/74: Density: 0.012 CPU - 0.003 wallclock seconds used. [15:14:49|TIMER ]==|Step 63/74: Potential: 0.009 CPU - 0.002 wallclock seconds used. [15:14:49|TIMER ]==|Step 63/74: Accelerations (long-range): 0.067 CPU - 0.019 wallclock seconds used. [15:14:49|TIMER ]==|Step 63/74: Accelerations (short-range): 0.422 CPU - 0.124 wallclock seconds used. [15:14:49|TIMER ]==|Step 63/74: Kick: 0.006 CPU - 0.002 wallclock seconds used. [15:14:49|TIMER ]==|Step 63/74: Drift: 0.002 CPU - 0.001 wallclock seconds used. [15:14:49|TIMER ]==|Step 63/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:49|TIMER ]==|Step 63/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:49|TIMER ]==|Step 63/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:49|TIMER ]==|Step 63/74: Total Evolution: 0.517 CPU - 0.151 wallclock seconds used. [15:14:49|STATUS ]==|ModuleP3M: Begin COLA+P3M step 64/74, time_kick:0.797670, time_drift=0.798920. [15:14:49|STATUS ]====|ModuleP3M: Compute time step limiters for step 64/74 done. [15:14:49|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:49|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:49|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:49|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:49|STATUS ]====|Kicking particles (using 8 cores)... [15:14:49|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:49|STATUS ]====|Drifting particles (using 8 cores)... [15:14:49|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:49|STATUS ]==|ModuleP3M: End COLA+P3M step 64/74, time_kick:0.817670, time_drift=0.818920. [15:14:49|TIMER ]==|Step 64/74: Density: 0.009 CPU - 0.003 wallclock seconds used. [15:14:49|TIMER ]==|Step 64/74: Potential: 0.008 CPU - 0.003 wallclock seconds used. [15:14:49|TIMER ]==|Step 64/74: Accelerations (long-range): 0.065 CPU - 0.017 wallclock seconds used. [15:14:49|TIMER ]==|Step 64/74: Accelerations (short-range): 0.423 CPU - 0.126 wallclock seconds used. [15:14:49|TIMER ]==|Step 64/74: Kick: 0.006 CPU - 0.002 wallclock seconds used. [15:14:49|TIMER ]==|Step 64/74: Drift: 0.002 CPU - 0.001 wallclock seconds used. [15:14:49|TIMER ]==|Step 64/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:49|TIMER ]==|Step 64/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:49|TIMER ]==|Step 64/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:49|TIMER ]==|Step 64/74: Total Evolution: 0.514 CPU - 0.151 wallclock seconds used. [15:14:49|STATUS ]==|ModuleP3M: Begin COLA+P3M step 65/74, time_kick:0.817670, time_drift=0.818920. [15:14:49|STATUS ]====|ModuleP3M: Compute time step limiters for step 65/74 done. [15:14:49|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:49|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:49|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:49|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:49|STATUS ]====|Kicking particles (using 8 cores)... [15:14:49|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:49|STATUS ]====|Drifting particles (using 8 cores)... [15:14:49|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:49|STATUS ]==|ModuleP3M: End COLA+P3M step 65/74, time_kick:0.837670, time_drift=0.838920. [15:14:49|TIMER ]==|Step 65/74: Density: 0.013 CPU - 0.004 wallclock seconds used. [15:14:49|TIMER ]==|Step 65/74: Potential: 0.010 CPU - 0.006 wallclock seconds used. [15:14:49|TIMER ]==|Step 65/74: Accelerations (long-range): 0.067 CPU - 0.018 wallclock seconds used. [15:14:49|TIMER ]==|Step 65/74: Accelerations (short-range): 0.429 CPU - 0.121 wallclock seconds used. [15:14:49|TIMER ]==|Step 65/74: Kick: 0.006 CPU - 0.002 wallclock seconds used. [15:14:49|TIMER ]==|Step 65/74: Drift: 0.002 CPU - 0.001 wallclock seconds used. [15:14:49|TIMER ]==|Step 65/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:49|TIMER ]==|Step 65/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:49|TIMER ]==|Step 65/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:49|TIMER ]==|Step 65/74: Total Evolution: 0.528 CPU - 0.152 wallclock seconds used. [15:14:49|STATUS ]==|ModuleP3M: Begin COLA+P3M step 66/74, time_kick:0.837670, time_drift=0.838920. [15:14:49|STATUS ]====|ModuleP3M: Compute time step limiters for step 66/74 done. [15:14:49|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:49|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:49|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:49|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:49|STATUS ]====|Kicking particles (using 8 cores)... [15:14:49|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:49|STATUS ]====|Drifting particles (using 8 cores)... [15:14:49|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:49|STATUS ]==|ModuleP3M: End COLA+P3M step 66/74, time_kick:0.857670, time_drift=0.858920. [15:14:49|TIMER ]==|Step 66/74: Density: 0.013 CPU - 0.003 wallclock seconds used. [15:14:49|TIMER ]==|Step 66/74: Potential: 0.009 CPU - 0.003 wallclock seconds used. [15:14:49|TIMER ]==|Step 66/74: Accelerations (long-range): 0.063 CPU - 0.019 wallclock seconds used. [15:14:49|TIMER ]==|Step 66/74: Accelerations (short-range): 0.442 CPU - 0.139 wallclock seconds used. [15:14:49|TIMER ]==|Step 66/74: Kick: 0.006 CPU - 0.002 wallclock seconds used. [15:14:49|TIMER ]==|Step 66/74: Drift: 0.002 CPU - 0.001 wallclock seconds used. [15:14:49|TIMER ]==|Step 66/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:49|TIMER ]==|Step 66/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:49|TIMER ]==|Step 66/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:49|TIMER ]==|Step 66/74: Total Evolution: 0.536 CPU - 0.167 wallclock seconds used. [15:14:49|STATUS ]==|ModuleP3M: Begin COLA+P3M step 67/74, time_kick:0.857670, time_drift=0.858920. [15:14:49|STATUS ]====|ModuleP3M: Compute time step limiters for step 67/74 done. [15:14:49|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:49|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:49|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:49|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:49|STATUS ]====|Kicking particles (using 8 cores)... [15:14:50|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:50|STATUS ]====|Drifting particles (using 8 cores)... [15:14:50|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:50|STATUS ]==|ModuleP3M: End COLA+P3M step 67/74, time_kick:0.877670, time_drift=0.878920. [15:14:50|TIMER ]==|Step 67/74: Density: 0.014 CPU - 0.003 wallclock seconds used. [15:14:50|TIMER ]==|Step 67/74: Potential: 0.009 CPU - 0.003 wallclock seconds used. [15:14:50|TIMER ]==|Step 67/74: Accelerations (long-range): 0.061 CPU - 0.015 wallclock seconds used. [15:14:50|TIMER ]==|Step 67/74: Accelerations (short-range): 0.435 CPU - 0.201 wallclock seconds used. [15:14:50|TIMER ]==|Step 67/74: Kick: 0.006 CPU - 0.001 wallclock seconds used. [15:14:50|TIMER ]==|Step 67/74: Drift: 0.001 CPU - 0.000 wallclock seconds used. [15:14:50|TIMER ]==|Step 67/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:50|TIMER ]==|Step 67/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:50|TIMER ]==|Step 67/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:50|TIMER ]==|Step 67/74: Total Evolution: 0.527 CPU - 0.224 wallclock seconds used. [15:14:50|STATUS ]==|ModuleP3M: Begin COLA+P3M step 68/74, time_kick:0.877670, time_drift=0.878920. [15:14:50|STATUS ]====|ModuleP3M: Compute time step limiters for step 68/74 done. [15:14:50|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:50|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:50|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:50|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:50|STATUS ]====|ModuleP3M: Writing gravitational potential to /Users/hoellinger/WIP3M/notebook12/gravpot/gp_nforce67.h5. [15:14:50|STATUS ]====|Writing field to '/Users/hoellinger/WIP3M/notebook12/gravpot/gp_nforce67.h5'... [15:14:50|STATUS ]====|Writing field to '/Users/hoellinger/WIP3M/notebook12/gravpot/gp_nforce67.h5' done. [15:14:50|STATUS ]====|Kicking particles (using 8 cores)... [15:14:50|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:50|STATUS ]====|Drifting particles (using 8 cores)... [15:14:50|STATUS ]======|Writing field to '/Users/hoellinger/WIP3M/notebook12/p_res/p67.h5'... [15:14:50|STATUS ]======|Writing field to '/Users/hoellinger/WIP3M/notebook12/p_res/p67.h5' done. [15:14:50|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:50|STATUS ]==|ModuleP3M: End COLA+P3M step 68/74, time_kick:0.897670, time_drift=0.898920. [15:14:50|TIMER ]==|Step 68/74: Density: 0.009 CPU - 0.003 wallclock seconds used. [15:14:50|TIMER ]==|Step 68/74: Potential: 0.008 CPU - 0.003 wallclock seconds used. [15:14:50|TIMER ]==|Step 68/74: Accelerations (long-range): 0.058 CPU - 0.016 wallclock seconds used. [15:14:50|TIMER ]==|Step 68/74: Accelerations (short-range): 0.446 CPU - 0.129 wallclock seconds used. [15:14:50|TIMER ]==|Step 68/74: Kick: 0.006 CPU - 0.002 wallclock seconds used. [15:14:50|TIMER ]==|Step 68/74: Drift: 0.002 CPU - 0.001 wallclock seconds used. [15:14:50|TIMER ]==|Step 68/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:50|TIMER ]==|Step 68/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:50|TIMER ]==|Step 68/74: Outputs: 0.001 CPU - 0.001 wallclock seconds used. [15:14:50|TIMER ]==|Step 68/74: Total Evolution: 0.531 CPU - 0.155 wallclock seconds used. [15:14:50|STATUS ]==|ModuleP3M: Begin COLA+P3M step 69/74, time_kick:0.897670, time_drift=0.898920. [15:14:50|STATUS ]====|ModuleP3M: Compute time step limiters for step 69/74 done. [15:14:50|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:50|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:50|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:50|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:50|STATUS ]====|Kicking particles (using 8 cores)... [15:14:50|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:50|STATUS ]====|Drifting particles (using 8 cores)... [15:14:50|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:50|STATUS ]==|ModuleP3M: End COLA+P3M step 69/74, time_kick:0.917670, time_drift=0.918920. [15:14:50|TIMER ]==|Step 69/74: Density: 0.011 CPU - 0.003 wallclock seconds used. [15:14:50|TIMER ]==|Step 69/74: Potential: 0.009 CPU - 0.004 wallclock seconds used. [15:14:50|TIMER ]==|Step 69/74: Accelerations (long-range): 0.062 CPU - 0.014 wallclock seconds used. [15:14:50|TIMER ]==|Step 69/74: Accelerations (short-range): 0.446 CPU - 0.172 wallclock seconds used. [15:14:50|TIMER ]==|Step 69/74: Kick: 0.006 CPU - 0.001 wallclock seconds used. [15:14:50|TIMER ]==|Step 69/74: Drift: 0.002 CPU - 0.001 wallclock seconds used. [15:14:50|TIMER ]==|Step 69/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:50|TIMER ]==|Step 69/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:50|TIMER ]==|Step 69/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:50|TIMER ]==|Step 69/74: Total Evolution: 0.535 CPU - 0.195 wallclock seconds used. [15:14:50|STATUS ]==|ModuleP3M: Begin COLA+P3M step 70/74, time_kick:0.917670, time_drift=0.918920. [15:14:50|STATUS ]====|ModuleP3M: Compute time step limiters for step 70/74 done. [15:14:50|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:50|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:50|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:50|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:50|STATUS ]====|Kicking particles (using 8 cores)... [15:14:50|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:50|STATUS ]====|Drifting particles (using 8 cores)... [15:14:50|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:50|STATUS ]==|ModuleP3M: End COLA+P3M step 70/74, time_kick:0.937670, time_drift=0.938920. [15:14:50|TIMER ]==|Step 70/74: Density: 0.016 CPU - 0.003 wallclock seconds used. [15:14:50|TIMER ]==|Step 70/74: Potential: 0.009 CPU - 0.003 wallclock seconds used. [15:14:50|TIMER ]==|Step 70/74: Accelerations (long-range): 0.068 CPU - 0.020 wallclock seconds used. [15:14:50|TIMER ]==|Step 70/74: Accelerations (short-range): 0.457 CPU - 0.135 wallclock seconds used. [15:14:50|TIMER ]==|Step 70/74: Kick: 0.006 CPU - 0.002 wallclock seconds used. [15:14:50|TIMER ]==|Step 70/74: Drift: 0.002 CPU - 0.001 wallclock seconds used. [15:14:50|TIMER ]==|Step 70/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:50|TIMER ]==|Step 70/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:50|TIMER ]==|Step 70/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:50|TIMER ]==|Step 70/74: Total Evolution: 0.558 CPU - 0.164 wallclock seconds used. [15:14:50|STATUS ]==|ModuleP3M: Begin COLA+P3M step 71/74, time_kick:0.937670, time_drift=0.938920. [15:14:50|STATUS ]====|ModuleP3M: Compute time step limiters for step 71/74 done. [15:14:50|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:50|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:50|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:50|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:50|STATUS ]====|Kicking particles (using 8 cores)... [15:14:50|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:50|STATUS ]====|Drifting particles (using 8 cores)... [15:14:50|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:50|STATUS ]==|ModuleP3M: End COLA+P3M step 71/74, time_kick:0.957670, time_drift=0.958920. [15:14:50|TIMER ]==|Step 71/74: Density: 0.014 CPU - 0.003 wallclock seconds used. [15:14:50|TIMER ]==|Step 71/74: Potential: 0.009 CPU - 0.003 wallclock seconds used. [15:14:50|TIMER ]==|Step 71/74: Accelerations (long-range): 0.066 CPU - 0.016 wallclock seconds used. [15:14:50|TIMER ]==|Step 71/74: Accelerations (short-range): 0.459 CPU - 0.143 wallclock seconds used. [15:14:50|TIMER ]==|Step 71/74: Kick: 0.006 CPU - 0.002 wallclock seconds used. [15:14:50|TIMER ]==|Step 71/74: Drift: 0.002 CPU - 0.001 wallclock seconds used. [15:14:50|TIMER ]==|Step 71/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:50|TIMER ]==|Step 71/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:50|TIMER ]==|Step 71/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:50|TIMER ]==|Step 71/74: Total Evolution: 0.556 CPU - 0.168 wallclock seconds used. [15:14:50|STATUS ]==|ModuleP3M: Begin COLA+P3M step 72/74, time_kick:0.957670, time_drift=0.958920. [15:14:51|STATUS ]====|ModuleP3M: Compute time step limiters for step 72/74 done. [15:14:51|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:51|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:51|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:51|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:51|STATUS ]====|Kicking particles (using 8 cores)... [15:14:51|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:51|STATUS ]====|Drifting particles (using 8 cores)... [15:14:51|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:51|STATUS ]==|ModuleP3M: End COLA+P3M step 72/74, time_kick:0.977670, time_drift=0.978920. [15:14:51|TIMER ]==|Step 72/74: Density: 0.014 CPU - 0.004 wallclock seconds used. [15:14:51|TIMER ]==|Step 72/74: Potential: 0.009 CPU - 0.003 wallclock seconds used. [15:14:51|TIMER ]==|Step 72/74: Accelerations (long-range): 0.067 CPU - 0.017 wallclock seconds used. [15:14:51|TIMER ]==|Step 72/74: Accelerations (short-range): 0.469 CPU - 0.147 wallclock seconds used. [15:14:51|TIMER ]==|Step 72/74: Kick: 0.006 CPU - 0.002 wallclock seconds used. [15:14:51|TIMER ]==|Step 72/74: Drift: 0.002 CPU - 0.001 wallclock seconds used. [15:14:51|TIMER ]==|Step 72/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:51|TIMER ]==|Step 72/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:51|TIMER ]==|Step 72/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:51|TIMER ]==|Step 72/74: Total Evolution: 0.568 CPU - 0.174 wallclock seconds used. [15:14:51|STATUS ]==|ModuleP3M: Begin COLA+P3M step 73/74, time_kick:0.977670, time_drift=0.978920. [15:14:51|STATUS ]====|ModuleP3M: Compute time step limiters for step 73/74 done. [15:14:51|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:51|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:51|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:51|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:51|STATUS ]====|ModuleP3M: Writing gravitational potential to /Users/hoellinger/WIP3M/notebook12/gravpot/gp_nforce72.h5. [15:14:51|STATUS ]====|Writing field to '/Users/hoellinger/WIP3M/notebook12/gravpot/gp_nforce72.h5'... [15:14:51|STATUS ]====|Writing field to '/Users/hoellinger/WIP3M/notebook12/gravpot/gp_nforce72.h5' done. [15:14:51|STATUS ]====|Kicking particles (using 8 cores)... [15:14:51|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:51|STATUS ]====|Drifting particles (using 8 cores)... [15:14:51|STATUS ]======|Writing field to '/Users/hoellinger/WIP3M/notebook12/p_res/p72.h5'... [15:14:51|STATUS ]======|Writing field to '/Users/hoellinger/WIP3M/notebook12/p_res/p72.h5' done. [15:14:51|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:51|STATUS ]==|ModuleP3M: End COLA+P3M step 73/74, time_kick:0.997670, time_drift=0.998920. [15:14:51|TIMER ]==|Step 73/74: Density: 0.014 CPU - 0.003 wallclock seconds used. [15:14:51|TIMER ]==|Step 73/74: Potential: 0.009 CPU - 0.003 wallclock seconds used. [15:14:51|TIMER ]==|Step 73/74: Accelerations (long-range): 0.064 CPU - 0.019 wallclock seconds used. [15:14:51|TIMER ]==|Step 73/74: Accelerations (short-range): 0.477 CPU - 0.137 wallclock seconds used. [15:14:51|TIMER ]==|Step 73/74: Kick: 0.007 CPU - 0.002 wallclock seconds used. [15:14:51|TIMER ]==|Step 73/74: Drift: 0.002 CPU - 0.001 wallclock seconds used. [15:14:51|TIMER ]==|Step 73/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:51|TIMER ]==|Step 73/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:51|TIMER ]==|Step 73/74: Outputs: 0.001 CPU - 0.001 wallclock seconds used. [15:14:51|TIMER ]==|Step 73/74: Total Evolution: 0.574 CPU - 0.167 wallclock seconds used. [15:14:51|STATUS ]==|ModuleP3M: Begin COLA+P3M step 74/74, time_kick:0.997670, time_drift=0.998920. [15:14:51|STATUS ]====|ModuleP3M: Compute time step limiters for step 74/74 done. [15:14:51|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:51|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:51|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:51|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:51|STATUS ]====|Kicking particles (using 8 cores)... [15:14:51|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:51|STATUS ]====|Drifting particles (using 8 cores)... [15:14:51|STATUS ]====|Drifting particles (using 8 cores) done. [15:14:51|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:51|STATUS ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:51|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)... [15:14:51|STATUS ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done. [15:14:51|STATUS ]====|Kicking particles (using 8 cores)... [15:14:51|STATUS ]====|Kicking particles (using 8 cores) done. [15:14:51|STATUS ]==|ModuleP3M: End COLA+P3M step 74/74, time_kick:1.000000, time_drift=1.000000. [15:14:51|TIMER ]==|Step 74/74: Density: 0.025 CPU - 0.008 wallclock seconds used. [15:14:51|TIMER ]==|Step 74/74: Potential: 0.019 CPU - 0.007 wallclock seconds used. [15:14:51|TIMER ]==|Step 74/74: Accelerations (long-range): 0.130 CPU - 0.032 wallclock seconds used. [15:14:51|TIMER ]==|Step 74/74: Accelerations (short-range): 0.965 CPU - 0.307 wallclock seconds used. [15:14:51|TIMER ]==|Step 74/74: Kick: 0.012 CPU - 0.004 wallclock seconds used. [15:14:51|TIMER ]==|Step 74/74: Drift: 0.002 CPU - 0.001 wallclock seconds used. [15:14:51|TIMER ]==|Step 74/74: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:51|TIMER ]==|Step 74/74: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:51|TIMER ]==|Step 74/74: Outputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:51|TIMER ]==|Step 74/74: Total Evolution: 1.154 CPU - 0.360 wallclock seconds used. [15:14:51|STATUS ]==|Writing field to '/Users/hoellinger/WIP3M/notebook12/p_res/p74.h5'... [15:14:51|STATUS ]==|Writing field to '/Users/hoellinger/WIP3M/notebook12/p_res/p74.h5' done. [15:14:51|STATUS ]==|ModulePMCOLA: L_plus operator: changing reference frame after COLA evolution... [15:14:51|STATUS ]==|ModulePMCOLA: L_plus operator: changing reference frame after COLA evolution done. [15:14:51|TIMER ]==|Box: Density: 0.905 CPU - 0.241 wallclock seconds used. [15:14:51|TIMER ]==|Box: Potential: 0.679 CPU - 0.276 wallclock seconds used. [15:14:51|TIMER ]==|Box: Accelerations (long-range): 4.688 CPU - 1.235 wallclock seconds used. [15:14:51|TIMER ]==|Box: Accelerations (short-range): 23.905 CPU - 5.710 wallclock seconds used. [15:14:51|TIMER ]==|Box: Kick: 0.446 CPU - 0.143 wallclock seconds used. [15:14:51|TIMER ]==|Box: Drift: 0.121 CPU - 0.067 wallclock seconds used. [15:14:51|TIMER ]==|Box: Inputs: 0.000 CPU - 0.000 wallclock seconds used. [15:14:51|TIMER ]==|Box: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used. [15:14:51|TIMER ]==|Box: Outputs: 0.019 CPU - 0.011 wallclock seconds used. [15:14:51|TIMER ]==|Box: Total Evolution: 30.763 CPU - 7.683 wallclock seconds used. [15:14:51|MODULE ]|ModuleP3M: Evolving with P3M done. [15:14:51|MODULE ]|ModulePMCOLA: Computing outputs... [15:14:51|STATUS ]==|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)... [15:14:51|STATUS ]==|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done. [15:14:51|STATUS ]==|Writing field to '/Users/hoellinger/WIP3M/notebook12/final_density_p3m.h5'... [15:14:51|STATUS ]==|Writing field to '/Users/hoellinger/WIP3M/notebook12/final_density_p3m.h5' done. [15:14:51|STATUS ]==|Writing header in '/Users/hoellinger/WIP3M/notebook12/p3m_snapshot.gadget3'... [15:14:51|STATUS ]==|Writing header in '/Users/hoellinger/WIP3M/notebook12/p3m_snapshot.gadget3' done. [15:14:51|STATUS ]==|Writing snapshot in '/Users/hoellinger/WIP3M/notebook12/p3m_snapshot.gadget3' (32768 particles)... [15:14:51|STATUS ]====|Writing block: 'POS '... [15:14:51|STATUS ]====|Writing block: 'POS ' done. [15:14:51|STATUS ]====|Writing block: 'VEL '... [15:14:51|STATUS ]====|Writing block: 'VEL ' done. [15:14:51|STATUS ]====|Writing block: 'ID '... [15:14:51|STATUS ]====|Writing block: 'ID ' done. [15:14:51|STATUS ]==|Writing snapshot in '/Users/hoellinger/WIP3M/notebook12/p3m_snapshot.gadget3' done. [15:14:51|MODULE ]|ModulePMCOLA: Computing outputs done. [15:14:51|TIMER ]|PMCOLA output: 0.018 CPU - 0.005 wallclock seconds used. [15:14:51|TIMER ]|ModulePMCOLA: 32.093 CPU - 9.015 wallclock seconds used. [15:14:51|TIMER ]|Simbelmynë: 32.143 CPU - 9.031 wallclock seconds used. [15:14:51|INFO ]|Everything done successfully, exiting.
Gravitational potential¶
In [13]:
slice_ijk = (N // 2, slice(None), slice(None))
steps = [3,23,67] # Steps to compare
# steps = [1,38,75] # Steps to compare
DELTA_P3M = read_field(simdir + f"final_density_p3m.h5").data[slice_ijk]
DELTA_GP1 = read_field(gravpotdir + f"gp_nforce{steps[0]}.h5").data[slice_ijk]
DELTA_GP2 = read_field(gravpotdir + f"gp_nforce{steps[1]}.h5").data[slice_ijk]
DELTA_GP3 = read_field(gravpotdir + f"gp_nforce{steps[2]}.h5").data[slice_ijk]
diff_gp2_gp1 = DELTA_GP3 - DELTA_GP1
diff_gp3_gp1 = DELTA_GP3 - DELTA_GP2
[15:15:28|STATUS ]==|Read field in data file '/Users/hoellinger/WIP3M/notebook12/final_density_p3m.h5'... [15:15:28|DIAGNOSTIC]====|ranges=[np.float64(0.0), np.float64(32.0), np.float64(0.0), np.float64(32.0), np.float64(0.0), np.float64(32.0), np.int32(32), np.int32(32), np.int32(32)] [15:15:28|STATUS ]==|Read field in data file '/Users/hoellinger/WIP3M/notebook12/final_density_p3m.h5' done. [15:15:28|STATUS ]==|Read field in data file '/Users/hoellinger/WIP3M/notebook12/gravpot/gp_nforce3.h5'... [15:15:28|DIAGNOSTIC]====|ranges=[np.float64(0.0), np.float64(32.0), np.float64(0.0), np.float64(32.0), np.float64(0.0), np.float64(32.0), np.int32(32), np.int32(32), np.int32(32)] [15:15:28|STATUS ]==|Read field in data file '/Users/hoellinger/WIP3M/notebook12/gravpot/gp_nforce3.h5' done. [15:15:28|STATUS ]==|Read field in data file '/Users/hoellinger/WIP3M/notebook12/gravpot/gp_nforce23.h5'... [15:15:28|DIAGNOSTIC]====|ranges=[np.float64(0.0), np.float64(32.0), np.float64(0.0), np.float64(32.0), np.float64(0.0), np.float64(32.0), np.int32(32), np.int32(32), np.int32(32)] [15:15:28|STATUS ]==|Read field in data file '/Users/hoellinger/WIP3M/notebook12/gravpot/gp_nforce23.h5' done. [15:15:28|STATUS ]==|Read field in data file '/Users/hoellinger/WIP3M/notebook12/gravpot/gp_nforce67.h5'... [15:15:28|DIAGNOSTIC]====|ranges=[np.float64(0.0), np.float64(32.0), np.float64(0.0), np.float64(32.0), np.float64(0.0), np.float64(32.0), np.int32(32), np.int32(32), np.int32(32)] [15:15:28|STATUS ]==|Read field in data file '/Users/hoellinger/WIP3M/notebook12/gravpot/gp_nforce67.h5' done.
In [14]:
fields = ["p3m", "gp1", "gp2", "gp3", "diff_gp2_gp1", "diff_gp3_gp1"] # fields to plot
figname = "_".join(fields)
slices_dict = {
"p3m": DELTA_P3M,
"gp1": DELTA_GP1,
"gp2": DELTA_GP2,
"gp3": DELTA_GP3,
"diff_gp2_gp1": diff_gp2_gp1,
"diff_gp3_gp1": diff_gp3_gp1,
}
titles_dict = {
"p3m": f"P3M $n_\\mathrm{{steps}}={nsteps}$",
"gp1": rf"$\phi$, step {steps[0]}",
"gp2": rf"$\phi$, step {steps[1]}",
"gp3": rf"$\phi$, step {steps[2]}",
"diff_gp2_gp1": r"$\phi_3 - \phi_2$",
"diff_gp3_gp1": r"$\phi_3 - \phi_1$",
}
npanels = len(fields)
fig, axs = plt.subplots(1, npanels, figsize=(3 * npanels, 4), sharey=True)
ims = []
for i, key in enumerate(fields):
ax = axs[i]
data = slices_dict[key]
title = titles_dict[key]
if key.startswith("diff"):
im = ax.imshow(data, cmap="viridis")
elif key.startswith("gp"):
im = ax.imshow(data, cmap="plasma")
# im = ax.imshow(np.log10(1 + data - np.min(data)), cmap="plasma")
else:
im = ax.imshow(np.log10(2 + data), cmap=cmap)
ims.append((im, key))
ax.set_title(title, fontsize=fs_titles)
for spine in ax.spines.values():
spine.set_visible(False)
axs[0].set_yticks([0, N // 2, N])
axs[0].set_yticklabels([f"{-L/2:.0f}", "0", f"{L/2:.0f}"], fontsize=fs)
axs[0].set_ylabel(r"Mpc/$h$", size=GLOBAL_FS_SMALL)
for i, ax in enumerate(axs):
ax.set_xticks([0, N // 2, N])
ax.set_xticklabels([f"{-L/2:.0f}", "0", f"{L/2:.0f}"], fontsize=fs)
ax.set_xlabel(r"Mpc/$h$", size=GLOBAL_FS_SMALL)
for ax, (im, key) in zip(axs, ims):
divider = make_axes_locatable(ax)
cax = divider.append_axes("bottom", size="5%", pad=0.6)
cb = fig.colorbar(im, cax=cax, orientation="horizontal")
if key.startswith("gp"):
cb.set_label(r"$\phi$", fontsize=fs)
elif key.startswith("diff"):
cb.set_label(r"$\Delta\phi$", fontsize=fs)
else:
cb.set_label(r"$\log_{10}(2 + \delta)$", fontsize=fs)
cb.ax.tick_params(labelsize=fs)
cax.xaxis.set_ticks_position("bottom")
cax.xaxis.set_label_position("bottom")
fig.savefig(
simdir + f"{figname}.png",
bbox_inches="tight",
dpi=300,
transparent=True,
)
fig.savefig(
simdir + f"{figname}.pdf",
bbox_inches="tight",
dpi=300,
)
plt.show()
Residual momenta¶
In [16]:
component = 0
slice_cijk = (component, N // 2, slice(None), slice(None))
DELTA_P1 = read_field(momentadir + f"p{steps[0]}.h5").data[slice_cijk]
DELTA_P2 = read_field(momentadir + f"p{steps[1]}.h5").data[slice_cijk]
DELTA_P3 = read_field(momentadir + f"p{steps[2]}.h5").data[slice_cijk]
[15:15:38|STATUS ]====|Read field in data file '/Users/hoellinger/WIP3M/notebook12/p_res/p3.h5'... [15:15:38|DIAGNOSTIC]======|ranges=[np.float64(0.0), np.float64(32.0), np.float64(0.0), np.float64(32.0), np.float64(0.0), np.float64(32.0), np.int32(32), np.int32(32), np.int32(32)] [15:15:38|STATUS ]====|Read field in data file '/Users/hoellinger/WIP3M/notebook12/p_res/p3.h5' done. [15:15:38|STATUS ]====|Read field in data file '/Users/hoellinger/WIP3M/notebook12/p_res/p23.h5'... [15:15:38|DIAGNOSTIC]======|ranges=[np.float64(0.0), np.float64(32.0), np.float64(0.0), np.float64(32.0), np.float64(0.0), np.float64(32.0), np.int32(32), np.int32(32), np.int32(32)] [15:15:38|STATUS ]====|Read field in data file '/Users/hoellinger/WIP3M/notebook12/p_res/p23.h5' done. [15:15:38|STATUS ]====|Read field in data file '/Users/hoellinger/WIP3M/notebook12/p_res/p67.h5'... [15:15:38|DIAGNOSTIC]======|ranges=[np.float64(0.0), np.float64(32.0), np.float64(0.0), np.float64(32.0), np.float64(0.0), np.float64(32.0), np.int32(32), np.int32(32), np.int32(32)] [15:15:38|STATUS ]====|Read field in data file '/Users/hoellinger/WIP3M/notebook12/p_res/p67.h5' done.
In [17]:
fields = ["p3m", "p1", "p2", "p3"]
figname = "_".join(fields)
slices_dict = {
"p3m": DELTA_P3M,
"p1": DELTA_P1,
"p2": DELTA_P2,
"p3": DELTA_P3,
}
titles_dict = {
"p3m": f"P3M $n_\\mathrm{{steps}}={nsteps}$",
"p1": rf"$p_{component}$, step {steps[0]}",
"p2": rf"$p_{component}$, step {steps[1]}",
"p3": rf"$p_{component}$, step {steps[2]}",
}
npanels = len(fields)
fig, axs = plt.subplots(1, npanels, figsize=(3 * npanels, 4), sharey=True)
ims = []
for i, key in enumerate(fields):
ax = axs[i]
data = slices_dict[key]
title = titles_dict[key]
if key.startswith("diff"):
im = ax.imshow(data, cmap=cm.balance)
elif key.startswith("p3m"):
im = ax.imshow(np.log10(2 + data), cmap=cmap)
else:
im = ax.imshow(data, cmap=cm.curl)
ims.append((im, key))
ax.set_title(title, fontsize=fs_titles)
for spine in ax.spines.values():
spine.set_visible(False)
axs[0].set_yticks([0, N // 2, N])
axs[0].set_yticklabels([f"{-L/2:.0f}", "0", f"{L/2:.0f}"], fontsize=fs)
axs[0].set_ylabel(r"Mpc/$h$", size=GLOBAL_FS_SMALL)
for i, ax in enumerate(axs):
ax.set_xticks([0, N // 2, N])
ax.set_xticklabels([f"{-L/2:.0f}", "0", f"{L/2:.0f}"], fontsize=fs)
ax.set_xlabel(r"Mpc/$h$", size=GLOBAL_FS_SMALL)
for ax, (im, key) in zip(axs, ims):
divider = make_axes_locatable(ax)
cax = divider.append_axes("bottom", size="5%", pad=0.6)
cb = fig.colorbar(im, cax=cax, orientation="horizontal")
if key.startswith("p3m"):
cb.set_label(r"$\log_{10}(2 + \delta)$", fontsize=fs)
elif key.startswith("diff"):
cb.set_label(r"$\Delta\phi$", fontsize=fs)
else:
cb.set_label(rf"$p_{component}$", fontsize=fs)
cb.ax.tick_params(labelsize=fs)
cax.xaxis.set_ticks_position("bottom")
cax.xaxis.set_label_position("bottom")
fig.savefig(
simdir + f"{figname}.png",
bbox_inches="tight",
dpi=300,
transparent=True,
)
fig.savefig(
simdir + f"{figname}.pdf",
bbox_inches="tight",
dpi=300,
)
plt.show()
Time stepping diagnostic¶
In [18]:
a, _, _, _, _, da_p3m, da_p3m_fit, _, _, _ = np.loadtxt(
OutputTimestepsLog[:-4] + "_custom.txt", delimiter=",", unpack=True, skiprows=0
)
In [19]:
plot_custom_timestepping_diagnostics(
log_path=OutputTimestepsLog,
aiDrift=aiDrift,
TimeStepDistribution=TimeStepDistribution,
nsteps=nsteps,
ymin=5e-3,
ymax=0.5,
fac_hubble=fac_hubble,
plot_bend=False,
fac_p3m_fit=fac_p3m_fit,
da_max_early=da_early,
da_max_late=DEFAULT_DA_MAX_LATE_CUSTOM,
)
[15:15:41|INFO ]|(wip3m.plot_utils) Plotting timestep limiters from /Users/hoellinger/WIP3M/notebook12/timesteps_log.txt and /Users/hoellinger/WIP3M/notebook12/timesteps_log_custom.txt... [15:15:41|INFO ]|(wip3m.plot_utils) Plotting timestep limiters from /Users/hoellinger/WIP3M/notebook12/timesteps_log.txt and /Users/hoellinger/WIP3M/notebook12/timesteps_log_custom.txt done.
In [20]:
# Delta a/a = cst => da = cst * a
cst = (aiDrift[-2]-aiDrift[-3]) / aiDrift[-3]
# a_nsteps = aiDrift[0] * (1 + cst)**nsteps
# 1 = a_nsteps => 1 = aiDrift[0] * (1 + cst)**nsteps
nsteps_needed = int(np.ceil(np.log(af/aiDrift[0]) / np.log(1 + cst)))
print(f"Number of log steps needed to reach af={af} from ai={aiDrift[0]}: {nsteps_needed}")
Number of log steps needed to reach af=1.0 from ai=0.05: 146
In [ ]:
In [ ]:
In [ ]: