wip3m/notebooks/4_limiters_concept.ipynb

347 KiB

Tristan Hoellinger
Institut d'Astrophysique de Paris tristan.hoellinger@iap.fr

Exploring baseline CONCEPT time step limiters for P3M

Set up the environment and parameters

In [1]:
# pyright: reportWildcardImportFromLibrary=false
from wip3m import *
In [2]:
workdir = ROOT_PATH + "results/"
output_path = OUTPUT_PATH

# L = 8  # Box size in Mpc/h
# N = 8  # Density grid size
# Np = 8  # Number of dark matter particles per spatial dimension
# Npm = 16  # PM grid size
# n_Tiles = 2  # Make sure Npm/n_Tiles >= 6

# L = 16  # Box size in Mpc/h
# N = 16  # Density grid size
# Np = 16  # Number of dark matter particles per spatial dimension
# Npm = 32  # PM grid size
# n_Tiles = 4  # Make sure Npm/n_Tiles >= 6

# L = 32  # Box size in Mpc/h
# N = 32  # Density grid size
# Np = 32  # Number of dark matter particles per spatial dimension
# Npm = 256  # PM grid size
# n_Tiles = 32  # Make sure Npm/n_Tiles >= 6

# L = 64  # Box size in Mpc/h
# N = 64  # Density grid size
# Np = 64  # Number of dark matter particles per spatial dimension
# Npm = 128  # PM grid size
# n_Tiles = 16  # Make sure Npm/n_Tiles >= 6

# 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

go_beyond_Nyquist_ss = True  # for the summary statistics
    
force = force_hard = True
run_id = "notebook4"

