All files
This file contains bidirectional Unicode text that may be interpreted or compiled differently than what appears below. To review, open the file in an editor that reveals hidden Unicode characters.
Learn more about bidirectional Unicode characters
#============================================================================== | |
# BBH: TwoPunctures - Mclachlan | |
#============================================================================== | |
#------------------------------------------------------------------------------ | |
# Cactus parameters: | |
#------------------------------------------------------------------------------ | |
Cactus::cctk_run_title = "BBH" | |
Cactus::cctk_full_warnings = "yes" | |
#Cactus::terminate = "never" | |
#Cactus::terminate = "time" | |
#Cactus::cctk_final_time = 1500.0 | |
#Cactus::terminate = "iteration" | |
#Cactus::cctk_itlast = 0 | |
#Cactus::cctk_itlast = 256 | |
Cactus::terminate="runtime" | |
Cactus::max_runtime=500 | |
#------------------------------------------------------------------------------ | |
# Activate all necessary thorns: | |
#------------------------------------------------------------------------------ | |
ActiveThorns = "Boundary CartGrid3D CoordBase Fortran InitBase IOUtil LocalReduce SymBase Time" | |
ActiveThorns = "AEILocalInterp LocalInterp" | |
ActiveThorns = "MoL ReflectionSymmetry Slab SpaceMask SphericalSurface" | |
ActiveThorns = "Carpet CarpetInterp CarpetIOASCII CarpetIOHDF5 CarpetIOScalar CarpetLib CarpetIOBasic CarpetReduce CarpetRegrid2 CarpetSlab CarpetTracker CarpetMask LoopControl SystemTopology" | |
ActiveThorns = "NaNChecker TerminationTrigger TimerReport" | |
ActiveThorns = "ADMbase ADMcoupling ADMmacros CoordGauge StaticConformal" | |
ActiveThorns = "PunctureTracker" | |
ActiveThorns = "TmunuBase" | |
ActiveThorns = "QuasiLocalMeasures" | |
ActiveThorns = "BLAS LAPACK GSL HDF5" | |
ActiveThorns = "TwoPunctures" | |
ActiveThorns = "SummationByParts" | |
ActiveThorns = "GenericFD NewRad" | |
ActiveThorns = "ML_BSSN ML_BSSN_Helper ML_ADMConstraints" | |
ActiveThorns = "Dissipation" | |
ActiveThorns = "AHFinderDirect" | |
ActiveThorns = "WeylScal4 Multipole" | |
ActiveThorns = "SystemStatistics" | |
#------------------------------------------------------------------------------ | |
# Diagnostic parameters: | |
#------------------------------------------------------------------------------ | |
AHFinderDirect::verbose_level = "algorithm details" | |
Carpet::output_timers_every = 1024 | |
Carpet::storage_verbose = "no" | |
#Carpet::timers_verbose = "no" | |
Carpet::verbose = "no" | |
#Carpet::verbose = "yes" # only for Initial Data | |
Carpet::veryverbose = "no" | |
Carpet::grid_structure_filename = "carpet-grid-structure" | |
Carpet::grid_coordinates_filename = "carpet-grid-coordinates" | |
CarpetLib::output_bboxes = "no" | |
CarpetLib::print_memstats_every = 1024 | |
#CarpetLib::print_timestats_every = 1024 | |
CarpetMask::verbose = "yes" | |
CarpetReduce::verbose = "no" | |
CarpetRegrid2::verbose = "yes" | |
#CarpetRegrid2::veryverbose = "yes" | |
CarpetTracker::verbose = "yes" | |
Dissipation::verbose = "no" | |
NaNChecker::verbose = "all" | |
TimerReport::out_every = 1024 | |
TimerReport::out_filename = "TimerReport" | |
#TimerReport::output_all_timers = "yes" | |
#TimerReport::output_all_timers_together = "yes" | |
#TimerReport::output_all_timers_readable = "yes" | |
#TimerReport::before_checkpoint = "yes" | |
TimerReport::n_top_timers = 40 | |
TwoPunctures::verbose = "yes" | |
PunctureTracker::verbose = "yes" | |
QuasiLocalMeasures::verbose = "yes" | |
SphericalSurface::verbose = "yes" | |
#------------------------------------------------------------------------------ | |
# Utility parameters: | |
#------------------------------------------------------------------------------ | |
#NaNChecker::check_every = 16 | |
NaNChecker::check_every = 1 | |
NaNChecker::check_vars = " | |
ML_BSSN::ML_log_confac | |
ML_BSSN::ML_metric | |
ML_BSSN::ML_trace_curv | |
ML_BSSN::ML_curv | |
ML_BSSN::ML_Gamma | |
ML_BSSN::ML_lapse | |
ML_BSSN::ML_shift | |
ML_BSSN::ML_dtlapse | |
ML_BSSN::ML_dtshift | |
ADMBase::curv | |
ADMBase::metric | |
ADMBase::lapse | |
ADMBase::shift | |
ADMBase::dtlapse | |
ADMBase::dtshift | |
" | |
NaNChecker::action_if_found = "terminate" | |
#NaNChecker::action_if_found = "abort" | |
#NaNChecker::action_if_found = "just warn" #"terminate", "just warn", "abort" | |
#NaNChecker::check_after=0 | |
#TerminationTrigger::max_walltime = 0.0 # hours | |
TerminationTrigger::max_walltime = 48.0 # hours | |
TerminationTrigger::on_remaining_walltime = 10.0 # minutes | |
TerminationTrigger::termination_from_file = "yes" | |
TerminationTrigger::create_termination_file = "yes" | |
TerminationTrigger::termination_file = "../TERMINATE" | |
#------------------------------------------------------------------------------ | |
# Run parameters: | |
#------------------------------------------------------------------------------ | |
#------ | |
# Grid: | |
#------ | |
Time::dtfac = 0.25 | |
MoL::ODE_Method = "rk4" | |
MoL::MoL_Intermediate_Steps = 4 | |
MoL::MoL_Num_Scratch_Levels = 1 | |
CartGrid3D::type = "coordbase" | |
#CartGrid3D::domain = "full" | |
#CartGrid3D::avoid_origin = "no" | |
CoordBase::domainsize = "minmax" | |
CoordBase::spacing = "gridspacing" # "gridspacing" or "numcells" | |
CoordBase::xmin =-120.00 | |
CoordBase::ymin =-120.00 | |
CoordBase::zmin = 0.00 | |
CoordBase::xmax = 120.00 | |
CoordBase::ymax = 120.00 | |
CoordBase::zmax = 120.00 | |
CoordBase::dx = 1.25 # dx or ncells_x | |
CoordBase::dy = 1.25 # dy or ncells_y | |
CoordBase::dz = 1.25 # dz or ncells_z | |
CoordBase::boundary_size_x_lower = 3 | |
CoordBase::boundary_size_y_lower = 3 | |
CoordBase::boundary_size_z_lower = 3 | |
CoordBase::boundary_size_x_upper = 3 | |
CoordBase::boundary_size_y_upper = 3 | |
CoordBase::boundary_size_z_upper = 3 | |
CoordBase::boundary_shiftout_x_lower = 0 | |
CoordBase::boundary_shiftout_y_lower = 0 | |
CoordBase::boundary_shiftout_z_lower = 1 | |
CoordBase::boundary_shiftout_x_upper = 0 | |
CoordBase::boundary_shiftout_y_upper = 0 | |
CoordBase::boundary_shiftout_z_upper = 0 | |
Driver::ghost_size = 3 | |
ReflectionSymmetry::reflection_x = "no" | |
ReflectionSymmetry::reflection_y = "no" | |
ReflectionSymmetry::reflection_z = "yes" | |
ReflectionSymmetry::avoid_origin_x = "no" | |
ReflectionSymmetry::avoid_origin_y = "no" | |
ReflectionSymmetry::avoid_origin_z = "no" | |
# General Carpet parameters: | |
Carpet::domain_from_coordbase = "yes" | |
Carpet::enable_all_storage = "no" | |
Carpet::use_buffer_zones = "yes" | |
Carpet::schedule_barriers = "no" | |
Carpet::poison_new_timelevels = "yes" | |
Carpet::check_for_poison = "no" | |
#Carpet::poison_value = 113 # git version only! | |
Carpet::init_3_timelevels = "no" | |
Carpet::init_fill_timelevels = "yes" | |
CarpetLib::poison_new_memory = "yes" | |
CarpetLib::poison_value = 114 | |
CarpetLib::check_bboxes = "no" | |
CarpetLib::interleave_communications = "yes" | |
#CarpetLib::vary_tags = "yes" # git version only! | |
CarpetLib::combine_sends = "yes" | |
#CarpetLib::reduce_mpi_waitall = "yes" # git version only! | |
CarpetInterp::tree_search = "yes" | |
CarpetInterp::check_tree_search = "no" | |
CarpetRegrid2::freeze_unaligned_levels = "yes" | |
#CarpetRegrid2::snap_to_coarse = "yes" | |
# System specific Carpet parameters: | |
Carpet::time_refinement_factors = "[1, 1, 2, 4, 8, 16, 32, 64, 128, 256]" | |
Carpet::max_refinement_levels = 9 | |
Carpet::prolongation_order_space = 5 | |
Carpet::prolongation_order_time = 2 | |
CarpetRegrid2::regrid_every = 32 | |
CarpetRegrid2::num_centres = 2 | |
CarpetRegrid2::num_levels_1 = 9 | |
CarpetRegrid2::position_x_1 = +3.0 | |
CarpetRegrid2::radius_1[ 1] = 64.0 | |
CarpetRegrid2::radius_1[ 2] = 16.0 | |
CarpetRegrid2::radius_1[ 3] = 8.0 | |
CarpetRegrid2::radius_1[ 4] = 4.0 | |
CarpetRegrid2::radius_1[ 5] = 3.0 | |
CarpetRegrid2::radius_1[ 6] = 2.0 | |
CarpetRegrid2::radius_1[ 7] = 1.0 | |
CarpetRegrid2::radius_1[ 8] = 0.5 | |
CarpetRegrid2::movement_threshold_1 = 0.16 | |
CarpetRegrid2::num_levels_2 = 8 | |
CarpetRegrid2::position_x_2 = -1.0 | |
CarpetRegrid2::radius_2[ 1] = 64.0 | |
CarpetRegrid2::radius_2[ 2] = 16.0 | |
CarpetRegrid2::radius_2[ 3] = 8.0 | |
CarpetRegrid2::radius_2[ 4] = 4.0 | |
CarpetRegrid2::radius_2[ 5] = 3.0 | |
CarpetRegrid2::radius_2[ 6] = 2.0 | |
CarpetRegrid2::radius_2[ 7] = 1.0 | |
CarpetRegrid2::radius_2[ 8] = 0.5 | |
CarpetRegrid2::movement_threshold_2 = 0.16 | |
#CarpetMask::excluded_surface [0] = 0 | |
#CarpetMask::excluded_surface_factor[0] = 1.0 | |
#CarpetMask::excluded_surface [1] = 1 | |
#CarpetMask::excluded_surface_factor[1] = 1.0 | |
#CarpetMask::excluded_surface [2] = 2 | |
#CarpetMask::excluded_surface_factor[2] = 1.0 | |
CarpetTracker::surface[0] = 0 | |
CarpetTracker::surface[1] = 1 | |
#------ | |
# MODEL: | |
#------ | |
ADMBase::metric_type = "physical" | |
ADMBase::initial_data = "twopunctures" | |
ADMBase::initial_lapse = "twopunctures-averaged" | |
ADMBase::initial_shift = "zero" | |
ADMBase::initial_dtlapse = "zero" | |
ADMBase::initial_dtshift = "zero" | |
# needed for AHFinderDirect: | |
ADMBase::metric_timelevels = 3 | |
#TwoPunctures::keep_u_around = "yes" | |
TwoPunctures::npoints_A = 28 | |
TwoPunctures::npoints_B = 28 | |
TwoPunctures::npoints_phi = 14 | |
TwoPunctures::Newton_tol = 1.e-10 | |
TwoPunctures::grid_setup_method = "evaluation" | |
TwoPunctures::par_b = 3.0 | |
TwoPunctures::give_bare_mass = "no" | |
TwoPunctures::target_m_plus = 0.25 | |
TwoPunctures::target_m_minus = 0.75 | |
TwoPunctures::par_P_plus [1] = +0.13808 | |
TwoPunctures::par_P_minus[1] = -0.13808 | |
TwoPunctures::TP_Tiny = 1.e-10 | |
#---------- | |
# Numerics: | |
#---------- | |
InitBase::initial_data_setup_method = "init_all_levels" | |
ADMMacros::spatial_order = 4 | |
SummationByParts::order = 4 | |
#SpaceMask::use_mask = "yes" | |
#Dissipation::epsdis = 0.01 | |
#Dissipation::extra_dissipation_in_horizons = "yes" | |
#Dissipation::update_ah_every = 16 | |
#Dissipation::ah_slope = 0.2 | |
#Dissipation::ah_max_epsdis=0.1 | |
#Dissipation::surface_number[0] = 1 | |
#Dissipation::horizon_number[0] = 1 | |
Dissipation::order = 5 | |
Dissipation::vars = " | |
ML_BSSN::ML_log_confac | |
ML_BSSN::ML_metric | |
ML_BSSN::ML_curv | |
ML_BSSN::ML_trace_curv | |
ML_BSSN::ML_Gamma | |
ML_BSSN::ML_lapse | |
ML_BSSN::ML_shift | |
ML_BSSN::ML_dtlapse | |
ML_BSSN::ML_dtshift | |
" | |
SphericalSurface::nsurfaces = 3 | |
SphericalSurface::maxntheta = 39 | |
SphericalSurface::maxnphi = 76 | |
SphericalSurface::ntheta [0] = 39 | |
SphericalSurface::nphi [0] = 76 | |
SphericalSurface::nghoststheta[0] = 2 | |
SphericalSurface::nghostsphi [0] = 2 | |
SphericalSurface::ntheta [1] = 39 | |
SphericalSurface::nphi [1] = 76 | |
SphericalSurface::nghoststheta[1] = 2 | |
SphericalSurface::nghostsphi [1] = 2 | |
SphericalSurface::ntheta [2] = 39 | |
SphericalSurface::nphi [2] = 76 | |
SphericalSurface::nghoststheta[2] = 2 | |
SphericalSurface::nghostsphi [2] = 2 | |
#----------- | |
# Evolution: | |
#----------- | |
ADMBase::evolution_method = "ML_BSSN" | |
ADMBase::lapse_evolution_method = "ML_BSSN" | |
ADMBase::shift_evolution_method = "ML_BSSN" | |
ADMBase::dtlapse_evolution_method= "ML_BSSN" | |
ADMBase::dtshift_evolution_method= "ML_BSSN" | |
ML_BSSN::timelevels = 3 | |
ML_BSSN::harmonicN = 1 # 1+log | |
ML_BSSN::harmonicF = 2.0 # 1+log | |
ML_BSSN::ShiftGammaCoeff = 0.75 | |
#ML_BSSN::AlphaDriver = 1.0 | |
ML_BSSN::BetaDriver = 1.0 | |
ML_BSSN::advectLapse = 1.0 | |
ML_BSSN::advectShift = 1.0 | |
ML_BSSN::MinimumLapse = 1.0e-8 | |
ML_BSSN::initial_boundary_condition = "extrapolate-gammas" | |
ML_BSSN::rhs_boundary_condition = "NewRad" | |
Boundary::radpower = 2 | |
ML_BSSN::ML_log_confac_bound = "none" | |
ML_BSSN::ML_metric_bound = "none" | |
ML_BSSN::ML_Gamma_bound = "none" | |
ML_BSSN::ML_trace_curv_bound = "none" | |
ML_BSSN::ML_curv_bound = "none" | |
ML_BSSN::ML_lapse_bound = "none" | |
ML_BSSN::ML_dtlapse_bound = "none" | |
ML_BSSN::ML_shift_bound = "none" | |
ML_BSSN::ML_dtshift_bound = "none" | |
#------------------------------------------------------------------------------ | |
# Output: | |
#------------------------------------------------------------------------------ | |
IO::out_dir = $parfile | |
IO::out_fileinfo = "none" | |
IOBasic::outInfo_every = 1 | |
IOBasic::outInfo_reductions = "maximum" | |
IOBasic::outInfo_vars = " | |
Carpet::physical_time_per_hour | |
SystemStatistics::maxrss_mb | |
ML_ADMConstraints::ML_Ham | |
ML_BSSN::ML_trace_curv | |
" | |
IOScalar::outScalar_every = 32 | |
IOScalar::one_file_per_group = "yes" | |
IOScalar::outScalar_reductions = "minimum maximum average norm1 norm2" | |
IOScalar::outScalar_vars = " | |
ADMBase::lapse | |
ADMBase::shift | |
ADMBase::metric | |
ADMBase::curv | |
ADMBase::dtlapse | |
ADMBase::dtshift | |
ML_ADMConstraints::ML_Ham | |
ML_ADMConstraints::ML_mom | |
ML_BSSN::ML_Ham | |
ML_BSSN::ML_mom | |
SystemStatistics::process_memory_mb{out_every=4} | |
SphericalSurface::sf_radius | |
" | |
IOASCII::one_file_per_group = "yes" | |
IOASCII::output_symmetry_points = "no" | |
#IOASCII::output_ghost_points = "no" #hg version only! | |
IOASCII::out3D_ghosts = "no" | |
#IOASCII::out3D_outer_ghosts = "no" | |
IOASCII::out0D_every = 32 | |
IOASCII::out0D_vars = " | |
Carpet::timing | |
PunctureTracker::pt_loc | |
QuasiLocalMeasures::qlm_scalars | |
SphericalSurface::sf_active | |
SphericalSurface::sf_valid | |
SphericalSurface::sf_info | |
SphericalSurface::sf_radius | |
SphericalSurface::sf_origin | |
SphericalSurface::sf_coordinate_descriptors | |
" | |
#Set these IOASCII options for initial data only: | |
IOASCII::out1D_every = 512000000 | |
IOASCII::out1D_d = "no" | |
IOASCII::out1D_vars = " | |
CarpetReduce::weight | |
ADMBase::lapse | |
ADMBase::metric | |
ADMBase::curv | |
ADMBase::shift | |
ML_BSSN::ML_Ham | |
ML_BSSN::ML_mom | |
ML_ADMConstraints::ML_Ham | |
ML_ADMConstraints::ML_mom | |
" | |
# To draw the AH circunference in the z=0 plane | |
# set these IOASCII options (for evolution only): | |
# NOTE: it is not possible yet to output array lines | |
# as set below. | |
#IOASCII::out1D_every = 32 | |
#IOASCII::out1D_x = "no" | |
#IOASCII::out1D_z = "no" | |
#IOASCII::out1D_d = "no" | |
#IOASCII::out1D_yline_xi = 19 | |
#IOASCII::out1D_yline_zi = 0 | |
#IOASCII::out1D_vars = " | |
# SphericalSurface::sf_radius | |
#" | |
IOASCII::out2D_every = 512000000 | |
IOASCII::out2D_vars = " | |
ML_ADMConstraints::ML_Ham | |
ML_ADMConstraints::ML_mom | |
SphericalSurface::sf_radius{out_every=32} | |
" | |
# ADMBase::lapse | |
# ADMBase::metric | |
# ADMBase::curv | |
# ML_BSSN::ML_Ham | |
# ML_BSSN::ML_mom | |
IOHDF5::one_file_per_group = "yes" | |
IOHDF5::open_one_input_file_at_a_time = "yes" | |
IOHDF5::out2D_every = 512 | |
IOHDF5::out2D_xy = "yes" | |
IOHDF5::out2D_xz = "no" | |
IOHDF5::out2D_yz = "no" | |
IOHDF5::out2D_xyplane_z = 0.0 | |
IOHDF5::out2D_vars = " | |
CarpetReduce::weight | |
Grid::coordinates | |
ADMBase::lapse | |
ADMBase::metric | |
ADMBase::curv | |
ML_ADMConstraints::ML_Ham | |
ML_ADMConstraints::ML_Mom | |
WeylScal4::Psi4r | |
WeylScal4::Psi4i | |
" | |
#IOHDF5::out3D_ghosts = "no" | |
#IOHDF5::out3D_outer_ghosts = "no" | |
IOHDF5::out_every = 512000000 | |
#IOHDF5::out_every = 256 | |
IOHDF5::out_vars = " | |
CarpetReduce::weight | |
ADMBase::lapse | |
ML_ADMConstraints::ML_Ham | |
ML_ADMConstraints::ML_Mom | |
" | |
# Grid::coordinates | |
# ADMBase::metric | |
# ML_BSSN::ML_Ham | |
# ML_BSSN::ML_mom | |
#------------------------------------------------------------------------------ | |
# Analysis: | |
#------------------------------------------------------------------------------ | |
AHFinderDirect::find_every = 32 | |
#AHFinderDirect::run_at_CCTK_ANALYSIS = "yes" | |
#AHFinderDirect::run_at_CCTK_POSTSTEP = "no" | |
AHFinderDirect::run_at_CCTK_POST_RECOVER_VARIABLES = "no" | |
AHFinderDirect::move_origins = "yes" | |
AHFinderDirect::reshape_while_moving = "yes" | |
AHFinderDirect::predict_origin_movement = "yes" | |
# Hermite to order 3 to avoid discontinuities in the metric spatial derivatives: | |
#AHFinderDirect::geometry_interpolator_name = "Hermite polynomial interpolation" | |
#AHFinderDirect::geometry_interpolator_pars = "order=3" | |
#AHFinderDirect::surface_interpolator_name = "Hermite polynomial interpolation" | |
#AHFinderDirect::surface_interpolator_pars = "order=3" | |
AHFinderDirect::geometry_interpolator_name = "Lagrange polynomial interpolation" | |
AHFinderDirect::geometry_interpolator_pars = "order=4" | |
AHFinderDirect::surface_interpolator_name = "Lagrange polynomial interpolation" | |
AHFinderDirect::surface_interpolator_pars = "order=4" | |
AHFinderDirect::output_h_every = 0 | |
AHFinderDirect::N_horizons = 3 | |
AHFinderDirect::origin_x [1] = +3.0 | |
AHFinderDirect::initial_guess__coord_sphere__x_center[1] = +3.0 | |
AHFinderDirect::initial_guess__coord_sphere__radius [1] = 0.375 | |
AHFinderDirect::which_surface_to_store_info [1] = 0 | |
AHFinderDirect::set_mask_for_individual_horizon [1] = no | |
AHFinderDirect::reset_horizon_after_not_finding [1] = no | |
AHFinderDirect::track_origin_from_grid_scalar [1] = yes | |
AHFinderDirect::track_origin_source_x [1] = "PunctureTracker::pt_loc_x[0]" | |
AHFinderDirect::track_origin_source_y [1] = "PunctureTracker::pt_loc_y[0]" | |
AHFinderDirect::track_origin_source_z [1] = "PunctureTracker::pt_loc_z[0]" | |
AHFinderDirect::max_allowable_horizon_radius [1] = 3 | |
AHFinderDirect::origin_x [2] = -1.0 | |
AHFinderDirect::initial_guess__coord_sphere__x_center[2] = -1.0 | |
AHFinderDirect::initial_guess__coord_sphere__radius [2] = 0.125 | |
AHFinderDirect::which_surface_to_store_info [2] = 1 | |
AHFinderDirect::set_mask_for_individual_horizon [2] = no | |
AHFinderDirect::reset_horizon_after_not_finding [2] = no | |
AHFinderDirect::track_origin_from_grid_scalar [2] = yes | |
AHFinderDirect::track_origin_source_x [2] = "PunctureTracker::pt_loc_x[1]" | |
AHFinderDirect::track_origin_source_y [2] = "PunctureTracker::pt_loc_y[1]" | |
AHFinderDirect::track_origin_source_z [2] = "PunctureTracker::pt_loc_z[1]" | |
AHFinderDirect::max_allowable_horizon_radius [2] = 3 | |
AHFinderDirect::origin_x [3] = 0 | |
AHFinderDirect::find_after_individual_time [3] = 100.0 | |
AHFinderDirect::initial_guess__coord_sphere__x_center[3] = 0 | |
AHFinderDirect::initial_guess__coord_sphere__radius [3] = 1.0 | |
AHFinderDirect::which_surface_to_store_info [3] = 2 | |
AHFinderDirect::reset_horizon_after_not_finding [3] = no | |
AHFinderDirect::max_allowable_horizon_radius [3] = 6 | |
PunctureTracker::track [0] = "yes" | |
PunctureTracker::initial_x [0] = 3.0 | |
PunctureTracker::which_surface_to_store_info[0] = 0 | |
PunctureTracker::track [1] = "yes" | |
PunctureTracker::initial_x [1] = -1.0 | |
PunctureTracker::which_surface_to_store_info[1] = 1 | |
QuasiLocalMeasures::num_surfaces = 3 | |
QuasiLocalMeasures::spatial_order = 4 | |
QuasiLocalMeasures::interpolator = "Lagrange polynomial interpolation" | |
QuasiLocalMeasures::interpolator_options = "order=4" | |
QuasiLocalMeasures::surface_index [0] = 0 | |
QuasiLocalMeasures::surface_index [1] = 1 | |
QuasiLocalMeasures::surface_index [2] = 2 | |
Multipole::nradii = 4 | |
Multipole::radius[0] = 30 | |
Multipole::radius[1] = 40 | |
Multipole::radius[2] = 50 | |
Multipole::radius[3] = 60 | |
Multipole::ntheta = 120 | |
Multipole::nphi = 240 | |
Multipole::variables = "WeylScal4::Psi4r{sw=-2 cmplx='WeylScal4::Psi4i' name='psi4'}" | |
Multipole::out_every = 4 | |
Multipole::l_max = 4 | |
WeylScal4::fd_order = "4th" | |
#------------------------------------------------------------------------------ | |
# Checkpoint/Recovery: | |
#------------------------------------------------------------------------------ | |
IOHDF5::checkpoint = "no" | |
IO::checkpoint_dir = $parfile | |
IO::checkpoint_ID = "no" | |
IO::checkpoint_every = 6144 | |
#IO::checkpoint_every_walltime_hours = 6.0 | |
IO::checkpoint_keep=3 | |
IO::checkpoint_on_terminate = "no" | |
IO::recover = "no" | |
IO::recover_dir = $parfile | |
This file has been truncated, but you can view the full file.
This file contains bidirectional Unicode text that may be interpreted or compiled differently than what appears below. To review, open the file in an editor that reveals hidden Unicode characters.
Learn more about bidirectional Unicode characters
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=0 of N_interp_points=2964 | |
interpolation point (x,y,z)=(1.70792e+243,2.01396e+243,3.91836e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=1 of N_interp_points=2964 | |
interpolation point (x,y,z)=(1.88113e+243,1.98342e+243,3.93419e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=2 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.05504e+243,1.95275e+243,3.93419e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=3 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.22825e+243,1.92221e+243,3.91836e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=4 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.39937e+243,1.89204e+243,3.88682e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=5 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.56702e+243,1.86248e+243,3.83984e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=6 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.72984e+243,1.83377e+243,3.77779e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=7 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.88653e+243,1.80614e+243,3.70117e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=8 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.03582e+243,1.77981e+243,3.61059e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=9 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.17652e+243,1.755e+243,3.50679e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=10 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.30749e+243,1.73191e+243,3.39061e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=11 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.42768e+243,1.71072e+243,3.26296e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=12 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.53611e+243,1.6916e+243,3.12489e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=13 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.63192e+243,1.67471e+243,2.97751e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=14 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.71433e+243,1.66017e+243,2.822e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=15 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.78268e+243,1.64812e+243,2.65962e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=16 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.83642e+243,1.63865e+243,2.49167e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=17 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.87512e+243,1.63182e+243,2.3195e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=18 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.89847e+243,1.62771e+243,2.1445e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=19 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.90627e+243,1.62633e+243,1.96808e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=20 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.89847e+243,1.62771e+243,1.79167e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=21 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.87512e+243,1.63182e+243,1.61667e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=22 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.83642e+243,1.63865e+243,1.4445e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=23 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.78268e+243,1.64812e+243,1.27655e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=24 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.71433e+243,1.66017e+243,1.11416e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=25 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.63192e+243,1.67471e+243,9.58655e+242) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=26 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.53611e+243,1.6916e+243,8.11273e+242) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=27 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.42768e+243,1.71072e+243,6.73205e+242) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=28 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.30749e+243,1.73191e+243,5.45563e+242) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=29 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.17652e+243,1.755e+243,4.29374e+242) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=30 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.03582e+243,1.77981e+243,3.25574e+242) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=31 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.88653e+243,1.80614e+243,2.34998e+242) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=32 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.72984e+243,1.83377e+243,1.58376e+242) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=33 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.56702e+243,1.86248e+243,9.63249e+241) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=34 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.39937e+243,1.89204e+243,4.9344e+241) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=35 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.22825e+243,1.92221e+243,1.78116e+241) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=36 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.05504e+243,1.95275e+243,1.98173e+240) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=37 of N_interp_points=2964 | |
interpolation point (x,y,z)=(1.88113e+243,1.98342e+243,1.98173e+240) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=38 of N_interp_points=2964 | |
interpolation point (x,y,z)=(1.70792e+243,2.01396e+243,1.78116e+241) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=39 of N_interp_points=2964 | |
interpolation point (x,y,z)=(1.70491e+243,1.99111e+243,3.91836e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=40 of N_interp_points=2964 | |
interpolation point (x,y,z)=(1.88012e+243,1.97578e+243,3.93419e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=41 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.05605e+243,1.96039e+243,3.93419e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=42 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.23126e+243,1.94506e+243,3.91836e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=43 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.40436e+243,1.92992e+243,3.88682e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=44 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.57394e+243,1.91508e+243,3.83984e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=45 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.73865e+243,1.90067e+243,3.77779e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=46 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.89715e+243,1.8868e+243,3.70117e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=47 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.04817e+243,1.87359e+243,3.61059e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=48 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.1905e+243,1.86114e+243,3.50679e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=49 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.32298e+243,1.84955e+243,3.39061e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=50 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.44455e+243,1.83891e+243,3.26296e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=51 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.55424e+243,1.82931e+243,3.12489e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=52 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.65115e+243,1.82083e+243,2.97751e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=53 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.73452e+243,1.81354e+243,2.822e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=54 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.80366e+243,1.80749e+243,2.65962e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=55 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.85802e+243,1.80274e+243,2.49167e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=56 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.89717e+243,1.79931e+243,2.3195e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=57 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.92079e+243,1.79724e+243,2.1445e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=58 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.92868e+243,1.79655e+243,1.96808e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=59 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.92079e+243,1.79724e+243,1.79167e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=60 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.89717e+243,1.79931e+243,1.61667e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=61 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.85802e+243,1.80274e+243,1.4445e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=62 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.80366e+243,1.80749e+243,1.27655e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=63 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.73452e+243,1.81354e+243,1.11416e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=64 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.65115e+243,1.82083e+243,9.58655e+242) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=65 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.55424e+243,1.82931e+243,8.11273e+242) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=66 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.44455e+243,1.83891e+243,6.73205e+242) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=67 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.32298e+243,1.84955e+243,5.45563e+242) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=68 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.1905e+243,1.86114e+243,4.29374e+242) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=69 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.04817e+243,1.87359e+243,3.25574e+242) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=70 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.89715e+243,1.8868e+243,2.34998e+242) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=71 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.73865e+243,1.90067e+243,1.58376e+242) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=72 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.57394e+243,1.91508e+243,9.63249e+241) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=73 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.40436e+243,1.92992e+243,4.9344e+241) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=74 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.63433e+243,2.57455e+243,2.822e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=75 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.23126e+243,1.94506e+243,1.78116e+241) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=76 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.05605e+243,1.96039e+243,1.98173e+240) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=77 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.69955e+243,2.59829e+243,2.65962e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=78 of N_interp_points=2964 | |
interpolation point (x,y,z)=(1.88012e+243,1.97578e+243,1.98173e+240) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=79 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.75083e+243,2.61695e+243,2.49167e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=80 of N_interp_points=2964 | |
interpolation point (x,y,z)=(1.70491e+243,1.99111e+243,1.78116e+241) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=81 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.78776e+243,2.63039e+243,2.3195e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=82 of N_interp_points=2964 | |
interpolation point (x,y,z)=(1.7039e+243,1.96808e+243,3.91836e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=83 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.81003e+243,2.6385e+243,2.1445e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=84 of N_interp_points=2964 | |
interpolation point (x,y,z)=(1.87979e+243,1.96808e+243,3.93419e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=85 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.81748e+243,2.64121e+243,1.96808e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=86 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.05638e+243,1.96808e+243,3.93419e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=87 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.81003e+243,2.6385e+243,1.79167e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=88 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.78776e+243,2.63039e+243,1.61667e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=89 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.75083e+243,2.61695e+243,1.4445e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=90 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.69955e+243,2.59829e+243,1.27655e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=91 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.63433e+243,2.57455e+243,1.11416e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=92 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.55569e+243,2.54593e+243,9.58655e+242) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=93 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.46428e+243,2.51265e+243,8.11273e+242) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=94 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.36081e+243,2.47499e+243,6.73205e+242) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=95 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.24613e+243,2.43326e+243,5.45563e+242) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=96 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.12116e+243,2.38777e+243,4.29374e+242) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=97 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.23227e+243,1.96808e+243,3.91836e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=98 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.98691e+243,2.33891e+243,3.25574e+242) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=99 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.40602e+243,1.96808e+243,3.88682e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=100 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.84445e+243,2.28706e+243,2.34998e+242) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=101 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.57626e+243,1.96808e+243,3.83984e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=102 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.69494e+243,2.23264e+243,1.58376e+242) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=103 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.53958e+243,2.17609e+243,9.63249e+241) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=104 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.74159e+243,1.96808e+243,3.77779e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=105 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.37961e+243,2.11787e+243,4.9344e+241) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=106 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.9007e+243,1.96808e+243,3.70117e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=107 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.0523e+243,1.96808e+243,3.61059e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=108 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.21633e+243,2.05844e+243,1.78116e+241) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=109 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.19516e+243,1.96808e+243,3.50679e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=110 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.05106e+243,1.99828e+243,1.98173e+240) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=111 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.32815e+243,1.96808e+243,3.39061e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=112 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.45019e+243,1.96808e+243,3.26296e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=113 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.5603e+243,1.96808e+243,3.12489e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=114 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.65758e+243,1.96808e+243,2.97751e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=115 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.74127e+243,1.96808e+243,2.822e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=116 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.81067e+243,1.96808e+243,2.65962e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=117 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.86524e+243,1.96808e+243,2.49167e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=118 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.90454e+243,1.96808e+243,2.3195e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=119 of N_interp_points=2964 | |
interpolation point (x,y,z)=(1.88511e+243,1.93788e+243,1.98173e+240) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=120 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.92825e+243,1.96808e+243,2.1445e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=121 of N_interp_points=2964 | |
interpolation point (x,y,z)=(1.71983e+243,1.87773e+243,1.78116e+241) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=122 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.93617e+243,1.96808e+243,1.96808e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=123 of N_interp_points=2964 | |
interpolation point (x,y,z)=(1.72865e+243,1.85644e+243,3.91836e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=124 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.92825e+243,1.96808e+243,1.79167e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=125 of N_interp_points=2964 | |
interpolation point (x,y,z)=(1.88806e+243,1.93077e+243,3.93419e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=126 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.90454e+243,1.96808e+243,1.61667e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=127 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.04811e+243,2.0054e+243,3.93419e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=128 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.86524e+243,1.96808e+243,1.4445e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=129 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.20751e+243,2.07973e+243,3.91836e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=130 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.81067e+243,1.96808e+243,1.27655e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=131 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.36499e+243,2.15317e+243,3.88682e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=132 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.74127e+243,1.96808e+243,1.11416e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=133 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.51927e+243,2.22511e+243,3.83984e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=134 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.65758e+243,1.96808e+243,9.58655e+242) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=135 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.66912e+243,2.29498e+243,3.77779e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=136 of N_interp_points=2964 | |
interpolation point (x,y,z)=(1.88806e+243,1.93077e+243,1.98173e+240) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=137 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.5603e+243,1.96808e+243,8.11273e+242) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=138 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.81332e+243,2.36222e+243,3.70117e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=139 of N_interp_points=2964 | |
interpolation point (x,y,z)=(1.72865e+243,1.85644e+243,1.78116e+241) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=140 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.45019e+243,1.96808e+243,6.73205e+242) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=141 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.32815e+243,1.96808e+243,5.45563e+242) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=142 of N_interp_points=2964 | |
interpolation point (x,y,z)=(1.7393e+243,1.83599e+243,3.91836e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=143 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.95071e+243,2.42629e+243,3.61059e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=144 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.19516e+243,1.96808e+243,4.29374e+242) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=145 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.0802e+243,2.48667e+243,3.50679e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=146 of N_interp_points=2964 | |
interpolation point (x,y,z)=(1.89162e+243,1.92394e+243,3.93419e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=147 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.04455e+243,2.01223e+243,3.93419e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=148 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.20073e+243,2.54287e+243,3.39061e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=149 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.0523e+243,1.96808e+243,3.25574e+242) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=150 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.31133e+243,2.59445e+243,3.26296e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=151 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.19687e+243,2.10018e+243,3.91836e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=152 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.34735e+243,2.18705e+243,3.88682e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=153 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.41112e+243,2.64098e+243,3.12489e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=154 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.9007e+243,1.96808e+243,2.34998e+242) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=155 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.49478e+243,2.27217e+243,3.83984e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=156 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.49929e+243,2.6821e+243,2.97751e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=157 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.74159e+243,1.96808e+243,1.58376e+242) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=158 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.57626e+243,1.96808e+243,9.63249e+241) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=159 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.57513e+243,2.71746e+243,2.822e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=160 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.63796e+243,2.35484e+243,3.77779e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=161 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.40602e+243,1.96808e+243,4.9344e+241) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=162 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.77575e+243,2.43439e+243,3.70117e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=163 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.63804e+243,2.7468e+243,2.65962e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=164 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.68749e+243,2.76986e+243,2.49167e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=165 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.90704e+243,2.51019e+243,3.61059e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=166 of N_interp_points=2964 | |
interpolation point (x,y,z)=(2.23227e+243,1.96808e+243,1.78116e+241) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=167 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.72311e+243,2.78647e+243,2.3195e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=168 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.03077e+243,2.58162e+243,3.50679e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=169 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.14594e+243,2.64812e+243,3.39061e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=170 of N_interp_points=2964 | |
interpolation point (x,y,z)=(3.74459e+243,2.79648e+243,2.1445e+243) | |
grid x_min(delta_x)x_max = -122.5(1.25)122.5 | |
grid y_min(delta_y)y_max = -122.5(1.25)3.75 | |
grid z_min(delta_z)z_max = -3.75(1.25)122.5 | |
WARNING level 1 from host nid00027 process 0 | |
while executing schedule bin CCTK_ANALYSIS, routine QuasiLocalMeasures::qlm_calculate | |
in thorn AEILocalInterp, file /lustre/tetyda/home/topolski/Cactus/arrangements/Numerical/AEILocalInterp/src/Lagrange-tensor-product/../template.c:1109: | |
-> | |
CCTK_InterpLocalUniform(): | |
interpolation point is either outside the grid, | |
or inside but too close to the grid boundary! | |
(this may be caused by a global interpolation with | |
driver::ghost_size too small) | |
0-origin interpolation point number pt=171 of N_interp_points=2964 | |