[Commits] [svn:einsteintoolkit] AHFinderDirect/trunk/test/ (Rev. 1563)
roland.haas at physics.gatech.edu
roland.haas at physics.gatech.edu
Sat Apr 28 14:12:21 CDT 2012
User: rhaas
Date: 2012/04/28 02:12 PM
Removed:
/trunk/test/
checkpoint.par, checkpoint2.par, recover2.par
/trunk/test/checkpoint/
/trunk/test/checkpoint2/
/trunk/test/recover/
/trunk/test/recover2/
Modified:
/trunk/test/
checkpointML.par, recoverML.par, test.ccl
/trunk/test/checkpointML/
checkpoint.chkpt.it_1.h5
Log:
remove BSSN_MoL tests, switch to ML_BSSN from ML_BSSN_O2
The BSSN_MoL tests either used LegoExcision (which we will remove) or have
equivalent ML tests.
The ML tests now use fdOrder and still pass with the old data (only
modification to hdf5 file was renaming of datasets and regeneration of the
Parameters group)
File Changes:
Directory: /trunk/test/checkpointML/
====================================
File [modified]: checkpoint.chkpt.it_1.h5
Delta lines: +0 -0
===================================================================
(Binary files differ)
Directory: /trunk/test/
=======================
File [removed]: checkpoint.par
Delta lines: +0 -86
===================================================================
--- trunk/test/checkpoint.par 2012-01-24 20:24:54 UTC (rev 1562)
+++ trunk/test/checkpoint.par 2012-04-28 19:12:20 UTC (rev 1563)
@@ -1,86 +0,0 @@
-# $Header$
-
-# This parameter file sets up Kerr/Kerr-Schild initial data, then
-# finds the apparent horizon in it.
-
-# flesh
-cactus::cctk_itlast = 1
-
-# create output directory
-ActiveThorns = "IOUtil"
-IO::out_dir = $parfile
-IO::parfile_write = "no"
-
-ActiveThorns = "Carpet CarpetLib"
-driver::ghost_size = 3
-driver::global_nx = 19
-driver::global_ny = 31
-driver::global_nz = 19
-
-ActiveThorns = "Boundary CartGrid3D CoordBase RotatingSymmetry180 Slab SymBase"
-grid::domain = "bitant"
-grid::avoid_origin = "false"
-grid::type = "byrange"
-grid::xmin = -0.6
-grid::ymin = -3.0
-grid::zmin = -0.6
-grid::xmax = 3.0
-grid::ymax = 3.0
-grid::zmax = 3.0
-
-ActiveThorns = "ADMBase ADMCoupling StaticConformal CoordGauge SpaceMask Exact ADMMacros BSSN_MoL MoL"
-ADMBase::initial_lapse = "exact"
-ADMBase::initial_shift = "exact"
-ADMBase::initial_data = "exact"
-ADMBase::lapse_evolution_method = "harmonic"
-ADMBase::shift_evolution_method = "static"
-ADMBase::metric_type = "physical"
-ADMBase::evolution_method = ADM_BSSN
-Exact::exact_model = "Kerr/Kerr-Schild"
-Exact::Kerr_KerrSchild__mass = 1.0
-Exact::Kerr_KerrSchild__spin = 0.6
-
-ActiveThorns = "Time"
-Time::dtfac = 0.25
-
-ActiveThorns = "SphericalSurface NoExcision"
-NoExcision::num_regions = 1
-NoExcision::radius[0] = 1.01
-
-ActiveThorns = "CarpetIOASCII"
-IOASCII::out1D_every = 1
-IOASCII::out1D_vars = "ADM_BSSN::ADM_BSSN_phi"
-
-ActiveThorns = "CarpetIOHDF5"
-IOHDF5::checkpoint = yes
-IO::checkpoint_dir = $parfile
-IO::checkpoint_every = 1
-IO::checkpoint_keep = -1
-
-########################################
-
-ActiveThorns = "SphericalSurface"
-
-ActiveThorns = "LocalInterp AEILocalInterp CarpetInterp GSL LoopControl CarpetReduce AHFinderDirect"
-
-AHFinderDirect::print_timing_stats = "true"
-
-AHFinderDirect::h_base_file_name = "h"
-AHFinderDirect::BH_diagnostics_base_file_name = "BH_diagnostics"
-AHFinderDirect::output_OpenDX_control_files = "no"
-AHFinderDirect::Theta_norm_for_convergence = 1.0e-12
-
-AHFinderDirect::geometry_interpolator_name = "Lagrange polynomial interpolation"
-AHFinderDirect::geometry_interpolator_pars = "order=4"
-
-AHFinderDirect::N_horizons = 1
-
-AHFinderDirect::origin_x[1] = 0.5
-AHFinderDirect::origin_y[1] = 0.7
-AHFinderDirect::origin_z[1] = 0.0
-
-AHFinderDirect::initial_guess_method[1] = "coordinate sphere"
-AHFinderDirect::initial_guess__coord_sphere__x_center[1] = -0.2
-AHFinderDirect::initial_guess__coord_sphere__y_center[1] = 0.3
-AHFinderDirect::initial_guess__coord_sphere__z_center[1] = 0.0
-AHFinderDirect::initial_guess__coord_sphere__radius[1] = 2.0
File [removed]: checkpoint2.par
Delta lines: +0 -102
===================================================================
--- trunk/test/checkpoint2.par 2012-01-24 20:24:54 UTC (rev 1562)
+++ trunk/test/checkpoint2.par 2012-04-28 19:12:20 UTC (rev 1563)
@@ -1,102 +0,0 @@
-# $Header$
-
-# This parameter file sets up Kerr/Kerr-Schild initial data, then
-# finds the apparent horizon in it.
-
-# flesh
-cactus::cctk_itlast = 1
-
-# create output directory
-ActiveThorns = "IOUtil"
-IO::out_dir = $parfile
-IO::parfile_write = "no"
-IO::out_fileinfo = "axis labels"
-
-ActiveThorns = "Carpet CarpetLib"
-driver::ghost_size = 3
-driver::global_nx = 19
-driver::global_ny = 31
-driver::global_nz = 19
-
-ActiveThorns = "Boundary CartGrid3D CoordBase RotatingSymmetry180 Slab SymBase"
-grid::domain = "bitant"
-grid::avoid_origin = "false"
-grid::type = "byrange"
-grid::xmin = -0.6
-grid::ymin = -3.0
-grid::zmin = -0.6
-grid::xmax = 3.0
-grid::ymax = 3.0
-grid::zmax = 3.0
-
-ActiveThorns = "ADMBase ADMCoupling StaticConformal CoordGauge SpaceMask Exact ADMMacros BSSN_MoL MoL"
-ADMBase::initial_lapse = "exact"
-ADMBase::initial_shift = "exact"
-ADMBase::initial_data = "exact"
-ADMBase::lapse_evolution_method = "harmonic"
-ADMBase::shift_evolution_method = "static"
-ADMBase::metric_type = "physical"
-ADMBase::evolution_method = ADM_BSSN
-Exact::exact_model = "Kerr/Kerr-Schild"
-Exact::Kerr_KerrSchild__mass = 1.0
-Exact::Kerr_KerrSchild__spin = 0.6
-SpaceMask::use_mask = yes
-BSSN_MoL::excise = yes
-BSSN_MoL::excisionType = lego
-
-ActiveThorns = "Time"
-Time::dtfac = 0.25
-
-ActiveThorns = "LegoExcision"
-LegoExcision::fixed_excision = sphere
-LegoExcision::num_fixed_regions = 1
-LegoExcision::fixed_size = 1.001
-
-ActiveThorns = "CarpetIOASCII"
-IOASCII::out1D_every = 1
-IOASCII::out1D_vars = "SpaceMask::emask ADM_BSSN::ADM_BSSN_phi"
-IOASCII::out1D_d = no
-
-ActiveThorns = "CarpetIOHDF5"
-IOHDF5::checkpoint = yes
-IO::checkpoint_dir = $parfile
-IO::checkpoint_every = 1
-IO::checkpoint_keep = -1
-
-########################################
-
-ActiveThorns = "SphericalSurface"
-
-ActiveThorns = "LocalInterp AEILocalInterp CarpetInterp GSL LoopControl CarpetReduce AHFinderDirect"
-
-AHFinderDirect::print_timing_stats = "true"
-
-AHFinderDirect::h_base_file_name = "h"
-AHFinderDirect::BH_diagnostics_base_file_name = "BH_diagnostics"
-AHFinderDirect::output_OpenDX_control_files = "no"
-AHFinderDirect::Theta_norm_for_convergence = 1.0e-12
-
-AHFinderDirect::geometry_interpolator_name = "Lagrange polynomial interpolation"
-AHFinderDirect::geometry_interpolator_pars = "order=4"
-
-AHFinderDirect::N_horizons = 2
-
-AHFinderDirect::origin_x[0] = 0.5
-AHFinderDirect::origin_y[0] = 0.7
-AHFinderDirect::origin_z[0] = 0.0
-
-AHFinderDirect::initial_guess_method[0] = "coordinate sphere"
-AHFinderDirect::initial_guess__coord_sphere__x_center[0] = -0.2
-AHFinderDirect::initial_guess__coord_sphere__y_center[0] = 0.3
-AHFinderDirect::initial_guess__coord_sphere__z_center[0] = 0.0
-AHFinderDirect::initial_guess__coord_sphere__radius[0] = 2.0
-
-AHFinderDirect::origin_x[1] = 0.4
-AHFinderDirect::origin_y[1] = 0.6
-AHFinderDirect::origin_z[1] = 0.0
-
-AHFinderDirect::initial_guess_method[1] = "coordinate sphere"
-AHFinderDirect::initial_guess__coord_sphere__x_center[1] = -0.1
-AHFinderDirect::initial_guess__coord_sphere__y_center[1] = 0.2
-AHFinderDirect::initial_guess__coord_sphere__z_center[1] = 0.0
-AHFinderDirect::initial_guess__coord_sphere__radius[1] = 2.0
File [modified]: checkpointML.par
Delta lines: +20 -19
===================================================================
--- trunk/test/checkpointML.par 2012-01-24 20:24:54 UTC (rev 1562)
+++ trunk/test/checkpointML.par 2012-04-28 19:12:20 UTC (rev 1563)
@@ -43,38 +43,39 @@
CoordBase::boundary_shiftout_x_lower = 1
CoordBase::boundary_shiftout_z_lower = 1
-ActiveThorns = "ADMBase ADMCoupling StaticConformal CoordGauge SpaceMask Exact ADMMacros ML_BSSN_O2 ML_BSSN_O2_Helper GenericFD TmunuBase NewRad MoL"
+ActiveThorns = "ADMBase ADMCoupling StaticConformal CoordGauge SpaceMask Exact ADMMacros ML_BSSN ML_BSSN_Helper GenericFD TmunuBase NewRad MoL"
ADMBase::initial_lapse = "exact"
ADMBase::initial_shift = "exact"
ADMBase::initial_data = "exact"
-ADMBase::lapse_evolution_method = "ML_BSSN_O2"
-ADMBase::dtlapse_evolution_method = "ML_BSSN_O2"
+ADMBase::lapse_evolution_method = "ML_BSSN"
+ADMBase::dtlapse_evolution_method = "ML_BSSN"
ADMBase::shift_evolution_method = "static"
ADMBase::metric_type = "physical"
-ADMBase::evolution_method = ML_BSSN_O2
+ADMBase::evolution_method = ML_BSSN
Exact::exact_model = "Kerr/Kerr-Schild"
Exact::Kerr_KerrSchild__mass = 1.0
Exact::Kerr_KerrSchild__spin = 0.6
-ML_BSSN_O2::my_initial_boundary_condition = "extrapolate-gammas"
-ML_BSSN_O2::my_rhs_boundary_condition = "NewRad"
+ML_BSSN::my_initial_boundary_condition = "extrapolate-gammas"
+ML_BSSN::my_rhs_boundary_condition = "NewRad"
# These are necessary
-ML_BSSN_O2::ML_log_confac_bound = "none"
-ML_BSSN_O2::ML_metric_bound = "none"
-ML_BSSN_O2::ML_Gamma_bound = "none"
-ML_BSSN_O2::ML_trace_curv_bound = "none"
-ML_BSSN_O2::ML_curv_bound = "none"
-ML_BSSN_O2::ML_lapse_bound = "none"
-ML_BSSN_O2::ML_dtlapse_bound = "none"
-ML_BSSN_O2::ML_shift_bound = "none"
-ML_BSSN_O2::ML_dtshift_bound = "none"
+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"
-ML_BSSN_O2::harmonicN = 1 # 1+log
-ML_BSSN_O2::LapseAdvectionCoeff = 1
+ML_BSSN::harmonicN = 1 # 1+log
+ML_BSSN::LapseAdvectionCoeff = 1
# the default of 3 fails in Recovery since Carpet tries to time-interpolate the
# third timelevel for which is had allocated no metadata, see Carpet issue #626
-ML_BSSN_O2::timelevels = 2 # unigrid run
+ML_BSSN::timelevels = 2 # unigrid run
+ML_BSSN::fdOrder = 2
ActiveThorns = "Time"
@@ -86,7 +87,7 @@
ActiveThorns = "CarpetIOASCII"
IOASCII::out1D_every = 1
-IOASCII::out1D_vars = "ML_BSSN_O2::phi"
+IOASCII::out1D_vars = "ML_BSSN::phi"
ActiveThorns = "CarpetIOHDF5"
IOHDF5::checkpoint = yes
File [removed]: recover2.par
Delta lines: +0 -110
===================================================================
--- trunk/test/recover2.par 2012-01-24 20:24:54 UTC (rev 1562)
+++ trunk/test/recover2.par 2012-04-28 19:12:20 UTC (rev 1563)
@@ -1,110 +0,0 @@
-# $Header$
-
-# This parameter file sets up Kerr/Kerr-Schild initial data, then
-# finds the apparent horizon in it.
-
-# flesh
-cactus::cctk_itlast = 2
-
-# create output directory
-ActiveThorns = "IOUtil"
-IO::out_dir = $parfile
-IO::parfile_write = "no"
-
-ActiveThorns = "Carpet CarpetLib"
-driver::ghost_size = 3
-driver::global_nx = 19
-driver::global_ny = 31
-driver::global_nz = 19
-
-ActiveThorns = "Boundary CartGrid3D CoordBase RotatingSymmetry180 Slab SymBase"
-grid::domain = "bitant"
-grid::avoid_origin = "false"
-grid::type = "byrange"
-grid::xmin = -0.6
-grid::ymin = -3.0
-grid::zmin = -0.6
-grid::xmax = 3.0
-grid::ymax = 3.0
-grid::zmax = 3.0
-
-ActiveThorns = "ADMBase ADMCoupling StaticConformal CoordGauge SpaceMask Exact ADMMacros BSSN_MoL MoL"
-ADMBase::initial_lapse = "exact"
-ADMBase::initial_shift = "exact"
-ADMBase::initial_data = "exact"
-ADMBase::lapse_evolution_method = "harmonic"
-ADMBase::shift_evolution_method = "static"
-ADMBase::metric_type = "physical"
-ADMBase::evolution_method = ADM_BSSN
-Exact::exact_model = "Kerr/Kerr-Schild"
-Exact::Kerr_KerrSchild__mass = 1.0
-Exact::Kerr_KerrSchild__spin = 0.6
-SpaceMask::use_mask = yes
-BSSN_MoL::excise = yes
-BSSN_MoL::excisionType = lego
-
-ActiveThorns = "Time"
-Time::dtfac = 0.25
-
-ActiveThorns = "LegoExcision"
-LegoExcision::fixed_excision = sphere
-LegoExcision::num_fixed_regions = 1
-LegoExcision::fixed_size = 1.001
-
-ActiveThorns = "CarpetIOASCII"
-IOASCII::out1D_every = 1
-IOASCII::out1D_vars = "SpaceMask::emask ADM_BSSN::ADM_BSSN_phi"
-IOASCII::out1D_xline_yi = 15
-IOASCII::out1D_xline_zi = 3
-IOASCII::out1D_yline_xi = 3
-IOASCII::out1D_yline_zi = 3
-IOASCII::out1D_zline_xi = 3
-IOASCII::out1D_zline_yi = 15
-IOASCII::out1D_d = no
-
-ActiveThorns = "CarpetIOHDF5"
-IOHDF5::checkpoint = yes
-IO::checkpoint_dir = $parfile
-IO::checkpoint_every = 0
-IO::checkpoint_keep = -1
-IO::recover = "manual"
-IO::recover_dir = "../../../arrangements/AEIThorns/AHFinderDirect/test/checkpoint2"
-IO::recover_file = "checkpoint.chkpt.it_1"
-
-########################################
-
-ActiveThorns = "SphericalSurface"
-
-ActiveThorns = "LocalInterp AEILocalInterp CarpetInterp GSL LoopControl CarpetReduce AHFinderDirect"
-
-AHFinderDirect::print_timing_stats = "true"
-
-AHFinderDirect::h_base_file_name = "h"
-AHFinderDirect::BH_diagnostics_base_file_name = "BH_diagnostics"
-AHFinderDirect::output_OpenDX_control_files = "no"
-AHFinderDirect::Theta_norm_for_convergence = 1.0e-12
-
-AHFinderDirect::geometry_interpolator_name = "Lagrange polynomial interpolation"
-AHFinderDirect::geometry_interpolator_pars = "order=4"
-
-AHFinderDirect::N_horizons = 2
-
-AHFinderDirect::origin_x[1] = 0.5
-AHFinderDirect::origin_y[1] = 0.7
-AHFinderDirect::origin_z[1] = 0.0
-
-AHFinderDirect::initial_guess_method[1] = "coordinate sphere"
-AHFinderDirect::initial_guess__coord_sphere__x_center[1] = -0.2
-AHFinderDirect::initial_guess__coord_sphere__y_center[1] = 0.3
-AHFinderDirect::initial_guess__coord_sphere__z_center[1] = 0.0
-AHFinderDirect::initial_guess__coord_sphere__radius[1] = 2.0
-
-AHFinderDirect::origin_x[2] = 0.4
-AHFinderDirect::origin_y[2] = 0.6
-AHFinderDirect::origin_z[2] = 0.0
-
-AHFinderDirect::initial_guess_method[2] = "coordinate sphere"
-AHFinderDirect::initial_guess__coord_sphere__x_center[2] = -0.1
-AHFinderDirect::initial_guess__coord_sphere__y_center[2] = 0.2
-AHFinderDirect::initial_guess__coord_sphere__z_center[2] = 0.0
-AHFinderDirect::initial_guess__coord_sphere__radius[2] = 2.0
File [modified]: recoverML.par
Delta lines: +20 -19
===================================================================
--- trunk/test/recoverML.par 2012-01-24 20:24:54 UTC (rev 1562)
+++ trunk/test/recoverML.par 2012-04-28 19:12:20 UTC (rev 1563)
@@ -43,38 +43,39 @@
CoordBase::boundary_shiftout_x_lower = 1
CoordBase::boundary_shiftout_z_lower = 1
-ActiveThorns = "ADMBase ADMCoupling StaticConformal CoordGauge SpaceMask Exact ADMMacros ML_BSSN_O2 ML_BSSN_O2_Helper GenericFD TmunuBase NewRad MoL"
+ActiveThorns = "ADMBase ADMCoupling StaticConformal CoordGauge SpaceMask Exact ADMMacros ML_BSSN ML_BSSN_Helper GenericFD TmunuBase NewRad MoL"
ADMBase::initial_lapse = "exact"
ADMBase::initial_shift = "exact"
ADMBase::initial_data = "exact"
-ADMBase::lapse_evolution_method = "ML_BSSN_O2"
-ADMBase::dtlapse_evolution_method = "ML_BSSN_O2"
+ADMBase::lapse_evolution_method = "ML_BSSN"
+ADMBase::dtlapse_evolution_method = "ML_BSSN"
ADMBase::shift_evolution_method = "static"
ADMBase::metric_type = "physical"
-ADMBase::evolution_method = ML_BSSN_O2
+ADMBase::evolution_method = ML_BSSN
Exact::exact_model = "Kerr/Kerr-Schild"
Exact::Kerr_KerrSchild__mass = 1.0
Exact::Kerr_KerrSchild__spin = 0.6
-ML_BSSN_O2::my_initial_boundary_condition = "extrapolate-gammas"
-ML_BSSN_O2::my_rhs_boundary_condition = "NewRad"
+ML_BSSN::my_initial_boundary_condition = "extrapolate-gammas"
+ML_BSSN::my_rhs_boundary_condition = "NewRad"
# These are necessary
-ML_BSSN_O2::ML_log_confac_bound = "none"
-ML_BSSN_O2::ML_metric_bound = "none"
-ML_BSSN_O2::ML_Gamma_bound = "none"
-ML_BSSN_O2::ML_trace_curv_bound = "none"
-ML_BSSN_O2::ML_curv_bound = "none"
-ML_BSSN_O2::ML_lapse_bound = "none"
-ML_BSSN_O2::ML_dtlapse_bound = "none"
-ML_BSSN_O2::ML_shift_bound = "none"
-ML_BSSN_O2::ML_dtshift_bound = "none"
+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"
-ML_BSSN_O2::harmonicN = 1 # 1+log
-ML_BSSN_O2::LapseAdvectionCoeff = 1
+ML_BSSN::harmonicN = 1 # 1+log
+ML_BSSN::LapseAdvectionCoeff = 1
# the default of 3 fails in Recovery since Carpet tries to time-interpolate the
# third timelevel for which is had allocated no metadata, see Carpet issue #626
-ML_BSSN_O2::timelevels = 2 # unigrid run
+ML_BSSN::timelevels = 2 # unigrid run
+ML_BSSN::fdOrder = 2
ActiveThorns = "Time"
@@ -86,7 +87,7 @@
ActiveThorns = "CarpetIOASCII"
IOASCII::out1D_every = 1
-IOASCII::out1D_vars = "ML_BSSN_O2::phi"
+IOASCII::out1D_vars = "ML_BSSN::phi"
IOASCII::out1D_xline_yi = 15
IOASCII::out1D_xline_zi = 3
File [modified]: test.ccl
Delta lines: +0 -15
===================================================================
--- trunk/test/test.ccl 2012-01-24 20:24:54 UTC (rev 1562)
+++ trunk/test/test.ccl 2012-04-28 19:12:20 UTC (rev 1563)
@@ -6,21 +6,6 @@
ABSTOL 1e-8
RELTOL 1e-8
-TEST recover
-{
- NPROCS 1
-}
-
-TEST recover2
-{
- NPROCS 1
-}
-
-TEST checkpoint2
-{
- NPROCS 1
-}
-
TEST recoverML
{
NPROCS 1
More information about the Commits
mailing list