GXRPS class¶
- class GXRPS(handle=0)[source]¶
GXRPS class.
Not a class. A catch-all group of functions performing various Radiometric Processing System tasks.
- classmethod altitude_attenuation(db, line, input_channel, height_att_coeff, nom_altimeter, stp_alt_channel, output_channel)[source]¶
Apply altitude attenuation for a radioelement
- Parameters:
line (int) – Line to process (NULLSYMB for all selected lines)
input_channel (str) – Input channel name
height_att_coeff (float) – Height attenuation coefficient (per metre at STP)
nom_altimeter (float) – Nominal survey altitude (m)
stp_alt_channel (str) – Input STP corrected altimeter channel name
output_channel (str) – Output channel name (can be same channel as input)
New in version 2025.2.
License: Geosoft End-User License
Note: The altitude attenuation is calculated using the formula:
Ns = Nm * exp(k * (H0 - H)) => Ns = Nm * exp(-k * (H - H0))
where: Ns = the count rate normalized to the nominal survey altitude, H0, Nm = the background corrected, stripped count rate at effective height H, k = height attenuation coefficient (per metre at STP) H = effective altitude (m) H0 = nominal survey altitude (m)
The effective height was determined by applying Compton Stripping.
HEIGHT ATTENUATION COEFF: Total Count (Recommended: -0.0070) (per metre at STP) Potassium (Recommended: -0.0088)
Uranium (Recommended: -0.0082) Thorium (Recommended: -0.0070)
Ref: See the RPSCORR.GXC file for details and implementation of the algorithm.
- classmethod compton_stripping(db, line, stp_alt_channel, K_levl, U_levl, Th_levl, alpha, beta, gamma, a, b, g, k_strip, u_strip, th_strip)[source]¶
Perform Compton Stripping
- Parameters:
line (int) – Line to process (NULLSYMB for all selected lines)
stp_alt_channel (str) – Input STP corrected altimeter channel name
K_levl (str) – Input Postassium levelelled count channel
U_levl (str) – Input Uranium levelelled count channel
Th_levl (str) – Input Thorium levelelled count channel
alpha (float) – Input Compton Stripping ratio alpha (default: 0.24)
beta (float) – Input Compton Stripping ratio beta (default: 0.37)
gamma (float) – Input Compton Stripping ratio gamma (default: 0.70)
a (float) – Input Compton Stripping ratio a (default: 0.05)
b (float) – Input Compton Stripping ratio b (default: 0.0)
g (float) – Input Compton Stripping ratio g (default: 0.0)
k_strip (str) – Output Compton Stripped Potassium channel (can be same channel as input)
u_strip (str) – Output Compton Stripped Uranium channel (can be same channel as input)
th_strip (str) – Output Compton Stripped Thorium channel (can be same channel as input)
New in version 2025.2.
License: Geosoft End-User License
Note: Compton stripping is calculated using the formula:
KSTRIP = (BK*THLEVL + CK*ULEVL + DK*KLEVL) / A USTRIP = (BU*THLEVL + CU*ULEVL + DU*KLEVL) / A THSTRIP = (BTH*THLEVL + CTH*ULEVL + DTH*KLEVL) / A
where
KSTRIP = Output Compton stripped potassium (can be same channel as input) USTRIP = Output Compton stripped uranium (can be same channel as input) THSTRIP = Output Compton stripped thorium (can be same channel as input)
and where:
KLEVL = Input potassium levelled count channel (e.g. “KLEVL”) ULEVL = Input uranium levelled count channel (e.g. “ULEVL”) THLEVL = Input thorium levelled count channel (e.g. “THLEVL”)
BK = ALPHA2*GAMMA2-BETA2; CK = ASTRIP*BETA2-GAMMA2; DK = 1-ASTRIP*ALPHA2;
BU = GSTRIP*BETA-ALPHA CU = 1-BSTRIP*BETA DU = BSTRIP*ALPHA-GSTRIP
BTH = 1-GSTRIP*GAMMA2; CTH = BSTRIP*GAMMA2-ASTRIP; DTH = ASTRIP*GSTRIP-BSTRIP;
where:
ALPHA2 = ALPHA + 0.0004895*RALTSTP BETA2 = BETA + 0.0006469*RALTSTP GAMMA2 = GAMMA + 0.0006874*RALTSTP
and:
RALTSTP = Input STP corrected radar altimeter channel value (m) ALPHA = Input Compton stripping alpha factor (default: 0.24) BETA = Input Compton stripping beta factor (default: 0.37) GAMMA = Input Compton stripping gamma factor (default: 0.70) ASTRIP = Input Compton stripping a factor (default: 0.05) BSTRIP = Input Compton stripping b factor (default: 0.0) GSTRIP = Input Compton stripping g factor (default: 0.0)
and where:
- A = 1-GSTRIP*GAMMA2 - ASTRIP*(ALPHA2 - GSTRIP*BETA2) -
BSTRIP*(BETA2-ALPHA2*GAMMA2)
Ref: See the RPSCORR.GXC file for details and implementation of the algorithm.
- classmethod convert_to_elemental(db, line, K, U, Th, TC, k_sens, u_sens, th_sens, tc_sens, k_conc, u_conc, th_conc, TC_conc)[source]¶
Convert a radio-channels’ data to ELemental concentrations
- Parameters:
line (int) – Line to process (NULLSYMB for all selected lines)
K (str) – Input Postassium count channel
U (str) – Input Uranium count channel
Th (str) – Input Thorium count channel
TC (str) – Input Total Count channel
k_sens (float) – Potassium broad source sensitivity (default: 75 (cps/%))
u_sens (float) – Uranium broad source sensitivity (default: 7.5 (cps/ppm))
th_sens (float) – Thorium broad source sensitivity (default: 4.5 (cps/ppm))
tc_sens (float) – Total count broad source sensitivity (default: 23 (uR/hr))
k_conc (str) – Output elemental concentration Potassium channel (can be same channel as input)
u_conc (str) – Output elemental concentration Uranium channel (can be same channel as input)
th_conc (str) – Output elemental concentration Thorium channel (can be same channel as input)
TC_conc (str) – Output elemental concentration Total Count channel (can be same channel as input)
New in version 2025.2.
License: Geosoft End-User License
Note: The conversions are calculated using the formulae:
OutputK = InputK / SensK OutputU = InputU / SensU OutputTh = InputTh / SensTh OutputTC = Input TC / SensTC
where:
OutputK = Output potassium channel expressed in elemental concentration OutputU = Output uranium channel expressed in elemental concentration OutputTh = Output thorium channel expressed in elemental concentration OutputTC = Output total count channel expressed in elemental concentration
InputK = Input potassium channel expressed in counts InputU = Input uranium channel expressed in counts InputTh = Input thorium channel expressed in counts InputTC = Input total count channel expressed in counts
SensK = Input Potassium Broad source sensitivity (default: 75 (cps/%)) SensU = Input Uranium Broad source sensitivity (default: 7.5 (cps/ppm)) SensTh = Input Thorium Broad source sensitivity (default: 4.5 (cps/ppm)) SensTC = Input Total Count Broad source sensitivity (default: 23 (uR/hr))
Ref: See the RPSCORR.GXC file for details and implementation of the algorithm.
- classmethod dead_time_correction(db, line, raw_channel, raw_tc_channel, deadtime_factor, deadtime_corr_channel)[source]¶
Apply the Dead-time correction to a channel for a line in a database
- Parameters:
line (int) – Line to process (NULLSYMB for all selected lines)
raw_channel (str) – Input raw channel name
raw_tc_channel (str) – Input raw total count channel name
deadtime_factor (float) – Dead time factor (microseconds/pulse
deadtime_corr_channel (str) – Output deadtime corrected channel name
New in version 2025.2.
License: Geosoft End-User License
Note: The output dead-time corrected channel is calculated using the formula:
deadtime_value = raw_value / (1 - raw_TC * dead_time * 0.000001)
where:
deadtime_value = output dead-time corrected value raw_value = raw channel value (counts) raw_TC = raw total count channel value dead_time = dead-time factor (microseconds/pulse)
Ref: See the RPSFILT.GXC file for details and implementation of the algorithm.
- classmethod full_spectral_analysis(db, line, spectral_data_channel, livetime_channel, altitude_channel, start_window, end_window, fit_mode, output_channel_suffix)[source]¶
Apply Medusa’s Full Spectral Analysis algorithm to extract the radionuclide channels from the spectral data
- Parameters:
line (int) – Line to process (NULLSYMB for all selected lines)
spectral_data_channel (str) – Spectral data channel name
livetime_channel (str) – Livetime channel name - assumes 1.0 if left blank
altitude_channel (str) – Altitude (e.g. radar altimeter) channel name - assumes 0 if left blank
start_window (int) – Index of the first window to include in the analysis (0 to N/4)
end_window (int) – Index of the last window to include in the analysis (3N/4 to N-1)
fit_mode (int) – RPS_FITMODE constants
output_channel_suffix (str) – Suffix for output channels
New in version 2025.2.
License: Geosoft End-User License
Note:
- is_null()[source]¶
Check if this is a null (undefined) instance
- Returns:
True if this is a null (undefined) instance, False otherwise.
- Return type:
bool
- classmethod live_time_correction(db, line, raw_channel, livetime_channel, livetime_corr_channel)[source]¶
Apply the Live-time correction to a channel for a line in a database
- Parameters:
New in version 2025.2.
License: Geosoft End-User License
Note: The output live-time corrected channel is calculated using the formula:
livetime_value = 1000 * raw_value / livetime_value
where:
livetime_value = output dead-time corrected value raw_value = raw channel value (counts) livetime_value = live time channel value (milliseconds)
Ref: See the RPSFILT.GXC file for details and implementation of the algorithm.
- classmethod radio_element_bandpass_filter(db, line, inputCh1, inputCh2, inputCh3, ch1_short_cutoff, ch1_high_cutoff, ch2_short_cutoff, ch2_high_cutoff, ch3_short_cutoff, ch3_high_cutoff, outputCh1, outputCh2, outputCh3)[source]¶
Applies a band-pass filter for up to three elements simultaneously
- Parameters:
line (int) – Line to process (NULLSYMB for all selected lines)
inputCh1 (int) – Input channel 1 handle (READONLY) (can be NULLSYMB to skip channel 1)
inputCh2 (int) – Input channel 2 handle (READONLY) (can be NULLSYMB to skip channel 2)
inputCh3 (int) – Input channel 3 handle (READONLY) (can be NULLSYMB to skip channel 3)
ch1_short_cutoff (float) – Channel 1 short wavelength cutoff
ch1_high_cutoff (float) – Channel 1 high wavelength cutoff
ch2_short_cutoff (float) – Channel 2 short wavelength cutoff
ch2_high_cutoff (float) – Channel 2 high wavelength cutoff
ch3_short_cutoff (float) – Channel 3 short wavelength cutoff
ch3_high_cutoff (float) – Channel 3 high wavelength cutoff
outputCh1 (int) – Output filtered channel 1 handle (READWRITE)
outputCh2 (int) – Output filtered channel 2 handle (READWRITE)
outputCh3 (int) – Output filtered channel 3 handle (READWRITE)
New in version 2025.2.
License: Geosoft End-User License
Note: Use short wavelength = 0 for highpass. is simply copied to the output channel without filtering.
- Ref: See the RPSFILT.GXC, RPSLEVLT.GXC, RPSLEVLU.GXC and RPSRATIO.GXC files
for details and implementation of the algorithm.
- classmethod radio_element_ground_exposure_rate(db, line, K, U, Th, Exposure)[source]¶
Applies ground level exposure rate
- Parameters:
New in version 2025.2.
License: Geosoft End-User License
Note: Ground exposure rate gives the measure of the rate of ionizations produced in air by photon radiation, which is the amount of exposure received.
E = 1.505𝐾(%) + 0.653𝑒𝑈(𝑝𝑝𝑚)+ 0.287𝑒𝑇ℎ(𝑝𝑝𝑚)
where:
𝐾 = Corrected Potassium 𝑒𝑈 = Corrected Uranium 𝑒𝑇ℎ = Corrected Thorium
Ref: See the RPSCORR.GXC file for details and implementation of the algorithm.
- classmethod radio_element_minimum_concentration_filter(db, line, K, U, Th, potassium_percent, uranium_ppm, thorium_ppm, threshold_method)[source]¶
Minimum Concentration Filtering
- Parameters:
line (int) – Line to process (NULLSYMB for all selected lines)
K (str) – Input/Output Postassium channel
U (str) – Input/Output Uranium channel
Th (str) – Input/Output Thorium channel
potassium_percent (float) – Input min. potassium ratio (default: 1.0)
uranium_ppm (float) – Input min. uranium ratio (default: 1.0)
thorium_ppm (float) – Input min. thorium ratio (default: 1.0)
threshold_method (int) – min. threshold method (0: Clip, 1: DUMMY)
New in version 2025.2.
License: Geosoft End-User License
Note: The conversions are calculated using the formulae: (Clip) if(( %s <= 0.0 || %s < %lf ) && %s != DUMMY) %s = KMIN; if(( %s <= 0.0 || %s < %lf ) && %s != DUMMY) %s = UMIN; if(( %s <= 0.0 || %s < %lf ) && %s != DUMMY) %s = THMIN;
The conversions are calculated using the formulae: (Dummy) if(( %s <= 0.0 || %s < %lf ) && %s != DUMMY) %s = DUMMY;
where:
KMIN = Min Potassium in %K ppm (Default is 1.0) UMIN = Min Uranium in eU ppm (Default is 1.0) THMIN = Min Thorium in eTH ppm (Default is 1.0)
Ref: See the RPSRATIO.GXC file for details and implementation of the algorithm.
- classmethod radio_element_ratios(db, line, K_in, U_in, Th_in, uk_ratio, uth_ratio, thk_ratio)[source]¶
Calculate radioelement ratios
- Parameters:
line (int) – Line to process (NULLSYMB for all selected lines)
K_in (str) – Input filtered Postassium channel
U_in (str) – Input filtered Uranium channel
Th_in (str) – Input filtered Thorium channel
uk_ratio (str) – Output Uranium/Potassium ratio channel name
uth_ratio (str) – Output Uranium/Thorium ratio channel name
thk_ratio (str) – Output Thorium/Potassium ratio channel name
New in version 2025.2.
License: Geosoft End-User License
Note: The conversions are calculated using the formulae:
OutputUKRatio = InputU /InputK OutputUThRatio = InputU / InputTh OutputThKRatio = InputTh /InputK
where:
InputK = Filtering Potassium InputU = Filtering Uranium InputTh = Filtering Thorium
Ref: See the RPSRATIO.GXC file for details and implementation of the algorithm.
- classmethod radon_aircraft_cosmic_correction(db, line, K_filt, U_filt, Th_filt, TC_filt, U_upward_filt, Cosmic_filt, aircraft_k, aircraft_u, aircraft_th, aircraft_tc, aircraft_upu, cosmic_k, cosmic_u, cosmic_th, cosmic_tc, cosmic_upu, K_levl, U_levl, Th_levl, TC_levl, U_upward_levl)[source]¶
Remove effects of aircraft and cosmic stripping
- Parameters:
line (int) – Line to process (NULLSYMB for all selected lines)
K_filt (str) – Input filtered potassium channel
U_filt (str) – Input filtered uranium channel
Th_filt (str) – Input filtered thorium channel
TC_filt (str) – Input filtered total count channel
U_upward_filt (str) – Input filtered upward uranium channel (optional - can be left blank)
Cosmic_filt (str) – Input filtered cosmic channel
aircraft_k (float) – Aircraft background value for potassium (cps). (Default = 12)
aircraft_u (float) – Aircraft background value for uranium (cps). (Default = 2.2)
aircraft_th (float) – Aircraft background value for thorium (cps). (Default = 1.5)
aircraft_tc (float) – Aircraft background value for total count (cps). (Default = 90)
aircraft_upu (float) – Aircraft background value for upward uranium (cps) (optional - can be left blank). (Default = 0.6)
cosmic_k (float) – Cosmic stripping ratio for potassium (cps/cosmic cps). (Default = 0.032)
cosmic_u (float) – Cosmic stripping ratio for uranium (cps/cosmic cps). (Default = 0.026)
cosmic_th (float) – Cosmic stripping ratio for thorium (cps/cosmic cps). (Default = 0.03)
cosmic_tc (float) – Cosmic stripping ratio for total count (cps/cosmic cps). (Default = 0.6)
cosmic_upu (float) – Cosmic stripping ratio for upward uranium (cps/cosmic cps) (optional - can be left blank). (Default = 0.008)
K_levl (str) – Output levelled potassium channel
U_levl (str) – Output levelled uranium channel
Th_levl (str) – Output levelled thorium channel
TC_levl (str) – Output levelled total count channel
U_upward_levl (str) – Output levelled upward uranium channel (optional - can be left blank)
New in version 2025.2.
License: Geosoft End-User License
Note: This wrapper performs the following simple operation:
LEVL = FILT - (AIRBACK + COS_STRIP * COSFILT)
where:
LEVL = Output levelled element channel FILT = Input filtered element channel AIRBACK = Input Air Background value for that element COS_STRIP = Input Cosmic Stripping factor for that element COSFILT = Input filtered cosmic channel
The Upward uranium parameters are optional and can be left blank if not required, but all three should be defined for the Upward method.
Ref: See the RPSLEVU.GXC file for details and implementation of the algorithm.
- classmethod radon_background_table(db, line, table, ref_field, K_field, U_field, Th_field, TC_field, ref_channel, K_channel, U_channel, Th_channel, TC_channel, interp_mode)[source]¶
Calculate the Radon Background using a Background Table
- Parameters:
line (int) – Line to process (NULLSYMB for all selected lines)
table (GXTB) – Reference background look-up table (e.g. “rpsbackg.tbl”
ref_field (str) – Reference field name in table
K_field (str) – Potassium field name in table
U_field (str) – Uranium field name in table
Th_field (str) – Thorium field name in table
TC_field (str) – Total count field name in table
ref_channel (int) – Reference channel handle (READONLY)
K_channel (int) – Output potassium channel handle (READWRITE)
U_channel (int) – Output uranium channel handle (READWRITE)
Th_channel (int) – Output thorium channel handle (READWRITE)
TC_channel (int) – Output total count channel handle (READWRITE)
interp_mode (int) – DU_LOOKUP constants
New in version 2025.2.
License: Geosoft End-User License
Note: Background levels for K, U, Th and TC are calculated obtained by table-lookup using a reference channel.
Ref: See the RPSLEVT.GXC file for details and implementation of the algorithm.
- classmethod radon_overwater_background_correction(db, line, K_bg, U_bg, Th_bg, TC_bg, K_ref, U_ref, Th_ref, TC_ref, K_rad, U_rad, Th_rad, TC_rad)[source]¶
Overwater Radon correction method: Calculate radon correction levels from the reference channel
- Parameters:
line (int) – Line to process (NULLSYMB for all selected lines)
K_bg (str) – Input Potassium channel
U_bg (str) – Input Uranium channel
Th_bg (str) – Input Thorium channel
TC_bg (str) – Input Total Count channel
K_ref (str) – Input Potassium Radon reference channel
U_ref (str) – Input Uranium Radon reference channel
Th_ref (str) – Input Thorium Radon reference channel
TC_ref (str) – Input Total Count Radon reference channel
K_rad (str) – Output Potassium channel
U_rad (str) – Output Uranium channel
Th_rad (str) – Output Thorium channel
TC_rad (str) – Output Total Count channel
New in version 2025.2.
License: Geosoft End-User License
Note: Radon water background correction channel:
K_rad = K_bg - KREF Output Potassium Radon background correction channel U_rad = U_bg - UREF Output Uranium Radon background correction channel Th_rad = TH_bg - THREF Output Thorium Radon background correction channel TC_rad = TC_bg - TCREF Output Total Count Radon background correction channe
where
K_bg = Input Potassium levelled count channel U_bg = Input Uranium levelled count channel TH_bg = Input Thorium levelled count channel TC_bg = Input Total Count levelled count channel
and
KREF = Input Radon background reference channel UREF = Input Radon background reference channel THREF = Input Radon background reference channel TCREF = Input Radon background reference channel
Ref: See the RPSLEVT.GXC file for details and implementation of the algorithm.
- classmethod radon_overwater_create_background_table(db, flight_ref_channel, water_back_ref_channel, K_ref, U_ref, Th_ref, TC_ref, fid_ref, table)[source]¶
Create the table (TB) file used for the overwater radon removal method
- Parameters:
flight_ref_channel (str) – Input Flight Reference table column name (.e.g “_RpsFlight_”
water_back_ref_channel (str) – Input Water Background Reference channel name
K_ref (str) – Input Potassium Radon reference channel
U_ref (str) – Input Uranium Radon reference channel
Th_ref (str) – Input Thorium Radon reference channel
TC_ref (str) – Input Total Count Radon reference channel
fid_ref (str) – Reference (e.g. FID) channel name (created)
table (str) – Output Radon reference table name
New in version 2025.2.
License: Geosoft End-User License
Note: The Radon reference channels are scanned to produce a table of background values. The table is created for all selected lines.
Ref: See the RPSLEVT.GXC file for details and implementation of the algorithm.
- classmethod radon_overwater_reference_channels(db, line, K_levl, U_levl, Th_levl, TC_levl, water_back_ref_channel, K_ref, U_ref, Th_ref, TC_ref)[source]¶
Overwater Radon removel method: Calculate radon reference levels from the filtered data
- Parameters:
line (int) – Line to process (NULLSYMB for all selected lines)
K_levl (str) – Input levelled Potassium data channel
U_levl (str) – Input levelled Uranium data channel
Th_levl (str) – Input levelled Thorium data channel
TC_levl (str) – Input levelled Total Count data channel
water_back_ref_channel (str) – Input Water Background Reference channel name
K_ref (str) – Output Potassium Radon reference channel
U_ref (str) – Output Uranium Radon reference channel
Th_ref (str) – Output Thorium Radon reference channel
TC_ref (str) – Output Total Count Radon reference channel
New in version 2025.2.
License: Geosoft End-User License
Note: Radon reference channels are calculate via simple multiplication with the water background reference channel:
KREF = KLEV * WREF Output Potassium Radon reference channel UREF = ULEV * WREF Output Uranium Radon reference channel THREF = THLEV * WREF Output Thorium Radon reference channel TCREF = TCLEV * WREF Output Total Count Radon reference channe
where
KLEV = Input Potassium levelled count channel ULEV = Input Uranium levelled count channel THLEV = Input Thorium levelled count channel TCLEV = Input Total Count levelled count channel
and
WREF = Input Water Background Reference channel
Ref: See the RPSLEVT.GXC file for details and implementation of the algorithm.
- classmethod radon_upward_removal_apply(db, line, K_filt, U_filt, Th_filt, TC_filt, U_upward_filt, K_back, U_back, Th_back, TC_back, U_upward_back, K_out, U_out, Th_out, TC_out, U_upward_out)[source]¶
Remove the calculated Radon Background using the ‘upward’ method
- Parameters:
line (int) – Line to process (NULLSYMB for all selected lines)
K_filt (str) – Input Low-pass filtered potassium channel
U_filt (str) – Input Low-pass filtered uranium channel
Th_filt (str) – Input Low-pass filtered thorium channel
TC_filt (str) – Input Low-pass filtered total count channel
U_upward_filt (str) – Input Low-pass filtered upward uranium channel
K_back (str) – Input potassium background to remove (channel)
U_back (str) – Input uranium background to remove (channel)
Th_back (str) – Input thorium channel background to remove (channel)
TC_back (str) – Input total count background to remove (channel)
U_upward_back (str) – Input upward uranium background to remove (channel)
K_out (str) – Output potassium channel with background radon removed
U_out (str) – Output uranium channel with background radon removed
Th_out (str) – Output thorium channel with background radon removed
TC_out (str) – Output total count channel with background radon removed
U_upward_out (str) – Output upward uranium channel with background radon removed
New in version 2025.2.
License: Geosoft End-User License
Note: The calculated Radon Background to remove is applied to the data channels using the formula:
KOUT = KFILT - KRADREF Output potassium channel with radon background removed UOUT = UFILT - URADREF Output uranium channel with radon background removed THOUT = THFILT - THRADREF Output thorium channel with radon background removed TCOUT = TCFILT - TCRADREF Output total count channel with radon background removed UPUOUT = UPUFILT - UPURADREF Output upward uranium channel with radon background removed
where:
KFILT = Input Low-pass filtered potassium channel UFILT = Input Low-pass filtered uranium channel THFILT = Input Low-pass filtered thorium channel TCFILT = Input Low-pass filtered total count channel UPUFILT = Input Low-pass filtered upward uranium channel
and the following calculated using the RadonUpwardRemovalCalculate_RPS method:
KRADREF = Input potassium background to remove (channel) URADREF = Input uranium background to remove (channel) THRADREF = Input uranium background to remove (channel) TCRADREF = Input thorium background to remove (channel) UPURADREF = Input upward uranium background to remove (channel)
Ref: See the RPSLEVLU.GXC file for details and implementation of the algorithm.
- classmethod radon_upward_removal_calculate(db, line, U_filt, Th_filt, U_upward_filt, skyshine_A1, skyshine_A2, ak, ath, au, atc, bk, bu, bth, btc, K_back, U_back, Th_back, TC_back, U_upward_back)[source]¶
Calculate the Radon Background to remove using the ‘upward’ method
- Parameters:
line (int) – Line to process (NULLSYMB for all selected lines)
U_filt (str) – Input Low-pass filtered uranium channel
Th_filt (str) – Input Low-pass filtered thorium channel
U_upward_filt (str) – Input Low-pass filtered upward uranium channel
skyshine_A1 (float) – Input Skyshine coefficient A1 (default: 0.036)
skyshine_A2 (float) – Input Skyshine coefficient A2 (default: 0.022)
ak (float) – Input calibration factor ak - potassium (default: 0.8)
ath (float) – Input calibration factor ath - thorium (default: 0.1)
au (float) – Input calibration factor au - uranium (default: 0.25)
atc (float) – Input calibration factor atc - total count (default: 12)
bk (float) – Input calibration factor bk - potassium (default: 0)
bu (float) – Input calibration factor bu - uranium (default: 0)
bth (float) – Input calibration factor bth - thorium (default: 0)
btc (float) – Input calibration factor btc - total count (default: 0)
K_back (str) – Output potassium background to remove (channel)
U_back (str) – Output uranium background to remove (channel)
Th_back (str) – Output thorium channel background to remove (channel)
TC_back (str) – Output total count background to remove (channel)
U_upward_back (str) – Output upward uranium background to remove (channel)
New in version 2025.2.
License: Geosoft End-User License
- Note: The Upward method of radon-removal is applied to the low-pass filtered data,
using the formula:
KRADREF = AK * URADREF + BK Output potassium background to remove (channel) THRADREF = ATH * URADREF + BTH Output thorium background to remove (channel) TCRADREF = ATC * URADREF + BTC Output total count background to remove (channel) UPURADREF = AU * URADREF + BU Output upward uranium background to remove (channel)
where:
AK = Input calibration factor ak (default: 0.8) BK = Input calibration factor bk (default: 0) ATH = Input calibration factor at (default: 0.1) BTH = Input calibration factor bt (default: 0) ATC = Input calibration factor atc (default: 12) BTC = Input calibration factor btc (default: 0) AU = Input calibration factor au (default: 0.25) BU = Input calibration factor bu (default: 0)
and:
URADREF = Output uranium background to remove (channel)
where
- URADREF = (UPUFILT - A1*UFILT - A2*THFILT + A2*BT - BU)/
(AU-A1 - A2*AT)
THFILT = Input Low-pass filtered thorium channel UFILT = Input Low-pass filtered uranium channel UPUFILT = Input Low-pass filtered upward uranium channel
and
A1 = Input Skyshine coefficient A1 (default: 0.036) A2 = Input Skyshine coefficient A2 (default: 0.022)
Ref: See the RPSLEVLU.GXC file for details and implementation of the algorithm.
- classmethod stp_correction_from_barometric_altitude(db, line, raw_radar_altimeter, raw_barometric_altimeter_channel, temperature_channel, stp_alt_channel)[source]¶
Apply the Standard Temperature/Pressure (STP) correction to the altimeter channel for a line in a database
- Parameters:
line (int) – Line to process (NULLSYMB for all selected lines)
raw_radar_altimeter (str) – Input (BP-filtered) radar altimeter channel name
raw_barometric_altimeter_channel (str) – Input raw barometric altimeter channel name
temperature_channel (str) – Input temperature channel name (degrees Celsius)
stp_alt_channel (str) – Output STP corrected altimeter channel name
New in version 2025.2.
License: Geosoft End-User License
Note: The output STP corrected altitude is calculated using the formula:
STP_Altitude = (273.15 * radar_alt * exp(-1.0/8581.0 * barometric_alt))/(273.15 + temp)
where:
STP_Altitude = STP corrected altitude (m) radar_alt = raw radar altimeter channel value (m) barometric_alt = raw barometric altimeter channel value (m) temp = temperature channel value (degrees Celsius)
Ref: See the RPSFILT.GXC file for details and implementation of the algorithm.
- classmethod stp_correction_from_pressure(db, line, raw_radar_altimeter, pressure_channel, temperature_channel, stp_alt_channel)[source]¶
Apply the Standard Temperature/Pressure (STP) correction to the altimeter channel for a line in a database
- Parameters:
line (int) – Line to process (NULLSYMB for all selected lines)
raw_radar_altimeter (str) – Input (BP-filtered) radar altimeter channel name
pressure_channel (str) – Input pressure channel name (kPa)
temperature_channel (str) – Input temperature channel name (degrees Celsius)
stp_alt_channel (str) – Output STP corrected altimeter channel name
New in version 2025.2.
License: Geosoft End-User License
Note: The output STP corrected altitude is calculated using the formula:
STP_Altitude = (273.15 * radar_alt * P))/((273.15 + temp) * 101.325)
where:
STP_Altitude = STP corrected altitude (m) radar_alt = raw radar altimeter channel value (m) P = raw pressure channel value (kPa) temp = temperature channel value (degrees Celsius)
- classmethod window_spectrum_to_channel(db, line, spectral_data, start_window, end_window, output_channel, channel_description)[source]¶
Window radiometric data channel on a line in a database
- Parameters:
line (int) – Line to process (NULLSYMB for all selected lines)
spectral_data (int) – Spectral data channel handle (READONLY)
start_window (float) – Starting fractional window index (0 to N)
end_window (float) – Ending fractional window index (0 to N), >= Starting window
output_channel (int) – Output channel handle (READWRITE)
channel_description (str) – Output channel description for output/errors etc
New in version 2025.2.
License: Geosoft End-User License
Note: The average value of the windows in the given fractional index range is written to the specified output channel. For instance, if you specified 0.5 to 1.5, then half values in the first window would be added to half the values in the second window. To specify a single window ‘i’ you need to specify the range i to i+1.
Ref: See the RPSWINDOW.GXC file for details and implementation of the algorithm.
RPS_FITMODE constants¶
Full spectrum analysis fit mode