diff --git a/burnman/__init__.py b/burnman/__init__.py index f542669cb..f837c10d8 100644 --- a/burnman/__init__.py +++ b/burnman/__init__.py @@ -35,7 +35,7 @@ (including Vinet, Birch Murnaghan, Mie-Debye-Grueneisen, Modified Tait), and solution models (ideal, symmetric, asymmetric, subregular). - popular endmember and solution datasets already coded into burnman-usable format - (including :cite:`HP2011`, :cite:`Stixrude2005` and :cite:`Stixrude2011`) + (including :cite:`HP2011`, :cite:`Stixrude2005`, :cite:`Stixrude2011` and :cite:`Stixrude2022`) - Optimal least squares fitting routines for multivariate data with (potentially correlated) errors in pressure and temperature. As an example, such functions can be used to simultaneously fit volumes, seismic velocities and enthalpies. diff --git a/burnman/data/input_raw_endmember_datasets/HeFESTo_to_burnman.py b/burnman/data/input_raw_endmember_datasets/HeFESTo_to_burnman.py new file mode 100644 index 000000000..14386abf9 --- /dev/null +++ b/burnman/data/input_raw_endmember_datasets/HeFESTo_to_burnman.py @@ -0,0 +1,424 @@ +# This file is part of BurnMan - a thermoelastic and thermodynamic toolkit for +# the Earth and Planetary Sciences +# Copyright (C) 2012 - 2023 by the BurnMan team, released under the GNU +# GPL v2 or later. + + +# This is a script that converts a version of the +# HeFESTo data format into the standard burnman +# format (printed to stdout) +# This script is used to generate the 2022 dataset, +# taking parameters from https://github.com/stixrude/HeFESTo_parameters_010121 +# via git clone https://github.com/stixrude/HeFESTo_parameters_010121.git +# The SLB_2022 BurnMan file is then created via the commands +# python HeFESTo_to_burnman.py > ../../minerals/SLB_2022.py; black ../../minerals/SLB_2022.py +# and from . import SLB_2022 added to the minerals __init__.py + + +import os +import pathlib +import pandas as pd +import numpy as np +from burnman.utils.chemistry import dictionarize_formula +from itertools import groupby +import re + + +def all_equal(iterable): + g = groupby(iterable) + return next(g, True) and not next(g, False) + + +def rfloat(x, m=1.0): + return round(float(x) * m, ndigits=10) + + +hefesto_path = "HeFESTo_parameters_010121" +mbrdir = pathlib.Path(hefesto_path) +phasedir = pathlib.Path(f"{hefesto_path}/phase") + +param_dict = {} +with open("hefesto_parameter_names.txt") as file: + lines = [line.rstrip() for line in file] + for line in lines: + param_dict[" ".join(line.split()[1:])] = line.split()[0] + +ignored_mbrs = [ + "crst", + "enm", + "fapv", + "fea", + "fee", + "feg", + "flpv", + "hem", + "hepv", + "hlpv", + "hmag", + "hppv", + "lppv", + "mag", + "mgl", + "sil", + "wuls", +] + +solution_aliases = { + "sp": "mg_fe_aluminous_spinel", + "pv": "bridgmanite", + "opx": "orthopyroxene", + "gt": "garnet", + "ol": "olivine", + "cf": "calcium_ferrite_structured_phase", + "ppv": "post_perovskite", + "c2c": "c2c_pyroxene", + "ri": "ringwoodite", + "plg": "plagioclase", + "mw": "ferropericlase", + "cpx": "clinopyroxene", + "nal": "new_aluminous_phase", + "il": "ilmenite", + "wa": "wadsleyite", +} + +# solutions +sol_params = {} +for f in phasedir.iterdir(): + # Do not process liquid!! + if os.stat(f).st_size > 0 and str(f).split("/")[-1] != "liq": + name = str(f).split("/")[-1] + d = pd.read_csv(f, delim_whitespace=True) + + endmembers = list(d.columns) + + n_mbrs = len(endmembers) + + data = d.values.tolist() + + n_data = len(data) + v0 = n_data - n_mbrs + + # Preprocess interaction matrices + # to get rid of ignored endmembers + use_indices = np.array( + [i for i, mbr in enumerate(endmembers) if mbr not in ignored_mbrs] + ) + use_endmembers = np.array( + [mbr for mbr in endmembers if mbr not in ignored_mbrs] + ) + n_use_mbrs = len(use_indices) + + energy_matrix = np.array( + np.array(data)[np.ix_(use_indices, use_indices)], dtype=float + ) + volume_matrix = np.array( + np.array(data)[np.ix_(v0 + use_indices, use_indices)], dtype=float + ) + + if n_data == 2 * n_mbrs + 1: + energy_interactions = [] + energy_interactions_2 = [] + volume_interactions = [] + for i in range(n_use_mbrs - 1): + j = i + 1 + energy_interactions.append( + list(np.around(energy_matrix[i][j:] * 1000.0, decimals=6)) + ) + energy_interactions_2.append( + list(np.around(energy_matrix[i][:j] * 1000.0, decimals=6)) + ) + volume_interactions.append( + list(np.around(volume_matrix[i][j:] * 1.0e-6, decimals=20)) + ) + + max_abs_e = np.max( + np.abs([item for sublist in energy_interactions for item in sublist]) + ) + max_abs_v = np.max( + np.abs([item for sublist in volume_interactions for item in sublist]) + ) + max_abs_lower_triangular_e2 = np.max( + np.abs([item for sublist in energy_interactions_2 for item in sublist]) + ) + assert max_abs_lower_triangular_e2 < 1.0e-3 + + # print(endmembers, n_mbrs) + # print(energy_interactions) + if max_abs_v > 1.0e-20: + # print(volume_interactions) + pass + + alphas = [] + mbr_sites = [] + for mbr in use_endmembers: + with open(f"HeFESTo_parameters_010121/{mbr}") as file: + lines = [line.rstrip() for line in file] + i_laar = [i for i, line in enumerate(lines) if "Laar" in line][0] + alphas.append(float(lines[i_laar].split()[0])) + + formula_raw = lines[0].split()[0] + + # Catch for MgTs mixing + if mbr == "mgts": + formula_raw = "Mg_1Al_1Si_2O_6" + + # Catch for plag mixing + if mbr == "ab": + formula_raw = "Na_1Al_2Si_2O_8" + + # Catch for mt mixing + if mbr == "mag": + formula_raw = "(Vac_1Fe_1)Fe_2O_4" + + starts = [i for i, char in enumerate(formula_raw) if char.isupper()] + mixstarts = [i for i, char in enumerate(formula_raw) if char == "("] + mixends = [i for i, char in enumerate(formula_raw) if char == ")"] + + for i in range(len(mixstarts)): + ms = mixstarts[i] + me = mixends[i] + starts = [i for i in starts if i < ms or i > me] + + starts.extend(mixstarts) + starts.sort() + sites = [ + formula_raw[i:j] for i, j in zip(starts, starts[1:] + [None]) + ] + mbr_sites.append(sites) + + n_sites = [len(sites) for sites in mbr_sites] + + assert all_equal(n_sites) + + active_sites = [] + for i in range(n_sites[0]): + occupancies = [sites[i] for sites in mbr_sites] + if not all_equal(occupancies): + active_sites.append(i) + + site_formula_strings = [] + totals = [] + for mbr_site in mbr_sites: + totals.append([]) + site_formula_strings.append("") + for i in active_sites: + # Get number of atoms on sites + n_atoms = [int(s) for s in re.findall(r"\d+", mbr_site[i])] + + species_starts = [ + i for i, char in enumerate(mbr_site[i]) if char.isupper() + ] + species_ends = [ + i for i, char in enumerate(mbr_site[i]) if char == "_" + ] + total_atoms = np.sum(n_atoms) + totals[-1].append(total_atoms) + + site_string = "[" + if len(n_atoms) > 1: + species = "" + for j in range(len(n_atoms)): + species += mbr_site[i][species_starts[j] : species_ends[j]] + species += f"{n_atoms[j]}/{total_atoms}" + site_string += species + else: + site_string += mbr_site[i][species_starts[0] : species_ends[0]] + + site_string += "]" + if total_atoms != 1: + site_string += f"{total_atoms}" + + site_formula_strings[-1] += site_string + + for i in range(len(totals[0])): + t = [total[i] for total in totals] + assert all_equal(t) + + solution_is_symmetric = np.max(np.abs(np.array(alphas) - 1.0)) < 1.0e-5 + + sol_params[name] = { + "name": name, + "n_mbrs": n_use_mbrs, + "mbr_names": use_endmembers, + "mbr_site_formulae": site_formula_strings, + "alphas": alphas, + } + + if max_abs_e < 1.0: + sol_params[name]["solution_type"] = "IdealSolution" + elif solution_is_symmetric: + sol_params[name]["solution_type"] = "SymmetricRegularSolution" + else: + sol_params[name]["solution_type"] = "AsymmetricRegularSolution" + + if max_abs_e > 1.0: + sol_params[name]["energy_interaction"] = energy_interactions + if max_abs_v > 1.0e-20: + sol_params[name]["volume_interaction"] = volume_interactions + + else: + pass + +# endmembers +mbr_params = {} +mbr_mods = {} +mbr_names = {} +for f in mbrdir.iterdir(): + if os.stat(f).st_size > 0: + name = str(f).split("/")[-1] + + process = False + try: + with open(f) as file: + lines = [line.rstrip().split() for line in file] + if lines[-1][-1] == "prime": + process = True + if lines[0][-1] == "Liquid": + process = False + except IsADirectoryError: + pass + + if process: + form = lines[0][0].replace("_", "").replace("(", "").replace(")", "") + formula = dictionarize_formula(form) + full_name = "_".join(lines[0][1:]) + # formula = formula_to_string(formula) + # print(formula) + # print(name) + idict = {} + for line in lines[1:]: + key = param_dict[" ".join(line[1:])] + idict[key] = line[0] + + if "T_crit" not in idict: + idict["T_crit"] = "0.00000" + + assert idict["debye"] == "1.00000" + + if idict["beta"] != "0.00000": + # Fe endmember equations of state not yet implemented + process = False + + if idict["zpp"] != "0.00000": + process = False + + if process: + mbr_params[name] = { + "name": full_name, + "formula": formula, + "equation_of_state": "slb3", + "F_0": rfloat(idict["F_0"], 1.0e3), + "V_0": rfloat(idict["V_0"], 1.0e-6), + "K_0": rfloat(idict["K_0"], 1.0e9), + "Kprime_0": rfloat(idict["Kprime_0"]), + "Debye_0": rfloat(idict["Theta_0"]), + "grueneisen_0": rfloat(idict["gamma_0"]), + "q_0": rfloat(idict["q_0"]), + "G_0": rfloat(idict["G_0"], 1.0e9), + "Gprime_0": rfloat(idict["Gprime_0"]), + "eta_s_0": rfloat(idict["eta_s_0"]), + "n": rfloat(idict["n"]), + "Z": rfloat(idict["Z"]), + "molar_mass": rfloat(idict["molar_mass"], 1.0e-3), + } + + if idict["T_crit"] != "0.00000": + mbr_mods[name] = [ + [ + "landau_slb_2022", + { + "Tc_0": float(idict["T_crit"]), + "S_D": float(idict["S_crit"]), + "V_D": float(idict["V_crit"]), + }, + ] + ] + mbr_names[name] = ( + full_name.lower() + .replace("-", "_") + .replace(" ", "_") + .replace("'", "") + .replace('\\"', "") + ) + +# WRITE FILE + +print( + "# This file is part of BurnMan - a thermoelastic and thermodynamic toolkit\n" + "# for the Earth and Planetary Sciences\n" + "# Copyright (C) 2012 - 2023 by the BurnMan team,\n" + "# released under the GNU GPL v2 or later.\n" + "\n\n" + '"""\n' + "SLB_2022\n" + "Minerals from Stixrude & Lithgow-Bertelloni 2022 and references therein\n" + f"File autogenerated using HeFESTO_to_burnman.py and {hefesto_path}\n" + '"""\n\n' + "from __future__ import absolute_import\n" + "\n\n" + "from ..classes.mineral import Mineral\n" + "from ..classes.solution import Solution\n" + "from ..classes.solutionmodel import (\n" + " IdealSolution,\n" + " SymmetricRegularSolution,\n" + " AsymmetricRegularSolution,\n" + ")\n\n" +) + +print('"""\n' "ENDMEMBERS\n" '"""\n') +for key, mbr_prm in sorted(mbr_params.items()): + print( + f"\nclass {key}(Mineral):\n" + " def __init__(self):\n" + f" self.params = {mbr_prm}\n" + ) + if key in mbr_mods: + print( + f" self.property_modifiers = {mbr_mods[key]}", + ) + print("") + print(" Mineral.__init__(self)") + print("") + +print('"""\n' "SOLUTIONS\n" '"""\n') + + +for key, prm in sorted(sol_params.items()): + print( + f"\nclass {solution_aliases[key]}(Solution):\n" + " def __init__(self, molar_fractions=None):\n" + f' self.name = "{solution_aliases[key]}"\n' + f" self.solution_model = {prm['solution_type']}(\n" + " endmembers=[" + ) + for i in range(prm["n_mbrs"]): + print( + f' [{prm["mbr_names"][i]}(), "{prm["mbr_site_formulae"][i]}"],' + ) + print(" ],") + + if prm["solution_type"] == "AsymmetricRegularSolution": + print(f" alphas={prm['alphas']},") + + if prm["solution_type"] != "IdealSolution": + print(f' energy_interaction={prm["energy_interaction"]},') + if "volume_interaction" in prm: + print(f' volume_interaction={prm["volume_interaction"]},') + + print(" )\n") + print(" Solution.__init__(self, molar_fractions=molar_fractions)\n") + + +print('\n"""\n' "ENDMEMBER ALIASES\n" '"""\n') + +for key, value in sorted(mbr_names.items()): + print(f"{value} = {key}") + +print("") + + +print('\n"""\n' "SOLUTION ALIASES\n" '"""\n') + +for key, value in sorted(solution_aliases.items()): + if key != "sp": + print(f"{key} = {value}") diff --git a/burnman/data/input_raw_endmember_datasets/hefesto_parameter_names.txt b/burnman/data/input_raw_endmember_datasets/hefesto_parameter_names.txt new file mode 100644 index 000000000..7a0a49328 --- /dev/null +++ b/burnman/data/input_raw_endmember_datasets/hefesto_parameter_names.txt @@ -0,0 +1,47 @@ +n Atoms in formula unit +Z Z, Formula units in unit cell +molar_mass Formula mass (g/mol) +T_ref T_0 (K) +F_0 F_0 (kJ/mol) +V_0 V_0 (cm^3/mol) +K_0 K_0 (GPa) +Kprime_0 K_0 prime +unknown K_0K_0 prime prime (zero for third order) +Theta_0 Theta_0 (K) +unknown Debye Acoustic Branch 2 +unknown Debye Acoustic Branch 3 +unknown Sin Acoustic Branch 1 +unknown Sin Acoustic Branch 2 +unknown Sin Acoustic Branch 3 +unknown Einstein Oscillator 1 +unknown Weight of Einstein Oscillator 1 +unknown Einstein Oscillator 2 +unknown Weight of Einstein Oscillator 2 +unknown Einstein Oscillator 3 +unknown Weight of Einstein Oscillator 3 +unknown Einstein Oscillator 4 +unknown Weight of Einstein Oscillator 4 +unknown Upper Limit of Optic Continuum +unknown Lower Limit of Optic Continuum +gamma_0 gamma_0 +q_0 q_0 +beta beta (electronic contribution) +gammael_0 gammael_0 (electronic contribution) +q_2A_2 q_2A_2 (anharmonic contribution) +unknown High Temperature Approximation (1=yes) +unknown Birch-Murnaghan (0) or Vinet (1) +debye Einstein (0) or Debye (1) +zpp Zero Point Pressure (1=yes) +G_0 Ambient Shear Modulus +Gprime_0 Pressure Derivative +eta_s_0 Temperature Derivative +T_crit Critical Temperature (K) +S_crit Critical Entropy (J/mol/K) +V_crit Critical Volume (cm^3/mol) +unknown Van Laar size parameter (-) +unknown C11 +unknown C12 +unknown C44 +unknown C11 prime +unknown C12 prime +unknown C44 prime diff --git a/burnman/eos/birch_murnaghan.py b/burnman/eos/birch_murnaghan.py index add334982..d4bf98a8b 100644 --- a/burnman/eos/birch_murnaghan.py +++ b/burnman/eos/birch_murnaghan.py @@ -249,7 +249,7 @@ def validate_parameters(self, params): warnings.warn("Unusual value for V_0", stacklevel=2) if params["K_0"] < 1.0e9 or params["K_0"] > 1.0e13: warnings.warn("Unusual value for K_0", stacklevel=2) - if params["Kprime_0"] < 0.0 or params["Kprime_0"] > 10.0: + if params["Kprime_0"] < 0.0 or params["Kprime_0"] > 20.0: warnings.warn("Unusual value for Kprime_0", stacklevel=2) if params["G_0"] < 0.0 or params["G_0"] > 1.0e13: warnings.warn("Unusual value for G_0", stacklevel=2) diff --git a/burnman/eos/property_modifiers.py b/burnman/eos/property_modifiers.py index 64f0b5514..a087ef130 100644 --- a/burnman/eos/property_modifiers.py +++ b/burnman/eos/property_modifiers.py @@ -11,7 +11,7 @@ """ Functions for modifying the thermodynamic properties of minerals Currently includes modifications for: -- second order transitions (landau, landau_hp), +- second order transitions (landau, landau_slb_2022, landau_hp), - order-disorder (bragg_williams), - magnetism (magnetic_chs), - and a linear modification (linear). @@ -29,12 +29,11 @@ def _landau_excesses(pressure, temperature, params): Holland and Powell (2011), who compute properties relative to the completely disordered state and standard states respectively. - The current implementation is preferred, as the excess - entropy (and heat capacity) terms are equal to zero at 0 K. + The excess entropy (and heat capacity) terms are equal to zero at 0 K. N.B. The excesses are for a *completely relaxed* mineral; for example, seismic wave propagation is *slow* compared to the - rate of reaction. + rate of change in order parameter. """ Tc = params["Tc_0"] + params["V_D"] * pressure / params["S_D"] @@ -100,6 +99,91 @@ def _landau_excesses(pressure, temperature, params): return (excesses, {"Q": np.sqrt(Q2)}) +def _landau_slb_2022_excesses(pressure, temperature, params): + """ + Applies a tricritical Landau correction to the properties + of an endmember which undergoes a displacive phase transition. + This correction follows Stixrude and Lithgow-Bertelloni (2022), + and is done relative to the state with order parameter Q=1. + + The order parameter of this formulation can exceed one, + at odds with Putnis (above), but in better agreement with + atomic intuition (Stixrude and Lithgow-Bertelloni, 2022). + Nevertheless, this implementation is still not perfect, + as the excess entropy (and heat capacity) terms are not equal + to zero at 0 K. Q is limited to values less than or equal to 2 + to avoid unrealistic stabilisation at ultrahigh pressure. + + N.B. These excesses are for a *completely relaxed* mineral; + for example, seismic wave propagation is *slow* compared to the + rate of change in order parameter. + """ + + Tc = params["Tc_0"] + params["V_D"] * pressure / params["S_D"] + + G_disordered = -params["S_D"] * ((temperature - Tc) + params["Tc_0"] / 3.0) + dGdT_disordered = -params["S_D"] + dGdP_disordered = params["V_D"] + + if temperature < Tc: + Q2 = np.sqrt((Tc - temperature) / params["Tc_0"]) + + if Q2 < 4.0: + # Wolfram input to check partial differentials + # x = T, y = P, a = S, c = Tc0, d = V + # D[D[a ((x - c - d*y/a)*((c + d*y/a - x)/c)^0.5 + # + c/3*((c + d*y/a - x)/c)^1.5), x], x] + # where Q2 = ((c + d*y/a - x)/c)^0.5 + G = ( + params["S_D"] + * ((temperature - Tc) * Q2 + params["Tc_0"] * Q2 * Q2 * Q2 / 3.0) + + G_disordered + ) + dGdP = -params["V_D"] * Q2 + dGdP_disordered + dGdT = params["S_D"] * Q2 + dGdT_disordered + d2GdP2 = ( + -0.5 + * params["V_D"] + * params["V_D"] + / (params["S_D"] * params["Tc_0"] * Q2) + ) + d2GdT2 = -0.5 * params["S_D"] / (Tc * Q2) + d2GdPdT = 0.5 * params["V_D"] / (Tc * Q2) + else: + # Wolfram input to check partial differentials + # x = T, y = P, a = S, c = Tc0, d = V + # D[D[a ((x - c - d*y/a)*4 + c/3*64), x], x] + G = ( + params["S_D"] * ((temperature - Tc) * 4.0 + params["Tc_0"] * 64.0 / 3.0) + + G_disordered + ) + dGdP = -params["V_D"] * 4.0 + dGdP_disordered + dGdT = params["S_D"] * 4.0 + dGdT_disordered + d2GdP2 = 0.0 + d2GdT2 = 0.0 + d2GdPdT = 0.0 + + else: + Q2 = 0.0 + G = G_disordered + dGdT = dGdT_disordered + dGdP = dGdP_disordered + d2GdT2 = 0.0 + d2GdP2 = 0.0 + d2GdPdT = 0.0 + + excesses = { + "G": G, + "dGdT": dGdT, + "dGdP": dGdP, + "d2GdT2": d2GdT2, + "d2GdP2": d2GdP2, + "d2GdPdT": d2GdPdT, + } + + return (excesses, {"Q": np.sqrt(Q2)}) + + def _landau_hp_excesses(pressure, temperature, params): """ Applies a tricritical Landau correction to the properties @@ -111,13 +195,12 @@ def _landau_hp_excesses(pressure, temperature, params): (Holland, pers. comm), which 'corrects' the terms involving the critical temperature Tc / Tc* - Note that this formalism is still inconsistent, as it predicts that - the order parameter can be greater than one. For this reason - _landau_excesses is preferred. + This formalism predicts that the order parameter can be greater + than one, unlike _landau_excesses. N.B. The excesses are for a *completely relaxed* mineral; i.e. the seismic wave propagation is *slow* compared to the - rate of reaction. + rate of change in order parameter. """ P = pressure @@ -606,6 +689,8 @@ def calculate_property_modifications(mineral): for modifier in mineral.property_modifiers: if modifier[0] == "landau": xs_function = _landau_excesses + elif modifier[0] == "landau_slb_2022": + xs_function = _landau_slb_2022_excesses elif modifier[0] == "landau_hp": xs_function = _landau_hp_excesses elif modifier[0] == "linear": diff --git a/burnman/minerals/SLB_2022.py b/burnman/minerals/SLB_2022.py new file mode 100644 index 000000000..8b05f60b8 --- /dev/null +++ b/burnman/minerals/SLB_2022.py @@ -0,0 +1,1950 @@ +# This file is part of BurnMan - a thermoelastic and thermodynamic toolkit +# for the Earth and Planetary Sciences +# Copyright (C) 2012 - 2023 by the BurnMan team, +# released under the GNU GPL v2 or later. + + +""" +SLB_2022 +Minerals from Stixrude & Lithgow-Bertelloni 2022 and references therein +File autogenerated using HeFESTO_to_burnman.py and HeFESTo_parameters_010121 +""" + +from __future__ import absolute_import + + +from ..classes.mineral import Mineral +from ..classes.solution import Solution +from ..classes.solutionmodel import ( + IdealSolution, + SymmetricRegularSolution, + AsymmetricRegularSolution, +) + + +""" +ENDMEMBERS +""" + + +class ab(Mineral): + def __init__(self): + self.params = { + "name": "Albite", + "formula": {"Na": 1.0, "Al": 1.0, "Si": 3.0, "O": 8.0}, + "equation_of_state": "slb3", + "F_0": -3720147.5999999996, + "V_0": 0.000100452, + "K_0": 59752680000.0, + "Kprime_0": 2.77841, + "Debye_0": 720.00359, + "grueneisen_0": 0.57885, + "q_0": 1.0, + "G_0": 36000000000.0, + "Gprime_0": 1.38571, + "eta_s_0": 1.02978, + "n": 13.0, + "Z": 4.0, + "molar_mass": 0.262223, + } + + Mineral.__init__(self) + + +class al(Mineral): + def __init__(self): + self.params = { + "name": "Almandine", + "formula": {"Fe": 3.0, "Al": 2.0, "Si": 3.0, "O": 12.0}, + "equation_of_state": "slb3", + "F_0": -4933027.97, + "V_0": 0.00011543, + "K_0": 173896370000.0, + "Kprime_0": 4.91341, + "Debye_0": 741.38227, + "grueneisen_0": 1.06493, + "q_0": 1.42169, + "G_0": 96000000000.0, + "Gprime_0": 1.40927, + "eta_s_0": 2.09289, + "n": 20.0, + "Z": 4.0, + "molar_mass": 0.49776, + } + + self.property_modifiers = [ + ["landau_slb_2022", {"Tc_0": 7.5, "S_D": 40.14405, "V_D": 0.0}] + ] + + Mineral.__init__(self) + + +class alpv(Mineral): + def __init__(self): + self.params = { + "name": "Al-Perovskite", + "formula": {"Al": 2.0, "O": 3.0}, + "equation_of_state": "slb3", + "F_0": -1517728.6300000001, + "V_0": 2.4944e-05, + "K_0": 242400000000.0, + "Kprime_0": 4.1, + "Debye_0": 858.26509, + "grueneisen_0": 1.54222, + "q_0": 0.84088, + "G_0": 169199620000.0, + "Gprime_0": 1.55703, + "eta_s_0": 2.2751, + "n": 5.0, + "Z": 4.0, + "molar_mass": 0.101961, + } + + Mineral.__init__(self) + + +class an(Mineral): + def __init__(self): + self.params = { + "name": "Anorthite", + "formula": {"Ca": 1.0, "Al": 2.0, "Si": 2.0, "O": 8.0}, + "equation_of_state": "slb3", + "F_0": -4013369.04, + "V_0": 0.00010061, + "K_0": 84093310000.0, + "Kprime_0": 6.73404, + "Debye_0": 752.34537, + "grueneisen_0": 0.38497, + "q_0": 1.0, + "G_0": 39900000000.0, + "Gprime_0": 1.09129, + "eta_s_0": 1.63323, + "n": 13.0, + "Z": 2.0, + "molar_mass": 0.278211, + } + + Mineral.__init__(self) + + +class anao(Mineral): + def __init__(self): + self.params = { + "name": "alpha-NaO2_phase", + "formula": {"Na": 2.0, "Al": 2.0, "O": 4.0}, + "equation_of_state": "slb3", + "F_0": -2114835.79, + "V_0": 4.542e-05, + "K_0": 161143930000.0, + "Kprime_0": 3.90838, + "Debye_0": 753.49641, + "grueneisen_0": 1.45033, + "q_0": 1.5487, + "G_0": 108455900000.0, + "Gprime_0": 2.14668, + "eta_s_0": 0.78047, + "n": 8.0, + "Z": 1.0, + "molar_mass": 0.16394023, + } + + Mineral.__init__(self) + + +class apbo(Mineral): + def __init__(self): + self.params = { + "name": "alpha-PbO_2-SiO_2", + "formula": {"Si": 1.0, "O": 2.0}, + "equation_of_state": "slb3", + "F_0": -793366.84, + "V_0": 1.367e-05, + "K_0": 327156010000.0, + "Kprime_0": 4.01662, + "Debye_0": 1128.9459, + "grueneisen_0": 1.55674, + "q_0": 2.2096, + "G_0": 227411590000.0, + "Gprime_0": 1.77078, + "eta_s_0": 4.55828, + "n": 3.0, + "Z": 4.0, + "molar_mass": 0.060085, + } + + Mineral.__init__(self) + + +class appv(Mineral): + def __init__(self): + self.params = { + "name": "Al-Post-Perovskite", + "formula": {"Al": 2.0, "O": 3.0}, + "equation_of_state": "slb3", + "F_0": -1336464.73, + "V_0": 2.3847e-05, + "K_0": 249000000000.0, + "Kprime_0": 4.0, + "Debye_0": 722.93835, + "grueneisen_0": 1.88758, + "q_0": 2.04631, + "G_0": 91965260000.0, + "Gprime_0": 1.81603, + "eta_s_0": 2.52605, + "n": 5.0, + "Z": 4.0, + "molar_mass": 0.101961, + } + + Mineral.__init__(self) + + +class capv(Mineral): + def __init__(self): + self.params = { + "name": "Ca-Perovskite", + "formula": {"Ca": 1.0, "Si": 1.0, "O": 3.0}, + "equation_of_state": "slb3", + "F_0": -1459910.1800000002, + "V_0": 2.745e-05, + "K_0": 236000000000.0, + "Kprime_0": 3.9, + "Debye_0": 798.78581, + "grueneisen_0": 1.88943, + "q_0": 0.89662, + "G_0": 155205240000.0, + "Gprime_0": 2.22637, + "eta_s_0": 1.23493, + "n": 5.0, + "Z": 1.0, + "molar_mass": 0.116164, + } + + Mineral.__init__(self) + + +class cats(Mineral): + def __init__(self): + self.params = { + "name": "Lime_Tschermak'", + "formula": {"Ca": 1.0, "Al": 2.0, "Si": 1.0, "O": 6.0}, + "equation_of_state": "slb3", + "F_0": -3119447.41, + "V_0": 6.3574e-05, + "K_0": 113759900000.0, + "Kprime_0": 4.8061, + "Debye_0": 804.36068, + "grueneisen_0": 0.82288, + "q_0": 0.60142, + "G_0": 74424990000.0, + "Gprime_0": 1.71384, + "eta_s_0": 1.73383, + "n": 10.0, + "Z": 1.0, + "molar_mass": 0.218123, + } + + Mineral.__init__(self) + + +class cen(Mineral): + def __init__(self): + self.params = { + "name": "Clinoenstatite", + "formula": {"Mg": 2.0, "Si": 2.0, "O": 6.0}, + "equation_of_state": "slb3", + "F_0": -2906835.53, + "V_0": 6.25e-05, + "K_0": 113759900000.0, + "Kprime_0": 4.8061, + "Debye_0": 806.64315, + "grueneisen_0": 1.00921, + "q_0": 0.60142, + "G_0": 76970360000.0, + "Gprime_0": 1.71384, + "eta_s_0": 1.43121, + "n": 10.0, + "Z": 1.0, + "molar_mass": 0.2007774, + } + + Mineral.__init__(self) + + +class co(Mineral): + def __init__(self): + self.params = { + "name": "Corundum", + "formula": {"Al": 2.0, "O": 3.0}, + "equation_of_state": "slb3", + "F_0": -1582440.3199999998, + "V_0": 2.5577e-05, + "K_0": 252585720000.0, + "Kprime_0": 3.88671, + "Debye_0": 932.21586, + "grueneisen_0": 1.3081, + "q_0": 1.71245, + "G_0": 163200000000.0, + "Gprime_0": 1.81492, + "eta_s_0": 2.63052, + "n": 5.0, + "Z": 2.0, + "molar_mass": 0.101961, + } + + Mineral.__init__(self) + + +class coes(Mineral): + def __init__(self): + self.params = { + "name": "Coesite", + "formula": {"Si": 1.0, "O": 2.0}, + "equation_of_state": "slb3", + "F_0": -856110.36, + "V_0": 2.0657e-05, + "K_0": 103538150000.0, + "Kprime_0": 2.9007, + "Debye_0": 880.23946, + "grueneisen_0": 0.29064, + "q_0": 1.0, + "G_0": 61600000000.0, + "Gprime_0": 0.49686, + "eta_s_0": 2.75988, + "n": 3.0, + "Z": 16.0, + "molar_mass": 0.060085, + } + + Mineral.__init__(self) + + +class crst(Mineral): + def __init__(self): + self.params = { + "name": "Cristobalite", + "formula": {"Si": 1.0, "O": 2.0}, + "equation_of_state": "slb3", + "F_0": -852539.43, + "V_0": 2.72397e-05, + "K_0": 11500000000.0, + "Kprime_0": 9.0, + "Debye_0": 794.74452, + "grueneisen_0": 0.01515, + "q_0": 1.0, + "G_0": 20327540000.0, + "Gprime_0": 4.06551, + "eta_s_0": 1.17003, + "n": 3.0, + "Z": 16.0, + "molar_mass": 0.060085, + } + + Mineral.__init__(self) + + +class di(Mineral): + def __init__(self): + self.params = { + "name": "Diopside", + "formula": {"Ca": 1.0, "Mg": 1.0, "Si": 2.0, "O": 6.0}, + "equation_of_state": "slb3", + "F_0": -3029608.3800000004, + "V_0": 6.6039e-05, + "K_0": 113759900000.0, + "Kprime_0": 4.8061, + "Debye_0": 782.57306, + "grueneisen_0": 1.00921, + "q_0": 0.60142, + "G_0": 72700000000.0, + "Gprime_0": 1.71384, + "eta_s_0": 1.06175, + "n": 10.0, + "Z": 1.0, + "molar_mass": 0.2165504, + } + + Mineral.__init__(self) + + +class en(Mineral): + def __init__(self): + self.params = { + "name": "Enstatite", + "formula": {"Mg": 2.0, "Si": 2.0, "O": 6.0}, + "equation_of_state": "slb3", + "F_0": -2914163.5999999996, + "V_0": 6.2676e-05, + "K_0": 107076810000.0, + "Kprime_0": 7.02751, + "Debye_0": 812.21227, + "grueneisen_0": 0.78477, + "q_0": 3.43847, + "G_0": 76800000000.0, + "Gprime_0": 1.54596, + "eta_s_0": 2.5045, + "n": 10.0, + "Z": 4.0, + "molar_mass": 0.2007774, + } + + Mineral.__init__(self) + + +class fa(Mineral): + def __init__(self): + self.params = { + "name": "Fayalite", + "formula": {"Fe": 2.0, "Si": 1.0, "O": 4.0}, + "equation_of_state": "slb3", + "F_0": -1371695.6600000001, + "V_0": 4.629e-05, + "K_0": 136485580000.0, + "Kprime_0": 4.88157, + "Debye_0": 618.96116, + "grueneisen_0": 1.08388, + "q_0": 2.88055, + "G_0": 51220000000.0, + "Gprime_0": 0.85893, + "eta_s_0": 1.65937, + "n": 7.0, + "Z": 4.0, + "molar_mass": 0.203777, + } + + self.property_modifiers = [ + ["landau_slb_2022", {"Tc_0": 65.0, "S_D": 26.7627, "V_D": 0.0}] + ] + + Mineral.__init__(self) + + +class fapv(Mineral): + def __init__(self): + self.params = { + "name": "FeAlO3-Perovskite_HS", + "formula": {"Fe": 1.0, "Al": 1.0, "O": 3.0}, + "equation_of_state": "slb3", + "F_0": -848315.02, + "V_0": 2.72604e-05, + "K_0": 223325500000.0, + "Kprime_0": 4.1, + "Debye_0": 755.38117, + "grueneisen_0": 1.54222, + "q_0": 0.84088, + "G_0": 150042090000.0, + "Gprime_0": 1.73259, + "eta_s_0": 2.55505, + "n": 5.0, + "Z": 4.0, + "molar_mass": 0.1308249, + } + + self.property_modifiers = [ + ["landau_slb_2022", {"Tc_0": 10.0, "S_D": 14.89723, "V_D": 0.0}] + ] + + Mineral.__init__(self) + + +class fec2(Mineral): + def __init__(self): + self.params = { + "name": "HP-Clinoferrosilite", + "formula": {"Fe": 2.0, "Si": 2.0, "O": 6.0}, + "equation_of_state": "slb3", + "F_0": -2224211.0, + "V_0": 6.38541e-05, + "K_0": 116024900000.0, + "Kprime_0": 6.23682, + "Debye_0": 698.72086, + "grueneisen_0": 1.12442, + "q_0": 0.20362, + "G_0": 75147210000.0, + "Gprime_0": 1.8412, + "eta_s_0": 0.98031, + "n": 10.0, + "Z": 1.0, + "molar_mass": 0.2638614, + } + + self.property_modifiers = [ + ["landau_slb_2022", {"Tc_0": 5.0, "S_D": 26.7627, "V_D": 0.0}] + ] + + Mineral.__init__(self) + + +class fecf(Mineral): + def __init__(self): + self.params = { + "name": "Fe-Ca-Ferrite", + "formula": {"Fe": 1.0, "Al": 2.0, "O": 4.0}, + "equation_of_state": "slb3", + "F_0": -1774197.05, + "V_0": 3.7216e-05, + "K_0": 213000000000.0, + "Kprime_0": 4.1, + "Debye_0": 734.07527, + "grueneisen_0": 1.56672, + "q_0": 1.0, + "G_0": 159709650000.0, + "Gprime_0": 1.93591, + "eta_s_0": 2.34163, + "n": 7.0, + "Z": 4.0, + "molar_mass": 0.173806, + } + + self.property_modifiers = [ + ["landau_slb_2022", {"Tc_0": 5.0, "S_D": 13.38135, "V_D": 0.0}] + ] + + Mineral.__init__(self) + + +class feil(Mineral): + def __init__(self): + self.params = { + "name": "Fe-Akimotoite", + "formula": {"Fe": 1.0, "Si": 1.0, "O": 3.0}, + "equation_of_state": "slb3", + "F_0": -1047531.34, + "V_0": 2.6854e-05, + "K_0": 210693870000.0, + "Kprime_0": 5.2154, + "Debye_0": 781.36175, + "grueneisen_0": 1.19458, + "q_0": 2.2246, + "G_0": 160833570000.0, + "Gprime_0": 1.81492, + "eta_s_0": 3.43813, + "n": 5.0, + "Z": 2.0, + "molar_mass": 0.131931, + } + + self.property_modifiers = [ + ["landau_slb_2022", {"Tc_0": 5.0, "S_D": 13.38135, "V_D": 0.0}] + ] + + Mineral.__init__(self) + + +class fepv(Mineral): + def __init__(self): + self.params = { + "name": "Fe-Perovskite", + "formula": {"Fe": 1.0, "Si": 1.0, "O": 3.0}, + "equation_of_state": "slb3", + "F_0": -1002662.5299999999, + "V_0": 2.5321e-05, + "K_0": 270582550000.00003, + "Kprime_0": 4.01, + "Debye_0": 746.56455, + "grueneisen_0": 1.54222, + "q_0": 0.84088, + "G_0": 130020980000.00002, + "Gprime_0": 1.37254, + "eta_s_0": 2.0941, + "n": 5.0, + "Z": 4.0, + "molar_mass": 0.131931, + } + + self.property_modifiers = [ + ["landau_slb_2022", {"Tc_0": 5.0, "S_D": 13.38135, "V_D": 0.0}] + ] + + Mineral.__init__(self) + + +class feri(Mineral): + def __init__(self): + self.params = { + "name": "Fe-Ringwoodite", + "formula": {"Fe": 2.0, "Si": 1.0, "O": 4.0}, + "equation_of_state": "slb3", + "F_0": -1359229.67, + "V_0": 4.186e-05, + "K_0": 213410280000.0, + "Kprime_0": 4.22034, + "Debye_0": 662.84304, + "grueneisen_0": 1.26584, + "q_0": 2.39042, + "G_0": 92000000000.0, + "Gprime_0": 1.35412, + "eta_s_0": 1.77066, + "n": 7.0, + "Z": 2.0, + "molar_mass": 0.203777, + } + + self.property_modifiers = [ + ["landau_slb_2022", {"Tc_0": 5.0, "S_D": 26.7627, "V_D": 0.0}] + ] + + Mineral.__init__(self) + + +class fewa(Mineral): + def __init__(self): + self.params = { + "name": "Fe-Wadsleyite", + "formula": {"Fe": 2.0, "Si": 1.0, "O": 4.0}, + "equation_of_state": "slb3", + "F_0": -1358363.34, + "V_0": 4.28e-05, + "K_0": 168579210000.0, + "Kprime_0": 4.12303, + "Debye_0": 647.34559, + "grueneisen_0": 1.20388, + "q_0": 2.21007, + "G_0": 72000000000.0, + "Gprime_0": 1.50973, + "eta_s_0": 0.95246, + "n": 7.0, + "Z": 8.0, + "molar_mass": 0.203777, + } + + self.property_modifiers = [ + ["landau_slb_2022", {"Tc_0": 5.0, "S_D": 26.7627, "V_D": 0.0}] + ] + + Mineral.__init__(self) + + +class flpv(Mineral): + def __init__(self): + self.params = { + "name": "Fe-Perovskite_Low_Spin", + "formula": {"Fe": 1.0, "Si": 1.0, "O": 3.0}, + "equation_of_state": "slb3", + "F_0": -879526.2000000001, + "V_0": 2.497e-05, + "K_0": 270582550000.00003, + "Kprime_0": 4.01, + "Debye_0": 692.38659, + "grueneisen_0": 1.54222, + "q_0": 0.84088, + "G_0": 130337050000.0, + "Gprime_0": 1.37411, + "eta_s_0": 1.99344, + "n": 5.0, + "Z": 4.0, + "molar_mass": 0.131931, + } + + Mineral.__init__(self) + + +class fnal(Mineral): + def __init__(self): + self.params = { + "name": "Fe-NAL_Phase", + "formula": {"Na": 1.0, "Fe": 2.0, "Al": 5.0, "Si": 1.0, "O": 12.0}, + "equation_of_state": "slb3", + "F_0": -5475295.42, + "V_0": 0.000112045, + "K_0": 203995010000.0, + "Kprime_0": 4.31884, + "Debye_0": 795.29328, + "grueneisen_0": 1.42971, + "q_0": 1.0, + "G_0": 149593770000.0, + "Gprime_0": 1.7423, + "eta_s_0": 2.65939, + "n": 21.0, + "Z": 1.0, + "molar_mass": 0.48966601, + } + + self.property_modifiers = [ + ["landau_slb_2022", {"Tc_0": 5.0, "S_D": 26.7627, "V_D": 0.0}] + ] + + Mineral.__init__(self) + + +class fo(Mineral): + def __init__(self): + self.params = { + "name": "Forsterite", + "formula": {"Mg": 2.0, "Si": 1.0, "O": 4.0}, + "equation_of_state": "slb3", + "F_0": -2055371.19, + "V_0": 4.3603e-05, + "K_0": 127955500000.0, + "Kprime_0": 4.21796, + "Debye_0": 809.1977, + "grueneisen_0": 0.9928, + "q_0": 2.10671, + "G_0": 81600000000.0, + "Gprime_0": 1.46257, + "eta_s_0": 2.29968, + "n": 7.0, + "Z": 4.0, + "molar_mass": 0.140695, + } + + Mineral.__init__(self) + + +class fppv(Mineral): + def __init__(self): + self.params = { + "name": "Fe-PostPerovskite", + "formula": {"Fe": 1.0, "Si": 1.0, "O": 3.0}, + "equation_of_state": "slb3", + "F_0": -982035.5, + "V_0": 2.46519e-05, + "K_0": 292000000000.0, + "Kprime_0": 3.74, + "Debye_0": 794.15823, + "grueneisen_0": 1.76958, + "q_0": 2.04631, + "G_0": 129500000000.0, + "Gprime_0": 1.31526, + "eta_s_0": 1.72601, + "n": 5.0, + "Z": 4.0, + "molar_mass": 0.131931, + } + + self.property_modifiers = [ + ["landau_slb_2022", {"Tc_0": 5.0, "S_D": 13.38135, "V_D": 0.0}] + ] + + Mineral.__init__(self) + + +class fs(Mineral): + def __init__(self): + self.params = { + "name": "Ferrosilite", + "formula": {"Fe": 2.0, "Si": 2.0, "O": 6.0}, + "equation_of_state": "slb3", + "F_0": -2228327.6999999997, + "V_0": 6.5941e-05, + "K_0": 100545910000.0, + "Kprime_0": 7.87534, + "Debye_0": 682.67865, + "grueneisen_0": 0.71519, + "q_0": 3.43847, + "G_0": 52000000000.0, + "Gprime_0": 1.54596, + "eta_s_0": 1.08309, + "n": 10.0, + "Z": 4.0, + "molar_mass": 0.2638614, + } + + self.property_modifiers = [ + ["landau_slb_2022", {"Tc_0": 5.0, "S_D": 26.7627, "V_D": 0.0}] + ] + + Mineral.__init__(self) + + +class gr(Mineral): + def __init__(self): + self.params = { + "name": "Grossular", + "formula": {"Ca": 3.0, "Al": 2.0, "Si": 3.0, "O": 12.0}, + "equation_of_state": "slb3", + "F_0": -6275179.81, + "V_0": 0.00012512, + "K_0": 167062260000.0, + "Kprime_0": 3.91544, + "Debye_0": 822.77062, + "grueneisen_0": 1.05402, + "q_0": 1.88886, + "G_0": 109000000000.0, + "Gprime_0": 1.16274, + "eta_s_0": 2.38415, + "n": 20.0, + "Z": 4.0, + "molar_mass": 0.450449, + } + + Mineral.__init__(self) + + +class hc(Mineral): + def __init__(self): + self.params = { + "name": "Hercynite", + "formula": {"Fe": 4.0, "Al": 8.0, "O": 16.0}, + "equation_of_state": "slb3", + "F_0": -7356185.029999999, + "V_0": 0.000163372, + "K_0": 208982310000.0, + "Kprime_0": 4.62659, + "Debye_0": 794.21184, + "grueneisen_0": 1.19332, + "q_0": 4.05077, + "G_0": 84500000000.0, + "Gprime_0": 0.62792, + "eta_s_0": 2.49369, + "n": 28.0, + "Z": 8.0, + "molar_mass": 0.69524, + } + + self.property_modifiers = [ + ["landau_slb_2022", {"Tc_0": 5.0, "S_D": 53.5254, "V_D": 0.0}] + ] + + Mineral.__init__(self) + + +class he(Mineral): + def __init__(self): + self.params = { + "name": "Hedenbergite", + "formula": {"Ca": 1.0, "Fe": 1.0, "Si": 2.0, "O": 6.0}, + "equation_of_state": "slb3", + "F_0": -2676991.78, + "V_0": 6.7867e-05, + "K_0": 119204720000.0, + "Kprime_0": 4.81927, + "Debye_0": 702.08234, + "grueneisen_0": 0.96665, + "q_0": 0.60142, + "G_0": 61000000000.0, + "Gprime_0": 1.71384, + "eta_s_0": 1.01745, + "n": 10.0, + "Z": 1.0, + "molar_mass": 0.2480924, + } + + self.property_modifiers = [ + ["landau_slb_2022", {"Tc_0": 5.0, "S_D": 13.38135, "V_D": 0.0}] + ] + + Mineral.__init__(self) + + +class hem(Mineral): + def __init__(self): + self.params = { + "name": "Hematite", + "formula": {"Fe": 2.0, "O": 3.0}, + "equation_of_state": "slb3", + "F_0": -744041.62, + "V_0": 3.0287e-05, + "K_0": 204245330000.0, + "Kprime_0": 4.0997, + "Debye_0": 653.80768, + "grueneisen_0": 1.58945, + "q_0": 2.2246, + "G_0": 91000000000.0, + "Gprime_0": 1.81492, + "eta_s_0": 0.52408, + "n": 5.0, + "Z": 1.0, + "molar_mass": 0.15968852, + } + + self.property_modifiers = [ + ["landau_slb_2022", {"Tc_0": 950.01, "S_D": 29.79445, "V_D": 0.0}] + ] + + Mineral.__init__(self) + + +class hepv(Mineral): + def __init__(self): + self.params = { + "name": "Fe2O3-Perovskite_HS", + "formula": {"Fe": 2.0, "O": 3.0}, + "equation_of_state": "slb3", + "F_0": -721269.05, + "V_0": 3.08668e-05, + "K_0": 135000000000.0, + "Kprime_0": 4.0, + "Debye_0": 613.90405, + "grueneisen_0": 1.54222, + "q_0": 0.84088, + "G_0": 88766580000.0, + "Gprime_0": 1.73259, + "eta_s_0": 0.66524, + "n": 5.0, + "Z": 4.0, + "molar_mass": 0.15968852, + } + + self.property_modifiers = [ + ["landau_slb_2022", {"Tc_0": 10.0, "S_D": 29.79445, "V_D": 0.0}] + ] + + Mineral.__init__(self) + + +class hlpv(Mineral): + def __init__(self): + self.params = { + "name": "Fe2O3-Perovskite_LS", + "formula": {"Fe": 2.0, "O": 3.0}, + "equation_of_state": "slb3", + "F_0": -617631.95, + "V_0": 2.75209e-05, + "K_0": 204251000000.0, + "Kprime_0": 4.1, + "Debye_0": 725.62214, + "grueneisen_0": 1.54222, + "q_0": 0.84088, + "G_0": 163996000000.0, + "Gprime_0": 1.73259, + "eta_s_0": 3.0318, + "n": 5.0, + "Z": 4.0, + "molar_mass": 0.15968852, + } + + self.property_modifiers = [ + ["landau_slb_2022", {"Tc_0": 10.0, "S_D": 20.66026, "V_D": 0.0}] + ] + + Mineral.__init__(self) + + +class hmag(Mineral): + def __init__(self): + self.params = { + "name": "High-Pressure_Magnetit", + "formula": {"Fe": 3.0, "O": 4.0}, + "equation_of_state": "slb3", + "F_0": -964475.2200000001, + "V_0": 4.1702e-05, + "K_0": 172000000000.0, + "Kprime_0": 4.0, + "Debye_0": 533.17958, + "grueneisen_0": 1.56672, + "q_0": 1.0, + "G_0": 108730730000.0, + "Gprime_0": 1.93591, + "eta_s_0": 0.90477, + "n": 7.0, + "Z": 1.0, + "molar_mass": 0.23153307, + } + + self.property_modifiers = [ + ["landau_slb_2022", {"Tc_0": 845.5, "S_D": 43.1758, "V_D": 0.0}] + ] + + Mineral.__init__(self) + + +class hppv(Mineral): + def __init__(self): + self.params = { + "name": "HS_Fe2O3-Post-Perovski", + "formula": {"Fe": 2.0, "O": 3.0}, + "equation_of_state": "slb3", + "F_0": -622376.42, + "V_0": 2.76884e-05, + "K_0": 176500000000.0, + "Kprime_0": 4.0, + "Debye_0": 688.0644, + "grueneisen_0": 1.76958, + "q_0": 2.04631, + "G_0": 159009520000.0, + "Gprime_0": 1.85188, + "eta_s_0": 2.00124, + "n": 5.0, + "Z": 4.0, + "molar_mass": 0.15968852, + } + + self.property_modifiers = [ + ["landau_slb_2022", {"Tc_0": 10.0, "S_D": 29.79445, "V_D": 0.0}] + ] + + Mineral.__init__(self) + + +class jd(Mineral): + def __init__(self): + self.params = { + "name": "Jadeite", + "formula": {"Na": 1.0, "Al": 1.0, "Si": 2.0, "O": 6.0}, + "equation_of_state": "slb3", + "F_0": -2855195.56, + "V_0": 6.0508e-05, + "K_0": 142292260000.0, + "Kprime_0": 4.8061, + "Debye_0": 820.78389, + "grueneisen_0": 0.89983, + "q_0": 0.78628, + "G_0": 85000000000.0, + "Gprime_0": 1.71384, + "eta_s_0": 1.88167, + "n": 10.0, + "Z": 1.0, + "molar_mass": 0.2021387, + } + + Mineral.__init__(self) + + +class ky(Mineral): + def __init__(self): + self.params = { + "name": "Kyanite", + "formula": {"Al": 2.0, "Si": 1.0, "O": 5.0}, + "equation_of_state": "slb3", + "F_0": -2446081.74, + "V_0": 4.4227e-05, + "K_0": 160000000000.0, + "Kprime_0": 4.0, + "Debye_0": 943.19593, + "grueneisen_0": 0.92549, + "q_0": 1.0, + "G_0": 117854530000.0, + "Gprime_0": 1.69416, + "eta_s_0": 2.90375, + "n": 8.0, + "Z": 4.0, + "molar_mass": 0.1620456, + } + + Mineral.__init__(self) + + +class lppv(Mineral): + def __init__(self): + self.params = { + "name": "LS_Fe2O3-Post-Perovski", + "formula": {"Fe": 2.0, "O": 3.0}, + "equation_of_state": "slb3", + "F_0": -407182.57, + "V_0": 2.62534e-05, + "K_0": 176500000000.0, + "Kprime_0": 4.0, + "Debye_0": 720.85819, + "grueneisen_0": 1.76958, + "q_0": 2.04631, + "G_0": 207396350000.0, + "Gprime_0": 1.85188, + "eta_s_0": 3.23888, + "n": 5.0, + "Z": 4.0, + "molar_mass": 0.15968852, + } + + self.property_modifiers = [ + ["landau_slb_2022", {"Tc_0": 10.0, "S_D": 20.66026, "V_D": 0.0}] + ] + + Mineral.__init__(self) + + +class mag(Mineral): + def __init__(self): + self.params = { + "name": "Magnetite", + "formula": {"Fe": 3.0, "O": 4.0}, + "equation_of_state": "slb3", + "F_0": -987192.39, + "V_0": 4.4528e-05, + "K_0": 183965710000.0, + "Kprime_0": 5.24573, + "Debye_0": 520.10184, + "grueneisen_0": 1.32115, + "q_0": 1.5487, + "G_0": 60300000000.0, + "Gprime_0": -0.05466, + "eta_s_0": 2.43429, + "n": 7.0, + "Z": 1.0, + "molar_mass": 0.23153307, + } + + self.property_modifiers = [ + ["landau_slb_2022", {"Tc_0": 845.5, "S_D": 43.1758, "V_D": 0.0}] + ] + + Mineral.__init__(self) + + +class mgc2(Mineral): + def __init__(self): + self.params = { + "name": "HP-Clinoenstatite", + "formula": {"Mg": 2.0, "Si": 2.0, "O": 6.0}, + "equation_of_state": "slb3", + "F_0": -2905475.75, + "V_0": 6.076e-05, + "K_0": 116024900000.0, + "Kprime_0": 6.23682, + "Debye_0": 822.89602, + "grueneisen_0": 1.12442, + "q_0": 0.20362, + "G_0": 87927160000.0, + "Gprime_0": 1.8412, + "eta_s_0": 2.14112, + "n": 10.0, + "Z": 1.0, + "molar_mass": 0.2007774, + } + + Mineral.__init__(self) + + +class mgcf(Mineral): + def __init__(self): + self.params = { + "name": "Mg-Ca-Ferrite", + "formula": {"Mg": 1.0, "Al": 2.0, "O": 4.0}, + "equation_of_state": "slb3", + "F_0": -2122873.69, + "V_0": 3.6135e-05, + "K_0": 213000000000.0, + "Kprime_0": 4.1, + "Debye_0": 831.14221, + "grueneisen_0": 1.56672, + "q_0": 1.0, + "G_0": 129699999999.99998, + "Gprime_0": 1.93591, + "eta_s_0": 1.30302, + "n": 7.0, + "Z": 4.0, + "molar_mass": 0.142266, + } + + Mineral.__init__(self) + + +class mgil(Mineral): + def __init__(self): + self.params = { + "name": "Mg-Akimotoite", + "formula": {"Mg": 1.0, "Si": 1.0, "O": 3.0}, + "equation_of_state": "slb3", + "F_0": -1409831.95, + "V_0": 2.6354e-05, + "K_0": 210693870000.0, + "Kprime_0": 5.2154, + "Debye_0": 932.602, + "grueneisen_0": 1.19458, + "q_0": 2.2246, + "G_0": 132000000000.0, + "Gprime_0": 1.81492, + "eta_s_0": 3.40174, + "n": 5.0, + "Z": 2.0, + "molar_mass": 0.100389, + } + + Mineral.__init__(self) + + +class mgmj(Mineral): + def __init__(self): + self.params = { + "name": "Mg-Majorite", + "formula": {"Mg": 4.0, "Si": 4.0, "O": 12.0}, + "equation_of_state": "slb3", + "F_0": -5693291.79, + "V_0": 0.000114324, + "K_0": 165118370000.0, + "Kprime_0": 4.21183, + "Debye_0": 822.48562, + "grueneisen_0": 0.97681, + "q_0": 1.53581, + "G_0": 85000000000.0, + "Gprime_0": 1.42969, + "eta_s_0": 1.01779, + "n": 20.0, + "Z": 4.0, + "molar_mass": 0.40156, + } + + Mineral.__init__(self) + + +class mgpv(Mineral): + def __init__(self): + self.params = { + "name": "Mg-Perovskite", + "formula": {"Mg": 1.0, "Si": 1.0, "O": 3.0}, + "equation_of_state": "slb3", + "F_0": -1362442.75, + "V_0": 2.4445e-05, + "K_0": 250546900000.0, + "Kprime_0": 4.13499, + "Debye_0": 880.01895, + "grueneisen_0": 1.54222, + "q_0": 0.84088, + "G_0": 172900000000.0, + "Gprime_0": 1.73259, + "eta_s_0": 1.65573, + "n": 5.0, + "Z": 4.0, + "molar_mass": 0.100389, + } + + Mineral.__init__(self) + + +class mgri(Mineral): + def __init__(self): + self.params = { + "name": "Mg-Ringwoodite", + "formula": {"Mg": 2.0, "Si": 1.0, "O": 4.0}, + "equation_of_state": "slb3", + "F_0": -2017223.98, + "V_0": 3.9493e-05, + "K_0": 184899930000.0, + "Kprime_0": 4.22034, + "Debye_0": 875.13511, + "grueneisen_0": 1.1072, + "q_0": 2.39042, + "G_0": 123000000000.0, + "Gprime_0": 1.35412, + "eta_s_0": 2.30288, + "n": 7.0, + "Z": 2.0, + "molar_mass": 0.140693, + } + + Mineral.__init__(self) + + +class mgts(Mineral): + def __init__(self): + self.params = { + "name": "Mg-Tschermak's", + "formula": {"Mg": 1.0, "Al": 2.0, "Si": 1.0, "O": 6.0}, + "equation_of_state": "slb3", + "F_0": -3002410.17, + "V_0": 5.914e-05, + "K_0": 107076810000.0, + "Kprime_0": 7.02751, + "Debye_0": 783.94073, + "grueneisen_0": 0.78477, + "q_0": 3.43847, + "G_0": 93471460000.0, + "Gprime_0": 1.54596, + "eta_s_0": 2.39416, + "n": 10.0, + "Z": 4.0, + "molar_mass": 0.20235, + } + + Mineral.__init__(self) + + +class mgwa(Mineral): + def __init__(self): + self.params = { + "name": "Mg-Wadsleyite", + "formula": {"Mg": 2.0, "Si": 1.0, "O": 4.0}, + "equation_of_state": "slb3", + "F_0": -2028172.68, + "V_0": 4.0515e-05, + "K_0": 168701060000.0, + "Kprime_0": 4.12303, + "Debye_0": 845.20132, + "grueneisen_0": 1.20388, + "q_0": 2.21007, + "G_0": 112000000000.0, + "Gprime_0": 1.50973, + "eta_s_0": 2.56133, + "n": 7.0, + "Z": 8.0, + "molar_mass": 0.140695, + } + + Mineral.__init__(self) + + +class mnal(Mineral): + def __init__(self): + self.params = { + "name": "Mg-NAL_Phase", + "formula": {"Na": 1.0, "Mg": 2.0, "Al": 5.0, "Si": 1.0, "O": 12.0}, + "equation_of_state": "slb3", + "F_0": -6167391.6, + "V_0": 0.000109883, + "K_0": 203995010000.0, + "Kprime_0": 4.31884, + "Debye_0": 858.38264, + "grueneisen_0": 1.42971, + "q_0": 1.0, + "G_0": 129000000000.0, + "Gprime_0": 1.7423, + "eta_s_0": 1.93069, + "n": 21.0, + "Z": 1.0, + "molar_mass": 0.42658581, + } + + Mineral.__init__(self) + + +class mppv(Mineral): + def __init__(self): + self.params = { + "name": "Mg-PostPerovskite", + "formula": {"Mg": 1.0, "Si": 1.0, "O": 3.0}, + "equation_of_state": "slb3", + "F_0": -1313625.76, + "V_0": 2.35252e-05, + "K_0": 292000000000.0, + "Kprime_0": 3.74, + "Debye_0": 941.49795, + "grueneisen_0": 1.76958, + "q_0": 2.04631, + "G_0": 171135870000.0, + "Gprime_0": 1.85188, + "eta_s_0": 1.2881, + "n": 5.0, + "Z": 4.0, + "molar_mass": 0.100389, + } + + Mineral.__init__(self) + + +class nacf(Mineral): + def __init__(self): + self.params = { + "name": "Na-Ca-Ferrite", + "formula": {"Na": 1.0, "Al": 1.0, "Si": 1.0, "O": 4.0}, + "equation_of_state": "slb3", + "F_0": -1835429.51, + "V_0": 3.627e-05, + "K_0": 220000000000.0, + "Kprime_0": 4.1, + "Debye_0": 683.31827, + "grueneisen_0": 1.56672, + "q_0": 1.0, + "G_0": 135326619999.99998, + "Gprime_0": 1.93591, + "eta_s_0": 1.36827, + "n": 7.0, + "Z": 4.0, + "molar_mass": 0.142054, + } + + Mineral.__init__(self) + + +class namj(Mineral): + def __init__(self): + self.params = { + "name": "Na-Majorite", + "formula": {"Na": 2.0, "Mg": 1.0, "Si": 5.0, "O": 12.0}, + "equation_of_state": "slb3", + "F_0": -5303066.24, + "V_0": 0.000110842, + "K_0": 172035150000.0, + "Kprime_0": 5.2005, + "Debye_0": 844.73722, + "grueneisen_0": 1.25078, + "q_0": 0.10916, + "G_0": 114700000000.0, + "Gprime_0": 1.35756, + "eta_s_0": 2.4849, + "n": 20.0, + "Z": 4.0, + "molar_mass": 0.40270437, + } + + Mineral.__init__(self) + + +class neph(Mineral): + def __init__(self): + self.params = { + "name": "Nepheline", + "formula": {"Na": 1.0, "Al": 1.0, "Si": 1.0, "O": 4.0}, + "equation_of_state": "slb3", + "F_0": -1994469.57, + "V_0": 5.38684e-05, + "K_0": 53055500000.0, + "Kprime_0": 4.0, + "Debye_0": 743.57985, + "grueneisen_0": 0.6969, + "q_0": 1.0, + "G_0": 30700000000.0, + "Gprime_0": 1.33087, + "eta_s_0": 0.6241, + "n": 7.0, + "Z": 2.0, + "molar_mass": 0.14205431, + } + + self.property_modifiers = [ + ["landau_slb_2022", {"Tc_0": 467.0, "S_D": 10.0, "V_D": 0.8}] + ] + + Mineral.__init__(self) + + +class nnal(Mineral): + def __init__(self): + self.params = { + "name": "Na-NAL_Phase", + "formula": {"Na": 3.0, "Al": 3.0, "Si": 3.0, "O": 12.0}, + "equation_of_state": "slb3", + "F_0": -5567127.9, + "V_0": 0.000109401, + "K_0": 203995010000.0, + "Kprime_0": 4.31884, + "Debye_0": 850.32833, + "grueneisen_0": 1.42971, + "q_0": 1.0, + "G_0": 144451020000.0, + "Gprime_0": 1.7423, + "eta_s_0": 2.42502, + "n": 21.0, + "Z": 1.0, + "molar_mass": 0.42616294, + } + + Mineral.__init__(self) + + +class odi(Mineral): + def __init__(self): + self.params = { + "name": "Ortho-Diopside", + "formula": {"Ca": 1.0, "Mg": 1.0, "Si": 2.0, "O": 6.0}, + "equation_of_state": "slb3", + "F_0": -3015734.13, + "V_0": 6.8054e-05, + "K_0": 107076810000.0, + "Kprime_0": 7.02751, + "Debye_0": 744.54893, + "grueneisen_0": 0.78477, + "q_0": 3.43847, + "G_0": 57508750000.0, + "Gprime_0": 1.54596, + "eta_s_0": 1.31909, + "n": 10.0, + "Z": 1.0, + "molar_mass": 0.2165504, + } + + Mineral.__init__(self) + + +class pe(Mineral): + def __init__(self): + self.params = { + "name": "Periclase", + "formula": {"Mg": 4.0, "O": 4.0}, + "equation_of_state": "slb3", + "F_0": -2278109.88, + "V_0": 4.4976e-05, + "K_0": 161143930000.0, + "Kprime_0": 3.90838, + "Debye_0": 770.90151, + "grueneisen_0": 1.45033, + "q_0": 1.5487, + "G_0": 130900000000.0, + "Gprime_0": 2.14668, + "eta_s_0": 2.56123, + "n": 8.0, + "Z": 1.0, + "molar_mass": 0.16121782, + } + + Mineral.__init__(self) + + +class py(Mineral): + def __init__(self): + self.params = { + "name": "Pyrope", + "formula": {"Mg": 3.0, "Al": 2.0, "Si": 3.0, "O": 12.0}, + "equation_of_state": "slb3", + "F_0": -5937137.35, + "V_0": 0.00011308, + "K_0": 170239640000.0, + "Kprime_0": 4.11067, + "Debye_0": 823.23783, + "grueneisen_0": 1.01422, + "q_0": 1.42169, + "G_0": 93700000000.0, + "Gprime_0": 1.35756, + "eta_s_0": 0.98186, + "n": 20.0, + "Z": 4.0, + "molar_mass": 0.40313, + } + + Mineral.__init__(self) + + +class qtz(Mineral): + def __init__(self): + self.params = { + "name": "Quartz", + "formula": {"Si": 1.0, "O": 2.0}, + "equation_of_state": "slb3", + "F_0": -860118.03, + "V_0": 2.24211e-05, + "K_0": 61425370000.0, + "Kprime_0": 19.78011, + "Debye_0": 884.20481, + "grueneisen_0": -0.03958, + "q_0": 1.0, + "G_0": 44857760000.0, + "Gprime_0": -0.04277, + "eta_s_0": 2.40509, + "n": 3.0, + "Z": 16.0, + "molar_mass": 0.060085, + } + + self.property_modifiers = [ + ["landau_slb_2022", {"Tc_0": 847.0, "S_D": 5.76, "V_D": 1.35936}] + ] + + Mineral.__init__(self) + + +class sp(Mineral): + def __init__(self): + self.params = { + "name": "Spinel", + "formula": {"Mg": 4.0, "Al": 8.0, "O": 16.0}, + "equation_of_state": "slb3", + "F_0": -8680043.36, + "V_0": 0.000159048, + "K_0": 195139330000.0, + "Kprime_0": 4.62659, + "Debye_0": 856.3695, + "grueneisen_0": 0.97518, + "q_0": 4.05077, + "G_0": 109000000000.0, + "Gprime_0": 0.62792, + "eta_s_0": 2.44263, + "n": 28.0, + "Z": 8.0, + "molar_mass": 0.569068, + } + + Mineral.__init__(self) + + +class st(Mineral): + def __init__(self): + self.params = { + "name": "Stishovite", + "formula": {"Si": 1.0, "O": 2.0}, + "equation_of_state": "slb3", + "F_0": -817491.62, + "V_0": 1.4017e-05, + "K_0": 305833020000.0, + "Kprime_0": 4.0292, + "Debye_0": 1092.17047, + "grueneisen_0": 1.55674, + "q_0": 2.2096, + "G_0": 228000000000.0, + "Gprime_0": 1.94045, + "eta_s_0": 4.40394, + "n": 3.0, + "Z": 2.0, + "molar_mass": 0.060085, + } + + self.property_modifiers = [ + ["landau_slb_2022", {"Tc_0": -4250.0, "S_D": 4e-05, "V_D": 0.0}] + ] + + Mineral.__init__(self) + + +class wu(Mineral): + def __init__(self): + self.params = { + "name": 'W\\"ustite', + "formula": {"Fe": 4.0, "O": 4.0}, + "equation_of_state": "slb3", + "F_0": -974607.49, + "V_0": 4.9024e-05, + "K_0": 160700000000.0, + "Kprime_0": 4.0, + "Debye_0": 454.1752, + "grueneisen_0": 1.45033, + "q_0": 1.5487, + "G_0": 59000000000.0, + "Gprime_0": 1.44764, + "eta_s_0": 0.06776, + "n": 8.0, + "Z": 1.0, + "molar_mass": 0.28737822, + } + + self.property_modifiers = [ + ["landau_slb_2022", {"Tc_0": 191.0, "S_D": 53.5254, "V_D": 0.0}] + ] + + Mineral.__init__(self) + + +class wuls(Mineral): + def __init__(self): + self.params = { + "name": 'W\\"ustite_Low_Spin', + "formula": {"Fe": 4.0, "O": 4.0}, + "equation_of_state": "slb3", + "F_0": -621968.16, + "V_0": 4.33997e-05, + "K_0": 199700000000.0, + "Kprime_0": 4.0, + "Debye_0": 524.57881, + "grueneisen_0": 1.45033, + "q_0": 1.5487, + "G_0": 59000000000.0, + "Gprime_0": 1.44073, + "eta_s_0": -0.13801, + "n": 8.0, + "Z": 1.0, + "molar_mass": 0.28737822, + } + + Mineral.__init__(self) + + +""" +SOLUTIONS +""" + + +class c2c_pyroxene(Solution): + def __init__(self, molar_fractions=None): + self.name = "c2c_pyroxene" + self.solution_model = IdealSolution( + endmembers=[ + [mgc2(), "[Mg]2"], + [fec2(), "[Fe]2"], + ], + ) + + Solution.__init__(self, molar_fractions=molar_fractions) + + +class calcium_ferrite_structured_phase(Solution): + def __init__(self, molar_fractions=None): + self.name = "calcium_ferrite_structured_phase" + self.solution_model = AsymmetricRegularSolution( + endmembers=[ + [mgcf(), "[Mg][Al]"], + [fecf(), "[Fe][Al]"], + [nacf(), "[Na][Si]"], + ], + alphas=[1.0, 1.0, 4.4532], + energy_interaction=[[0.0, 60825.08], [60825.08]], + ) + + Solution.__init__(self, molar_fractions=molar_fractions) + + +class clinopyroxene(Solution): + def __init__(self, molar_fractions=None): + self.name = "clinopyroxene" + self.solution_model = AsymmetricRegularSolution( + endmembers=[ + [di(), "[Ca][Mg][Si]2"], + [he(), "[Ca][Fe][Si]2"], + [cen(), "[Mg][Mg][Si]2"], + [cats(), "[Ca][Al][Si1/2Al1/2]2"], + [jd(), "[Na][Al][Si]2"], + ], + alphas=[1.0, 1.0, 1.0, 3.5, 1.0], + energy_interaction=[ + [0.0, 24740.0, 26000.0, 24300.0], + [24740.0, 26000.0, 24300.0], + [60132.81, 46046.07], + [10000.0], + ], + ) + + Solution.__init__(self, molar_fractions=molar_fractions) + + +class garnet(Solution): + def __init__(self, molar_fractions=None): + self.name = "garnet" + self.solution_model = SymmetricRegularSolution( + endmembers=[ + [py(), "[Mg]3[Al][Al]"], + [al(), "[Fe]3[Al][Al]"], + [gr(), "[Ca]3[Al][Al]"], + [mgmj(), "[Mg]3[Mg][Si]"], + [namj(), "[Na2/3Mg1/3]3[Si][Si]"], + ], + energy_interaction=[ + [0.0, 21117.58, 22672.42, 22672.42], + [21117.58, 22672.42, 22672.42], + [60718.2, 60718.2], + [70879.14], + ], + volume_interaction=[ + [0.0, 1.03e-06, 0.0, 0.0], + [0.0, 0.0, 0.0], + [1.03e-06, 0.0], + [0.0], + ], + ) + + Solution.__init__(self, molar_fractions=molar_fractions) + + +class ilmenite(Solution): + def __init__(self, molar_fractions=None): + self.name = "ilmenite" + self.solution_model = SymmetricRegularSolution( + endmembers=[ + [mgil(), "[Mg][Si]"], + [feil(), "[Fe][Si]"], + [co(), "[Al][Al]"], + ], + energy_interaction=[[0.0, 59348.69], [59348.69]], + ) + + Solution.__init__(self, molar_fractions=molar_fractions) + + +class ferropericlase(Solution): + def __init__(self, molar_fractions=None): + self.name = "ferropericlase" + self.solution_model = SymmetricRegularSolution( + endmembers=[ + [pe(), "[Mg]2[Mg]2"], + [wu(), "[Fe]2[Fe]2"], + [anao(), "[Na]2[Al]2"], + ], + energy_interaction=[[44000.0, 120000.0], [120000.0]], + volume_interaction=[[4.4e-07, 0.0], [0.0]], + ) + + Solution.__init__(self, molar_fractions=molar_fractions) + + +class new_aluminous_phase(Solution): + def __init__(self, molar_fractions=None): + self.name = "new_aluminous_phase" + self.solution_model = SymmetricRegularSolution( + endmembers=[ + [mnal(), "[Mg]2[Al5/6Si1/6]6"], + [fnal(), "[Fe]2[Al5/6Si1/6]6"], + [nnal(), "[Na]2[Al3/6Si3/6]6"], + ], + energy_interaction=[[0.0, -60781.47], [-60781.47]], + ) + + Solution.__init__(self, molar_fractions=molar_fractions) + + +class olivine(Solution): + def __init__(self, molar_fractions=None): + self.name = "olivine" + self.solution_model = SymmetricRegularSolution( + endmembers=[ + [fo(), "[Mg]2"], + [fa(), "[Fe]2"], + ], + energy_interaction=[[4694.66]], + ) + + Solution.__init__(self, molar_fractions=molar_fractions) + + +class orthopyroxene(Solution): + def __init__(self, molar_fractions=None): + self.name = "orthopyroxene" + self.solution_model = SymmetricRegularSolution( + endmembers=[ + [en(), "[Mg][Mg]"], + [fs(), "[Fe][Fe]"], + [mgts(), "[Mg][Al]"], + [odi(), "[Ca][Mg]"], + ], + energy_interaction=[[0.0, 0.0, 32217.44], [0.0, 32217.44], [48370.41]], + ) + + Solution.__init__(self, molar_fractions=molar_fractions) + + +class plagioclase(Solution): + def __init__(self, molar_fractions=None): + self.name = "plagioclase" + self.solution_model = SymmetricRegularSolution( + endmembers=[ + [an(), "[Ca]"], + [ab(), "[Na]"], + ], + energy_interaction=[[13000.0]], + ) + + Solution.__init__(self, molar_fractions=molar_fractions) + + +class post_perovskite(Solution): + def __init__(self, molar_fractions=None): + self.name = "post_perovskite" + self.solution_model = SymmetricRegularSolution( + endmembers=[ + [mppv(), "[Mg][Si]"], + [fppv(), "[Fe][Si]"], + [appv(), "[Al][Al]"], + ], + energy_interaction=[[-10955.49, 34979.87], [34979.87]], + ) + + Solution.__init__(self, molar_fractions=molar_fractions) + + +class bridgmanite(Solution): + def __init__(self, molar_fractions=None): + self.name = "bridgmanite" + self.solution_model = SymmetricRegularSolution( + endmembers=[ + [mgpv(), "[Mg][Si]"], + [fepv(), "[Fe][Si]"], + [alpv(), "[Al][Al]"], + ], + energy_interaction=[[-11396.17, 34979.87], [0.0]], + ) + + Solution.__init__(self, molar_fractions=molar_fractions) + + +class ringwoodite(Solution): + def __init__(self, molar_fractions=None): + self.name = "ringwoodite" + self.solution_model = SymmetricRegularSolution( + endmembers=[ + [mgri(), "[Mg]2"], + [feri(), "[Fe]2"], + ], + energy_interaction=[[7600.74]], + ) + + Solution.__init__(self, molar_fractions=molar_fractions) + + +class mg_fe_aluminous_spinel(Solution): + def __init__(self, molar_fractions=None): + self.name = "mg_fe_aluminous_spinel" + self.solution_model = SymmetricRegularSolution( + endmembers=[ + [sp(), "[Mg3/4Al1/4]4[Al7/8Mg1/8]8"], + [hc(), "[Fe3/4Al1/4]4[Al7/8Fe1/8]8"], + ], + energy_interaction=[[-533.21]], + ) + + Solution.__init__(self, molar_fractions=molar_fractions) + + +class wadsleyite(Solution): + def __init__(self, molar_fractions=None): + self.name = "wadsleyite" + self.solution_model = SymmetricRegularSolution( + endmembers=[ + [mgwa(), "[Mg]2"], + [fewa(), "[Fe]2"], + ], + energy_interaction=[[13202.38]], + ) + + Solution.__init__(self, molar_fractions=molar_fractions) + + +""" +ENDMEMBER ALIASES +""" + +albite = ab +almandine = al +al_perovskite = alpv +anorthite = an +alpha_nao2_phase = anao +alpha_pbo_2_sio_2 = apbo +al_post_perovskite = appv +ca_perovskite = capv +lime_tschermak = cats +clinoenstatite = cen +corundum = co +coesite = coes +cristobalite = crst +diopside = di +enstatite = en +fayalite = fa +fealo3_perovskite_hs = fapv +hp_clinoferrosilite = fec2 +fe_ca_ferrite = fecf +fe_akimotoite = feil +fe_perovskite = fepv +fe_ringwoodite = feri +fe_wadsleyite = fewa +fe_perovskite_low_spin = flpv +fe_nal_phase = fnal +forsterite = fo +fe_postperovskite = fppv +ferrosilite = fs +grossular = gr +hercynite = hc +hedenbergite = he +hematite = hem +fe2o3_perovskite_hs = hepv +fe2o3_perovskite_ls = hlpv +high_pressure_magnetit = hmag +hs_fe2o3_post_perovski = hppv +jadeite = jd +kyanite = ky +ls_fe2o3_post_perovski = lppv +magnetite = mag +hp_clinoenstatite = mgc2 +mg_ca_ferrite = mgcf +mg_akimotoite = mgil +mg_majorite = mgmj +mg_perovskite = mgpv +mg_ringwoodite = mgri +mg_tschermaks = mgts +mg_wadsleyite = mgwa +mg_nal_phase = mnal +mg_postperovskite = mppv +na_ca_ferrite = nacf +na_majorite = namj +nepheline = neph +na_nal_phase = nnal +ortho_diopside = odi +periclase = pe +pyrope = py +quartz = qtz +spinel = sp +stishovite = st +wustite = wu +wustite_low_spin = wuls + + +""" +SOLUTION ALIASES +""" + +c2c = c2c_pyroxene +cf = calcium_ferrite_structured_phase +cpx = clinopyroxene +gt = garnet +il = ilmenite +mw = ferropericlase +nal = new_aluminous_phase +ol = olivine +opx = orthopyroxene +plg = plagioclase +ppv = post_perovskite +pv = bridgmanite +ri = ringwoodite +wa = wadsleyite diff --git a/burnman/minerals/__init__.py b/burnman/minerals/__init__.py index 8c87f7db1..0e3caa660 100644 --- a/burnman/minerals/__init__.py +++ b/burnman/minerals/__init__.py @@ -10,6 +10,7 @@ - :mod:`~burnman.minerals.SLB_2005` - :mod:`~burnman.minerals.SLB_2011_ZSB_2013` - :mod:`~burnman.minerals.SLB_2011` + - :mod:`~burnman.minerals.SLB_2022` - :mod:`~burnman.minerals.DKS_2013_liquids` - :mod:`~burnman.minerals.DKS_2013_solids` - :mod:`~burnman.minerals.RS_2014_liquids` @@ -26,6 +27,7 @@ from __future__ import absolute_import # Stixrude and Lithgow-Bertelloni +from . import SLB_2022 from . import SLB_2011 from . import SLB_2011_ZSB_2013 from . import SLB_2005 diff --git a/docs/changelog/20230620_bobmyhill.rst b/docs/changelog/20230620_bobmyhill.rst new file mode 100644 index 000000000..0b5e36590 --- /dev/null +++ b/docs/changelog/20230620_bobmyhill.rst @@ -0,0 +1,3 @@ +* BurnMan now has an implementation of the SLB2022 dataset. + + *Bob Myhill, 2023/06/20* diff --git a/docs/mineral_database.rst b/docs/mineral_database.rst index 08f7a3b4a..4645f1d8e 100644 --- a/docs/mineral_database.rst +++ b/docs/mineral_database.rst @@ -19,6 +19,9 @@ Mineral databases .. automodule:: burnman.minerals.SLB_2011 :no-inherited-members: +.. automodule:: burnman.minerals.SLB_2022 + :no-inherited-members: + .. automodule:: burnman.minerals.SLB_2011_ZSB_2013 :no-inherited-members: diff --git a/docs/ref.bib b/docs/ref.bib index 9f22bc62f..1a8330e51 100644 --- a/docs/ref.bib +++ b/docs/ref.bib @@ -278,6 +278,23 @@ @article{Watt1976 volume = {14}, year = {1976} } + +@article{Stixrude2022, + author = {Stixrude, Lars and Lithgow-Bertelloni, Carolina}, + doi = {10.1093/gji/ggab394}, + eprint = {https://academic.oup.com/gji/article-pdf/228/2/1119/40854679/ggab394.pdf}, + issn = {0956-540X}, + journal = {Geophysical Journal International}, + month = {09}, + number = {2}, + pages = {1119-1149}, + title = {{Thermal expansivity, heat capacity and bulk modulus of the mantle}}, + url = {https://doi.org/10.1093/gji/ggab394}, + volume = {228}, + year = {2022}, + bdsk-url-1 = {https://doi.org/10.1093/gji/ggab394}} + + @article{Stixrude2011, author = {Stixrude, L and Lithgow-Bertelloni, C}, journal = {Geophys. J. Int.}, diff --git a/misc/ref/table_mineral_library.py.out b/misc/ref/table_mineral_library.py.out index 00d51684a..7d560cbf3 100644 --- a/misc/ref/table_mineral_library.py.out +++ b/misc/ref/table_mineral_library.py.out @@ -8,493 +8,493 @@ DKS_2013_liquids.MgSi3O7_liquid 9.35e-05 3000.0 2 3 0.86 0.02273836 DKS_2013_liquids.MgSi5O11_liquid 0.000146 3000.0 2 4 0.77 0.03318133543 0.4033708612 2037.798559 -0.6209203711 DKS_2013_liquids.MgSiO3_liquid 4.18e-05 3000.0 2 3 0.83 0.008009960983 -0.08859010337 2194.563521 -0.775354875 DKS_2013_liquids.SiO2_liquid 2.78e-05 3000.0 2 5 0.91 0.0004266056389 0.8639433047 5651.204964 -0.2783503528 -Name (dks_s equation of state) V_0 T_0 E_0 S_0 K_0 Kprime_0 Kdprime_0 n Cv grueneisen_0 q_0 -DKS_2013_solids.periclase 1.223e-05 2000.0 -1164949.141 119.8358648 1.09833574725e+11 4.62521269729 -4.46584071885e-11 2.0 49.04715075 1.412003694 0.6317609916 -DKS_2013_solids.perovskite 2.705e-05 3000.0 -3355012.782 338.4574347 1.67066911316e+11 4.19294951057 -2.465519881e-11 2.0 133.8111589 1.893754815 1.48780973 -DKS_2013_solids.stishovite 1.513e-05 3000.0 -2274840.214 166.8222552 1.81486727106e+11 5.29297964642 -3.77640007656e-11 2.0 77.94230433 1.389501259 1.33202555 -Name (hp_tmt equation of state) V_0 K_0 Kprime_0 Kdprime_0 molar_mass n Cp -HGP_2018_ds633.Cu 7.11e-06 1.625e+11 4.24 -2.6e-11 0.063546 1.0 [12.4, 0.00922, -379900.0, 233.5] -HGP_2018_ds633.Ni 6.59e-06 1.905e+11 4.25 -2.2e-11 0.0586934 1.0 [49.8, 0.0, 585900.0, -533.9] -HGP_2018_ds633.NiO 1.097e-05 2e+11 3.94 -2e-11 0.0746928 2.0 [47.7, 0.007824, -392500.0, 0.0] -HGP_2018_ds633.S 1.551e-05 14500000000.0 7.0 -4.8e-10 0.032065 1.0 [56.6, -0.004557, 638000.0, -681.8] -HGP_2018_ds633.ab 0.00010067 54100000000.0 5.91 -1.09e-10 0.262223 13.0 [452.0, -0.013364, -1275900.0, -3953.6] -HGP_2018_ds633.abh 0.00010105 54100000000.0 5.91 -1.09e-10 0.262223 13.0 [452.0, -0.013364, -1275900.0, -3953.6] -HGP_2018_ds633.acm 6.459e-05 1.06e+11 4.08 -3.8e-11 0.2310022 10.0 [307.1, 0.016758, -1685500.0, -2125.8] -HGP_2018_ds633.afchl 0.0002157 87000000000.0 4.09 -4.7e-11 0.55422472 36.0 [1155.0, -0.000417, -4024400.0, -9952.9] -HGP_2018_ds633.ak 9.254e-05 1.42e+11 4.06 -2.9e-11 0.2726278 12.0 [385.4, 0.003209, -247500.0, -2889.9] -HGP_2018_ds633.alm 0.00011525 1.9e+11 2.98 -1.6e-11 0.4977473 20.0 [716.2, -0.01241, -3160800.0, -5863.5] -HGP_2018_ds633.ames 0.0002071 87000000000.0 4.09 -4.7e-11 0.55736972 36.0 [1186.0, -0.002599, -3627200.0, -10677.0] -HGP_2018_ds633.amul 5.083e-05 1.74e+11 4.0 -2.3e-11 0.15749365 7.75 [244.8, 0.000968, -2533300.0, -1641.6] -HGP_2018_ds633.an 0.00010079 86000000000.0 4.09 -4.8e-11 0.2782072 13.0 [370.5, 0.01001, -4339100.0, -1960.6] -HGP_2018_ds633.andalusite 5.153e-05 1.442e+11 6.89 -4.8e-11 0.1620455 8.0 [277.3, -0.006588, -1914100.0, -2265.6] -HGP_2018_ds633.andr 0.00013204 1.588e+11 5.68 -3.6e-11 0.5081733 20.0 [638.6, 0.0, -4955100.0, -3989.2] -HGP_2018_ds633.ank 6.606e-05 91400000000.0 3.88 -4.3e-11 0.2159408 10.0 [341.0, -0.001161, 0.0, -3054.8] -HGP_2018_ds633.anl 9.74e-05 40000000000.0 4.18 -1.04e-10 0.22015398 13.0 [643.5, -0.016067, 9302300.0, -9179.6] -HGP_2018_ds633.ann 0.00015432 51300000000.0 7.33 -1.43e-10 0.51187998 22.0 [815.7, -0.034861, 19800.0, -7466.7] -HGP_2018_ds633.anth 0.0002654 70000000000.0 4.11 -5.9e-11 0.78082048 41.0 [1277.3, 0.025825, -9704600.0, -9074.7] -HGP_2018_ds633.any 4.594e-05 54380000000.0 4.19 -7.7e-11 0.1361406 6.0 [128.7, 0.048545, -1223000.0, -560.5] -HGP_2018_ds633.apv 2.54e-05 2.03e+11 4.0 -2e-11 0.1019612 5.0 [139.5, 0.00589, -2460600.0, -589.2] -HGP_2018_ds633.arag 3.415e-05 61400000000.0 5.87 -9.6e-11 0.1000869 5.0 [167.1, 0.010695, 162000.0, -1564.9] -HGP_2018_ds633.atg 0.0017548 63100000000.0 5.92 -9.4e-11 4.53595108 291.0 [9621.0, -0.091183, -35941600.0, -83034.2] -HGP_2018_ds633.bdy 2.115e-05 95300000000.0 3.88 -4.1e-11 0.1232228 3.0 [89.6, 0.000354, -853100.0, -413.7] -HGP_2018_ds633.bdyC 2.495e-05 95300000000.0 3.88 -4.1e-11 0.1232228 3.0 [89.6, 0.000354, -853100.0, -413.7] -HGP_2018_ds633.bdyT 2.115e-05 95300000000.0 3.88 -4.1e-11 0.1232228 3.0 [89.6, 0.000354, -853100.0, -413.7] -HGP_2018_ds633.bix 3.137e-05 2.23e+11 4.04 -1.8e-11 0.1578742 5.0 [145.1, 0.023534, 721600.0, -1008.4] -HGP_2018_ds633.br 2.463e-05 41500000000.0 6.45 -1.55e-10 0.05831968 5.0 [158.4, -0.004076, -1052300.0, -1171.3] -HGP_2018_ds633.cacf 3.976e-05 1.9e+11 4.0 -2.1e-11 0.1580386 7.0 [191.9, 0.009563, -3211300.0, -640.2] -HGP_2018_ds633.caes 6.05e-05 1.192e+11 5.19 -4.4e-11 0.1991879 9.5 [362.0, -0.016944, -175900.0, -3565.7] -HGP_2018_ds633.canal 0.00011159 1.77e+11 4.0 -2.2e-11 0.4425698 21.0 [591.9, 0.022067, -9204100.0, -2417.0] -HGP_2018_ds633.cats 6.356e-05 1.192e+11 5.19 -4.4e-11 0.2181229 10.0 [347.6, -0.006974, -1781600.0, -2757.5] -HGP_2018_ds633.cc 3.689e-05 73300000000.0 4.06 -5.5e-11 0.1000869 5.0 [140.9, 0.005029, -950700.0, -858.4] -HGP_2018_ds633.cel 0.00013957 70000000000.0 4.11 -5.9e-11 0.39673548 21.0 [741.2, -0.018748, -2368800.0, -6616.9] -HGP_2018_ds633.cen 6.264e-05 1.059e+11 8.65 -8.2e-11 0.2007774 10.0 [306.0, -0.003793, -3041700.0, -1852.1] -HGP_2018_ds633.cg 5.603e-05 46500000000.0 4.16 -8.9e-11 0.1420544 7.0 [116.1, 0.086021, -1992700.0, 0.0] -HGP_2018_ds633.cgh 5.67e-05 46500000000.0 4.16 -8.9e-11 0.1420544 7.0 [229.2, 0.011876, 0.0, -1970.7] -HGP_2018_ds633.chdr 0.00011084 1.161e+11 4.8 -4.1e-11 0.33970588 19.0 [625.0, -0.001088, -2259900.0, -4910.7] -HGP_2018_ds633.chr 0.00010746 62800000000.0 4.0 -6.4e-11 0.27711236 18.0 [624.7, -0.02077, -1721800.0, -5619.4] -HGP_2018_ds633.chum 0.00019801 1.199e+11 4.58 -3.8e-11 0.62109208 33.0 [1071.0, -0.016533, -7899600.0, -7373.9] -HGP_2018_ds633.clin 0.0002114 87000000000.0 4.09 -4.7e-11 0.55579722 36.0 [1170.8, -0.001508, -3825800.0, -10315.0] -HGP_2018_ds633.coe 2.064e-05 97900000000.0 4.19 -4.3e-11 0.0600843 3.0 [107.8, -0.003279, -190300.0, -1041.6] -HGP_2018_ds633.cor 2.558e-05 2.54e+11 4.34 -1.7e-11 0.1019612 5.0 [139.5, 0.00589, -2460600.0, -589.2] -HGP_2018_ds633.cpv 2.745e-05 2.36e+11 3.9 -1.6e-11 0.1161617 5.0 [159.3, 0.0, -967300.0, -1075.4] -HGP_2018_ds633.crd 0.00023322 1.29e+11 4.1 -3.1e-11 0.5849527 29.0 [906.1, 0.0, -7902000.0, -6293.4] -HGP_2018_ds633.crst 2.745e-05 16000000000.0 4.35 -2.72e-10 0.0600843 3.0 [72.7, 0.001304, -4129000.0, 0.0] -HGP_2018_ds633.cstn 4.818e-05 1.782e+11 4.0 -2.2e-11 0.176246 8.0 [205.6, 0.006034, -5517700.0, -352.6] -HGP_2018_ds633.cumm 0.0002633 70000000000.0 4.11 -5.9e-11 0.78082048 41.0 [1277.3, 0.025825, -9704600.0, -9074.7] -HGP_2018_ds633.cup 2.344e-05 1.31e+11 5.7 -4.3e-11 0.1430914 3.0 [110.3, 0.0, 0.0, -674.8] -HGP_2018_ds633.cz 0.0001363 1.197e+11 4.07 -3.4e-11 0.45435714 22.0 [630.9, 0.013693, -6645800.0, -3731.1] -HGP_2018_ds633.daph 0.0002162 87000000000.0 4.09 -4.7e-11 0.71349722 36.0 [1192.0, -0.00594, -4826400.0, -9768.3] -HGP_2018_ds633.deer 0.0005574 63000000000.0 4.12 -6.5e-11 2.1522854 90.0 [3164.4, -0.027883, -5039100.0, -26721.0] -HGP_2018_ds633.di 6.619e-05 1.192e+11 5.19 -4.4e-11 0.2165504 10.0 [314.5, 4.1e-05, -2745900.0, -2020.1] -HGP_2018_ds633.diam 3.42e-06 4.465e+11 1.61 -3.6e-12 0.0120107 1.0 [40.0, 0.0, -28500.0, -580.5] -HGP_2018_ds633.dol 6.429e-05 94300000000.0 3.74 -4e-11 0.1844008 10.0 [358.9, -0.004905, 0.0, -3456.2] -HGP_2018_ds633.dsp 1.786e-05 2.28e+11 4.04 -1.8e-11 0.05998824 4.0 [145.1, 0.008709, 584400.0, -1741.1] -HGP_2018_ds633.east 0.00014738 53000000000.0 7.33 -1.43e-10 0.41883248 22.0 [785.5, -0.038031, -2130300.0, -6893.7] -HGP_2018_ds633.en 6.262e-05 1.059e+11 8.65 -8.2e-11 0.2007774 10.0 [356.2, -0.00299, -596900.0, -3185.3] -HGP_2018_ds633.ep 0.0001392 1.34e+11 4.0 -3e-11 0.48322064 22.0 [613.3, 0.02207, -7160000.0, -2987.7] -HGP_2018_ds633.esk 2.898e-05 2.45e+11 3.6 -1.5e-11 0.1519904 5.0 [119.0, 0.009496, -1442000.0, -3.4] -HGP_2018_ds633.fa 4.631e-05 1.256e+11 4.68 -3.7e-11 0.2037731 7.0 [201.1, 0.01733, -1960600.0, -900.9] -HGP_2018_ds633.fact 0.0002842 76000000000.0 4.1 -5.4e-11 0.97006648 41.0 [1290.0, 0.029992, -8447500.0, -8947.0] -HGP_2018_ds633.fak 2.76e-05 2.18e+11 4.55 -2.2e-11 0.1319287 5.0 [100.3, 0.013328, -4364900.0, 419.8] -HGP_2018_ds633.fanth 0.0002787 70000000000.0 4.11 -5.9e-11 1.00160048 41.0 [1383.1, 0.030669, -4224700.0, -11257.6] -HGP_2018_ds633.fcar 0.00010695 52500000000.0 4.14 -7.9e-11 0.33000476 19.0 [686.6, -0.012415, 186000.0, -6884.0] -HGP_2018_ds633.fcel 0.0001407 70000000000.0 4.11 -5.9e-11 0.42827548 21.0 [756.3, -0.019147, -1586100.0, -6928.7] -HGP_2018_ds633.fcrd 0.0002371 1.29e+11 4.1 -3.1e-11 0.6480327 29.0 [924.0, 0.0, -7039400.0, -6439.6] -HGP_2018_ds633.fctd 6.98e-05 1.456e+11 4.06 -2.8e-11 0.25190518 13.0 [416.1, -0.003477, -2835900.0, -3360.3] -HGP_2018_ds633.fep 0.0001421 1.513e+11 4.0 -2.6e-11 0.51208414 22.0 [584.7, 0.030447, -7674200.0, -2244.3] -HGP_2018_ds633.fgl 0.0002659 89000000000.0 4.09 -4.6e-11 0.87816308 41.0 [1762.9, -0.118992, 9423700.0, -20207.1] -HGP_2018_ds633.fo 4.366e-05 1.285e+11 3.84 -3e-11 0.1406931 7.0 [233.3, 0.001494, -603800.0, -1869.7] -HGP_2018_ds633.fper 1.206e-05 1.52e+11 4.9 -3.2e-11 0.0718444 2.0 [44.4, 0.00828, -1214200.0, 185.2] -HGP_2018_ds633.fpm 0.0002968 1.615e+11 4.05 -2.5e-11 0.97461628 51.0 [1737.2, -0.024582, -5161100.0, -14963.0] -HGP_2018_ds633.fpre 0.000148 1.093e+11 4.01 -3.7e-11 0.44124768 21.0 [737.1, -0.01681, -1957300.0, -6358.1] -HGP_2018_ds633.fpv 2.534e-05 2.81e+11 4.14 -1.6e-11 0.1319287 5.0 [133.2, 0.01083, -3661400.0, -314.7] -HGP_2018_ds633.frw 4.203e-05 1.977e+11 4.92 -2.5e-11 0.2037731 7.0 [166.8, 0.04261, -1705400.0, -541.4] -HGP_2018_ds633.fs 6.592e-05 1.01e+11 4.08 -4e-11 0.2638574 10.0 [398.7, -0.006579, 1290100.0, -4058.0] -HGP_2018_ds633.fscf 3.914e-05 1.85e+11 4.0 -1.7e-11 0.2037731 7.0 [181.1, 0.018526, -2767200.0, -527.1] -HGP_2018_ds633.fsnal 0.00011856 1.85e+11 4.0 -2.2e-11 0.6113193 21.0 [543.3, 0.055578, -8301600.0, -1581.3] -HGP_2018_ds633.fspr 0.00019923 2.5e+11 4.04 -1.7e-11 0.815391 34.0 [1132.9, -0.007348, -10420200.0, -7036.6] -HGP_2018_ds633.fst 0.0004488 1.8e+11 4.76 -2.6e-11 1.69169121 81.5 [2880.0, -0.056595, -10642000.0, -25373.0] -HGP_2018_ds633.fstp 0.00037239 51300000000.0 7.33 -1.43e-10 1.0780021 58.5 [1944.3, -0.012289, -4840200.0, -16635.0] -HGP_2018_ds633.fsud 0.000204 87000000000.0 4.09 -4.7e-11 0.59992522 35.0 [1466.3, -0.047365, -1182800.0, -14388.0] -HGP_2018_ds633.fta 0.00014225 43000000000.0 6.17 -1.44e-10 0.47388568 21.0 [579.7, 0.039494, -6459300.0, -3088.1] -HGP_2018_ds633.fwd 4.321e-05 1.69e+11 4.35 -2.6e-11 0.2037731 7.0 [201.1, 0.01733, -1960600.0, -900.9] -HGP_2018_ds633.ged 0.00025956 70000000000.0 4.11 -5.9e-11 0.78396548 41.0 [1307.7, 0.023642, -9307400.0, -9799.0] -HGP_2018_ds633.geh 9.024e-05 1.08e+11 4.08 -3.8e-11 0.2742003 12.0 [405.7, -0.007099, -1188300.0, -3174.4] -HGP_2018_ds633.geik 3.086e-05 1.7e+11 8.3 -4.9e-11 0.1201702 5.0 [115.5, 0.014938, -2637700.0, 45.5] -HGP_2018_ds633.gl 0.0002598 88300000000.0 4.09 -4.6e-11 0.78354308 41.0 [1717.5, -0.12107, 7075000.0, -19272.0] -HGP_2018_ds633.glt 0.0001198 63000000000.0 4.0 -6.3e-11 0.37173236 18.0 [576.4, 0.002984, -3757000.0, -4166.2] -HGP_2018_ds633.gph 5.3e-06 31200000000.0 3.9 -1.25e-10 0.0120107 1.0 [34.3, 0.0, -240700.0, -403.8] -HGP_2018_ds633.gr 0.00012535 1.72e+11 5.53 -3.2e-11 0.4504463 20.0 [626.0, 0.0, -5779200.0, -4002.9] -HGP_2018_ds633.grun 0.0002784 64800000000.0 4.12 -6.4e-11 1.00160048 41.0 [1383.1, 0.030669, -4224700.0, -11257.6] -HGP_2018_ds633.gth 2.082e-05 2.5e+11 4.03 -1.6e-11 0.08885174 4.0 [139.3, 0.000147, -212700.0, -1077.8] -HGP_2018_ds633.hcrd 0.00023322 1.29e+11 4.1 -3.1e-11 0.60296798 32.0 [955.3, 0.0, -8352600.0, -6301.2] -HGP_2018_ds633.hed 6.795e-05 1.192e+11 3.97 -3.3e-11 0.2480904 10.0 [340.2, 0.000812, -1047800.0, -2646.7] -HGP_2018_ds633.hem 3.027e-05 2.23e+11 4.04 -1.8e-11 0.1596882 5.0 [163.9, 0.0, -2257200.0, -657.6] -HGP_2018_ds633.hen 6.099e-05 1.5e+11 5.5 -3.6e-11 0.2007774 10.0 [356.2, -0.00299, -596900.0, -3185.3] -HGP_2018_ds633.herc 4.075e-05 1.922e+11 4.04 -2.1e-11 0.1738056 7.0 [184.9, 0.01417, -3674800.0, -404.0] -HGP_2018_ds633.heu 0.000317 27400000000.0 4.0 -1.46e-10 0.68672038 46.0 [1504.8, -0.033224, -2959300.0, -13297.2] -HGP_2018_ds633.hfs 6.405e-05 1.5e+11 5.5 -3.6e-11 0.2638574 10.0 [398.7, -0.006579, 1290100.0, -4058.0] -HGP_2018_ds633.hlt 2.702e-05 23800000000.0 5.0 -2.1e-10 0.0584428 2.0 [45.2, 0.01797, 0.0, 0.0] -HGP_2018_ds633.hol 7.128e-05 1.8e+11 4.0 -2.2e-11 0.2783315 13.0 [417.6, -0.003617, -4748100.0, -2819.9] -HGP_2018_ds633.ilm 3.169e-05 1.7e+11 8.3 -4.9e-11 0.1517102 5.0 [138.9, 0.005081, -1288800.0, -463.7] -HGP_2018_ds633.iron 7.09e-06 1.64e+11 5.16 -3.1e-11 0.055845 1.0 [46.2, 0.005159, 723100.0, -556.2] -HGP_2018_ds633.jd 6.04e-05 1.281e+11 3.81 -3e-11 0.2021387 10.0 [319.4, 0.003616, -1173900.0, -2469.5] -HGP_2018_ds633.jgd 0.0003108 1.615e+11 4.05 -2.5e-11 1.11893378 51.0 [1795.4, -0.037986, -4455700.0, -14888.0] -HGP_2018_ds633.kao 9.934e-05 64500000000.0 4.12 -6.4e-11 0.25816036 17.0 [436.7, -0.034295, -4055900.0, -2699.1] -HGP_2018_ds633.kcm 0.00011438 42500000000.0 2.0 -4.7e-11 0.29634678 16.0 [536.5, -0.01009, -980400.0, -4735.0] -HGP_2018_ds633.kjd 6.479e-05 1.45e+11 5.0 -3.4e-11 0.2182472 10.0 [316.2, 0.006905, -905300.0, -2489.0] -HGP_2018_ds633.kls 6.052e-05 51400000000.0 2.0 -3.9e-11 0.1581629 7.0 [242.0, -0.004482, -895800.0, -1935.8] -HGP_2018_ds633.knor 0.00011738 1.534e+11 4.34 -2.8e-11 0.4531565 20.0 [613.0, 0.003606, -4178000.0, -3729.4] -HGP_2018_ds633.kos 6.309e-05 1.308e+11 3.0 -2.3e-11 0.2271533 10.0 [309.2, 0.005419, -664600.0, -2176.6] -HGP_2018_ds633.ky 4.414e-05 1.601e+11 4.05 -2.5e-11 0.1620455 8.0 [279.4, -0.007124, -2055600.0, -2289.4] -HGP_2018_ds633.law 0.00010132 1.229e+11 5.45 -4.4e-11 0.31423776 19.0 [687.8, 0.001566, 375900.0, -7179.2] -HGP_2018_ds633.lc 8.826e-05 45000000000.0 5.7 -1.27e-10 0.2182472 10.0 [369.8, -0.016332, 684700.0, -3683.1] -HGP_2018_ds633.lime 1.676e-05 1.13e+11 3.87 -3.4e-11 0.0560774 2.0 [52.4, 0.003673, -750700.0, -51.0] -HGP_2018_ds633.liz 0.00010645 71000000000.0 3.2 -4.5e-11 0.27711236 18.0 [614.7, -0.02077, -1721800.0, -5619.4] -HGP_2018_ds633.lmt 0.0002037 86000000000.0 4.09 -4.8e-11 0.47043692 31.0 [1013.4, -0.021413, -2235800.0, -8806.7] -HGP_2018_ds633.lot 1.818e-05 65800000000.0 4.17 -6.3e-11 0.08791 2.0 [50.2, 0.011052, -940000.0, 0.0] -HGP_2018_ds633.lrn 5.16e-05 98500000000.0 4.07 -4.1e-11 0.1722391 7.0 [247.5, -0.003206, 0.0, -2051.9] -HGP_2018_ds633.ma 0.00012964 1e+11 4.08 -4.1e-11 0.39818368 21.0 [744.4, -0.0168, -2074400.0, -6783.2] -HGP_2018_ds633.macf 3.614e-05 2.12e+11 4.0 -1.7e-11 0.1422656 7.0 [200.0, 0.006252, -2996400.0, -888.4] -HGP_2018_ds633.mag 2.803e-05 1.028e+11 5.41 -5.3e-11 0.0843139 5.0 [186.4, -0.003772, 0.0, -1886.2] -HGP_2018_ds633.maj 0.00011457 1.6e+11 4.56 -2.8e-11 0.4015548 20.0 [713.6, -0.000997, -1158200.0, -6622.3] -HGP_2018_ds633.mak 2.635e-05 2.11e+11 4.55 -2.2e-11 0.1003887 5.0 [147.8, 0.002015, -2395000.0, -801.8] -HGP_2018_ds633.manal 0.00011166 1.84e+11 4.0 -2.2e-11 0.4267968 21.0 [600.0, 0.018756, -8989200.0, -2665.2] -HGP_2018_ds633.mang 1.322e-05 1.645e+11 4.46 -2.7e-11 0.0709374 2.0 [59.8, 0.0036, -31400.0, -282.6] -HGP_2018_ds633.mcar 0.0001059 52500000000.0 4.14 -7.9e-11 0.29846476 19.0 [683.0, -0.014054, 291000.0, -6976.4] -HGP_2018_ds633.mcor 2.635e-05 2.11e+11 4.55 -2.2e-11 0.1003887 5.0 [147.8, 0.002015, -2395000.0, -801.8] -HGP_2018_ds633.mctd 6.875e-05 1.456e+11 4.06 -2.8e-11 0.22036518 13.0 [417.4, -0.003771, -2920600.0, -3417.8] -HGP_2018_ds633.me 0.00033985 87000000000.0 4.09 -4.7e-11 0.9347085 44.0 [1359.0, 0.036442, -8594700.0, -9598.2] -HGP_2018_ds633.merw 9.847e-05 1.2e+11 4.07 -3.4e-11 0.3287052 14.0 [417.5, 0.008117, -2923000.0, -2320.3] -HGP_2018_ds633.mft 4.457e-05 1.857e+11 4.05 -2.2e-11 0.1999926 7.0 [270.5, -0.007505, -999200.0, -2022.4] -HGP_2018_ds633.mgts 6.05e-05 1.028e+11 8.55 -8.3e-11 0.2023499 10.0 [371.4, -0.004082, -398400.0, -3547.1] -HGP_2018_ds633.mic 0.00010871 58300000000.0 4.02 -6.9e-11 0.2783315 13.0 [448.8, -0.010075, -1007300.0, -3973.1] -HGP_2018_ds633.minm 0.00014291 43000000000.0 6.17 -1.44e-10 0.37926568 21.0 [622.2, 0.0, -6385500.0, -3916.3] -HGP_2018_ds633.minn 0.00014851 43000000000.0 6.17 -1.44e-10 0.47388568 21.0 [579.7, 0.039494, -6459300.0, -3088.1] -HGP_2018_ds633.mnbi 0.00015264 53000000000.0 7.33 -1.43e-10 0.50915898 22.0 [809.9, -0.059213, -1514400.0, -6998.7] -HGP_2018_ds633.mnchl 0.0002259 87000000000.0 4.09 -4.7e-11 0.70896222 36.0 [1136.5, -0.005243, -5548100.0, -8911.5] -HGP_2018_ds633.mncrd 0.00024027 1.29e+11 4.1 -3.1e-11 0.6462187 29.0 [886.5, 0.0, -8840000.0, -5590.4] -HGP_2018_ds633.mnctd 7.175e-05 1.456e+11 4.06 -2.8e-11 0.25099818 13.0 [464.4, -0.012654, -1147200.0, -4341.0] -HGP_2018_ds633.mnst 0.0004546 1.8e+11 4.76 -2.6e-11 1.68806321 81.5 [2873.3, -0.089064, -12688000.0, -24749.0] -HGP_2018_ds633.mont 5.148e-05 1.134e+11 3.87 -3.4e-11 0.1564661 7.0 [250.7, -0.010433, -797200.0, -1996.1] -HGP_2018_ds633.mpm 0.0002955 1.615e+11 4.05 -2.5e-11 0.94307628 51.0 [1720.8, -0.024928, -5998700.0, -14620.3] -HGP_2018_ds633.mpv 2.445e-05 2.51e+11 4.14 -1.6e-11 0.1003887 5.0 [149.3, 0.002918, -2983000.0, -799.1] -HGP_2018_ds633.mrw 3.949e-05 1.781e+11 4.35 -2.4e-11 0.1406931 7.0 [213.3, 0.00269, -1410400.0, -1495.9] -HGP_2018_ds633.mscf 3.649e-05 1.85e+11 4.0 -1.7e-11 0.1406931 7.0 [213.3, 0.00269, -1410400.0, -1495.9] -HGP_2018_ds633.msnal 0.00011061 1.85e+11 4.0 -2.2e-11 0.4220793 21.0 [639.9, 0.00807, -4231200.0, -4487.7] -HGP_2018_ds633.mst 0.0004426 1.684e+11 4.05 -2.4e-11 1.56553121 81.5 [2820.5, -0.059366, -13774000.0, -24126.0] -HGP_2018_ds633.mstp 0.00036577 51300000000.0 7.33 -1.43e-10 0.9203021 58.5 [1862.2, -0.014018, -8983100.0, -14923.0] -HGP_2018_ds633.mt 4.452e-05 1.857e+11 4.05 -2.2e-11 0.2315326 7.0 [262.5, -0.007205, -1926200.0, -1655.7] -HGP_2018_ds633.mu 0.00014083 49000000000.0 4.15 -8.5e-11 0.39830798 21.0 [756.4, -0.01984, -2170000.0, -6979.2] -HGP_2018_ds633.mwd 4.051e-05 1.726e+11 3.84 -2.2e-11 0.1406931 7.0 [208.7, 0.003942, -1709500.0, -1302.8] -HGP_2018_ds633.nacf 3.631e-05 1.85e+11 4.6 -2.5e-11 0.1420544 7.0 [272.7, -0.012398, 0.0, -2763.1] -HGP_2018_ds633.nagt 0.0001109 1.7e+11 4.0 -2.3e-11 0.4029161 20.0 [620.8, 0.0112, -3755900.0, -4421.3] -HGP_2018_ds633.nanal 0.00011322 1.84e+11 4.0 -2.2e-11 0.4265856 21.0 [672.7, 0.000106, -5992800.0, -4539.9] -HGP_2018_ds633.naph 0.0001445 51300000000.0 7.33 -1.43e-10 0.40115148 22.0 [773.5, -0.040229, -2597900.0, -6512.6] -HGP_2018_ds633.ne 5.419e-05 46500000000.0 4.16 -8.9e-11 0.1420544 7.0 [272.7, -0.012398, 0.0, -2763.1] -HGP_2018_ds633.npv 2.334e-05 2.03e+11 4.0 -2e-11 0.10106935 5.0 [135.0, 0.00846, -1850300.0, -600.8] -HGP_2018_ds633.nta 0.0001445 51300000000.0 7.33 -1.43e-10 0.40115148 22.0 [773.5, -0.040229, -2597900.0, -6512.6] -HGP_2018_ds633.nyb 0.00026314 91000000000.0 4.09 -4.5e-11 0.80542888 42.0 [1745.2, -0.112162, 6425500.0, -19163.0] -HGP_2018_ds633.osfa 0.0003845 1.29e+11 4.1 -3.1e-11 1.0465328 48.0 [1558.6, -0.011359, -9476500.0, -11845.0] -HGP_2018_ds633.osma 0.00037893 1.29e+11 4.1 -3.1e-11 0.9834528 48.0 [1540.7, -0.011359, -10339000.0, -11699.0] -HGP_2018_ds633.osmm 0.0003844 1.29e+11 4.1 -3.1e-11 0.9818803 48.0 [1525.5, -0.010267, -10538000.0, -11337.0] -HGP_2018_ds633.pa 0.00013211 51500000000.0 6.51 -1.26e-10 0.38219948 21.0 [803.0, -0.03158, 217000.0, -8151.0] -HGP_2018_ds633.parg 0.0002719 91200000000.0 4.09 -4.5e-11 0.83582478 42.0 [1280.2, 0.022997, -12359500.0, -8065.8] -HGP_2018_ds633.per 1.125e-05 1.616e+11 3.95 -2.4e-11 0.0403044 2.0 [60.5, 0.000362, -535800.0, -299.2] -HGP_2018_ds633.phA 0.00015422 1.45e+11 4.06 -2.8e-11 0.45634524 29.0 [962.0, -0.011521, -4517800.0, -7724.7] -HGP_2018_ds633.phD 5.103e-05 1.65e+11 5.0 -3e-11 0.17848828 11.0 [294.6, 0.007944, -5008700.0, -1335.5] -HGP_2018_ds633.phE 6.435e-05 93000000000.0 5.0 -5.4e-11 0.190450056 12.0 [397.4, -0.003533, -1344400.0, -3290.2] -HGP_2018_ds633.phl 0.00014964 51300000000.0 7.33 -1.43e-10 0.41725998 22.0 [770.3, -0.036939, -2328900.0, -6531.6] -HGP_2018_ds633.picr 4.356e-05 1.922e+11 4.04 -2.1e-11 0.1922948 7.0 [196.1, 0.005398, -3126000.0, -616.9] -HGP_2018_ds633.pmt 0.0001382 1.197e+11 4.07 -3.4e-11 0.48231364 22.0 [569.8, 0.02779, -5442900.0, -2812.6] -HGP_2018_ds633.pnt 3.288e-05 1.7e+11 8.3 -4.9e-11 0.1508032 5.0 [143.5, 0.003373, -1940700.0, -407.6] -HGP_2018_ds633.ppv 2.442e-05 2.312e+11 4.0 -1.6e-11 0.1003887 5.0 [149.3, 0.002918, -2983000.0, -799.1] -HGP_2018_ds633.pre 0.00014026 1.093e+11 4.01 -3.7e-11 0.41238418 21.0 [724.9, -0.013865, -2059000.0, -6323.9] -HGP_2018_ds633.pren 6.476e-05 1.059e+11 8.65 -8.2e-11 0.2007774 10.0 [356.2, -0.00299, -596900.0, -3185.3] -HGP_2018_ds633.prl 0.00012804 37000000000.0 10.0 -2.71e-10 0.36031368 20.0 [784.5, -0.042948, 1251000.0, -8495.9] -HGP_2018_ds633.pswo 4.008e-05 1.1e+11 4.08 -3.7e-11 0.1161617 5.0 [157.8, 0.0, -967300.0, -1075.4] -HGP_2018_ds633.pxmn 3.472e-05 84000000000.0 4.0 -4.8e-11 0.1310217 5.0 [138.4, 0.004088, -1936000.0, -538.9] -HGP_2018_ds633.py 0.00011313 1.743e+11 4.05 -2.3e-11 0.4031273 20.0 [633.5, 0.0, -5196100.0, -4315.2] -HGP_2018_ds633.pyr 2.394e-05 1.395e+11 4.09 -2.9e-11 0.119975 3.0 [37.3, 0.026715, -1817000.0, 649.3] -HGP_2018_ds633.q 2.269e-05 73000000000.0 6.0 -8.2e-11 0.0600843 3.0 [92.9, -0.000642, -714900.0, -716.1] -HGP_2018_ds633.qnd 4.529e-05 1.47e+11 4.0 -2.72e-11 0.1604746 7.0 [161.7, 0.03286, -2382200.0, -278.6] -HGP_2018_ds633.rhc 3.107e-05 95300000000.0 3.88 -4.1e-11 0.1149469 5.0 [169.5, 0.0, 0.0, -1534.3] -HGP_2018_ds633.rhod 3.494e-05 84000000000.0 4.0 -4.8e-11 0.1310217 5.0 [138.4, 0.004088, -1936000.0, -538.9] -HGP_2018_ds633.rieb 0.0002749 89000000000.0 4.09 -4.6e-11 0.93589008 41.0 [1787.3, -0.124882, 9627100.0, -20275.5] -HGP_2018_ds633.rnk 9.651e-05 95000000000.0 4.09 -4.3e-11 0.2884008 12.0 [372.3, -0.002893, -2462400.0, -2181.3] -HGP_2018_ds633.ru 1.882e-05 2.22e+11 4.24 -1.9e-11 0.0798658 3.0 [90.4, 0.0029, 0.0, -623.8] -HGP_2018_ds633.san 0.00010871 58300000000.0 4.02 -6.9e-11 0.2783315 13.0 [448.8, -0.010075, -1007300.0, -3973.1] -HGP_2018_ds633.sdl 0.0004213 46500000000.0 4.16 -8.9e-11 0.969212 46.0 [1532.7, 0.047747, -2972800.0, -12427.0] -HGP_2018_ds633.shB 0.00018615 1.32e+11 5.3 -3.91e-11 0.61932746 35.0 [1077.7, 0.000642, -7407400.0, -7428.7] -HGP_2018_ds633.sid 2.943e-05 1.2e+11 4.07 -3.4e-11 0.1158539 5.0 [168.4, 0.0, 0.0, -1483.6] -HGP_2018_ds633.sill 4.986e-05 1.64e+11 5.06 -3.1e-11 0.1620455 8.0 [280.2, -0.0069, -1375700.0, -2399.4] -HGP_2018_ds633.ski 0.00012144 1.574e+11 6.7 -4.3e-11 0.5554743 20.0 [689.9, 0.0, -2948600.0, -5030.3] -HGP_2018_ds633.smul 4.987e-05 1.74e+11 4.0 -2.3e-11 0.1620455 8.0 [280.2, -0.0069, -1375700.0, -2399.4] -HGP_2018_ds633.sp 3.978e-05 1.922e+11 4.04 -2.1e-11 0.1422656 7.0 [200.5, 0.006252, -2996400.0, -888.4] -HGP_2018_ds633.sph 5.565e-05 1.017e+11 9.85 -9.7e-11 0.1960275 8.0 [227.9, 0.002924, -3539500.0, -894.3] -HGP_2018_ds633.spr4 0.000199 2.5e+11 4.04 -1.6e-11 0.689231 34.0 [1133.1, -0.007596, -8816600.0, -8180.6] -HGP_2018_ds633.spr5 0.0001975 2.5e+11 4.04 -1.6e-11 0.6908035 34.0 [1103.4, 0.001015, -10957000.0, -7409.2] -HGP_2018_ds633.spss 0.00011792 1.74e+11 6.68 -3.8e-11 0.4950263 20.0 [646.9, 0.0, -4525800.0, -4452.8] -HGP_2018_ds633.spu 0.00014697 95000000000.0 4.09 -4.3e-11 0.4445651 19.0 [614.1, -0.003508, -2493100.0, -4168.0] -HGP_2018_ds633.stlb 0.0003287 86000000000.0 4.09 -4.8e-11 0.70473566 49.0 [1588.4, -0.032043, -3071600.0, -13966.9] -HGP_2018_ds633.stv 1.401e-05 3.09e+11 4.6 -1.5e-11 0.0600843 3.0 [68.1, 0.00601, -1978200.0, -82.1] -HGP_2018_ds633.sud 0.000203 87000000000.0 4.09 -4.7e-11 0.53684522 35.0 [1436.1, -0.048749, -2748500.0, -13764.0] -HGP_2018_ds633.syv 3.752e-05 17000000000.0 5.0 -2.94e-10 0.0745513 2.0 [46.2, 0.01797, 0.0, 0.0] -HGP_2018_ds633.ta 0.00013665 43000000000.0 6.17 -1.44e-10 0.37926568 21.0 [622.2, 0.0, -6385500.0, -3916.3] -HGP_2018_ds633.tan 0.00013665 43000000000.0 6.17 -1.44e-10 0.37926568 21.0 [622.2, 0.0, -6385500.0, -3916.3] -HGP_2018_ds633.tap 0.0001345 37000000000.0 10.0 -2.71e-10 0.36031368 20.0 [784.5, -0.042948, 1251000.0, -8495.9] -HGP_2018_ds633.tats 0.0001351 43000000000.0 6.17 -1.44e-10 0.38083818 21.0 [549.5, 0.036324, -8606600.0, -2515.3] -HGP_2018_ds633.tcn 3.493e-05 2.301e+11 4.04 -1.8e-11 0.1399501 6.0 [208.6, -0.003669, 113000.0, -1906.9] -HGP_2018_ds633.ten 1.222e-05 2e+11 3.94 -2e-11 0.0795454 2.0 [31.0, 0.01374, -1258000.0, 369.3] -HGP_2018_ds633.teph 4.899e-05 1.256e+11 4.68 -3.7e-11 0.2019591 7.0 [219.6, 0.0, -1292700.0, -1308.3] -HGP_2018_ds633.tpz 5.339e-05 1.315e+11 4.06 -3.1e-11 0.18006078 11.0 [387.7, -0.00712, -857200.0, -3744.2] -HGP_2018_ds633.tr 0.0002727 76200000000.0 4.1 -5.4e-11 0.81236648 41.0 [1260.2, 0.00383, -11455000.0, -8237.6] -HGP_2018_ds633.trd 2.8e-05 15000000000.0 4.36 -2.91e-10 0.0600843 3.0 [74.9, 0.0031, -1174000.0, -236.7] -HGP_2018_ds633.tro 1.819e-05 65800000000.0 4.17 -6.3e-11 0.08791 2.0 [50.2, 0.011052, -940000.0, 0.0] -HGP_2018_ds633.trot 1.819e-05 65800000000.0 4.17 -6.3e-11 0.08791 2.0 [50.2, 0.011052, -940000.0, 0.0] -HGP_2018_ds633.trov 1.738e-05 65800000000.0 4.17 -6.3e-11 0.080929375 1.875 [51.1, 0.008307, -669700.0, 0.0] -HGP_2018_ds633.ts 0.000268 76000000000.0 4.1 -5.4e-11 0.81551148 41.0 [1244.8, 0.024348, -11965000.0, -8112.1] -HGP_2018_ds633.ty 0.00017039 95000000000.0 4.09 -4.3e-11 0.4885746 22.0 [741.7, -0.005345, -1434600.0, -5878.5] -HGP_2018_ds633.usp 4.682e-05 1.47e+11 4.0 -2.72e-11 0.2235546 7.0 [129.5, 0.048696, -3739000.0, 690.2] -HGP_2018_ds633.uv 0.00013077 1.62e+11 4.7 -2.9e-11 0.5004755 20.0 [605.1, 0.003606, -4760600.0, -3417.1] -HGP_2018_ds633.vsv 0.000852 1.255e+11 4.8 -3.8e-11 2.86945216 137.0 [4488.0, -0.057952, -22269300.0, -33478.0] -HGP_2018_ds633.wa 0.00010844 90000000000.0 4.0 -4.4e-11 0.3345332 15.0 [499.1, 0.0, 0.0, -4350.1] -HGP_2018_ds633.wal 3.7633e-05 86000000000.0 4.0 -4.7e-11 0.1161617 5.0 [159.3, 0.0, -967300.0, -1075.4] -HGP_2018_ds633.wo 3.993e-05 79500000000.0 4.1 -5.2e-11 0.1161617 5.0 [159.3, 0.0, -967300.0, -1075.4] -HGP_2018_ds633.wrk 0.0001904 86000000000.0 4.09 -4.8e-11 0.43440636 25.0 [838.3, -0.02146, -2272000.0, -7292.3] -HGP_2018_ds633.wu 1.206e-05 1.52e+11 4.0 -3.2e-11 0.0718444 2.0 [67.4, 0.003758, 315700.0, -381.7] -HGP_2018_ds633.zo 0.00013575 1.044e+11 4.0 -3.8e-11 0.45435714 22.0 [662.0, 0.010416, -6006400.0, -4260.7] -HGP_2018_ds633.zrc 3.926e-05 2.301e+11 4.04 -1.8e-11 0.1833071 6.0 [232.0, -0.014405, 0.0, -2238.2] -HGP_2018_ds633.zrt 4.42e-05 2.301e+11 4.04 -1.8e-11 0.2030886 6.0 [214.6, -0.008226, 190300.0, -1820.4] -Name (hp_tmt equation of state) V_0 K_0 Kprime_0 Kdprime_0 molar_mass n Cp -HHPH_2013.alm 0.00011525 1.9e+11 2.98 -1.6e-11 0.4977473 20.0 [677.3, 0.0, -3772700.0, -5044.0] -HHPH_2013.apv 2.54e-05 2.03e+11 4.0 -2e-11 0.1019612 5.0 [139.5, 0.00589, -2460600.0, -589.2] -HHPH_2013.cacf 3.976e-05 1.9e+11 4.0 -2.1e-11 0.1580386 7.0 [191.9, 0.009563, -3211300.0, -640.2] -HHPH_2013.canal 0.00011159 1.77e+11 4.0 -2.2e-11 0.4425698 21.0 [591.9, 0.022067, -9204100.0, -2417.0] -HHPH_2013.cats 6.356e-05 1.192e+11 5.19 -4.4e-11 0.2181229 10.0 [347.6, -0.006974, -1781600.0, -2757.5] -HHPH_2013.cen 6.264e-05 1.059e+11 8.65 -8.2e-11 0.2007774 10.0 [306.0, -0.003793, -3041700.0, -1852.1] -HHPH_2013.cor 2.558e-05 2.54e+11 4.34 -1.7e-11 0.1019612 5.0 [139.5, 0.00589, -2460600.0, -589.2] -HHPH_2013.cpv 2.745e-05 2.36e+11 3.9 -1.6e-11 0.1161617 5.0 [159.3, 0.0, -967300.0, -1075.4] -HHPH_2013.di 6.619e-05 1.192e+11 5.19 -4.4e-11 0.2165504 10.0 [314.5, 4.1e-05, -2745900.0, -2020.1] -HHPH_2013.en 6.262e-05 1.059e+11 8.65 -8.2e-11 0.2007774 10.0 [356.2, -0.00299, -596900.0, -3185.3] -HHPH_2013.fa 4.631e-05 1.256e+11 4.68 -3.7e-11 0.2037731 7.0 [201.1, 0.01733, -1960600.0, -900.9] -HHPH_2013.fak 2.76e-05 2.18e+11 4.55 -2.2e-11 0.1319287 5.0 [100.3, 0.013328, -4364900.0, 419.8] -HHPH_2013.fo 4.366e-05 1.285e+11 3.84 -3e-11 0.1406931 7.0 [233.3, 0.001494, -603800.0, -1869.7] -HHPH_2013.fper 1.206e-05 1.52e+11 4.9 -3.2e-11 0.0718444 2.0 [44.4, 0.00828, -1214200.0, 185.2] -HHPH_2013.fpv 2.534e-05 2.81e+11 4.14 -1.6e-11 0.1319287 5.0 [133.2, 0.01083, -3661400.0, -314.7] -HHPH_2013.frw 4.203e-05 1.977e+11 4.92 -2.5e-11 0.2037731 7.0 [166.8, 0.04261, -1705400.0, -541.4] -HHPH_2013.fs 6.592e-05 1.01e+11 4.08 -4e-11 0.2638574 10.0 [398.7, -0.006579, 1290100.0, -4058.0] -HHPH_2013.fscf 3.914e-05 1.85e+11 4.0 -1.7e-11 0.2037731 7.0 [181.1, 0.018526, -2767200.0, -527.1] -HHPH_2013.fsnal 0.00011856 1.85e+11 4.0 -2.2e-11 0.6113193 21.0 [543.3, 0.055578, -8301600.0, -1581.3] -HHPH_2013.fwd 4.321e-05 1.69e+11 4.35 -2.6e-11 0.2037731 7.0 [201.1, 0.01733, -1960600.0, -900.9] -HHPH_2013.gr 0.00012535 1.72e+11 5.53 -3.2e-11 0.4504463 20.0 [626.0, 0.0, -5779200.0, -4002.9] -HHPH_2013.hed 6.795e-05 1.192e+11 3.97 -3.3e-11 0.2480904 10.0 [340.2, 0.000812, -1047800.0, -2646.7] -HHPH_2013.hen 6.099e-05 1.5e+11 5.5 -3.6e-11 0.2007774 10.0 [356.2, -0.00299, -596900.0, -3185.3] -HHPH_2013.hfs 6.405e-05 1.5e+11 5.5 -3.6e-11 0.2638574 10.0 [398.7, -0.006579, 1290100.0, -4058.0] -HHPH_2013.jd 6.04e-05 1.281e+11 3.81 -3e-11 0.1740532 9.0 [319.4, 0.003616, -1173900.0, -2469.5] -HHPH_2013.macf 3.614e-05 2.12e+11 4.0 -1.7e-11 0.1422656 7.0 [200.0, 0.006252, -2996400.0, -888.4] -HHPH_2013.maj 0.00011457 1.6e+11 4.56 -2.8e-11 0.4015548 20.0 [713.6, -0.000997, -1158200.0, -6622.3] -HHPH_2013.mak 2.635e-05 2.11e+11 4.55 -2.2e-11 0.1003887 5.0 [147.8, 0.002015, -2395000.0, -801.8] -HHPH_2013.manal 0.00011166 1.84e+11 4.0 -2.2e-11 0.4267968 21.0 [600.0, 0.018756, -8989200.0, -2665.2] -HHPH_2013.mcor 2.635e-05 2.11e+11 4.55 -2.2e-11 0.1003887 5.0 [147.8, 0.002015, -2395000.0, -801.8] -HHPH_2013.mgts 6.05e-05 1.028e+11 8.55 -8.3e-11 0.2023499 10.0 [371.4, -0.004082, -398400.0, -3547.1] -HHPH_2013.mpv 2.445e-05 2.51e+11 4.14 -1.6e-11 0.1003887 5.0 [149.3, 0.002918, -2983000.0, -799.1] -HHPH_2013.mrw 3.949e-05 1.781e+11 4.35 -2.4e-11 0.1406931 7.0 [213.3, 0.00269, -1410400.0, -1495.9] -HHPH_2013.mscf 3.649e-05 1.85e+11 4.0 -1.7e-11 0.1406931 7.0 [213.3, 0.00269, -1410400.0, -1495.9] -HHPH_2013.msnal 0.00011061 1.85e+11 4.0 -2.2e-11 0.4220793 21.0 [639.9, 0.00807, -4231200.0, -4487.7] -HHPH_2013.mwd 4.051e-05 1.726e+11 3.84 -2.2e-11 0.1406931 7.0 [208.7, 0.003942, -1709500.0, -1302.8] -HHPH_2013.nacf 3.631e-05 1.85e+11 4.6 -2.5e-11 0.1740532 9.0 [272.7, -0.012398, 0.0, -2763.1] -HHPH_2013.nagt 0.0001109 1.7e+11 4.0 -2.3e-11 0.4029161 20.0 [620.8, 0.0112, -3755900.0, -4421.3] -HHPH_2013.nanal 0.00011322 1.84e+11 4.0 -2.2e-11 0.4265856 21.0 [672.7, 0.000106, -5992800.0, -4539.9] -HHPH_2013.npv 2.334e-05 2.03e+11 4.0 -2e-11 0.10106935 5.0 [135.0, 0.00846, -1850300.0, -600.8] -HHPH_2013.per 1.125e-05 1.616e+11 3.95 -2.4e-11 0.0403044 2.0 [60.5, 0.000362, -535800.0, -299.2] -HHPH_2013.py 0.00011313 1.743e+11 4.05 -2.3e-11 0.4031273 20.0 [633.5, 0.0, -5196100.0, -4315.2] -HHPH_2013.stv 1.401e-05 3.09e+11 4.6 -1.5e-11 0.0600843 3.0 [68.1, 0.00601, -1978200.0, -82.1] -Name (hp_tmt equation of state) V_0 K_0 Kprime_0 Kdprime_0 molar_mass n Cp -HP_2011_ds62.Cu 7.11e-06 1.625e+11 4.24 -2.6e-11 0.063546 1.0 [12.4, 0.00922, -379900.0, 233.5] -HP_2011_ds62.Ni 6.59e-06 1.905e+11 4.25 -2.2e-11 0.0586934 1.0 [49.8, 0.0, 585900.0, -533.9] -HP_2011_ds62.NiO 1.097e-05 2e+11 3.94 -2e-11 0.0746928 2.0 [47.7, 0.007824, -392500.0, 0.0] -HP_2011_ds62.S 1.551e-05 14500000000.0 7.0 -4.8e-10 0.032065 1.0 [56.6, -0.004557, 638000.0, -681.8] -HP_2011_ds62.ab 0.00010067 54100000000.0 5.91 -1.09e-10 0.262223 13.0 [452.0, -0.013364, -1275900.0, -3953.6] -HP_2011_ds62.abh 0.00010105 54100000000.0 5.91 -1.09e-10 0.262223 13.0 [452.0, -0.013364, -1275900.0, -3953.6] -HP_2011_ds62.acm 6.459e-05 1.06e+11 4.08 -3.8e-11 0.2310022 10.0 [307.1, 0.016758, -1685500.0, -2125.8] -HP_2011_ds62.afchl 0.0002157 87000000000.0 4.09 -4.7e-11 0.55422472 36.0 [1155.0, -0.000417, -4024400.0, -9952.9] -HP_2011_ds62.ak 9.254e-05 1.42e+11 4.06 -2.9e-11 0.2726278 12.0 [385.4, 0.003209, -247500.0, -2889.9] -HP_2011_ds62.alm 0.00011525 1.9e+11 2.98 -1.6e-11 0.4977473 20.0 [677.3, 0.0, -3772700.0, -5044.0] -HP_2011_ds62.ames 0.0002071 87000000000.0 4.09 -4.7e-11 0.55736972 36.0 [1186.0, -0.002599, -3627200.0, -10677.0] -HP_2011_ds62.amul 5.083e-05 1.74e+11 4.0 -2.3e-11 0.15749365 7.75 [244.8, 0.000968, -2533300.0, -1641.6] -HP_2011_ds62.an 0.00010079 86000000000.0 4.09 -4.8e-11 0.2782072 13.0 [370.5, 0.01001, -4339100.0, -1960.6] -HP_2011_ds62.andalusite 5.153e-05 1.442e+11 6.89 -4.8e-11 0.1620455 8.0 [277.3, -0.006588, -1914100.0, -2265.6] -HP_2011_ds62.andr 0.00013204 1.588e+11 5.68 -3.6e-11 0.5081733 20.0 [638.6, 0.0, -4955100.0, -3989.2] -HP_2011_ds62.ank 6.606e-05 91400000000.0 3.88 -4.3e-11 0.2159408 10.0 [341.0, -0.001161, 0.0, -3054.8] -HP_2011_ds62.anl 9.74e-05 40000000000.0 4.18 -1.04e-10 0.22015398 13.0 [643.5, -0.016067, 9302300.0, -9179.6] -HP_2011_ds62.ann 0.00015432 51300000000.0 7.33 -1.43e-10 0.51187998 22.0 [815.7, -0.034861, 19800.0, -7466.7] -HP_2011_ds62.anth 0.0002654 70000000000.0 4.11 -5.9e-11 0.78082048 41.0 [1277.3, 0.025825, -9704600.0, -9074.7] -HP_2011_ds62.any 4.594e-05 54380000000.0 4.19 -7.7e-11 0.1361406 6.0 [128.7, 0.048545, -1223000.0, -560.5] -HP_2011_ds62.apv 2.54e-05 2.03e+11 4.0 -2e-11 0.1019612 5.0 [139.5, 0.00589, -2460600.0, -589.2] -HP_2011_ds62.arag 3.415e-05 61400000000.0 5.87 -9.6e-11 0.1000869 5.0 [167.1, 0.010695, 162000.0, -1564.9] -HP_2011_ds62.atg 0.0017548 63100000000.0 5.92 -9.4e-11 4.53595108 291.0 [9621.0, -0.091183, -35941600.0, -83034.2] -HP_2011_ds62.bdy 2.115e-05 95300000000.0 3.88 -4.1e-11 0.1232228 3.0 [103.5, -0.004547, -416200.0, -713.6] -HP_2011_ds62.bix 3.137e-05 2.23e+11 4.04 -1.8e-11 0.1578742 5.0 [145.1, 0.023534, 721600.0, -1008.4] -HP_2011_ds62.br 2.463e-05 41500000000.0 6.45 -1.55e-10 0.05831968 5.0 [158.4, -0.004076, -1052300.0, -1171.3] -HP_2011_ds62.caes 6.05e-05 1.192e+11 5.19 -4.4e-11 0.1991879 9.5 [362.0, -0.016944, -175900.0, -3565.7] -HP_2011_ds62.cats 6.356e-05 1.192e+11 5.19 -4.4e-11 0.2181229 10.0 [347.6, -0.006974, -1781600.0, -2757.5] -HP_2011_ds62.cc 3.689e-05 73300000000.0 4.06 -5.5e-11 0.1000869 5.0 [140.9, 0.005029, -950700.0, -858.4] -HP_2011_ds62.cel 0.00013957 70000000000.0 4.11 -5.9e-11 0.39673548 21.0 [741.2, -0.018748, -2368800.0, -6616.9] -HP_2011_ds62.cen 6.264e-05 1.059e+11 8.65 -8.2e-11 0.2007774 10.0 [306.0, -0.003793, -3041700.0, -1852.1] -HP_2011_ds62.cg 5.603e-05 46500000000.0 4.16 -8.9e-11 0.1420544 7.0 [116.1, 0.086021, -1992700.0, 0.0] -HP_2011_ds62.cgh 5.67e-05 46500000000.0 4.16 -8.9e-11 0.1420544 7.0 [229.2, 0.011876, 0.0, -1970.7] -HP_2011_ds62.chdr 0.00011084 1.161e+11 4.8 -4.1e-11 0.33970588 19.0 [625.0, -0.001088, -2259900.0, -4910.7] -HP_2011_ds62.chr 0.00010746 62800000000.0 4.0 -6.4e-11 0.27711236 18.0 [624.7, -0.02077, -1721800.0, -5619.4] -HP_2011_ds62.chum 0.00019801 1.199e+11 4.58 -3.8e-11 0.62109208 33.0 [1071.0, -0.016533, -7899600.0, -7373.9] -HP_2011_ds62.clin 0.0002114 87000000000.0 4.09 -4.7e-11 0.55579722 36.0 [1170.8, -0.001508, -3825800.0, -10315.0] -HP_2011_ds62.coe 2.064e-05 97900000000.0 4.19 -4.3e-11 0.0600843 3.0 [107.8, -0.003279, -190300.0, -1041.6] -HP_2011_ds62.cor 2.558e-05 2.54e+11 4.34 -1.7e-11 0.1019612 5.0 [139.5, 0.00589, -2460600.0, -589.2] -HP_2011_ds62.cpv 2.745e-05 2.36e+11 3.9 -1.6e-11 0.1161617 5.0 [159.3, 0.0, -967300.0, -1075.4] -HP_2011_ds62.crd 0.00023322 1.29e+11 4.1 -3.1e-11 0.5849527 29.0 [906.1, 0.0, -7902000.0, -6293.4] -HP_2011_ds62.crst 2.745e-05 16000000000.0 4.35 -2.72e-10 0.0600843 3.0 [72.7, 0.001304, -4129000.0, 0.0] -HP_2011_ds62.cstn 4.818e-05 1.782e+11 4.0 -2.2e-11 0.176246 8.0 [205.6, 0.006034, -5517700.0, -352.6] -HP_2011_ds62.cumm 0.0002633 70000000000.0 4.11 -5.9e-11 0.78082048 41.0 [1277.3, 0.025825, -9704600.0, -9074.7] -HP_2011_ds62.cup 2.344e-05 1.31e+11 5.7 -4.3e-11 0.1430914 3.0 [110.3, 0.0, 0.0, -674.8] -HP_2011_ds62.cz 0.0001363 1.197e+11 4.07 -3.4e-11 0.45435714 22.0 [630.9, 0.013693, -6645800.0, -3731.1] -HP_2011_ds62.daph 0.0002162 87000000000.0 4.09 -4.7e-11 0.71349722 36.0 [1192.0, -0.00594, -4826400.0, -9768.3] -HP_2011_ds62.deer 0.0005574 63000000000.0 4.12 -6.5e-11 2.1522854 90.0 [3164.4, -0.027883, -5039100.0, -26721.0] -HP_2011_ds62.di 6.619e-05 1.192e+11 5.19 -4.4e-11 0.2165504 10.0 [314.5, 4.1e-05, -2745900.0, -2020.1] -HP_2011_ds62.diam 3.42e-06 4.465e+11 1.61 -3.6e-12 0.0120107 1.0 [40.0, 0.0, -28500.0, -580.5] -HP_2011_ds62.dol 6.429e-05 94300000000.0 3.74 -4e-11 0.1844008 10.0 [358.9, -0.004905, 0.0, -3456.2] -HP_2011_ds62.dsp 1.786e-05 2.28e+11 4.04 -1.8e-11 0.05998824 4.0 [145.1, 0.008709, 584400.0, -1741.1] -HP_2011_ds62.east 0.00014738 53000000000.0 7.33 -1.43e-10 0.41883248 22.0 [785.5, -0.038031, -2130300.0, -6893.7] -HP_2011_ds62.en 6.262e-05 1.059e+11 8.65 -8.2e-11 0.2007774 10.0 [356.2, -0.00299, -596900.0, -3185.3] -HP_2011_ds62.ep 0.0001392 1.34e+11 4.0 -3e-11 0.48322064 22.0 [613.3, 0.02207, -7160000.0, -2987.7] -HP_2011_ds62.esk 2.909e-05 2.38e+11 4.0 -1.7e-11 0.1519904 5.0 [119.0, 0.009496, -1442000.0, -3.4] -HP_2011_ds62.fa 4.631e-05 1.256e+11 4.68 -3.7e-11 0.2037731 7.0 [201.1, 0.01733, -1960600.0, -900.9] -HP_2011_ds62.fact 0.0002842 76000000000.0 4.1 -5.4e-11 0.97006648 41.0 [1290.0, 0.029992, -8447500.0, -8947.0] -HP_2011_ds62.fak 2.76e-05 2.18e+11 4.55 -2.2e-11 0.1319287 5.0 [100.3, 0.013328, -4364900.0, 419.8] -HP_2011_ds62.fanth 0.0002787 70000000000.0 4.11 -5.9e-11 1.00160048 41.0 [1383.1, 0.030669, -4224700.0, -11257.6] -HP_2011_ds62.fcar 0.00010695 52500000000.0 4.14 -7.9e-11 0.33000476 19.0 [686.6, -0.012415, 186000.0, -6884.0] -HP_2011_ds62.fcel 0.0001407 70000000000.0 4.11 -5.9e-11 0.42827548 21.0 [756.3, -0.019147, -1586100.0, -6928.7] -HP_2011_ds62.fcrd 0.0002371 1.29e+11 4.1 -3.1e-11 0.6480327 29.0 [924.0, 0.0, -7039400.0, -6439.6] -HP_2011_ds62.fctd 6.98e-05 1.456e+11 4.06 -2.8e-11 0.25190518 13.0 [416.1, -0.003477, -2835900.0, -3360.3] -HP_2011_ds62.fep 0.0001421 1.513e+11 4.0 -2.6e-11 0.51208414 22.0 [584.7, 0.030447, -7674200.0, -2244.3] -HP_2011_ds62.fgl 0.0002659 89000000000.0 4.09 -4.6e-11 0.87816308 41.0 [1762.9, -0.118992, 9423700.0, -20207.1] -HP_2011_ds62.fo 4.366e-05 1.285e+11 3.84 -3e-11 0.1406931 7.0 [233.3, 0.001494, -603800.0, -1869.7] -HP_2011_ds62.fper 1.206e-05 1.52e+11 4.9 -3.2e-11 0.0718444 2.0 [44.4, 0.00828, -1214200.0, 185.2] -HP_2011_ds62.fpm 0.0002968 1.615e+11 4.05 -2.5e-11 0.97461628 51.0 [1737.2, -0.024582, -5161100.0, -14963.0] -HP_2011_ds62.fpre 0.000148 1.093e+11 4.01 -3.7e-11 0.44124768 21.0 [737.1, -0.01681, -1957300.0, -6358.1] -HP_2011_ds62.fpv 2.548e-05 2.81e+11 4.14 -1.6e-11 0.1319287 5.0 [133.2, 0.01083, -3661400.0, -314.7] -HP_2011_ds62.frw 4.203e-05 1.977e+11 4.92 -2.5e-11 0.2037731 7.0 [166.8, 0.04261, -1705400.0, -541.4] -HP_2011_ds62.fs 6.592e-05 1.01e+11 4.08 -4e-11 0.2638574 10.0 [398.7, -0.006579, 1290100.0, -4058.0] -HP_2011_ds62.fspr 0.00019923 2.5e+11 4.04 -1.7e-11 0.815391 34.0 [1132.9, -0.007348, -10420200.0, -7036.6] -HP_2011_ds62.fst 0.0004488 1.8e+11 4.76 -2.6e-11 1.69169121 81.5 [2880.0, -0.056595, -10642000.0, -25373.0] -HP_2011_ds62.fstp 0.00037239 51300000000.0 7.33 -1.43e-10 1.0780021 58.5 [1944.3, -0.012289, -4840200.0, -16635.0] -HP_2011_ds62.fsud 0.000204 87000000000.0 4.09 -4.7e-11 0.59992522 35.0 [1466.3, -0.047365, -1182800.0, -14388.0] -HP_2011_ds62.fta 0.00014225 43000000000.0 6.17 -1.44e-10 0.47388568 21.0 [579.7, 0.039494, -6459300.0, -3088.1] -HP_2011_ds62.fwd 4.321e-05 1.69e+11 4.35 -2.6e-11 0.2037731 7.0 [201.1, 0.01733, -1960600.0, -900.9] -HP_2011_ds62.ged 0.00025548 77000000000.0 4.1 -5.3e-11 0.78396548 41.0 [1307.7, 0.023642, -9307400.0, -9799.0] -HP_2011_ds62.geh 9.024e-05 1.08e+11 4.08 -3.8e-11 0.2742003 12.0 [405.7, -0.007099, -1188300.0, -3174.4] -HP_2011_ds62.geik 3.086e-05 1.7e+11 8.3 -4.9e-11 0.1201702 5.0 [151.0, 0.0, -1890400.0, -652.2] -HP_2011_ds62.gl 0.0002598 88300000000.0 4.09 -4.6e-11 0.78354308 41.0 [1717.5, -0.12107, 7075000.0, -19272.0] -HP_2011_ds62.glt 0.0001198 63000000000.0 4.0 -6.3e-11 0.37173236 18.0 [576.4, 0.002984, -3757000.0, -4166.2] -HP_2011_ds62.gph 5.3e-06 31200000000.0 3.9 -1.25e-10 0.0120107 1.0 [34.3, 0.0, -240700.0, -403.8] -HP_2011_ds62.gr 0.00012535 1.72e+11 5.53 -3.2e-11 0.4504463 20.0 [626.0, 0.0, -5779200.0, -4002.9] -HP_2011_ds62.grun 0.0002784 64800000000.0 4.12 -6.4e-11 1.00160048 41.0 [1383.1, 0.030669, -4224700.0, -11257.6] -HP_2011_ds62.gth 2.082e-05 2.5e+11 4.03 -1.6e-11 0.08885174 4.0 [139.3, 0.000147, -212700.0, -1077.8] -HP_2011_ds62.hcrd 0.00023322 1.29e+11 4.1 -3.1e-11 0.60296798 32.0 [955.3, 0.0, -8352600.0, -6301.2] -HP_2011_ds62.hed 6.795e-05 1.192e+11 3.97 -3.3e-11 0.2480904 10.0 [340.2, 0.000812, -1047800.0, -2646.7] -HP_2011_ds62.hem 3.027e-05 2.23e+11 4.04 -1.8e-11 0.1596882 5.0 [163.9, 0.0, -2257200.0, -657.6] -HP_2011_ds62.hen 6.099e-05 1.5e+11 5.5 -3.6e-11 0.2007774 10.0 [356.2, -0.00299, -596900.0, -3185.3] -HP_2011_ds62.herc 4.075e-05 1.922e+11 4.04 -2.1e-11 0.1738056 7.0 [216.7, 0.005868, -2430200.0, -1178.3] -HP_2011_ds62.heu 0.000317 27400000000.0 4.0 -1.46e-10 0.68672038 46.0 [1504.8, -0.033224, -2959300.0, -13297.2] -HP_2011_ds62.hlt 2.702e-05 23800000000.0 5.0 -2.1e-10 0.0584428 2.0 [45.2, 0.01797, 0.0, 0.0] -HP_2011_ds62.hol 7.128e-05 1.8e+11 4.0 -2.2e-11 0.2783315 13.0 [417.6, -0.003617, -4748100.0, -2819.9] -HP_2011_ds62.ilm 3.169e-05 1.7e+11 8.3 -4.9e-11 0.1517102 5.0 [138.9, 0.005081, -1288800.0, -463.7] -HP_2011_ds62.iron 7.09e-06 1.64e+11 5.16 -3.1e-11 0.055845 1.0 [46.2, 0.005159, 723100.0, -556.2] -HP_2011_ds62.jd 6.04e-05 1.281e+11 3.81 -3e-11 0.2021387 10.0 [319.4, 0.003616, -1173900.0, -2469.5] -HP_2011_ds62.jgd 0.0003108 1.615e+11 4.05 -2.5e-11 1.11893378 51.0 [1795.4, -0.037986, -4455700.0, -14888.0] -HP_2011_ds62.kao 9.934e-05 64500000000.0 4.12 -6.4e-11 0.25816036 17.0 [436.7, -0.034295, -4055900.0, -2699.1] -HP_2011_ds62.kcm 0.00011438 42500000000.0 2.0 -4.7e-11 0.29634678 16.0 [536.5, -0.01009, -980400.0, -4735.0] -HP_2011_ds62.kls 6.052e-05 51400000000.0 2.0 -3.9e-11 0.1581629 7.0 [242.0, -0.004482, -895800.0, -1935.8] -HP_2011_ds62.knor 0.00011738 1.743e+11 4.05 -2.3e-11 0.4531565 20.0 [613.0, 0.003606, -4178000.0, -3729.4] -HP_2011_ds62.kos 6.309e-05 1.308e+11 3.0 -2.3e-11 0.2271533 10.0 [309.2, 0.005419, -664600.0, -2176.6] -HP_2011_ds62.ky 4.414e-05 1.601e+11 4.05 -2.5e-11 0.1620455 8.0 [279.4, -0.007124, -2055600.0, -2289.4] -HP_2011_ds62.law 0.00010132 1.229e+11 5.45 -4.4e-11 0.31423776 19.0 [687.8, 0.001566, 375900.0, -7179.2] -HP_2011_ds62.lc 8.826e-05 45000000000.0 5.7 -1.27e-10 0.2182472 10.0 [369.8, -0.016332, 684700.0, -3683.1] -HP_2011_ds62.lime 1.676e-05 1.13e+11 3.87 -3.4e-11 0.0560774 2.0 [52.4, 0.003673, -750700.0, -51.0] -HP_2011_ds62.liz 0.00010645 71000000000.0 3.2 -4.5e-11 0.27711236 18.0 [614.7, -0.02077, -1721800.0, -5619.4] -HP_2011_ds62.lmt 0.0002037 86000000000.0 4.09 -4.8e-11 0.47043692 31.0 [1013.4, -0.021413, -2235800.0, -8806.7] -HP_2011_ds62.lot 1.818e-05 65800000000.0 4.17 -6.3e-11 0.08791 2.0 [50.2, 0.011052, -940000.0, 0.0] -HP_2011_ds62.lrn 5.16e-05 98500000000.0 4.07 -4.1e-11 0.1722391 7.0 [247.5, -0.003206, 0.0, -2051.9] -HP_2011_ds62.ma 0.00012964 1e+11 4.08 -4.1e-11 0.39818368 21.0 [744.4, -0.0168, -2074400.0, -6783.2] -HP_2011_ds62.mag 2.803e-05 1.028e+11 5.41 -5.3e-11 0.0843139 5.0 [186.4, -0.003772, 0.0, -1886.2] -HP_2011_ds62.maj 0.00011457 1.6e+11 4.56 -2.8e-11 0.4015548 20.0 [713.6, -0.000997, -1158200.0, -6622.3] -HP_2011_ds62.mak 2.635e-05 2.11e+11 4.55 -2.2e-11 0.1003887 5.0 [147.8, 0.002015, -2395000.0, -801.8] -HP_2011_ds62.mang 1.322e-05 1.645e+11 4.46 -2.7e-11 0.0709374 2.0 [59.8, 0.0036, -31400.0, -282.6] -HP_2011_ds62.mcar 0.0001059 52500000000.0 4.14 -7.9e-11 0.29846476 19.0 [683.0, -0.014054, 291000.0, -6976.4] -HP_2011_ds62.mcor 2.635e-05 2.11e+11 4.55 -2.2e-11 0.1003887 5.0 [147.8, 0.002015, -2395000.0, -801.8] -HP_2011_ds62.mctd 6.875e-05 1.456e+11 4.06 -2.8e-11 0.22036518 13.0 [417.4, -0.003771, -2920600.0, -3417.8] -HP_2011_ds62.me 0.00033985 87000000000.0 4.09 -4.7e-11 0.9347085 44.0 [1359.0, 0.036442, -8594700.0, -9598.2] -HP_2011_ds62.merw 9.847e-05 1.2e+11 4.07 -3.4e-11 0.3287052 14.0 [417.5, 0.008117, -2923000.0, -2320.3] -HP_2011_ds62.mft 4.457e-05 1.857e+11 4.05 -2.2e-11 0.1999926 7.0 [270.5, -0.007505, -999200.0, -2022.4] -HP_2011_ds62.mgts 6.05e-05 1.028e+11 8.55 -8.3e-11 0.2023499 10.0 [371.4, -0.004082, -398400.0, -3547.1] -HP_2011_ds62.mic 0.00010871 58300000000.0 4.02 -6.9e-11 0.2783315 13.0 [448.8, -0.010075, -1007300.0, -3973.1] -HP_2011_ds62.minm 0.00014291 43000000000.0 6.17 -1.44e-10 0.37926568 21.0 [622.2, 0.0, -6385500.0, -3916.3] -HP_2011_ds62.minn 0.00014851 43000000000.0 6.17 -1.44e-10 0.47388568 21.0 [579.7, 0.039494, -6459300.0, -3088.1] -HP_2011_ds62.mnbi 0.00015264 53000000000.0 7.33 -1.43e-10 0.50915898 22.0 [809.9, -0.059213, -1514400.0, -6998.7] -HP_2011_ds62.mnchl 0.0002259 87000000000.0 4.09 -4.7e-11 0.70896222 36.0 [1136.5, -0.005243, -5548100.0, -8911.5] -HP_2011_ds62.mncrd 0.00024027 1.29e+11 4.1 -3.1e-11 0.6462187 29.0 [886.5, 0.0, -8840000.0, -5590.4] -HP_2011_ds62.mnctd 7.175e-05 1.456e+11 4.06 -2.8e-11 0.25099818 13.0 [464.4, -0.012654, -1147200.0, -4341.0] -HP_2011_ds62.mnst 0.0004546 1.8e+11 4.76 -2.6e-11 1.68806321 81.5 [2873.3, -0.089064, -12688000.0, -24749.0] -HP_2011_ds62.mont 5.148e-05 1.134e+11 3.87 -3.4e-11 0.1564661 7.0 [250.7, -0.010433, -797200.0, -1996.1] -HP_2011_ds62.mpm 0.0002955 1.615e+11 4.05 -2.5e-11 0.94307628 51.0 [1720.8, -0.024928, -5998700.0, -14620.3] -HP_2011_ds62.mpv 2.445e-05 2.51e+11 4.14 -1.6e-11 0.1003887 5.0 [149.3, 0.002918, -2983000.0, -799.1] -HP_2011_ds62.mrw 3.949e-05 1.781e+11 4.35 -2.4e-11 0.1406931 7.0 [213.3, 0.00269, -1410400.0, -1495.9] -HP_2011_ds62.mst 0.0004426 1.684e+11 4.05 -2.4e-11 1.56553121 81.5 [2820.5, -0.059366, -13774000.0, -24126.0] -HP_2011_ds62.mstp 0.00036577 51300000000.0 7.33 -1.43e-10 0.9203021 58.5 [1862.2, -0.014018, -8983100.0, -14923.0] -HP_2011_ds62.mt 4.452e-05 1.857e+11 4.05 -2.2e-11 0.2315326 7.0 [262.5, -0.007205, -1926200.0, -1655.7] -HP_2011_ds62.mu 0.00014083 49000000000.0 4.15 -8.5e-11 0.39830798 21.0 [756.4, -0.01984, -2170000.0, -6979.2] -HP_2011_ds62.mwd 4.051e-05 1.726e+11 3.84 -2.2e-11 0.1406931 7.0 [208.7, 0.003942, -1709500.0, -1302.8] -HP_2011_ds62.naph 0.0001445 51300000000.0 7.33 -1.43e-10 0.40115148 22.0 [773.5, -0.040229, -2597900.0, -6512.6] -HP_2011_ds62.ne 5.419e-05 46500000000.0 4.16 -8.9e-11 0.1420544 7.0 [272.7, -0.012398, 0.0, -2763.1] -HP_2011_ds62.osfa 0.0003845 1.29e+11 4.1 -3.1e-11 1.0465328 48.0 [1558.6, -0.011359, -9476500.0, -11845.0] -HP_2011_ds62.osma 0.00037893 1.29e+11 4.1 -3.1e-11 0.9834528 48.0 [1540.7, -0.011359, -10339000.0, -11699.0] -HP_2011_ds62.osmm 0.0003844 1.29e+11 4.1 -3.1e-11 0.9818803 48.0 [1525.5, -0.010267, -10538000.0, -11337.0] -HP_2011_ds62.pa 0.00013211 51500000000.0 6.51 -1.26e-10 0.38219948 21.0 [803.0, -0.03158, 217000.0, -8151.0] -HP_2011_ds62.parg 0.0002719 91200000000.0 4.09 -4.5e-11 0.83582478 42.0 [1280.2, 0.022997, -12359500.0, -8065.8] -HP_2011_ds62.per 1.125e-05 1.616e+11 3.95 -2.4e-11 0.0403044 2.0 [60.5, 0.000362, -535800.0, -299.2] -HP_2011_ds62.phA 0.00015422 1.45e+11 4.06 -2.8e-11 0.45634524 29.0 [962.0, -0.011521, -4517800.0, -7724.7] -HP_2011_ds62.phl 0.00014964 51300000000.0 7.33 -1.43e-10 0.41725998 22.0 [770.3, -0.036939, -2328900.0, -6531.6] -HP_2011_ds62.picr 4.356e-05 1.922e+11 4.04 -2.1e-11 0.1922948 7.0 [196.1, 0.005398, -3126000.0, -616.9] -HP_2011_ds62.pmt 0.0001382 1.197e+11 4.07 -3.4e-11 0.48231364 22.0 [569.8, 0.02779, -5442900.0, -2812.6] -HP_2011_ds62.pnt 3.288e-05 1.7e+11 8.3 -4.9e-11 0.1508032 5.0 [143.5, 0.003373, -1940700.0, -407.6] -HP_2011_ds62.pre 0.00014026 1.093e+11 4.01 -3.7e-11 0.41238418 21.0 [724.9, -0.013865, -2059000.0, -6323.9] -HP_2011_ds62.pren 6.476e-05 1.059e+11 8.65 -8.2e-11 0.2007774 10.0 [356.2, -0.00299, -596900.0, -3185.3] -HP_2011_ds62.prl 0.00012804 37000000000.0 10.0 -2.71e-10 0.36031368 20.0 [784.5, -0.042948, 1251000.0, -8495.9] -HP_2011_ds62.pswo 4.008e-05 1.1e+11 4.08 -3.7e-11 0.1161617 5.0 [157.8, 0.0, -967300.0, -1075.4] -HP_2011_ds62.pxmn 3.472e-05 84000000000.0 4.0 -4.8e-11 0.1310217 5.0 [138.4, 0.004088, -1936000.0, -538.9] -HP_2011_ds62.py 0.00011313 1.743e+11 4.05 -2.3e-11 0.4031273 20.0 [633.5, 0.0, -5196100.0, -4315.2] -HP_2011_ds62.pyr 2.394e-05 1.395e+11 4.09 -2.9e-11 0.119975 3.0 [37.3, 0.026715, -1817000.0, 649.3] -HP_2011_ds62.q 2.269e-05 73000000000.0 6.0 -8.2e-11 0.0600843 3.0 [92.9, -0.000642, -714900.0, -716.1] -HP_2011_ds62.rhc 3.107e-05 95300000000.0 3.88 -4.1e-11 0.1149469 5.0 [169.5, 0.0, 0.0, -1534.3] -HP_2011_ds62.rhod 3.494e-05 84000000000.0 4.0 -4.8e-11 0.1310217 5.0 [138.4, 0.004088, -1936000.0, -538.9] -HP_2011_ds62.rieb 0.0002749 89000000000.0 4.09 -4.6e-11 0.93589008 41.0 [1787.3, -0.124882, 9627100.0, -20275.5] -HP_2011_ds62.rnk 9.651e-05 95000000000.0 4.09 -4.3e-11 0.2884008 12.0 [372.3, -0.002893, -2462400.0, -2181.3] -HP_2011_ds62.ru 1.882e-05 2.22e+11 4.24 -1.9e-11 0.0798658 3.0 [90.4, 0.0029, 0.0, -623.8] -HP_2011_ds62.san 0.00010871 58300000000.0 4.02 -6.9e-11 0.2783315 13.0 [448.8, -0.010075, -1007300.0, -3973.1] -HP_2011_ds62.sdl 0.0004213 46500000000.0 4.16 -8.9e-11 0.969212 46.0 [1532.7, 0.047747, -2972800.0, -12427.0] -HP_2011_ds62.sid 2.943e-05 1.2e+11 4.07 -3.4e-11 0.1158539 5.0 [168.4, 0.0, 0.0, -1483.6] -HP_2011_ds62.sill 4.986e-05 1.64e+11 5.06 -3.1e-11 0.1620455 8.0 [280.2, -0.0069, -1375700.0, -2399.4] -HP_2011_ds62.smul 4.987e-05 1.74e+11 4.0 -2.3e-11 0.1620455 8.0 [280.2, -0.0069, -1375700.0, -2399.4] -HP_2011_ds62.sp 3.978e-05 1.922e+11 4.04 -2.1e-11 0.1422656 7.0 [222.9, 0.006127, -1686000.0, -1551.0] -HP_2011_ds62.sph 5.565e-05 1.017e+11 9.85 -9.7e-11 0.1960275 8.0 [227.9, 0.002924, -3539500.0, -894.3] -HP_2011_ds62.spr4 0.000199 2.5e+11 4.04 -1.6e-11 0.689231 34.0 [1133.1, -0.007596, -8816600.0, -8180.6] -HP_2011_ds62.spr5 0.0001975 2.5e+11 4.04 -1.6e-11 0.6908035 34.0 [1103.4, 0.001015, -10957000.0, -7409.2] -HP_2011_ds62.spss 0.00011792 1.74e+11 6.68 -3.8e-11 0.4950263 20.0 [646.9, 0.0, -4525800.0, -4452.8] -HP_2011_ds62.spu 0.00014697 95000000000.0 4.09 -4.3e-11 0.4445651 19.0 [614.1, -0.003508, -2493100.0, -4168.0] -HP_2011_ds62.stlb 0.0003287 86000000000.0 4.09 -4.8e-11 0.70473566 49.0 [1588.4, -0.032043, -3071600.0, -13966.9] -HP_2011_ds62.stv 1.401e-05 3.09e+11 4.6 -1.5e-11 0.0600843 3.0 [68.1, 0.00601, -1978200.0, -82.1] -HP_2011_ds62.sud 0.000203 87000000000.0 4.09 -4.7e-11 0.53684522 35.0 [1436.1, -0.048749, -2748500.0, -13764.0] -HP_2011_ds62.syv 3.752e-05 17000000000.0 5.0 -2.94e-10 0.0745513 2.0 [46.2, 0.01797, 0.0, 0.0] -HP_2011_ds62.ta 0.00013665 43000000000.0 6.17 -1.44e-10 0.37926568 21.0 [622.2, 0.0, -6385500.0, -3916.3] -HP_2011_ds62.tap 0.0001345 37000000000.0 10.0 -2.71e-10 0.36031368 20.0 [784.5, -0.042948, 1251000.0, -8495.9] -HP_2011_ds62.tats 0.0001351 43000000000.0 6.17 -1.44e-10 0.38083818 21.0 [549.5, 0.036324, -8606600.0, -2515.3] -HP_2011_ds62.ten 1.222e-05 2e+11 3.94 -2e-11 0.0795454 2.0 [31.0, 0.01374, -1258000.0, 369.3] -HP_2011_ds62.teph 4.899e-05 1.256e+11 4.68 -3.7e-11 0.2019591 7.0 [219.6, 0.0, -1292700.0, -1308.3] -HP_2011_ds62.tpz 5.339e-05 1.315e+11 4.06 -3.1e-11 0.18006078 11.0 [387.7, -0.00712, -857200.0, -3744.2] -HP_2011_ds62.tr 0.0002727 76200000000.0 4.1 -5.4e-11 0.81236648 41.0 [1260.2, 0.00383, -11455000.0, -8237.6] -HP_2011_ds62.trd 2.8e-05 15000000000.0 4.36 -2.91e-10 0.0600843 3.0 [74.9, 0.0031, -1174000.0, -236.7] -HP_2011_ds62.tro 1.819e-05 65800000000.0 4.17 -6.3e-11 0.08791 2.0 [50.2, 0.011052, -940000.0, 0.0] -HP_2011_ds62.trot 1.819e-05 65800000000.0 4.17 -6.3e-11 0.08791 2.0 [50.2, 0.011052, -940000.0, 0.0] -HP_2011_ds62.trov 1.738e-05 65800000000.0 4.17 -6.3e-11 0.080929375 1.875 [51.1, 0.008307, -669700.0, 0.0] -HP_2011_ds62.ts 0.000268 76000000000.0 4.1 -5.4e-11 0.81551148 41.0 [1244.8, 0.024348, -11965000.0, -8112.1] -HP_2011_ds62.ty 0.00017039 95000000000.0 4.09 -4.3e-11 0.4885746 22.0 [741.7, -0.005345, -1434600.0, -5878.5] -HP_2011_ds62.usp 4.682e-05 1.857e+11 4.05 -2.2e-11 0.2235546 7.0 [-102.6, 0.14252, -9144500.0, 5270.7] -HP_2011_ds62.vsv 0.000852 1.255e+11 4.8 -3.8e-11 2.86945216 137.0 [4488.0, -0.057952, -22269300.0, -33478.0] -HP_2011_ds62.wa 0.00010844 90000000000.0 4.0 -4.4e-11 0.3345332 15.0 [499.1, 0.0, 0.0, -4350.1] -HP_2011_ds62.wal 3.7633e-05 79500000000.0 4.1 -5.2e-11 0.1161617 5.0 [159.3, 0.0, -967300.0, -1075.4] -HP_2011_ds62.wo 3.993e-05 79500000000.0 4.1 -5.2e-11 0.1161617 5.0 [159.3, 0.0, -967300.0, -1075.4] -HP_2011_ds62.wrk 0.0001904 86000000000.0 4.09 -4.8e-11 0.43440636 25.0 [838.3, -0.02146, -2272000.0, -7292.3] -HP_2011_ds62.zo 0.00013575 1.044e+11 4.0 -3.8e-11 0.45435714 22.0 [662.0, 0.010416, -6006400.0, -4260.7] -HP_2011_ds62.zrc 3.926e-05 2.301e+11 4.04 -1.8e-11 0.1833071 6.0 [232.0, -0.014405, 0.0, -2238.2] +Name (dks_s equation of state) V_0 T_0 E_0 S_0 K_0 Kprime_0 Kdprime_0 n Cv grueneisen_0 q_0 +DKS_2013_solids.periclase 1.223e-05 2000.0 -1164949.141 119.8358648 109833574725.1749 4.625212697294325 -4.465840718846227e-11 2.0 49.04715075 1.412003694 0.6317609916 +DKS_2013_solids.perovskite 2.705e-05 3000.0 -3355012.7819999997 338.4574347 167066911316.49207 4.19294951056697 -2.4655198810018805e-11 2.0 133.8111589 1.893754815 1.48780973 +DKS_2013_solids.stishovite 1.513e-05 3000.0 -2274840.2139999997 166.8222552 181486727105.82358 5.292979646422778 -3.776400076562578e-11 2.0 77.94230433 1.389501259 1.33202555 +Name (hp_tmt equation of state) V_0 K_0 Kprime_0 Kdprime_0 molar_mass n Cp +HGP_2018_ds633.Cu 7.11e-06 162500000000.0 4.24 -2.6e-11 0.063546 1.0 [12.4, 0.00922, -379900.0, 233.5] +HGP_2018_ds633.Ni 6.59e-06 190500000000.0 4.25 -2.2e-11 0.0586934 1.0 [49.8, 0.0, 585900.0, -533.9] +HGP_2018_ds633.NiO 1.097e-05 200000000000.0 3.94 -2e-11 0.0746928 2.0 [47.7, 0.007824, -392500.0, 0.0] +HGP_2018_ds633.S 1.551e-05 14500000000.0 7.0 -4.8e-10 0.032065 1.0 [56.6, -0.004557, 638000.0, -681.8] +HGP_2018_ds633.ab 0.00010067 54100000000.0 5.91 -1.09e-10 0.262223 13.0 [452.0, -0.013364, -1275900.0, -3953.6] +HGP_2018_ds633.abh 0.00010105 54100000000.0 5.91 -1.09e-10 0.262223 13.0 [452.0, -0.013364, -1275900.0, -3953.6] +HGP_2018_ds633.acm 6.459e-05 106000000000.0 4.08 -3.8e-11 0.2310022 10.0 [307.1, 0.016758, -1685500.0, -2125.8] +HGP_2018_ds633.afchl 0.0002157 87000000000.0 4.09 -4.7e-11 0.55422472 36.0 [1155.0, -0.000417, -4024400.0, -9952.9] +HGP_2018_ds633.ak 9.254e-05 142000000000.0 4.06 -2.9e-11 0.2726278 12.0 [385.4, 0.003209, -247500.0, -2889.9] +HGP_2018_ds633.alm 0.00011525 190000000000.0 2.98 -1.6e-11 0.4977473 20.0 [716.2, -0.01241, -3160800.0, -5863.5] +HGP_2018_ds633.ames 0.0002071 87000000000.0 4.09 -4.7e-11 0.55736972 36.0 [1186.0, -0.002599, -3627200.0, -10677.0] +HGP_2018_ds633.amul 5.083e-05 174000000000.0 4.0 -2.3e-11 0.15749365 7.75 [244.8, 0.000968, -2533300.0, -1641.6] +HGP_2018_ds633.an 0.00010079 86000000000.0 4.09 -4.8e-11 0.2782072 13.0 [370.5, 0.01001, -4339100.0, -1960.6] +HGP_2018_ds633.andalusite 5.153e-05 144200000000.0 6.89 -4.8e-11 0.1620455 8.0 [277.3, -0.006588, -1914100.0, -2265.6] +HGP_2018_ds633.andr 0.00013204 158800000000.0 5.68 -3.6e-11 0.5081733 20.0 [638.6, 0.0, -4955100.0, -3989.2] +HGP_2018_ds633.ank 6.606e-05 91400000000.0 3.88 -4.3e-11 0.2159408 10.0 [341.0, -0.001161, 0.0, -3054.8] +HGP_2018_ds633.anl 9.74e-05 40000000000.0 4.18 -1.04e-10 0.22015398 13.0 [643.5, -0.016067, 9302300.0, -9179.6] +HGP_2018_ds633.ann 0.00015432 51300000000.0 7.33 -1.43e-10 0.51187998 22.0 [815.7, -0.034861, 19800.0, -7466.7] +HGP_2018_ds633.anth 0.0002654 70000000000.0 4.11 -5.9e-11 0.78082048 41.0 [1277.3, 0.025825, -9704600.0, -9074.7] +HGP_2018_ds633.any 4.594e-05 54379999999.99999 4.19 -7.7e-11 0.1361406 6.0 [128.7, 0.048545, -1223000.0, -560.5] +HGP_2018_ds633.apv 2.54e-05 203000000000.0 4.0 -2e-11 0.1019612 5.0 [139.5, 0.00589, -2460600.0, -589.2] +HGP_2018_ds633.arag 3.415e-05 61400000000.0 5.87 -9.6e-11 0.1000869 5.0 [167.1, 0.010695, 162000.0, -1564.9] +HGP_2018_ds633.atg 0.0017548 63100000000.0 5.92 -9.4e-11 4.53595108 291.0 [9621.0, -0.091183, -35941600.0, -83034.2] +HGP_2018_ds633.bdy 2.115e-05 95300000000.0 3.88 -4.1e-11 0.1232228 3.0 [89.6, 0.000354, -853100.0, -413.7] +HGP_2018_ds633.bdyC 2.495e-05 95300000000.0 3.88 -4.1e-11 0.1232228 3.0 [89.6, 0.000354, -853100.0, -413.7] +HGP_2018_ds633.bdyT 2.115e-05 95300000000.0 3.88 -4.1e-11 0.1232228 3.0 [89.6, 0.000354, -853100.0, -413.7] +HGP_2018_ds633.bix 3.137e-05 223000000000.0 4.04 -1.8e-11 0.1578742 5.0 [145.1, 0.023534, 721600.0, -1008.4] +HGP_2018_ds633.br 2.463e-05 41500000000.0 6.45 -1.55e-10 0.05831968 5.0 [158.4, -0.004076, -1052300.0, -1171.3] +HGP_2018_ds633.cacf 3.976e-05 190000000000.0 4.0 -2.1e-11 0.1580386 7.0 [191.9, 0.009563, -3211300.0, -640.2] +HGP_2018_ds633.caes 6.05e-05 119200000000.0 5.19 -4.4e-11 0.1991879 9.5 [362.0, -0.016944, -175900.0, -3565.7] +HGP_2018_ds633.canal 0.00011159 177000000000.0 4.0 -2.2e-11 0.4425698 21.0 [591.9, 0.022067, -9204100.0, -2417.0] +HGP_2018_ds633.cats 6.356e-05 119200000000.0 5.19 -4.4e-11 0.2181229 10.0 [347.6, -0.006974, -1781600.0, -2757.5] +HGP_2018_ds633.cc 3.689e-05 73300000000.0 4.06 -5.5e-11 0.1000869 5.0 [140.9, 0.005029, -950700.0, -858.4] +HGP_2018_ds633.cel 0.00013957 70000000000.0 4.11 -5.9e-11 0.39673548 21.0 [741.2, -0.018748, -2368800.0, -6616.9] +HGP_2018_ds633.cen 6.264e-05 105900000000.0 8.65 -8.2e-11 0.2007774 10.0 [306.0, -0.003793, -3041700.0, -1852.1] +HGP_2018_ds633.cg 5.603e-05 46500000000.0 4.16 -8.9e-11 0.1420544 7.0 [116.1, 0.086021, -1992700.0, 0.0] +HGP_2018_ds633.cgh 5.67e-05 46500000000.0 4.16 -8.9e-11 0.1420544 7.0 [229.2, 0.011876, 0.0, -1970.7] +HGP_2018_ds633.chdr 0.00011084 116100000000.0 4.8 -4.1e-11 0.33970588 19.0 [625.0, -0.001088, -2259900.0, -4910.7] +HGP_2018_ds633.chr 0.00010746 62800000000.0 4.0 -6.4e-11 0.27711236 18.0 [624.7, -0.02077, -1721800.0, -5619.4] +HGP_2018_ds633.chum 0.00019801 119900000000.0 4.58 -3.8e-11 0.62109208 33.0 [1071.0, -0.016533, -7899600.0, -7373.9] +HGP_2018_ds633.clin 0.0002114 87000000000.0 4.09 -4.7e-11 0.55579722 36.0 [1170.8, -0.001508, -3825800.0, -10315.0] +HGP_2018_ds633.coe 2.064e-05 97900000000.0 4.19 -4.3e-11 0.0600843 3.0 [107.8, -0.003279, -190300.0, -1041.6] +HGP_2018_ds633.cor 2.558e-05 254000000000.0 4.34 -1.7e-11 0.1019612 5.0 [139.5, 0.00589, -2460600.0, -589.2] +HGP_2018_ds633.cpv 2.745e-05 236000000000.0 3.9 -1.6e-11 0.1161617 5.0 [159.3, 0.0, -967300.0, -1075.4] +HGP_2018_ds633.crd 0.00023322 129000000000.0 4.1 -3.1e-11 0.5849527 29.0 [906.1, 0.0, -7902000.0, -6293.4] +HGP_2018_ds633.crst 2.745e-05 16000000000.0 4.35 -2.72e-10 0.0600843 3.0 [72.7, 0.001304, -4129000.0, 0.0] +HGP_2018_ds633.cstn 4.818e-05 178200000000.0 4.0 -2.2e-11 0.176246 8.0 [205.6, 0.006034, -5517700.0, -352.6] +HGP_2018_ds633.cumm 0.0002633 70000000000.0 4.11 -5.9e-11 0.78082048 41.0 [1277.3, 0.025825, -9704600.0, -9074.7] +HGP_2018_ds633.cup 2.344e-05 131000000000.0 5.7 -4.3e-11 0.1430914 3.0 [110.3, 0.0, 0.0, -674.8] +HGP_2018_ds633.cz 0.0001363 119700000000.0 4.07 -3.4e-11 0.45435714 22.0 [630.9, 0.013693, -6645800.0, -3731.1] +HGP_2018_ds633.daph 0.0002162 87000000000.0 4.09 -4.7e-11 0.71349722 36.0 [1192.0, -0.00594, -4826400.0, -9768.3] +HGP_2018_ds633.deer 0.0005574 63000000000.0 4.12 -6.5e-11 2.1522854 90.0 [3164.4, -0.027883, -5039100.0, -26721.0] +HGP_2018_ds633.di 6.619e-05 119200000000.0 5.19 -4.4e-11 0.2165504 10.0 [314.5, 4.1e-05, -2745900.0, -2020.1] +HGP_2018_ds633.diam 3.42e-06 446500000000.0 1.61 -3.6e-12 0.0120107 1.0 [40.0, 0.0, -28500.0, -580.5] +HGP_2018_ds633.dol 6.429e-05 94300000000.0 3.74 -4e-11 0.1844008 10.0 [358.9, -0.004905, 0.0, -3456.2] +HGP_2018_ds633.dsp 1.786e-05 228000000000.0 4.04 -1.8e-11 0.05998824 4.0 [145.1, 0.008709, 584400.0, -1741.1] +HGP_2018_ds633.east 0.00014738 53000000000.0 7.33 -1.43e-10 0.41883248 22.0 [785.5, -0.038031, -2130300.0, -6893.7] +HGP_2018_ds633.en 6.262e-05 105900000000.0 8.65 -8.2e-11 0.2007774 10.0 [356.2, -0.00299, -596900.0, -3185.3] +HGP_2018_ds633.ep 0.0001392 134000000000.0 4.0 -3e-11 0.48322064 22.0 [613.3, 0.02207, -7160000.0, -2987.7] +HGP_2018_ds633.esk 2.898e-05 245000000000.0 3.6 -1.5e-11 0.1519904 5.0 [119.0, 0.009496, -1442000.0, -3.4] +HGP_2018_ds633.fa 4.631e-05 125600000000.0 4.68 -3.7e-11 0.2037731 7.0 [201.1, 0.01733, -1960600.0, -900.9] +HGP_2018_ds633.fact 0.0002842 76000000000.0 4.1 -5.4e-11 0.97006648 41.0 [1290.0, 0.029992, -8447500.0, -8947.0] +HGP_2018_ds633.fak 2.76e-05 218000000000.0 4.55 -2.2e-11 0.1319287 5.0 [100.3, 0.013328, -4364900.0, 419.8] +HGP_2018_ds633.fanth 0.0002787 70000000000.0 4.11 -5.9e-11 1.00160048 41.0 [1383.1, 0.030669, -4224700.0, -11257.6] +HGP_2018_ds633.fcar 0.00010695 52500000000.0 4.14 -7.9e-11 0.33000476 19.0 [686.6, -0.012415, 186000.0, -6884.0] +HGP_2018_ds633.fcel 0.0001407 70000000000.0 4.11 -5.9e-11 0.42827548 21.0 [756.3, -0.019147, -1586100.0, -6928.7] +HGP_2018_ds633.fcrd 0.0002371 129000000000.0 4.1 -3.1e-11 0.6480327 29.0 [924.0, 0.0, -7039400.0, -6439.6] +HGP_2018_ds633.fctd 6.98e-05 145600000000.0 4.06 -2.8e-11 0.25190518 13.0 [416.1, -0.003477, -2835900.0, -3360.3] +HGP_2018_ds633.fep 0.0001421 151300000000.0 4.0 -2.6e-11 0.51208414 22.0 [584.7, 0.030447, -7674200.0, -2244.3] +HGP_2018_ds633.fgl 0.0002659 89000000000.0 4.09 -4.6e-11 0.87816308 41.0 [1762.9, -0.118992, 9423700.0, -20207.1] +HGP_2018_ds633.fo 4.366e-05 128500000000.0 3.84 -3e-11 0.1406931 7.0 [233.3, 0.001494, -603800.0, -1869.7] +HGP_2018_ds633.fper 1.206e-05 152000000000.0 4.9 -3.2e-11 0.0718444 2.0 [44.4, 0.00828, -1214200.0, 185.2] +HGP_2018_ds633.fpm 0.0002968 161500000000.0 4.05 -2.5e-11 0.97461628 51.0 [1737.2, -0.024582, -5161100.0, -14963.0] +HGP_2018_ds633.fpre 0.000148 109300000000.0 4.01 -3.7e-11 0.44124768 21.0 [737.1, -0.01681, -1957300.0, -6358.1] +HGP_2018_ds633.fpv 2.534e-05 281000000000.0 4.14 -1.6e-11 0.1319287 5.0 [133.2, 0.01083, -3661400.0, -314.7] +HGP_2018_ds633.frw 4.203e-05 197700000000.0 4.92 -2.5e-11 0.2037731 7.0 [166.8, 0.04261, -1705400.0, -541.4] +HGP_2018_ds633.fs 6.592e-05 101000000000.0 4.08 -4e-11 0.2638574 10.0 [398.7, -0.006579, 1290100.0, -4058.0] +HGP_2018_ds633.fscf 3.914e-05 185000000000.0 4.0 -1.7e-11 0.2037731 7.0 [181.1, 0.018526, -2767200.0, -527.1] +HGP_2018_ds633.fsnal 0.00011856 185000000000.0 4.0 -2.2e-11 0.6113193 21.0 [543.3, 0.055578, -8301600.0, -1581.3] +HGP_2018_ds633.fspr 0.00019923 250000000000.0 4.04 -1.7e-11 0.815391 34.0 [1132.9, -0.007348, -10420200.0, -7036.6] +HGP_2018_ds633.fst 0.0004488 180000000000.0 4.76 -2.6e-11 1.69169121 81.5 [2880.0, -0.056595, -10642000.0, -25373.0] +HGP_2018_ds633.fstp 0.00037239 51300000000.0 7.33 -1.43e-10 1.0780021 58.5 [1944.3, -0.012289, -4840200.0, -16635.0] +HGP_2018_ds633.fsud 0.000204 87000000000.0 4.09 -4.7e-11 0.59992522 35.0 [1466.3, -0.047365, -1182800.0, -14388.0] +HGP_2018_ds633.fta 0.00014225 43000000000.0 6.17 -1.44e-10 0.47388568 21.0 [579.7, 0.039494, -6459300.0, -3088.1] +HGP_2018_ds633.fwd 4.321e-05 169000000000.0 4.35 -2.6e-11 0.2037731 7.0 [201.1, 0.01733, -1960600.0, -900.9] +HGP_2018_ds633.ged 0.00025956 70000000000.0 4.11 -5.9e-11 0.78396548 41.0 [1307.7, 0.023642, -9307400.0, -9799.0] +HGP_2018_ds633.geh 9.024e-05 108000000000.0 4.08 -3.8e-11 0.2742003 12.0 [405.7, -0.007099, -1188300.0, -3174.4] +HGP_2018_ds633.geik 3.086e-05 170000000000.0 8.3 -4.9e-11 0.1201702 5.0 [115.5, 0.014938, -2637700.0, 45.5] +HGP_2018_ds633.gl 0.0002598 88300000000.0 4.09 -4.6e-11 0.78354308 41.0 [1717.5, -0.12107, 7075000.0, -19272.0] +HGP_2018_ds633.glt 0.0001198 63000000000.0 4.0 -6.3e-11 0.37173236 18.0 [576.4, 0.002984, -3757000.0, -4166.2] +HGP_2018_ds633.gph 5.3e-06 31200000000.0 3.9 -1.25e-10 0.0120107 1.0 [34.3, 0.0, -240700.0, -403.8] +HGP_2018_ds633.gr 0.00012535 172000000000.0 5.53 -3.2e-11 0.4504463 20.0 [626.0, 0.0, -5779200.0, -4002.9] +HGP_2018_ds633.grun 0.0002784 64800000000.0 4.12 -6.4e-11 1.00160048 41.0 [1383.1, 0.030669, -4224700.0, -11257.6] +HGP_2018_ds633.gth 2.082e-05 250000000000.0 4.03 -1.6e-11 0.08885174 4.0 [139.3, 0.000147, -212700.0, -1077.8] +HGP_2018_ds633.hcrd 0.00023322 129000000000.0 4.1 -3.1e-11 0.60296798 32.0 [955.3, 0.0, -8352600.0, -6301.2] +HGP_2018_ds633.hed 6.795e-05 119200000000.0 3.97 -3.3e-11 0.2480904 10.0 [340.2, 0.000812, -1047800.0, -2646.7] +HGP_2018_ds633.hem 3.027e-05 223000000000.0 4.04 -1.8e-11 0.1596882 5.0 [163.9, 0.0, -2257200.0, -657.6] +HGP_2018_ds633.hen 6.099e-05 150000000000.0 5.5 -3.6e-11 0.2007774 10.0 [356.2, -0.00299, -596900.0, -3185.3] +HGP_2018_ds633.herc 4.075e-05 192200000000.0 4.04 -2.1e-11 0.1738056 7.0 [184.9, 0.01417, -3674800.0, -404.0] +HGP_2018_ds633.heu 0.000317 27400000000.0 4.0 -1.46e-10 0.68672038 46.0 [1504.8, -0.033224, -2959300.0, -13297.2] +HGP_2018_ds633.hfs 6.405e-05 150000000000.0 5.5 -3.6e-11 0.2638574 10.0 [398.7, -0.006579, 1290100.0, -4058.0] +HGP_2018_ds633.hlt 2.702e-05 23800000000.0 5.0 -2.1e-10 0.0584428 2.0 [45.2, 0.01797, 0.0, 0.0] +HGP_2018_ds633.hol 7.128e-05 180000000000.0 4.0 -2.2e-11 0.2783315 13.0 [417.6, -0.003617, -4748100.0, -2819.9] +HGP_2018_ds633.ilm 3.169e-05 170000000000.0 8.3 -4.9e-11 0.1517102 5.0 [138.9, 0.005081, -1288800.0, -463.7] +HGP_2018_ds633.iron 7.09e-06 164000000000.0 5.16 -3.1e-11 0.055845 1.0 [46.2, 0.005159, 723100.0, -556.2] +HGP_2018_ds633.jd 6.04e-05 128100000000.0 3.81 -3e-11 0.2021387 10.0 [319.4, 0.003616, -1173900.0, -2469.5] +HGP_2018_ds633.jgd 0.0003108 161500000000.0 4.05 -2.5e-11 1.11893378 51.0 [1795.4, -0.037986, -4455700.0, -14888.0] +HGP_2018_ds633.kao 9.934e-05 64500000000.0 4.12 -6.4e-11 0.25816036 17.0 [436.7, -0.034295, -4055900.0, -2699.1] +HGP_2018_ds633.kcm 0.00011438 42500000000.0 2.0 -4.7e-11 0.29634678 16.0 [536.5, -0.01009, -980400.0, -4735.0] +HGP_2018_ds633.kjd 6.479e-05 145000000000.0 5.0 -3.4e-11 0.2182472 10.0 [316.2, 0.006905, -905300.0, -2489.0] +HGP_2018_ds633.kls 6.052e-05 51400000000.0 2.0 -3.9e-11 0.1581629 7.0 [242.0, -0.004482, -895800.0, -1935.8] +HGP_2018_ds633.knor 0.00011738 153400000000.0 4.34 -2.8e-11 0.4531565 20.0 [613.0, 0.003606, -4178000.0, -3729.4] +HGP_2018_ds633.kos 6.309e-05 130800000000.0 3.0 -2.3e-11 0.2271533 10.0 [309.2, 0.005419, -664600.0, -2176.6] +HGP_2018_ds633.ky 4.414e-05 160100000000.0 4.05 -2.5e-11 0.1620455 8.0 [279.4, -0.007124, -2055600.0, -2289.4] +HGP_2018_ds633.law 0.00010132 122900000000.0 5.45 -4.4e-11 0.31423776 19.0 [687.8, 0.001566, 375900.0, -7179.2] +HGP_2018_ds633.lc 8.826e-05 45000000000.0 5.7 -1.27e-10 0.2182472 10.0 [369.8, -0.016332, 684700.0, -3683.1] +HGP_2018_ds633.lime 1.676e-05 113000000000.0 3.87 -3.4e-11 0.0560774 2.0 [52.4, 0.003673, -750700.0, -51.0] +HGP_2018_ds633.liz 0.00010645 71000000000.0 3.2 -4.5e-11 0.27711236 18.0 [614.7, -0.02077, -1721800.0, -5619.4] +HGP_2018_ds633.lmt 0.0002037 86000000000.0 4.09 -4.8e-11 0.47043692 31.0 [1013.4, -0.021413, -2235800.0, -8806.7] +HGP_2018_ds633.lot 1.818e-05 65800000000.0 4.17 -6.3e-11 0.08791 2.0 [50.2, 0.011052, -940000.0, 0.0] +HGP_2018_ds633.lrn 5.16e-05 98500000000.0 4.07 -4.1e-11 0.1722391 7.0 [247.5, -0.003206, 0.0, -2051.9] +HGP_2018_ds633.ma 0.00012964 100000000000.0 4.08 -4.1e-11 0.39818368 21.0 [744.4, -0.0168, -2074400.0, -6783.2] +HGP_2018_ds633.macf 3.614e-05 212000000000.0 4.0 -1.7e-11 0.1422656 7.0 [200.0, 0.006252, -2996400.0, -888.4] +HGP_2018_ds633.mag 2.803e-05 102800000000.0 5.41 -5.3e-11 0.0843139 5.0 [186.4, -0.003772, 0.0, -1886.2] +HGP_2018_ds633.maj 0.00011457 160000000000.0 4.56 -2.8e-11 0.4015548 20.0 [713.6, -0.000997, -1158200.0, -6622.3] +HGP_2018_ds633.mak 2.635e-05 211000000000.0 4.55 -2.2e-11 0.1003887 5.0 [147.8, 0.002015, -2395000.0, -801.8] +HGP_2018_ds633.manal 0.00011166 184000000000.0 4.0 -2.2e-11 0.4267968 21.0 [600.0, 0.018756, -8989200.0, -2665.2] +HGP_2018_ds633.mang 1.322e-05 164500000000.0 4.46 -2.7e-11 0.0709374 2.0 [59.8, 0.0036, -31400.0, -282.6] +HGP_2018_ds633.mcar 0.0001059 52500000000.0 4.14 -7.9e-11 0.29846476 19.0 [683.0, -0.014054, 291000.0, -6976.4] +HGP_2018_ds633.mcor 2.635e-05 211000000000.0 4.55 -2.2e-11 0.1003887 5.0 [147.8, 0.002015, -2395000.0, -801.8] +HGP_2018_ds633.mctd 6.875e-05 145600000000.0 4.06 -2.8e-11 0.22036518 13.0 [417.4, -0.003771, -2920600.0, -3417.8] +HGP_2018_ds633.me 0.00033985 87000000000.0 4.09 -4.7e-11 0.9347085 44.0 [1359.0, 0.036442, -8594700.0, -9598.2] +HGP_2018_ds633.merw 9.847e-05 120000000000.0 4.07 -3.4e-11 0.3287052 14.0 [417.5, 0.008117, -2923000.0, -2320.3] +HGP_2018_ds633.mft 4.457e-05 185700000000.0 4.05 -2.2e-11 0.1999926 7.0 [270.5, -0.007505, -999200.0, -2022.4] +HGP_2018_ds633.mgts 6.05e-05 102800000000.0 8.55 -8.3e-11 0.2023499 10.0 [371.4, -0.004082, -398400.0, -3547.1] +HGP_2018_ds633.mic 0.00010871 58300000000.0 4.02 -6.9e-11 0.2783315 13.0 [448.8, -0.010075, -1007300.0, -3973.1] +HGP_2018_ds633.minm 0.00014291 43000000000.0 6.17 -1.44e-10 0.37926568 21.0 [622.2, 0.0, -6385500.0, -3916.3] +HGP_2018_ds633.minn 0.00014851 43000000000.0 6.17 -1.44e-10 0.47388568 21.0 [579.7, 0.039494, -6459300.0, -3088.1] +HGP_2018_ds633.mnbi 0.00015264 53000000000.0 7.33 -1.43e-10 0.50915898 22.0 [809.9, -0.059213, -1514400.0, -6998.7] +HGP_2018_ds633.mnchl 0.0002259 87000000000.0 4.09 -4.7e-11 0.70896222 36.0 [1136.5, -0.005243, -5548100.0, -8911.5] +HGP_2018_ds633.mncrd 0.00024027 129000000000.0 4.1 -3.1e-11 0.6462187 29.0 [886.5, 0.0, -8840000.0, -5590.4] +HGP_2018_ds633.mnctd 7.175e-05 145600000000.0 4.06 -2.8e-11 0.25099818 13.0 [464.4, -0.012654, -1147200.0, -4341.0] +HGP_2018_ds633.mnst 0.0004546 180000000000.0 4.76 -2.6e-11 1.68806321 81.5 [2873.3, -0.089064, -12688000.0, -24749.0] +HGP_2018_ds633.mont 5.148e-05 113400000000.0 3.87 -3.4e-11 0.1564661 7.0 [250.7, -0.010433, -797200.0, -1996.1] +HGP_2018_ds633.mpm 0.0002955 161500000000.0 4.05 -2.5e-11 0.94307628 51.0 [1720.8, -0.024928, -5998700.0, -14620.3] +HGP_2018_ds633.mpv 2.445e-05 251000000000.0 4.14 -1.6e-11 0.1003887 5.0 [149.3, 0.002918, -2983000.0, -799.1] +HGP_2018_ds633.mrw 3.949e-05 178100000000.0 4.35 -2.4e-11 0.1406931 7.0 [213.3, 0.00269, -1410400.0, -1495.9] +HGP_2018_ds633.mscf 3.649e-05 185000000000.0 4.0 -1.7e-11 0.1406931 7.0 [213.3, 0.00269, -1410400.0, -1495.9] +HGP_2018_ds633.msnal 0.00011061 185000000000.0 4.0 -2.2e-11 0.4220793 21.0 [639.9, 0.00807, -4231200.0, -4487.7] +HGP_2018_ds633.mst 0.0004426 168400000000.0 4.05 -2.4e-11 1.56553121 81.5 [2820.5, -0.059366, -13774000.0, -24126.0] +HGP_2018_ds633.mstp 0.00036577 51300000000.0 7.33 -1.43e-10 0.9203021 58.5 [1862.2, -0.014018, -8983100.0, -14923.0] +HGP_2018_ds633.mt 4.452e-05 185700000000.0 4.05 -2.2e-11 0.2315326 7.0 [262.5, -0.007205, -1926200.0, -1655.7] +HGP_2018_ds633.mu 0.00014083 49000000000.0 4.15 -8.5e-11 0.39830798 21.0 [756.4, -0.01984, -2170000.0, -6979.2] +HGP_2018_ds633.mwd 4.051e-05 172600000000.0 3.84 -2.2e-11 0.1406931 7.0 [208.7, 0.003942, -1709500.0, -1302.8] +HGP_2018_ds633.nacf 3.631e-05 185000000000.0 4.6 -2.5e-11 0.1420544 7.0 [272.7, -0.012398, 0.0, -2763.1] +HGP_2018_ds633.nagt 0.0001109 170000000000.0 4.0 -2.3e-11 0.4029161 20.0 [620.8, 0.0112, -3755900.0, -4421.3] +HGP_2018_ds633.nanal 0.00011322 184000000000.0 4.0 -2.2e-11 0.4265856 21.0 [672.7, 0.000106, -5992800.0, -4539.9] +HGP_2018_ds633.naph 0.0001445 51300000000.0 7.33 -1.43e-10 0.40115148 22.0 [773.5, -0.040229, -2597900.0, -6512.6] +HGP_2018_ds633.ne 5.419e-05 46500000000.0 4.16 -8.9e-11 0.1420544 7.0 [272.7, -0.012398, 0.0, -2763.1] +HGP_2018_ds633.npv 2.334e-05 203000000000.0 4.0 -2e-11 0.10106935 5.0 [135.0, 0.00846, -1850300.0, -600.8] +HGP_2018_ds633.nta 0.0001445 51300000000.0 7.33 -1.43e-10 0.40115148 22.0 [773.5, -0.040229, -2597900.0, -6512.6] +HGP_2018_ds633.nyb 0.00026314 91000000000.0 4.09 -4.5e-11 0.80542888 42.0 [1745.2, -0.112162, 6425500.0, -19163.0] +HGP_2018_ds633.osfa 0.0003845 129000000000.0 4.1 -3.1e-11 1.0465328 48.0 [1558.6, -0.011359, -9476500.0, -11845.0] +HGP_2018_ds633.osma 0.00037893 129000000000.0 4.1 -3.1e-11 0.9834528 48.0 [1540.7, -0.011359, -10339000.0, -11699.0] +HGP_2018_ds633.osmm 0.0003844 129000000000.0 4.1 -3.1e-11 0.9818803 48.0 [1525.5, -0.010267, -10538000.0, -11337.0] +HGP_2018_ds633.pa 0.00013211 51500000000.0 6.51 -1.26e-10 0.38219948 21.0 [803.0, -0.03158, 217000.0, -8151.0] +HGP_2018_ds633.parg 0.0002719 91200000000.0 4.09 -4.5e-11 0.83582478 42.0 [1280.2, 0.022997, -12359500.0, -8065.8] +HGP_2018_ds633.per 1.125e-05 161600000000.0 3.95 -2.4e-11 0.0403044 2.0 [60.5, 0.000362, -535800.0, -299.2] +HGP_2018_ds633.phA 0.00015422 145000000000.0 4.06 -2.8e-11 0.45634524 29.0 [962.0, -0.011521, -4517800.0, -7724.7] +HGP_2018_ds633.phD 5.103e-05 165000000000.0 5.0 -3e-11 0.17848828 11.0 [294.6, 0.007944, -5008700.0, -1335.5] +HGP_2018_ds633.phE 6.435e-05 93000000000.0 5.0 -5.4e-11 0.190450056 12.0 [397.4, -0.003533, -1344400.0, -3290.2] +HGP_2018_ds633.phl 0.00014964 51300000000.0 7.33 -1.43e-10 0.41725998 22.0 [770.3, -0.036939, -2328900.0, -6531.6] +HGP_2018_ds633.picr 4.356e-05 192200000000.0 4.04 -2.1e-11 0.1922948 7.0 [196.1, 0.005398, -3126000.0, -616.9] +HGP_2018_ds633.pmt 0.0001382 119700000000.0 4.07 -3.4e-11 0.48231364 22.0 [569.8, 0.02779, -5442900.0, -2812.6] +HGP_2018_ds633.pnt 3.288e-05 170000000000.0 8.3 -4.9e-11 0.1508032 5.0 [143.5, 0.003373, -1940700.0, -407.6] +HGP_2018_ds633.ppv 2.442e-05 231200000000.0 4.0 -1.6e-11 0.1003887 5.0 [149.3, 0.002918, -2983000.0, -799.1] +HGP_2018_ds633.pre 0.00014026 109300000000.0 4.01 -3.7e-11 0.41238418 21.0 [724.9, -0.013865, -2059000.0, -6323.9] +HGP_2018_ds633.pren 6.476e-05 105900000000.0 8.65 -8.2e-11 0.2007774 10.0 [356.2, -0.00299, -596900.0, -3185.3] +HGP_2018_ds633.prl 0.00012804 37000000000.0 10.0 -2.71e-10 0.36031368 20.0 [784.5, -0.042948, 1251000.0, -8495.9] +HGP_2018_ds633.pswo 4.008e-05 110000000000.0 4.08 -3.7e-11 0.1161617 5.0 [157.8, 0.0, -967300.0, -1075.4] +HGP_2018_ds633.pxmn 3.472e-05 84000000000.0 4.0 -4.8e-11 0.1310217 5.0 [138.4, 0.004088, -1936000.0, -538.9] +HGP_2018_ds633.py 0.00011313 174300000000.0 4.05 -2.3e-11 0.4031273 20.0 [633.5, 0.0, -5196100.0, -4315.2] +HGP_2018_ds633.pyr 2.394e-05 139500000000.0 4.09 -2.9e-11 0.119975 3.0 [37.3, 0.026715, -1817000.0, 649.3] +HGP_2018_ds633.q 2.269e-05 73000000000.0 6.0 -8.2e-11 0.0600843 3.0 [92.9, -0.000642, -714900.0, -716.1] +HGP_2018_ds633.qnd 4.529e-05 147000000000.0 4.0 -2.72e-11 0.1604746 7.0 [161.7, 0.03286, -2382200.0, -278.6] +HGP_2018_ds633.rhc 3.107e-05 95300000000.0 3.88 -4.1e-11 0.1149469 5.0 [169.5, 0.0, 0.0, -1534.3] +HGP_2018_ds633.rhod 3.494e-05 84000000000.0 4.0 -4.8e-11 0.1310217 5.0 [138.4, 0.004088, -1936000.0, -538.9] +HGP_2018_ds633.rieb 0.0002749 89000000000.0 4.09 -4.6e-11 0.93589008 41.0 [1787.3, -0.124882, 9627100.0, -20275.5] +HGP_2018_ds633.rnk 9.651e-05 95000000000.0 4.09 -4.3e-11 0.2884008 12.0 [372.3, -0.002893, -2462400.0, -2181.3] +HGP_2018_ds633.ru 1.882e-05 222000000000.0 4.24 -1.9e-11 0.0798658 3.0 [90.4, 0.0029, 0.0, -623.8] +HGP_2018_ds633.san 0.00010871 58300000000.0 4.02 -6.9e-11 0.2783315 13.0 [448.8, -0.010075, -1007300.0, -3973.1] +HGP_2018_ds633.sdl 0.0004213 46500000000.0 4.16 -8.9e-11 0.969212 46.0 [1532.7, 0.047747, -2972800.0, -12427.0] +HGP_2018_ds633.shB 0.00018615 132000000000.0 5.3 -3.91e-11 0.61932746 35.0 [1077.7, 0.000642, -7407400.0, -7428.7] +HGP_2018_ds633.sid 2.943e-05 120000000000.0 4.07 -3.4e-11 0.1158539 5.0 [168.4, 0.0, 0.0, -1483.6] +HGP_2018_ds633.sill 4.986e-05 164000000000.0 5.06 -3.1e-11 0.1620455 8.0 [280.2, -0.0069, -1375700.0, -2399.4] +HGP_2018_ds633.ski 0.00012144 157400000000.0 6.7 -4.3e-11 0.5554743 20.0 [689.9, 0.0, -2948600.0, -5030.3] +HGP_2018_ds633.smul 4.987e-05 174000000000.0 4.0 -2.3e-11 0.1620455 8.0 [280.2, -0.0069, -1375700.0, -2399.4] +HGP_2018_ds633.sp 3.978e-05 192200000000.0 4.04 -2.1e-11 0.1422656 7.0 [200.5, 0.006252, -2996400.0, -888.4] +HGP_2018_ds633.sph 5.565e-05 101700000000.0 9.85 -9.7e-11 0.1960275 8.0 [227.9, 0.002924, -3539500.0, -894.3] +HGP_2018_ds633.spr4 0.000199 250000000000.0 4.04 -1.6e-11 0.689231 34.0 [1133.1, -0.007596, -8816600.0, -8180.6] +HGP_2018_ds633.spr5 0.0001975 250000000000.0 4.04 -1.6e-11 0.6908035 34.0 [1103.4, 0.001015, -10957000.0, -7409.2] +HGP_2018_ds633.spss 0.00011792 174000000000.0 6.68 -3.8e-11 0.4950263 20.0 [646.9, 0.0, -4525800.0, -4452.8] +HGP_2018_ds633.spu 0.00014697 95000000000.0 4.09 -4.3e-11 0.4445651 19.0 [614.1, -0.003508, -2493100.0, -4168.0] +HGP_2018_ds633.stlb 0.0003287 86000000000.0 4.09 -4.8e-11 0.70473566 49.0 [1588.4, -0.032043, -3071600.0, -13966.9] +HGP_2018_ds633.stv 1.401e-05 309000000000.0 4.6 -1.5e-11 0.0600843 3.0 [68.1, 0.00601, -1978200.0, -82.1] +HGP_2018_ds633.sud 0.000203 87000000000.0 4.09 -4.7e-11 0.53684522 35.0 [1436.1, -0.048749, -2748500.0, -13764.0] +HGP_2018_ds633.syv 3.752e-05 17000000000.0 5.0 -2.94e-10 0.0745513 2.0 [46.2, 0.01797, 0.0, 0.0] +HGP_2018_ds633.ta 0.00013665 43000000000.0 6.17 -1.44e-10 0.37926568 21.0 [622.2, 0.0, -6385500.0, -3916.3] +HGP_2018_ds633.tan 0.00013665 43000000000.0 6.17 -1.44e-10 0.37926568 21.0 [622.2, 0.0, -6385500.0, -3916.3] +HGP_2018_ds633.tap 0.0001345 37000000000.0 10.0 -2.71e-10 0.36031368 20.0 [784.5, -0.042948, 1251000.0, -8495.9] +HGP_2018_ds633.tats 0.0001351 43000000000.0 6.17 -1.44e-10 0.38083818 21.0 [549.5, 0.036324, -8606600.0, -2515.3] +HGP_2018_ds633.tcn 3.493e-05 230100000000.0 4.04 -1.8e-11 0.1399501 6.0 [208.6, -0.003669, 113000.0, -1906.9] +HGP_2018_ds633.ten 1.222e-05 200000000000.0 3.94 -2e-11 0.0795454 2.0 [31.0, 0.01374, -1258000.0, 369.3] +HGP_2018_ds633.teph 4.899e-05 125600000000.0 4.68 -3.7e-11 0.2019591 7.0 [219.6, 0.0, -1292700.0, -1308.3] +HGP_2018_ds633.tpz 5.339e-05 131500000000.0 4.06 -3.1e-11 0.18006078 11.0 [387.7, -0.00712, -857200.0, -3744.2] +HGP_2018_ds633.tr 0.0002727 76200000000.0 4.1 -5.4e-11 0.81236648 41.0 [1260.2, 0.00383, -11455000.0, -8237.6] +HGP_2018_ds633.trd 2.8e-05 15000000000.0 4.36 -2.91e-10 0.0600843 3.0 [74.9, 0.0031, -1174000.0, -236.7] +HGP_2018_ds633.tro 1.819e-05 65800000000.0 4.17 -6.3e-11 0.08791 2.0 [50.2, 0.011052, -940000.0, 0.0] +HGP_2018_ds633.trot 1.819e-05 65800000000.0 4.17 -6.3e-11 0.08791 2.0 [50.2, 0.011052, -940000.0, 0.0] +HGP_2018_ds633.trov 1.738e-05 65800000000.0 4.17 -6.3e-11 0.080929375 1.875 [51.1, 0.008307, -669700.0, 0.0] +HGP_2018_ds633.ts 0.000268 76000000000.0 4.1 -5.4e-11 0.81551148 41.0 [1244.8, 0.024348, -11965000.0, -8112.1] +HGP_2018_ds633.ty 0.00017039 95000000000.0 4.09 -4.3e-11 0.4885746 22.0 [741.7, -0.005345, -1434600.0, -5878.5] +HGP_2018_ds633.usp 4.682e-05 147000000000.0 4.0 -2.72e-11 0.2235546 7.0 [129.5, 0.048696, -3739000.0, 690.2] +HGP_2018_ds633.uv 0.00013077 162000000000.0 4.7 -2.9e-11 0.5004755 20.0 [605.1, 0.003606, -4760600.0, -3417.1] +HGP_2018_ds633.vsv 0.000852 125500000000.0 4.8 -3.8e-11 2.86945216 137.0 [4488.0, -0.057952, -22269300.0, -33478.0] +HGP_2018_ds633.wa 0.00010844 90000000000.0 4.0 -4.4e-11 0.3345332 15.0 [499.1, 0.0, 0.0, -4350.1] +HGP_2018_ds633.wal 3.7633e-05 86000000000.0 4.0 -4.7e-11 0.1161617 5.0 [159.3, 0.0, -967300.0, -1075.4] +HGP_2018_ds633.wo 3.993e-05 79500000000.0 4.1 -5.2e-11 0.1161617 5.0 [159.3, 0.0, -967300.0, -1075.4] +HGP_2018_ds633.wrk 0.0001904 86000000000.0 4.09 -4.8e-11 0.43440636 25.0 [838.3, -0.02146, -2272000.0, -7292.3] +HGP_2018_ds633.wu 1.206e-05 152000000000.0 4.0 -3.2e-11 0.0718444 2.0 [67.4, 0.003758, 315700.0, -381.7] +HGP_2018_ds633.zo 0.00013575 104400000000.0 4.0 -3.8e-11 0.45435714 22.0 [662.0, 0.010416, -6006400.0, -4260.7] +HGP_2018_ds633.zrc 3.926e-05 230100000000.0 4.04 -1.8e-11 0.1833071 6.0 [232.0, -0.014405, 0.0, -2238.2] +HGP_2018_ds633.zrt 4.42e-05 230100000000.0 4.04 -1.8e-11 0.2030886 6.0 [214.6, -0.008226, 190300.0, -1820.4] +Name (hp_tmt equation of state) V_0 K_0 Kprime_0 Kdprime_0 molar_mass n Cp +HHPH_2013.alm 0.00011525 190000000000.0 2.98 -1.6e-11 0.4977473 20.0 [677.3, 0.0, -3772700.0, -5044.0] +HHPH_2013.apv 2.54e-05 203000000000.0 4.0 -2e-11 0.1019612 5.0 [139.5, 0.00589, -2460600.0, -589.2] +HHPH_2013.cacf 3.976e-05 190000000000.0 4.0 -2.1e-11 0.1580386 7.0 [191.9, 0.009563, -3211300.0, -640.2] +HHPH_2013.canal 0.00011159 177000000000.0 4.0 -2.2e-11 0.4425698 21.0 [591.9, 0.022067, -9204100.0, -2417.0] +HHPH_2013.cats 6.356e-05 119200000000.0 5.19 -4.4e-11 0.2181229 10.0 [347.6, -0.006974, -1781600.0, -2757.5] +HHPH_2013.cen 6.264e-05 105900000000.0 8.65 -8.2e-11 0.2007774 10.0 [306.0, -0.003793, -3041700.0, -1852.1] +HHPH_2013.cor 2.558e-05 254000000000.0 4.34 -1.7e-11 0.1019612 5.0 [139.5, 0.00589, -2460600.0, -589.2] +HHPH_2013.cpv 2.745e-05 236000000000.0 3.9 -1.6e-11 0.1161617 5.0 [159.3, 0.0, -967300.0, -1075.4] +HHPH_2013.di 6.619e-05 119200000000.0 5.19 -4.4e-11 0.2165504 10.0 [314.5, 4.1e-05, -2745900.0, -2020.1] +HHPH_2013.en 6.262e-05 105900000000.0 8.65 -8.2e-11 0.2007774 10.0 [356.2, -0.00299, -596900.0, -3185.3] +HHPH_2013.fa 4.631e-05 125600000000.0 4.68 -3.7e-11 0.20377309999999998 7.0 [201.1, 0.01733, -1960600.0, -900.9] +HHPH_2013.fak 2.76e-05 218000000000.0 4.55 -2.2e-11 0.1319287 5.0 [100.3, 0.013328, -4364900.0, 419.8] +HHPH_2013.fo 4.366e-05 128500000000.0 3.84 -3e-11 0.14069310000000002 7.0 [233.3, 0.001494, -603800.0, -1869.7] +HHPH_2013.fper 1.206e-05 152000000000.0 4.9 -3.2e-11 0.0718444 2.0 [44.4, 0.00828, -1214200.0, 185.2] +HHPH_2013.fpv 2.534e-05 281000000000.0 4.14 -1.6e-11 0.1319287 5.0 [133.2, 0.01083, -3661400.0, -314.7] +HHPH_2013.frw 4.203e-05 197700000000.0 4.92 -2.5e-11 0.20377309999999998 7.0 [166.8, 0.04261, -1705400.0, -541.4] +HHPH_2013.fs 6.592e-05 101000000000.0 4.08 -4e-11 0.2638574 10.0 [398.7, -0.006579, 1290100.0, -4058.0] +HHPH_2013.fscf 3.914e-05 185000000000.0 4.0 -1.7e-11 0.20377309999999998 7.0 [181.1, 0.018526, -2767200.0, -527.1] +HHPH_2013.fsnal 0.00011856 185000000000.0 4.0 -2.2e-11 0.6113193 21.0 [543.3, 0.055578, -8301600.0, -1581.3] +HHPH_2013.fwd 4.321e-05 169000000000.0 4.35 -2.6e-11 0.20377309999999998 7.0 [201.1, 0.01733, -1960600.0, -900.9] +HHPH_2013.gr 0.00012535 172000000000.0 5.53 -3.2e-11 0.4504463 20.0 [626.0, 0.0, -5779200.0, -4002.9] +HHPH_2013.hed 6.795e-05 119200000000.0 3.97 -3.3e-11 0.24809040000000002 10.0 [340.2, 0.000812, -1047800.0, -2646.7] +HHPH_2013.hen 6.099e-05 150000000000.0 5.5 -3.6e-11 0.2007774 10.0 [356.2, -0.00299, -596900.0, -3185.3] +HHPH_2013.hfs 6.405e-05 150000000000.0 5.5 -3.6e-11 0.2638574 10.0 [398.7, -0.006579, 1290100.0, -4058.0] +HHPH_2013.jd 6.04e-05 128100000000.0 3.81 -3e-11 0.17405320000000002 9.0 [319.4, 0.003616, -1173900.0, -2469.5] +HHPH_2013.macf 3.614e-05 212000000000.0 4.0 -1.7e-11 0.1422656 7.0 [200.0, 0.006252, -2996400.0, -888.4] +HHPH_2013.maj 0.00011457 160000000000.0 4.56 -2.8e-11 0.4015548 20.0 [713.6, -0.000997, -1158200.0, -6622.3] +HHPH_2013.mak 2.635e-05 211000000000.0 4.55 -2.2e-11 0.1003887 5.0 [147.8, 0.002015, -2395000.0, -801.8] +HHPH_2013.manal 0.00011166 184000000000.0 4.0 -2.2e-11 0.42679680000000003 21.0 [600.0, 0.018756, -8989200.0, -2665.2] +HHPH_2013.mcor 2.635e-05 211000000000.0 4.55 -2.2e-11 0.1003887 5.0 [147.8, 0.002015, -2395000.0, -801.8] +HHPH_2013.mgts 6.05e-05 102800000000.0 8.55 -8.3e-11 0.20234990000000003 10.0 [371.4, -0.004082, -398400.0, -3547.1] +HHPH_2013.mpv 2.445e-05 251000000000.0 4.14 -1.6e-11 0.1003887 5.0 [149.3, 0.002918, -2983000.0, -799.1] +HHPH_2013.mrw 3.949e-05 178100000000.0 4.35 -2.4e-11 0.14069310000000002 7.0 [213.3, 0.00269, -1410400.0, -1495.9] +HHPH_2013.mscf 3.649e-05 185000000000.0 4.0 -1.7e-11 0.14069310000000002 7.0 [213.3, 0.00269, -1410400.0, -1495.9] +HHPH_2013.msnal 0.00011061 185000000000.0 4.0 -2.2e-11 0.42207930000000005 21.0 [639.9, 0.00807, -4231200.0, -4487.7] +HHPH_2013.mwd 4.051e-05 172600000000.0 3.84 -2.2e-11 0.14069310000000002 7.0 [208.7, 0.003942, -1709500.0, -1302.8] +HHPH_2013.nacf 3.631e-05 185000000000.0 4.6 -2.5e-11 0.17405320000000002 9.0 [272.7, -0.012398, 0.0, -2763.1] +HHPH_2013.nagt 0.0001109 170000000000.0 4.0 -2.3e-11 0.4029161 20.0 [620.8, 0.0112, -3755900.0, -4421.3] +HHPH_2013.nanal 0.00011322 184000000000.0 4.0 -2.2e-11 0.4265856 21.0 [672.7, 0.000106, -5992800.0, -4539.9] +HHPH_2013.npv 2.334e-05 203000000000.0 4.0 -2e-11 0.10106935 5.0 [135.0, 0.00846, -1850300.0, -600.8] +HHPH_2013.per 1.125e-05 161600000000.0 3.95 -2.4e-11 0.040304400000000004 2.0 [60.5, 0.000362, -535800.0, -299.2] +HHPH_2013.py 0.00011313 174300000000.0 4.05 -2.3e-11 0.4031273 20.0 [633.5, 0.0, -5196100.0, -4315.2] +HHPH_2013.stv 1.401e-05 309000000000.0 4.6 -1.5e-11 0.0600843 3.0 [68.1, 0.00601, -1978200.0, -82.1] +Name (hp_tmt equation of state) V_0 K_0 Kprime_0 Kdprime_0 molar_mass n Cp +HP_2011_ds62.Cu 7.11e-06 162500000000.0 4.24 -2.6e-11 0.063546 1.0 [12.4, 0.00922, -379900.0, 233.5] +HP_2011_ds62.Ni 6.59e-06 190500000000.0 4.25 -2.2e-11 0.0586934 1.0 [49.8, 0.0, 585900.0, -533.9] +HP_2011_ds62.NiO 1.097e-05 200000000000.0 3.94 -2e-11 0.0746928 2.0 [47.7, 0.007824, -392500.0, 0.0] +HP_2011_ds62.S 1.551e-05 14500000000.0 7.0 -4.8e-10 0.032065 1.0 [56.6, -0.004557, 638000.0, -681.8] +HP_2011_ds62.ab 0.00010067 54100000000.0 5.91 -1.09e-10 0.262223 13.0 [452.0, -0.013364, -1275900.0, -3953.6] +HP_2011_ds62.abh 0.00010105 54100000000.0 5.91 -1.09e-10 0.262223 13.0 [452.0, -0.013364, -1275900.0, -3953.6] +HP_2011_ds62.acm 6.459e-05 106000000000.0 4.08 -3.8e-11 0.2310022 10.0 [307.1, 0.016758, -1685500.0, -2125.8] +HP_2011_ds62.afchl 0.0002157 87000000000.0 4.09 -4.7e-11 0.55422472 36.0 [1155.0, -0.000417, -4024400.0, -9952.9] +HP_2011_ds62.ak 9.254e-05 142000000000.0 4.06 -2.9e-11 0.2726278 12.0 [385.4, 0.003209, -247500.0, -2889.9] +HP_2011_ds62.alm 0.00011525 190000000000.0 2.98 -1.6e-11 0.4977473 20.0 [677.3, 0.0, -3772700.0, -5044.0] +HP_2011_ds62.ames 0.0002071 87000000000.0 4.09 -4.7e-11 0.55736972 36.0 [1186.0, -0.002599, -3627200.0, -10677.0] +HP_2011_ds62.amul 5.083e-05 174000000000.0 4.0 -2.3e-11 0.15749365 7.75 [244.8, 0.000968, -2533300.0, -1641.6] +HP_2011_ds62.an 0.00010079 86000000000.0 4.09 -4.8e-11 0.2782072 13.0 [370.5, 0.01001, -4339100.0, -1960.6] +HP_2011_ds62.andalusite 5.153e-05 144200000000.0 6.89 -4.8e-11 0.1620455 8.0 [277.3, -0.006588, -1914100.0, -2265.6] +HP_2011_ds62.andr 0.00013204 158800000000.0 5.68 -3.6e-11 0.5081733 20.0 [638.6, 0.0, -4955100.0, -3989.2] +HP_2011_ds62.ank 6.606e-05 91400000000.0 3.88 -4.3e-11 0.2159408 10.0 [341.0, -0.001161, 0.0, -3054.8] +HP_2011_ds62.anl 9.74e-05 40000000000.0 4.18 -1.04e-10 0.22015398 13.0 [643.5, -0.016067, 9302300.0, -9179.6] +HP_2011_ds62.ann 0.00015432 51300000000.0 7.33 -1.43e-10 0.51187998 22.0 [815.7, -0.034861, 19800.0, -7466.7] +HP_2011_ds62.anth 0.0002654 70000000000.0 4.11 -5.9e-11 0.78082048 41.0 [1277.3, 0.025825, -9704600.0, -9074.7] +HP_2011_ds62.any 4.594e-05 54379999999.99999 4.19 -7.7e-11 0.1361406 6.0 [128.7, 0.048545, -1223000.0, -560.5] +HP_2011_ds62.apv 2.54e-05 203000000000.0 4.0 -2e-11 0.1019612 5.0 [139.5, 0.00589, -2460600.0, -589.2] +HP_2011_ds62.arag 3.415e-05 61400000000.0 5.87 -9.6e-11 0.1000869 5.0 [167.1, 0.010695, 162000.0, -1564.9] +HP_2011_ds62.atg 0.0017548 63100000000.0 5.92 -9.4e-11 4.53595108 291.0 [9621.0, -0.091183, -35941600.0, -83034.2] +HP_2011_ds62.bdy 2.115e-05 95300000000.0 3.88 -4.1e-11 0.1232228 3.0 [103.5, -0.004547, -416200.0, -713.6] +HP_2011_ds62.bix 3.137e-05 223000000000.0 4.04 -1.8e-11 0.1578742 5.0 [145.1, 0.023534, 721600.0, -1008.4] +HP_2011_ds62.br 2.463e-05 41500000000.0 6.45 -1.55e-10 0.05831968 5.0 [158.4, -0.004076, -1052300.0, -1171.3] +HP_2011_ds62.caes 6.05e-05 119200000000.0 5.19 -4.4e-11 0.1991879 9.5 [362.0, -0.016944, -175900.0, -3565.7] +HP_2011_ds62.cats 6.356e-05 119200000000.0 5.19 -4.4e-11 0.2181229 10.0 [347.6, -0.006974, -1781600.0, -2757.5] +HP_2011_ds62.cc 3.689e-05 73300000000.0 4.06 -5.5e-11 0.1000869 5.0 [140.9, 0.005029, -950700.0, -858.4] +HP_2011_ds62.cel 0.00013957 70000000000.0 4.11 -5.9e-11 0.39673548 21.0 [741.2, -0.018748, -2368800.0, -6616.9] +HP_2011_ds62.cen 6.264e-05 105900000000.0 8.65 -8.2e-11 0.2007774 10.0 [306.0, -0.003793, -3041700.0, -1852.1] +HP_2011_ds62.cg 5.603e-05 46500000000.0 4.16 -8.9e-11 0.1420544 7.0 [116.1, 0.086021, -1992700.0, 0.0] +HP_2011_ds62.cgh 5.67e-05 46500000000.0 4.16 -8.9e-11 0.1420544 7.0 [229.2, 0.011876, 0.0, -1970.7] +HP_2011_ds62.chdr 0.00011084 116100000000.0 4.8 -4.1e-11 0.33970588 19.0 [625.0, -0.001088, -2259900.0, -4910.7] +HP_2011_ds62.chr 0.00010746 62800000000.0 4.0 -6.4e-11 0.27711236 18.0 [624.7, -0.02077, -1721800.0, -5619.4] +HP_2011_ds62.chum 0.00019801 119900000000.0 4.58 -3.8e-11 0.62109208 33.0 [1071.0, -0.016533, -7899600.0, -7373.9] +HP_2011_ds62.clin 0.0002114 87000000000.0 4.09 -4.7e-11 0.55579722 36.0 [1170.8, -0.001508, -3825800.0, -10315.0] +HP_2011_ds62.coe 2.064e-05 97900000000.0 4.19 -4.3e-11 0.0600843 3.0 [107.8, -0.003279, -190300.0, -1041.6] +HP_2011_ds62.cor 2.558e-05 254000000000.0 4.34 -1.7e-11 0.1019612 5.0 [139.5, 0.00589, -2460600.0, -589.2] +HP_2011_ds62.cpv 2.745e-05 236000000000.0 3.9 -1.6e-11 0.1161617 5.0 [159.3, 0.0, -967300.0, -1075.4] +HP_2011_ds62.crd 0.00023322 129000000000.0 4.1 -3.1e-11 0.5849527 29.0 [906.1, 0.0, -7902000.0, -6293.4] +HP_2011_ds62.crst 2.745e-05 16000000000.0 4.35 -2.72e-10 0.0600843 3.0 [72.7, 0.001304, -4129000.0, 0.0] +HP_2011_ds62.cstn 4.818e-05 178200000000.0 4.0 -2.2e-11 0.176246 8.0 [205.6, 0.006034, -5517700.0, -352.6] +HP_2011_ds62.cumm 0.0002633 70000000000.0 4.11 -5.9e-11 0.78082048 41.0 [1277.3, 0.025825, -9704600.0, -9074.7] +HP_2011_ds62.cup 2.344e-05 131000000000.0 5.7 -4.3e-11 0.1430914 3.0 [110.3, 0.0, 0.0, -674.8] +HP_2011_ds62.cz 0.0001363 119700000000.0 4.07 -3.4e-11 0.45435714 22.0 [630.9, 0.013693, -6645800.0, -3731.1] +HP_2011_ds62.daph 0.0002162 87000000000.0 4.09 -4.7e-11 0.71349722 36.0 [1192.0, -0.00594, -4826400.0, -9768.3] +HP_2011_ds62.deer 0.0005574 63000000000.0 4.12 -6.5e-11 2.1522854 90.0 [3164.4, -0.027883, -5039100.0, -26721.0] +HP_2011_ds62.di 6.619e-05 119200000000.0 5.19 -4.4e-11 0.2165504 10.0 [314.5, 4.1e-05, -2745900.0, -2020.1] +HP_2011_ds62.diam 3.42e-06 446500000000.0 1.61 -3.6e-12 0.0120107 1.0 [40.0, 0.0, -28500.0, -580.5] +HP_2011_ds62.dol 6.429e-05 94300000000.0 3.74 -4e-11 0.1844008 10.0 [358.9, -0.004905, 0.0, -3456.2] +HP_2011_ds62.dsp 1.786e-05 228000000000.0 4.04 -1.8e-11 0.05998824 4.0 [145.1, 0.008709, 584400.0, -1741.1] +HP_2011_ds62.east 0.00014738 53000000000.0 7.33 -1.43e-10 0.41883248 22.0 [785.5, -0.038031, -2130300.0, -6893.7] +HP_2011_ds62.en 6.262e-05 105900000000.0 8.65 -8.2e-11 0.2007774 10.0 [356.2, -0.00299, -596900.0, -3185.3] +HP_2011_ds62.ep 0.0001392 134000000000.0 4.0 -3e-11 0.48322064 22.0 [613.3, 0.02207, -7160000.0, -2987.7] +HP_2011_ds62.esk 2.909e-05 238000000000.0 4.0 -1.7e-11 0.1519904 5.0 [119.0, 0.009496, -1442000.0, -3.4] +HP_2011_ds62.fa 4.631e-05 125600000000.0 4.68 -3.7e-11 0.2037731 7.0 [201.1, 0.01733, -1960600.0, -900.9] +HP_2011_ds62.fact 0.0002842 76000000000.0 4.1 -5.4e-11 0.97006648 41.0 [1290.0, 0.029992, -8447500.0, -8947.0] +HP_2011_ds62.fak 2.76e-05 218000000000.0 4.55 -2.2e-11 0.1319287 5.0 [100.3, 0.013328, -4364900.0, 419.8] +HP_2011_ds62.fanth 0.0002787 70000000000.0 4.11 -5.9e-11 1.00160048 41.0 [1383.1, 0.030669, -4224700.0, -11257.6] +HP_2011_ds62.fcar 0.00010695 52500000000.0 4.14 -7.9e-11 0.33000476 19.0 [686.6, -0.012415, 186000.0, -6884.0] +HP_2011_ds62.fcel 0.0001407 70000000000.0 4.11 -5.9e-11 0.42827548 21.0 [756.3, -0.019147, -1586100.0, -6928.7] +HP_2011_ds62.fcrd 0.0002371 129000000000.0 4.1 -3.1e-11 0.6480327 29.0 [924.0, 0.0, -7039400.0, -6439.6] +HP_2011_ds62.fctd 6.98e-05 145600000000.0 4.06 -2.8e-11 0.25190518 13.0 [416.1, -0.003477, -2835900.0, -3360.3] +HP_2011_ds62.fep 0.0001421 151300000000.0 4.0 -2.6e-11 0.51208414 22.0 [584.7, 0.030447, -7674200.0, -2244.3] +HP_2011_ds62.fgl 0.0002659 89000000000.0 4.09 -4.6e-11 0.87816308 41.0 [1762.9, -0.118992, 9423700.0, -20207.1] +HP_2011_ds62.fo 4.366e-05 128500000000.0 3.84 -3e-11 0.1406931 7.0 [233.3, 0.001494, -603800.0, -1869.7] +HP_2011_ds62.fper 1.206e-05 152000000000.0 4.9 -3.2e-11 0.0718444 2.0 [44.4, 0.00828, -1214200.0, 185.2] +HP_2011_ds62.fpm 0.0002968 161500000000.0 4.05 -2.5e-11 0.97461628 51.0 [1737.2, -0.024582, -5161100.0, -14963.0] +HP_2011_ds62.fpre 0.000148 109300000000.0 4.01 -3.7e-11 0.44124768 21.0 [737.1, -0.01681, -1957300.0, -6358.1] +HP_2011_ds62.fpv 2.548e-05 281000000000.0 4.14 -1.6e-11 0.1319287 5.0 [133.2, 0.01083, -3661400.0, -314.7] +HP_2011_ds62.frw 4.203e-05 197700000000.0 4.92 -2.5e-11 0.2037731 7.0 [166.8, 0.04261, -1705400.0, -541.4] +HP_2011_ds62.fs 6.592e-05 101000000000.0 4.08 -4e-11 0.2638574 10.0 [398.7, -0.006579, 1290100.0, -4058.0] +HP_2011_ds62.fspr 0.00019923 250000000000.0 4.04 -1.7e-11 0.815391 34.0 [1132.9, -0.007348, -10420200.0, -7036.6] +HP_2011_ds62.fst 0.0004488 180000000000.0 4.76 -2.6e-11 1.69169121 81.5 [2880.0, -0.056595, -10642000.0, -25373.0] +HP_2011_ds62.fstp 0.00037239 51300000000.0 7.33 -1.43e-10 1.0780021 58.5 [1944.3, -0.012289, -4840200.0, -16635.0] +HP_2011_ds62.fsud 0.000204 87000000000.0 4.09 -4.7e-11 0.59992522 35.0 [1466.3, -0.047365, -1182800.0, -14388.0] +HP_2011_ds62.fta 0.00014225 43000000000.0 6.17 -1.44e-10 0.47388568 21.0 [579.7, 0.039494, -6459300.0, -3088.1] +HP_2011_ds62.fwd 4.321e-05 169000000000.0 4.35 -2.6e-11 0.2037731 7.0 [201.1, 0.01733, -1960600.0, -900.9] +HP_2011_ds62.ged 0.00025548 77000000000.0 4.1 -5.3e-11 0.78396548 41.0 [1307.7, 0.023642, -9307400.0, -9799.0] +HP_2011_ds62.geh 9.024e-05 108000000000.0 4.08 -3.8e-11 0.2742003 12.0 [405.7, -0.007099, -1188300.0, -3174.4] +HP_2011_ds62.geik 3.086e-05 170000000000.0 8.3 -4.9e-11 0.1201702 5.0 [151.0, 0.0, -1890400.0, -652.2] +HP_2011_ds62.gl 0.0002598 88300000000.0 4.09 -4.6e-11 0.78354308 41.0 [1717.5, -0.12107, 7075000.0, -19272.0] +HP_2011_ds62.glt 0.0001198 63000000000.0 4.0 -6.3e-11 0.37173236 18.0 [576.4, 0.002984, -3757000.0, -4166.2] +HP_2011_ds62.gph 5.3e-06 31200000000.0 3.9 -1.25e-10 0.0120107 1.0 [34.3, 0.0, -240700.0, -403.8] +HP_2011_ds62.gr 0.00012535 172000000000.0 5.53 -3.2e-11 0.4504463 20.0 [626.0, 0.0, -5779200.0, -4002.9] +HP_2011_ds62.grun 0.0002784 64800000000.0 4.12 -6.4e-11 1.00160048 41.0 [1383.1, 0.030669, -4224700.0, -11257.6] +HP_2011_ds62.gth 2.082e-05 250000000000.0 4.03 -1.6e-11 0.08885174 4.0 [139.3, 0.000147, -212700.0, -1077.8] +HP_2011_ds62.hcrd 0.00023322 129000000000.0 4.1 -3.1e-11 0.60296798 32.0 [955.3, 0.0, -8352600.0, -6301.2] +HP_2011_ds62.hed 6.795e-05 119200000000.0 3.97 -3.3e-11 0.2480904 10.0 [340.2, 0.000812, -1047800.0, -2646.7] +HP_2011_ds62.hem 3.027e-05 223000000000.0 4.04 -1.8e-11 0.1596882 5.0 [163.9, 0.0, -2257200.0, -657.6] +HP_2011_ds62.hen 6.099e-05 150000000000.0 5.5 -3.6e-11 0.2007774 10.0 [356.2, -0.00299, -596900.0, -3185.3] +HP_2011_ds62.herc 4.075e-05 192200000000.0 4.04 -2.1e-11 0.1738056 7.0 [216.7, 0.005868, -2430200.0, -1178.3] +HP_2011_ds62.heu 0.000317 27400000000.0 4.0 -1.46e-10 0.68672038 46.0 [1504.8, -0.033224, -2959300.0, -13297.2] +HP_2011_ds62.hlt 2.702e-05 23800000000.0 5.0 -2.1e-10 0.0584428 2.0 [45.2, 0.01797, 0.0, 0.0] +HP_2011_ds62.hol 7.128e-05 180000000000.0 4.0 -2.2e-11 0.2783315 13.0 [417.6, -0.003617, -4748100.0, -2819.9] +HP_2011_ds62.ilm 3.169e-05 170000000000.0 8.3 -4.9e-11 0.1517102 5.0 [138.9, 0.005081, -1288800.0, -463.7] +HP_2011_ds62.iron 7.09e-06 164000000000.0 5.16 -3.1e-11 0.055845 1.0 [46.2, 0.005159, 723100.0, -556.2] +HP_2011_ds62.jd 6.04e-05 128100000000.0 3.81 -3e-11 0.2021387 10.0 [319.4, 0.003616, -1173900.0, -2469.5] +HP_2011_ds62.jgd 0.0003108 161500000000.0 4.05 -2.5e-11 1.11893378 51.0 [1795.4, -0.037986, -4455700.0, -14888.0] +HP_2011_ds62.kao 9.934e-05 64500000000.0 4.12 -6.4e-11 0.25816036 17.0 [436.7, -0.034295, -4055900.0, -2699.1] +HP_2011_ds62.kcm 0.00011438 42500000000.0 2.0 -4.7e-11 0.29634678 16.0 [536.5, -0.01009, -980400.0, -4735.0] +HP_2011_ds62.kls 6.052e-05 51400000000.0 2.0 -3.9e-11 0.1581629 7.0 [242.0, -0.004482, -895800.0, -1935.8] +HP_2011_ds62.knor 0.00011738 174300000000.0 4.05 -2.3e-11 0.4531565 20.0 [613.0, 0.003606, -4178000.0, -3729.4] +HP_2011_ds62.kos 6.309e-05 130800000000.0 3.0 -2.3e-11 0.2271533 10.0 [309.2, 0.005419, -664600.0, -2176.6] +HP_2011_ds62.ky 4.414e-05 160100000000.0 4.05 -2.5e-11 0.1620455 8.0 [279.4, -0.007124, -2055600.0, -2289.4] +HP_2011_ds62.law 0.00010132 122900000000.0 5.45 -4.4e-11 0.31423776 19.0 [687.8, 0.001566, 375900.0, -7179.2] +HP_2011_ds62.lc 8.826e-05 45000000000.0 5.7 -1.27e-10 0.2182472 10.0 [369.8, -0.016332, 684700.0, -3683.1] +HP_2011_ds62.lime 1.676e-05 113000000000.0 3.87 -3.4e-11 0.0560774 2.0 [52.4, 0.003673, -750700.0, -51.0] +HP_2011_ds62.liz 0.00010645 71000000000.0 3.2 -4.5e-11 0.27711236 18.0 [614.7, -0.02077, -1721800.0, -5619.4] +HP_2011_ds62.lmt 0.0002037 86000000000.0 4.09 -4.8e-11 0.47043692 31.0 [1013.4, -0.021413, -2235800.0, -8806.7] +HP_2011_ds62.lot 1.818e-05 65800000000.0 4.17 -6.3e-11 0.08791 2.0 [50.2, 0.011052, -940000.0, 0.0] +HP_2011_ds62.lrn 5.16e-05 98500000000.0 4.07 -4.1e-11 0.1722391 7.0 [247.5, -0.003206, 0.0, -2051.9] +HP_2011_ds62.ma 0.00012964 100000000000.0 4.08 -4.1e-11 0.39818368 21.0 [744.4, -0.0168, -2074400.0, -6783.2] +HP_2011_ds62.mag 2.803e-05 102800000000.0 5.41 -5.3e-11 0.0843139 5.0 [186.4, -0.003772, 0.0, -1886.2] +HP_2011_ds62.maj 0.00011457 160000000000.0 4.56 -2.8e-11 0.4015548 20.0 [713.6, -0.000997, -1158200.0, -6622.3] +HP_2011_ds62.mak 2.635e-05 211000000000.0 4.55 -2.2e-11 0.1003887 5.0 [147.8, 0.002015, -2395000.0, -801.8] +HP_2011_ds62.mang 1.322e-05 164500000000.0 4.46 -2.7e-11 0.0709374 2.0 [59.8, 0.0036, -31400.0, -282.6] +HP_2011_ds62.mcar 0.0001059 52500000000.0 4.14 -7.9e-11 0.29846476 19.0 [683.0, -0.014054, 291000.0, -6976.4] +HP_2011_ds62.mcor 2.635e-05 211000000000.0 4.55 -2.2e-11 0.1003887 5.0 [147.8, 0.002015, -2395000.0, -801.8] +HP_2011_ds62.mctd 6.875e-05 145600000000.0 4.06 -2.8e-11 0.22036518 13.0 [417.4, -0.003771, -2920600.0, -3417.8] +HP_2011_ds62.me 0.00033985 87000000000.0 4.09 -4.7e-11 0.9347085 44.0 [1359.0, 0.036442, -8594700.0, -9598.2] +HP_2011_ds62.merw 9.847e-05 120000000000.0 4.07 -3.4e-11 0.3287052 14.0 [417.5, 0.008117, -2923000.0, -2320.3] +HP_2011_ds62.mft 4.457e-05 185700000000.0 4.05 -2.2e-11 0.1999926 7.0 [270.5, -0.007505, -999200.0, -2022.4] +HP_2011_ds62.mgts 6.05e-05 102800000000.0 8.55 -8.3e-11 0.2023499 10.0 [371.4, -0.004082, -398400.0, -3547.1] +HP_2011_ds62.mic 0.00010871 58300000000.0 4.02 -6.9e-11 0.2783315 13.0 [448.8, -0.010075, -1007300.0, -3973.1] +HP_2011_ds62.minm 0.00014291 43000000000.0 6.17 -1.44e-10 0.37926568 21.0 [622.2, 0.0, -6385500.0, -3916.3] +HP_2011_ds62.minn 0.00014851 43000000000.0 6.17 -1.44e-10 0.47388568 21.0 [579.7, 0.039494, -6459300.0, -3088.1] +HP_2011_ds62.mnbi 0.00015264 53000000000.0 7.33 -1.43e-10 0.50915898 22.0 [809.9, -0.059213, -1514400.0, -6998.7] +HP_2011_ds62.mnchl 0.0002259 87000000000.0 4.09 -4.7e-11 0.70896222 36.0 [1136.5, -0.005243, -5548100.0, -8911.5] +HP_2011_ds62.mncrd 0.00024027 129000000000.0 4.1 -3.1e-11 0.6462187 29.0 [886.5, 0.0, -8840000.0, -5590.4] +HP_2011_ds62.mnctd 7.175e-05 145600000000.0 4.06 -2.8e-11 0.25099818 13.0 [464.4, -0.012654, -1147200.0, -4341.0] +HP_2011_ds62.mnst 0.0004546 180000000000.0 4.76 -2.6e-11 1.68806321 81.5 [2873.3, -0.089064, -12688000.0, -24749.0] +HP_2011_ds62.mont 5.148e-05 113400000000.0 3.87 -3.4e-11 0.1564661 7.0 [250.7, -0.010433, -797200.0, -1996.1] +HP_2011_ds62.mpm 0.0002955 161500000000.0 4.05 -2.5e-11 0.94307628 51.0 [1720.8, -0.024928, -5998700.0, -14620.3] +HP_2011_ds62.mpv 2.445e-05 251000000000.0 4.14 -1.6e-11 0.1003887 5.0 [149.3, 0.002918, -2983000.0, -799.1] +HP_2011_ds62.mrw 3.949e-05 178100000000.0 4.35 -2.4e-11 0.1406931 7.0 [213.3, 0.00269, -1410400.0, -1495.9] +HP_2011_ds62.mst 0.0004426 168400000000.0 4.05 -2.4e-11 1.56553121 81.5 [2820.5, -0.059366, -13774000.0, -24126.0] +HP_2011_ds62.mstp 0.00036577 51300000000.0 7.33 -1.43e-10 0.9203021 58.5 [1862.2, -0.014018, -8983100.0, -14923.0] +HP_2011_ds62.mt 4.452e-05 185700000000.0 4.05 -2.2e-11 0.2315326 7.0 [262.5, -0.007205, -1926200.0, -1655.7] +HP_2011_ds62.mu 0.00014083 49000000000.0 4.15 -8.5e-11 0.39830798 21.0 [756.4, -0.01984, -2170000.0, -6979.2] +HP_2011_ds62.mwd 4.051e-05 172600000000.0 3.84 -2.2e-11 0.1406931 7.0 [208.7, 0.003942, -1709500.0, -1302.8] +HP_2011_ds62.naph 0.0001445 51300000000.0 7.33 -1.43e-10 0.40115148 22.0 [773.5, -0.040229, -2597900.0, -6512.6] +HP_2011_ds62.ne 5.419e-05 46500000000.0 4.16 -8.9e-11 0.1420544 7.0 [272.7, -0.012398, 0.0, -2763.1] +HP_2011_ds62.osfa 0.0003845 129000000000.0 4.1 -3.1e-11 1.0465328 48.0 [1558.6, -0.011359, -9476500.0, -11845.0] +HP_2011_ds62.osma 0.00037893 129000000000.0 4.1 -3.1e-11 0.9834528 48.0 [1540.7, -0.011359, -10339000.0, -11699.0] +HP_2011_ds62.osmm 0.0003844 129000000000.0 4.1 -3.1e-11 0.9818803 48.0 [1525.5, -0.010267, -10538000.0, -11337.0] +HP_2011_ds62.pa 0.00013211 51500000000.0 6.51 -1.26e-10 0.38219948 21.0 [803.0, -0.03158, 217000.0, -8151.0] +HP_2011_ds62.parg 0.0002719 91200000000.0 4.09 -4.5e-11 0.83582478 42.0 [1280.2, 0.022997, -12359500.0, -8065.8] +HP_2011_ds62.per 1.125e-05 161600000000.0 3.95 -2.4e-11 0.0403044 2.0 [60.5, 0.000362, -535800.0, -299.2] +HP_2011_ds62.phA 0.00015422 145000000000.0 4.06 -2.8e-11 0.45634524 29.0 [962.0, -0.011521, -4517800.0, -7724.7] +HP_2011_ds62.phl 0.00014964 51300000000.0 7.33 -1.43e-10 0.41725998 22.0 [770.3, -0.036939, -2328900.0, -6531.6] +HP_2011_ds62.picr 4.356e-05 192200000000.0 4.04 -2.1e-11 0.1922948 7.0 [196.1, 0.005398, -3126000.0, -616.9] +HP_2011_ds62.pmt 0.0001382 119700000000.0 4.07 -3.4e-11 0.48231364 22.0 [569.8, 0.02779, -5442900.0, -2812.6] +HP_2011_ds62.pnt 3.288e-05 170000000000.0 8.3 -4.9e-11 0.1508032 5.0 [143.5, 0.003373, -1940700.0, -407.6] +HP_2011_ds62.pre 0.00014026 109300000000.0 4.01 -3.7e-11 0.41238418 21.0 [724.9, -0.013865, -2059000.0, -6323.9] +HP_2011_ds62.pren 6.476e-05 105900000000.0 8.65 -8.2e-11 0.2007774 10.0 [356.2, -0.00299, -596900.0, -3185.3] +HP_2011_ds62.prl 0.00012804 37000000000.0 10.0 -2.71e-10 0.36031368 20.0 [784.5, -0.042948, 1251000.0, -8495.9] +HP_2011_ds62.pswo 4.008e-05 110000000000.0 4.08 -3.7e-11 0.1161617 5.0 [157.8, 0.0, -967300.0, -1075.4] +HP_2011_ds62.pxmn 3.472e-05 84000000000.0 4.0 -4.8e-11 0.1310217 5.0 [138.4, 0.004088, -1936000.0, -538.9] +HP_2011_ds62.py 0.00011313 174300000000.0 4.05 -2.3e-11 0.4031273 20.0 [633.5, 0.0, -5196100.0, -4315.2] +HP_2011_ds62.pyr 2.394e-05 139500000000.0 4.09 -2.9e-11 0.119975 3.0 [37.3, 0.026715, -1817000.0, 649.3] +HP_2011_ds62.q 2.269e-05 73000000000.0 6.0 -8.2e-11 0.0600843 3.0 [92.9, -0.000642, -714900.0, -716.1] +HP_2011_ds62.rhc 3.107e-05 95300000000.0 3.88 -4.1e-11 0.1149469 5.0 [169.5, 0.0, 0.0, -1534.3] +HP_2011_ds62.rhod 3.494e-05 84000000000.0 4.0 -4.8e-11 0.1310217 5.0 [138.4, 0.004088, -1936000.0, -538.9] +HP_2011_ds62.rieb 0.0002749 89000000000.0 4.09 -4.6e-11 0.93589008 41.0 [1787.3, -0.124882, 9627100.0, -20275.5] +HP_2011_ds62.rnk 9.651e-05 95000000000.0 4.09 -4.3e-11 0.2884008 12.0 [372.3, -0.002893, -2462400.0, -2181.3] +HP_2011_ds62.ru 1.882e-05 222000000000.0 4.24 -1.9e-11 0.0798658 3.0 [90.4, 0.0029, 0.0, -623.8] +HP_2011_ds62.san 0.00010871 58300000000.0 4.02 -6.9e-11 0.2783315 13.0 [448.8, -0.010075, -1007300.0, -3973.1] +HP_2011_ds62.sdl 0.0004213 46500000000.0 4.16 -8.9e-11 0.969212 46.0 [1532.7, 0.047747, -2972800.0, -12427.0] +HP_2011_ds62.sid 2.943e-05 120000000000.0 4.07 -3.4e-11 0.1158539 5.0 [168.4, 0.0, 0.0, -1483.6] +HP_2011_ds62.sill 4.986e-05 164000000000.0 5.06 -3.1e-11 0.1620455 8.0 [280.2, -0.0069, -1375700.0, -2399.4] +HP_2011_ds62.smul 4.987e-05 174000000000.0 4.0 -2.3e-11 0.1620455 8.0 [280.2, -0.0069, -1375700.0, -2399.4] +HP_2011_ds62.sp 3.978e-05 192200000000.0 4.04 -2.1e-11 0.1422656 7.0 [222.9, 0.006127, -1686000.0, -1551.0] +HP_2011_ds62.sph 5.565e-05 101700000000.0 9.85 -9.7e-11 0.1960275 8.0 [227.9, 0.002924, -3539500.0, -894.3] +HP_2011_ds62.spr4 0.000199 250000000000.0 4.04 -1.6e-11 0.689231 34.0 [1133.1, -0.007596, -8816600.0, -8180.6] +HP_2011_ds62.spr5 0.0001975 250000000000.0 4.04 -1.6e-11 0.6908035 34.0 [1103.4, 0.001015, -10957000.0, -7409.2] +HP_2011_ds62.spss 0.00011792 174000000000.0 6.68 -3.8e-11 0.4950263 20.0 [646.9, 0.0, -4525800.0, -4452.8] +HP_2011_ds62.spu 0.00014697 95000000000.0 4.09 -4.3e-11 0.4445651 19.0 [614.1, -0.003508, -2493100.0, -4168.0] +HP_2011_ds62.stlb 0.0003287 86000000000.0 4.09 -4.8e-11 0.70473566 49.0 [1588.4, -0.032043, -3071600.0, -13966.9] +HP_2011_ds62.stv 1.401e-05 309000000000.0 4.6 -1.5e-11 0.0600843 3.0 [68.1, 0.00601, -1978200.0, -82.1] +HP_2011_ds62.sud 0.000203 87000000000.0 4.09 -4.7e-11 0.53684522 35.0 [1436.1, -0.048749, -2748500.0, -13764.0] +HP_2011_ds62.syv 3.752e-05 17000000000.0 5.0 -2.94e-10 0.0745513 2.0 [46.2, 0.01797, 0.0, 0.0] +HP_2011_ds62.ta 0.00013665 43000000000.0 6.17 -1.44e-10 0.37926568 21.0 [622.2, 0.0, -6385500.0, -3916.3] +HP_2011_ds62.tap 0.0001345 37000000000.0 10.0 -2.71e-10 0.36031368 20.0 [784.5, -0.042948, 1251000.0, -8495.9] +HP_2011_ds62.tats 0.0001351 43000000000.0 6.17 -1.44e-10 0.38083818 21.0 [549.5, 0.036324, -8606600.0, -2515.3] +HP_2011_ds62.ten 1.222e-05 200000000000.0 3.94 -2e-11 0.0795454 2.0 [31.0, 0.01374, -1258000.0, 369.3] +HP_2011_ds62.teph 4.899e-05 125600000000.0 4.68 -3.7e-11 0.2019591 7.0 [219.6, 0.0, -1292700.0, -1308.3] +HP_2011_ds62.tpz 5.339e-05 131500000000.0 4.06 -3.1e-11 0.18006078 11.0 [387.7, -0.00712, -857200.0, -3744.2] +HP_2011_ds62.tr 0.0002727 76200000000.0 4.1 -5.4e-11 0.81236648 41.0 [1260.2, 0.00383, -11455000.0, -8237.6] +HP_2011_ds62.trd 2.8e-05 15000000000.0 4.36 -2.91e-10 0.0600843 3.0 [74.9, 0.0031, -1174000.0, -236.7] +HP_2011_ds62.tro 1.819e-05 65800000000.0 4.17 -6.3e-11 0.08791 2.0 [50.2, 0.011052, -940000.0, 0.0] +HP_2011_ds62.trot 1.819e-05 65800000000.0 4.17 -6.3e-11 0.08791 2.0 [50.2, 0.011052, -940000.0, 0.0] +HP_2011_ds62.trov 1.738e-05 65800000000.0 4.17 -6.3e-11 0.080929375 1.875 [51.1, 0.008307, -669700.0, 0.0] +HP_2011_ds62.ts 0.000268 76000000000.0 4.1 -5.4e-11 0.81551148 41.0 [1244.8, 0.024348, -11965000.0, -8112.1] +HP_2011_ds62.ty 0.00017039 95000000000.0 4.09 -4.3e-11 0.4885746 22.0 [741.7, -0.005345, -1434600.0, -5878.5] +HP_2011_ds62.usp 4.682e-05 185700000000.0 4.05 -2.2e-11 0.2235546 7.0 [-102.6, 0.14252, -9144500.0, 5270.7] +HP_2011_ds62.vsv 0.000852 125500000000.0 4.8 -3.8e-11 2.86945216 137.0 [4488.0, -0.057952, -22269300.0, -33478.0] +HP_2011_ds62.wa 0.00010844 90000000000.0 4.0 -4.4e-11 0.3345332 15.0 [499.1, 0.0, 0.0, -4350.1] +HP_2011_ds62.wal 3.7633e-05 79500000000.0 4.1 -5.2e-11 0.1161617 5.0 [159.3, 0.0, -967300.0, -1075.4] +HP_2011_ds62.wo 3.993e-05 79500000000.0 4.1 -5.2e-11 0.1161617 5.0 [159.3, 0.0, -967300.0, -1075.4] +HP_2011_ds62.wrk 0.0001904 86000000000.0 4.09 -4.8e-11 0.43440636 25.0 [838.3, -0.02146, -2272000.0, -7292.3] +HP_2011_ds62.zo 0.00013575 104400000000.0 4.0 -3.8e-11 0.45435714 22.0 [662.0, 0.010416, -6006400.0, -4260.7] +HP_2011_ds62.zrc 3.926e-05 230100000000.0 4.04 -1.8e-11 0.1833071 6.0 [232.0, -0.014405, 0.0, -2238.2] Name (cork equation of state) cork_params cork_T cork_P Cp HP_2011_fluids.CH4 [[54.5963, -8.6392], [0.918301], [-0.0330558, 0.00230524], [0.000693054, -8.38293e-05]] 190.6 4600000.0 [150.1, 0.002063, 3427700.0, -2650.4] HP_2011_fluids.CO2 [[54.5963, -8.6392], [0.918301], [-0.0330558, 0.00230524], [0.000693054, -8.38293e-05]] 304.2 7380000.0 [87.8, -0.002644, 706400.0, -998.9] @@ -502,379 +502,504 @@ HP_2011_fluids.H2 [[54.5963, -8.6392], [0.918301], [-0.0330558, 0.0 HP_2011_fluids.H2S [[54.5963, -8.6392], [0.918301], [-0.0330558, 0.00230524], [0.000693054, -8.38293e-05]] 373.15 8937000.0 [47.4, 0.01024, 615900.0, -397.8] HP_2011_fluids.O2 [[54.5963, -8.6392], [0.918301], [-0.0330558, 0.00230524], [0.000693054, -8.38293e-05]] 0.0 100000.0 [48.3, -0.000691, 499200.0, -420.7] HP_2011_fluids.S2 [[54.5963, -8.6392], [0.918301], [-0.0330558, 0.00230524], [0.000693054, -8.38293e-05]] 1314.0 21000000.0 [37.1, 0.002398, -161000.0, -65.0] -Name (hp_tmt equation of state) V_0 K_0 Kprime_0 Kdprime_0 molar_mass n Cp -JH_2015.Cu (HP_2011_ds62.Cu) 7.11e-06 1.625e+11 4.24 -2.6e-11 0.063546 1.0 [12.4, 0.00922, -379900.0, 233.5] -JH_2015.Ni (HP_2011_ds62.Ni) 6.59e-06 1.905e+11 4.25 -2.2e-11 0.0586934 1.0 [49.8, 0.0, 585900.0, -533.9] -JH_2015.NiO (HP_2011_ds62.NiO) 1.097e-05 2e+11 3.94 -2e-11 0.0746928 2.0 [47.7, 0.007824, -392500.0, 0.0] -JH_2015.S (HP_2011_ds62.S) 1.551e-05 14500000000.0 7.0 -4.8e-10 0.032065 1.0 [56.6, -0.004557, 638000.0, -681.8] -JH_2015.ab (HP_2011_ds62.ab) 0.00010067 54100000000.0 5.91 -1.09e-10 0.262223 13.0 [452.0, -0.013364, -1275900.0, -3953.6] -JH_2015.abh (HP_2011_ds62.abh) 0.00010105 54100000000.0 5.91 -1.09e-10 0.262223 13.0 [452.0, -0.013364, -1275900.0, -3953.6] -JH_2015.acm (HP_2011_ds62.acm) 6.459e-05 1.06e+11 4.08 -3.8e-11 0.2310022 10.0 [307.1, 0.016758, -1685500.0, -2125.8] -JH_2015.afchl (HP_2011_ds62.afchl) 0.0002157 87000000000.0 4.09 -4.7e-11 0.55422472 36.0 [1155.0, -0.000417, -4024400.0, -9952.9] -JH_2015.ak (HP_2011_ds62.ak) 9.254e-05 1.42e+11 4.06 -2.9e-11 0.2726278 12.0 [385.4, 0.003209, -247500.0, -2889.9] -JH_2015.alm (HP_2011_ds62.alm) 0.00011525 1.9e+11 2.98 -1.6e-11 0.4977473 20.0 [677.3, 0.0, -3772700.0, -5044.0] -JH_2015.ames (HP_2011_ds62.ames) 0.0002071 87000000000.0 4.09 -4.7e-11 0.55736972 36.0 [1186.0, -0.002599, -3627200.0, -10677.0] -JH_2015.amul (HP_2011_ds62.amul) 5.083e-05 1.74e+11 4.0 -2.3e-11 0.15749365 7.75 [244.8, 0.000968, -2533300.0, -1641.6] -JH_2015.an (HP_2011_ds62.an) 0.00010079 86000000000.0 4.09 -4.8e-11 0.2782072 13.0 [370.5, 0.01001, -4339100.0, -1960.6] -JH_2015.andalusite (HP_2011_ds62.andalusite) 5.153e-05 1.442e+11 6.89 -4.8e-11 0.1620455 8.0 [277.3, -0.006588, -1914100.0, -2265.6] -JH_2015.andr (HP_2011_ds62.andr) 0.00013204 1.588e+11 5.68 -3.6e-11 0.5081733 20.0 [638.6, 0.0, -4955100.0, -3989.2] -JH_2015.ank (HP_2011_ds62.ank) 6.606e-05 91400000000.0 3.88 -4.3e-11 0.2159408 10.0 [341.0, -0.001161, 0.0, -3054.8] -JH_2015.anl (HP_2011_ds62.anl) 9.74e-05 40000000000.0 4.18 -1.04e-10 0.22015398 13.0 [643.5, -0.016067, 9302300.0, -9179.6] -JH_2015.ann (HP_2011_ds62.ann) 0.00015432 51300000000.0 7.33 -1.43e-10 0.51187998 22.0 [815.7, -0.034861, 19800.0, -7466.7] -JH_2015.anth (HP_2011_ds62.anth) 0.0002654 70000000000.0 4.11 -5.9e-11 0.78082048 41.0 [1277.3, 0.025825, -9704600.0, -9074.7] -JH_2015.any (HP_2011_ds62.any) 4.594e-05 54380000000.0 4.19 -7.7e-11 0.1361406 6.0 [128.7, 0.048545, -1223000.0, -560.5] -JH_2015.apv (HP_2011_ds62.apv) 2.54e-05 2.03e+11 4.0 -2e-11 0.1019612 5.0 [139.5, 0.00589, -2460600.0, -589.2] -JH_2015.arag (HP_2011_ds62.arag) 3.415e-05 61400000000.0 5.87 -9.6e-11 0.1000869 5.0 [167.1, 0.010695, 162000.0, -1564.9] -JH_2015.atg (HP_2011_ds62.atg) 0.0017548 63100000000.0 5.92 -9.4e-11 4.53595108 291.0 [9621.0, -0.091183, -35941600.0, -83034.2] -JH_2015.bdy (HP_2011_ds62.bdy) 2.115e-05 95300000000.0 3.88 -4.1e-11 0.1232228 3.0 [103.5, -0.004547, -416200.0, -713.6] -JH_2015.bix (HP_2011_ds62.bix) 3.137e-05 2.23e+11 4.04 -1.8e-11 0.1578742 5.0 [145.1, 0.023534, 721600.0, -1008.4] -JH_2015.br (HP_2011_ds62.br) 2.463e-05 41500000000.0 6.45 -1.55e-10 0.05831968 5.0 [158.4, -0.004076, -1052300.0, -1171.3] -JH_2015.caes (HP_2011_ds62.caes) 6.05e-05 1.192e+11 5.19 -4.4e-11 0.1991879 9.5 [362.0, -0.016944, -175900.0, -3565.7] -JH_2015.cats (HP_2011_ds62.cats) 6.356e-05 1.192e+11 5.19 -4.4e-11 0.2181229 10.0 [347.6, -0.006974, -1781600.0, -2757.5] -JH_2015.cc (HP_2011_ds62.cc) 3.689e-05 73300000000.0 4.06 -5.5e-11 0.1000869 5.0 [140.9, 0.005029, -950700.0, -858.4] -JH_2015.cel (HP_2011_ds62.cel) 0.00013957 70000000000.0 4.11 -5.9e-11 0.39673548 21.0 [741.2, -0.018748, -2368800.0, -6616.9] -JH_2015.cg (HP_2011_ds62.cg) 5.603e-05 46500000000.0 4.16 -8.9e-11 0.1420544 7.0 [116.1, 0.086021, -1992700.0, 0.0] -JH_2015.cgh (HP_2011_ds62.cgh) 5.67e-05 46500000000.0 4.16 -8.9e-11 0.1420544 7.0 [229.2, 0.011876, 0.0, -1970.7] -JH_2015.chdr (HP_2011_ds62.chdr) 0.00011084 1.161e+11 4.8 -4.1e-11 0.33970588 19.0 [625.0, -0.001088, -2259900.0, -4910.7] -JH_2015.chr (HP_2011_ds62.chr) 0.00010746 62800000000.0 4.0 -6.4e-11 0.27711236 18.0 [624.7, -0.02077, -1721800.0, -5619.4] -JH_2015.chum (HP_2011_ds62.chum) 0.00019801 1.199e+11 4.58 -3.8e-11 0.62109208 33.0 [1071.0, -0.016533, -7899600.0, -7373.9] -JH_2015.clin (HP_2011_ds62.clin) 0.0002114 87000000000.0 4.09 -4.7e-11 0.55579722 36.0 [1170.8, -0.001508, -3825800.0, -10315.0] -JH_2015.coe (HP_2011_ds62.coe) 2.064e-05 97900000000.0 4.19 -4.3e-11 0.0600843 3.0 [107.8, -0.003279, -190300.0, -1041.6] -JH_2015.cor (HP_2011_ds62.cor) 2.558e-05 2.54e+11 4.34 -1.7e-11 0.1019612 5.0 [139.5, 0.00589, -2460600.0, -589.2] -JH_2015.cpv (HP_2011_ds62.cpv) 2.745e-05 2.36e+11 3.9 -1.6e-11 0.1161617 5.0 [159.3, 0.0, -967300.0, -1075.4] -JH_2015.crd (HP_2011_ds62.crd) 0.00023322 1.29e+11 4.1 -3.1e-11 0.5849527 29.0 [906.1, 0.0, -7902000.0, -6293.4] -JH_2015.crst (HP_2011_ds62.crst) 2.745e-05 16000000000.0 4.35 -2.72e-10 0.0600843 3.0 [72.7, 0.001304, -4129000.0, 0.0] -JH_2015.cstn (HP_2011_ds62.cstn) 4.818e-05 1.782e+11 4.0 -2.2e-11 0.176246 8.0 [205.6, 0.006034, -5517700.0, -352.6] -JH_2015.cumm (HP_2011_ds62.cumm) 0.0002633 70000000000.0 4.11 -5.9e-11 0.78082048 41.0 [1277.3, 0.025825, -9704600.0, -9074.7] -JH_2015.cup (HP_2011_ds62.cup) 2.344e-05 1.31e+11 5.7 -4.3e-11 0.1430914 3.0 [110.3, 0.0, 0.0, -674.8] -JH_2015.cz (HP_2011_ds62.cz) 0.0001363 1.197e+11 4.07 -3.4e-11 0.45435714 22.0 [630.9, 0.013693, -6645800.0, -3731.1] -JH_2015.daph (HP_2011_ds62.daph) 0.0002162 87000000000.0 4.09 -4.7e-11 0.71349722 36.0 [1192.0, -0.00594, -4826400.0, -9768.3] -JH_2015.deer (HP_2011_ds62.deer) 0.0005574 63000000000.0 4.12 -6.5e-11 2.1522854 90.0 [3164.4, -0.027883, -5039100.0, -26721.0] -JH_2015.di (HP_2011_ds62.di) 6.619e-05 1.192e+11 5.19 -4.4e-11 0.2165504 10.0 [314.5, 4.1e-05, -2745900.0, -2020.1] -JH_2015.diam (HP_2011_ds62.diam) 3.42e-06 4.465e+11 1.61 -3.6e-12 0.0120107 1.0 [40.0, 0.0, -28500.0, -580.5] -JH_2015.dol (HP_2011_ds62.dol) 6.429e-05 94300000000.0 3.74 -4e-11 0.1844008 10.0 [358.9, -0.004905, 0.0, -3456.2] -JH_2015.dsp (HP_2011_ds62.dsp) 1.786e-05 2.28e+11 4.04 -1.8e-11 0.05998824 4.0 [145.1, 0.008709, 584400.0, -1741.1] -JH_2015.east (HP_2011_ds62.east) 0.00014738 53000000000.0 7.33 -1.43e-10 0.41883248 22.0 [785.5, -0.038031, -2130300.0, -6893.7] -JH_2015.en (HP_2011_ds62.en) 6.262e-05 1.059e+11 8.65 -8.2e-11 0.2007774 10.0 [356.2, -0.00299, -596900.0, -3185.3] -JH_2015.ep (HP_2011_ds62.ep) 0.0001392 1.34e+11 4.0 -3e-11 0.48322064 22.0 [613.3, 0.02207, -7160000.0, -2987.7] -JH_2015.esk (HP_2011_ds62.esk) 2.909e-05 2.38e+11 4.0 -1.7e-11 0.1519904 5.0 [119.0, 0.009496, -1442000.0, -3.4] -JH_2015.fa (HP_2011_ds62.fa) 4.631e-05 1.256e+11 4.68 -3.7e-11 0.2037731 7.0 [201.1, 0.01733, -1960600.0, -900.9] -JH_2015.fact (HP_2011_ds62.fact) 0.0002842 76000000000.0 4.1 -5.4e-11 0.97006648 41.0 [1290.0, 0.029992, -8447500.0, -8947.0] -JH_2015.fak (HP_2011_ds62.fak) 2.76e-05 2.18e+11 4.55 -2.2e-11 0.1319287 5.0 [100.3, 0.013328, -4364900.0, 419.8] -JH_2015.fanth (HP_2011_ds62.fanth) 0.0002787 70000000000.0 4.11 -5.9e-11 1.00160048 41.0 [1383.1, 0.030669, -4224700.0, -11257.6] -JH_2015.fcar (HP_2011_ds62.fcar) 0.00010695 52500000000.0 4.14 -7.9e-11 0.33000476 19.0 [686.6, -0.012415, 186000.0, -6884.0] -JH_2015.fcel (HP_2011_ds62.fcel) 0.0001407 70000000000.0 4.11 -5.9e-11 0.42827548 21.0 [756.3, -0.019147, -1586100.0, -6928.7] -JH_2015.fcrd (HP_2011_ds62.fcrd) 0.0002371 1.29e+11 4.1 -3.1e-11 0.6480327 29.0 [924.0, 0.0, -7039400.0, -6439.6] -JH_2015.fctd (HP_2011_ds62.fctd) 6.98e-05 1.456e+11 4.06 -2.8e-11 0.25190518 13.0 [416.1, -0.003477, -2835900.0, -3360.3] -JH_2015.fep (HP_2011_ds62.fep) 0.0001421 1.513e+11 4.0 -2.6e-11 0.51208414 22.0 [584.7, 0.030447, -7674200.0, -2244.3] -JH_2015.fgl (HP_2011_ds62.fgl) 0.0002659 89000000000.0 4.09 -4.6e-11 0.87816308 41.0 [1762.9, -0.118992, 9423700.0, -20207.1] -JH_2015.fo (HP_2011_ds62.fo) 4.366e-05 1.285e+11 3.84 -3e-11 0.1406931 7.0 [233.3, 0.001494, -603800.0, -1869.7] -JH_2015.fper (HP_2011_ds62.fper) 1.206e-05 1.52e+11 4.9 -3.2e-11 0.0718444 2.0 [44.4, 0.00828, -1214200.0, 185.2] -JH_2015.fpm (HP_2011_ds62.fpm) 0.0002968 1.615e+11 4.05 -2.5e-11 0.97461628 51.0 [1737.2, -0.024582, -5161100.0, -14963.0] -JH_2015.fpre (HP_2011_ds62.fpre) 0.000148 1.093e+11 4.01 -3.7e-11 0.44124768 21.0 [737.1, -0.01681, -1957300.0, -6358.1] -JH_2015.fpv (HP_2011_ds62.fpv) 2.548e-05 2.81e+11 4.14 -1.6e-11 0.1319287 5.0 [133.2, 0.01083, -3661400.0, -314.7] -JH_2015.frw (HP_2011_ds62.frw) 4.203e-05 1.977e+11 4.92 -2.5e-11 0.2037731 7.0 [166.8, 0.04261, -1705400.0, -541.4] -JH_2015.fs (HP_2011_ds62.fs) 6.592e-05 1.01e+11 4.08 -4e-11 0.2638574 10.0 [398.7, -0.006579, 1290100.0, -4058.0] -JH_2015.fspr (HP_2011_ds62.fspr) 0.00019923 2.5e+11 4.04 -1.7e-11 0.815391 34.0 [1132.9, -0.007348, -10420200.0, -7036.6] -JH_2015.fst (HP_2011_ds62.fst) 0.0004488 1.8e+11 4.76 -2.6e-11 1.69169121 81.5 [2880.0, -0.056595, -10642000.0, -25373.0] -JH_2015.fstp (HP_2011_ds62.fstp) 0.00037239 51300000000.0 7.33 -1.43e-10 1.0780021 58.5 [1944.3, -0.012289, -4840200.0, -16635.0] -JH_2015.fsud (HP_2011_ds62.fsud) 0.000204 87000000000.0 4.09 -4.7e-11 0.59992522 35.0 [1466.3, -0.047365, -1182800.0, -14388.0] -JH_2015.fta (HP_2011_ds62.fta) 0.00014225 43000000000.0 6.17 -1.44e-10 0.47388568 21.0 [579.7, 0.039494, -6459300.0, -3088.1] -JH_2015.fwd (HP_2011_ds62.fwd) 4.321e-05 1.69e+11 4.35 -2.6e-11 0.2037731 7.0 [201.1, 0.01733, -1960600.0, -900.9] -JH_2015.ged (HP_2011_ds62.ged) 0.00025548 77000000000.0 4.1 -5.3e-11 0.78396548 41.0 [1307.7, 0.023642, -9307400.0, -9799.0] -JH_2015.geh (HP_2011_ds62.geh) 9.024e-05 1.08e+11 4.08 -3.8e-11 0.2742003 12.0 [405.7, -0.007099, -1188300.0, -3174.4] -JH_2015.geik (HP_2011_ds62.geik) 3.086e-05 1.7e+11 8.3 -4.9e-11 0.1201702 5.0 [151.0, 0.0, -1890400.0, -652.2] -JH_2015.gl (HP_2011_ds62.gl) 0.0002598 88300000000.0 4.09 -4.6e-11 0.78354308 41.0 [1717.5, -0.12107, 7075000.0, -19272.0] -JH_2015.glt (HP_2011_ds62.glt) 0.0001198 63000000000.0 4.0 -6.3e-11 0.37173236 18.0 [576.4, 0.002984, -3757000.0, -4166.2] -JH_2015.gph (HP_2011_ds62.gph) 5.3e-06 31200000000.0 3.9 -1.25e-10 0.0120107 1.0 [34.3, 0.0, -240700.0, -403.8] -JH_2015.gr (HP_2011_ds62.gr) 0.00012535 1.72e+11 5.53 -3.2e-11 0.4504463 20.0 [626.0, 0.0, -5779200.0, -4002.9] -JH_2015.grun (HP_2011_ds62.grun) 0.0002784 64800000000.0 4.12 -6.4e-11 1.00160048 41.0 [1383.1, 0.030669, -4224700.0, -11257.6] -JH_2015.gth (HP_2011_ds62.gth) 2.082e-05 2.5e+11 4.03 -1.6e-11 0.08885174 4.0 [139.3, 0.000147, -212700.0, -1077.8] -JH_2015.hcrd (HP_2011_ds62.hcrd) 0.00023322 1.29e+11 4.1 -3.1e-11 0.60296798 32.0 [955.3, 0.0, -8352600.0, -6301.2] -JH_2015.hed (HP_2011_ds62.hed) 6.795e-05 1.192e+11 3.97 -3.3e-11 0.2480904 10.0 [340.2, 0.000812, -1047800.0, -2646.7] -JH_2015.hem (HP_2011_ds62.hem) 3.027e-05 2.23e+11 4.04 -1.8e-11 0.1596882 5.0 [163.9, 0.0, -2257200.0, -657.6] -JH_2015.hen (HP_2011_ds62.hen) 6.099e-05 1.5e+11 5.5 -3.6e-11 0.2007774 10.0 [356.2, -0.00299, -596900.0, -3185.3] -JH_2015.herc (HP_2011_ds62.herc) 4.075e-05 1.922e+11 4.04 -2.1e-11 0.1738056 7.0 [216.7, 0.005868, -2430200.0, -1178.3] -JH_2015.heu (HP_2011_ds62.heu) 0.000317 27400000000.0 4.0 -1.46e-10 0.68672038 46.0 [1504.8, -0.033224, -2959300.0, -13297.2] -JH_2015.hlt (HP_2011_ds62.hlt) 2.702e-05 23800000000.0 5.0 -2.1e-10 0.0584428 2.0 [45.2, 0.01797, 0.0, 0.0] -JH_2015.hol (HP_2011_ds62.hol) 7.128e-05 1.8e+11 4.0 -2.2e-11 0.2783315 13.0 [417.6, -0.003617, -4748100.0, -2819.9] -JH_2015.ilm (HP_2011_ds62.ilm) 3.169e-05 1.7e+11 8.3 -4.9e-11 0.1517102 5.0 [138.9, 0.005081, -1288800.0, -463.7] -JH_2015.iron (HP_2011_ds62.iron) 7.09e-06 1.64e+11 5.16 -3.1e-11 0.055845 1.0 [46.2, 0.005159, 723100.0, -556.2] -JH_2015.jd (HP_2011_ds62.jd) 6.04e-05 1.281e+11 3.81 -3e-11 0.2021387 10.0 [319.4, 0.003616, -1173900.0, -2469.5] -JH_2015.jgd (HP_2011_ds62.jgd) 0.0003108 1.615e+11 4.05 -2.5e-11 1.11893378 51.0 [1795.4, -0.037986, -4455700.0, -14888.0] -JH_2015.kao (HP_2011_ds62.kao) 9.934e-05 64500000000.0 4.12 -6.4e-11 0.25816036 17.0 [436.7, -0.034295, -4055900.0, -2699.1] -JH_2015.kcm (HP_2011_ds62.kcm) 0.00011438 42500000000.0 2.0 -4.7e-11 0.29634678 16.0 [536.5, -0.01009, -980400.0, -4735.0] -JH_2015.kls (HP_2011_ds62.kls) 6.052e-05 51400000000.0 2.0 -3.9e-11 0.1581629 7.0 [242.0, -0.004482, -895800.0, -1935.8] -JH_2015.knor (HP_2011_ds62.knor) 0.00011738 1.743e+11 4.05 -2.3e-11 0.4531565 20.0 [613.0, 0.003606, -4178000.0, -3729.4] -JH_2015.kos (HP_2011_ds62.kos) 6.309e-05 1.308e+11 3.0 -2.3e-11 0.2271533 10.0 [309.2, 0.005419, -664600.0, -2176.6] -JH_2015.ky (HP_2011_ds62.ky) 4.414e-05 1.601e+11 4.05 -2.5e-11 0.1620455 8.0 [279.4, -0.007124, -2055600.0, -2289.4] -JH_2015.law (HP_2011_ds62.law) 0.00010132 1.229e+11 5.45 -4.4e-11 0.31423776 19.0 [687.8, 0.001566, 375900.0, -7179.2] -JH_2015.lc (HP_2011_ds62.lc) 8.826e-05 45000000000.0 5.7 -1.27e-10 0.2182472 10.0 [369.8, -0.016332, 684700.0, -3683.1] -JH_2015.lime (HP_2011_ds62.lime) 1.676e-05 1.13e+11 3.87 -3.4e-11 0.0560774 2.0 [52.4, 0.003673, -750700.0, -51.0] -JH_2015.liz (HP_2011_ds62.liz) 0.00010645 71000000000.0 3.2 -4.5e-11 0.27711236 18.0 [614.7, -0.02077, -1721800.0, -5619.4] -JH_2015.lmt (HP_2011_ds62.lmt) 0.0002037 86000000000.0 4.09 -4.8e-11 0.47043692 31.0 [1013.4, -0.021413, -2235800.0, -8806.7] -JH_2015.lot (HP_2011_ds62.lot) 1.818e-05 65800000000.0 4.17 -6.3e-11 0.08791 2.0 [50.2, 0.011052, -940000.0, 0.0] -JH_2015.lrn (HP_2011_ds62.lrn) 5.16e-05 98500000000.0 4.07 -4.1e-11 0.1722391 7.0 [247.5, -0.003206, 0.0, -2051.9] -JH_2015.ma (HP_2011_ds62.ma) 0.00012964 1e+11 4.08 -4.1e-11 0.39818368 21.0 [744.4, -0.0168, -2074400.0, -6783.2] -JH_2015.mag (HP_2011_ds62.mag) 2.803e-05 1.028e+11 5.41 -5.3e-11 0.0843139 5.0 [186.4, -0.003772, 0.0, -1886.2] -JH_2015.maj (HP_2011_ds62.maj) 0.00011457 1.6e+11 4.56 -2.8e-11 0.4015548 20.0 [713.6, -0.000997, -1158200.0, -6622.3] -JH_2015.mak (HP_2011_ds62.mak) 2.635e-05 2.11e+11 4.55 -2.2e-11 0.1003887 5.0 [147.8, 0.002015, -2395000.0, -801.8] -JH_2015.mang (HP_2011_ds62.mang) 1.322e-05 1.645e+11 4.46 -2.7e-11 0.0709374 2.0 [59.8, 0.0036, -31400.0, -282.6] -JH_2015.mcar (HP_2011_ds62.mcar) 0.0001059 52500000000.0 4.14 -7.9e-11 0.29846476 19.0 [683.0, -0.014054, 291000.0, -6976.4] -JH_2015.mcor (HP_2011_ds62.mcor) 2.635e-05 2.11e+11 4.55 -2.2e-11 0.1003887 5.0 [147.8, 0.002015, -2395000.0, -801.8] -JH_2015.mctd (HP_2011_ds62.mctd) 6.875e-05 1.456e+11 4.06 -2.8e-11 0.22036518 13.0 [417.4, -0.003771, -2920600.0, -3417.8] -JH_2015.me (HP_2011_ds62.me) 0.00033985 87000000000.0 4.09 -4.7e-11 0.9347085 44.0 [1359.0, 0.036442, -8594700.0, -9598.2] -JH_2015.merw (HP_2011_ds62.merw) 9.847e-05 1.2e+11 4.07 -3.4e-11 0.3287052 14.0 [417.5, 0.008117, -2923000.0, -2320.3] -JH_2015.mft (HP_2011_ds62.mft) 4.457e-05 1.857e+11 4.05 -2.2e-11 0.1999926 7.0 [270.5, -0.007505, -999200.0, -2022.4] -JH_2015.mgts (HP_2011_ds62.mgts) 6.05e-05 1.028e+11 8.55 -8.3e-11 0.2023499 10.0 [371.4, -0.004082, -398400.0, -3547.1] -JH_2015.mic (HP_2011_ds62.mic) 0.00010871 58300000000.0 4.02 -6.9e-11 0.2783315 13.0 [448.8, -0.010075, -1007300.0, -3973.1] -JH_2015.minm (HP_2011_ds62.minm) 0.00014291 43000000000.0 6.17 -1.44e-10 0.37926568 21.0 [622.2, 0.0, -6385500.0, -3916.3] -JH_2015.minn (HP_2011_ds62.minn) 0.00014851 43000000000.0 6.17 -1.44e-10 0.47388568 21.0 [579.7, 0.039494, -6459300.0, -3088.1] -JH_2015.mnbi (HP_2011_ds62.mnbi) 0.00015264 53000000000.0 7.33 -1.43e-10 0.50915898 22.0 [809.9, -0.059213, -1514400.0, -6998.7] -JH_2015.mnchl (HP_2011_ds62.mnchl) 0.0002259 87000000000.0 4.09 -4.7e-11 0.70896222 36.0 [1136.5, -0.005243, -5548100.0, -8911.5] -JH_2015.mncrd (HP_2011_ds62.mncrd) 0.00024027 1.29e+11 4.1 -3.1e-11 0.6462187 29.0 [886.5, 0.0, -8840000.0, -5590.4] -JH_2015.mnctd (HP_2011_ds62.mnctd) 7.175e-05 1.456e+11 4.06 -2.8e-11 0.25099818 13.0 [464.4, -0.012654, -1147200.0, -4341.0] -JH_2015.mnst (HP_2011_ds62.mnst) 0.0004546 1.8e+11 4.76 -2.6e-11 1.68806321 81.5 [2873.3, -0.089064, -12688000.0, -24749.0] -JH_2015.mont (HP_2011_ds62.mont) 5.148e-05 1.134e+11 3.87 -3.4e-11 0.1564661 7.0 [250.7, -0.010433, -797200.0, -1996.1] -JH_2015.mpm (HP_2011_ds62.mpm) 0.0002955 1.615e+11 4.05 -2.5e-11 0.94307628 51.0 [1720.8, -0.024928, -5998700.0, -14620.3] -JH_2015.mpv (HP_2011_ds62.mpv) 2.445e-05 2.51e+11 4.14 -1.6e-11 0.1003887 5.0 [149.3, 0.002918, -2983000.0, -799.1] -JH_2015.mrw (HP_2011_ds62.mrw) 3.949e-05 1.781e+11 4.35 -2.4e-11 0.1406931 7.0 [213.3, 0.00269, -1410400.0, -1495.9] -JH_2015.mst (HP_2011_ds62.mst) 0.0004426 1.684e+11 4.05 -2.4e-11 1.56553121 81.5 [2820.5, -0.059366, -13774000.0, -24126.0] -JH_2015.mstp (HP_2011_ds62.mstp) 0.00036577 51300000000.0 7.33 -1.43e-10 0.9203021 58.5 [1862.2, -0.014018, -8983100.0, -14923.0] -JH_2015.mt (HP_2011_ds62.mt) 4.452e-05 1.857e+11 4.05 -2.2e-11 0.2315326 7.0 [262.5, -0.007205, -1926200.0, -1655.7] -JH_2015.mu (HP_2011_ds62.mu) 0.00014083 49000000000.0 4.15 -8.5e-11 0.39830798 21.0 [756.4, -0.01984, -2170000.0, -6979.2] -JH_2015.mwd (HP_2011_ds62.mwd) 4.051e-05 1.726e+11 3.84 -2.2e-11 0.1406931 7.0 [208.7, 0.003942, -1709500.0, -1302.8] -JH_2015.naph (HP_2011_ds62.naph) 0.0001445 51300000000.0 7.33 -1.43e-10 0.40115148 22.0 [773.5, -0.040229, -2597900.0, -6512.6] -JH_2015.ne (HP_2011_ds62.ne) 5.419e-05 46500000000.0 4.16 -8.9e-11 0.1420544 7.0 [272.7, -0.012398, 0.0, -2763.1] -JH_2015.osfa (HP_2011_ds62.osfa) 0.0003845 1.29e+11 4.1 -3.1e-11 1.0465328 48.0 [1558.6, -0.011359, -9476500.0, -11845.0] -JH_2015.osma (HP_2011_ds62.osma) 0.00037893 1.29e+11 4.1 -3.1e-11 0.9834528 48.0 [1540.7, -0.011359, -10339000.0, -11699.0] -JH_2015.osmm (HP_2011_ds62.osmm) 0.0003844 1.29e+11 4.1 -3.1e-11 0.9818803 48.0 [1525.5, -0.010267, -10538000.0, -11337.0] -JH_2015.pa (HP_2011_ds62.pa) 0.00013211 51500000000.0 6.51 -1.26e-10 0.38219948 21.0 [803.0, -0.03158, 217000.0, -8151.0] -JH_2015.parg (HP_2011_ds62.parg) 0.0002719 91200000000.0 4.09 -4.5e-11 0.83582478 42.0 [1280.2, 0.022997, -12359500.0, -8065.8] -JH_2015.per (HP_2011_ds62.per) 1.125e-05 1.616e+11 3.95 -2.4e-11 0.0403044 2.0 [60.5, 0.000362, -535800.0, -299.2] -JH_2015.phA (HP_2011_ds62.phA) 0.00015422 1.45e+11 4.06 -2.8e-11 0.45634524 29.0 [962.0, -0.011521, -4517800.0, -7724.7] -JH_2015.phl (HP_2011_ds62.phl) 0.00014964 51300000000.0 7.33 -1.43e-10 0.41725998 22.0 [770.3, -0.036939, -2328900.0, -6531.6] -JH_2015.picr (HP_2011_ds62.picr) 4.356e-05 1.922e+11 4.04 -2.1e-11 0.1922948 7.0 [196.1, 0.005398, -3126000.0, -616.9] -JH_2015.pmt (HP_2011_ds62.pmt) 0.0001382 1.197e+11 4.07 -3.4e-11 0.48231364 22.0 [569.8, 0.02779, -5442900.0, -2812.6] -JH_2015.pnt (HP_2011_ds62.pnt) 3.288e-05 1.7e+11 8.3 -4.9e-11 0.1508032 5.0 [143.5, 0.003373, -1940700.0, -407.6] -JH_2015.pre (HP_2011_ds62.pre) 0.00014026 1.093e+11 4.01 -3.7e-11 0.41238418 21.0 [724.9, -0.013865, -2059000.0, -6323.9] -JH_2015.pren (HP_2011_ds62.pren) 6.476e-05 1.059e+11 8.65 -8.2e-11 0.2007774 10.0 [356.2, -0.00299, -596900.0, -3185.3] -JH_2015.prl (HP_2011_ds62.prl) 0.00012804 37000000000.0 10.0 -2.71e-10 0.36031368 20.0 [784.5, -0.042948, 1251000.0, -8495.9] -JH_2015.pswo (HP_2011_ds62.pswo) 4.008e-05 1.1e+11 4.08 -3.7e-11 0.1161617 5.0 [157.8, 0.0, -967300.0, -1075.4] -JH_2015.pxmn (HP_2011_ds62.pxmn) 3.472e-05 84000000000.0 4.0 -4.8e-11 0.1310217 5.0 [138.4, 0.004088, -1936000.0, -538.9] -JH_2015.py (HP_2011_ds62.py) 0.00011313 1.743e+11 4.05 -2.3e-11 0.4031273 20.0 [633.5, 0.0, -5196100.0, -4315.2] -JH_2015.pyr (HP_2011_ds62.pyr) 2.394e-05 1.395e+11 4.09 -2.9e-11 0.119975 3.0 [37.3, 0.026715, -1817000.0, 649.3] -JH_2015.q (HP_2011_ds62.q) 2.269e-05 73000000000.0 6.0 -8.2e-11 0.0600843 3.0 [92.9, -0.000642, -714900.0, -716.1] -JH_2015.rhc (HP_2011_ds62.rhc) 3.107e-05 95300000000.0 3.88 -4.1e-11 0.1149469 5.0 [169.5, 0.0, 0.0, -1534.3] -JH_2015.rhod (HP_2011_ds62.rhod) 3.494e-05 84000000000.0 4.0 -4.8e-11 0.1310217 5.0 [138.4, 0.004088, -1936000.0, -538.9] -JH_2015.rieb (HP_2011_ds62.rieb) 0.0002749 89000000000.0 4.09 -4.6e-11 0.93589008 41.0 [1787.3, -0.124882, 9627100.0, -20275.5] -JH_2015.rnk (HP_2011_ds62.rnk) 9.651e-05 95000000000.0 4.09 -4.3e-11 0.2884008 12.0 [372.3, -0.002893, -2462400.0, -2181.3] -JH_2015.ru (HP_2011_ds62.ru) 1.882e-05 2.22e+11 4.24 -1.9e-11 0.0798658 3.0 [90.4, 0.0029, 0.0, -623.8] -JH_2015.san (HP_2011_ds62.san) 0.00010871 58300000000.0 4.02 -6.9e-11 0.2783315 13.0 [448.8, -0.010075, -1007300.0, -3973.1] -JH_2015.sdl (HP_2011_ds62.sdl) 0.0004213 46500000000.0 4.16 -8.9e-11 0.969212 46.0 [1532.7, 0.047747, -2972800.0, -12427.0] -JH_2015.sid (HP_2011_ds62.sid) 2.943e-05 1.2e+11 4.07 -3.4e-11 0.1158539 5.0 [168.4, 0.0, 0.0, -1483.6] -JH_2015.sill (HP_2011_ds62.sill) 4.986e-05 1.64e+11 5.06 -3.1e-11 0.1620455 8.0 [280.2, -0.0069, -1375700.0, -2399.4] -JH_2015.smul (HP_2011_ds62.smul) 4.987e-05 1.74e+11 4.0 -2.3e-11 0.1620455 8.0 [280.2, -0.0069, -1375700.0, -2399.4] -JH_2015.sp (HP_2011_ds62.sp) 3.978e-05 1.922e+11 4.04 -2.1e-11 0.1422656 7.0 [222.9, 0.006127, -1686000.0, -1551.0] -JH_2015.sph (HP_2011_ds62.sph) 5.565e-05 1.017e+11 9.85 -9.7e-11 0.1960275 8.0 [227.9, 0.002924, -3539500.0, -894.3] -JH_2015.spr4 (HP_2011_ds62.spr4) 0.000199 2.5e+11 4.04 -1.6e-11 0.689231 34.0 [1133.1, -0.007596, -8816600.0, -8180.6] -JH_2015.spr5 (HP_2011_ds62.spr5) 0.0001975 2.5e+11 4.04 -1.6e-11 0.6908035 34.0 [1103.4, 0.001015, -10957000.0, -7409.2] -JH_2015.spss (HP_2011_ds62.spss) 0.00011792 1.74e+11 6.68 -3.8e-11 0.4950263 20.0 [646.9, 0.0, -4525800.0, -4452.8] -JH_2015.spu (HP_2011_ds62.spu) 0.00014697 95000000000.0 4.09 -4.3e-11 0.4445651 19.0 [614.1, -0.003508, -2493100.0, -4168.0] -JH_2015.stlb (HP_2011_ds62.stlb) 0.0003287 86000000000.0 4.09 -4.8e-11 0.70473566 49.0 [1588.4, -0.032043, -3071600.0, -13966.9] -JH_2015.stv (HP_2011_ds62.stv) 1.401e-05 3.09e+11 4.6 -1.5e-11 0.0600843 3.0 [68.1, 0.00601, -1978200.0, -82.1] -JH_2015.sud (HP_2011_ds62.sud) 0.000203 87000000000.0 4.09 -4.7e-11 0.53684522 35.0 [1436.1, -0.048749, -2748500.0, -13764.0] -JH_2015.syv (HP_2011_ds62.syv) 3.752e-05 17000000000.0 5.0 -2.94e-10 0.0745513 2.0 [46.2, 0.01797, 0.0, 0.0] -JH_2015.ta (HP_2011_ds62.ta) 0.00013665 43000000000.0 6.17 -1.44e-10 0.37926568 21.0 [622.2, 0.0, -6385500.0, -3916.3] -JH_2015.tap (HP_2011_ds62.tap) 0.0001345 37000000000.0 10.0 -2.71e-10 0.36031368 20.0 [784.5, -0.042948, 1251000.0, -8495.9] -JH_2015.tats (HP_2011_ds62.tats) 0.0001351 43000000000.0 6.17 -1.44e-10 0.38083818 21.0 [549.5, 0.036324, -8606600.0, -2515.3] -JH_2015.ten (HP_2011_ds62.ten) 1.222e-05 2e+11 3.94 -2e-11 0.0795454 2.0 [31.0, 0.01374, -1258000.0, 369.3] -JH_2015.teph (HP_2011_ds62.teph) 4.899e-05 1.256e+11 4.68 -3.7e-11 0.2019591 7.0 [219.6, 0.0, -1292700.0, -1308.3] -JH_2015.tpz (HP_2011_ds62.tpz) 5.339e-05 1.315e+11 4.06 -3.1e-11 0.18006078 11.0 [387.7, -0.00712, -857200.0, -3744.2] -JH_2015.tr (HP_2011_ds62.tr) 0.0002727 76200000000.0 4.1 -5.4e-11 0.81236648 41.0 [1260.2, 0.00383, -11455000.0, -8237.6] -JH_2015.trd (HP_2011_ds62.trd) 2.8e-05 15000000000.0 4.36 -2.91e-10 0.0600843 3.0 [74.9, 0.0031, -1174000.0, -236.7] -JH_2015.tro (HP_2011_ds62.tro) 1.819e-05 65800000000.0 4.17 -6.3e-11 0.08791 2.0 [50.2, 0.011052, -940000.0, 0.0] -JH_2015.trot (HP_2011_ds62.trot) 1.819e-05 65800000000.0 4.17 -6.3e-11 0.08791 2.0 [50.2, 0.011052, -940000.0, 0.0] -JH_2015.trov (HP_2011_ds62.trov) 1.738e-05 65800000000.0 4.17 -6.3e-11 0.080929375 1.875 [51.1, 0.008307, -669700.0, 0.0] -JH_2015.ts (HP_2011_ds62.ts) 0.000268 76000000000.0 4.1 -5.4e-11 0.81551148 41.0 [1244.8, 0.024348, -11965000.0, -8112.1] -JH_2015.ty (HP_2011_ds62.ty) 0.00017039 95000000000.0 4.09 -4.3e-11 0.4885746 22.0 [741.7, -0.005345, -1434600.0, -5878.5] -JH_2015.usp (HP_2011_ds62.usp) 4.682e-05 1.857e+11 4.05 -2.2e-11 0.2235546 7.0 [-102.6, 0.14252, -9144500.0, 5270.7] -JH_2015.vsv (HP_2011_ds62.vsv) 0.000852 1.255e+11 4.8 -3.8e-11 2.86945216 137.0 [4488.0, -0.057952, -22269300.0, -33478.0] -JH_2015.wa (HP_2011_ds62.wa) 0.00010844 90000000000.0 4.0 -4.4e-11 0.3345332 15.0 [499.1, 0.0, 0.0, -4350.1] -JH_2015.wal (HP_2011_ds62.wal) 3.7633e-05 79500000000.0 4.1 -5.2e-11 0.1161617 5.0 [159.3, 0.0, -967300.0, -1075.4] -JH_2015.wo (HP_2011_ds62.wo) 3.993e-05 79500000000.0 4.1 -5.2e-11 0.1161617 5.0 [159.3, 0.0, -967300.0, -1075.4] -JH_2015.wrk (HP_2011_ds62.wrk) 0.0001904 86000000000.0 4.09 -4.8e-11 0.43440636 25.0 [838.3, -0.02146, -2272000.0, -7292.3] -JH_2015.zo (HP_2011_ds62.zo) 0.00013575 1.044e+11 4.0 -3.8e-11 0.45435714 22.0 [662.0, 0.010416, -6006400.0, -4260.7] -JH_2015.zrc (HP_2011_ds62.zrc) 3.926e-05 2.301e+11 4.04 -1.8e-11 0.1833071 6.0 [232.0, -0.014405, 0.0, -2238.2] -Name (slb3 equation of state) V_0 K_0 Kprime_0 G_0 Gprime_0 molar_mass n Debye_0 grueneisen_0 q_0 eta_s_0 -KMFBZ_2017.al_al_perovskite 2.494e-05 2.58e+11 4.1 1.71e+11 1.5 0.1019612 5.0 886.0 1.57 1.1 2.5 -KMFBZ_2017.ca_perovskite 2.754e-05 2.36e+11 3.9 1.57e+11 2.2 0.1161617 5.0 802.0 1.89 0.9 1.3 -KMFBZ_2017.fe_al_perovskite 2.69e-05 2.2e+11 1.3 96000000000.0 3.4 0.1308247 5.0 886.0 1.57 1.1 2.5 -KMFBZ_2017.fe_si_perovskite 2.534e-05 2.72e+11 4.1 12.33 1.4 0.1319287 5.0 871.0 1.57 1.1 2.3 -KMFBZ_2017.hcp_iron 6.73e-06 1.64e+11 4.0 81500000000.0 1.9 0.055845 1.0 422.0 1.71 1.4 7 -KMFBZ_2017.mg_si_perovskite 2.4445e-05 2.51e+11 4.1 1.73e+11 1.7 0.1003887 5.0 905.0 1.57 1.1 2.3 -KMFBZ_2017.periclase 1.124e-05 1.602e+11 3.99 1.31e+11 2.1 0.0403044 2.0 767.0 1.36 1.7 2.8 -KMFBZ_2017.wuestite 1.226e-05 1.49e+11 3.6 60000000000.0 1.8 0.0718444 2.0 454.0 1.53 1.7 0.6 -Name (mgd2 equation of state) V_0 K_0 Kprime_0 G_0 Gprime_0 molar_mass n Debye_0 grueneisen_0 q_0 eta_s_0 -Matas_etal_2007.al_bridgmanite (Matas_etal_2007.al_perovskite) 2.458e-05 2.49e+11 4.0 1.65e+11 1.8 0.1005 5 1021.0 1.48 1.4 -Matas_etal_2007.al_perovskite 2.458e-05 2.49e+11 4.0 1.65e+11 1.8 0.1005 5 1021.0 1.48 1.4 -Matas_etal_2007.ca_bridgmanite (Matas_etal_2007.ca_perovskite) 2.745e-05 2.36e+11 3.9 1.65e+11 2.46 0.11616 5 984.0 1.53 1.6 -Matas_etal_2007.ca_perovskite 2.745e-05 2.36e+11 3.9 1.65e+11 2.46 0.11616 5 984.0 1.53 1.6 -Matas_etal_2007.fe_bridgmanite (Matas_etal_2007.fe_perovskite) 2.534e-05 2.5e+11 4.0 1.35e+11 1.3 0.1319 5 841.0 1.48 1.4 -Matas_etal_2007.fe_perovskite 2.534e-05 2.5e+11 4.0 1.35e+11 1.3 0.1319 5 841.0 1.48 1.4 -Matas_etal_2007.mg_bridgmanite (Matas_etal_2007.mg_perovskite) 2.443e-05 2.5e+11 4.0 1.75e+11 1.8 0.102 5 1070.0 1.48 1.4 -Matas_etal_2007.mg_perovskite 2.443e-05 2.5e+11 4.0 1.75e+11 1.8 0.102 5 1070.0 1.48 1.4 -Matas_etal_2007.periclase 1.125e-05 1.601e+11 3.83 1.3e+11 2.2 0.0403 2 673.0 1.41 1.3 -Matas_etal_2007.wuestite 1.226e-05 1.601e+11 3.83 46000000000.0 0.6 0.0718 2 673.0 1.41 1.3 -Name (slb2 equation of state) V_0 K_0 Kprime_0 G_0 Gprime_0 molar_mass n Debye_0 grueneisen_0 q_0 eta_s_0 -Murakami_2013.fe_bridgmanite (Murakami_2013.fe_perovskite) 2.549e-05 2.81e+11 4.1 1.38e+11 1.7 0.1319 5 841.0 1.48 1.4 2.1 -Murakami_2013.fe_perovskite 2.549e-05 2.81e+11 4.1 1.38e+11 1.7 0.1319 5 841.0 1.48 1.4 2.1 -Murakami_2013.mg_bridgmanite (Murakami_2013.mg_perovskite) 2.445e-05 2.53e+11 4.1 1.729e+11 1.56 0.1 5 1100.0 1.4 1.4 2.6 -Murakami_2013.mg_perovskite 2.445e-05 2.53e+11 4.1 1.729e+11 1.56 0.1 5 1100.0 1.4 1.4 2.6 -Murakami_2013.periclase 1.124e-05 1.61e+11 3.9 1.309e+11 1.92 0.0403 2 773.0 1.5 1.5 2.3 -Murakami_2013.wuestite 1.206e-05 1.52e+11 4.9 47000000000.0 0.7 0.0718 2 455.0 1.28 1.5 0.8 -Name (slb2 equation of state) V_0 K_0 Kprime_0 G_0 Gprime_0 molar_mass n Debye_0 grueneisen_0 q_0 eta_s_0 -Murakami_etal_2012.fe_bridgmanite (Murakami_etal_2012.fe_perovskite) 2.4607e-05 2.519e+11 4.01 1.647e+11 1.58 0.102 5 1054.0 1.48 1.4 2.4 -Murakami_etal_2012.fe_periclase_HS 1.1412e-05 1.591e+11 4.11 1.0543e+11 1.773 0.047 2 706.0 1.45 1.5 2.54 -Murakami_etal_2012.fe_periclase_LS 1.1171e-05 1.7e+11 4.0 1.1634e+11 1.668 0.047 2 706.0 1.45 1.5 2.54 -Murakami_etal_2012.fe_perovskite 2.4607e-05 2.519e+11 4.01 1.647e+11 1.58 0.102 5 1054.0 1.48 1.4 2.4 -Murakami_etal_2012.mg_bridgmanite (Murakami_etal_2012.mg_perovskite) 2.445e-05 2.81e+11 4.1 1.73e+11 1.56 0.1 5 1070.0 1.48 1.4 2.4 -Murakami_etal_2012.mg_periclase 1.124e-05 1.61e+11 3.9 1.31e+11 1.92 0.0403 2 773.0 1.5 1.5 3.0 -Murakami_etal_2012.mg_perovskite 2.445e-05 2.81e+11 4.1 1.73e+11 1.56 0.1 5 1070.0 1.48 1.4 2.4 -Name (slb3 equation of state) V_0 K_0 Kprime_0 G_0 Gprime_0 molar_mass n Debye_0 grueneisen_0 q_0 eta_s_0 -Murakami_etal_2012.fe_periclase_HS_3rd 1.1412e-05 1.591e+11 4.11 1.2935e+11 1.993 0.0469 2 706.0 1.45 1.5 2.54 -Murakami_etal_2012.fe_periclase_LS_3rd 1.1171e-05 1.7e+11 4.0 1.5167e+11 1.754 0.0469 2 706.0 1.45 1.5 2.54 -Murakami_etal_2012.mg_bridgmanite_3rdorder (Murakami_etal_2012.mg_perovskite_3rdorder) 2.445e-05 2.81e+11 4.1 1.7142e+11 1.83 0.1 5 1070.0 1.48 1.4 2.4 -Murakami_etal_2012.mg_perovskite_3rdorder 2.445e-05 2.81e+11 4.1 1.7142e+11 1.83 0.1 5 1070.0 1.48 1.4 2.4 +Name (hp_tmt equation of state) V_0 K_0 Kprime_0 Kdprime_0 molar_mass n Cp +JH_2015.Cu (HP_2011_ds62.Cu) 7.11e-06 162500000000.0 4.24 -2.6e-11 0.063546 1.0 [12.4, 0.00922, -379900.0, 233.5] +JH_2015.Ni (HP_2011_ds62.Ni) 6.59e-06 190500000000.0 4.25 -2.2e-11 0.0586934 1.0 [49.8, 0.0, 585900.0, -533.9] +JH_2015.NiO (HP_2011_ds62.NiO) 1.097e-05 200000000000.0 3.94 -2e-11 0.0746928 2.0 [47.7, 0.007824, -392500.0, 0.0] +JH_2015.S (HP_2011_ds62.S) 1.551e-05 14500000000.0 7.0 -4.8e-10 0.032065 1.0 [56.6, -0.004557, 638000.0, -681.8] +JH_2015.ab (HP_2011_ds62.ab) 0.00010067 54100000000.0 5.91 -1.09e-10 0.262223 13.0 [452.0, -0.013364, -1275900.0, -3953.6] +JH_2015.abh (HP_2011_ds62.abh) 0.00010105 54100000000.0 5.91 -1.09e-10 0.262223 13.0 [452.0, -0.013364, -1275900.0, -3953.6] +JH_2015.acm (HP_2011_ds62.acm) 6.459e-05 106000000000.0 4.08 -3.8e-11 0.2310022 10.0 [307.1, 0.016758, -1685500.0, -2125.8] +JH_2015.afchl (HP_2011_ds62.afchl) 0.0002157 87000000000.0 4.09 -4.7e-11 0.55422472 36.0 [1155.0, -0.000417, -4024400.0, -9952.9] +JH_2015.ak (HP_2011_ds62.ak) 9.254e-05 142000000000.0 4.06 -2.9e-11 0.2726278 12.0 [385.4, 0.003209, -247500.0, -2889.9] +JH_2015.alm (HP_2011_ds62.alm) 0.00011525 190000000000.0 2.98 -1.6e-11 0.4977473 20.0 [677.3, 0.0, -3772700.0, -5044.0] +JH_2015.ames (HP_2011_ds62.ames) 0.0002071 87000000000.0 4.09 -4.7e-11 0.55736972 36.0 [1186.0, -0.002599, -3627200.0, -10677.0] +JH_2015.amul (HP_2011_ds62.amul) 5.083e-05 174000000000.0 4.0 -2.3e-11 0.15749365 7.75 [244.8, 0.000968, -2533300.0, -1641.6] +JH_2015.an (HP_2011_ds62.an) 0.00010079 86000000000.0 4.09 -4.8e-11 0.2782072 13.0 [370.5, 0.01001, -4339100.0, -1960.6] +JH_2015.andalusite (HP_2011_ds62.andalusite) 5.153e-05 144200000000.0 6.89 -4.8e-11 0.1620455 8.0 [277.3, -0.006588, -1914100.0, -2265.6] +JH_2015.andr (HP_2011_ds62.andr) 0.00013204 158800000000.0 5.68 -3.6e-11 0.5081733 20.0 [638.6, 0.0, -4955100.0, -3989.2] +JH_2015.ank (HP_2011_ds62.ank) 6.606e-05 91400000000.0 3.88 -4.3e-11 0.2159408 10.0 [341.0, -0.001161, 0.0, -3054.8] +JH_2015.anl (HP_2011_ds62.anl) 9.74e-05 40000000000.0 4.18 -1.04e-10 0.22015398 13.0 [643.5, -0.016067, 9302300.0, -9179.6] +JH_2015.ann (HP_2011_ds62.ann) 0.00015432 51300000000.0 7.33 -1.43e-10 0.51187998 22.0 [815.7, -0.034861, 19800.0, -7466.7] +JH_2015.anth (HP_2011_ds62.anth) 0.0002654 70000000000.0 4.11 -5.9e-11 0.78082048 41.0 [1277.3, 0.025825, -9704600.0, -9074.7] +JH_2015.any (HP_2011_ds62.any) 4.594e-05 54379999999.99999 4.19 -7.7e-11 0.1361406 6.0 [128.7, 0.048545, -1223000.0, -560.5] +JH_2015.apv (HP_2011_ds62.apv) 2.54e-05 203000000000.0 4.0 -2e-11 0.1019612 5.0 [139.5, 0.00589, -2460600.0, -589.2] +JH_2015.arag (HP_2011_ds62.arag) 3.415e-05 61400000000.0 5.87 -9.6e-11 0.1000869 5.0 [167.1, 0.010695, 162000.0, -1564.9] +JH_2015.atg (HP_2011_ds62.atg) 0.0017548 63100000000.0 5.92 -9.4e-11 4.53595108 291.0 [9621.0, -0.091183, -35941600.0, -83034.2] +JH_2015.bdy (HP_2011_ds62.bdy) 2.115e-05 95300000000.0 3.88 -4.1e-11 0.1232228 3.0 [103.5, -0.004547, -416200.0, -713.6] +JH_2015.bix (HP_2011_ds62.bix) 3.137e-05 223000000000.0 4.04 -1.8e-11 0.1578742 5.0 [145.1, 0.023534, 721600.0, -1008.4] +JH_2015.br (HP_2011_ds62.br) 2.463e-05 41500000000.0 6.45 -1.55e-10 0.05831968 5.0 [158.4, -0.004076, -1052300.0, -1171.3] +JH_2015.caes (HP_2011_ds62.caes) 6.05e-05 119200000000.0 5.19 -4.4e-11 0.1991879 9.5 [362.0, -0.016944, -175900.0, -3565.7] +JH_2015.cats (HP_2011_ds62.cats) 6.356e-05 119200000000.0 5.19 -4.4e-11 0.2181229 10.0 [347.6, -0.006974, -1781600.0, -2757.5] +JH_2015.cc (HP_2011_ds62.cc) 3.689e-05 73300000000.0 4.06 -5.5e-11 0.1000869 5.0 [140.9, 0.005029, -950700.0, -858.4] +JH_2015.cel (HP_2011_ds62.cel) 0.00013957 70000000000.0 4.11 -5.9e-11 0.39673548 21.0 [741.2, -0.018748, -2368800.0, -6616.9] +JH_2015.cg (HP_2011_ds62.cg) 5.603e-05 46500000000.0 4.16 -8.9e-11 0.1420544 7.0 [116.1, 0.086021, -1992700.0, 0.0] +JH_2015.cgh (HP_2011_ds62.cgh) 5.67e-05 46500000000.0 4.16 -8.9e-11 0.1420544 7.0 [229.2, 0.011876, 0.0, -1970.7] +JH_2015.chdr (HP_2011_ds62.chdr) 0.00011084 116100000000.0 4.8 -4.1e-11 0.33970588 19.0 [625.0, -0.001088, -2259900.0, -4910.7] +JH_2015.chr (HP_2011_ds62.chr) 0.00010746 62800000000.0 4.0 -6.4e-11 0.27711236 18.0 [624.7, -0.02077, -1721800.0, -5619.4] +JH_2015.chum (HP_2011_ds62.chum) 0.00019801 119900000000.0 4.58 -3.8e-11 0.62109208 33.0 [1071.0, -0.016533, -7899600.0, -7373.9] +JH_2015.clin (HP_2011_ds62.clin) 0.0002114 87000000000.0 4.09 -4.7e-11 0.55579722 36.0 [1170.8, -0.001508, -3825800.0, -10315.0] +JH_2015.coe (HP_2011_ds62.coe) 2.064e-05 97900000000.0 4.19 -4.3e-11 0.0600843 3.0 [107.8, -0.003279, -190300.0, -1041.6] +JH_2015.cor (HP_2011_ds62.cor) 2.558e-05 254000000000.0 4.34 -1.7e-11 0.1019612 5.0 [139.5, 0.00589, -2460600.0, -589.2] +JH_2015.cpv (HP_2011_ds62.cpv) 2.745e-05 236000000000.0 3.9 -1.6e-11 0.1161617 5.0 [159.3, 0.0, -967300.0, -1075.4] +JH_2015.crd (HP_2011_ds62.crd) 0.00023322 129000000000.0 4.1 -3.1e-11 0.5849527 29.0 [906.1, 0.0, -7902000.0, -6293.4] +JH_2015.crst (HP_2011_ds62.crst) 2.745e-05 16000000000.0 4.35 -2.72e-10 0.0600843 3.0 [72.7, 0.001304, -4129000.0, 0.0] +JH_2015.cstn (HP_2011_ds62.cstn) 4.818e-05 178200000000.0 4.0 -2.2e-11 0.176246 8.0 [205.6, 0.006034, -5517700.0, -352.6] +JH_2015.cumm (HP_2011_ds62.cumm) 0.0002633 70000000000.0 4.11 -5.9e-11 0.78082048 41.0 [1277.3, 0.025825, -9704600.0, -9074.7] +JH_2015.cup (HP_2011_ds62.cup) 2.344e-05 131000000000.0 5.7 -4.3e-11 0.1430914 3.0 [110.3, 0.0, 0.0, -674.8] +JH_2015.cz (HP_2011_ds62.cz) 0.0001363 119700000000.0 4.07 -3.4e-11 0.45435714 22.0 [630.9, 0.013693, -6645800.0, -3731.1] +JH_2015.daph (HP_2011_ds62.daph) 0.0002162 87000000000.0 4.09 -4.7e-11 0.71349722 36.0 [1192.0, -0.00594, -4826400.0, -9768.3] +JH_2015.deer (HP_2011_ds62.deer) 0.0005574 63000000000.0 4.12 -6.5e-11 2.1522854 90.0 [3164.4, -0.027883, -5039100.0, -26721.0] +JH_2015.di (HP_2011_ds62.di) 6.619e-05 119200000000.0 5.19 -4.4e-11 0.2165504 10.0 [314.5, 4.1e-05, -2745900.0, -2020.1] +JH_2015.diam (HP_2011_ds62.diam) 3.42e-06 446500000000.0 1.61 -3.6e-12 0.0120107 1.0 [40.0, 0.0, -28500.0, -580.5] +JH_2015.dol (HP_2011_ds62.dol) 6.429e-05 94300000000.0 3.74 -4e-11 0.1844008 10.0 [358.9, -0.004905, 0.0, -3456.2] +JH_2015.dsp (HP_2011_ds62.dsp) 1.786e-05 228000000000.0 4.04 -1.8e-11 0.05998824 4.0 [145.1, 0.008709, 584400.0, -1741.1] +JH_2015.east (HP_2011_ds62.east) 0.00014738 53000000000.0 7.33 -1.43e-10 0.41883248 22.0 [785.5, -0.038031, -2130300.0, -6893.7] +JH_2015.en (HP_2011_ds62.en) 6.262e-05 105900000000.0 8.65 -8.2e-11 0.2007774 10.0 [356.2, -0.00299, -596900.0, -3185.3] +JH_2015.ep (HP_2011_ds62.ep) 0.0001392 134000000000.0 4.0 -3e-11 0.48322064 22.0 [613.3, 0.02207, -7160000.0, -2987.7] +JH_2015.esk (HP_2011_ds62.esk) 2.909e-05 238000000000.0 4.0 -1.7e-11 0.1519904 5.0 [119.0, 0.009496, -1442000.0, -3.4] +JH_2015.fa (HP_2011_ds62.fa) 4.631e-05 125600000000.0 4.68 -3.7e-11 0.2037731 7.0 [201.1, 0.01733, -1960600.0, -900.9] +JH_2015.fact (HP_2011_ds62.fact) 0.0002842 76000000000.0 4.1 -5.4e-11 0.97006648 41.0 [1290.0, 0.029992, -8447500.0, -8947.0] +JH_2015.fak (HP_2011_ds62.fak) 2.76e-05 218000000000.0 4.55 -2.2e-11 0.1319287 5.0 [100.3, 0.013328, -4364900.0, 419.8] +JH_2015.fanth (HP_2011_ds62.fanth) 0.0002787 70000000000.0 4.11 -5.9e-11 1.00160048 41.0 [1383.1, 0.030669, -4224700.0, -11257.6] +JH_2015.fcar (HP_2011_ds62.fcar) 0.00010695 52500000000.0 4.14 -7.9e-11 0.33000476 19.0 [686.6, -0.012415, 186000.0, -6884.0] +JH_2015.fcel (HP_2011_ds62.fcel) 0.0001407 70000000000.0 4.11 -5.9e-11 0.42827548 21.0 [756.3, -0.019147, -1586100.0, -6928.7] +JH_2015.fcrd (HP_2011_ds62.fcrd) 0.0002371 129000000000.0 4.1 -3.1e-11 0.6480327 29.0 [924.0, 0.0, -7039400.0, -6439.6] +JH_2015.fctd (HP_2011_ds62.fctd) 6.98e-05 145600000000.0 4.06 -2.8e-11 0.25190518 13.0 [416.1, -0.003477, -2835900.0, -3360.3] +JH_2015.fep (HP_2011_ds62.fep) 0.0001421 151300000000.0 4.0 -2.6e-11 0.51208414 22.0 [584.7, 0.030447, -7674200.0, -2244.3] +JH_2015.fgl (HP_2011_ds62.fgl) 0.0002659 89000000000.0 4.09 -4.6e-11 0.87816308 41.0 [1762.9, -0.118992, 9423700.0, -20207.1] +JH_2015.fo (HP_2011_ds62.fo) 4.366e-05 128500000000.0 3.84 -3e-11 0.1406931 7.0 [233.3, 0.001494, -603800.0, -1869.7] +JH_2015.fper (HP_2011_ds62.fper) 1.206e-05 152000000000.0 4.9 -3.2e-11 0.0718444 2.0 [44.4, 0.00828, -1214200.0, 185.2] +JH_2015.fpm (HP_2011_ds62.fpm) 0.0002968 161500000000.0 4.05 -2.5e-11 0.97461628 51.0 [1737.2, -0.024582, -5161100.0, -14963.0] +JH_2015.fpre (HP_2011_ds62.fpre) 0.000148 109300000000.0 4.01 -3.7e-11 0.44124768 21.0 [737.1, -0.01681, -1957300.0, -6358.1] +JH_2015.fpv (HP_2011_ds62.fpv) 2.548e-05 281000000000.0 4.14 -1.6e-11 0.1319287 5.0 [133.2, 0.01083, -3661400.0, -314.7] +JH_2015.frw (HP_2011_ds62.frw) 4.203e-05 197700000000.0 4.92 -2.5e-11 0.2037731 7.0 [166.8, 0.04261, -1705400.0, -541.4] +JH_2015.fs (HP_2011_ds62.fs) 6.592e-05 101000000000.0 4.08 -4e-11 0.2638574 10.0 [398.7, -0.006579, 1290100.0, -4058.0] +JH_2015.fspr (HP_2011_ds62.fspr) 0.00019923 250000000000.0 4.04 -1.7e-11 0.815391 34.0 [1132.9, -0.007348, -10420200.0, -7036.6] +JH_2015.fst (HP_2011_ds62.fst) 0.0004488 180000000000.0 4.76 -2.6e-11 1.69169121 81.5 [2880.0, -0.056595, -10642000.0, -25373.0] +JH_2015.fstp (HP_2011_ds62.fstp) 0.00037239 51300000000.0 7.33 -1.43e-10 1.0780021 58.5 [1944.3, -0.012289, -4840200.0, -16635.0] +JH_2015.fsud (HP_2011_ds62.fsud) 0.000204 87000000000.0 4.09 -4.7e-11 0.59992522 35.0 [1466.3, -0.047365, -1182800.0, -14388.0] +JH_2015.fta (HP_2011_ds62.fta) 0.00014225 43000000000.0 6.17 -1.44e-10 0.47388568 21.0 [579.7, 0.039494, -6459300.0, -3088.1] +JH_2015.fwd (HP_2011_ds62.fwd) 4.321e-05 169000000000.0 4.35 -2.6e-11 0.2037731 7.0 [201.1, 0.01733, -1960600.0, -900.9] +JH_2015.ged (HP_2011_ds62.ged) 0.00025548 77000000000.0 4.1 -5.3e-11 0.78396548 41.0 [1307.7, 0.023642, -9307400.0, -9799.0] +JH_2015.geh (HP_2011_ds62.geh) 9.024e-05 108000000000.0 4.08 -3.8e-11 0.2742003 12.0 [405.7, -0.007099, -1188300.0, -3174.4] +JH_2015.geik (HP_2011_ds62.geik) 3.086e-05 170000000000.0 8.3 -4.9e-11 0.1201702 5.0 [151.0, 0.0, -1890400.0, -652.2] +JH_2015.gl (HP_2011_ds62.gl) 0.0002598 88300000000.0 4.09 -4.6e-11 0.78354308 41.0 [1717.5, -0.12107, 7075000.0, -19272.0] +JH_2015.glt (HP_2011_ds62.glt) 0.0001198 63000000000.0 4.0 -6.3e-11 0.37173236 18.0 [576.4, 0.002984, -3757000.0, -4166.2] +JH_2015.gph (HP_2011_ds62.gph) 5.3e-06 31200000000.0 3.9 -1.25e-10 0.0120107 1.0 [34.3, 0.0, -240700.0, -403.8] +JH_2015.gr (HP_2011_ds62.gr) 0.00012535 172000000000.0 5.53 -3.2e-11 0.4504463 20.0 [626.0, 0.0, -5779200.0, -4002.9] +JH_2015.grun (HP_2011_ds62.grun) 0.0002784 64800000000.0 4.12 -6.4e-11 1.00160048 41.0 [1383.1, 0.030669, -4224700.0, -11257.6] +JH_2015.gth (HP_2011_ds62.gth) 2.082e-05 250000000000.0 4.03 -1.6e-11 0.08885174 4.0 [139.3, 0.000147, -212700.0, -1077.8] +JH_2015.hcrd (HP_2011_ds62.hcrd) 0.00023322 129000000000.0 4.1 -3.1e-11 0.60296798 32.0 [955.3, 0.0, -8352600.0, -6301.2] +JH_2015.hed (HP_2011_ds62.hed) 6.795e-05 119200000000.0 3.97 -3.3e-11 0.2480904 10.0 [340.2, 0.000812, -1047800.0, -2646.7] +JH_2015.hem (HP_2011_ds62.hem) 3.027e-05 223000000000.0 4.04 -1.8e-11 0.1596882 5.0 [163.9, 0.0, -2257200.0, -657.6] +JH_2015.hen (HP_2011_ds62.hen) 6.099e-05 150000000000.0 5.5 -3.6e-11 0.2007774 10.0 [356.2, -0.00299, -596900.0, -3185.3] +JH_2015.herc (HP_2011_ds62.herc) 4.075e-05 192200000000.0 4.04 -2.1e-11 0.1738056 7.0 [216.7, 0.005868, -2430200.0, -1178.3] +JH_2015.heu (HP_2011_ds62.heu) 0.000317 27400000000.0 4.0 -1.46e-10 0.68672038 46.0 [1504.8, -0.033224, -2959300.0, -13297.2] +JH_2015.hlt (HP_2011_ds62.hlt) 2.702e-05 23800000000.0 5.0 -2.1e-10 0.0584428 2.0 [45.2, 0.01797, 0.0, 0.0] +JH_2015.hol (HP_2011_ds62.hol) 7.128e-05 180000000000.0 4.0 -2.2e-11 0.2783315 13.0 [417.6, -0.003617, -4748100.0, -2819.9] +JH_2015.ilm (HP_2011_ds62.ilm) 3.169e-05 170000000000.0 8.3 -4.9e-11 0.1517102 5.0 [138.9, 0.005081, -1288800.0, -463.7] +JH_2015.iron (HP_2011_ds62.iron) 7.09e-06 164000000000.0 5.16 -3.1e-11 0.055845 1.0 [46.2, 0.005159, 723100.0, -556.2] +JH_2015.jd (HP_2011_ds62.jd) 6.04e-05 128100000000.0 3.81 -3e-11 0.2021387 10.0 [319.4, 0.003616, -1173900.0, -2469.5] +JH_2015.jgd (HP_2011_ds62.jgd) 0.0003108 161500000000.0 4.05 -2.5e-11 1.11893378 51.0 [1795.4, -0.037986, -4455700.0, -14888.0] +JH_2015.kao (HP_2011_ds62.kao) 9.934e-05 64500000000.0 4.12 -6.4e-11 0.25816036 17.0 [436.7, -0.034295, -4055900.0, -2699.1] +JH_2015.kcm (HP_2011_ds62.kcm) 0.00011438 42500000000.0 2.0 -4.7e-11 0.29634678 16.0 [536.5, -0.01009, -980400.0, -4735.0] +JH_2015.kls (HP_2011_ds62.kls) 6.052e-05 51400000000.0 2.0 -3.9e-11 0.1581629 7.0 [242.0, -0.004482, -895800.0, -1935.8] +JH_2015.knor (HP_2011_ds62.knor) 0.00011738 174300000000.0 4.05 -2.3e-11 0.4531565 20.0 [613.0, 0.003606, -4178000.0, -3729.4] +JH_2015.kos (HP_2011_ds62.kos) 6.309e-05 130800000000.0 3.0 -2.3e-11 0.2271533 10.0 [309.2, 0.005419, -664600.0, -2176.6] +JH_2015.ky (HP_2011_ds62.ky) 4.414e-05 160100000000.0 4.05 -2.5e-11 0.1620455 8.0 [279.4, -0.007124, -2055600.0, -2289.4] +JH_2015.law (HP_2011_ds62.law) 0.00010132 122900000000.0 5.45 -4.4e-11 0.31423776 19.0 [687.8, 0.001566, 375900.0, -7179.2] +JH_2015.lc (HP_2011_ds62.lc) 8.826e-05 45000000000.0 5.7 -1.27e-10 0.2182472 10.0 [369.8, -0.016332, 684700.0, -3683.1] +JH_2015.lime (HP_2011_ds62.lime) 1.676e-05 113000000000.0 3.87 -3.4e-11 0.0560774 2.0 [52.4, 0.003673, -750700.0, -51.0] +JH_2015.liz (HP_2011_ds62.liz) 0.00010645 71000000000.0 3.2 -4.5e-11 0.27711236 18.0 [614.7, -0.02077, -1721800.0, -5619.4] +JH_2015.lmt (HP_2011_ds62.lmt) 0.0002037 86000000000.0 4.09 -4.8e-11 0.47043692 31.0 [1013.4, -0.021413, -2235800.0, -8806.7] +JH_2015.lot (HP_2011_ds62.lot) 1.818e-05 65800000000.0 4.17 -6.3e-11 0.08791 2.0 [50.2, 0.011052, -940000.0, 0.0] +JH_2015.lrn (HP_2011_ds62.lrn) 5.16e-05 98500000000.0 4.07 -4.1e-11 0.1722391 7.0 [247.5, -0.003206, 0.0, -2051.9] +JH_2015.ma (HP_2011_ds62.ma) 0.00012964 100000000000.0 4.08 -4.1e-11 0.39818368 21.0 [744.4, -0.0168, -2074400.0, -6783.2] +JH_2015.mag (HP_2011_ds62.mag) 2.803e-05 102800000000.0 5.41 -5.3e-11 0.0843139 5.0 [186.4, -0.003772, 0.0, -1886.2] +JH_2015.maj (HP_2011_ds62.maj) 0.00011457 160000000000.0 4.56 -2.8e-11 0.4015548 20.0 [713.6, -0.000997, -1158200.0, -6622.3] +JH_2015.mak (HP_2011_ds62.mak) 2.635e-05 211000000000.0 4.55 -2.2e-11 0.1003887 5.0 [147.8, 0.002015, -2395000.0, -801.8] +JH_2015.mang (HP_2011_ds62.mang) 1.322e-05 164500000000.0 4.46 -2.7e-11 0.0709374 2.0 [59.8, 0.0036, -31400.0, -282.6] +JH_2015.mcar (HP_2011_ds62.mcar) 0.0001059 52500000000.0 4.14 -7.9e-11 0.29846476 19.0 [683.0, -0.014054, 291000.0, -6976.4] +JH_2015.mcor (HP_2011_ds62.mcor) 2.635e-05 211000000000.0 4.55 -2.2e-11 0.1003887 5.0 [147.8, 0.002015, -2395000.0, -801.8] +JH_2015.mctd (HP_2011_ds62.mctd) 6.875e-05 145600000000.0 4.06 -2.8e-11 0.22036518 13.0 [417.4, -0.003771, -2920600.0, -3417.8] +JH_2015.me (HP_2011_ds62.me) 0.00033985 87000000000.0 4.09 -4.7e-11 0.9347085 44.0 [1359.0, 0.036442, -8594700.0, -9598.2] +JH_2015.merw (HP_2011_ds62.merw) 9.847e-05 120000000000.0 4.07 -3.4e-11 0.3287052 14.0 [417.5, 0.008117, -2923000.0, -2320.3] +JH_2015.mft (HP_2011_ds62.mft) 4.457e-05 185700000000.0 4.05 -2.2e-11 0.1999926 7.0 [270.5, -0.007505, -999200.0, -2022.4] +JH_2015.mgts (HP_2011_ds62.mgts) 6.05e-05 102800000000.0 8.55 -8.3e-11 0.2023499 10.0 [371.4, -0.004082, -398400.0, -3547.1] +JH_2015.mic (HP_2011_ds62.mic) 0.00010871 58300000000.0 4.02 -6.9e-11 0.2783315 13.0 [448.8, -0.010075, -1007300.0, -3973.1] +JH_2015.minm (HP_2011_ds62.minm) 0.00014291 43000000000.0 6.17 -1.44e-10 0.37926568 21.0 [622.2, 0.0, -6385500.0, -3916.3] +JH_2015.minn (HP_2011_ds62.minn) 0.00014851 43000000000.0 6.17 -1.44e-10 0.47388568 21.0 [579.7, 0.039494, -6459300.0, -3088.1] +JH_2015.mnbi (HP_2011_ds62.mnbi) 0.00015264 53000000000.0 7.33 -1.43e-10 0.50915898 22.0 [809.9, -0.059213, -1514400.0, -6998.7] +JH_2015.mnchl (HP_2011_ds62.mnchl) 0.0002259 87000000000.0 4.09 -4.7e-11 0.70896222 36.0 [1136.5, -0.005243, -5548100.0, -8911.5] +JH_2015.mncrd (HP_2011_ds62.mncrd) 0.00024027 129000000000.0 4.1 -3.1e-11 0.6462187 29.0 [886.5, 0.0, -8840000.0, -5590.4] +JH_2015.mnctd (HP_2011_ds62.mnctd) 7.175e-05 145600000000.0 4.06 -2.8e-11 0.25099818 13.0 [464.4, -0.012654, -1147200.0, -4341.0] +JH_2015.mnst (HP_2011_ds62.mnst) 0.0004546 180000000000.0 4.76 -2.6e-11 1.68806321 81.5 [2873.3, -0.089064, -12688000.0, -24749.0] +JH_2015.mont (HP_2011_ds62.mont) 5.148e-05 113400000000.0 3.87 -3.4e-11 0.1564661 7.0 [250.7, -0.010433, -797200.0, -1996.1] +JH_2015.mpm (HP_2011_ds62.mpm) 0.0002955 161500000000.0 4.05 -2.5e-11 0.94307628 51.0 [1720.8, -0.024928, -5998700.0, -14620.3] +JH_2015.mpv (HP_2011_ds62.mpv) 2.445e-05 251000000000.0 4.14 -1.6e-11 0.1003887 5.0 [149.3, 0.002918, -2983000.0, -799.1] +JH_2015.mrw (HP_2011_ds62.mrw) 3.949e-05 178100000000.0 4.35 -2.4e-11 0.1406931 7.0 [213.3, 0.00269, -1410400.0, -1495.9] +JH_2015.mst (HP_2011_ds62.mst) 0.0004426 168400000000.0 4.05 -2.4e-11 1.56553121 81.5 [2820.5, -0.059366, -13774000.0, -24126.0] +JH_2015.mstp (HP_2011_ds62.mstp) 0.00036577 51300000000.0 7.33 -1.43e-10 0.9203021 58.5 [1862.2, -0.014018, -8983100.0, -14923.0] +JH_2015.mt (HP_2011_ds62.mt) 4.452e-05 185700000000.0 4.05 -2.2e-11 0.2315326 7.0 [262.5, -0.007205, -1926200.0, -1655.7] +JH_2015.mu (HP_2011_ds62.mu) 0.00014083 49000000000.0 4.15 -8.5e-11 0.39830798 21.0 [756.4, -0.01984, -2170000.0, -6979.2] +JH_2015.mwd (HP_2011_ds62.mwd) 4.051e-05 172600000000.0 3.84 -2.2e-11 0.1406931 7.0 [208.7, 0.003942, -1709500.0, -1302.8] +JH_2015.naph (HP_2011_ds62.naph) 0.0001445 51300000000.0 7.33 -1.43e-10 0.40115148 22.0 [773.5, -0.040229, -2597900.0, -6512.6] +JH_2015.ne (HP_2011_ds62.ne) 5.419e-05 46500000000.0 4.16 -8.9e-11 0.1420544 7.0 [272.7, -0.012398, 0.0, -2763.1] +JH_2015.osfa (HP_2011_ds62.osfa) 0.0003845 129000000000.0 4.1 -3.1e-11 1.0465328 48.0 [1558.6, -0.011359, -9476500.0, -11845.0] +JH_2015.osma (HP_2011_ds62.osma) 0.00037893 129000000000.0 4.1 -3.1e-11 0.9834528 48.0 [1540.7, -0.011359, -10339000.0, -11699.0] +JH_2015.osmm (HP_2011_ds62.osmm) 0.0003844 129000000000.0 4.1 -3.1e-11 0.9818803 48.0 [1525.5, -0.010267, -10538000.0, -11337.0] +JH_2015.pa (HP_2011_ds62.pa) 0.00013211 51500000000.0 6.51 -1.26e-10 0.38219948 21.0 [803.0, -0.03158, 217000.0, -8151.0] +JH_2015.parg (HP_2011_ds62.parg) 0.0002719 91200000000.0 4.09 -4.5e-11 0.83582478 42.0 [1280.2, 0.022997, -12359500.0, -8065.8] +JH_2015.per (HP_2011_ds62.per) 1.125e-05 161600000000.0 3.95 -2.4e-11 0.0403044 2.0 [60.5, 0.000362, -535800.0, -299.2] +JH_2015.phA (HP_2011_ds62.phA) 0.00015422 145000000000.0 4.06 -2.8e-11 0.45634524 29.0 [962.0, -0.011521, -4517800.0, -7724.7] +JH_2015.phl (HP_2011_ds62.phl) 0.00014964 51300000000.0 7.33 -1.43e-10 0.41725998 22.0 [770.3, -0.036939, -2328900.0, -6531.6] +JH_2015.picr (HP_2011_ds62.picr) 4.356e-05 192200000000.0 4.04 -2.1e-11 0.1922948 7.0 [196.1, 0.005398, -3126000.0, -616.9] +JH_2015.pmt (HP_2011_ds62.pmt) 0.0001382 119700000000.0 4.07 -3.4e-11 0.48231364 22.0 [569.8, 0.02779, -5442900.0, -2812.6] +JH_2015.pnt (HP_2011_ds62.pnt) 3.288e-05 170000000000.0 8.3 -4.9e-11 0.1508032 5.0 [143.5, 0.003373, -1940700.0, -407.6] +JH_2015.pre (HP_2011_ds62.pre) 0.00014026 109300000000.0 4.01 -3.7e-11 0.41238418 21.0 [724.9, -0.013865, -2059000.0, -6323.9] +JH_2015.pren (HP_2011_ds62.pren) 6.476e-05 105900000000.0 8.65 -8.2e-11 0.2007774 10.0 [356.2, -0.00299, -596900.0, -3185.3] +JH_2015.prl (HP_2011_ds62.prl) 0.00012804 37000000000.0 10.0 -2.71e-10 0.36031368 20.0 [784.5, -0.042948, 1251000.0, -8495.9] +JH_2015.pswo (HP_2011_ds62.pswo) 4.008e-05 110000000000.0 4.08 -3.7e-11 0.1161617 5.0 [157.8, 0.0, -967300.0, -1075.4] +JH_2015.pxmn (HP_2011_ds62.pxmn) 3.472e-05 84000000000.0 4.0 -4.8e-11 0.1310217 5.0 [138.4, 0.004088, -1936000.0, -538.9] +JH_2015.py (HP_2011_ds62.py) 0.00011313 174300000000.0 4.05 -2.3e-11 0.4031273 20.0 [633.5, 0.0, -5196100.0, -4315.2] +JH_2015.pyr (HP_2011_ds62.pyr) 2.394e-05 139500000000.0 4.09 -2.9e-11 0.119975 3.0 [37.3, 0.026715, -1817000.0, 649.3] +JH_2015.q (HP_2011_ds62.q) 2.269e-05 73000000000.0 6.0 -8.2e-11 0.0600843 3.0 [92.9, -0.000642, -714900.0, -716.1] +JH_2015.rhc (HP_2011_ds62.rhc) 3.107e-05 95300000000.0 3.88 -4.1e-11 0.1149469 5.0 [169.5, 0.0, 0.0, -1534.3] +JH_2015.rhod (HP_2011_ds62.rhod) 3.494e-05 84000000000.0 4.0 -4.8e-11 0.1310217 5.0 [138.4, 0.004088, -1936000.0, -538.9] +JH_2015.rieb (HP_2011_ds62.rieb) 0.0002749 89000000000.0 4.09 -4.6e-11 0.93589008 41.0 [1787.3, -0.124882, 9627100.0, -20275.5] +JH_2015.rnk (HP_2011_ds62.rnk) 9.651e-05 95000000000.0 4.09 -4.3e-11 0.2884008 12.0 [372.3, -0.002893, -2462400.0, -2181.3] +JH_2015.ru (HP_2011_ds62.ru) 1.882e-05 222000000000.0 4.24 -1.9e-11 0.0798658 3.0 [90.4, 0.0029, 0.0, -623.8] +JH_2015.san (HP_2011_ds62.san) 0.00010871 58300000000.0 4.02 -6.9e-11 0.2783315 13.0 [448.8, -0.010075, -1007300.0, -3973.1] +JH_2015.sdl (HP_2011_ds62.sdl) 0.0004213 46500000000.0 4.16 -8.9e-11 0.969212 46.0 [1532.7, 0.047747, -2972800.0, -12427.0] +JH_2015.sid (HP_2011_ds62.sid) 2.943e-05 120000000000.0 4.07 -3.4e-11 0.1158539 5.0 [168.4, 0.0, 0.0, -1483.6] +JH_2015.sill (HP_2011_ds62.sill) 4.986e-05 164000000000.0 5.06 -3.1e-11 0.1620455 8.0 [280.2, -0.0069, -1375700.0, -2399.4] +JH_2015.smul (HP_2011_ds62.smul) 4.987e-05 174000000000.0 4.0 -2.3e-11 0.1620455 8.0 [280.2, -0.0069, -1375700.0, -2399.4] +JH_2015.sp (HP_2011_ds62.sp) 3.978e-05 192200000000.0 4.04 -2.1e-11 0.1422656 7.0 [222.9, 0.006127, -1686000.0, -1551.0] +JH_2015.sph (HP_2011_ds62.sph) 5.565e-05 101700000000.0 9.85 -9.7e-11 0.1960275 8.0 [227.9, 0.002924, -3539500.0, -894.3] +JH_2015.spr4 (HP_2011_ds62.spr4) 0.000199 250000000000.0 4.04 -1.6e-11 0.689231 34.0 [1133.1, -0.007596, -8816600.0, -8180.6] +JH_2015.spr5 (HP_2011_ds62.spr5) 0.0001975 250000000000.0 4.04 -1.6e-11 0.6908035 34.0 [1103.4, 0.001015, -10957000.0, -7409.2] +JH_2015.spss (HP_2011_ds62.spss) 0.00011792 174000000000.0 6.68 -3.8e-11 0.4950263 20.0 [646.9, 0.0, -4525800.0, -4452.8] +JH_2015.spu (HP_2011_ds62.spu) 0.00014697 95000000000.0 4.09 -4.3e-11 0.4445651 19.0 [614.1, -0.003508, -2493100.0, -4168.0] +JH_2015.stlb (HP_2011_ds62.stlb) 0.0003287 86000000000.0 4.09 -4.8e-11 0.70473566 49.0 [1588.4, -0.032043, -3071600.0, -13966.9] +JH_2015.stv (HP_2011_ds62.stv) 1.401e-05 309000000000.0 4.6 -1.5e-11 0.0600843 3.0 [68.1, 0.00601, -1978200.0, -82.1] +JH_2015.sud (HP_2011_ds62.sud) 0.000203 87000000000.0 4.09 -4.7e-11 0.53684522 35.0 [1436.1, -0.048749, -2748500.0, -13764.0] +JH_2015.syv (HP_2011_ds62.syv) 3.752e-05 17000000000.0 5.0 -2.94e-10 0.0745513 2.0 [46.2, 0.01797, 0.0, 0.0] +JH_2015.ta (HP_2011_ds62.ta) 0.00013665 43000000000.0 6.17 -1.44e-10 0.37926568 21.0 [622.2, 0.0, -6385500.0, -3916.3] +JH_2015.tap (HP_2011_ds62.tap) 0.0001345 37000000000.0 10.0 -2.71e-10 0.36031368 20.0 [784.5, -0.042948, 1251000.0, -8495.9] +JH_2015.tats (HP_2011_ds62.tats) 0.0001351 43000000000.0 6.17 -1.44e-10 0.38083818 21.0 [549.5, 0.036324, -8606600.0, -2515.3] +JH_2015.ten (HP_2011_ds62.ten) 1.222e-05 200000000000.0 3.94 -2e-11 0.0795454 2.0 [31.0, 0.01374, -1258000.0, 369.3] +JH_2015.teph (HP_2011_ds62.teph) 4.899e-05 125600000000.0 4.68 -3.7e-11 0.2019591 7.0 [219.6, 0.0, -1292700.0, -1308.3] +JH_2015.tpz (HP_2011_ds62.tpz) 5.339e-05 131500000000.0 4.06 -3.1e-11 0.18006078 11.0 [387.7, -0.00712, -857200.0, -3744.2] +JH_2015.tr (HP_2011_ds62.tr) 0.0002727 76200000000.0 4.1 -5.4e-11 0.81236648 41.0 [1260.2, 0.00383, -11455000.0, -8237.6] +JH_2015.trd (HP_2011_ds62.trd) 2.8e-05 15000000000.0 4.36 -2.91e-10 0.0600843 3.0 [74.9, 0.0031, -1174000.0, -236.7] +JH_2015.tro (HP_2011_ds62.tro) 1.819e-05 65800000000.0 4.17 -6.3e-11 0.08791 2.0 [50.2, 0.011052, -940000.0, 0.0] +JH_2015.trot (HP_2011_ds62.trot) 1.819e-05 65800000000.0 4.17 -6.3e-11 0.08791 2.0 [50.2, 0.011052, -940000.0, 0.0] +JH_2015.trov (HP_2011_ds62.trov) 1.738e-05 65800000000.0 4.17 -6.3e-11 0.080929375 1.875 [51.1, 0.008307, -669700.0, 0.0] +JH_2015.ts (HP_2011_ds62.ts) 0.000268 76000000000.0 4.1 -5.4e-11 0.81551148 41.0 [1244.8, 0.024348, -11965000.0, -8112.1] +JH_2015.ty (HP_2011_ds62.ty) 0.00017039 95000000000.0 4.09 -4.3e-11 0.4885746 22.0 [741.7, -0.005345, -1434600.0, -5878.5] +JH_2015.usp (HP_2011_ds62.usp) 4.682e-05 185700000000.0 4.05 -2.2e-11 0.2235546 7.0 [-102.6, 0.14252, -9144500.0, 5270.7] +JH_2015.vsv (HP_2011_ds62.vsv) 0.000852 125500000000.0 4.8 -3.8e-11 2.86945216 137.0 [4488.0, -0.057952, -22269300.0, -33478.0] +JH_2015.wa (HP_2011_ds62.wa) 0.00010844 90000000000.0 4.0 -4.4e-11 0.3345332 15.0 [499.1, 0.0, 0.0, -4350.1] +JH_2015.wal (HP_2011_ds62.wal) 3.7633e-05 79500000000.0 4.1 -5.2e-11 0.1161617 5.0 [159.3, 0.0, -967300.0, -1075.4] +JH_2015.wo (HP_2011_ds62.wo) 3.993e-05 79500000000.0 4.1 -5.2e-11 0.1161617 5.0 [159.3, 0.0, -967300.0, -1075.4] +JH_2015.wrk (HP_2011_ds62.wrk) 0.0001904 86000000000.0 4.09 -4.8e-11 0.43440636 25.0 [838.3, -0.02146, -2272000.0, -7292.3] +JH_2015.zo (HP_2011_ds62.zo) 0.00013575 104400000000.0 4.0 -3.8e-11 0.45435714 22.0 [662.0, 0.010416, -6006400.0, -4260.7] +JH_2015.zrc (HP_2011_ds62.zrc) 3.926e-05 230100000000.0 4.04 -1.8e-11 0.1833071 6.0 [232.0, -0.014405, 0.0, -2238.2] +Name (slb3 equation of state) V_0 K_0 Kprime_0 G_0 Gprime_0 molar_mass n Debye_0 grueneisen_0 q_0 eta_s_0 +KMFBZ_2017.al_al_perovskite 2.494e-05 258000000000.0 4.1 171000000000.0 1.5 0.1019612 5.0 886.0 1.57 1.1 2.5 +KMFBZ_2017.ca_perovskite 2.754e-05 236000000000.0 3.9 157000000000.0 2.2 0.1161617 5.0 802.0 1.89 0.9 1.3 +KMFBZ_2017.fe_al_perovskite 2.69e-05 220000000000.0 1.3 96000000000.0 3.4 0.13082470000000002 5.0 886.0 1.57 1.1 2.5 +KMFBZ_2017.fe_si_perovskite 2.534e-05 272000000000.0 4.1 12.33 1.4 0.1319287 5.0 871.0 1.57 1.1 2.3 +KMFBZ_2017.hcp_iron 6.73e-06 164000000000.0 4.0 81500000000.0 1.9 0.055845 1.0 422.0 1.71 1.4 7 +KMFBZ_2017.mg_si_perovskite 2.4445e-05 251000000000.0 4.1 173000000000.0 1.7 0.1003887 5.0 905.0 1.57 1.1 2.3 +KMFBZ_2017.periclase 1.124e-05 160200000000.0 3.99 131000000000.0 2.1 0.040304400000000004 2.0 767.0 1.36 1.7 2.8 +KMFBZ_2017.wuestite 1.226e-05 149000000000.0 3.6 60000000000.0 1.8 0.0718444 2.0 454.0 1.53 1.7 0.6 +Name (mgd2 equation of state) V_0 K_0 Kprime_0 G_0 Gprime_0 molar_mass n Debye_0 grueneisen_0 q_0 eta_s_0 +Matas_etal_2007.al_bridgmanite (Matas_etal_2007.al_perovskite) 2.458e-05 249000000000.0 4.0 165000000000.0 1.8 0.1005 5 1021.0 1.48 1.4 +Matas_etal_2007.al_perovskite 2.458e-05 249000000000.0 4.0 165000000000.0 1.8 0.1005 5 1021.0 1.48 1.4 +Matas_etal_2007.ca_bridgmanite (Matas_etal_2007.ca_perovskite) 2.745e-05 236000000000.0 3.9 165000000000.0 2.46 0.11616 5 984.0 1.53 1.6 +Matas_etal_2007.ca_perovskite 2.745e-05 236000000000.0 3.9 165000000000.0 2.46 0.11616 5 984.0 1.53 1.6 +Matas_etal_2007.fe_bridgmanite (Matas_etal_2007.fe_perovskite) 2.534e-05 250000000000.0 4.0 135000000000.0 1.3 0.1319 5 841.0 1.48 1.4 +Matas_etal_2007.fe_perovskite 2.534e-05 250000000000.0 4.0 135000000000.0 1.3 0.1319 5 841.0 1.48 1.4 +Matas_etal_2007.mg_bridgmanite (Matas_etal_2007.mg_perovskite) 2.443e-05 250000000000.0 4.0 175000000000.0 1.8 0.102 5 1070.0 1.48 1.4 +Matas_etal_2007.mg_perovskite 2.443e-05 250000000000.0 4.0 175000000000.0 1.8 0.102 5 1070.0 1.48 1.4 +Matas_etal_2007.periclase 1.125e-05 160100000000.0 3.83 130000000000.0 2.2 0.0403 2 673.0 1.41 1.3 +Matas_etal_2007.wuestite 1.226e-05 160100000000.0 3.83 46000000000.0 0.6 0.0718 2 673.0 1.41 1.3 +Name (slb2 equation of state) V_0 K_0 Kprime_0 G_0 Gprime_0 molar_mass n Debye_0 grueneisen_0 q_0 eta_s_0 +Murakami_2013.fe_bridgmanite (Murakami_2013.fe_perovskite) 2.549e-05 281000000000.0 4.1 138000000000.0 1.7 0.1319 5 841.0 1.48 1.4 2.1 +Murakami_2013.fe_perovskite 2.549e-05 281000000000.0 4.1 138000000000.0 1.7 0.1319 5 841.0 1.48 1.4 2.1 +Murakami_2013.mg_bridgmanite (Murakami_2013.mg_perovskite) 2.445e-05 253000000000.0 4.1 172900000000.0 1.56 0.1 5 1100.0 1.4 1.4 2.6 +Murakami_2013.mg_perovskite 2.445e-05 253000000000.0 4.1 172900000000.0 1.56 0.1 5 1100.0 1.4 1.4 2.6 +Murakami_2013.periclase 1.124e-05 161000000000.0 3.9 130900000000.0 1.92 0.0403 2 773.0 1.5 1.5 2.3 +Murakami_2013.wuestite 1.206e-05 152000000000.0 4.9 47000000000.0 0.7 0.0718 2 455.0 1.28 1.5 0.8 +Name (slb2 equation of state) V_0 K_0 Kprime_0 G_0 Gprime_0 molar_mass n Debye_0 grueneisen_0 q_0 eta_s_0 +Murakami_etal_2012.fe_bridgmanite (Murakami_etal_2012.fe_perovskite) 2.4607e-05 251900000000.0 4.01 164700000000.0 1.58 0.102 5 1054.0 1.48 1.4 2.4 +Murakami_etal_2012.fe_periclase_HS 1.1412e-05 159100000000.0 4.11 105430000000.0 1.773 0.047 2 706.0 1.45 1.5 2.54 +Murakami_etal_2012.fe_periclase_LS 1.1171e-05 170000000000.0 4.0 116340000000.0 1.668 0.047 2 706.0 1.45 1.5 2.54 +Murakami_etal_2012.fe_perovskite 2.4607e-05 251900000000.0 4.01 164700000000.0 1.58 0.102 5 1054.0 1.48 1.4 2.4 +Murakami_etal_2012.mg_bridgmanite (Murakami_etal_2012.mg_perovskite) 2.445e-05 281000000000.0 4.1 173000000000.0 1.56 0.1 5 1070.0 1.48 1.4 2.4 +Murakami_etal_2012.mg_periclase 1.124e-05 161000000000.0 3.9 131000000000.0 1.92 0.0403 2 773.0 1.5 1.5 3.0 +Murakami_etal_2012.mg_perovskite 2.445e-05 281000000000.0 4.1 173000000000.0 1.56 0.1 5 1070.0 1.48 1.4 2.4 +Name (slb3 equation of state) V_0 K_0 Kprime_0 G_0 Gprime_0 molar_mass n Debye_0 grueneisen_0 q_0 eta_s_0 +Murakami_etal_2012.fe_periclase_HS_3rd 1.1412e-05 159100000000.0 4.11 129350000000.0 1.993 0.0469 2 706.0 1.45 1.5 2.54 +Murakami_etal_2012.fe_periclase_LS_3rd 1.1171e-05 170000000000.0 4.0 151670000000.0 1.754 0.0469 2 706.0 1.45 1.5 2.54 +Murakami_etal_2012.mg_bridgmanite_3rdorder (Murakami_etal_2012.mg_perovskite_3rdorder) 2.445e-05 281000000000.0 4.1 171420000000.0 1.83 0.1 5 1070.0 1.48 1.4 2.4 +Murakami_etal_2012.mg_perovskite_3rdorder 2.445e-05 281000000000.0 4.1 171420000000.0 1.83 0.1 5 1070.0 1.48 1.4 2.4 Name (dks_l equation of state) V_0 T_0 O_theta O_f m zeta_0 xi Tel_0 eta RS_2014_liquids.Fe2SiO4_liquid 5.97717e-05 1900.0 1 4 0.6 0.0161350928 0.34431043 1919.3553 0.012706711 -Name (slb3 equation of state) V_0 K_0 Kprime_0 G_0 Gprime_0 molar_mass n Debye_0 grueneisen_0 q_0 eta_s_0 -SLB_2005.fe_bridgmanite (SLB_2005.fe_perovskite) 2.548e-05 2.81e+11 4.1 1.38e+11 1.7 0.1319 5 841.0 1.48 1.4 2.1 -SLB_2005.fe_perovskite 2.548e-05 2.81e+11 4.1 1.38e+11 1.7 0.1319 5 841.0 1.48 1.4 2.1 -SLB_2005.mg_bridgmanite (SLB_2005.mg_perovskite) 2.445e-05 2.51e+11 4.1 1.75e+11 1.7 0.1 5 1070.0 1.48 1.4 2.6 -SLB_2005.mg_perovskite 2.445e-05 2.51e+11 4.1 1.75e+11 1.7 0.1 5 1070.0 1.48 1.4 2.6 -SLB_2005.periclase 1.124e-05 1.61e+11 3.8 1.31e+11 2.1 0.0403 2 773.0 1.5 1.5 2.8 -SLB_2005.stishovite 1.402e-05 3.14e+11 4.4 2.2e+11 1.6 0.0601 3 1044.0 1.34 2.4 5.0 -SLB_2005.wuestite 1.206e-05 1.52e+11 4.9 47000000000.0 0.7 0.0718 2 455.0 1.28 1.5 0.8 -Name (slb3 equation of state) V_0 K_0 Kprime_0 G_0 Gprime_0 molar_mass n Debye_0 grueneisen_0 q_0 eta_s_0 -SLB_2011.ab (SLB_2011.albite) 0.000100452 59761620000.0 4.0 36000000000.0 1.3855 0.262223 13.0 713.7824 0.56704 1.0 1.04208 -SLB_2011.al (SLB_2011.almandine) 0.00011543 1.738963e+11 4.91341 96000000000.0 1.40927 0.4977473 20.0 741.356 1.06495 1.42169 2.09292 -SLB_2011.al_perovskite 2.4944e-05 2.582e+11 4.14 1.713116e+11 1.49706 0.1019612 5.0 886.4601 1.56508 1.10945 2.47126 -SLB_2011.al_post_perovskite 2.3847e-05 2.49e+11 4.0 91965310000.0 1.81603 0.1019612 5.0 762.1951 1.64573 1.09081 2.83762 -SLB_2011.albite 0.000100452 59761620000.0 4.0 36000000000.0 1.3855 0.262223 13.0 713.7824 0.56704 1.0 1.04208 -SLB_2011.almandine 0.00011543 1.738963e+11 4.91341 96000000000.0 1.40927 0.4977473 20.0 741.356 1.06495 1.42169 2.09292 -SLB_2011.alpv (SLB_2011.al_perovskite) 2.4944e-05 2.582e+11 4.14 1.713116e+11 1.49706 0.1019612 5.0 886.4601 1.56508 1.10945 2.47126 -SLB_2011.an (SLB_2011.anorthite) 0.00010061 84089150000.0 4.0 39900000000.0 1.09134 0.2782072 13.0 752.3911 0.39241 1.0 1.6254 -SLB_2011.anorthite 0.00010061 84089150000.0 4.0 39900000000.0 1.09134 0.2782072 13.0 752.3911 0.39241 1.0 1.6254 -SLB_2011.appv (SLB_2011.al_post_perovskite) 2.3847e-05 2.49e+11 4.0 91965310000.0 1.81603 0.1019612 5.0 762.1951 1.64573 1.09081 2.83762 -SLB_2011.ca_perovskite 2.745e-05 2.36e+11 3.9 1.568315e+11 2.22713 0.1161617 5.0 795.779 1.88839 0.89769 1.28818 -SLB_2011.ca_tschermaks 6.3574e-05 1.122413e+11 5.23885 75160660000.0 1.54016 0.2181229 10.0 803.6626 0.78126 1.52852 1.9672 -SLB_2011.capv (SLB_2011.ca_perovskite) 2.745e-05 2.36e+11 3.9 1.568315e+11 2.22713 0.1161617 5.0 795.779 1.88839 0.89769 1.28818 -SLB_2011.cats (SLB_2011.ca_tschermaks) 6.3574e-05 1.122413e+11 5.23885 75160660000.0 1.54016 0.2181229 10.0 803.6626 0.78126 1.52852 1.9672 -SLB_2011.cen (SLB_2011.clinoenstatite) 6.25e-05 1.122413e+11 5.23885 79496860000.0 1.62901 0.2007774 10.0 805.0547 0.95873 1.52852 1.69074 -SLB_2011.clinoenstatite 6.25e-05 1.122413e+11 5.23885 79496860000.0 1.62901 0.2007774 10.0 805.0547 0.95873 1.52852 1.69074 -SLB_2011.co (SLB_2011.corundum) 2.5577e-05 2.525457e+11 4.33728 1.632e+11 1.64174 0.1019612 5.0 932.5696 1.32442 1.30316 2.8316 -SLB_2011.coes (SLB_2011.coesite) 2.0657e-05 1.135856e+11 4.0 61600010000.0 1.24734 0.0600843 3.0 852.4267 0.39157 1.0 2.39793 -SLB_2011.coesite 2.0657e-05 1.135856e+11 4.0 61600010000.0 1.24734 0.0600843 3.0 852.4267 0.39157 1.0 2.39793 -SLB_2011.corundum 2.5577e-05 2.525457e+11 4.33728 1.632e+11 1.64174 0.1019612 5.0 932.5696 1.32442 1.30316 2.8316 -SLB_2011.di (SLB_2011.diopside) 6.6039e-05 1.122413e+11 5.23885 67000000000.0 1.37293 0.2165504 10.0 781.6146 0.95873 1.52852 1.57351 -SLB_2011.diopside 6.6039e-05 1.122413e+11 5.23885 67000000000.0 1.37293 0.2165504 10.0 781.6146 0.95873 1.52852 1.57351 -SLB_2011.en (SLB_2011.enstatite) 6.2676e-05 1.070768e+11 7.02751 76800000000.0 1.54596 0.2007774 10.0 812.1848 0.78479 3.43846 2.50453 -SLB_2011.enstatite 6.2676e-05 1.070768e+11 7.02751 76800000000.0 1.54596 0.2007774 10.0 812.1848 0.78479 3.43846 2.50453 -SLB_2011.fa (SLB_2011.fayalite) 4.629e-05 1.349622e+11 4.21796 50899990000.0 1.46257 0.2037731 7.0 618.7007 1.06023 3.6466 1.02497 -SLB_2011.fayalite 4.629e-05 1.349622e+11 4.21796 50899990000.0 1.46257 0.2037731 7.0 618.7007 1.06023 3.6466 1.02497 -SLB_2011.fe_akimotoite 2.6854e-05 2.10706e+11 5.62088 1.523046e+11 1.57889 0.1319287 5.0 887.8709 1.18984 2.34514 3.5716 -SLB_2011.fe_bridgmanite (SLB_2011.fe_perovskite) 2.5485e-05 2.721152e+11 4.14 1.326849e+11 1.37485 0.1319287 5.0 870.8122 1.56508 1.10945 2.29211 -SLB_2011.fe_ca_ferrite 3.7258e-05 2.106663e+11 4.0528 1.535236e+11 1.75878 0.1738056 7.0 804.1986 1.31156 1.0 3.0268 -SLB_2011.fe_perovskite 2.5485e-05 2.721152e+11 4.14 1.326849e+11 1.37485 0.1319287 5.0 870.8122 1.56508 1.10945 2.29211 -SLB_2011.fe_post_perovskite 2.5459e-05 2.312e+11 4.0 1.295e+11 1.44675 0.1319287 5.0 781.3465 1.89155 1.09081 1.36382 -SLB_2011.fe_ringwoodite 4.186e-05 2.13412e+11 4.22035 92000000000.0 1.35412 0.2037731 7.0 677.7177 1.27193 2.3914 1.77249 -SLB_2011.fe_wadsleyite 4.28e-05 1.68591e+11 4.3229 72000000000.0 1.44424 0.2037731 7.0 665.4492 1.2061 2.0188 1.04017 -SLB_2011.fec2 (SLB_2011.hp_clinoferrosilite) 6.385413e-05 1.160254e+11 6.23685 70623090000.0 1.84119 0.2638574 10.0 691.564 1.12473 0.20401 0.79216 -SLB_2011.fecf (SLB_2011.fe_ca_ferrite) 3.7258e-05 2.106663e+11 4.0528 1.535236e+11 1.75878 0.1738056 7.0 804.1986 1.31156 1.0 3.0268 -SLB_2011.feil (SLB_2011.fe_akimotoite) 2.6854e-05 2.10706e+11 5.62088 1.523046e+11 1.57889 0.1319287 5.0 887.8709 1.18984 2.34514 3.5716 -SLB_2011.fepv (SLB_2011.fe_perovskite) 2.5485e-05 2.721152e+11 4.14 1.326849e+11 1.37485 0.1319287 5.0 870.8122 1.56508 1.10945 2.29211 -SLB_2011.feri (SLB_2011.fe_ringwoodite) 4.186e-05 2.13412e+11 4.22035 92000000000.0 1.35412 0.2037731 7.0 677.7177 1.27193 2.3914 1.77249 -SLB_2011.ferrosilite 6.5941e-05 1.005386e+11 7.02751 52000000000.0 1.54596 0.2638574 10.0 674.4769 0.71889 3.43846 1.07706 -SLB_2011.fewa (SLB_2011.fe_wadsleyite) 4.28e-05 1.68591e+11 4.3229 72000000000.0 1.44424 0.2037731 7.0 665.4492 1.2061 2.0188 1.04017 -SLB_2011.fo (SLB_2011.forsterite) 4.3603e-05 1.279555e+11 4.21796 81599990000.0 1.46257 0.1406931 7.0 809.1703 0.99282 2.10672 2.29972 -SLB_2011.forsterite 4.3603e-05 1.279555e+11 4.21796 81599990000.0 1.46257 0.1406931 7.0 809.1703 0.99282 2.10672 2.29972 -SLB_2011.fppv (SLB_2011.fe_post_perovskite) 2.5459e-05 2.312e+11 4.0 1.295e+11 1.44675 0.1319287 5.0 781.3465 1.89155 1.09081 1.36382 -SLB_2011.fs (SLB_2011.ferrosilite) 6.5941e-05 1.005386e+11 7.02751 52000000000.0 1.54596 0.2638574 10.0 674.4769 0.71889 3.43846 1.07706 -SLB_2011.gr (SLB_2011.grossular) 0.00012512 1.670622e+11 3.91544 1.09e+11 1.16274 0.4504463 20.0 822.743 1.05404 1.88887 2.38418 -SLB_2011.grossular 0.00012512 1.670622e+11 3.91544 1.09e+11 1.16274 0.4504463 20.0 822.743 1.05404 1.88887 2.38418 -SLB_2011.hc (SLB_2011.hercynite) 0.000163372 2.088965e+11 5.68282 84500000000.0 0.37303 0.6952224 28.0 763.231 1.21719 2.71208 2.768 -SLB_2011.he (SLB_2011.hedenbergite) 6.7867e-05 1.192555e+11 5.23885 61000000000.0 1.17647 0.2480904 10.0 701.5851 0.93516 1.52852 1.5703 -SLB_2011.hedenbergite 6.7867e-05 1.192555e+11 5.23885 61000000000.0 1.17647 0.2480904 10.0 701.5851 0.93516 1.52852 1.5703 -SLB_2011.hercynite 0.000163372 2.088965e+11 5.68282 84500000000.0 0.37303 0.6952224 28.0 763.231 1.21719 2.71208 2.768 -SLB_2011.hp_clinoenstatite 6.076e-05 1.160254e+11 6.23685 87927170000.0 1.84119 0.2007774 10.0 824.4439 1.12473 0.20401 2.14181 -SLB_2011.hp_clinoferrosilite 6.385413e-05 1.160254e+11 6.23685 70623090000.0 1.84119 0.2638574 10.0 691.564 1.12473 0.20401 0.79216 -SLB_2011.hpcen (SLB_2011.hp_clinoenstatite) 6.076e-05 1.160254e+11 6.23685 87927170000.0 1.84119 0.2007774 10.0 824.4439 1.12473 0.20401 2.14181 -SLB_2011.hpcfs (SLB_2011.hp_clinoferrosilite) 6.385413e-05 1.160254e+11 6.23685 70623090000.0 1.84119 0.2638574 10.0 691.564 1.12473 0.20401 0.79216 -SLB_2011.jadeite 6.0508e-05 1.422873e+11 5.23885 85000000000.0 1.37398 0.2021387 10.0 820.7623 0.903 0.39234 2.18453 -SLB_2011.jd (SLB_2011.jadeite) 6.0508e-05 1.422873e+11 5.23885 85000000000.0 1.37398 0.2021387 10.0 820.7623 0.903 0.39234 2.18453 -SLB_2011.jd_majorite 0.00011094 1.770772e+11 4.11067 1.25e+11 1.35756 0.4042774 20.0 895.914 1.01424 1.42169 3.30517 -SLB_2011.jdmj (SLB_2011.jd_majorite) 0.00011094 1.770772e+11 4.11067 1.25e+11 1.35756 0.4042774 20.0 895.914 1.01424 1.42169 3.30517 -SLB_2011.ky (SLB_2011.kyanite) 4.4227e-05 1.6e+11 4.0 1.204033e+11 1.7308 0.1620455 8.0 943.1665 0.9255 1.0 2.96665 -SLB_2011.kyanite 4.4227e-05 1.6e+11 4.0 1.204033e+11 1.7308 0.1620455 8.0 943.1665 0.9255 1.0 2.96665 -SLB_2011.mg_akimotoite 2.6354e-05 2.10706e+11 5.62088 1.32e+11 1.57889 0.1003887 5.0 935.9778 1.18984 2.34514 2.80782 -SLB_2011.mg_bridgmanite (SLB_2011.mg_perovskite) 2.4445e-05 2.505264e+11 4.14 1.729e+11 1.69037 0.1003887 5.0 905.9412 1.56508 1.10945 2.56536 -SLB_2011.mg_ca_ferrite 3.6177e-05 2.106663e+11 4.0528 1.29826e+11 1.75878 0.1422656 7.0 838.6291 1.31156 1.0 2.1073 -SLB_2011.mg_majorite 0.000114324 1.651183e+11 4.21183 84999990000.0 1.42969 0.4015548 20.0 822.458 0.97682 1.53581 1.0178 -SLB_2011.mg_perovskite 2.4445e-05 2.505264e+11 4.14 1.729e+11 1.69037 0.1003887 5.0 905.9412 1.56508 1.10945 2.56536 -SLB_2011.mg_post_perovskite 2.4419e-05 2.312e+11 4.0 1.50167e+11 1.97874 0.1003887 5.0 855.8173 1.89155 1.09081 1.16704 -SLB_2011.mg_ringwoodite 3.9493e-05 1.849009e+11 4.22035 1.23e+11 1.35412 0.1406931 7.0 877.7094 1.10791 2.3914 2.30461 -SLB_2011.mg_tschermaks 5.914e-05 1.070768e+11 7.02751 95950860000.0 1.54596 0.2023499 10.0 783.8404 0.78479 3.43846 2.49099 -SLB_2011.mg_wadsleyite 4.0515e-05 1.686948e+11 4.3229 1.12e+11 1.44424 0.1406931 7.0 843.4973 1.2061 2.0188 2.63683 -SLB_2011.mgc2 (SLB_2011.hp_clinoenstatite) 6.076e-05 1.160254e+11 6.23685 87927170000.0 1.84119 0.2007774 10.0 824.4439 1.12473 0.20401 2.14181 -SLB_2011.mgcf (SLB_2011.mg_ca_ferrite) 3.6177e-05 2.106663e+11 4.0528 1.29826e+11 1.75878 0.1422656 7.0 838.6291 1.31156 1.0 2.1073 -SLB_2011.mgil (SLB_2011.mg_akimotoite) 2.6354e-05 2.10706e+11 5.62088 1.32e+11 1.57889 0.1003887 5.0 935.9778 1.18984 2.34514 2.80782 -SLB_2011.mgmj (SLB_2011.mg_majorite) 0.000114324 1.651183e+11 4.21183 84999990000.0 1.42969 0.4015548 20.0 822.458 0.97682 1.53581 1.0178 -SLB_2011.mgpv (SLB_2011.mg_perovskite) 2.4445e-05 2.505264e+11 4.14 1.729e+11 1.69037 0.1003887 5.0 905.9412 1.56508 1.10945 2.56536 -SLB_2011.mgri (SLB_2011.mg_ringwoodite) 3.9493e-05 1.849009e+11 4.22035 1.23e+11 1.35412 0.1406931 7.0 877.7094 1.10791 2.3914 2.30461 -SLB_2011.mgts (SLB_2011.mg_tschermaks) 5.914e-05 1.070768e+11 7.02751 95950860000.0 1.54596 0.2023499 10.0 783.8404 0.78479 3.43846 2.49099 -SLB_2011.mgwa (SLB_2011.mg_wadsleyite) 4.0515e-05 1.686948e+11 4.3229 1.12e+11 1.44424 0.1406931 7.0 843.4973 1.2061 2.0188 2.63683 -SLB_2011.mppv (SLB_2011.mg_post_perovskite) 2.4419e-05 2.312e+11 4.0 1.50167e+11 1.97874 0.1003887 5.0 855.8173 1.89155 1.09081 1.16704 -SLB_2011.na_ca_ferrite 3.627e-05 1.613385e+11 4.32479 1.220049e+11 2.07687 0.1420544 7.0 812.4769 0.69428 1.0 2.79016 -SLB_2011.nacf (SLB_2011.na_ca_ferrite) 3.627e-05 1.613385e+11 4.32479 1.220049e+11 2.07687 0.1420544 7.0 812.4769 0.69428 1.0 2.79016 -SLB_2011.neph (SLB_2011.nepheline) 5.46684e-05 53077990000.0 4.0 30700000000.0 1.33031 0.1420544 7.0 700.9422 0.69428 1.0 0.6291 -SLB_2011.nepheline 5.46684e-05 53077990000.0 4.0 30700000000.0 1.33031 0.1420544 7.0 700.9422 0.69428 1.0 0.6291 -SLB_2011.odi (SLB_2011.ortho_diopside) 6.8054e-05 1.070768e+11 7.02751 58458950000.0 1.54596 0.2165504 10.0 744.6988 0.78479 3.43846 1.36161 -SLB_2011.ortho_diopside 6.8054e-05 1.070768e+11 7.02751 58458950000.0 1.54596 0.2165504 10.0 744.6988 0.78479 3.43846 1.36161 -SLB_2011.pe (SLB_2011.periclase) 1.1244e-05 1.613836e+11 3.84045 1.309e+11 2.1438 0.0403044 2.0 767.0977 1.36127 1.7217 2.81765 -SLB_2011.periclase 1.1244e-05 1.613836e+11 3.84045 1.309e+11 2.1438 0.0403044 2.0 767.0977 1.36127 1.7217 2.81765 -SLB_2011.py (SLB_2011.pyrope) 0.00011308 1.702396e+11 4.11067 93699990000.0 1.35756 0.4031273 20.0 823.2102 1.01424 1.42169 0.98186 -SLB_2011.pyrope 0.00011308 1.702396e+11 4.11067 93699990000.0 1.35756 0.4031273 20.0 823.2102 1.01424 1.42169 0.98186 -SLB_2011.qtz (SLB_2011.quartz) 2.367003e-05 49547430000.0 4.33155 44856170000.0 0.95315 0.0600843 3.0 816.3307 -0.00296 1.0 2.36469 -SLB_2011.quartz 2.367003e-05 49547430000.0 4.33155 44856170000.0 0.95315 0.0600843 3.0 816.3307 -0.00296 1.0 2.36469 -SLB_2011.seif (SLB_2011.seifertite) 1.367e-05 3.275843e+11 4.01553 2.274532e+11 1.76965 0.0600843 3.0 1140.772 1.37466 2.83517 4.97108 -SLB_2011.seifertite 1.367e-05 3.275843e+11 4.01553 2.274532e+11 1.76965 0.0600843 3.0 1140.772 1.37466 2.83517 4.97108 -SLB_2011.sp (SLB_2011.spinel) 0.000159048 1.969428e+11 5.68282 1.085e+11 0.37303 0.5690624 28.0 842.8104 1.02283 2.71208 2.66282 -SLB_2011.spinel 0.000159048 1.969428e+11 5.68282 1.085e+11 0.37303 0.5690624 28.0 842.8104 1.02283 2.71208 2.66282 -SLB_2011.st (SLB_2011.stishovite) 1.4017e-05 3.143352e+11 3.75122 2.2e+11 1.93334 0.0600843 3.0 1107.824 1.37466 2.83517 4.60904 -SLB_2011.stishovite 1.4017e-05 3.143352e+11 3.75122 2.2e+11 1.93334 0.0600843 3.0 1107.824 1.37466 2.83517 4.60904 -SLB_2011.wu (SLB_2011.wuestite) 1.2264e-05 1.794442e+11 4.9376 59000000000.0 1.44673 0.0718444 2.0 454.1592 1.53047 1.7217 -0.05731 -SLB_2011.wuestite 1.2264e-05 1.794442e+11 4.9376 59000000000.0 1.44673 0.0718444 2.0 454.1592 1.53047 1.7217 -0.05731 -Name (slb3 equation of state) V_0 K_0 Kprime_0 G_0 Gprime_0 molar_mass n Debye_0 grueneisen_0 q_0 eta_s_0 -SLB_2011_ZSB_2013.fe_bridgmanite (SLB_2011_ZSB_2013.fe_perovskite) 2.549e-05 2.72e+11 4.1 1.33e+11 1.4 0.1319 5 871.0 1.57 1.1 2.3 -SLB_2011_ZSB_2013.fe_perovskite 2.549e-05 2.72e+11 4.1 1.33e+11 1.4 0.1319 5 871.0 1.57 1.1 2.3 -SLB_2011_ZSB_2013.mg_bridgmanite (SLB_2011_ZSB_2013.mg_perovskite) 2.445e-05 2.505e+11 4.01 1.729e+11 1.74 0.1 5 905.9 1.44 1.09 2.13 -SLB_2011_ZSB_2013.mg_perovskite 2.445e-05 2.505e+11 4.01 1.729e+11 1.74 0.1 5 905.9 1.44 1.09 2.13 -SLB_2011_ZSB_2013.periclase 1.124e-05 1.61e+11 3.8 1.31e+11 2.1 0.0403 2 767.0 1.36 1.7 2.8 -SLB_2011_ZSB_2013.stishovite 1.402e-05 3.14e+11 3.8 2.2e+11 1.9 0.0601 3 1108.0 1.37 2.8 4.6 -SLB_2011_ZSB_2013.wuestite 1.226e-05 1.79e+11 4.9 59000000000.0 1.4 0.0718 2 454.0 1.53 1.7 -0.1 -Name (hp_tmt equation of state) V_0 K_0 Kprime_0 Kdprime_0 molar_mass n Cp -Sundman_1991.bcc_iron 7.09e-06 1.64e+11 5.16 -3.1e-11 0.055845 1.0 [21.09, 0.0101455, -221508.0, 47.1947] -Sundman_1991.fcc_iron 6.93863394593e-06 1.539e+11 5.2 -3.37e-11 0.055845 1.0 [22.24, 0.0088656, -221517.0, 47.1998] -Name (aa equation of state) T_0 S_0 V_0 K_S Kprime_S Kprime_prime_S grueneisen_0 grueneisen_prime grueneisen_n -other.liquid_iron 1811.0 100.0 7.95626157572e-06 1.097e+11 4.661 -4.3e-11 1.735 -2.32787178798e-06 -1.87 -Name (mgd3 equation of state) V_0 K_0 Kprime_0 G_0 Gprime_0 molar_mass n Debye_0 grueneisen_0 q_0 eta_s_0 -other.Speziale_fe_periclase_HS 2.29e-05 1.575e+11 3.92 nan nan 0.04567 2 587 1.46 1.2 -other.Speziale_fe_periclase_LS 2.149e-05 1.86e+11 4.6 nan nan 0.04567 2 587.0 1.46 1.2 -Name (slb3 equation of state) V_0 K_0 Kprime_0 G_0 Gprime_0 molar_mass n Debye_0 grueneisen_0 q_0 eta_s_0 -other.ZSB_2013_fe_perovskite 2.549e-05 2.72e+11 4.1 1.33e+11 1.4 0.1319 5 871.0 1.57 1.1 2.3 -other.ZSB_2013_mg_perovskite 2.445e-05 2.505e+11 4.01 1.729e+11 1.74 0.1 5 905.9 1.44 1.09 2.13 -other.fe_perovskite (SLB_2011.fe_perovskite) 2.5485e-05 2.721152e+11 4.14 1.326849e+11 1.37485 0.1319287 5.0 870.8122 1.56508 1.10945 2.29211 -other.mg_perovskite (SLB_2011.mg_perovskite) 2.4445e-05 2.505264e+11 4.14 1.729e+11 1.69037 0.1003887 5.0 905.9412 1.56508 1.10945 2.56536 -other.periclase (SLB_2011.periclase) 1.1244e-05 1.613836e+11 3.84045 1.309e+11 2.1438 0.0403044 2.0 767.0977 1.36127 1.7217 2.81765 -other.wuestite (SLB_2011.wuestite) 1.2264e-05 1.794442e+11 4.9376 59000000000.0 1.44673 0.0718444 2.0 454.1592 1.53047 1.7217 -0.05731 +Name (slb3 equation of state) V_0 K_0 Kprime_0 G_0 Gprime_0 molar_mass n Debye_0 grueneisen_0 q_0 eta_s_0 +SLB_2005.fe_bridgmanite (SLB_2005.fe_perovskite) 2.548e-05 281000000000.0 4.1 138000000000.0 1.7 0.1319 5 841.0 1.48 1.4 2.1 +SLB_2005.fe_perovskite 2.548e-05 281000000000.0 4.1 138000000000.0 1.7 0.1319 5 841.0 1.48 1.4 2.1 +SLB_2005.mg_bridgmanite (SLB_2005.mg_perovskite) 2.445e-05 251000000000.0 4.1 175000000000.0 1.7 0.1 5 1070.0 1.48 1.4 2.6 +SLB_2005.mg_perovskite 2.445e-05 251000000000.0 4.1 175000000000.0 1.7 0.1 5 1070.0 1.48 1.4 2.6 +SLB_2005.periclase 1.124e-05 161000000000.0 3.8 131000000000.0 2.1 0.0403 2 773.0 1.5 1.5 2.8 +SLB_2005.stishovite 1.402e-05 314000000000.0 4.4 220000000000.0 1.6 0.0601 3 1044.0 1.34 2.4 5.0 +SLB_2005.wuestite 1.206e-05 152000000000.0 4.9 47000000000.0 0.7 0.0718 2 455.0 1.28 1.5 0.8 +Name (slb3 equation of state) V_0 K_0 Kprime_0 G_0 Gprime_0 molar_mass n Debye_0 grueneisen_0 q_0 eta_s_0 +SLB_2011.ab (SLB_2011.albite) 0.000100452 59761620000.0 4.0 36000000000.0 1.3855 0.262223 13.0 713.7824 0.56704 1.0 1.04208 +SLB_2011.al (SLB_2011.almandine) 0.00011543 173896300000.0 4.91341 96000000000.0 1.40927 0.4977473 20.0 741.356 1.06495 1.42169 2.09292 +SLB_2011.al_perovskite 2.4944e-05 258200000000.0 4.14 171311600000.0 1.49706 0.1019612 5.0 886.4601 1.56508 1.10945 2.47126 +SLB_2011.al_post_perovskite 2.3847e-05 249000000000.0 4.0 91965310000.0 1.81603 0.1019612 5.0 762.1951 1.64573 1.09081 2.83762 +SLB_2011.albite 0.000100452 59761620000.0 4.0 36000000000.0 1.3855 0.262223 13.0 713.7824 0.56704 1.0 1.04208 +SLB_2011.almandine 0.00011543 173896300000.0 4.91341 96000000000.0 1.40927 0.4977473 20.0 741.356 1.06495 1.42169 2.09292 +SLB_2011.alpv (SLB_2011.al_perovskite) 2.4944e-05 258200000000.0 4.14 171311600000.0 1.49706 0.1019612 5.0 886.4601 1.56508 1.10945 2.47126 +SLB_2011.an (SLB_2011.anorthite) 0.00010061 84089150000.0 4.0 39900000000.0 1.09134 0.2782072 13.0 752.3911 0.39241 1.0 1.6254 +SLB_2011.anorthite 0.00010061 84089150000.0 4.0 39900000000.0 1.09134 0.2782072 13.0 752.3911 0.39241 1.0 1.6254 +SLB_2011.appv (SLB_2011.al_post_perovskite) 2.3847e-05 249000000000.0 4.0 91965310000.0 1.81603 0.1019612 5.0 762.1951 1.64573 1.09081 2.83762 +SLB_2011.ca_perovskite 2.745e-05 236000000000.0 3.9 156831500000.0 2.22713 0.1161617 5.0 795.779 1.88839 0.89769 1.28818 +SLB_2011.ca_tschermaks 6.3574e-05 112241300000.0 5.23885 75160660000.0 1.54016 0.2181229 10.0 803.6626 0.78126 1.52852 1.9672 +SLB_2011.capv (SLB_2011.ca_perovskite) 2.745e-05 236000000000.0 3.9 156831500000.0 2.22713 0.1161617 5.0 795.779 1.88839 0.89769 1.28818 +SLB_2011.cats (SLB_2011.ca_tschermaks) 6.3574e-05 112241300000.0 5.23885 75160660000.0 1.54016 0.2181229 10.0 803.6626 0.78126 1.52852 1.9672 +SLB_2011.cen (SLB_2011.clinoenstatite) 6.25e-05 112241300000.0 5.23885 79496860000.0 1.62901 0.2007774 10.0 805.0547 0.95873 1.52852 1.69074 +SLB_2011.clinoenstatite 6.25e-05 112241300000.0 5.23885 79496860000.0 1.62901 0.2007774 10.0 805.0547 0.95873 1.52852 1.69074 +SLB_2011.co (SLB_2011.corundum) 2.5577e-05 252545700000.0 4.33728 163200000000.0 1.64174 0.1019612 5.0 932.5696 1.32442 1.30316 2.8316 +SLB_2011.coes (SLB_2011.coesite) 2.0657e-05 113585600000.0 4.0 61600010000.0 1.24734 0.0600843 3.0 852.4267 0.39157 1.0 2.39793 +SLB_2011.coesite 2.0657e-05 113585600000.0 4.0 61600010000.0 1.24734 0.0600843 3.0 852.4267 0.39157 1.0 2.39793 +SLB_2011.corundum 2.5577e-05 252545700000.0 4.33728 163200000000.0 1.64174 0.1019612 5.0 932.5696 1.32442 1.30316 2.8316 +SLB_2011.di (SLB_2011.diopside) 6.6039e-05 112241300000.0 5.23885 67000000000.0 1.37293 0.2165504 10.0 781.6146 0.95873 1.52852 1.57351 +SLB_2011.diopside 6.6039e-05 112241300000.0 5.23885 67000000000.0 1.37293 0.2165504 10.0 781.6146 0.95873 1.52852 1.57351 +SLB_2011.en (SLB_2011.enstatite) 6.2676e-05 107076800000.0 7.02751 76800000000.0 1.54596 0.2007774 10.0 812.1848 0.78479 3.43846 2.50453 +SLB_2011.enstatite 6.2676e-05 107076800000.0 7.02751 76800000000.0 1.54596 0.2007774 10.0 812.1848 0.78479 3.43846 2.50453 +SLB_2011.fa (SLB_2011.fayalite) 4.629e-05 134962200000.0 4.21796 50899990000.0 1.46257 0.20377309999999998 7.0 618.7007 1.06023 3.6466 1.02497 +SLB_2011.fayalite 4.629e-05 134962200000.0 4.21796 50899990000.0 1.46257 0.20377309999999998 7.0 618.7007 1.06023 3.6466 1.02497 +SLB_2011.fe_akimotoite 2.6854e-05 210706000000.0 5.62088 152304600000.0 1.57889 0.1319287 5.0 887.8709 1.18984 2.34514 3.5716 +SLB_2011.fe_bridgmanite (SLB_2011.fe_perovskite) 2.5485e-05 272115200000.0 4.14 132684900000.0 1.37485 0.1319287 5.0 870.8122 1.56508 1.10945 2.29211 +SLB_2011.fe_ca_ferrite 3.7258e-05 210666300000.0 4.0528 153523600000.0 1.75878 0.1738056 7.0 804.1986 1.31156 1.0 3.0268 +SLB_2011.fe_perovskite 2.5485e-05 272115200000.0 4.14 132684900000.0 1.37485 0.1319287 5.0 870.8122 1.56508 1.10945 2.29211 +SLB_2011.fe_post_perovskite 2.5459e-05 231200000000.0 4.0 129500000000.0 1.44675 0.1319287 5.0 781.3465 1.89155 1.09081 1.36382 +SLB_2011.fe_ringwoodite 4.186e-05 213412000000.0 4.22035 92000000000.0 1.35412 0.20377309999999998 7.0 677.7177 1.27193 2.3914 1.77249 +SLB_2011.fe_wadsleyite 4.28e-05 168591000000.0 4.3229 72000000000.0 1.44424 0.20377309999999998 7.0 665.4492 1.2061 2.0188 1.04017 +SLB_2011.fec2 (SLB_2011.hp_clinoferrosilite) 6.385413e-05 116025400000.0 6.23685 70623090000.0 1.84119 0.2638574 10.0 691.564 1.12473 0.20401 0.79216 +SLB_2011.fecf (SLB_2011.fe_ca_ferrite) 3.7258e-05 210666300000.0 4.0528 153523600000.0 1.75878 0.1738056 7.0 804.1986 1.31156 1.0 3.0268 +SLB_2011.feil (SLB_2011.fe_akimotoite) 2.6854e-05 210706000000.0 5.62088 152304600000.0 1.57889 0.1319287 5.0 887.8709 1.18984 2.34514 3.5716 +SLB_2011.fepv (SLB_2011.fe_perovskite) 2.5485e-05 272115200000.0 4.14 132684900000.0 1.37485 0.1319287 5.0 870.8122 1.56508 1.10945 2.29211 +SLB_2011.feri (SLB_2011.fe_ringwoodite) 4.186e-05 213412000000.0 4.22035 92000000000.0 1.35412 0.20377309999999998 7.0 677.7177 1.27193 2.3914 1.77249 +SLB_2011.ferrosilite 6.5941e-05 100538600000.0 7.02751 52000000000.0 1.54596 0.2638574 10.0 674.4769 0.71889 3.43846 1.07706 +SLB_2011.fewa (SLB_2011.fe_wadsleyite) 4.28e-05 168591000000.0 4.3229 72000000000.0 1.44424 0.20377309999999998 7.0 665.4492 1.2061 2.0188 1.04017 +SLB_2011.fo (SLB_2011.forsterite) 4.3603e-05 127955500000.0 4.21796 81599990000.0 1.46257 0.14069310000000002 7.0 809.1703 0.99282 2.10672 2.29972 +SLB_2011.forsterite 4.3603e-05 127955500000.0 4.21796 81599990000.0 1.46257 0.14069310000000002 7.0 809.1703 0.99282 2.10672 2.29972 +SLB_2011.fppv (SLB_2011.fe_post_perovskite) 2.5459e-05 231200000000.0 4.0 129500000000.0 1.44675 0.1319287 5.0 781.3465 1.89155 1.09081 1.36382 +SLB_2011.fs (SLB_2011.ferrosilite) 6.5941e-05 100538600000.0 7.02751 52000000000.0 1.54596 0.2638574 10.0 674.4769 0.71889 3.43846 1.07706 +SLB_2011.gr (SLB_2011.grossular) 0.00012512 167062200000.0 3.91544 109000000000.0 1.16274 0.4504463 20.0 822.743 1.05404 1.88887 2.38418 +SLB_2011.grossular 0.00012512 167062200000.0 3.91544 109000000000.0 1.16274 0.4504463 20.0 822.743 1.05404 1.88887 2.38418 +SLB_2011.hc (SLB_2011.hercynite) 0.000163372 208896500000.0 5.68282 84500000000.0 0.37303 0.6952224 28.0 763.231 1.21719 2.71208 2.768 +SLB_2011.he (SLB_2011.hedenbergite) 6.7867e-05 119255500000.0 5.23885 61000000000.0 1.17647 0.24809040000000002 10.0 701.5851 0.93516 1.52852 1.5703 +SLB_2011.hedenbergite 6.7867e-05 119255500000.0 5.23885 61000000000.0 1.17647 0.24809040000000002 10.0 701.5851 0.93516 1.52852 1.5703 +SLB_2011.hercynite 0.000163372 208896500000.0 5.68282 84500000000.0 0.37303 0.6952224 28.0 763.231 1.21719 2.71208 2.768 +SLB_2011.hp_clinoenstatite 6.076e-05 116025400000.0 6.23685 87927170000.0 1.84119 0.2007774 10.0 824.4439 1.12473 0.20401 2.14181 +SLB_2011.hp_clinoferrosilite 6.385413e-05 116025400000.0 6.23685 70623090000.0 1.84119 0.2638574 10.0 691.564 1.12473 0.20401 0.79216 +SLB_2011.hpcen (SLB_2011.hp_clinoenstatite) 6.076e-05 116025400000.0 6.23685 87927170000.0 1.84119 0.2007774 10.0 824.4439 1.12473 0.20401 2.14181 +SLB_2011.hpcfs (SLB_2011.hp_clinoferrosilite) 6.385413e-05 116025400000.0 6.23685 70623090000.0 1.84119 0.2638574 10.0 691.564 1.12473 0.20401 0.79216 +SLB_2011.jadeite 6.0508e-05 142287300000.0 5.23885 85000000000.0 1.37398 0.2021387 10.0 820.7623 0.903 0.39234 2.18453 +SLB_2011.jd (SLB_2011.jadeite) 6.0508e-05 142287300000.0 5.23885 85000000000.0 1.37398 0.2021387 10.0 820.7623 0.903 0.39234 2.18453 +SLB_2011.jd_majorite 0.00011094 177077200000.0 4.11067 125000000000.0 1.35756 0.4042774 20.0 895.914 1.01424 1.42169 3.30517 +SLB_2011.jdmj (SLB_2011.jd_majorite) 0.00011094 177077200000.0 4.11067 125000000000.0 1.35756 0.4042774 20.0 895.914 1.01424 1.42169 3.30517 +SLB_2011.ky (SLB_2011.kyanite) 4.4227e-05 160000000000.0 4.0 120403300000.0 1.7308 0.1620455 8.0 943.1665 0.9255 1.0 2.96665 +SLB_2011.kyanite 4.4227e-05 160000000000.0 4.0 120403300000.0 1.7308 0.1620455 8.0 943.1665 0.9255 1.0 2.96665 +SLB_2011.mg_akimotoite 2.6354e-05 210706000000.0 5.62088 132000000000.0 1.57889 0.1003887 5.0 935.9778 1.18984 2.34514 2.80782 +SLB_2011.mg_bridgmanite (SLB_2011.mg_perovskite) 2.4445e-05 250526400000.0 4.14 172900000000.0 1.69037 0.1003887 5.0 905.9412 1.56508 1.10945 2.56536 +SLB_2011.mg_ca_ferrite 3.6177e-05 210666300000.0 4.0528 129826000000.0 1.75878 0.1422656 7.0 838.6291 1.31156 1.0 2.1073 +SLB_2011.mg_majorite 0.000114324 165118300000.0 4.21183 84999990000.0 1.42969 0.4015548 20.0 822.458 0.97682 1.53581 1.0178 +SLB_2011.mg_perovskite 2.4445e-05 250526400000.0 4.14 172900000000.0 1.69037 0.1003887 5.0 905.9412 1.56508 1.10945 2.56536 +SLB_2011.mg_post_perovskite 2.4419e-05 231200000000.0 4.0 150167000000.0 1.97874 0.1003887 5.0 855.8173 1.89155 1.09081 1.16704 +SLB_2011.mg_ringwoodite 3.9493e-05 184900900000.0 4.22035 123000000000.0 1.35412 0.14069310000000002 7.0 877.7094 1.10791 2.3914 2.30461 +SLB_2011.mg_tschermaks 5.914e-05 107076800000.0 7.02751 95950860000.0 1.54596 0.20234990000000003 10.0 783.8404 0.78479 3.43846 2.49099 +SLB_2011.mg_wadsleyite 4.0515e-05 168694800000.0 4.3229 112000000000.0 1.44424 0.14069310000000002 7.0 843.4973 1.2061 2.0188 2.63683 +SLB_2011.mgc2 (SLB_2011.hp_clinoenstatite) 6.076e-05 116025400000.0 6.23685 87927170000.0 1.84119 0.2007774 10.0 824.4439 1.12473 0.20401 2.14181 +SLB_2011.mgcf (SLB_2011.mg_ca_ferrite) 3.6177e-05 210666300000.0 4.0528 129826000000.0 1.75878 0.1422656 7.0 838.6291 1.31156 1.0 2.1073 +SLB_2011.mgil (SLB_2011.mg_akimotoite) 2.6354e-05 210706000000.0 5.62088 132000000000.0 1.57889 0.1003887 5.0 935.9778 1.18984 2.34514 2.80782 +SLB_2011.mgmj (SLB_2011.mg_majorite) 0.000114324 165118300000.0 4.21183 84999990000.0 1.42969 0.4015548 20.0 822.458 0.97682 1.53581 1.0178 +SLB_2011.mgpv (SLB_2011.mg_perovskite) 2.4445e-05 250526400000.0 4.14 172900000000.0 1.69037 0.1003887 5.0 905.9412 1.56508 1.10945 2.56536 +SLB_2011.mgri (SLB_2011.mg_ringwoodite) 3.9493e-05 184900900000.0 4.22035 123000000000.0 1.35412 0.14069310000000002 7.0 877.7094 1.10791 2.3914 2.30461 +SLB_2011.mgts (SLB_2011.mg_tschermaks) 5.914e-05 107076800000.0 7.02751 95950860000.0 1.54596 0.20234990000000003 10.0 783.8404 0.78479 3.43846 2.49099 +SLB_2011.mgwa (SLB_2011.mg_wadsleyite) 4.0515e-05 168694800000.0 4.3229 112000000000.0 1.44424 0.14069310000000002 7.0 843.4973 1.2061 2.0188 2.63683 +SLB_2011.mppv (SLB_2011.mg_post_perovskite) 2.4419e-05 231200000000.0 4.0 150167000000.0 1.97874 0.1003887 5.0 855.8173 1.89155 1.09081 1.16704 +SLB_2011.na_ca_ferrite 3.627e-05 161338500000.0 4.32479 122004900000.0 2.07687 0.1420544 7.0 812.4769 0.69428 1.0 2.79016 +SLB_2011.nacf (SLB_2011.na_ca_ferrite) 3.627e-05 161338500000.0 4.32479 122004900000.0 2.07687 0.1420544 7.0 812.4769 0.69428 1.0 2.79016 +SLB_2011.neph (SLB_2011.nepheline) 5.46684e-05 53077990000.0 4.0 30700000000.0 1.33031 0.1420544 7.0 700.9422 0.69428 1.0 0.6291 +SLB_2011.nepheline 5.46684e-05 53077990000.0 4.0 30700000000.0 1.33031 0.1420544 7.0 700.9422 0.69428 1.0 0.6291 +SLB_2011.odi (SLB_2011.ortho_diopside) 6.8054e-05 107076800000.0 7.02751 58458950000.0 1.54596 0.2165504 10.0 744.6988 0.78479 3.43846 1.36161 +SLB_2011.ortho_diopside 6.8054e-05 107076800000.0 7.02751 58458950000.0 1.54596 0.2165504 10.0 744.6988 0.78479 3.43846 1.36161 +SLB_2011.pe (SLB_2011.periclase) 1.1244e-05 161383600000.0 3.84045 130900000000.0 2.1438 0.040304400000000004 2.0 767.0977 1.36127 1.7217 2.81765 +SLB_2011.periclase 1.1244e-05 161383600000.0 3.84045 130900000000.0 2.1438 0.040304400000000004 2.0 767.0977 1.36127 1.7217 2.81765 +SLB_2011.py (SLB_2011.pyrope) 0.00011308 170239600000.0 4.11067 93699990000.0 1.35756 0.4031273 20.0 823.2102 1.01424 1.42169 0.98186 +SLB_2011.pyrope 0.00011308 170239600000.0 4.11067 93699990000.0 1.35756 0.4031273 20.0 823.2102 1.01424 1.42169 0.98186 +SLB_2011.qtz (SLB_2011.quartz) 2.367003e-05 49547430000.0 4.33155 44856170000.0 0.95315 0.0600843 3.0 816.3307 -0.00296 1.0 2.36469 +SLB_2011.quartz 2.367003e-05 49547430000.0 4.33155 44856170000.0 0.95315 0.0600843 3.0 816.3307 -0.00296 1.0 2.36469 +SLB_2011.seif (SLB_2011.seifertite) 1.367e-05 327584300000.0 4.01553 227453200000.0 1.76965 0.0600843 3.0 1140.772 1.37466 2.83517 4.97108 +SLB_2011.seifertite 1.367e-05 327584300000.0 4.01553 227453200000.0 1.76965 0.0600843 3.0 1140.772 1.37466 2.83517 4.97108 +SLB_2011.sp (SLB_2011.spinel) 0.000159048 196942800000.0 5.68282 108500000000.0 0.37303 0.5690624 28.0 842.8104 1.02283 2.71208 2.66282 +SLB_2011.spinel 0.000159048 196942800000.0 5.68282 108500000000.0 0.37303 0.5690624 28.0 842.8104 1.02283 2.71208 2.66282 +SLB_2011.st (SLB_2011.stishovite) 1.4017e-05 314335200000.0 3.75122 220000000000.0 1.93334 0.0600843 3.0 1107.824 1.37466 2.83517 4.60904 +SLB_2011.stishovite 1.4017e-05 314335200000.0 3.75122 220000000000.0 1.93334 0.0600843 3.0 1107.824 1.37466 2.83517 4.60904 +SLB_2011.wu (SLB_2011.wuestite) 1.2264e-05 179444200000.0 4.9376 59000000000.0 1.44673 0.0718444 2.0 454.1592 1.53047 1.7217 -0.05731 +SLB_2011.wuestite 1.2264e-05 179444200000.0 4.9376 59000000000.0 1.44673 0.0718444 2.0 454.1592 1.53047 1.7217 -0.05731 +Name (slb3 equation of state) V_0 K_0 Kprime_0 G_0 Gprime_0 molar_mass n Debye_0 grueneisen_0 q_0 eta_s_0 +SLB_2011_ZSB_2013.fe_bridgmanite (SLB_2011_ZSB_2013.fe_perovskite) 2.549e-05 272000000000.0 4.1 133000000000.0 1.4 0.1319 5 871.0 1.57 1.1 2.3 +SLB_2011_ZSB_2013.fe_perovskite 2.549e-05 272000000000.0 4.1 133000000000.0 1.4 0.1319 5 871.0 1.57 1.1 2.3 +SLB_2011_ZSB_2013.mg_bridgmanite (SLB_2011_ZSB_2013.mg_perovskite) 2.445e-05 250500000000.0 4.01 172900000000.0 1.74 0.1 5 905.9 1.44 1.09 2.13 +SLB_2011_ZSB_2013.mg_perovskite 2.445e-05 250500000000.0 4.01 172900000000.0 1.74 0.1 5 905.9 1.44 1.09 2.13 +SLB_2011_ZSB_2013.periclase 1.124e-05 161000000000.0 3.8 131000000000.0 2.1 0.0403 2 767.0 1.36 1.7 2.8 +SLB_2011_ZSB_2013.stishovite 1.402e-05 314000000000.0 3.8 220000000000.0 1.9 0.0601 3 1108.0 1.37 2.8 4.6 +SLB_2011_ZSB_2013.wuestite 1.226e-05 179000000000.0 4.9 59000000000.0 1.4 0.0718 2 454.0 1.53 1.7 -0.1 +Name (slb3 equation of state) V_0 K_0 Kprime_0 G_0 Gprime_0 molar_mass n Debye_0 grueneisen_0 q_0 eta_s_0 +SLB_2022.ab 0.000100452 59752680000.0 2.77841 36000000000.0 1.38571 0.262223 13.0 720.00359 0.57885 1.0 1.02978 +SLB_2022.al 0.00011543 173896370000.0 4.91341 96000000000.0 1.40927 0.49776 20.0 741.38227 1.06493 1.42169 2.09289 +SLB_2022.al_perovskite (SLB_2022.alpv) 2.4944e-05 242400000000.0 4.1 169199620000.0 1.55703 0.101961 5.0 858.26509 1.54222 0.84088 2.2751 +SLB_2022.al_post_perovskite (SLB_2022.appv) 2.3847e-05 249000000000.0 4.0 91965260000.0 1.81603 0.101961 5.0 722.93835 1.88758 2.04631 2.52605 +SLB_2022.albite (SLB_2022.ab) 0.000100452 59752680000.0 2.77841 36000000000.0 1.38571 0.262223 13.0 720.00359 0.57885 1.0 1.02978 +SLB_2022.almandine (SLB_2022.al) 0.00011543 173896370000.0 4.91341 96000000000.0 1.40927 0.49776 20.0 741.38227 1.06493 1.42169 2.09289 +SLB_2022.alpha_nao2_phase (SLB_2022.anao) 4.542e-05 161143930000.0 3.90838 108455900000.0 2.14668 0.16394023 8.0 753.49641 1.45033 1.5487 0.78047 +SLB_2022.alpha_pbo_2_sio_2 (SLB_2022.apbo) 1.367e-05 327156010000.0 4.01662 227411590000.0 1.77078 0.060085 3.0 1128.9459 1.55674 2.2096 4.55828 +SLB_2022.alpv 2.4944e-05 242400000000.0 4.1 169199620000.0 1.55703 0.101961 5.0 858.26509 1.54222 0.84088 2.2751 +SLB_2022.an 0.00010061 84093310000.0 6.73404 39900000000.0 1.09129 0.278211 13.0 752.34537 0.38497 1.0 1.63323 +SLB_2022.anao 4.542e-05 161143930000.0 3.90838 108455900000.0 2.14668 0.16394023 8.0 753.49641 1.45033 1.5487 0.78047 +SLB_2022.anorthite (SLB_2022.an) 0.00010061 84093310000.0 6.73404 39900000000.0 1.09129 0.278211 13.0 752.34537 0.38497 1.0 1.63323 +SLB_2022.apbo 1.367e-05 327156010000.0 4.01662 227411590000.0 1.77078 0.060085 3.0 1128.9459 1.55674 2.2096 4.55828 +SLB_2022.appv 2.3847e-05 249000000000.0 4.0 91965260000.0 1.81603 0.101961 5.0 722.93835 1.88758 2.04631 2.52605 +SLB_2022.ca_perovskite (SLB_2022.capv) 2.745e-05 236000000000.0 3.9 155205240000.0 2.22637 0.116164 5.0 798.78581 1.88943 0.89662 1.23493 +SLB_2022.capv 2.745e-05 236000000000.0 3.9 155205240000.0 2.22637 0.116164 5.0 798.78581 1.88943 0.89662 1.23493 +SLB_2022.cats 6.3574e-05 113759900000.0 4.8061 74424990000.0 1.71384 0.218123 10.0 804.36068 0.82288 0.60142 1.73383 +SLB_2022.cen 6.25e-05 113759900000.0 4.8061 76970360000.0 1.71384 0.2007774 10.0 806.64315 1.00921 0.60142 1.43121 +SLB_2022.clinoenstatite (SLB_2022.cen) 6.25e-05 113759900000.0 4.8061 76970360000.0 1.71384 0.2007774 10.0 806.64315 1.00921 0.60142 1.43121 +SLB_2022.co 2.5577e-05 252585720000.0 3.88671 163200000000.0 1.81492 0.101961 5.0 932.21586 1.3081 1.71245 2.63052 +SLB_2022.coes 2.0657e-05 103538150000.0 2.9007 61600000000.0 0.49686 0.060085 3.0 880.23946 0.29064 1.0 2.75988 +SLB_2022.coesite (SLB_2022.coes) 2.0657e-05 103538150000.0 2.9007 61600000000.0 0.49686 0.060085 3.0 880.23946 0.29064 1.0 2.75988 +SLB_2022.corundum (SLB_2022.co) 2.5577e-05 252585720000.0 3.88671 163200000000.0 1.81492 0.101961 5.0 932.21586 1.3081 1.71245 2.63052 +SLB_2022.cristobalite (SLB_2022.crst) 2.72397e-05 11500000000.0 9.0 20327540000.0 4.06551 0.060085 3.0 794.74452 0.01515 1.0 1.17003 +SLB_2022.crst 2.72397e-05 11500000000.0 9.0 20327540000.0 4.06551 0.060085 3.0 794.74452 0.01515 1.0 1.17003 +SLB_2022.di 6.6039e-05 113759900000.0 4.8061 72700000000.0 1.71384 0.2165504 10.0 782.57306 1.00921 0.60142 1.06175 +SLB_2022.diopside (SLB_2022.di) 6.6039e-05 113759900000.0 4.8061 72700000000.0 1.71384 0.2165504 10.0 782.57306 1.00921 0.60142 1.06175 +SLB_2022.en 6.2676e-05 107076810000.0 7.02751 76800000000.0 1.54596 0.2007774 10.0 812.21227 0.78477 3.43847 2.5045 +SLB_2022.enstatite (SLB_2022.en) 6.2676e-05 107076810000.0 7.02751 76800000000.0 1.54596 0.2007774 10.0 812.21227 0.78477 3.43847 2.5045 +SLB_2022.fa 4.629e-05 136485580000.0 4.88157 51220000000.0 0.85893 0.203777 7.0 618.96116 1.08388 2.88055 1.65937 +SLB_2022.fapv 2.72604e-05 223325500000.0 4.1 150042090000.0 1.73259 0.1308249 5.0 755.38117 1.54222 0.84088 2.55505 +SLB_2022.fayalite (SLB_2022.fa) 4.629e-05 136485580000.0 4.88157 51220000000.0 0.85893 0.203777 7.0 618.96116 1.08388 2.88055 1.65937 +SLB_2022.fe2o3_perovskite_hs (SLB_2022.hepv) 3.08668e-05 135000000000.0 4.0 88766580000.0 1.73259 0.15968852 5.0 613.90405 1.54222 0.84088 0.66524 +SLB_2022.fe2o3_perovskite_ls (SLB_2022.hlpv) 2.75209e-05 204251000000.0 4.1 163996000000.0 1.73259 0.15968852 5.0 725.62214 1.54222 0.84088 3.0318 +SLB_2022.fe_akimotoite (SLB_2022.feil) 2.6854e-05 210693870000.0 5.2154 160833570000.0 1.81492 0.131931 5.0 781.36175 1.19458 2.2246 3.43813 +SLB_2022.fe_ca_ferrite (SLB_2022.fecf) 3.7216e-05 213000000000.0 4.1 159709650000.0 1.93591 0.173806 7.0 734.07527 1.56672 1.0 2.34163 +SLB_2022.fe_nal_phase (SLB_2022.fnal) 0.000112045 203995010000.0 4.31884 149593770000.0 1.7423 0.48966601 21.0 795.29328 1.42971 1.0 2.65939 +SLB_2022.fe_perovskite (SLB_2022.fepv) 2.5321e-05 270582550000.00003 4.01 130020980000.00002 1.37254 0.131931 5.0 746.56455 1.54222 0.84088 2.0941 +SLB_2022.fe_perovskite_low_spin (SLB_2022.flpv) 2.497e-05 270582550000.00003 4.01 130337050000.0 1.37411 0.131931 5.0 692.38659 1.54222 0.84088 1.99344 +SLB_2022.fe_postperovskite (SLB_2022.fppv) 2.46519e-05 292000000000.0 3.74 129500000000.0 1.31526 0.131931 5.0 794.15823 1.76958 2.04631 1.72601 +SLB_2022.fe_ringwoodite (SLB_2022.feri) 4.186e-05 213410280000.0 4.22034 92000000000.0 1.35412 0.203777 7.0 662.84304 1.26584 2.39042 1.77066 +SLB_2022.fe_wadsleyite (SLB_2022.fewa) 4.28e-05 168579210000.0 4.12303 72000000000.0 1.50973 0.203777 7.0 647.34559 1.20388 2.21007 0.95246 +SLB_2022.fealo3_perovskite_hs (SLB_2022.fapv) 2.72604e-05 223325500000.0 4.1 150042090000.0 1.73259 0.1308249 5.0 755.38117 1.54222 0.84088 2.55505 +SLB_2022.fec2 6.38541e-05 116024900000.0 6.23682 75147210000.0 1.8412 0.2638614 10.0 698.72086 1.12442 0.20362 0.98031 +SLB_2022.fecf 3.7216e-05 213000000000.0 4.1 159709650000.0 1.93591 0.173806 7.0 734.07527 1.56672 1.0 2.34163 +SLB_2022.feil 2.6854e-05 210693870000.0 5.2154 160833570000.0 1.81492 0.131931 5.0 781.36175 1.19458 2.2246 3.43813 +SLB_2022.fepv 2.5321e-05 270582550000.00003 4.01 130020980000.00002 1.37254 0.131931 5.0 746.56455 1.54222 0.84088 2.0941 +SLB_2022.feri 4.186e-05 213410280000.0 4.22034 92000000000.0 1.35412 0.203777 7.0 662.84304 1.26584 2.39042 1.77066 +SLB_2022.ferrosilite (SLB_2022.fs) 6.5941e-05 100545910000.0 7.87534 52000000000.0 1.54596 0.2638614 10.0 682.67865 0.71519 3.43847 1.08309 +SLB_2022.fewa 4.28e-05 168579210000.0 4.12303 72000000000.0 1.50973 0.203777 7.0 647.34559 1.20388 2.21007 0.95246 +SLB_2022.flpv 2.497e-05 270582550000.00003 4.01 130337050000.0 1.37411 0.131931 5.0 692.38659 1.54222 0.84088 1.99344 +SLB_2022.fnal 0.000112045 203995010000.0 4.31884 149593770000.0 1.7423 0.48966601 21.0 795.29328 1.42971 1.0 2.65939 +SLB_2022.fo 4.3603e-05 127955500000.0 4.21796 81600000000.0 1.46257 0.140695 7.0 809.1977 0.9928 2.10671 2.29968 +SLB_2022.forsterite (SLB_2022.fo) 4.3603e-05 127955500000.0 4.21796 81600000000.0 1.46257 0.140695 7.0 809.1977 0.9928 2.10671 2.29968 +SLB_2022.fppv 2.46519e-05 292000000000.0 3.74 129500000000.0 1.31526 0.131931 5.0 794.15823 1.76958 2.04631 1.72601 +SLB_2022.fs 6.5941e-05 100545910000.0 7.87534 52000000000.0 1.54596 0.2638614 10.0 682.67865 0.71519 3.43847 1.08309 +SLB_2022.gr 0.00012512 167062260000.0 3.91544 109000000000.0 1.16274 0.450449 20.0 822.77062 1.05402 1.88886 2.38415 +SLB_2022.grossular (SLB_2022.gr) 0.00012512 167062260000.0 3.91544 109000000000.0 1.16274 0.450449 20.0 822.77062 1.05402 1.88886 2.38415 +SLB_2022.hc 0.000163372 208982310000.0 4.62659 84500000000.0 0.62792 0.69524 28.0 794.21184 1.19332 4.05077 2.49369 +SLB_2022.he 6.7867e-05 119204720000.0 4.81927 61000000000.0 1.71384 0.2480924 10.0 702.08234 0.96665 0.60142 1.01745 +SLB_2022.hedenbergite (SLB_2022.he) 6.7867e-05 119204720000.0 4.81927 61000000000.0 1.71384 0.2480924 10.0 702.08234 0.96665 0.60142 1.01745 +SLB_2022.hem 3.0287e-05 204245330000.0 4.0997 91000000000.0 1.81492 0.15968852 5.0 653.80768 1.58945 2.2246 0.52408 +SLB_2022.hematite (SLB_2022.hem) 3.0287e-05 204245330000.0 4.0997 91000000000.0 1.81492 0.15968852 5.0 653.80768 1.58945 2.2246 0.52408 +SLB_2022.hepv 3.08668e-05 135000000000.0 4.0 88766580000.0 1.73259 0.15968852 5.0 613.90405 1.54222 0.84088 0.66524 +SLB_2022.hercynite (SLB_2022.hc) 0.000163372 208982310000.0 4.62659 84500000000.0 0.62792 0.69524 28.0 794.21184 1.19332 4.05077 2.49369 +SLB_2022.high_pressure_magnetit (SLB_2022.hmag) 4.1702e-05 172000000000.0 4.0 108730730000.0 1.93591 0.23153307 7.0 533.17958 1.56672 1.0 0.90477 +SLB_2022.hlpv 2.75209e-05 204251000000.0 4.1 163996000000.0 1.73259 0.15968852 5.0 725.62214 1.54222 0.84088 3.0318 +SLB_2022.hmag 4.1702e-05 172000000000.0 4.0 108730730000.0 1.93591 0.23153307 7.0 533.17958 1.56672 1.0 0.90477 +SLB_2022.hp_clinoenstatite (SLB_2022.mgc2) 6.076e-05 116024900000.0 6.23682 87927160000.0 1.8412 0.2007774 10.0 822.89602 1.12442 0.20362 2.14112 +SLB_2022.hp_clinoferrosilite (SLB_2022.fec2) 6.38541e-05 116024900000.0 6.23682 75147210000.0 1.8412 0.2638614 10.0 698.72086 1.12442 0.20362 0.98031 +SLB_2022.hppv 2.76884e-05 176500000000.0 4.0 159009520000.0 1.85188 0.15968852 5.0 688.0644 1.76958 2.04631 2.00124 +SLB_2022.hs_fe2o3_post_perovski (SLB_2022.hppv) 2.76884e-05 176500000000.0 4.0 159009520000.0 1.85188 0.15968852 5.0 688.0644 1.76958 2.04631 2.00124 +SLB_2022.jadeite (SLB_2022.jd) 6.0508e-05 142292260000.0 4.8061 85000000000.0 1.71384 0.2021387 10.0 820.78389 0.89983 0.78628 1.88167 +SLB_2022.jd 6.0508e-05 142292260000.0 4.8061 85000000000.0 1.71384 0.2021387 10.0 820.78389 0.89983 0.78628 1.88167 +SLB_2022.ky 4.4227e-05 160000000000.0 4.0 117854530000.0 1.69416 0.1620456 8.0 943.19593 0.92549 1.0 2.90375 +SLB_2022.kyanite (SLB_2022.ky) 4.4227e-05 160000000000.0 4.0 117854530000.0 1.69416 0.1620456 8.0 943.19593 0.92549 1.0 2.90375 +SLB_2022.lime_tschermak (SLB_2022.cats) 6.3574e-05 113759900000.0 4.8061 74424990000.0 1.71384 0.218123 10.0 804.36068 0.82288 0.60142 1.73383 +SLB_2022.lppv 2.62534e-05 176500000000.0 4.0 207396350000.0 1.85188 0.15968852 5.0 720.85819 1.76958 2.04631 3.23888 +SLB_2022.ls_fe2o3_post_perovski (SLB_2022.lppv) 2.62534e-05 176500000000.0 4.0 207396350000.0 1.85188 0.15968852 5.0 720.85819 1.76958 2.04631 3.23888 +SLB_2022.mag 4.4528e-05 183965710000.0 5.24573 60300000000.0 -0.05466 0.23153307 7.0 520.10184 1.32115 1.5487 2.43429 +SLB_2022.magnetite (SLB_2022.mag) 4.4528e-05 183965710000.0 5.24573 60300000000.0 -0.05466 0.23153307 7.0 520.10184 1.32115 1.5487 2.43429 +SLB_2022.mg_akimotoite (SLB_2022.mgil) 2.6354e-05 210693870000.0 5.2154 132000000000.0 1.81492 0.100389 5.0 932.602 1.19458 2.2246 3.40174 +SLB_2022.mg_ca_ferrite (SLB_2022.mgcf) 3.6135e-05 213000000000.0 4.1 129699999999.99998 1.93591 0.142266 7.0 831.14221 1.56672 1.0 1.30302 +SLB_2022.mg_majorite (SLB_2022.mgmj) 0.000114324 165118370000.0 4.21183 85000000000.0 1.42969 0.40156 20.0 822.48562 0.97681 1.53581 1.01779 +SLB_2022.mg_nal_phase (SLB_2022.mnal) 0.000109883 203995010000.0 4.31884 129000000000.0 1.7423 0.42658581 21.0 858.38264 1.42971 1.0 1.93069 +SLB_2022.mg_perovskite (SLB_2022.mgpv) 2.4445e-05 250546900000.0 4.13499 172900000000.0 1.73259 0.100389 5.0 880.01895 1.54222 0.84088 1.65573 +SLB_2022.mg_postperovskite (SLB_2022.mppv) 2.35252e-05 292000000000.0 3.74 171135870000.0 1.85188 0.100389 5.0 941.49795 1.76958 2.04631 1.2881 +SLB_2022.mg_ringwoodite (SLB_2022.mgri) 3.9493e-05 184899930000.0 4.22034 123000000000.0 1.35412 0.140693 7.0 875.13511 1.1072 2.39042 2.30288 +SLB_2022.mg_tschermaks (SLB_2022.mgts) 5.914e-05 107076810000.0 7.02751 93471460000.0 1.54596 0.20235 10.0 783.94073 0.78477 3.43847 2.39416 +SLB_2022.mg_wadsleyite (SLB_2022.mgwa) 4.0515e-05 168701060000.0 4.12303 112000000000.0 1.50973 0.140695 7.0 845.20132 1.20388 2.21007 2.56133 +SLB_2022.mgc2 6.076e-05 116024900000.0 6.23682 87927160000.0 1.8412 0.2007774 10.0 822.89602 1.12442 0.20362 2.14112 +SLB_2022.mgcf 3.6135e-05 213000000000.0 4.1 129699999999.99998 1.93591 0.142266 7.0 831.14221 1.56672 1.0 1.30302 +SLB_2022.mgil 2.6354e-05 210693870000.0 5.2154 132000000000.0 1.81492 0.100389 5.0 932.602 1.19458 2.2246 3.40174 +SLB_2022.mgmj 0.000114324 165118370000.0 4.21183 85000000000.0 1.42969 0.40156 20.0 822.48562 0.97681 1.53581 1.01779 +SLB_2022.mgpv 2.4445e-05 250546900000.0 4.13499 172900000000.0 1.73259 0.100389 5.0 880.01895 1.54222 0.84088 1.65573 +SLB_2022.mgri 3.9493e-05 184899930000.0 4.22034 123000000000.0 1.35412 0.140693 7.0 875.13511 1.1072 2.39042 2.30288 +SLB_2022.mgts 5.914e-05 107076810000.0 7.02751 93471460000.0 1.54596 0.20235 10.0 783.94073 0.78477 3.43847 2.39416 +SLB_2022.mgwa 4.0515e-05 168701060000.0 4.12303 112000000000.0 1.50973 0.140695 7.0 845.20132 1.20388 2.21007 2.56133 +SLB_2022.mnal 0.000109883 203995010000.0 4.31884 129000000000.0 1.7423 0.42658581 21.0 858.38264 1.42971 1.0 1.93069 +SLB_2022.mppv 2.35252e-05 292000000000.0 3.74 171135870000.0 1.85188 0.100389 5.0 941.49795 1.76958 2.04631 1.2881 +SLB_2022.na_ca_ferrite (SLB_2022.nacf) 3.627e-05 220000000000.0 4.1 135326619999.99998 1.93591 0.142054 7.0 683.31827 1.56672 1.0 1.36827 +SLB_2022.na_majorite (SLB_2022.namj) 0.000110842 172035150000.0 5.2005 114700000000.0 1.35756 0.40270437 20.0 844.73722 1.25078 0.10916 2.4849 +SLB_2022.na_nal_phase (SLB_2022.nnal) 0.000109401 203995010000.0 4.31884 144451020000.0 1.7423 0.42616294 21.0 850.32833 1.42971 1.0 2.42502 +SLB_2022.nacf 3.627e-05 220000000000.0 4.1 135326619999.99998 1.93591 0.142054 7.0 683.31827 1.56672 1.0 1.36827 +SLB_2022.namj 0.000110842 172035150000.0 5.2005 114700000000.0 1.35756 0.40270437 20.0 844.73722 1.25078 0.10916 2.4849 +SLB_2022.neph 5.38684e-05 53055500000.0 4.0 30700000000.0 1.33087 0.14205431 7.0 743.57985 0.6969 1.0 0.6241 +SLB_2022.nepheline (SLB_2022.neph) 5.38684e-05 53055500000.0 4.0 30700000000.0 1.33087 0.14205431 7.0 743.57985 0.6969 1.0 0.6241 +SLB_2022.nnal 0.000109401 203995010000.0 4.31884 144451020000.0 1.7423 0.42616294 21.0 850.32833 1.42971 1.0 2.42502 +SLB_2022.odi 6.8054e-05 107076810000.0 7.02751 57508750000.0 1.54596 0.2165504 10.0 744.54893 0.78477 3.43847 1.31909 +SLB_2022.ortho_diopside (SLB_2022.odi) 6.8054e-05 107076810000.0 7.02751 57508750000.0 1.54596 0.2165504 10.0 744.54893 0.78477 3.43847 1.31909 +SLB_2022.pe 4.4976e-05 161143930000.0 3.90838 130900000000.0 2.14668 0.16121782 8.0 770.90151 1.45033 1.5487 2.56123 +SLB_2022.periclase (SLB_2022.pe) 4.4976e-05 161143930000.0 3.90838 130900000000.0 2.14668 0.16121782 8.0 770.90151 1.45033 1.5487 2.56123 +SLB_2022.py 0.00011308 170239640000.0 4.11067 93700000000.0 1.35756 0.40313 20.0 823.23783 1.01422 1.42169 0.98186 +SLB_2022.pyrope (SLB_2022.py) 0.00011308 170239640000.0 4.11067 93700000000.0 1.35756 0.40313 20.0 823.23783 1.01422 1.42169 0.98186 +SLB_2022.qtz 2.24211e-05 61425370000.0 19.78011 44857760000.0 -0.04277 0.060085 3.0 884.20481 -0.03958 1.0 2.40509 +SLB_2022.quartz (SLB_2022.qtz) 2.24211e-05 61425370000.0 19.78011 44857760000.0 -0.04277 0.060085 3.0 884.20481 -0.03958 1.0 2.40509 +SLB_2022.sp 0.000159048 195139330000.0 4.62659 109000000000.0 0.62792 0.569068 28.0 856.3695 0.97518 4.05077 2.44263 +SLB_2022.spinel (SLB_2022.sp) 0.000159048 195139330000.0 4.62659 109000000000.0 0.62792 0.569068 28.0 856.3695 0.97518 4.05077 2.44263 +SLB_2022.st 1.4017e-05 305833020000.0 4.0292 228000000000.0 1.94045 0.060085 3.0 1092.17047 1.55674 2.2096 4.40394 +SLB_2022.stishovite (SLB_2022.st) 1.4017e-05 305833020000.0 4.0292 228000000000.0 1.94045 0.060085 3.0 1092.17047 1.55674 2.2096 4.40394 +SLB_2022.wu 4.9024e-05 160700000000.0 4.0 59000000000.0 1.44764 0.28737822 8.0 454.1752 1.45033 1.5487 0.06776 +SLB_2022.wuls 4.33997e-05 199700000000.0 4.0 59000000000.0 1.44073 0.28737822 8.0 524.57881 1.45033 1.5487 -0.13801 +SLB_2022.wustite (SLB_2022.wu) 4.9024e-05 160700000000.0 4.0 59000000000.0 1.44764 0.28737822 8.0 454.1752 1.45033 1.5487 0.06776 +SLB_2022.wustite_low_spin (SLB_2022.wuls) 4.33997e-05 199700000000.0 4.0 59000000000.0 1.44073 0.28737822 8.0 524.57881 1.45033 1.5487 -0.13801 +Name (hp_tmt equation of state) V_0 K_0 Kprime_0 Kdprime_0 molar_mass n Cp +Sundman_1991.bcc_iron 7.09e-06 164000000000.0 5.16 -3.1e-11 0.055845 1.0 [21.09, 0.0101455, -221508.0, 47.1947] +Sundman_1991.fcc_iron 6.93863394593e-06 153900000000.0 5.2 -3.37e-11 0.055845 1.0 [22.24, 0.0088656, -221517.0, 47.1998] +Name (aa equation of state) T_0 S_0 V_0 K_S Kprime_S Kprime_prime_S grueneisen_0 grueneisen_prime grueneisen_n +other.liquid_iron 1811.0 100.0 7.956261575723038e-06 109700000000.0 4.661 -4.3e-11 1.735 -2.3278717879846e-06 -1.87 +Name (mgd3 equation of state) V_0 K_0 Kprime_0 G_0 Gprime_0 molar_mass n Debye_0 grueneisen_0 q_0 eta_s_0 +other.Speziale_fe_periclase_HS 2.29e-05 157500000000.0 3.92 nan nan 0.04567 2 587 1.46 1.2 +other.Speziale_fe_periclase_LS 2.149e-05 186000000000.0 4.6 nan nan 0.04567 2 587.0 1.46 1.2 +Name (slb3 equation of state) V_0 K_0 Kprime_0 G_0 Gprime_0 molar_mass n Debye_0 grueneisen_0 q_0 eta_s_0 +other.ZSB_2013_fe_perovskite 2.549e-05 272000000000.0 4.1 133000000000.0 1.4 0.1319 5 871.0 1.57 1.1 2.3 +other.ZSB_2013_mg_perovskite 2.445e-05 250500000000.0 4.01 172900000000.0 1.74 0.1 5 905.9 1.44 1.09 2.13 +other.fe_perovskite (SLB_2011.fe_perovskite) 2.5485e-05 272115200000.0 4.14 132684900000.0 1.37485 0.1319287 5.0 870.8122 1.56508 1.10945 2.29211 +other.mg_perovskite (SLB_2011.mg_perovskite) 2.4445e-05 250526400000.0 4.14 172900000000.0 1.69037 0.1003887 5.0 905.9412 1.56508 1.10945 2.56536 +other.periclase (SLB_2011.periclase) 1.1244e-05 161383600000.0 3.84045 130900000000.0 2.1438 0.040304400000000004 2.0 767.0977 1.36127 1.7217 2.81765 +other.wuestite (SLB_2011.wuestite) 1.2264e-05 179444200000.0 4.9376 59000000000.0 1.44673 0.0718444 2.0 454.1592 1.53047 1.7217 -0.05731 diff --git a/tests/test_eos_consistency.py b/tests/test_eos_consistency.py index 465ff0724..72ef8f824 100644 --- a/tests/test_eos_consistency.py +++ b/tests/test_eos_consistency.py @@ -28,6 +28,13 @@ def test_SLB(self): check_eos_consistency(burnman.minerals.SLB_2011.periclase(), P, T), True ) + def test_SLB_2022(self): + P = 2.0e9 + T = 500.0 + self.assertEqual( + check_eos_consistency(burnman.minerals.SLB_2022.almandine(), P, T), True + ) + def test_modifier(self): P = 10.0e9 T = 3000.0