TimeStepDistribution = 1 # 0: constant time step, 1: log
nsteps = 30
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

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 = 199.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 + "/"
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(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"
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_params = common_params.copy()
p3m_params["method"] = "p3m"
p3m_params["EvolutionMode"] = 4
p3m_params["TimeStepDistribution"] = TimeStepDistribution
p3m_params["ai"] = ai
p3m_params["af"] = af
p3m_params["RedshiftLPT"] = RedshiftLPT
p3m_params["RedshiftFCs"] = RedshiftFCs
p3m_params["Npm"] = Npm
p3m_params["nsteps"] = nsteps
p3m_params["n_Tiles"] = n_Tiles
p3m_params["RunForceDiagnostic"] = False
p3m_params["PrintOutputTimestepsLog"] = True
p3m_params["OutputTimestepsLog"] = OutputTimestepsLog
In [6]:
reset_plotting()  # Default style for Simbelmynë
generate_sim_params(lpt_params, ICs_path, wd, simdir, None, force)
file_ext = f"p3m_nsteps{p3m_params['nsteps']}"
generate_sim_params(p3m_params, ICs_path, wd, simdir, file_ext, force)
setup_plotting()  # Reset plotting style for this project
[09:25:47|INFO      ]|(wip3m.tools) Generating parameter file...
[09:25:47|STATUS    ]|Writing parameter file in '/Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook4/example_lpt.sbmy'...
[09:25:47|STATUS    ]|Writing parameter file in '/Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook4/example_lpt.sbmy' done.
[09:25:47|INFO      ]|(wip3m.tools) Parameter file written to /Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook4/example_lpt.sbmy
[09:25:47|INFO      ]|(wip3m.tools) Time-stepping distribution file: /Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook4/p3m_nsteps30_ts_p3m.h5
[09:25:47|STATUS    ]|Write timestepping configuration in '/Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook4/p3m_nsteps30_ts_p3m.h5'...
[09:25:47|STATUS    ]|Write timestepping configuration in '/Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook4/p3m_nsteps30_ts_p3m.h5' done.
[09:25:47|INFO      ]|(wip3m.tools) TS.ai = 0.005000, TS.af = 1.000000, TS.nsteps = 30
[09:25:47|STATUS    ]|Read timestepping configuration in '/Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook4/p3m_nsteps30_ts_p3m.h5'...
[09:25:47|STATUS    ]|Read timestepping configuration in '/Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook4/p3m_nsteps30_ts_p3m.h5' done.
[09:25:47|INFO      ]|(wip3m.tools) Generating parameter file...
[09:25:47|STATUS    ]|Writing parameter file in '/Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook4/p3m_nsteps30_example_p3m.sbmy'...
[09:25:47|STATUS    ]|Writing parameter file in '/Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook4/p3m_nsteps30_example_p3m.sbmy' done.
[09:25:47|INFO      ]|(wip3m.tools) Parameter file written to /Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook4/p3m_nsteps30_example_p3m.sbmy
No description has been provided for this image

Load time stepping:

In [7]:
TS = StandardTimeStepping.read(wd + file_ext + "_ts_p3m.h5")
aKickBeg = TS.aKickBeg
aKickEnd = TS.aKickEnd
aDriftBeg = TS.aDriftBeg
aDriftEnd = TS.aDriftEnd
aiDrift = TS.aiDrift
afDrift = TS.afDrift
[09:25:47|STATUS    ]|Read timestepping configuration in '/Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook4/p3m_nsteps30_ts_p3m.h5'...
[09:25:47|STATUS    ]|Read timestepping configuration in '/Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook4/p3m_nsteps30_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)
[09:25:47|STATUS    ]|Setting up Fourier grid...
[09:25:47|STATUS    ]|Setting up Fourier grid done.
[09:25:47|STATUS    ]|Computing normalization of the power spectrum...
[09:25:47|STATUS    ]|Computing normalization of the power spectrum done.
[09:25:47|STATUS    ]|Computing power spectrum...
[09:25:47|STATUS    ]|Computing power spectrum done.
[09:25:47|STATUS    ]|Write power spectrum in data file '/Users/hoellinger/WIP3M/notebook4/input_power.h5'...
[09:25:47|DIAGNOSTIC]==|L0=32, L1=32, L2=32
[09:25:47|DIAGNOSTIC]==|N0=32, N1=32, N2=32, N2_HC=17, N_HC=17408, NUM_MODES=464
[09:25:47|STATUS    ]|Write power spectrum in data file '/Users/hoellinger/WIP3M/notebook4/input_power.h5' done.

Running the simulations

In [10]:
run_simulation("lpt", lpt_params, wd, logdir)
[09:25:47|COMMAND   ]|simbelmyne /Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook4/example_lpt.sbmy /Users/hoellinger/WIP3M/notebook4/logs/lpt.txt
[09:25:47|INFO      ]|
[09:25:47|INFO      ]|            .-~~-.--.
[09:25:47|INFO      ]|           :         )
[09:25:47|INFO      ]|     .~ ~ -.\       /.- ~~ .
[09:25:47|INFO      ]|     >       `.   .'       <
[09:25:47|INFO      ]|    (         .- -.         )
[09:25:47|INFO      ]|     `- -.-~  `- -'  ~-.- -'
[09:25:47|INFO      ]|       (        :        )           _ _ .-:        ___________________________________
[09:25:47|INFO      ]|        ~--.    :    .--~        .-~  .-~  }                    SIMBELMYNË
[09:25:47|INFO      ]|            ~-.-^-.-~ \_      .~  .-~   .~           (c) Florent Leclercq 2012 - SBMY_YEAR 
[09:25:47|INFO      ]|                     \ '     \ '_ _ -~              ___________________________________
[09:25:47|INFO      ]|                      `.`.    //
[09:25:47|INFO      ]|             . - ~ ~-.__`.`-.//
[09:25:47|INFO      ]|         .-~   . - ~  }~ ~ ~-.~-.
[09:25:47|INFO      ]|       .' .-~      .-~       :/~-.~-./:
[09:25:47|INFO      ]|      /_~_ _ . - ~                 ~-.~-._
[09:25:47|INFO      ]|                                       ~-.<
[09:25:47|INFO      ]|
[09:25:47|INFO      ]|2025-06-24 09:25:47: Starting SIMBELMYNË, commit hash bab918a5347585bc2fb9554e442fd77ad3ae69cc
[09:25:47|STATUS    ]|Reading parameter file in '/Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook4/example_lpt.sbmy'...
[09:25:47|STATUS    ]|Reading parameter file in '/Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook4/example_lpt.sbmy' done.
[09:25:47|MODULE    ]|ModuleLPT: Initializing snapshot...
[09:25:47|MODULE    ]|ModuleLPT: Initializing snapshot done.
[09:25:47|TIMER     ]|LPT snapshot initialization: 0.001 CPU - 0.000 wallclock seconds used.
[09:25:47|MODULE    ]|ModuleLPT: Returning initial conditions...
[09:25:47|STATUS    ]==|Reading field in '/Users/hoellinger/WIP3M/notebook4/input_white_noise.h5'...
[09:25:47|STATUS    ]==|Reading field in '/Users/hoellinger/WIP3M/notebook4/input_white_noise.h5' done.
[09:25:47|STATUS    ]==|Reading power spectrum...
[09:25:47|STATUS    ]====|Reading power spectrum in '/Users/hoellinger/WIP3M/notebook4/input_power.h5'...
[09:25:47|STATUS    ]====|Reading power spectrum in '/Users/hoellinger/WIP3M/notebook4/input_power.h5' done.
[09:25:47|STATUS    ]==|Reading power spectrum done.
[09:25:47|STATUS    ]==|Generating Gaussian random field (using 8 cores)...
[09:25:47|STATUS    ]==|Generating Gaussian random field (using 8 cores) done.
[09:25:47|STATUS    ]==|Writing field to '/Users/hoellinger/WIP3M/notebook4/initial_density.h5'...
[09:25:47|STATUS    ]==|Writing field to '/Users/hoellinger/WIP3M/notebook4/initial_density.h5' done.
[09:25:47|MODULE    ]|ModuleLPT: Returning initial conditions done.
[09:25:47|TIMER     ]|LPT initial conditions: 0.003 CPU - 0.002 wallclock seconds used.
[09:25:47|MODULE    ]|ModuleLPT: Evolving with Lagrangian perturbation theory (using 8 cores)...
[09:25:47|STATUS    ]==|Computing Lagrangian potentials, periodic boundary conditions (using 8 cores)...
[09:25:47|STATUS    ]==|Computing Lagrangian potentials, periodic boundary conditions (using 8 cores) done.
[09:25:47|STATUS    ]==|Computing Lagrangian displacement field (using 8 cores)...
[09:25:47|STATUS    ]==|Computing Lagrangian displacement field (using 8 cores) done.
[09:25:47|STATUS    ]==|Changing velocities of particles...
[09:25:47|STATUS    ]==|Changing velocities of particles done.
[09:25:47|STATUS    ]==|Displacing particles...
[09:25:47|STATUS    ]==|Displacing particles done.
[09:25:47|MODULE    ]|ModuleLPT: Evolving with Lagrangian perturbation theory (using 8 cores) done.
[09:25:47|TIMER     ]|LPT evolution: 0.048 CPU - 0.015 wallclock seconds used.
[09:25:47|MODULE    ]|ModuleLPT: Computing outputs...
[09:25:47|STATUS    ]==|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)...
[09:25:47|STATUS    ]==|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done.
[09:25:47|STATUS    ]==|Writing field to '/Users/hoellinger/WIP3M/notebook4/lpt_density.h5'...
[09:25:47|STATUS    ]==|Writing field to '/Users/hoellinger/WIP3M/notebook4/lpt_density.h5' done.
[09:25:47|STATUS    ]==|Writing header in '/Users/hoellinger/WIP3M/notebook4/lpt_particles.gadget3'...
[09:25:47|STATUS    ]==|Writing header in '/Users/hoellinger/WIP3M/notebook4/lpt_particles.gadget3' done.
[09:25:47|STATUS    ]==|Writing snapshot in '/Users/hoellinger/WIP3M/notebook4/lpt_particles.gadget3' (32768 particles)...
[09:25:47|STATUS    ]====|Writing block: 'POS '...
[09:25:47|STATUS    ]====|Writing block: 'POS ' done.
[09:25:47|STATUS    ]====|Writing block: 'VEL '...
[09:25:47|STATUS    ]====|Writing block: 'VEL ' done.
[09:25:47|STATUS    ]====|Writing block: 'ID  '...
[09:25:47|STATUS    ]====|Writing block: 'ID  ' done.
[09:25:47|STATUS    ]==|Writing snapshot in '/Users/hoellinger/WIP3M/notebook4/lpt_particles.gadget3' done.
[09:25:47|MODULE    ]|ModuleLPT: Computing outputs done.
[09:25:47|TIMER     ]|LPT output: 0.010 CPU - 0.004 wallclock seconds used.
[09:25:47|TIMER     ]|ModuleLPT: 0.061 CPU - 0.021 wallclock seconds used.
[09:25:47|TIMER     ]|Simbelmynë: 0.062 CPU - 0.022 wallclock seconds used.
[09:25:47|INFO      ]|Everything done successfully, exiting.
In [11]:
run_simulation("p3m", p3m_params, wd, logdir)
[09:25:47|COMMAND   ]|simbelmyne /Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook4/p3m_nsteps30_example_p3m.sbmy /Users/hoellinger/WIP3M/notebook4/logs/p3m_nsteps30p3m.txt
[09:25:47|INFO      ]|
[09:25:47|INFO      ]|            .-~~-.--.
[09:25:47|INFO      ]|           :         )
[09:25:47|INFO      ]|     .~ ~ -.\       /.- ~~ .
[09:25:47|INFO      ]|     >       `.   .'       <
[09:25:47|INFO      ]|    (         .- -.         )
[09:25:47|INFO      ]|     `- -.-~  `- -'  ~-.- -'
[09:25:47|INFO      ]|       (        :        )           _ _ .-:        ___________________________________
[09:25:47|INFO      ]|        ~--.    :    .--~        .-~  .-~  }                    SIMBELMYNË
[09:25:47|INFO      ]|            ~-.-^-.-~ \_      .~  .-~   .~           (c) Florent Leclercq 2012 - SBMY_YEAR 
[09:25:47|INFO      ]|                     \ '     \ '_ _ -~              ___________________________________
[09:25:47|INFO      ]|                      `.`.    //
[09:25:47|INFO      ]|             . - ~ ~-.__`.`-.//
[09:25:47|INFO      ]|         .-~   . - ~  }~ ~ ~-.~-.
[09:25:47|INFO      ]|       .' .-~      .-~       :/~-.~-./:
[09:25:47|INFO      ]|      /_~_ _ . - ~                 ~-.~-._
[09:25:47|INFO      ]|                                       ~-.<
[09:25:47|INFO      ]|
[09:25:47|INFO      ]|2025-06-24 09:25:47: Starting SIMBELMYNË, commit hash bab918a5347585bc2fb9554e442fd77ad3ae69cc
[09:25:47|STATUS    ]|Reading parameter file in '/Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook4/p3m_nsteps30_example_p3m.sbmy'...
[09:25:47|STATUS    ]|Reading parameter file in '/Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook4/p3m_nsteps30_example_p3m.sbmy' done.
[09:25:47|MODULE    ]|ModuleLPT: Initializing snapshot...
[09:25:47|MODULE    ]|ModuleLPT: Initializing snapshot done.
[09:25:47|TIMER     ]|LPT snapshot initialization: 0.001 CPU - 0.000 wallclock seconds used.
[09:25:47|MODULE    ]|ModuleLPT: Returning initial conditions...
[09:25:47|STATUS    ]==|Reading field in '/Users/hoellinger/WIP3M/notebook4/initial_density.h5'...
[09:25:47|STATUS    ]==|Reading field in '/Users/hoellinger/WIP3M/notebook4/initial_density.h5' done.
[09:25:47|MODULE    ]|ModuleLPT: Returning initial conditions done.
[09:25:47|TIMER     ]|LPT initial conditions: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:47|MODULE    ]|ModuleLPT: Evolving with Lagrangian perturbation theory (using 8 cores)...
[09:25:47|STATUS    ]==|Computing Lagrangian potentials, periodic boundary conditions (using 8 cores)...
[09:25:47|STATUS    ]==|Computing Lagrangian potentials, periodic boundary conditions (using 8 cores) done.
[09:25:47|STATUS    ]==|Computing Lagrangian displacement field (using 8 cores)...
[09:25:47|STATUS    ]==|Computing Lagrangian displacement field (using 8 cores) done.
[09:25:47|STATUS    ]==|Changing velocities of particles...
[09:25:47|STATUS    ]==|Changing velocities of particles done.
[09:25:47|STATUS    ]==|Displacing particles...
[09:25:47|STATUS    ]==|Displacing particles done.
[09:25:47|MODULE    ]|ModuleLPT: Evolving with Lagrangian perturbation theory (using 8 cores) done.
[09:25:47|TIMER     ]|LPT evolution: 0.047 CPU - 0.016 wallclock seconds used.
[09:25:47|TIMER     ]|ModuleLPT: 0.048 CPU - 0.016 wallclock seconds used.
[09:25:47|MODULE    ]|ModuleP3M: Evolving with P3M...
[09:25:47|STATUS    ]==|Read timestepping configuration in '/Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook4/p3m_nsteps30_ts_p3m.h5'...
[09:25:47|STATUS    ]==|Read timestepping configuration in '/Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook4/p3m_nsteps30_ts_p3m.h5' done.
[09:25:47|STATUS    ]==|OutputForceDiagnostic: force_diagnostic.csv
[09:25:47|STATUS    ]==|OutputSnapshotsBase: particles_
[09:25:47|STATUS    ]==|ModuleP3M: Begin P3M step 1/30, time_kick:0.005000, time_drift=0.005000.
[09:25:47|STATUS    ]====|ModuleP3M: Compute time step limiters for step 1/30 done.
[09:25:47|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)...
[09:25:47|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done.
[09:25:47|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)...
[09:25:47|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done.
[09:25:47|STATUS    ]====|Kicking particles (using 8 cores)...
[09:25:47|STATUS    ]====|Kicking particles (using 8 cores) done.
[09:25:47|STATUS    ]====|Drifting particles (using 8 cores)...
[09:25:47|STATUS    ]====|Drifting particles (using 8 cores) done.
[09:25:47|STATUS    ]==|ModuleP3M: End P3M step 1/30, time_kick:0.005462, time_drift=0.005966.
[09:25:47|TIMER     ]==|Step 1/30: Density: 0.009 CPU - 0.002 wallclock seconds used.
[09:25:47|TIMER     ]==|Step 1/30: Potential: 0.008 CPU - 0.003 wallclock seconds used.
[09:25:47|TIMER     ]==|Step 1/30: Accelerations (long-range): 0.065 CPU - 0.015 wallclock seconds used.
[09:25:47|TIMER     ]==|Step 1/30: Accelerations (short-range): 0.226 CPU - 0.103 wallclock seconds used.
[09:25:47|TIMER     ]==|Step 1/30: Kick: 0.006 CPU - 0.002 wallclock seconds used.
[09:25:47|TIMER     ]==|Step 1/30: Drift: 0.001 CPU - 0.001 wallclock seconds used.
[09:25:47|TIMER     ]==|Step 1/30: Inputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:47|TIMER     ]==|Step 1/30: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:47|TIMER     ]==|Step 1/30: Outputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:47|TIMER     ]==|Step 1/30: Total Evolution: 0.314 CPU - 0.126 wallclock seconds used.
[09:25:47|STATUS    ]==|ModuleP3M: Begin P3M step 2/30, time_kick:0.005462, time_drift=0.005966.
[09:25:47|STATUS    ]====|ModuleP3M: Compute time step limiters for step 2/30 done.
[09:25:47|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)...
[09:25:47|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done.
[09:25:47|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)...
[09:25:47|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done.
[09:25:47|STATUS    ]====|Kicking particles (using 8 cores)...
[09:25:48|STATUS    ]====|Kicking particles (using 8 cores) done.
[09:25:48|STATUS    ]====|Drifting particles (using 8 cores)...
[09:25:48|STATUS    ]====|Drifting particles (using 8 cores) done.
[09:25:48|STATUS    ]==|ModuleP3M: End P3M step 2/30, time_kick:0.006517, time_drift=0.007118.
[09:25:48|TIMER     ]==|Step 2/30: Density: 0.009 CPU - 0.002 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 2/30: Potential: 0.008 CPU - 0.003 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 2/30: Accelerations (long-range): 0.061 CPU - 0.013 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 2/30: Accelerations (short-range): 0.236 CPU - 0.049 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 2/30: Kick: 0.006 CPU - 0.001 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 2/30: Drift: 0.002 CPU - 0.001 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 2/30: Inputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 2/30: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 2/30: Outputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 2/30: Total Evolution: 0.323 CPU - 0.070 wallclock seconds used.
[09:25:48|STATUS    ]==|ModuleP3M: Begin P3M step 3/30, time_kick:0.006517, time_drift=0.007118.
[09:25:48|STATUS    ]====|ModuleP3M: Compute time step limiters for step 3/30 done.
[09:25:48|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)...
[09:25:48|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done.
[09:25:48|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)...
[09:25:48|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done.
[09:25:48|STATUS    ]====|Kicking particles (using 8 cores)...
[09:25:48|STATUS    ]====|Kicking particles (using 8 cores) done.
[09:25:48|STATUS    ]====|Drifting particles (using 8 cores)...
[09:25:48|STATUS    ]====|Drifting particles (using 8 cores) done.
[09:25:48|STATUS    ]==|ModuleP3M: End P3M step 3/30, time_kick:0.007775, time_drift=0.008493.
[09:25:48|TIMER     ]==|Step 3/30: Density: 0.012 CPU - 0.003 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 3/30: Potential: 0.009 CPU - 0.003 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 3/30: Accelerations (long-range): 0.062 CPU - 0.014 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 3/30: Accelerations (short-range): 0.253 CPU - 0.039 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 3/30: Kick: 0.005 CPU - 0.001 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 3/30: Drift: 0.001 CPU - 0.001 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 3/30: Inputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 3/30: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 3/30: Outputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 3/30: Total Evolution: 0.343 CPU - 0.061 wallclock seconds used.
[09:25:48|STATUS    ]==|ModuleP3M: Begin P3M step 4/30, time_kick:0.007775, time_drift=0.008493.
[09:25:48|STATUS    ]====|ModuleP3M: Compute time step limiters for step 4/30 done.
[09:25:48|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)...
[09:25:48|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done.
[09:25:48|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)...
[09:25:48|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done.
[09:25:48|STATUS    ]====|Kicking particles (using 8 cores)...
[09:25:48|STATUS    ]====|Kicking particles (using 8 cores) done.
[09:25:48|STATUS    ]====|Drifting particles (using 8 cores)...
[09:25:48|STATUS    ]====|Drifting particles (using 8 cores) done.
[09:25:48|STATUS    ]==|ModuleP3M: End P3M step 4/30, time_kick:0.009277, time_drift=0.010134.
[09:25:48|TIMER     ]==|Step 4/30: Density: 0.008 CPU - 0.002 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 4/30: Potential: 0.008 CPU - 0.003 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 4/30: Accelerations (long-range): 0.060 CPU - 0.015 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 4/30: Accelerations (short-range): 0.229 CPU - 0.042 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 4/30: Kick: 0.005 CPU - 0.002 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 4/30: Drift: 0.001 CPU - 0.001 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 4/30: Inputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 4/30: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 4/30: Outputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 4/30: Total Evolution: 0.311 CPU - 0.065 wallclock seconds used.
[09:25:48|STATUS    ]==|ModuleP3M: Begin P3M step 5/30, time_kick:0.009277, time_drift=0.010134.
[09:25:48|STATUS    ]====|ModuleP3M: Compute time step limiters for step 5/30 done.
[09:25:48|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)...
[09:25:48|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done.
[09:25:48|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)...
[09:25:48|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done.
[09:25:48|STATUS    ]====|Kicking particles (using 8 cores)...
[09:25:48|STATUS    ]====|Kicking particles (using 8 cores) done.
[09:25:48|STATUS    ]====|Drifting particles (using 8 cores)...
[09:25:48|STATUS    ]====|Drifting particles (using 8 cores) done.
[09:25:48|STATUS    ]==|ModuleP3M: End P3M step 5/30, time_kick:0.011069, time_drift=0.012091.
[09:25:48|TIMER     ]==|Step 5/30: Density: 0.010 CPU - 0.003 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 5/30: Potential: 0.009 CPU - 0.003 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 5/30: Accelerations (long-range): 0.058 CPU - 0.014 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 5/30: Accelerations (short-range): 0.235 CPU - 0.043 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 5/30: Kick: 0.005 CPU - 0.001 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 5/30: Drift: 0.001 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 5/30: Inputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 5/30: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 5/30: Outputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 5/30: Total Evolution: 0.319 CPU - 0.065 wallclock seconds used.
[09:25:48|STATUS    ]==|ModuleP3M: Begin P3M step 6/30, time_kick:0.011069, time_drift=0.012091.
[09:25:48|STATUS    ]====|ModuleP3M: Compute time step limiters for step 6/30 done.
[09:25:48|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)...
[09:25:48|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done.
[09:25:48|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)...
[09:25:48|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done.
[09:25:48|STATUS    ]====|Kicking particles (using 8 cores)...
[09:25:48|STATUS    ]====|Kicking particles (using 8 cores) done.
[09:25:48|STATUS    ]====|Drifting particles (using 8 cores)...
[09:25:48|STATUS    ]====|Drifting particles (using 8 cores) done.
[09:25:48|STATUS    ]==|ModuleP3M: End P3M step 6/30, time_kick:0.013208, time_drift=0.014427.
[09:25:48|TIMER     ]==|Step 6/30: Density: 0.005 CPU - 0.003 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 6/30: Potential: 0.009 CPU - 0.004 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 6/30: Accelerations (long-range): 0.063 CPU - 0.014 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 6/30: Accelerations (short-range): 0.244 CPU - 0.058 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 6/30: Kick: 0.006 CPU - 0.001 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 6/30: Drift: 0.001 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 6/30: Inputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 6/30: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 6/30: Outputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 6/30: Total Evolution: 0.328 CPU - 0.081 wallclock seconds used.
[09:25:48|STATUS    ]==|ModuleP3M: Begin P3M step 7/30, time_kick:0.013208, time_drift=0.014427.
[09:25:48|STATUS    ]====|ModuleP3M: Compute time step limiters for step 7/30 done.
[09:25:48|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)...
[09:25:48|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done.
[09:25:48|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)...
[09:25:48|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done.
[09:25:48|STATUS    ]====|Kicking particles (using 8 cores)...
[09:25:48|STATUS    ]====|Kicking particles (using 8 cores) done.
[09:25:48|STATUS    ]====|Drifting particles (using 8 cores)...
[09:25:48|STATUS    ]====|Drifting particles (using 8 cores) done.
[09:25:48|STATUS    ]==|ModuleP3M: End P3M step 7/30, time_kick:0.015759, time_drift=0.017214.
[09:25:48|TIMER     ]==|Step 7/30: Density: 0.010 CPU - 0.003 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 7/30: Potential: 0.008 CPU - 0.003 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 7/30: Accelerations (long-range): 0.062 CPU - 0.013 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 7/30: Accelerations (short-range): 0.219 CPU - 0.040 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 7/30: Kick: 0.006 CPU - 0.001 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 7/30: Drift: 0.002 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 7/30: Inputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 7/30: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 7/30: Outputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 7/30: Total Evolution: 0.306 CPU - 0.061 wallclock seconds used.
[09:25:48|STATUS    ]==|ModuleP3M: Begin P3M step 8/30, time_kick:0.015759, time_drift=0.017214.
[09:25:48|STATUS    ]====|ModuleP3M: Compute time step limiters for step 8/30 done.
[09:25:48|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)...
[09:25:48|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done.
[09:25:48|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)...
[09:25:48|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done.
[09:25:48|STATUS    ]====|Kicking particles (using 8 cores)...
[09:25:48|STATUS    ]====|Kicking particles (using 8 cores) done.
[09:25:48|STATUS    ]====|Drifting particles (using 8 cores)...
[09:25:48|STATUS    ]====|Drifting particles (using 8 cores) done.
[09:25:48|STATUS    ]==|ModuleP3M: End P3M step 8/30, time_kick:0.018803, time_drift=0.020539.
[09:25:48|TIMER     ]==|Step 8/30: Density: 0.017 CPU - 0.003 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 8/30: Potential: 0.008 CPU - 0.003 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 8/30: Accelerations (long-range): 0.060 CPU - 0.014 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 8/30: Accelerations (short-range): 0.227 CPU - 0.037 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 8/30: Kick: 0.006 CPU - 0.001 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 8/30: Drift: 0.001 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 8/30: Inputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 8/30: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 8/30: Outputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 8/30: Total Evolution: 0.319 CPU - 0.058 wallclock seconds used.
[09:25:48|STATUS    ]==|ModuleP3M: Begin P3M step 9/30, time_kick:0.018803, time_drift=0.020539.
[09:25:48|STATUS    ]====|ModuleP3M: Compute time step limiters for step 9/30 done.
[09:25:48|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)...
[09:25:48|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done.
[09:25:48|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)...
[09:25:48|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done.
[09:25:48|STATUS    ]====|Kicking particles (using 8 cores)...
[09:25:48|STATUS    ]====|Kicking particles (using 8 cores) done.
[09:25:48|STATUS    ]====|Drifting particles (using 8 cores)...
[09:25:48|STATUS    ]====|Drifting particles (using 8 cores) done.
[09:25:48|STATUS    ]==|ModuleP3M: End P3M step 9/30, time_kick:0.022435, time_drift=0.024506.
[09:25:48|TIMER     ]==|Step 9/30: Density: 0.013 CPU - 0.002 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 9/30: Potential: 0.008 CPU - 0.003 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 9/30: Accelerations (long-range): 0.056 CPU - 0.014 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 9/30: Accelerations (short-range): 0.242 CPU - 0.036 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 9/30: Kick: 0.005 CPU - 0.001 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 9/30: Drift: 0.001 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 9/30: Inputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 9/30: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 9/30: Outputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 9/30: Total Evolution: 0.325 CPU - 0.057 wallclock seconds used.
[09:25:48|STATUS    ]==|ModuleP3M: Begin P3M step 10/30, time_kick:0.022435, time_drift=0.024506.
[09:25:48|STATUS    ]====|ModuleP3M: Compute time step limiters for step 10/30 done.
[09:25:48|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)...
[09:25:48|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done.
[09:25:48|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)...
[09:25:48|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done.
[09:25:48|STATUS    ]====|Kicking particles (using 8 cores)...
[09:25:48|STATUS    ]====|Kicking particles (using 8 cores) done.
[09:25:48|STATUS    ]====|Drifting particles (using 8 cores)...
[09:25:48|STATUS    ]====|Drifting particles (using 8 cores) done.
[09:25:48|STATUS    ]==|ModuleP3M: End P3M step 10/30, time_kick:0.026769, time_drift=0.029240.
[09:25:48|TIMER     ]==|Step 10/30: Density: 0.010 CPU - 0.002 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 10/30: Potential: 0.009 CPU - 0.003 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 10/30: Accelerations (long-range): 0.062 CPU - 0.013 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 10/30: Accelerations (short-range): 0.249 CPU - 0.044 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 10/30: Kick: 0.005 CPU - 0.001 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 10/30: Drift: 0.002 CPU - 0.001 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 10/30: Inputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 10/30: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 10/30: Outputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 10/30: Total Evolution: 0.337 CPU - 0.064 wallclock seconds used.
[09:25:48|STATUS    ]==|ModuleP3M: Begin P3M step 11/30, time_kick:0.026769, time_drift=0.029240.
[09:25:48|STATUS    ]====|ModuleP3M: Compute time step limiters for step 11/30 done.
[09:25:48|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)...
[09:25:48|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done.
[09:25:48|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)...
[09:25:48|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done.
[09:25:48|STATUS    ]====|Kicking particles (using 8 cores)...
[09:25:48|STATUS    ]====|Kicking particles (using 8 cores) done.
[09:25:48|STATUS    ]====|Drifting particles (using 8 cores)...
[09:25:48|STATUS    ]====|Drifting particles (using 8 cores) done.
[09:25:48|STATUS    ]==|ModuleP3M: End P3M step 11/30, time_kick:0.031940, time_drift=0.034888.
[09:25:48|TIMER     ]==|Step 11/30: Density: 0.011 CPU - 0.003 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 11/30: Potential: 0.008 CPU - 0.003 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 11/30: Accelerations (long-range): 0.058 CPU - 0.014 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 11/30: Accelerations (short-range): 0.241 CPU - 0.037 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 11/30: Kick: 0.005 CPU - 0.001 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 11/30: Drift: 0.001 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 11/30: Inputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 11/30: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 11/30: Outputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 11/30: Total Evolution: 0.325 CPU - 0.058 wallclock seconds used.
[09:25:48|STATUS    ]==|ModuleP3M: Begin P3M step 12/30, time_kick:0.031940, time_drift=0.034888.
[09:25:48|STATUS    ]====|ModuleP3M: Compute time step limiters for step 12/30 done.
[09:25:48|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)...
[09:25:48|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done.
[09:25:48|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)...
[09:25:48|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done.
[09:25:48|STATUS    ]====|Kicking particles (using 8 cores)...
[09:25:48|STATUS    ]====|Kicking particles (using 8 cores) done.
[09:25:48|STATUS    ]====|Drifting particles (using 8 cores)...
[09:25:48|STATUS    ]====|Drifting particles (using 8 cores) done.
[09:25:48|STATUS    ]==|ModuleP3M: End P3M step 12/30, time_kick:0.038109, time_drift=0.041628.
[09:25:48|TIMER     ]==|Step 12/30: Density: 0.010 CPU - 0.002 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 12/30: Potential: 0.008 CPU - 0.003 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 12/30: Accelerations (long-range): 0.064 CPU - 0.012 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 12/30: Accelerations (short-range): 0.251 CPU - 0.038 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 12/30: Kick: 0.006 CPU - 0.001 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 12/30: Drift: 0.001 CPU - 0.001 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 12/30: Inputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 12/30: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 12/30: Outputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 12/30: Total Evolution: 0.341 CPU - 0.057 wallclock seconds used.
[09:25:48|STATUS    ]==|ModuleP3M: Begin P3M step 13/30, time_kick:0.038109, time_drift=0.041628.
[09:25:48|STATUS    ]====|ModuleP3M: Compute time step limiters for step 13/30 done.
[09:25:48|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)...
[09:25:48|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done.
[09:25:48|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)...
[09:25:48|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done.
[09:25:48|STATUS    ]====|Kicking particles (using 8 cores)...
[09:25:48|STATUS    ]====|Kicking particles (using 8 cores) done.
[09:25:48|STATUS    ]====|Drifting particles (using 8 cores)...
[09:25:48|STATUS    ]====|Drifting particles (using 8 cores) done.
[09:25:48|STATUS    ]==|ModuleP3M: End P3M step 13/30, time_kick:0.045471, time_drift=0.049669.
[09:25:48|TIMER     ]==|Step 13/30: Density: 0.014 CPU - 0.003 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 13/30: Potential: 0.009 CPU - 0.003 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 13/30: Accelerations (long-range): 0.061 CPU - 0.013 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 13/30: Accelerations (short-range): 0.255 CPU - 0.039 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 13/30: Kick: 0.006 CPU - 0.001 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 13/30: Drift: 0.001 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 13/30: Inputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 13/30: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 13/30: Outputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 13/30: Total Evolution: 0.346 CPU - 0.060 wallclock seconds used.
[09:25:48|STATUS    ]==|ModuleP3M: Begin P3M step 14/30, time_kick:0.045471, time_drift=0.049669.
[09:25:48|STATUS    ]====|ModuleP3M: Compute time step limiters for step 14/30 done.
[09:25:48|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)...
[09:25:48|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done.
[09:25:48|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)...
[09:25:48|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done.
[09:25:48|STATUS    ]====|Kicking particles (using 8 cores)...
[09:25:48|STATUS    ]====|Kicking particles (using 8 cores) done.
[09:25:48|STATUS    ]====|Drifting particles (using 8 cores)...
[09:25:48|STATUS    ]====|Drifting particles (using 8 cores) done.
[09:25:48|STATUS    ]==|ModuleP3M: End P3M step 14/30, time_kick:0.054254, time_drift=0.059263.
[09:25:48|TIMER     ]==|Step 14/30: Density: 0.017 CPU - 0.003 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 14/30: Potential: 0.008 CPU - 0.003 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 14/30: Accelerations (long-range): 0.065 CPU - 0.012 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 14/30: Accelerations (short-range): 0.259 CPU - 0.036 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 14/30: Kick: 0.005 CPU - 0.001 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 14/30: Drift: 0.001 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 14/30: Inputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 14/30: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 14/30: Outputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 14/30: Total Evolution: 0.355 CPU - 0.055 wallclock seconds used.
[09:25:48|STATUS    ]==|ModuleP3M: Begin P3M step 15/30, time_kick:0.054254, time_drift=0.059263.
[09:25:48|STATUS    ]====|ModuleP3M: Compute time step limiters for step 15/30 done.
[09:25:48|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)...
[09:25:48|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done.
[09:25:48|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)...
[09:25:48|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done.
[09:25:48|STATUS    ]====|Kicking particles (using 8 cores)...
[09:25:48|STATUS    ]====|Kicking particles (using 8 cores) done.
[09:25:48|STATUS    ]====|Drifting particles (using 8 cores)...
[09:25:48|STATUS    ]====|Drifting particles (using 8 cores) done.
[09:25:48|STATUS    ]==|ModuleP3M: End P3M step 15/30, time_kick:0.064734, time_drift=0.070711.
[09:25:48|TIMER     ]==|Step 15/30: Density: 0.015 CPU - 0.003 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 15/30: Potential: 0.008 CPU - 0.003 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 15/30: Accelerations (long-range): 0.064 CPU - 0.013 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 15/30: Accelerations (short-range): 0.261 CPU - 0.036 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 15/30: Kick: 0.005 CPU - 0.001 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 15/30: Drift: 0.001 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 15/30: Inputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 15/30: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 15/30: Outputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 15/30: Total Evolution: 0.355 CPU - 0.056 wallclock seconds used.
[09:25:48|STATUS    ]==|ModuleP3M: Begin P3M step 16/30, time_kick:0.064734, time_drift=0.070711.
[09:25:48|STATUS    ]====|ModuleP3M: Compute time step limiters for step 16/30 done.
[09:25:48|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)...
[09:25:48|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done.
[09:25:48|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)...
[09:25:48|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done.
[09:25:48|STATUS    ]====|Kicking particles (using 8 cores)...
[09:25:48|STATUS    ]====|Kicking particles (using 8 cores) done.
[09:25:48|STATUS    ]====|Drifting particles (using 8 cores)...
[09:25:48|STATUS    ]====|Drifting particles (using 8 cores) done.
[09:25:48|STATUS    ]==|ModuleP3M: End P3M step 16/30, time_kick:0.077239, time_drift=0.084370.
[09:25:48|TIMER     ]==|Step 16/30: Density: 0.017 CPU - 0.003 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 16/30: Potential: 0.009 CPU - 0.003 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 16/30: Accelerations (long-range): 0.065 CPU - 0.012 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 16/30: Accelerations (short-range): 0.259 CPU - 0.035 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 16/30: Kick: 0.005 CPU - 0.001 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 16/30: Drift: 0.001 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 16/30: Inputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 16/30: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 16/30: Outputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 16/30: Total Evolution: 0.356 CPU - 0.055 wallclock seconds used.
[09:25:48|STATUS    ]==|ModuleP3M: Begin P3M step 17/30, time_kick:0.077239, time_drift=0.084370.
[09:25:48|STATUS    ]====|ModuleP3M: Compute time step limiters for step 17/30 done.
[09:25:48|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)...
[09:25:48|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done.
[09:25:48|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)...
[09:25:48|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done.
[09:25:48|STATUS    ]====|Kicking particles (using 8 cores)...
[09:25:48|STATUS    ]====|Kicking particles (using 8 cores) done.
[09:25:48|STATUS    ]====|Drifting particles (using 8 cores)...
[09:25:48|STATUS    ]====|Drifting particles (using 8 cores) done.
[09:25:48|STATUS    ]==|ModuleP3M: End P3M step 17/30, time_kick:0.092159, time_drift=0.100667.
[09:25:48|TIMER     ]==|Step 17/30: Density: 0.014 CPU - 0.003 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 17/30: Potential: 0.008 CPU - 0.002 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 17/30: Accelerations (long-range): 0.064 CPU - 0.013 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 17/30: Accelerations (short-range): 0.259 CPU - 0.036 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 17/30: Kick: 0.006 CPU - 0.001 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 17/30: Drift: 0.001 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 17/30: Inputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 17/30: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 17/30: Outputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:48|TIMER     ]==|Step 17/30: Total Evolution: 0.352 CPU - 0.056 wallclock seconds used.
[09:25:48|STATUS    ]==|ModuleP3M: Begin P3M step 18/30, time_kick:0.092159, time_drift=0.100667.
[09:25:48|STATUS    ]====|ModuleP3M: Compute time step limiters for step 18/30 done.
[09:25:48|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)...
[09:25:49|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done.
[09:25:49|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)...
[09:25:49|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done.
[09:25:49|STATUS    ]====|Kicking particles (using 8 cores)...
[09:25:49|STATUS    ]====|Kicking particles (using 8 cores) done.
[09:25:49|STATUS    ]====|Drifting particles (using 8 cores)...
[09:25:49|STATUS    ]====|Drifting particles (using 8 cores) done.
[09:25:49|STATUS    ]==|ModuleP3M: End P3M step 18/30, time_kick:0.109961, time_drift=0.120112.
[09:25:49|TIMER     ]==|Step 18/30: Density: 0.014 CPU - 0.003 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 18/30: Potential: 0.008 CPU - 0.003 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 18/30: Accelerations (long-range): 0.063 CPU - 0.013 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 18/30: Accelerations (short-range): 0.265 CPU - 0.036 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 18/30: Kick: 0.006 CPU - 0.001 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 18/30: Drift: 0.002 CPU - 0.001 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 18/30: Inputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 18/30: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 18/30: Outputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 18/30: Total Evolution: 0.358 CPU - 0.056 wallclock seconds used.
[09:25:49|STATUS    ]==|ModuleP3M: Begin P3M step 19/30, time_kick:0.109961, time_drift=0.120112.
[09:25:49|STATUS    ]====|ModuleP3M: Compute time step limiters for step 19/30 done.
[09:25:49|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)...
[09:25:49|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done.
[09:25:49|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)...
[09:25:49|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done.
[09:25:49|STATUS    ]====|Kicking particles (using 8 cores)...
[09:25:49|STATUS    ]====|Kicking particles (using 8 cores) done.
[09:25:49|STATUS    ]====|Drifting particles (using 8 cores)...
[09:25:49|STATUS    ]====|Drifting particles (using 8 cores) done.
[09:25:49|STATUS    ]==|ModuleP3M: End P3M step 19/30, time_kick:0.131201, time_drift=0.143314.
[09:25:49|TIMER     ]==|Step 19/30: Density: 0.017 CPU - 0.003 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 19/30: Potential: 0.009 CPU - 0.002 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 19/30: Accelerations (long-range): 0.064 CPU - 0.013 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 19/30: Accelerations (short-range): 0.267 CPU - 0.037 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 19/30: Kick: 0.006 CPU - 0.001 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 19/30: Drift: 0.001 CPU - 0.000 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 19/30: Inputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 19/30: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 19/30: Outputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 19/30: Total Evolution: 0.364 CPU - 0.057 wallclock seconds used.
[09:25:49|STATUS    ]==|ModuleP3M: Begin P3M step 20/30, time_kick:0.131201, time_drift=0.143314.
[09:25:49|STATUS    ]====|ModuleP3M: Compute time step limiters for step 20/30 done.
[09:25:49|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)...
[09:25:49|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done.
[09:25:49|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)...
[09:25:49|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done.
[09:25:49|STATUS    ]====|Kicking particles (using 8 cores)...
[09:25:49|STATUS    ]====|Kicking particles (using 8 cores) done.
[09:25:49|STATUS    ]====|Drifting particles (using 8 cores)...
[09:25:49|STATUS    ]====|Drifting particles (using 8 cores) done.
[09:25:49|STATUS    ]==|ModuleP3M: End P3M step 20/30, time_kick:0.156545, time_drift=0.170998.
[09:25:49|TIMER     ]==|Step 20/30: Density: 0.016 CPU - 0.003 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 20/30: Potential: 0.008 CPU - 0.002 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 20/30: Accelerations (long-range): 0.063 CPU - 0.013 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 20/30: Accelerations (short-range): 0.269 CPU - 0.036 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 20/30: Kick: 0.006 CPU - 0.001 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 20/30: Drift: 0.001 CPU - 0.000 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 20/30: Inputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 20/30: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 20/30: Outputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 20/30: Total Evolution: 0.363 CPU - 0.056 wallclock seconds used.
[09:25:49|STATUS    ]==|ModuleP3M: Begin P3M step 21/30, time_kick:0.156545, time_drift=0.170998.
[09:25:49|STATUS    ]====|ModuleP3M: Compute time step limiters for step 21/30 done.
[09:25:49|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)...
[09:25:49|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done.
[09:25:49|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)...
[09:25:49|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done.
[09:25:49|STATUS    ]====|Kicking particles (using 8 cores)...
[09:25:49|STATUS    ]====|Kicking particles (using 8 cores) done.
[09:25:49|STATUS    ]====|Drifting particles (using 8 cores)...
[09:25:49|STATUS    ]====|Drifting particles (using 8 cores) done.
[09:25:49|STATUS    ]==|ModuleP3M: End P3M step 21/30, time_kick:0.186784, time_drift=0.204029.
[09:25:49|TIMER     ]==|Step 21/30: Density: 0.016 CPU - 0.003 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 21/30: Potential: 0.009 CPU - 0.002 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 21/30: Accelerations (long-range): 0.065 CPU - 0.013 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 21/30: Accelerations (short-range): 0.275 CPU - 0.037 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 21/30: Kick: 0.006 CPU - 0.001 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 21/30: Drift: 0.001 CPU - 0.000 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 21/30: Inputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 21/30: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 21/30: Outputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 21/30: Total Evolution: 0.371 CPU - 0.057 wallclock seconds used.
[09:25:49|STATUS    ]==|ModuleP3M: Begin P3M step 22/30, time_kick:0.186784, time_drift=0.204029.
[09:25:49|STATUS    ]====|ModuleP3M: Compute time step limiters for step 22/30 done.
[09:25:49|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)...
[09:25:49|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done.
[09:25:49|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)...
[09:25:49|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done.
[09:25:49|STATUS    ]====|Kicking particles (using 8 cores)...
[09:25:49|STATUS    ]====|Kicking particles (using 8 cores) done.
[09:25:49|STATUS    ]====|Drifting particles (using 8 cores)...
[09:25:49|STATUS    ]====|Drifting particles (using 8 cores) done.
[09:25:49|STATUS    ]==|ModuleP3M: End P3M step 22/30, time_kick:0.222865, time_drift=0.243440.
[09:25:49|TIMER     ]==|Step 22/30: Density: 0.018 CPU - 0.003 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 22/30: Potential: 0.009 CPU - 0.003 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 22/30: Accelerations (long-range): 0.065 CPU - 0.012 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 22/30: Accelerations (short-range): 0.274 CPU - 0.038 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 22/30: Kick: 0.006 CPU - 0.001 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 22/30: Drift: 0.001 CPU - 0.001 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 22/30: Inputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 22/30: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 22/30: Outputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 22/30: Total Evolution: 0.372 CPU - 0.057 wallclock seconds used.
[09:25:49|STATUS    ]==|ModuleP3M: Begin P3M step 23/30, time_kick:0.222865, time_drift=0.243440.
[09:25:49|STATUS    ]====|ModuleP3M: Compute time step limiters for step 23/30 done.
[09:25:49|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)...
[09:25:49|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done.
[09:25:49|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)...
[09:25:49|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done.
[09:25:49|STATUS    ]====|Kicking particles (using 8 cores)...
[09:25:49|STATUS    ]====|Kicking particles (using 8 cores) done.
[09:25:49|STATUS    ]====|Drifting particles (using 8 cores)...
[09:25:49|STATUS    ]====|Drifting particles (using 8 cores) done.
[09:25:49|STATUS    ]==|ModuleP3M: End P3M step 23/30, time_kick:0.265915, time_drift=0.290464.
[09:25:49|TIMER     ]==|Step 23/30: Density: 0.015 CPU - 0.003 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 23/30: Potential: 0.009 CPU - 0.002 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 23/30: Accelerations (long-range): 0.063 CPU - 0.013 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 23/30: Accelerations (short-range): 0.286 CPU - 0.040 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 23/30: Kick: 0.006 CPU - 0.001 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 23/30: Drift: 0.001 CPU - 0.001 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 23/30: Inputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 23/30: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 23/30: Outputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 23/30: Total Evolution: 0.381 CPU - 0.060 wallclock seconds used.
[09:25:49|STATUS    ]==|ModuleP3M: Begin P3M step 24/30, time_kick:0.265915, time_drift=0.290464.
[09:25:49|STATUS    ]====|ModuleP3M: Compute time step limiters for step 24/30 done.
[09:25:49|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)...
[09:25:49|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done.
[09:25:49|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)...
[09:25:49|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done.
[09:25:49|STATUS    ]====|Kicking particles (using 8 cores)...
[09:25:49|STATUS    ]====|Kicking particles (using 8 cores) done.
[09:25:49|STATUS    ]====|Drifting particles (using 8 cores)...
[09:25:49|STATUS    ]====|Drifting particles (using 8 cores) done.
[09:25:49|STATUS    ]==|ModuleP3M: End P3M step 24/30, time_kick:0.317281, time_drift=0.346572.
[09:25:49|TIMER     ]==|Step 24/30: Density: 0.015 CPU - 0.003 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 24/30: Potential: 0.009 CPU - 0.003 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 24/30: Accelerations (long-range): 0.061 CPU - 0.014 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 24/30: Accelerations (short-range): 0.266 CPU - 0.043 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 24/30: Kick: 0.006 CPU - 0.002 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 24/30: Drift: 0.001 CPU - 0.003 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 24/30: Inputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 24/30: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 24/30: Outputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 24/30: Total Evolution: 0.358 CPU - 0.066 wallclock seconds used.
[09:25:49|STATUS    ]==|ModuleP3M: Begin P3M step 25/30, time_kick:0.317281, time_drift=0.346572.
[09:25:49|STATUS    ]====|ModuleP3M: Compute time step limiters for step 25/30 done.
[09:25:49|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)...
[09:25:49|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done.
[09:25:49|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)...
[09:25:49|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done.
[09:25:49|STATUS    ]====|Kicking particles (using 8 cores)...
[09:25:49|STATUS    ]====|Kicking particles (using 8 cores) done.
[09:25:49|STATUS    ]====|Drifting particles (using 8 cores)...
[09:25:49|STATUS    ]====|Drifting particles (using 8 cores) done.
[09:25:49|STATUS    ]==|ModuleP3M: End P3M step 25/30, time_kick:0.378569, time_drift=0.413519.
[09:25:49|TIMER     ]==|Step 25/30: Density: 0.016 CPU - 0.003 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 25/30: Potential: 0.008 CPU - 0.002 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 25/30: Accelerations (long-range): 0.065 CPU - 0.012 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 25/30: Accelerations (short-range): 0.304 CPU - 0.046 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 25/30: Kick: 0.006 CPU - 0.001 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 25/30: Drift: 0.002 CPU - 0.001 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 25/30: Inputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 25/30: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 25/30: Outputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 25/30: Total Evolution: 0.401 CPU - 0.065 wallclock seconds used.
[09:25:49|STATUS    ]==|ModuleP3M: Begin P3M step 26/30, time_kick:0.378569, time_drift=0.413519.
[09:25:49|STATUS    ]====|ModuleP3M: Compute time step limiters for step 26/30 done.
[09:25:49|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)...
[09:25:49|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done.
[09:25:49|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)...
[09:25:49|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done.
[09:25:49|STATUS    ]====|Kicking particles (using 8 cores)...
[09:25:49|STATUS    ]====|Kicking particles (using 8 cores) done.
[09:25:49|STATUS    ]====|Drifting particles (using 8 cores)...
[09:25:49|STATUS    ]====|Drifting particles (using 8 cores) done.
[09:25:49|STATUS    ]==|ModuleP3M: End P3M step 26/30, time_kick:0.451695, time_drift=0.493396.
[09:25:49|TIMER     ]==|Step 26/30: Density: 0.018 CPU - 0.003 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 26/30: Potential: 0.008 CPU - 0.002 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 26/30: Accelerations (long-range): 0.063 CPU - 0.013 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 26/30: Accelerations (short-range): 0.320 CPU - 0.050 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 26/30: Kick: 0.006 CPU - 0.001 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 26/30: Drift: 0.001 CPU - 0.000 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 26/30: Inputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 26/30: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 26/30: Outputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 26/30: Total Evolution: 0.417 CPU - 0.070 wallclock seconds used.
[09:25:49|STATUS    ]==|ModuleP3M: Begin P3M step 27/30, time_kick:0.451695, time_drift=0.493396.
[09:25:49|STATUS    ]====|ModuleP3M: Compute time step limiters for step 27/30 done.
[09:25:49|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)...
[09:25:49|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done.
[09:25:49|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)...
[09:25:49|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done.
[09:25:49|STATUS    ]====|Kicking particles (using 8 cores)...
[09:25:49|STATUS    ]====|Kicking particles (using 8 cores) done.
[09:25:49|STATUS    ]====|Drifting particles (using 8 cores)...
[09:25:49|STATUS    ]====|Drifting particles (using 8 cores) done.
[09:25:49|STATUS    ]==|ModuleP3M: End P3M step 27/30, time_kick:0.538948, time_drift=0.588704.
[09:25:49|TIMER     ]==|Step 27/30: Density: 0.019 CPU - 0.003 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 27/30: Potential: 0.009 CPU - 0.002 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 27/30: Accelerations (long-range): 0.062 CPU - 0.012 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 27/30: Accelerations (short-range): 0.342 CPU - 0.055 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 27/30: Kick: 0.005 CPU - 0.001 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 27/30: Drift: 0.001 CPU - 0.001 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 27/30: Inputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 27/30: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 27/30: Outputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:49|TIMER     ]==|Step 27/30: Total Evolution: 0.438 CPU - 0.075 wallclock seconds used.
[09:25:49|STATUS    ]==|ModuleP3M: Begin P3M step 28/30, time_kick:0.538948, time_drift=0.588704.
[09:25:49|STATUS    ]====|ModuleP3M: Compute time step limiters for step 28/30 done.
[09:25:49|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)...
[09:25:49|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done.
[09:25:49|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)...
[09:25:49|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done.
[09:25:49|STATUS    ]====|Kicking particles (using 8 cores)...
[09:25:50|STATUS    ]====|Kicking particles (using 8 cores) done.
[09:25:50|STATUS    ]====|Drifting particles (using 8 cores)...
[09:25:50|STATUS    ]====|Drifting particles (using 8 cores) done.
[09:25:50|STATUS    ]==|ModuleP3M: End P3M step 28/30, time_kick:0.643054, time_drift=0.702422.
[09:25:50|TIMER     ]==|Step 28/30: Density: 0.016 CPU - 0.003 wallclock seconds used.
[09:25:50|TIMER     ]==|Step 28/30: Potential: 0.009 CPU - 0.003 wallclock seconds used.
[09:25:50|TIMER     ]==|Step 28/30: Accelerations (long-range): 0.066 CPU - 0.084 wallclock seconds used.
[09:25:50|TIMER     ]==|Step 28/30: Accelerations (short-range): 0.358 CPU - 0.336 wallclock seconds used.
[09:25:50|TIMER     ]==|Step 28/30: Kick: 0.006 CPU - 0.007 wallclock seconds used.
[09:25:50|TIMER     ]==|Step 28/30: Drift: 0.002 CPU - 0.010 wallclock seconds used.
[09:25:50|TIMER     ]==|Step 28/30: Inputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:50|TIMER     ]==|Step 28/30: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:50|TIMER     ]==|Step 28/30: Outputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:50|TIMER     ]==|Step 28/30: Total Evolution: 0.457 CPU - 0.443 wallclock seconds used.
[09:25:50|STATUS    ]==|ModuleP3M: Begin P3M step 29/30, time_kick:0.643054, time_drift=0.702422.
[09:25:50|STATUS    ]====|ModuleP3M: Compute time step limiters for step 29/30 done.
[09:25:50|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)...
[09:25:50|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done.
[09:25:50|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)...
[09:25:50|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done.
[09:25:50|STATUS    ]====|Kicking particles (using 8 cores)...
[09:25:50|STATUS    ]====|Kicking particles (using 8 cores) done.
[09:25:50|STATUS    ]====|Drifting particles (using 8 cores)...
[09:25:50|STATUS    ]====|Drifting particles (using 8 cores) done.
[09:25:50|STATUS    ]==|ModuleP3M: End P3M step 29/30, time_kick:0.767270, time_drift=0.838106.
[09:25:50|TIMER     ]==|Step 29/30: Density: 0.008 CPU - 0.006 wallclock seconds used.
[09:25:50|TIMER     ]==|Step 29/30: Potential: 0.009 CPU - 0.004 wallclock seconds used.
[09:25:50|TIMER     ]==|Step 29/30: Accelerations (long-range): 0.058 CPU - 0.019 wallclock seconds used.
[09:25:50|TIMER     ]==|Step 29/30: Accelerations (short-range): 0.358 CPU - 0.099 wallclock seconds used.
[09:25:50|TIMER     ]==|Step 29/30: Kick: 0.006 CPU - 0.003 wallclock seconds used.
[09:25:50|TIMER     ]==|Step 29/30: Drift: 0.001 CPU - 0.002 wallclock seconds used.
[09:25:50|TIMER     ]==|Step 29/30: Inputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:50|TIMER     ]==|Step 29/30: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:50|TIMER     ]==|Step 29/30: Outputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:50|TIMER     ]==|Step 29/30: Total Evolution: 0.439 CPU - 0.134 wallclock seconds used.
[09:25:50|STATUS    ]==|ModuleP3M: Begin P3M step 30/30, time_kick:0.767270, time_drift=0.838106.
[09:25:50|STATUS    ]====|ModuleP3M: Compute time step limiters for step 30/30 done.
[09:25:50|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)...
[09:25:50|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done.
[09:25:50|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)...
[09:25:50|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done.
[09:25:50|STATUS    ]====|Kicking particles (using 8 cores)...
[09:25:50|STATUS    ]====|Kicking particles (using 8 cores) done.
[09:25:50|STATUS    ]====|Drifting particles (using 8 cores)...
[09:25:50|STATUS    ]====|Drifting particles (using 8 cores) done.
[09:25:50|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)...
[09:25:50|STATUS    ]====|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done.
[09:25:50|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores)...
[09:25:50|STATUS    ]====|Getting gravitational potential, periodic boundary conditions (using 8 cores) done.
[09:25:50|STATUS    ]====|Kicking particles (using 8 cores)...
[09:25:50|STATUS    ]====|Kicking particles (using 8 cores) done.
[09:25:50|STATUS    ]==|ModuleP3M: End P3M step 30/30, time_kick:1.000000, time_drift=1.000000.
[09:25:50|TIMER     ]==|Step 30/30: Density: 0.015 CPU - 0.008 wallclock seconds used.
[09:25:50|TIMER     ]==|Step 30/30: Potential: 0.018 CPU - 0.011 wallclock seconds used.
[09:25:50|TIMER     ]==|Step 30/30: Accelerations (long-range): 0.125 CPU - 0.072 wallclock seconds used.
[09:25:50|TIMER     ]==|Step 30/30: Accelerations (short-range): 0.810 CPU - 0.367 wallclock seconds used.
[09:25:50|TIMER     ]==|Step 30/30: Kick: 0.013 CPU - 0.009 wallclock seconds used.
[09:25:50|TIMER     ]==|Step 30/30: Drift: 0.001 CPU - 0.001 wallclock seconds used.
[09:25:50|TIMER     ]==|Step 30/30: Inputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:50|TIMER     ]==|Step 30/30: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:50|TIMER     ]==|Step 30/30: Outputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:50|TIMER     ]==|Step 30/30: Total Evolution: 0.982 CPU - 0.468 wallclock seconds used.
[09:25:50|TIMER     ]==|Box: Density: 0.401 CPU - 0.090 wallclock seconds used.
[09:25:50|TIMER     ]==|Box: Potential: 0.268 CPU - 0.091 wallclock seconds used.
[09:25:50|TIMER     ]==|Box: Accelerations (long-range): 1.935 CPU - 0.532 wallclock seconds used.
[09:25:50|TIMER     ]==|Box: Accelerations (short-range): 8.537 CPU - 1.970 wallclock seconds used.
[09:25:50|TIMER     ]==|Box: Kick: 0.175 CPU - 0.057 wallclock seconds used.
[09:25:50|TIMER     ]==|Box: Drift: 0.041 CPU - 0.029 wallclock seconds used.
[09:25:50|TIMER     ]==|Box: Inputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:50|TIMER     ]==|Box: Diagnostic: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:50|TIMER     ]==|Box: Outputs: 0.000 CPU - 0.000 wallclock seconds used.
[09:25:50|TIMER     ]==|Box: Total Evolution: 11.358 CPU - 2.768 wallclock seconds used.
[09:25:50|MODULE    ]|ModuleP3M: Evolving with P3M done.
[09:25:50|MODULE    ]|ModulePMCOLA: Computing outputs...
[09:25:50|STATUS    ]==|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1)...
[09:25:50|STATUS    ]==|Getting density contrast (using 8 cores and 8 arrays, parallel routine 1) done.
[09:25:50|STATUS    ]==|Writing field to '/Users/hoellinger/WIP3M/notebook4/p3m_nsteps30_final_density_p3m.h5'...
[09:25:50|STATUS    ]==|Writing field to '/Users/hoellinger/WIP3M/notebook4/p3m_nsteps30_final_density_p3m.h5' done.
[09:25:50|STATUS    ]==|Writing header in '/Users/hoellinger/WIP3M/notebook4/p3m_nsteps30_p3m_snapshot.gadget3'...
[09:25:50|STATUS    ]==|Writing header in '/Users/hoellinger/WIP3M/notebook4/p3m_nsteps30_p3m_snapshot.gadget3' done.
[09:25:50|STATUS    ]==|Writing snapshot in '/Users/hoellinger/WIP3M/notebook4/p3m_nsteps30_p3m_snapshot.gadget3' (32768 particles)...
[09:25:50|STATUS    ]====|Writing block: 'POS '...
[09:25:50|STATUS    ]====|Writing block: 'POS ' done.
[09:25:50|STATUS    ]====|Writing block: 'VEL '...
[09:25:50|STATUS    ]====|Writing block: 'VEL ' done.
[09:25:50|STATUS    ]====|Writing block: 'ID  '...
[09:25:50|STATUS    ]====|Writing block: 'ID  ' done.
[09:25:50|STATUS    ]==|Writing snapshot in '/Users/hoellinger/WIP3M/notebook4/p3m_nsteps30_p3m_snapshot.gadget3' done.
[09:25:50|MODULE    ]|ModulePMCOLA: Computing outputs done.
[09:25:50|TIMER     ]|PMCOLA output: 0.019 CPU - 0.005 wallclock seconds used.
[09:25:50|TIMER     ]|ModulePMCOLA: 11.618 CPU - 3.025 wallclock seconds used.
[09:25:50|TIMER     ]|Simbelmynë: 11.667 CPU - 3.042 wallclock seconds used.
[09:25:50|INFO      ]|Everything done successfully, exiting.
In [12]:
plot_timestepping_diagnostics(
    log_path=OutputTimestepsLog,
    aiDrift=aiDrift,
    TimeStepDistribution=TimeStepDistribution,
    nsteps=nsteps,
    save_path=wd+"time_step_diagnostics.pdf",
    show=False,
)
a = aiDrift
plt.loglog(a, 0.1 * 0.031 * np.ones_like(a) / a)
plt.loglog(a, 1e-2 * np.ones_like(a))
fac_p3m_concept = 0.14
lambda_p3m = lambda x, eta: eta * np.maximum(0.1 * 0.031 / x, 0.01)/fac_p3m_concept
approx_P3Mlim = lambda_p3m(a, fac_p3m_concept)
plt.loglog(a, approx_P3Mlim, color="black")
approx_P3Mlim_eta01 = lambda_p3m(a, 0.1)
plt.loglog(a, approx_P3Mlim_eta01, color="red")
plt.show()
[09:25:50|INFO      ]|(wip3m.plot_utils) Plotting timestep limiters from /Users/hoellinger/WIP3M/notebook4/timesteps_log.txt...
[09:25:51|INFO      ]==|(wip3m.plot_utils) Figure saved to: /Users/hoellinger/Library/CloudStorage/Dropbox/travail/these/science/code/simbelmyne/simbelmyne2025/WIP_P3M/results/notebook4/time_step_diagnostics.pdf
[09:25:51|INFO      ]|(wip3m.plot_utils) Plotting timestep limiters from /Users/hoellinger/WIP3M/notebook4/timesteps_log.txt done.
No description has been provided for this image
In [ ]:

In [ ]: