diff --git a/.gitignore b/.gitignore index 8d27bf6..5043ad2 100644 --- a/.gitignore +++ b/.gitignore @@ -3,4 +3,5 @@ *.jl.mem /docs/Manifest.toml /docs/build/ -Manifest.toml \ No newline at end of file +Manifest.toml +.vscode/**/* \ No newline at end of file diff --git a/.vscode/settings.json b/.vscode/settings.json new file mode 100644 index 0000000..9e26dfe --- /dev/null +++ b/.vscode/settings.json @@ -0,0 +1 @@ +{} \ No newline at end of file diff --git a/Project.toml b/Project.toml index f0d28c1..c1880d4 100644 --- a/Project.toml +++ b/Project.toml @@ -4,7 +4,18 @@ authors = ["Avinash Subramanian"] version = "1.0.0-DEV" [deps] -SafeTestsets = "1bc83da4-3b8d-516f-aca4-4fe02f6d838f" +Clapeyron = "7c7805af-46cc-48c9-995b-ed0ed2dc909a" +DelimitedFiles = "8bb1440f-4735-579b-a4ab-409b98df4dab" +DifferentialEquations = "0c46a032-eb83-5123-abaf-570d42b7fbaa" +GCIdentifier = "b7ea765e-cbac-4e4a-9b0d-5427cc302506" +JSON = "682c06a0-de6a-54ab-a142-c8b1cf79cde6" +ModelingToolkit = "961ee093-0014-501f-94e3-6117800e7a78" +NonlinearSolve = "8913a72c-1f9b-4ce2-8d82-65094dcecaec" +Reexport = "189a3867-3050-52da-a836-e630ba90ab69" +SciMLBase = "0bca4576-84f4-4d90-8ffe-ffa030f20462" +SymbolicUtils = "d1185830-fcd6-423d-90d6-eec64667417b" +Symbolics = "0c5d862f-8b57-4792-8d23-62f2024744c7" +UnPack = "3a884ed6-31ef-47d7-9d2a-63182c4928ed" [compat] julia = "1.10" diff --git a/src/ProcessSimulator.jl b/src/ProcessSimulator.jl index 29592a9..69478e8 100644 --- a/src/ProcessSimulator.jl +++ b/src/ProcessSimulator.jl @@ -1,7 +1,18 @@ module ProcessSimulator -# Write your package code here. -export Gibbs -include("Reactors/Gibbs.jl") +using ModelingToolkit, JSON , DifferentialEquations +using ModelingToolkit: t_nounits as t, D_nounits as D +import ModelingToolkit: scalarize, equations, get_unknowns, defaults +using Clapeyron, Symbolics + + +export load_component_properties, read_reidcp, my_model, enthalpy_simple, molar_density_simple, MaterialSource, SimpleCSTR, my_model, KineticReactionNetwork, Display +include("utils") +include("Reactors/ReactionManager/KineticReaction.jl") +include("Reactors/SimplifiedCSTR.jl") + +export MaterialSource +include("Sources/MaterialSource.jl") +include("Sources/Sourceutils.jl") end diff --git a/src/Reactors/CSTR.jl b/src/Reactors/CSTR.jl new file mode 100644 index 0000000..d6546e9 --- /dev/null +++ b/src/Reactors/CSTR.jl @@ -0,0 +1,337 @@ +@component function CSTR(; substances_user = ["methanol", "propylene oxide", "water"], + Nc = length(substances_user), + phase = :liquid, + model = PR(substances_user), + properties = Dict(subs => load_component_properties(subs) for subs in substances_user), + Reaction = KineticReactionNetwork(Af_r = [1.0], Ef_r = [1.0], Do_r = [1.0 1.0], name = :DefaultReaction), + ninports = 1, + InPorts = [matcon(; Nc = Nc, name = Symbol("InPorts$i")) for i in 1:ninports], + Ac = 1.0, + height_out_port = 0.0 + ) + + #Numerical variables + + #Constants + GravitationalConst = 9.81 # m²/s + gramsToKilograms = 10^(-3) + Rᵍ = 8.314 # J/(mol K) + + #Properties of individual substances + MWs = [properties[subs]["MW"] for subs in substances_user] + + #Connection and reaction constants + Nri = defaults(Reaction)[@nonamespace Reaction.Nr] + + pars = @parameters begin + ## How to inherent parameters from Reaction? + height_out = height_out_port, [description = "Height of the outlet stream port with reference from the bottom of the tank (m)"] + N_InPorts = ninports + Nr = Nri, [description = "Number of reactions"] + Af_r[1:Nri] = defaults(Reaction)[@nonamespace Reaction.Af_r], [description = "Arrhenius constant of each reaction at given temperature ()"] + Coef_Cr[1:Nri, 1:Nc] = defaults(Reaction)[@nonamespace Reaction.Coef_Cr], [description = "Stoichiometric coefficients of each component in each reaction (-)"] + Do_r[1:Nri, 1:Nc] = defaults(Reaction)[@nonamespace Reaction.Do_r], [description = "Forward order of the components (-)"] + Ef_r[1:Nri] = defaults(Reaction)[@nonamespace Reaction.Ef_r], [description = "Activation energy of each reaction at given temperature ()"] + N = Nc, [description = "Number of components"] + A = Ac, [description = "Cross sectional area of the tank (m²)"] + end + + + OutPorts = @named begin + Out = matcon(; Nc = Nc) + end + + vars = @variables begin + + T(t), [description = "Temperature of vessel contents (K)"] + M(t), [description = "Mass holdup in the tank (kg)"] + N(t), [description = "Total molar holdup in the tank (kmol)"] + V(t), [description = "Volume holdup in the tank (m³)"] + (Nᵢ(t))[1:Nc], [description = "Molar holdup of each component in the tank (mol)"] + (Cᵢ(t))[1:Nc], [description = "Concentration of each component in the tank (mol/m³)"] + (ρ(t)), [description = "Molar Density of the fluid in the tank (mol/m³)"] + (ρʷ(t)), [description = "Mass Density of the fluid in the tank (kg/m³)"] + #h_out(t), [description = "Outlet specific enthalpy (J/mol)"] + MW(t), [description = "Molecular weight of fluid in the tank (kg/kmol)"] + P_out(t), [description = "Pressure at the outlet stream level (Pa)"] + H(t), [description = "Enthalpy holdup of the fluid in the tank (J)"] + S(t), [description = "Entropy holdup of the fluid in the tank (J/K)"] + F_out(t), [description = "Outlet molar flow rate (mol/s)"] + Fʷ_out(t), [description = "Outlet molar flow rate (mol/s)"] + Q_out(t), [description = "Outlet volumetric flow rate (m³/s)"] # DoF + height(t), [description = "Liquid level in vessel measured from bottom of the tank (m)"] + + (Cᵢ_in(t))[1:Nc, 1:Ni_InPorts], [description = "Inlet concentration of each component (mol/m³)"] # DoF through inlet stream + (F_in(t))[1:Ni_InPorts], [description = "Inlet molar flow rate (mol/s)"] # DoF through inlet stream + (Q_in(t))[1:Ni_InPorts], [description = "Inlet volumetric flow rate(s) (m³/s)"] + (T_in(t))[1:Ni_InPorts], [description = "Inlet temperature (K)"] # DoF through inlet stream + (h_in(t))[1:Ni_InPorts], [description = "Inlet specific enthalpy (J/mol)"] + (ρ_in(t))[1:Ni_InPorts], [description = "Inlet density (mol/m³)"] + (ρʷ_in(t))[1:Ni_InPorts], [description = "Inlet density (mol/m³)"] + P_atm(t), [description = "Tank pressure (Pa)"] # Pontetial DoF and equal to inlet pressures. + Q̇(t), [description = "Heat transfer rate (J/s)"] # Potential DoF + (r(t))[1:Nri, 1:Nc], [description = "Rate of each reaction for each component (mol/s/m³)"] + (R(t))[1:Nc], [description = "Overall reaction rate (mol/s/m³)"] + end + + + + #Reaction equations + reaction_rate = [r[i, j] ~ Af_r[i]*exp(-Ef_r[i]/(Rᵍ*T))*(Cᵢ[:].^(Do_r[j, :])) for i in 1:Nri for j in 1:Nc] # If there's an inert, the order is just zero, but it has to be written + overall_reaction_rate = [R[i] ~ sum(r[:, i].*Coef_Cr[:, i]) for i in 1:Nc] # If there's an inert, the coefficient is just zero, but it has to be written + + + #Inlet connector variables's equations + atm_pressure = [P_atm ~ InPorts[1].P] + mass_density_eqs = [ρʷ_in[j] ~ InPorts[j].ρʷ for j in 1:Ni_InPorts] + molar_density_eqs = [ρ_in[j] ~ InPorts[j].ρ for j in 1:Ni_InPorts] + inletenthalpy = [h_in[j] ~ InPorts[j].H for j in 1:Ni_InPorts] + inletconcentrations = [Cᵢ_in[i, j] ~ InPorts[j].z₁[i]*ρ_in[j] for j in 1:Ni_InPorts for i in 1:Nc] + inlettemperature_eqs = [T_in[j] ~ InPorts[j].T for j in 1:Ni_InPorts] + inletmolarflow_eqs = [F_in[j] ~ InPorts[j].F for j in 1:Ni_InPorts] + volumetricflow_eqs = [Q_in[j] ~ F_in[j] / ρ_in[j] for j in 1:Ni_InPorts] + + eqs = [reaction_rate; overall_reaction_rate; atm_pressure; mass_density_eqs; molar_density_eqs; inletenthalpy; inletconcentrations; inlettemperature_eqs; inletmolarflow_eqs; volumetricflow_eqs] + + #Outlet connector equations: + out_conn = [Out.P ~ P_out + Out.T ~ T + Out.F ~ F_out + Out.Fʷ ~ Fʷ_out + Out.H ~ H/N + Out.S ~ S/N + Out.ρʷ ~ ρʷ + Out.ρ ~ ρ + scalarize(Out.z₁ .~ Nᵢ/N)... + Out.MW[1] ~ MW + ] + + out_conn_phases = [if phase == :liquid + scalarize(Out.z₂ .~ 0.0)... + scalarize(Out.z₃ .~ z₁)... + Out.MW[2] ~ 0.0 + Out.MW[3] ~ Out.MW[1] + Out.α_g ~ 0.0 + elseif phase == :vapor + scalarize(Out.z₂ .~ z₁)... + scalarize(Out.z₃ .~ 0.0)... + Out.MW[2] ~ Out.MW[1] + Out.MW[3] ~ 0.0 + Out.α_g ~ 1.0 + end + ] + + + + #balances + mass_balance = [D(M) ~ sum(Q_in.*ρʷ_in) - Q_out*ρʷ] + component_balance = [d(Nᵢ[i]) ~ sum(Q_in.[:]*Cᵢ_in[i, :]) - Q_out*Cᵢ[i] + R[i]*V for i in 1:Nc] + energy_balance = [D(H(t)) ~ Q_in*ρ_in*h_in - Q_out*h_out*ρ + Q̇] + mass_volume_eq = [ρʷ*V ~ M] + mol_holdup = [N ~ sum(Nᵢ)] + mol_to_concentration = [Nᵢ .~ Cᵢ*V] + height_to_volume = [phase = :vapor ? height ~ 0.0 : height*A ~ V] + volumetricflow_to_molarflow = [Q_out ~ F_out/ρ] + volumetricflow_to_massflow = [Q_out ~ Fʷ_out/ρʷ] + + + #Thermodynamic properties (outlet) + pressure_out = [phase == :liquid ? P_out ~ P_atm + ρʷ*GravitationalConst*(height - height_out) : P_out ~ P_atm] #Estimation considering static pressure for liquids (May be off as tank is stirred and not static) + density_eqs = [ρ ~ molar_density(model, P_out, T, Nᵢ; phase = phase), ρʷ ~ mass_density(model, P, T, Nᵢ; phase = phase)] + globalEnthalpy_eq = [H ~ enthalpy(model, P_out, T, Nᵢ; phase = phase)] + molar_mass = [MW ~ sum(MWs[i]*Nᵢ[i]/N)*gramsToKilograms] + entropy_eq = [S ~ entropy(model, P_atm, T, Nᵢ; phase = phase)] + + eqs = [reaction_rate...; overall_reaction_rate...; atm_pressure...; mass_density_eqs...; molar_density_eqs...; inletenthalpy...; inletconcentrations...; inlettemperature_eqs...; inletmolarflow_eqs...; volumetricflow_eqs...; out_conn...; + out_conn_phases...; mass_balance...; component_balance...; energy_balance...; mass_volume_eq...; mol_holdup...; mol_to_concentration...; height_to_volume...; volumetricflow_to_molarflow...; volumetricflow_to_massflow...; + pressure_out...; density_eqs...; globalEnthalpy_eq...; molar_mass...; entropy_eq...] + +end + +#= +using ModelingToolkit, JSON, DifferentialEquations +using ModelingToolkit: t_nounits as t, D_nounits as D +import ModelingToolkit: scalarize, equations, get_unknowns, defaults +using Clapeyron, GCIdentifier +using NonlinearSolve +using JSON +@parameters t +D = Differential(t) +include("C:/Users/Vinic/OneDrive/Pos-Doc/Flowsheeting/ProcessModeling/ProcessSimulator.jl/src/utils") +include("C:/Users/Vinic/OneDrive/Pos-Doc/Flowsheeting/ProcessModeling/ProcessSimulator.jl/src/Sources/Sourceutils.jl") +substances_user = ["water", "methanol", "propyleneglycol","methyloxirane"] +Nc = size(substances_user, 1) +#substances_user = ["water"] +properties = Dict(subs => load_component_properties(subs) for subs in substances_user) +# Function to extract parameters for ReidIdeal model +read_reidcp(properties, substances_user) + + +cp_params = (a = [36.54206320678348, 39.19437678197436, 25.7415, 34.91747774761048], b = [-0.03480434051958945, -0.05808483585041852, 0.2355, -0.014935581577635826], c = [0.000116818199785053, 0.0003501220208504329, 0.0001578, 0.000756101594841365], d = [-1.3003819534791665e-7, -3.6941157412454843e-7, -4.0939e-7, -1.0894144551347726e-6], e = [5.2547403746728466e-11, 1.276270011886522e-10, 2.1166e-10, 4.896983427747592e-10]) +idealmodel = ReidIdeal(["water", "methanol", "propyleneglycol","methyloxirane"]; userlocations = cp_params) +pcpsaft = PCPSAFT(["water", "methanol", "propyleneglycol","methyloxirane"], idealmodel = idealmodel) +phase = :liquid +model = pcpsaft +ΔT = 10. +Ts = Base._linspace(298.00, 370.0, 20) |> collect +println(Ts) +z = [1.0, 1.0, 1.0, 1.0] +isobaric_heat_capacity(pcpsaft, 101325., 298.00, z, phase = :liquid) +bubble_temperature(pcpsaft, 5*101325., z) +molar_density(pcpsaft, 5*101325, 350.15, z, phase = :liquid) +rhos = [molar_density(pcpsaft, 5*101325, T, z, phase = :liquid) for T in Ts] +enthalpy(pcpsaft, eps(1.), 298.00, z) + +isobaric_heat_capacity(IAPWS95(), 101325, 298.0, 1.) + +cp_w = (a = [36.54206320678348], b = [-0.03480434051958945], c = [0.000116818199785053], d = [-1.3003819534791665e-7], e = [5.2547403746728466e-11]) +ideal_water = ReidIdeal(["water"]; userlocations = cp_w) +pcpwater = PCPSAFT(["water"], idealmodel = ideal_water) +isobaric_heat_capacity(pcpwater, 101325, 298.00, 1., phase = :liquid) +enthalpy(pcpwater, 101325, 298.00, 1., phase = :liquid) + + +Reaction = KineticReactionNetwork(;substances_user = substances_user, +Af_r = 4.71e9, Ef_r = 32400*1055.6/453.6, Coef_Cr = [-1.0 0.0 1.0 -1.0], +Do_r = [1.0 0.0 0.0 1.0], name = "Propyleneglycol synthesis") +#["water", "methanol", "propyleneglycol","methyloxirane"] +ninports = 1 +InPorts = [matcon(; Nc = Nc, name = Symbol("InPorts$i")) for i in 1:ninports] + +Ac = 1.0 +height_out_port = 0.0 +Nri = Reaction.Nri + +#Constants +GravitationalConst = 9.81 # m²/s +gramsToKilograms = 10^(-3) +Rᵍ = 8.314 # J/(mol K) + +#Properties of individual substances +MWs = [properties[subs]["MW"] for subs in substances_user] +ΔH₀f = [properties[subs]["IGHF"]/10^3 for subs in substances_user] # (IG formation enthalpy) J/mol + + +pars = @parameters begin +height_out = height_out_port, [description = "Height of the outlet stream port with reference from the bottom of the tank (m)"] +N_InPorts = ninports +Nr = Nri, [description = "Number of reactions"] +Af_r[1:Nri] = Reaction.Af_r, [description = "Arrhenius constant of each reaction at given temperature ()"] +Coef_Cr[1:Nri, 1:Nc] = Reaction.Coef_Cr, [description = "Stoichiometric coefficients of each component in each reaction (-)"] +Do_r[1:Nri, 1:Nc] = Reaction.Do_r, [description = "Forward order of the components (-) "] +Ef_r[1:Nri] = Reaction.Ef_r, [description = "Activation energy of each reaction at given temperature ()"] +N = Nc, [description = "Number of components"] +A = Ac, [description = "Cross sectional area of the tank (m²)"] +end + +@variables v + +OutPorts = @named begin + Out = matcon(; Nc = Nc) +end + +vars = @variables begin + + M(t), [description = "Mass holdup in the tank (kg)"] + N(t), [description = "Total molar holdup in the tank (kmol)"] + V(t), [description = "Volume holdup in the tank (m³)"] + (Nᵢ(t))[1:Nc], [description = "Molar holdup of each component in the tank (mol)"] + (Cᵢ(t))[1:Nc], [description = "Concentration of each component in the tank (mol/m³)"] + (ρ(t)), [description = "Molar Density of the fluid in the tank (mol/m³)"] + (ρʷ(t)), [description = "Mass Density of the fluid in the tank (kg/m³)"] + #h_out(t), [description = "Outlet specific enthalpy (J/mol)"] + MW(t), [description = "Molecular weight of fluid in the tank (kg/kmol)"] + T(t), [description = "Temperature of vessel contents (K)"] + P_out(t), [description = "Pressure at the outlet stream level (Pa)"] + H(t), [description = "Enthalpy holdup of the fluid in the tank (J)"] + S(t), [description = "Entropy holdup of the fluid in the tank (J/K)"] + F_out(t), [description = "Outlet molar flow rate (mol/s)"] + Fʷ_out(t), [description = "Outlet molar flow rate (mol/s)"] + Q_out(t), [description = "Outlet volumetric flow rate (m³/s)"] # DoF + height(t), [description = "Liquid level in vessel measured from bottom of the tank (m)"] + + (Cᵢ_in(t))[1:Nc, 1:Ni_InPorts], [description = "Inlet concentration of each component (mol/m³)"] # DoF through inlet stream + (F_in(t))[1:Ni_InPorts], [description = "Inlet molar flow rate (mol/s)"] # DoF through inlet stream + (Q_in(t))[1:Ni_InPorts], [description = "Inlet volumetric flow rate(s) (m³/s)"] + (T_in(t))[1:Ni_InPorts], [description = "Inlet temperature (K)"] # DoF through inlet stream + (h_in(t))[1:Ni_InPorts], [description = "Inlet specific enthalpy (J/mol)"] + (ρ_in(t))[1:Ni_InPorts], [description = "Inlet density (mol/m³)"] + (ρʷ_in(t))[1:Ni_InPorts], [description = "Inlet density (mol/m³)"] + P_atm(t), [description = "Tank pressure (Pa)"] # Equal to inlet pressures. + Q̇(t), [description = "Heat transfer rate (J/s)"] # Potential DoF + (r(t))[1:Nri], [description = "Rate of each reaction for each component (mol/s/m³)"] + (R(t))[1:Nc], [description = "Overall reaction rate (mol/s/m³)"] +end + + + +#Reaction equations +reaction_rate = [r[i] ~ Af_r[i]*exp(-Ef_r[i]/(Rᵍ*T))*prod(scalarize((Cᵢ[:].^Do_r[i, :]))) for i in 1:Nri] # If there's an inert, the order is just zero, but it has to be written +overall_reaction_rate = [R[i] ~ sum(scalarize(r[:].*Coef_Cr[:, i])) for i in 1:Nc] # If there's an inert, the coefficient is just zero, but it has to be written + + +#Inlet connector variables's equations +atm_pressure = [P_atm ~ InPorts[1].P] +mass_density_eqs = [ρʷ_in[j] ~ InPorts[j].ρʷ for j in 1:Ni_InPorts] +molar_density_eqs = [ρ_in[j] ~ InPorts[j].ρ for j in 1:Ni_InPorts] +inletenthalpy = [h_in[j] ~ InPorts[j].H for j in 1:Ni_InPorts] +inletconcentrations = [Cᵢ_in[i, j] ~ InPorts[j].z₁[i]*ρ_in[j] for j in 1:Ni_InPorts for i in 1:Nc] +inlettemperature_eqs = [T_in[j] ~ InPorts[j].T for j in 1:Ni_InPorts] +inletmolarflow_eqs = [F_in[j] ~ InPorts[j].F for j in 1:Ni_InPorts] +volumetricflow_eqs = [Q_in[j] ~ F_in[j] / ρ_in[j] for j in 1:Ni_InPorts] + +eqs = [reaction_rate; overall_reaction_rate; atm_pressure; mass_density_eqs; molar_density_eqs; inletenthalpy; inletconcentrations; inlettemperature_eqs; inletmolarflow_eqs; volumetricflow_eqs] + +#Outlet connector equations: +out_conn = [Out.P ~ P_out + Out.T ~ T + Out.F ~ F_out + Out.Fʷ ~ Fʷ_out + Out.H ~ H/N + Out.S ~ S/N + Out.ρʷ ~ ρʷ + Out.ρ ~ ρ + scalarize(Out.z₁ .~ Nᵢ/N)... + Out.MW[1] ~ MW +] + + if phase == :liquid + out_conn_phases = [ + scalarize(Out.z₂ .~ 0.0)... + scalarize(Out.z₃ .~ Out.z₁)... + Out.MW[2] ~ 0.0 + Out.MW[3] ~ Out.MW[1] + Out.α_g ~ 0.0] + + elseif phase == :vapor + out_conn_phases = [ + scalarize(Out.z₂ .~ Out.z₁)... + scalarize(Out.z₃ .~ 0.0)... + Out.MW[2] ~ Out.MW[1] + Out.MW[3] ~ 0.0 + Out.α_g ~ 1.0] + end + + + + #balances + mass_balance = [D(M) ~ sum(scalarize(Q_in.*ρʷ_in)) - Q_out*ρʷ] + component_balance = [D(Nᵢ[i]) ~ sum(scalarize(Q_in.*Cᵢ_in[i, :])) - Q_out*Cᵢ[i] + R[i]*V for i in 1:Nc] #Neglectable loss to vapor phase head space + energy_balance = [D(H) ~ sum(scalarize(Q_in.*ρ_in.*h_in)) - Q_out*H/N*ρ + Q̇] + mass_volume_eq = [ρʷ*V ~ M] + mol_holdup = [N ~ sum(scalarize(Nᵢ))] + mol_to_concentration = [scalarize(Nᵢ .~ Cᵢ*V)...] + height_to_volume = [height*A ~ V] + volumetricflow_to_molarflow = [Q_out ~ F_out/ρ] + volumetricflow_to_massflow = [Q_out ~ Fʷ_out/ρʷ] + + #Thermodynamic properties (outlet) + pressure_out = [phase == :liquid ? P_out ~ P_atm + ρʷ*GravitationalConst*(height - height_out) : P_out ~ P_atm] #Estimation considering static pressure (May be off as tank is agitated and not static) + density_eqs = [ρ ~ molar_density(model, P_out, T, scalarize(Nᵢ); phase = phase), ρʷ ~ mass_density(model, P_out, T, scalarize(Nᵢ); phase = phase)] + globalEnthalpy_eq = [H ~ enthalpy(model, P_out, T, Nᵢ; phase = phase)] + molar_mass = [MW ~ sum(MWs[i]*Nᵢ[i]/N)*gramsToKilograms] + entropy_eq = [S ~ entropy(model, P_atm, T, Nᵢ; phase = phase)] + + eqs = [reaction_rate...; overall_reaction_rate...; atm_pressure...; mass_density_eqs...; molar_density_eqs...; inletenthalpy...; inletconcentrations...; inlettemperature_eqs...; inletmolarflow_eqs...; volumetricflow_eqs...; out_conn...; + out_conn_phases...; mass_balance...; component_balance...; energy_balance...; mass_volume_eq...; mol_holdup...; mol_to_concentration...; height_to_volume...; volumetricflow_to_molarflow...; volumetricflow_to_massflow...; + pressure_out...; density_eqs...; globalEnthalpy_eq...; molar_mass...; entropy_eq...] =# \ No newline at end of file diff --git a/src/Reactors/Gibbs.jl b/src/Reactors/Gibbs.jl deleted file mode 100644 index 3e90b2e..0000000 --- a/src/Reactors/Gibbs.jl +++ /dev/null @@ -1,3 +0,0 @@ -function Gibbs(x) - return 2x -end \ No newline at end of file diff --git a/src/Reactors/Gibbs_Reactor/GibbsReactor_numeric.jl b/src/Reactors/Gibbs_Reactor/GibbsReactor_numeric.jl new file mode 100644 index 0000000..5bc0d78 --- /dev/null +++ b/src/Reactors/Gibbs_Reactor/GibbsReactor_numeric.jl @@ -0,0 +1,164 @@ +using Pkg +Pkg.activate("GibbsReactor") + +using ModelingToolkit +using Clapeyron +using GCIdentifier +using DelimitedFiles +using LinearAlgebra + +#define components +components_names = ["carbon dioxide", "carbon monoxide", "hydrogen", "water", "methane"] +components_smiles = ["C(=O)=O", "[C-]#[O+]", "[HH]", "O=O", "C"] + + +#Define the model +my_model = ShomateIdeal(components_names; + userlocations = ["C:/Users/Vinic/OneDrive/Pos-Doc/Flowsheeting/GibbsReactor/GibbsReactor.jl", "myShomate.csv"]) + +function readEnthalpyEntropyData(file_path, component_names) + # Read formation enthalpy from file + # file_path: File path of the file containing the formation enthalpy + # component_names: Names of the components + # Returns: Formation enthalpy in J/mol + + # initialize the formation enthalpy and entropy vector + H₀_S₀ = zeros(length(component_names), 2) + + # Read the TSV file + data = readdlm(file_path, '\t', header = true) + + # Get the column of chemical names + chemical_names = data[1][:, 2] + + # Find the index of the chemical name in the column + for i in eachindex(component_names) + index = findfirst(x -> x == component_names[i], chemical_names) + + # If the chemical name was found, return the corresponding line + if index !== nothing + H₀_S₀[i, :] = data[1][index, 3:end] + end + end + + return H₀_S₀ + +end + +H₀_S₀ = readEnthalpyEntropyData("Hf0_Sf0.tsv", components_names) + + +# Define reaction coefficients: +# Reaction 1: 5 CO + 3 H20 -> 4 CO2 + H2 + CH4 +# Reaction 2: CO + 3 H2 -> CH4 + H20 + +ν = [4 0; -5 -1; 1 -3; -3 1; 1 1] # Should be done automatically in the future +ν*[0.0; 0.0] + +function GibbsFreeEnergy_TP(T, P, H₀_S₀, ξ, ν, model, f_feed) + # Calculate the Gibbs free energy of the system + # T: Temperature in K + # P: Pressure in Pa + # ξ: Extent of reaction + # ν: Stoichiometric coefficients + # my_model: Model of the system + # Returns: Gibbs free energy in J + + f_prod = f_feed + ν*ξ #Mass balance + ΔHrxn = dot(H₀_S₀[:, 1], ν*ξ) #Heat released or taken from Reaction + ΔSrxn = dot(H₀_S₀[:, 2], ν*ξ) #Standard entropy of reaction + H = enthalpy(model, P, T, f_prod) + ΔHrxn #Outlet stream enthalpy + S = entropy(model, P, T, f_prod) + ΔSrxn #Outlet stream entropy + G = H - T*S + return G + +end + + + +function Entropy_TP(T, P, H₀_S₀, ξ, ν, model, f_feed) + # Calculate the entropy of the system (J) + + f_prod = f_feed + ν*ξ + + ΔSrxn = dot(H₀_S₀[:, 2], ν*ξ) #Standard entropy of reaction times how much was converted from reactants to products + + S = entropy(model, P, T, f_prod) + ΔSrxn + + return S + +end + + + +function EnergyBalance(T, P, H₀_S₀, ξ, ν, model, p) + # Calculate the energy balance of the system + # res: Energy balance error + # ξ: Extent of reaction + # p: Parameters of the system + # Returns: Energy balance error (res) in J + + f_feed, T_feed = p[1], p[2] + + # Calculate the energy balance + + f_prod = f_feed + ν*ξ #mass balance + + Hin = enthalpy(model, P, T_feed, f_feed) + Hout = enthalpy(model, P, T, f_prod) + ΔHrxnX = dot(H₀_S₀[:, 1], ν*ξ) + + res = Hin + ΔHrxnX - Hout + + return res + +end + +#Testing the functions: +GibbsFreeEnergy_TP(300, 10^5, H₀_S₀, [0.0, 0.0], ν, my_model, [5.0, 20.0, 5.0, 5.0, 5.0]) +Entropy_TP(300, 10^5, H₀_S₀, [0.0, 0.0], ν, my_model, [5.0, 20.0, 5.0, 5.0, 5.0]) +EnergyBalance(500, 10^5, H₀_S₀, [0.0, 0.0], ν, my_model, ([5.0, 20.0, 5.0, 5.0, 5.0], 500)) + +#Minimizing S(T,ξ) with respect to ξ constrained to energy balance (adiabatic reactor): +using OptimizationOptimJL, Optimization, OptimizationMOI, Ipopt + +f_feed = [5.0, 20.0, 5.0, 5.0, 5.0] #["carbon dioxide", "carbon monoxide", "hydrogen", "water", "methane"] +T_feed = 500.0 #K +P = 101325.0 #Pa + +#Target function +Smin(ξ_T) = -Entropy_TP(ξ_T[end], P, H₀_S₀, ξ_T[1:2], ν, my_model, f_feed) + + +#Energy balance constraint +E(ξ_T) = EnergyBalance(ξ_T[end], P, H₀_S₀, ξ_T[1:2], ν, my_model, [f_feed, T_feed]) + +#product flow rate positive +function f_prod_cons(ξ_T, f_feed, ν) + + res = f_feed + ν*ξ_T[1:2] + + return res + +end + + +#Initial guess +ξ₀ = [0.000; 0.000] +T₀ = 600.0 + +#Testing the functions: +Smin([ξ₀ ; T₀]) +E([ξ₀ ; T₀]) +f_prod_cons([ξ₀ ; T₀], f_feed, ν) + + +#Lower and upper bounds +lb = [0.00; zeros(size(components_names, 1))] +ub = [0.00; Inf*ones(size(components_names, 1))] + +optf = OptimizationFunction((x, p) -> Smin(x), Optimization.AutoForwardDiff(), cons = (res, x, p) -> [E(x), f_prod_cons(x, f_feed, ν)]) + +prob = OptimizationProblem(optf, [ξ₀; T₀], lcons = lb, ucons = ub) + +sol = solve(prob, Ipopt.Optimizer()) diff --git a/src/Reactors/Gibbs_Reactor/GibbsReactor_symbolic.jl b/src/Reactors/Gibbs_Reactor/GibbsReactor_symbolic.jl new file mode 100644 index 0000000..a6857b5 --- /dev/null +++ b/src/Reactors/Gibbs_Reactor/GibbsReactor_symbolic.jl @@ -0,0 +1,83 @@ +using Symbolics, SymbolicUtils, ModelingToolkit +using Reexport +@reexport using ModelingToolkit + +using Clapeyron +using GCIdentifier +using DelimitedFiles +using LinearAlgebra + +components_names = ["carbon dioxide", "carbon monoxide", "hydrogen", "water", "methane"] +abspath(joinpath(@__DIR__, "myShomate.csv")) +syngas_prop_model = ShomateIdeal(components_names; userlocations = [abspath(joinpath(@__DIR__, "myShomate.csv"))]) + +n_reactions = 2 + +function readEnthalpyEntropyData(file_path, component_names) + # Read formation enthalpy from file + # file_path: File path of the file containing the formation enthalpy + # component_names: Names of the components + # Returns: Formation enthalpy in J/mol + + # initialize the formation enthalpy and entropy vector + H₀_S₀ = zeros(length(component_names), 2) + + # Read the TSV file + data = readdlm(file_path, '\t', header = true) + + # Get the column of chemical names + chemical_names = data[1][:, 2] + + # Find the index of the chemical name in the column + for i in eachindex(component_names) + index = findfirst(x -> x == component_names[i], chemical_names) + + # If the chemical name was found, return the corresponding line + if index !== nothing + H₀_S₀[i, :] = data[1][index, 3:end] + end + end + + return H₀_S₀ + +end + +H₀_S₀ = readEnthalpyEntropyData(abspath(joinpath(@__DIR__, "Hf0_Sf0.tsv")), components_names) + +@register_symbolic Entropy_TP1(T, P, H₀_S₀, ξ, ν, model, f_feed) + +function Entropy_TP(T, P, H₀_S₀, ξ_1, ξ_2, ν, model, f_feed) + # Calculate the entropy of the system (J) + + f_prod = f_feed + ν*ξ + + ΔSrxn = dot(H₀_S₀[:, 2], ν*ξ) #Standard entropy of reaction times how much was converted from reactants to products + + S = entropy(model, P, T, f_prod) + ΔSrxn + + return S + +end + +function GibbsReactor(; name, n_reactions, v) +end + +ν = [4 0; -5 -1; 1 -3; -3 1; 1 1] + +vars = @variables begin + (T = 600.0), [description = "Reactor temperature"] + (ξ_1 = 0.5), [description = "Extent of rxn 1"] + (ξ_2 = 0.5), [description = "Extent of rxn 2"] + (s = 0.0), [description = "Entropy of the system"] +end + +pars = @parameters begin + (P = 101325.0), [description = "Reactor pressure"] + (T_feed = 500.0), [description = "Feed temperature"] + (f_feed[1:length(components_names)] = [5.0, 20.0, 5.0, 5.0, 5.0]), [description = "Feed molar fraction"] +end + +# TODO: structural_simplify optimization system. +eqns = [ + s ~ Entropy_TP(T, P, H₀_S₀, ξ, ν, syngas_prop_model, f_feed) +] diff --git a/src/Reactors/Gibbs_Reactor/Hf0_Sf0.tsv b/src/Reactors/Gibbs_Reactor/Hf0_Sf0.tsv new file mode 100644 index 0000000..8261362 --- /dev/null +++ b/src/Reactors/Gibbs_Reactor/Hf0_Sf0.tsv @@ -0,0 +1,5031 @@ +CAS name Hfg S0g +50-00-0 formaldehyde -108600 218.54 +50-21-5 lactic acid -621000 364.82 +50-70-4 sorbitol -1140000 645.66 +50-81-7 ascorbic acid -951000 434.73 +55-63-0 nitroglycerine -270900 +56-23-5 carbon tetrachloride -95800 310.03 +56-81-5 glycerol -582800 397.19 +56-86-0 l-glutamic acid -824000 492.31 +56-87-1 lysine -461000 530.94 +57-10-3 hexadecanoic acid -723000 881.92 +57-11-4 octadecanoic acid -764000 914.04 +57-13-6 urea -245800 +57-55-6 1,2-propanediol (propylene glycol) -433000 314.03 +57-57-8 beta-propiolactone -297060 286.48 +58-72-0 triphenylethylene 340000 583.35 +60-09-3 p-aminoazobenzene 330000 504.85 +60-12-8 2-phenylethanol -121000 405.62 +60-29-7 diethyl ether -250800 342.58 +60-33-3 linoleic acid -540000 904.47 +60-35-5 acetamide -238300 284.67 +62-53-3 aniline 86860 319.87 +62-76-0 sodium oxalate -1318000 +64-17-5 ethyl alcohol -235000 280.37 +64-18-6 formic acid -378600 249 +64-19-7 acetic acid -432300 312.3 +64-67-5 diethyl sulfate -754900 421.42 +65-85-0 benzoic acid -290100 369.72 +66-25-1 hexanal -248600 422.02 +67-56-1 methyl alcohol -200900 239.88 +67-63-0 isopropyl alcohol -272700 309.13 +67-64-1 acetone -217100 295.5 +67-66-3 chloroform -102900 295.69 +67-68-5 dimethyl sulfoxide -209160 224.65 +67-72-1 hexachloroethane -138900 398.99 +68-12-2 N,N'-dimethylformamide -191700 326.54 +69-72-7 salicylic acid -466350 400.72 +71-23-8 propyl alcohol -255200 322.54 +71-36-3 butanol -274600 361.7 +71-41-0 1-pentanol -300160 410.88 +71-43-2 benzene 82900 269.18 +71-55-6 1,1,1-trichloroethane -142300 320.09 +74-31-7 N,N'-diphenyl-p-phenylenediamine 321000 525.34 +74-82-8 methane -74500 186.6 +74-83-9 methyl bromide -37700 246 +74-84-0 ethane -83800 229.45 +74-85-1 ethylene 52500 219.18 +74-86-2 acetylene 228200 200.86 +74-87-3 methyl chloride -82000 234.15 +74-88-4 methyl iodide 13800 254.13 +74-89-5 methylamine -22500 243.1 +74-90-8 hydrogen cyanide 135140 201.83 +74-93-1 methyl mercaptan -22600 255.22 +74-95-3 dibromomethane -14800 293.33 +74-96-4 bromoethane -63600 287.17 +74-97-5 bromochloromethane -44800 287.84 +74-98-6 propane -104700 270.28 +74-99-7 methylacetylene 184500 248.39 +75-00-3 ethyl chloride -112300 275.65 +75-01-4 vinyl chloride 28500 276.78 +75-02-5 vinyl fluoride -138900 262.27 +75-03-6 ethyl iodide -8400 295.63 +75-04-7 ethylamine -47500 283.6 +75-05-8 acetonitrile 64400 242.6 +75-07-0 acetaldehyde -166200 264.06 +75-08-1 ethyl mercaptan -46000 288.33 +75-09-2 dichloromethane -95400 270.28 +75-10-5 difluoromethane -452300 246.64 +75-11-6 diiodomethane 117600 309.58 +75-12-7 formamide -186190 248.71 +75-15-0 carbon disulfide 116940 237.97 +75-18-3 dimethyl sulfide -37200 285.98 +75-19-4 cyclopropane 53300 237.87 +75-21-8 ethylene oxide -52600 243.27 +75-25-2 bromoform 16700 330.59 +75-26-3 2-bromopropane -97000 316.26 +75-28-5 isobutane -135000 295.34 +75-29-6 2-chloropropane -144800 306.08 +75-30-9 2-iodopropane -41700 325.39 +75-31-0 isopropylamine -83700 312.35 +75-33-2 isopropyl mercaptan -75900 324.47 +75-34-3 1,1-dichloroethane -130100 305.08 +75-35-4 1,1-dichloroethylene 2400 288.1 +75-36-5 acetyl chloride -242800 295.17 +75-37-6 1,1-difluoroethane -500800 282.78 +75-38-7 1,1-difluoroethylene -336800 265.46 +75-43-4 dichlorofluoromethane -284900 293.26 +75-44-5 carbonyl chloride -220080 283.8 +75-45-6 chlorodifluoromethane -482800 281.1 +75-46-7 fluoroform -693300 259.55 +75-47-8 iodoform 210900 355.64 +75-50-3 trimethylamine -23700 289.88 +75-52-5 nitromethane -74700 275.31 +75-54-7 methyl dichlorosilane -402000 328.88 +75-55-8 propyleneimine 88800 288 +75-56-9 1,2-propylene oxide -92760 287.15 +75-61-6 dibromodifluoromethane -386600 324.18 +75-62-7 bromotrichloromethane -38900 332.95 +75-63-8 bromotrifluoromethane -649800 295.81 +75-64-9 tert-butylamine -120700 328.03 +75-65-0 tert-butanol -312400 326.81 +75-66-1 tert-butyl mercaptan -109300 337.8 +75-68-3 1-chloro-1,1-difluoroethane -529700 307.17 +75-69-4 trichlorofluoromethane -283700 309.94 +75-71-8 dichlorodifluoromethane -490800 300.47 +75-72-9 chlorotrifluoromethane -704200 285.29 +75-73-0 carbon tetrafluoride -933500 261.4 +75-74-1 lead, tetramethyl 135900 +75-75-2 methanesulfonic acid -583000 190.98 +75-76-3 silane, tetramethyl -286600 361.18 +75-77-4 chlorotrimethylsilane -352800 369.04 +75-79-6 silane, methyltrichloro -528860 351.14 +75-83-2 2,2-dimethylbutane -184000 358.22 +75-84-3 2,2-dimethyl-1-propanol -319070 401.19 +75-85-4 tert-pentyl-alcohol -329280 366.66 +75-86-5 acetone cyanohydrin -133000 336.51 +75-87-6 trichloroacetaldehyde -197000 349.67 +75-88-7 2-chloro-1,1,1-trifluoroethane -748100 326.46 +75-91-2 t-butyl hydroperoxide -243000 364.66 +75-97-8 3,3-dimethyl-2-butanone -290500 385.12 +75-98-9 2,2-dimethylpropanoic acid -491000 413.83 +76-01-7 pentachloroethane -145600 381.63 +76-02-8 trichloroacetyl chloride -305930 369.68 +76-05-1 trifluoroacetic acid -1021700 332.26 +76-09-5 2,3-dimethyl-2,3-butanediol -513000 333.69 +76-11-9 1,1,1,2-tetrachloro-2,2-difluoroethane -519700 380.37 +76-12-0 1,1,2,2-tetrachloro-1,2-difluoroethane -511300 385.74 +76-13-1 1,1,2-trichloro-1,2,2-trifluoroethane -705800 387 +76-14-2 1,2-dichloro-1,1,2,2-tetrafluoroethane -900400 364.11 +76-15-3 chloropentafluoroethane -1123000 358.32 +76-16-4 hexafluoroethane -1343000 331.41 +76-19-7 octafluoropropane -1703200 415.17 +76-22-2 camphor -257000 392.07 +76-35-7 2,2-dimethyl-1,3-butanediol -489000 431.9 +77-47-4 hexachlorocyclopentadiene -102000 456.45 +77-73-6 dicyclopentadiene 196100 241.45 +77-74-7 3-methyl-3-pentanol -344000 348.57 +77-78-1 dimethyl sulfate -687500 335.06 +77-84-9 2-methyl-2-ethyl-1,3-propanediol -476200 466.64 +77-92-9 citric acid -1390000 557.43 +77-99-6 trimethylolpropane -640190 489.26 +78-11-5 pentaerythritol tetranitrate -386700 +78-26-2 2-methyl-2-propyl-1,3-propanediol -497000 505.06 +78-30-8 tri-o-cresyl phosphate -851000 +78-40-0 triethyl phosphate -1244700 +78-59-1 isophorone -251000 422.68 +78-69-3 3,7-dimethyl-3-octanol -415990 548.02 +78-74-0 1,1,2-tribromoethane -10900 377.52 +78-75-1 1,2-dibromopropane -72800 376.53 +78-76-2 2-bromobutane -134300 362.12 +78-77-3 1-bromo-2-methylpropane -134000 255.53 +78-78-4 isopentane -153700 343.89 +78-79-5 isoprene 75800 314.96 +78-80-8 2-methyl-1-butene-3-yne 260000 279.87 +78-81-9 isobutylamine -98550 352.35 +78-82-0 isobutyronitrile 24100 313.53 +78-83-1 isobutanol -282920 349.92 +78-84-2 isobutyraldehyde -215800 314.03 +78-85-3 methacrolein -112000 335.12 +78-87-5 1,2-dichloropropane -165690 355.3 +78-88-6 2,3-dichloropropene -47900 336.34 +78-90-0 1,2-propanediamine -53680 360.77 +78-92-2 sec-butanol -292800 359.35 +78-93-3 methyl ethyl ketone -238600 339.35 +78-96-6 1-amino-2-propanol -239000 364.28 +78-97-7 lactonitrile -63900 408.48 +78-99-9 1,1-dichloropropane -150800 344.57 +79-00-5 1,1,2-trichloroethane -145600 332.83 +79-01-6 trichloroethylene -9600 325.24 +79-02-7 dichloroacetaldehyde -201000 330.3 +79-04-9 chloroacetyl chloride -245600 326.18 +79-06-1 acrylamide -170000 300.48 +79-09-4 propanoic acid -452800 325.63 +79-10-7 acrylic acid -323500 307.65 +79-11-8 chloroacetic acid -435200 348.11 +79-16-3 N-methylacetamide -240000 320.81 +79-20-9 methyl acetate -411900 324.29 +79-22-1 methyl chloroformate -424000 312.89 +79-24-3 nitroethane -102000 316.82 +79-27-6 1,1,2,2-tetrabromoethane 10880 400.23 +79-29-8 2,3-dimethylbutane -175900 365.94 +79-31-2 isobutyric acid -478000 362.37 +79-34-5 1,1,2,2-tetrachloroethane -149000 354.88 +79-36-7 dichloroacetyl chloride -280830 350.74 +79-38-9 chlorotrifluoroethylene -505400 322.23 +79-39-0 2-methacrylamide -185000 361.43 +79-41-4 methacrylic acid -361800 351.9 +79-43-6 dichloroacetic acid -436000 342.32 +79-46-9 2-nitropropane -139000 344.23 +79-92-5 camphene -28600 +80-05-7 bisphenol a -245600 544.54 +80-15-9 cumene hydroperoxide -78400 455.95 +80-43-3 dicumyl peroxide -79400 667.97 +80-46-6 p-tert-amylphenol -212000 481.93 +80-56-8 alpha-pinene 28300 473.29 +80-59-1 trans-2-methyl-2-butenoic acid -389200 393.73 +80-62-6 methyl methacrylate -347360 401.82 +83-32-9 acenaphthene 155000 369.44 +84-15-1 o-terphenyl 277000 528.39 +84-65-1 anthraquinone -95200 +84-66-2 diethyl phthalate -688300 742.26 +84-74-2 dibutyl phthalate -750900 901.56 +85-01-8 phenanthrene 207500 396.01 +85-44-9 phthalic anhydride -393130 399.91 +86-73-7 fluorene 183300 381.21 +86-74-8 dibenzopyrrole 209600 244.95 +87-61-6 1,2,3-trichlorobenzene 9000 369.54 +87-66-1 1,2,3-benzenetriol -446000 382.04 +87-68-3 hexachloro-1,3-butadiene -29200 459.77 +87-69-4 tartaric acid -1160000 487.11 +87-85-4 hexamethylbenzene -105690 453.79 +88-09-5 2-ethyl butyric acid -517000 423.3 +88-18-6 2-tert-butylphenol -199260 426.71 +88-69-7 2-isopropylphenol -175150 417.1 +88-72-2 o-nitrotoluene 45500 387.65 +88-73-3 o-chloronitrobenzene 37200 370.21 +88-74-4 o-nitroaniline 63800 383.19 +88-99-3 phthalic acid -663330 442.93 +89-05-4 pyromellitic acid -1480000 632.78 +89-72-5 2-sec-butylphenol -195790 456.05 +89-83-8 5-methyl-2-isopropylphenol -207260 449.88 +90-00-6 o-ethylphenol -145230 392.94 +90-02-8 salicylaldehyde -214950 388.44 +90-05-1 guaiacol -249000 399.11 +90-11-9 1-bromonaphthalene 182000 386.39 +90-12-0 1-methylnaphthalene 116860 378.35 +90-13-1 1-chloronaphthalene 119800 376.45 +91-20-3 naphthalene 150600 333.6 +91-22-5 quinoline 222300 366.04 +91-23-6 o-nitroanisole -84500 401.68 +91-57-6 2-methylnaphthalene 116110 381 +91-62-3 6-methylquinoline 199190 336.74 +91-63-4 2-methylquinoline 177000 348.84 +91-66-7 N,N'-dietyhlaniline 40200 388.04 +92-06-8 m-terphenyl 277000 528.39 +92-51-3 bicyclohexyl -272000 451.19 +92-52-4 phenylbenzene (biphenyl) 182400 391.24 +92-67-1 p-aminodiphenyl 184000 433.99 +92-94-4 p-terphenyl 277000 525.04 +93-22-1 2-pentylnaphthalene 31670 540.77 +93-37-8 2,7-dimethylquinoline 167080 369.52 +93-58-3 methyl benzoate -287900 415.25 +93-89-0 ethyl benzoate -284000 454.07 +95-13-6 indene 163400 333.9 +95-15-8 benzothiophene 166300 212.76 +95-47-6 o-xylene 19100 353.86 +95-48-7 o-cresol -128600 349.19 +95-49-8 o-chlorotoluene 18200 348.49 +95-50-1 o-dichlorobenzene 29700 341.79 +95-51-2 o-chloroaniline 57300 356.45 +95-53-4 o-toluidine 58000 348.39 +95-54-5 o-phenylenediamine 91200 360.37 +95-57-8 o-chlorophenol -123000 351.54 +95-63-6 1,2,4-trimethylbenzene -13800 395.36 +95-71-6 1,4-dihydroxy-2-methylbenzene -305900 375.2 +95-73-8 3,4-xylenol -156600 391.03 +95-76-1 3,4-dichloroaniline 32600 376.82 +95-80-7 toluenediamine 58370 398.29 +95-87-4 2,5-xylenol -161600 392.37 +95-92-1 diethyl oxalate -739800 528.63 +95-93-2 1,2,4,5-tetramethylbenzene -44560 419.22 +95-94-3 1,2,4,5-tetrachlorobenzene -23400 393.61 +96-11-7 1,2,3-tribromopropane -31540 416.47 +96-14-0 3-methylpentane -172000 383.04 +96-15-1 2-methylbutylamine -122700 377.14 +96-17-3 2-methylbutanal -235200 367.24 +96-18-4 1,2,3-trichloropropane -185770 269.62 +96-22-0 diethyl ketone -257900 370.12 +96-33-3 methyl acrylate -333000 366.32 +96-34-4 methyl chloroacetate -449000 372.17 +96-37-7 methylcyclopentane -106000 339.9 +96-47-9 2-methyltetrahydrofuran -218050 249.04 +96-48-0 gamma-butyrolactone -379000 305.85 +96-49-1 ethylene carbonate -505900 294.51 +96-54-8 N-methylpyrrole 103100 307.53 +97-00-7 1-chloro-2,4-dinitrobenzene 35100 437.79 +97-62-1 ethyl isobutanoate -499600 434.71 +97-63-2 ethyl methacrylate -381000 443.55 +97-64-3 ethyl lactate -635000 456.54 +97-65-4 itaconic acid -729000 438.62 +97-85-8 isobutyl isobutyrate -547000 511.67 +97-88-1 butyl methacrylate -422000 525.21 +97-93-8 triethyl aluminum -163600 +97-95-0 2-ethyl-1-butanol -320900 445.4 +97-96-1 2-ethylbutanal -266000 372.11 +97-99-4 tetrahydrofurfuryl alcohol -369200 373.42 +98-00-0 furfuryl alcohol -218900 408.22 +98-01-1 furfural -151040 333.65 +98-06-6 tert-butylbenzene -21630 396.85 +98-07-7 benzotrichloride -12340 401.92 +98-08-8 benzotrifluoride -600000 373.23 +98-29-3 p-tert-butylcatechol -376000 479.68 +98-46-4 3-nitrobenzotrifluoride -602000 433.77 +98-51-1 1-methyl-4-tert-butylbenzene -54300 440.12 +98-56-6 p-chlorobenzotrifluoride -619650 403.43 +98-82-8 cumene 4000 389.32 +98-83-9 alpha-methylstyrene 118700 372.34 +98-86-2 acetophenone -86600 385.02 +98-87-3 benzyl dichloride 13000 386.31 +98-88-4 benzoyl chloride -105300 368.59 +98-95-3 nitrobenzene 67600 358.89 +99-08-1 m-nitrotoluene 20800 388.66 +99-09-2 m-nitroaniline 58500 382.19 +99-35-4 1,3,5-trinitrobenzene -37400 +99-54-7 1,2-dichloro-4-nitrobenzene 14600 404.34 +99-62-7 m-diisopropylbenzene -77600 499.97 +99-63-8 isophthaloyl chloride -302000 463.84 +99-65-0 m-dinitrobenzene 53800 376.5 +99-71-8 4-sec-butylphenol -195790 456.05 +99-83-2 alpha-phellandrene -9300 431.03 +99-85-4 gamma-terpinene -11700 456.52 +99-86-5 alpha-terpinene -20600 436.73 +99-87-6 p-cymene -29000 427.13 +99-89-8 4-isopropylphenol -175150 417.1 +99-94-5 p-toluic acid -322800 406.69 +99-99-0 p-nitrotoluene 31000 382.62 +100-00-5 p-chloronitrobenzene 37200 366.86 +100-01-6 p-nitroaniline 59500 378.83 +100-10-7 p-dimethylaminobenzaldehyde -27900 435.83 +100-18-5 p-diisopropylbenzene -77600 489 +100-21-0 terephthalic acid -717900 449.47 +100-25-4 p-dinitrobenzene 50800 376.5 +100-40-3 vinylcyclohexene 65100 377.54 +100-41-4 ethylbenzene 29900 361.24 +100-42-5 styrene 148300 344.93 +100-44-7 benzyl chloride 18700 361.91 +100-46-9 benzylamine 62230 359.23 +100-47-0 benzonitrile 218800 321.48 +100-51-6 benzyl alcohol -100400 365.96 +100-52-7 benzaldehyde -36800 335.9 +100-60-7 N-methylcyclohexylamine -103000 378.2 +100-61-8 N-methylaniline 88000 341.69 +100-63-0 phenylhydrazine 203500 351.55 +100-64-1 cyclohexanone oxime -194000 377.69 +100-66-3 anisole -68000 361.5 +100-71-0 2-ethylpyridine 78500 364.83 +100-80-1 m-methylstyrene 115500 375.7 +101-54-2 p-aminodiphenylamine 206000 450.91 +101-68-8 diphenylmethane-4,4'-diisocyanate -55800 +101-81-5 diphenylmethane 164580 437.64 +101-83-7 dicyclohexylamine -185000 475.32 +101-84-8 diphenyl ether 44300 420.03 +102-25-0 1,3,5-triethylbenzene -74730 509.1 +102-36-3 3,4-dichlorophenyl isocyanate -2970 406.55 +102-69-2 tripropylamine -161000 531.21 +102-71-6 triethanolamine -562080 538.82 +102-76-1 glyceryl triacetate -1252700 677.3 +102-82-9 tributylamine -233000 657.69 +102-86-3 trihexylamine -347320 873.23 +102-87-4 tridodecylamine -718840 1574.4 +102-88-5 trioctadecylamine -1090400 2275.5 +103-09-3 2-ethylhexyl acetate -570000 606.75 +103-11-7 2-ethylhexyl acrylate -470000 642.68 +103-29-7 1,2-diphenylethane 142880 474.01 +103-30-0 trans-stilbene 241000 458.6 +103-50-4 dibenzyl ether 19300 525.17 +103-65-1 propylbenzene 7910 399.08 +103-70-8 formanilide -55200 329.35 +103-71-9 phenyl isocyanate -22100 352.28 +103-73-1 phenetole -101700 402.6 +103-84-4 acetanilide -128500 369.61 +104-46-1 anethole -41500 466.11 +104-51-8 butylbenzene -13140 440.28 +104-72-3 decylbenzene -137500 675.13 +104-76-7 2-ethyl-1-hexanol -365300 498.12 +104-87-0 p-tolualdehyde -70700 389.48 +105-05-5 p-diethylbenzene -20370 433.94 +105-30-6 2-methyl-1-pentanol -322900 448.39 +105-34-0 methyl cyanoacetate -237000 382.3 +105-37-3 ethyl propanoate -463600 403.27 +105-38-4 vinyl propionate -347360 385.62 +105-42-0 4-methyl-2-hexanone -305670 445.84 +105-45-3 methyl acetoacetate -589000 443.25 +105-46-4 sec-butyl acetate -503800 440.07 +105-53-3 diethyl malonate -781000 553.7 +105-54-4 ethyl butanoate -485500 442.42 +105-56-6 ethyl cyanoacetate -316140 413.5 +105-57-7 acetal -453500 455.04 +105-58-8 diethyl carbonate -639100 404.72 +105-59-9 methyl diethanolamine -380000 471.38 +105-60-2 epsilon-caprolactam -246200 364.31 +105-66-8 propyl butanoate -505300 482.25 +105-67-9 2,4-xylenol -162900 393.38 +105-68-0 isopentyl propanoate -529200 514.69 +105-76-0 dibutyl maleate -688000 742.88 +106-21-8 3,7-dimethyl-1-octanol -412520 577.37 +106-27-4 3-methylbutyl butanoate -551500 554.18 +106-31-0 butyric anhydride -660650 548.47 +106-35-4 3-heptanone -301000 449.1 +106-36-5 propyl propanoate -483100 442.76 +106-38-7 p-bromotoluene 80400 363.7 +106-42-3 p-xylene 18000 352.18 +106-43-4 p-chlorotoluene 18200 342.46 +106-44-5 p-cresol -125300 350.87 +106-46-7 p-dichlorobenzene 22200 337.09 +106-47-8 p-chloroaniline 57300 356.45 +106-48-9 p-chlorophenol -145800 345.51 +106-49-0 p-toluidine 45000 355.1 +106-50-3 p-phenylenediamine 91200 350.31 +106-63-8 isobutyl acrylate -394000 476 +106-67-2 4-methyl-2-ethyl-1-pentanol -371240 499.46 +106-88-7 1,2-epoxybutane -110000 322.51 +106-89-8 alpha-epichlorohydrin -107800 319.7 +106-93-4 1,2-dibromoethane -38910 330.06 +106-94-5 1-bromopropane -87000 330.68 +106-95-6 3-bromo-1-propene 49370 317.43 +106-97-8 butane -126800 304.4 +106-98-9 1-butene -500 307.88 +106-99-0 butadiene (1,3 butadiene) 110000 278.83 +107-00-6 ethylacetylene 165200 290.23 +107-02-8 acrolein -84000 280.54 +107-03-9 propyl mercaptan -67500 336.54 +107-05-1 3-chloro-1-propene -630 307.11 +107-06-2 1,2-dichloroethane -126800 306.08 +107-07-3 2-chloroethanol -262000 320.87 +107-08-4 1-iodopropane -30300 338.47 +107-10-8 propylamine -70100 325.43 +107-11-9 allylamine 58200 312.82 +107-12-0 propionitrile 51500 285.44 +107-13-1 acrylonitrile 180600 273.83 +107-15-3 ethylenediamine -17320 321.52 +107-18-6 allyl alcohol -131900 308.25 +107-19-7 propargyl alcohol 42200 293.28 +107-20-0 chloroacetaldehyde -191000 304.23 +107-21-1 ethylene glycol -387500 303.79 +107-25-5 methyl vinyl ether -108000 308.25 +107-31-3 methyl formate -349700 301.57 +107-39-1 2,4,4-trimethyl-1-pentene -111300 406.13 +107-40-4 2,4,4-trimethyl-2-pentene -107300 409.49 +107-41-5 hexylene glycol -534760 457.52 +107-46-0 disiloxane, hexamethyl -777700 535.06 +107-80-2 1,3-dibromobutane -78510 478.64 +107-81-3 2-bromopentane -125480 392.29 +107-82-4 1-bromo-3-methylbutane -125480 392.29 +107-83-5 2-methylpentane -174600 380.69 +107-84-6 1-chloro-3-methylbutane -180330 400.65 +107-85-7 3-methylbutylamine -112700 410.68 +107-87-9 methyl propyl ketone -259200 378.84 +107-88-0 1,3-butanediol -452000 343.83 +107-92-6 butyric acid -473600 353.05 +107-93-7 trans-2-butenoic acid -378000 338.41 +107-96-0 3-mercaptopropionic acid -405940 438.38 +108-01-0 dimethylethanolamine -202000 384.66 +108-03-2 1-nitropropane -125500 350.6 +108-05-4 vinyl acetate -315700 328.02 +108-08-7 2,4-dimethylpentane -201700 397.38 +108-09-8 2-amino-4-methylpentane -149500 403.62 +108-10-1 4-methyl-2-pentanone -286400 413.63 +108-11-2 4-methyl-2-pentanol -339200 436.21 +108-18-9 diisopropylamine -138800 450.61 +108-20-3 diisopropyl ether -319400 399.76 +108-21-4 isopropyl acetate -481700 390.86 +108-24-7 acetic anhydride -575720 390.55 +108-30-5 succinic anhydride -524100 336.81 +108-31-6 maleic anhydride -398300 316.14 +108-36-1 m-dibromobenzene 125500 365.84 +108-38-3 m-xylene 17300 358.55 +108-39-4 m-cresol -132300 356.24 +108-41-8 m-chlorotoluene 18200 338.4 +108-42-9 m-chloroaniline 57300 356.45 +108-43-0 m-chlorophenol -153300 351.54 +108-44-1 m-toluidine 64000 355.1 +108-45-2 m-phenylenediamine 91200 360.37 +108-46-3 resorcinol -274900 344.53 +108-47-4 2,4-dimethylpyridine 63900 361.48 +108-48-5 2,6-dimethylpyridine 58700 356.11 +108-55-4 glutaric anhydride -349000 352.82 +108-57-6 m-divinylbenzene 212000 412.56 +108-64-5 ethyl isovalerate -527000 482.58 +108-67-8 mesitylene -15900 385.63 +108-68-9 3,5-xylenol -161500 392.04 +108-70-3 1,3,5-trichlorobenzene -6900 362.83 +108-75-8 2,4,6-trimethylpyridine 20000 394.26 +108-82-7 2,6-dimethyl-4-heptanol -410000 521.91 +108-83-8 diisobutyl ketone -357600 509.96 +108-86-1 bromobenzene 104200 324.89 +108-87-2 methylcyclohexane -154700 343.5 +108-88-3 toluene 50200 321.08 +108-89-4 4-methylpyridine 102100 319.3 +108-90-7 chlorobenzene 51100 314.04 +108-91-8 cyclohexylamine -104900 351.76 +108-93-0 cyclohexanol -286800 352.93 +108-94-1 cyclohexanone -225700 334.61 +108-95-2 phenol -96400 314.73 +108-98-5 phenyl mercaptan 111500 337.45 +108-99-6 3-methylpyridine 106400 325.34 +109-06-8 2-methylpyridine 99200 325.34 +109-21-7 butyl butanoate -524900 522.41 +109-43-3 dibutyl sebacate -1060000 984.39 +109-52-4 pentanoic acid -497000 397.57 +109-60-4 propyl acetate -464800 402.93 +109-64-8 1,3-dibromopropane -52590 374.95 +109-65-9 1-bromobutane -107320 370.41 +109-66-0 pentane -146800 349.25 +109-67-1 1-pentene -21300 347.03 +109-69-3 1-chlorobutane -147280 358.68 +109-73-9 butylamine -92000 364.59 +109-74-0 butyronitrile 33500 325.93 +109-75-1 vinylacetonitrile 157800 303.93 +109-77-3 malononitrile 265500 287.52 +109-78-4 hydracrylonitrile -98300 331.33 +109-79-5 butyl mercaptan -87800 375.36 +109-83-1 methylethanolamine -198000 344.5 +109-86-4 2-methoxyethanol -434000 359.38 +109-87-5 methylal -348200 336.27 +109-89-7 diethylamine -71700 352.18 +109-92-2 ethyl vinyl ether -140900 349.51 +109-93-3 divinyl ether -14000 334.38 +109-94-4 ethyl formate -388300 328.65 +109-97-7 pyrrole 108200 270.72 +109-99-9 tetrahydrofuran -184180 297.76 +110-00-9 furan -34700 267.49 +110-01-0 tetrahydrothiophene -33800 309.75 +110-02-1 thiophene 114900 278.81 +110-05-4 di-t-butyl peroxide -341000 496.12 +110-12-3 5-methyl-2-hexanone -304000 447.09 +110-15-6 succinic acid -822900 403.03 +110-16-7 maleic acid -675800 393.74 +110-17-8 fumaric acid -671950 393.47 +110-19-0 isobutyl acetate -494700 445.1 +110-33-8 dihexyl adipate -1020000 903.89 +110-39-4 octyl butanoate -608100 679.69 +110-43-0 2-heptanone -300900 457.82 +110-45-2 isopentyl formate -453800 440.74 +110-52-1 1,4-dibromobutane -73230 413.91 +110-53-2 1-bromopentane -129160 409.56 +110-54-3 hexane -166900 388.74 +110-56-5 1,4-dichlorobutane -179000 389.42 +110-57-6 1,4-dichloro-trans-2-butene -66200 383.44 +110-58-7 pentylamine -112700 404.08 +110-59-8 valeronitrile 11460 366.16 +110-62-3 pentanal -227800 382.86 +110-63-4 1,4-butanediol -428000 377.47 +110-65-6 2-butyne-1,4-diol -155000 358.54 +110-66-7 pentyl mercaptan -109800 415.52 +110-67-8 3-methoxypropionitrile -79000 364.45 +110-68-9 methyl-butylamine -86800 412.43 +110-71-4 1,2-dimethoxyethane -346000 385.65 +110-74-7 propyl formate -407600 368.47 +110-80-5 2-ethoxyethanol -400000 398.53 +110-81-6 diethyl disulfide -74100 414.46 +110-82-7 cyclohexane -123400 297.31 +110-83-8 cyclohexene -5000 310.51 +110-85-0 piperazine 22300 322.27 +110-86-1 pyridine 140400 282.5 +110-88-3 trioxane -465900 288.68 +110-89-4 piperidine -48900 337.12 +110-91-8 morpholine -156000 232.51 +110-94-1 glutaric acid -844000 445.21 +110-96-3 diisobutylamine -179200 486.32 +110-97-4 diisopropanolamine -454000 513.89 +110-99-6 diglycolic acid -945000 441.55 +111-13-7 2-octanone -321600 496.97 +111-14-8 heptanoic acid -538000 469.16 +111-15-9 2-ethoxyethyl acetate -611000 492.34 +111-20-6 sebacic acid -921900 641.31 +111-24-0 1,5-dibromopentane -93870 452.86 +111-25-1 1-bromohexane -140840 440.76 +111-26-2 hexylamine -133300 443.23 +111-27-3 1-hexanol -316800 440 +111-29-5 1,5-pentanediol -449000 434.33 +111-31-9 hexyl mercaptan -129200 455.01 +111-34-2 butyl vinyl ether -183000 428.73 +111-36-4 butyl isocyanate -127000 382.61 +111-40-0 diethylene triamine -5860 444.88 +111-41-1 N-aminoethyl ethanolamine -191000 447.83 +111-42-2 diethanolamine -396880 429.54 +111-43-3 dipropyl ether -293100 424.24 +111-46-6 diethylene glycol -571200 440.07 +111-47-7 dipropyl sulfide -125200 451.45 +111-49-9 hexamethyleneimine -34180 357.29 +111-55-7 ethylene glycol diacetate -807000 507.84 +111-65-9 octane -208800 467.05 +111-66-0 1-octene -83600 464.83 +111-68-2 heptylamine -154000 482.72 +111-69-3 adiponitrile 149500 400.59 +111-70-6 1-heptanol -336500 479.16 +111-71-7 1-heptanal -269400 461.51 +111-76-2 2-butoxyethanol -441000 480.19 +111-77-3 2-(2-methoxyethoxy)ethanol -530000 573.8 +111-78-4 1,5-cyclooctadiene 101100 350.71 +111-82-0 methyl dodecanoate -612300 729.91 +111-83-1 1-bromooctane -182120 518.67 +111-84-2 nonane -229030 507.08 +111-85-3 1-chlorooctane -234890 465.15 +111-86-4 octylamine -174600 521.87 +111-87-5 1-octanol -357000 518.65 +111-88-6 octyl mercaptan -170100 533.32 +111-90-0 2-(2-ethoxyethoxy)ethanol -565000 519.04 +111-92-2 dibutylamine -156600 502.86 +111-96-6 diethylene glycol dimethyl ether -511000 503.95 +112-05-0 nonanoic acid -578000 550.83 +112-06-1 heptyl acetate -547100 561.22 +112-12-9 2-undecanone -383600 615.44 +112-14-1 octyl acetate -567900 600.38 +112-15-2 diethylene glycol ethyl ether acetate -776000 612.11 +112-17-4 decyl acetate -609300 679.02 +112-18-5 dimethyldodecylamine -264760 717.42 +112-20-9 nonylamine -195200 561.36 +112-23-2 heptyl formate -489800 526.77 +112-24-3 triethylene tetramine 3350 565.27 +112-27-6 triethylene glycol -725090 559.34 +112-29-8 1-bromodecane -223400 596.57 +112-30-1 1-decanol -397400 596.95 +112-31-2 decanal -331700 578.97 +112-32-3 octyl formate -510600 565.92 +112-34-5 diethylene glycol monobutyl ether -606000 597.35 +112-36-7 diethylene glycol diethyl ether -580000 587.29 +112-37-8 undecanoic acid -619000 643.12 +112-40-3 dodecane -290830 625.21 +112-41-4 1-dodecene -165400 621.78 +112-42-5 1-undecanol -418400 636.44 +112-44-7 undecanal -352200 618.46 +112-47-0 1,10-decanediol -554190 647.31 +112-49-2 triethylene glycol dimethyl ether -676000 622.79 +112-51-6 dipentyl disulfide -202000 646.7 +112-52-7 1-chlorododecane -314890 629.55 +112-53-8 1-dodecanol -436500 675.6 +112-54-9 dodecanal -373300 657.61 +112-55-0 1-dodecanethiol -253200 690.27 +112-57-2 tetraethylenepentamine 12600 684.55 +112-58-3 dihexyl ether -415500 660.17 +112-60-7 tetraethylene glycol -882320 651.87 +112-62-9 methyl oleate -626000 959.26 +112-66-3 dodecyl acetate -650700 758 +112-69-6 dimethylhexadecylamine -347320 873.23 +112-70-9 1-tridecanol -460100 715.76 +112-71-0 1-bromotetradecane -305960 752.38 +112-72-1 1-tetradecanol -481100 753.9 +112-73-2 diethylene glycol dibutyl ether -662000 743.9 +112-75-4 dimethyltetradecylamine -306040 795.32 +112-80-1 oleic acid -671780 913.09 +112-82-3 1-bromohexadecane -347240 830.29 +112-88-9 1-octadecene -290000 857.37 +112-89-0 1-bromooctadecane -388520 908.19 +112-92-5 1-octadecanol -563800 910.85 +112-95-8 eicosane -456460 940.18 +112-99-2 dioctadecylamine -732900 1599 +115-07-1 propylene 19700 266.71 +115-10-6 dimethyl ether -184100 267.29 +115-11-7 isobutene -17100 293.12 +115-25-3 octafluorocyclobutane -1528000 400.92 +115-76-4 2,2-diethyl-1,3-propanediol -492000 521.83 +115-77-5 pentaerythritol -776700 438.08 +115-86-6 triphenyl phosphate -757300 +116-14-3 tetrafluoroethylene -658600 300.01 +116-15-4 hexafluoropropylene -1080000 491.77 +116-53-0 2-methylbutyric acid -497000 400.92 +117-84-0 dioctyl phthalate -966720 1151.3 +118-74-1 hexachlorobenzene -33900 436.7 +118-90-1 o-toluic acid -322800 406.69 +118-91-2 o-chlorobenzoic acid -325000 400.26 +118-96-7 2,4,6-trinitrotoluene -67100 +119-36-8 methyl salicylate -464300 456.11 +119-61-9 benzophenone 59000 441.53 +119-64-2 1,2,3,4-tetrahydronaphthalene 26000 366.22 +119-65-3 isoquinoline 208400 365.7 +120-12-7 anthracene 227700 385.95 +120-51-4 benzyl benzoate -191000 545.69 +120-61-6 dimethyl terephthalate -637000 574.4 +120-72-9 indole 156600 328.44 +120-80-9 pyrocatechol -272000 333.46 +120-82-1 1,2,4-trichlorobenzene -200 376.59 +120-92-3 cyclopentanone -192100 313.56 +120-94-5 N-methylpyrrolidine -8120 329.68 +121-14-2 2,4-dinitrotoluene -64200 +121-17-5 4-chloro-3-nitrobenzotrifluoride -634250 464.61 +121-32-4 ethyl vanillin -404000 506.33 +121-33-5 vanillin -369000 467.18 +121-44-8 triethylamine -92700 403.65 +121-69-7 N,N'-dimethylaniline 100500 366.65 +121-73-3 m-chloronitrobenzene 37200 373.57 +121-91-5 isophthalic acid -696300 443.4 +122-39-4 diphenylamine 202000 403.8 +122-66-7 hydrazobenzene 319000 454.26 +123-01-3 dodecylbenzene -179000 753.11 +123-02-4 tridecylbenzene -199700 792.26 +123-05-7 2-ethylhexanal -299600 495.93 +123-07-9 p-ethylphenol -144050 391.13 +123-08-0 p-hydroxybenzaldehyde -213000 389.17 +123-15-9 2-methylpentanal -256000 405.65 +123-19-3 4-heptanone -301100 448.76 +123-25-1 diethyl succinate -851000 589.5 +123-31-9 p-hydroquinone -261710 344.16 +123-38-6 propionaldehyde -186000 304.56 +123-39-7 N-methylformamide -184430 280.98 +123-42-2 diacetone alcohol -545800 437.39 +123-44-4 2,2,4-trimethyl-1-pentanol -374710 470.11 +123-51-3 3-methyl-1-butanol -300410 394.1 +123-54-6 acetylacetone -380000 404.4 +123-62-6 propionic anhydride -626500 470.66 +123-63-7 paraldehyde -645300 338.32 +123-72-8 butyraldehyde -207000 343.71 +123-73-9 trans-crotonaldehyde -104000 316.34 +123-75-1 pyrrolidine -3500 310.38 +123-76-2 levulinic acid -607000 426.48 +123-86-4 butyl acetate -485300 443.43 +123-91-1 1,4-dioxane -315060 300.49 +123-92-2 isopentyl acetate -511200 475.2 +123-95-5 butyl stearate -819270 1087 +123-96-6 2-octanol -376100 515.96 +123-99-9 azelaic acid -927000 601.82 +124-04-9 adipic acid -865040 499.22 +124-07-2 octanoic acid -556000 521.73 +124-09-4 hexamethylenediamine -98830 475.45 +124-11-8 1-nonene -104000 503.98 +124-12-9 octanenitrile -43570 473.73 +124-13-0 1-octanal -290200 500.66 +124-18-5 decane -249500 546.36 +124-19-6 1-nonanal -310900 539.81 +124-22-1 dodecylamine -257000 679.16 +124-25-4 tetradecanal -414800 736.25 +124-28-7 dimethyloctadecylamine -388600 951.13 +124-30-1 octadecylamine -380600 914.75 +124-38-9 carbon dioxide -393520 213.91 +124-40-3 dimethylamine -18600 270.52 +124-73-2 1,2-dibromotetrafluoroethane -922990 387.72 +126-30-7 neopentyl glycol -447000 404.15 +126-98-7 methacrylonitrile 98030 224.2 +126-99-8 chloroprene 27400 313.29 +127-17-3 pyruvic acid -625000 317.99 +127-18-4 tetrachloroethylene -12100 340.92 +127-19-5 N,N'-dimethylacetamide -225000 351.58 +127-91-3 beta-pinene 38700 404.2 +128-37-0 2,6-di-tert-butyl-p-cresol -341000 1049.1 +129-00-0 pyrene 225700 402.12 +131-11-3 dimethyl phthalate -663000 661.6 +132-64-9 dibenzofuran 83400 306.45 +135-01-3 o-diethylbenzene -15730 435.75 +135-98-8 sec-butylbenzene -16900 428.47 +136-35-6 1,3-diphenyltriazene 331600 +136-60-7 butyl benzoate -367000 539.08 +137-32-6 2-methyl-1-butanol -302080 394.23 +140-11-4 benzyl acetate -309160 459.63 +140-31-8 N-aminoethyl piperazine 25100 450.37 +140-66-9 p-tert-octylphenol -291000 568.26 +140-88-5 ethyl acrylate -349530 407.49 +141-05-9 diethyl maleate -740000 582.92 +141-32-2 butyl acrylate -395050 485.89 +141-43-5 monoethanolamine -210190 320.74 +141-59-3 tert-octyl mercaptan -205000 470.93 +141-78-6 ethyl acetate -444500 360.42 +141-79-7 mesityl oxide -195560 398.73 +141-93-5 m-diethylbenzene -21000 440.21 +141-97-9 ethylacetoacetate -560000 485.76 +142-28-9 1,3-dichloropropane -161500 367.68 +142-29-0 cyclopentene 33900 291.48 +142-60-9 octyl propanoate -585800 639.87 +142-62-1 hexanoic acid -509000 456.84 +142-82-5 heptane -187800 428.23 +142-84-7 di-propylamine -116000 430.15 +142-92-7 hexyl acetate -526300 522.07 +142-96-1 dibutyl ether -332900 502.55 +143-07-7 dodecanoic acid -640000 691.76 +143-08-8 1-nonanol -378500 557.8 +143-10-2 decyl mercaptan -210900 611.96 +143-13-5 nonyl acetate -588600 639.87 +143-15-7 1-bromododecane -264680 674.48 +143-16-8 dihexylamine -237540 664.1 +143-24-8 tetraethylene glycol dimethyl ether -884000 729.88 +143-27-1 hexadecylamine -339400 836.44 +144-62-7 oxalic acid -723700 342.17 +148-24-3 8-hydroxyquinoline 21500 397.17 +149-31-5 2-methyl-1,3-pentanediol -484400 465.03 +150-76-5 p-methoxyphenol -249000 399.11 +151-19-9 3,6-dimethyl-3-octanol -415990 548.02 +151-56-4 ethyleneimine 123430 250.99 +151-67-7 halothane -705000 366.27 +156-43-4 p-phenetidine -103000 437.8 +156-59-2 cis-1,2-dichloroethylene -2800 289.78 +156-60-5 trans-1,2-dichloroethylene -400 290.11 +156-87-6 3-amino-1-propanol -221000 367.64 +157-40-4 spiropentane 185200 282.76 +206-44-0 fluoranthene 289000 413.19 +218-01-9 chrysene 269800 450.04 +275-51-4 azulene 279900 338.63 +280-57-9 triethylenediamine 52700 358.44 +287-23-0 cyclobutane 28400 264.95 +287-27-4 thiacyclobutane 61000 285.35 +287-92-3 cyclopentane -77100 292.7 +288-42-6 oxazole -15500 270.75 +291-64-5 cycloheptane -118100 343.17 +292-64-8 cyclooctane -124400 367.56 +293-55-0 cyclononane -132800 +293-96-9 cyclodecane -154300 +294-41-7 cycloundecane -179400 +294-62-2 cyclododecane -230200 +295-02-3 cyclotridecane -246400 +295-17-0 cyclotetradecane -239200 +295-48-7 cyclopentadecane -301400 +295-65-8 cyclohexadecane -321700 +295-97-6 cycloheptadecane -364300 +296-18-4 cyclooctadecane -414110 +296-44-6 cyclononadecane -440910 +296-56-0 cycloeicosane -467710 +300-57-2 2-propenylbenzene 138000 412.76 +302-01-2 hydrazine 95350 238.72 +306-83-2 2,2-dichloro-1,1,1-trifluoroethane -743900 352.54 +320-60-5 2,4-dichlorobenzotrifluoride -651450 440.01 +334-48-5 decanoic acid -594300 599.04 +334-56-5 1-fluorodecane -428200 582.76 +334-68-9 1-fluorododecane -469400 662.07 +338-64-7 1-chloro-1,2-difluoroethane -497850 321.19 +338-65-8 2-chloro-1,1-difluoroethane -497850 321.19 +352-32-9 p-fluorotoluene -147500 339.02 +352-93-2 diethyl sulfide -83200 368.32 +353-36-6 ethyl fluoride -264400 265.17 +353-50-4 carbonyl fluoride -638900 258.89 +353-59-3 bromochlorodifluoromethane -435200 317.693 +353-61-7 2-fluoro-2-methylpropane -330750 304.63 +353-81-1 2,2-difluorobutane -526860 336.33 +354-09-6 2-fluoro-2,3-dimethylbutane -372030 382.54 +354-11-0 1,1,1,2-tetrachloro-2-fluoroethane -357710 350.89 +354-12-1 1,1,1-trichloro-2,2-difluoroethane -538080 349.16 +354-14-3 1,1,2,2-tetrachloro-1-fluoroethane -357710 350.89 +354-15-4 1,1,2-trichloro-1,2-difluoroethane -538080 349.16 +354-21-2 1,2,2-trichloro-1,1-difluoroethane -538080 349.16 +354-23-4 1,2-dichloro-1,1,2-trifluoroethane -718450 347.44 +354-25-6 1-chloro-1,1,2,2-tetrafluoroethane -898820 345.71 +354-33-6 pentafluoroethane -1105000 332.25 +354-56-3 pentachlorofluoroethane -325100 392.53 +354-58-5 1,1,1-trichloro-2,2,2-trifluoroethane -740600 369.22 +355-25-9 decafluorobutane -2140000 466.73 +358-03-2 3,3-difluoropentane -547500 375.28 +359-00-2 1-fluoro-2-methylpropane -327280 333.98 +359-01-3 2-fluorobutane -327280 333.98 +359-10-4 2-chloro-1,1-difluoroethylene -332200 302.27 +359-11-5 trifluoroethene -490800 292.46 +359-28-4 1,1,2-trichloro-2-fluoroethane -338500 346.82 +359-35-3 1,1,2,2-tetrafluoroethane -892400 320.34 +360-89-4 octafluoro-2-butene -1650000 431.64 +367-11-3 o-difluorobenzene -294500 320.83 +371-64-2 1-fluoro-3,3-dimethylbutane -373840 402.36 +371-65-3 2,2-difluoropentane -547500 375.28 +372-18-9 m-difluorobenzene -310000 320.16 +372-54-3 2-fluorohexane -368560 411.89 +372-90-7 1,4-difluorobutane -518110 375.2 +373-14-8 1-fluorohexane -345700 423.79 +373-17-1 1,5-difluoropentane -538750 414.15 +374-07-2 1,1-dichloro-1,2,2,2-tetrafluoroethane -926800 367.13 +392-56-3 hexafluorobenzene -957300 381.2 +406-82-6 1,1,1-trifluoropentane -743610 406.98 +407-06-7 1-fluoro-3-methylbutane -347920 372.93 +407-79-4 5-fluoro-1-pentene -217210 377.86 +407-96-5 1,1-difluoroheptane -604000 480.89 +408-38-8 1-fluorohexadecane -552000 820.69 +409-21-2 silicon carbide (hexagonal) 719650 213.03 +420-12-2 ethylene sulfide 82380 255.25 +420-26-8 2-fluoropropane -293500 292.92 +420-45-1 2,2-difluoropropane -522500 302.81 +420-46-2 1,1,1-trifluoroethane -745600 287.3 +421-04-5 1-chloro-1,1,2-trifluoroethane -697430 323.54 +421-07-8 1,1,1-trifluoropropane -702330 329.07 +421-48-7 1,1,1,2-tetrafluoropropane -903720 351.24 +430-44-4 2-fluoro-1-butene -206360 334.75 +430-53-5 1,1-dichloro-2-fluoroethane -317480 322.92 +430-57-9 1,2-dichloro-1-fluoroethane -317480 322.92 +430-61-5 1,1-difluoropropane -521500 321.93 +430-66-0 1,1,2-trifluoroethane -669400 310.45 +431-06-1 1,2-dichloro-1,2-difluoroethane -518870 345.09 +431-07-2 1-chloro-1,2,2-trifluoroethane -699240 343.36 +431-31-2 1,1,1,2,3-pentafluoropropane -1099800 382.94 +431-63-0 1,1,1,2,3,3-hexafluoropropane -1301200 405.11 +452-86-8 1,2-dihydroxy-4-methylbenzene -305900 375.2 +460-12-8 biacetylene 450000 249.9 +460-13-9 1-fluoropropane -283800 304.32 +460-19-5 cyanogen 309070 241.56 +460-34-4 1,1,1-trifluorobutane -722970 368.02 +460-36-6 1,1,1,3-tetrafluoropropane -898440 360.77 +460-73-1 1,1,1,3,3-pentafluoropropane -1099800 382.94 +462-06-6 fluorobenzene -116300 301.54 +462-39-5 1,3-difluoropropane -497470 336.25 +463-11-6 1-fluorooctane -386900 503.44 +463-18-3 1-fluorononane -407600 542.93 +463-49-0 allene 190900 243.7 +463-51-4 ketene -47700 241.72 +463-58-1 carbonyl sulfide -138410 231.58 +463-82-1 neopentane -167900 305.99 +464-06-2 2,2,3-trimethylbutane -204810 384.36 +464-07-3 3,3-dimethyl-2-butanol -342800 360.78 +471-43-2 1,1-dichloro-2,2-difluoroethane -518800 354.05 +486-34-0 1,2,7-trimethylnaphthalene 57000 442.68 +488-17-5 1,2-dihydroxy-3-methylbenzene -305900 375.2 +488-23-3 1,2,3,4-tetramethylbenzene -41800 418.08 +488-70-0 2,3,4,5-tetramethylphenol -224920 447.07 +490-65-3 1-methyl-7-isopropylnaphthalene 51300 509.67 +491-35-0 4-methylquinoline 199190 336.74 +493-01-6 cis-decahydronaphthalene -169200 378.92 +493-02-7 trans-decahydronaphthalene -182100 373.89 +496-11-7 indane 60700 346.85 +496-73-1 1,3-dihydroxy-4-methylbenzene -305900 375.2 +496-78-6 2,4,5-trimethylphenol -192810 414.28 +498-23-7 citraconic acid -740000 435.27 +498-66-8 2-norbornene 90000 314.58 +499-75-2 2-methyl-5-isopropylphenol -207260 449.88 +501-65-5 diphenylacetylene 430120 466.58 +502-44-3 epsilon-caprolactone -425930 362.76 +503-17-3 dimethylacetylene 145900 283.19 +503-30-0 1,3-propylene oxide -75060 265.65 +503-60-6 1-chloro-3-methyl-2-butene -54840 373.45 +503-64-0 cis-2-butenoic acid -354500 366.92 +503-74-2 3-methylbutanoic acid -503000 431.11 +504-15-4 1,3-dihydroxy-5-methylbenzene -305900 375.2 +504-63-2 1,3-propanediol -409000 302.97 +504-64-3 carbon suboxide -93640 276.07 +506-05-8 1-fluoroundecane -448800 622.24 +506-12-7 heptadecanoic acid -744000 872.94 +506-30-9 eicosanoic acid -806000 989.53 +506-68-3 cyanogen bromide 186190 248.37 +506-77-4 cyanogen chloride 137950 236.33 +506-78-5 cyanogen iodide 225940 257.34 +507-09-5 thioacetic-acid -181900 313.56 +507-19-7 2-bromo-2-methylpropane -133800 332.61 +507-20-0 2-chloro-2-methylpropane -184800 317.73 +507-25-5 carbon tetraiodide 267900 391.63 +507-36-8 2-bromo-2-methylbutane -128950 362.94 +507-45-9 2,3-dichloro-2-methylbutane -192040 369.21 +509-14-8 tetranitromethane 88300 +512-56-1 trimethyl phosphate -1080000 +513-35-9 2-methyl-2-butene -40800 338.65 +513-36-0 1-chloro-2-methylpropane -172000 251.56 +513-37-1 1-chloro-2-methyl-1-propene -34200 334.49 +513-38-2 1-iodo-2-methylpropane -54300 357.9 +513-44-0 isobutyl mercaptan -96900 362.95 +513-48-4 2-iodobutane -54300 357.9 +513-53-1 sec-butyl mercaptan -96600 366.98 +513-81-5 2,3-dimethyl-1,3-butadiene 45100 340.36 +514-10-3 abietic acid -537000 649.76 +526-73-8 1,2,3-trimethylbenzene -9500 384.62 +526-75-0 2,3-xylenol -157200 386 +526-85-2 2,3,4-trimethylphenol -192810 414.28 +527-35-5 2,3,5,6-tetramethylphenol -224920 447.07 +527-53-7 1,2,3,5-tetramethylbenzene -44700 424.11 +527-54-8 3,4,5-trimethylphenol -192810 414.28 +527-60-6 2,4,6-trimethylphenol -192810 414.28 +527-84-4 o-cymene -26400 427.47 +528-29-0 o-dinitrobenzene 27800 322.83 +533-98-2 1,2-dibromobutane -99200 409.24 +534-22-5 2-methylfuran -66300 308.99 +535-77-3 m-cymene -30900 432.16 +536-74-3 ethynylbenzene 327300 322.58 +536-75-4 4-ethylpyridine 81500 359.13 +536-78-7 3-ethylpyridine 85700 364.49 +538-68-1 pentylbenzene -33900 479.7 +538-93-2 isobutylbenzene -20340 434.38 +539-30-0 benzyl ethyl ether -115000 439.57 +539-90-2 isobutyl butanoate -533000 524.42 +540-18-1 pentyl butanoate -545800 561.89 +540-36-3 p-difluorobenzene -307400 314.12 +540-42-1 isobutyl propanoate -542500 446.69 +540-54-5 1-chloropropane -131900 318.49 +540-67-0 methyl ethyl ether -216500 309.13 +540-84-1 2,2,4-trimethylpentane -224000 423.11 +540-88-5 tert-butyl acetate -523000 406.87 +541-05-9 hexamethylcyclotrisiloxane -1770000 +541-28-6 1-iodo-3-methylbutane -74940 396.86 +541-31-1 3-methyl-1-butanethiol -114600 401.1 +541-33-3 1,1-dichlorobutane -171400 384.39 +541-41-3 ethyl chloroformate -458000 345.33 +541-47-9 3-methyl-2-butenoic acid -391900 384.68 +541-73-1 m-dichlorobenzene 25500 343.47 +542-10-9 ethylidene diacetate -812000 494.42 +542-54-1 4-methylpentanenitrile -16300 392.5 +542-55-2 isobutyl formate -436300 407.29 +542-69-8 1-iodobutane -49020 367.43 +542-88-1 bis(chloromethyl) ether -241000 360.36 +542-92-7 cyclopentadiene 134300 274.17 +543-49-7 2-heptanol -355000 477.14 +543-59-9 1-chloropentane -174890 397.84 +544-10-5 1-chlorohexane -182910 423.14 +544-13-8 glutaronitrile 170000 367.51 +544-25-2 1,3,5-cycloheptatriene 180900 316.38 +544-40-1 dibutyl sulfide -167320 527.88 +544-63-8 tetradecanoic acid -681000 796.9 +544-76-3 hexadecane -374170 782.9 +544-77-4 1-iodohexadecane -296700 834.86 +544-85-4 dotriacontane -703810 1402.5 +544-97-8 zinc, dimethyl 53000 +551-88-2 3-nitropentane -162570 421.53 +552-30-7 trimellitic anhydride -778000 349.63 +554-12-1 methyl propanoate -427500 360.09 +554-14-3 2-methylthiophene 83500 320.98 +555-10-2 beta-phellandrene -5660 423.12 +556-56-9 3-iodo-1-propene 91500 322.84 +556-67-2 octamethylcyclotetrasiloxane -2110000 +557-17-5 methyl propyl ether -237900 352.64 +557-91-5 1,1-dibromoethane -40800 327.45 +557-93-7 2-bromo-1-propene 46000 346.27 +557-98-2 2-chloro-1-propene -21000 296.48 +558-13-4 carbon tetrabromide 79500 357.79 +558-17-8 2-iodo-2-methylpropane -72000 345.43 +558-37-2 3,3-dimethyl-1-butene -60400 341.91 +558-43-0 2-methyl-1,2-propanediol -464000 291.21 +560-21-4 2,3,3-trimethylpentane -218500 426.8 +560-22-5 3,3,4-trimethyl-1-pentene -93700 425.86 +560-23-6 2,3,3-trimethyl-1-pentene -100800 422.54 +562-49-2 3,3-dimethylpentane -204400 383.29 +563-16-6 3,3-dimethylhexane -220000 438.21 +563-45-1 3-methyl-1-butene -27600 334.62 +563-46-2 2-methyl-1-butene -34900 339.65 +563-47-3 3-chloro-2-methyl-1-propene -25990 336.47 +563-52-0 3-chloro-1-butene -21480 331.11 +563-78-0 2,3-dimethyl-1-butene -61500 372.77 +563-79-1 2,3-dimethyl-2-butene -70000 364.72 +563-80-4 methyl isopropyl ketone -262600 371.13 +564-02-3 2,2,3-trimethylpentane -220000 423.78 +564-03-4 3,4,4-trimethyl-1-pentene -101500 399.69 +564-04-5 2,2-dimethyl-3-pentanone -309140 416.5 +565-59-3 2,3-dimethylpentane -194100 415.15 +565-60-6 3-methyl-2-pentanol -335200 403.98 +565-61-7 3-methyl-2-pentanone -282200 412.29 +565-63-9 cis-2-methyl-2-butenoic acid -389200 393.73 +565-67-3 2-methyl-3-pentanol -335200 403.98 +565-69-5 ethyl isopropyl ketone -286100 407.6 +565-75-3 2,3,4-trimethylpentane -217300 428.48 +565-76-4 2,3,4-trimethyl-1-pentene -105700 766.99 +565-77-5 2,3,4-trimethyl-2-pentene -109100 466.64 +565-78-6 3,4-dimethyl-2-pentanone -310950 436.32 +565-80-0 2,4-dimethyl-3-pentanone -311400 455.81 +569-41-5 1,8-dimethylnaphthalene 82000 406.88 +571-58-4 1,4-dimethylnaphthalene 82510 402.21 +571-61-9 1,5-dimethylnaphthalene 81800 402.21 +573-98-8 1,2-dimethylnaphthalene 83550 407.95 +575-37-1 1,7-dimethylnaphthalene 81800 410.5 +575-41-7 1,3-dimethylnaphthalene 81800 410.5 +575-43-9 1,6-dimethylnaphthalene 82510 410.5 +576-26-1 2,6-xylenol -161700 390.02 +578-54-1 o-ethylaniline 38500 389.23 +579-66-8 2,6-diethylaniline -20500 474.24 +581-40-8 2,3-dimethylnaphthalene 83550 412.01 +581-42-0 2,6-dimethylnaphthalene 82510 409.79 +582-16-1 2,7-dimethylnaphthalene 83800 414.25 +583-48-2 3,4-dimethylhexane -212700 451.62 +583-58-4 3,4-dimethylpyridine 70000 357.45 +583-61-9 2,3-dimethylpyridine 68300 357.45 +584-02-1 3-pentanol -317150 382.18 +584-03-2 1,2-butanediol -445000 372.64 +584-84-9 toluene diisocyanate -226150 402.53 +584-94-1 2,3-dimethylhexane -213800 452.63 +585-34-2 3-tert-butylphenol -199260 426.71 +589-34-4 3-methylhexane -191300 426.22 +589-35-5 3-methyl-1-pentanol -322900 437.05 +589-38-8 3-hexanone -277700 409.94 +589-40-2 sec-butyl formate -445400 405.28 +589-43-5 2,4-dimethylhexane -219200 448.27 +589-53-7 4-methylheptane -212000 457.32 +589-55-9 4-heptanol -345320 470.03 +589-62-8 4-octanol -365960 508.99 +589-81-1 3-methylheptane -212500 465.71 +589-82-2 3-heptanol -345320 470.03 +589-93-5 2,5-dimethylpyridine 66400 362.15 +589-98-0 3-octanol -365960 508.99 +590-01-2 butyl propanoate -502600 482.25 +590-13-6 cis-1-bromo-1-propene 40800 304.65 +590-15-8 trans-1-bromo-1-propene 43900 303.64 +590-18-1 cis-2-butene -7400 301.17 +590-19-2 1,2-butadiene 162300 292.58 +590-35-2 2,2-dimethylpentane -205800 392.68 +590-36-3 2-methyl-2-pentanol -349000 331.8 +590-50-1 4,4-dimethyl-2-pentanone -309140 416.5 +590-66-9 1,1-dimethylcyclohexane -180800 364.88 +590-67-0 1-methylcyclohexanol -332000 375.85 +590-73-8 2,2-dimethylhexane -224600 432.84 +590-86-3 3-methylbutanal -236500 362.87 +590-87-4 2-fluoropentane -347920 372.93 +590-94-3 isobutyl isocyanide 40177 438.26 +591-22-0 3,5-dimethylpyridine 72800 356.44 +591-34-4 sec-butyl propanoate -512700 484.93 +591-50-4 iodobenzene 162500 334.35 +591-68-4 butyl valerate -560200 572.96 +591-76-4 2-methylhexane -194600 420.52 +591-78-6 2-hexanone -279000 418.66 +591-80-0 4-pentenoic acid -369200 406.58 +591-87-7 allyl acetate -334000 404.4 +591-93-5 1,4-pentadiene 105700 334.08 +591-95-7 1,2-pentadiene 140700 335.09 +591-96-8 2,3-pentadiene 133100 329.38 +592-13-2 2,5-dimethylhexane -222500 442.57 +592-27-8 2-methylheptane -215400 459.34 +592-41-6 1-hexene -42000 383.84 +592-42-7 1,5-hexadiene 84100 372.9 +592-44-9 1,2-hexadiene 121040 370.15 +592-49-4 2,3-hexadiene 112830 368.17 +592-50-7 1-fluoropentane -325100 383.97 +592-57-4 1,3-cyclohexadiene 106200 303.26 +592-76-7 1-heptene -62800 425.34 +592-84-7 butyl formate -427100 408.63 +593-08-8 2-tridecanone -424900 694.08 +593-32-8 2-octadecanol -572360 935.13 +593-45-3 octadecane -415120 861.54 +593-49-7 heptacosane -600610 1207.7 +593-53-3 methyl fluoride -237700 222.66 +593-60-2 vinyl bromide 78400 275.56 +593-66-8 vinyl iodide 117690 284.92 +593-70-4 chlorofluoromethane -265700 264.5 +593-75-9 methyl isocyanide 150210 474.58 +593-95-3 carbonyl bromide -96200 309.83 +594-02-5 1,1-diiodoethane 66530 344.61 +594-11-6 methylcyclopropane 25000 285.74 +594-16-1 2,2-dibromopropane -61340 336.08 +594-20-7 2,2-dichloropropane -176700 325.45 +594-21-8 1,1,1-triiodoethane 137250 361.89 +594-27-4 tetramethyltin -18800 +594-34-3 1,2-dibromo-2-methylpropane -81980 375.03 +594-36-5 2-chloro-2-methylbutane -202300 366.61 +594-37-6 1,2-dichloro-2-methylpropane -166120 339.78 +594-38-7 2-iodo-2-methylbutane -78410 367.51 +594-39-8 1,1-dimethylpropylamine -112700 392.98 +594-51-4 2,3-dibromo-2-methylbutane -138910 300.45 +594-52-5 2-bromo-2,3-dimethylbutane -149590 401.89 +594-56-9 2,3,3-trimethyl-1-butene -86900 376.47 +594-57-0 2-chloro-2,3-dimethylbutane -196940 374.74 +594-59-2 2-iodo-2,3-dimethylbutane -99050 406.46 +594-60-5 2,3-dimethyl-2-butanol -348200 342.67 +594-70-7 2-nitro-2-methylpropane -175100 362.25 +594-82-1 2,2,3,3-tetramethylbutane -225890 390.58 +594-83-2 2,3,3-trimethyl-2-butanol -357540 401.81 +595-41-5 2,3-dimethyl-3-pentanol -354070 431.16 +595-42-6 2-nitro-2-methylbutane -175100 498.67 +597-05-7 2-methyl-3-ethyl-3-pentanol -374710 470.11 +597-49-9 3-ethyl-3-pentanol -348790 440.69 +597-76-2 3-ethyl-3-hexanol -369430 479.64 +597-77-3 5-methyl-3-ethyl-3-hexanol -395350 509.07 +597-90-0 4-ethyl-4-heptanol -390070 518.59 +597-96-6 3-methyl-3-hexanol -348790 440.69 +598-01-6 4-methyl-4-heptanol -369430 479.64 +598-03-8 dipropyl sulfone -468300 470.99 +598-04-9 dibutyl sulfone -509800 547.62 +598-05-0 dipropyl sulfate -796400 +598-17-4 1,1-dibromopropane -57870 365.43 +598-23-2 3-methyl-1-butyne 136400 319.99 +598-25-4 3-methyl-1,2-butadiene 129100 321.67 +598-29-8 1,2-diiodopropane 35980 396.14 +598-45-8 isopropyl isocyanide 61000 399.92 +598-53-8 methyl isopropyl ether -252000 342.24 +598-56-1 dimethylethylamine -50000 355.93 +598-58-3 methyl nitrate -120400 302.42 +598-61-8 methylcyclobutane -6800 295.05 +598-71-0 dl-2,3-dibromobutane -83790 394.85 +598-73-2 bromotrifluoroethylene -455000 334.75 +598-74-3 1,2-dimethylpropylamine -112700 418.87 +598-75-4 3-methyl-2-butanol -314550 384.77 +598-76-5 1,1-dichloro-2-methylpropane -167930 359.6 +598-77-6 1,1,2-trichloropropane -163030 354.07 +599-02-0 2-nitro-3,3-dimethylbutane -191960 421.61 +599-64-4 p-cumylphenol -65600 534.47 +600-06-6 1-chloro-2,3-dimethylbutane -193470 404.09 +600-10-2 1,2-dichloro-3-methylbutane -188570 398.56 +600-11-3 2,3-dichloropentane -188570 398.56 +600-24-8 2-nitrobutane -163600 367.96 +600-36-2 2,4-dimethyl-3-pentanol -355880 450.98 +603-35-0 triphenylphosphine 320200 +604-88-6 hexaethylbenzene -224260 699.37 +605-01-6 pentaethylbenzene -175180 649.78 +605-02-7 1-phenylnaphthalene 247000 459.65 +606-20-2 2,6-dinitrotoluene -51100 +608-25-3 1,3-dihydroxy-2-methylbenzene -305900 375.2 +608-93-5 pentachlorobenzene -29100 425.72 +609-26-7 3-ethyl-2-methylpentane -212800 443.91 +609-27-8 3-ethyl-2-pentanol -350600 460.51 +610-39-9 3,4-dinitrotoluene -14000 +611-14-3 o-ethyltoluene 1300 400.05 +611-15-4 o-methylstyrene 118400 374.35 +611-32-5 8-methylquinoline 199190 336.74 +612-00-0 1,1-diphenylethane 141360 471.29 +612-58-8 3-methylquinoline 199190 336.74 +612-60-2 7-methylquinoline 199190 336.74 +615-29-2 4-methyl-3-hexanol -350600 460.51 +616-12-6 3-methyl-trans-2-pentene -62500 381.83 +616-13-7 1-chloro-2-methylbutane -179000 336.26 +616-19-3 1,3-dichloro-2-methylpropane -162650 369.13 +616-20-6 3-chloropentane -185600 390.42 +616-21-7 1,2-dichlorobutane -162650 369.13 +616-31-9 3-pentanethiol -117000 410.15 +616-39-7 methyldiethylamine -76500 375.23 +616-42-2 dimethyl sulfite -484300 +616-44-4 3-methylthiophene 82600 321.32 +616-45-5 2-pyrrolidone -197150 301.66 +617-29-8 2-methyl-3-hexanol -350600 460.51 +617-30-1 2,3-hexanediol -495000 429.48 +617-78-7 3-ethylpentane -189660 412.6 +617-79-8 1-amino-2-ethylbutane -135700 441.72 +617-80-1 2-ethylbutanenitrile -14100 392.17 +617-94-7 2-phenyl-2-propanol -305000 690.12 +618-45-1 3-isopropylphenol -175150 417.1 +618-46-2 m-chlorobenzoyl chloride -165310 400.77 +618-85-9 3,5-dinitrotoluene -43000 +619-15-8 2,5-dinitrotoluene -34000 +619-82-9 1,4-cyclohexanedicarboxylic acid -877000 455.46 +619-99-8 3-ethylhexane -210700 458 +620-11-1 1-ethylpropyl acetate -525400 477.21 +620-14-4 m-ethyltoluene -1800 404.75 +620-17-7 m-ethylphenol -146060 396.4 +620-47-3 3-methyldiphenylmethane 133100 495.07 +620-83-7 4-methyldiphenylmethane 133100 495.07 +620-85-9 4-ethyldiphenylmethane 112300 533.49 +621-27-2 3-propylphenol -169870 426.63 +621-77-2 tripentylamine -285400 756.37 +622-96-8 p-ethyltoluene -3200 399.38 +622-97-9 p-methylstyrene 114600 375.36 +623-34-7 1,4-dichloro-2-methylbutane -183290 408.08 +623-37-0 3-hexanol -331500 408.21 +623-42-7 methyl butanoate -450700 399.58 +623-55-2 5-methyl-3-hexanol -350600 460.51 +623-56-3 5-methyl-3-hexanone -305670 445.84 +623-81-4 diethyl sulfite -551600 +623-93-8 5-nonanol -386600 547.94 +623-98-3 dipropyl sulfite -593200 +624-22-6 2-methyl-1-hexanol -345320 470.03 +624-29-3 cis-1,4-dimethylcyclohexane -176600 370.92 +624-41-9 2-methylbutyl acetate -511900 477.21 +624-48-6 dimethyl maleate -620800 499.91 +624-51-1 3-nonanol -386600 547.94 +624-54-4 pentyl propanoate -523500 521.4 +624-64-6 trans-2-butene -11000 296.48 +624-65-7 propargyl chloride 159000 287.89 +624-72-6 1,2-difluoroethane -447700 288.81 +624-73-7 1,2-diiodoethane 66500 348.77 +624-78-2 methylethylamine -45200 335.6 +624-79-3 ethyl isocyanide 83046 357.51 +624-83-9 methyl isocyanate -57780 271.45 +624-89-5 methyl ethyl sulfide -59400 205.74 +624-91-9 methyl nitrite -63900 285.04 +624-92-0 dimethyl disulfide -23600 336.82 +624-95-3 3,3-dimethyl-1-butanol -335000 378.76 +624-96-4 1,3-dichloro-3-methylbutane -186760 378.73 +625-06-9 2,4-dimethyl-2-pentanol -354070 431.16 +625-16-1 tert-pentyl acetate -540700 447.36 +625-22-9 dibutyl sulfate -838000 +625-23-0 2-methyl-2-hexanol -348790 440.69 +625-25-2 2-methyl-2-heptanol -369430 479.64 +625-27-4 2-methyl-2-pentene -66300 379.14 +625-28-5 3-methylbutanenitrile 4400 355.03 +625-29-6 2-chloropentane -176000 346.32 +625-30-9 1-methylbutylamine -122700 396.36 +625-38-7 vinylacetic acid -337200 405.73 +625-43-4 methyl-tert-butylamine -108300 330.79 +625-44-5 methyl isobutyl ether -265400 378.71 +625-45-6 methoxyacetic acid -563000 361.46 +625-54-7 ethyl isopropyl ether -285800 380.73 +625-55-8 isopropyl formate -424800 356.4 +625-58-1 ethyl nitrate -153970 348.92 +625-65-0 2,4-dimethyl-2-pentene -90200 393.18 +625-66-1 1,1-dichloro-3-methylbutane -188570 398.56 +625-67-2 2,4-dichloropentane -188570 398.56 +625-74-1 1-nitro-2-methylpropane -141930 382.58 +625-80-9 diisopropyl sulfide -141100 415.77 +625-86-5 2,5-dimethylfuran -97900 338.09 +626-38-0 1-methylbutyl acetate -523700 475.2 +626-85-7 dibutyl sulfite -634700 +626-87-9 1,4-dibromopentane -99150 443.33 +626-88-0 1-bromo-4-methylpentane -146120 431.24 +626-89-1 4-methyl-1-pentanol -324900 430.34 +626-91-5 methyl 3-methylbutyl ether -286800 420.89 +626-92-6 1,4-dichloropentane -183290 408.08 +626-93-7 2-hexanol -333500 436.98 +626-95-9 1,4-pentanediol -464000 417.09 +627-02-1 ethyl isobutyl ether -298800 418.2 +627-05-4 1-nitrobutane -143900 379.02 +627-08-7 propyl isopropyl ether -306200 411.83 +627-13-4 propyl nitrate -174050 386 +627-19-0 1-pentyne 144400 330.12 +627-20-3 cis-2-pentene -26300 347.37 +627-21-4 2-pentyne 120700 304.97 +627-26-9 trans-crotonitrile 140700 306.61 +627-31-6 1,3-diiodopropane 48490 384.1 +627-35-0 methyl-propylamine -66000 374.01 +627-36-1 propyl isocyanide 61000 391.74 +627-59-8 5-methyl-2-hexanol -350600 460.51 +627-67-8 1-nitro-3-methylbutane -162570 421.53 +627-97-4 2-methyl-2-heptene -106600 438.17 +627-98-5 5-methyl-1-hexanol -342000 467.08 +628-05-7 1-nitropentane -157290 431.06 +628-17-1 1-iodopentane -69660 406.38 +628-21-7 1,4-diiodobutane 27850 423.05 +628-28-4 methyl butyl ether -258100 390.79 +628-29-5 methyl butyl sulfide -101900 411.83 +628-32-0 ethyl propyl ether -272200 388.78 +628-44-4 2-methyl-2-octanol -390070 518.59 +628-63-7 pentyl acetate -505500 482.58 +628-71-7 1-heptyne 103000 408.36 +628-73-9 hexanenitrile -9600 403.91 +628-76-2 1,5-dichloropentane -200000 343.85 +628-77-3 1,5-diiodopentane 7210 462 +628-80-8 methyl pentyl ether -279100 430.28 +628-81-9 ethyl butyl ether -292400 429.94 +628-99-9 2-nonanol -398000 548.74 +629-04-9 1-bromoheptane -168000 486.96 +629-05-0 1-octyne 82300 447.52 +629-06-1 1-chloroheptane -214890 424.06 +629-08-3 heptanenitrile -30400 445.74 +629-11-8 1,6-hexanediol -469400 473.79 +629-19-6 dipropyl disulfide -117600 491.76 +629-20-9 1,3,5,7-cyclooctatetraene 298030 327.55 +629-27-6 1-iodooctane -131580 523.24 +629-30-1 1,7-heptanediol -490200 537.39 +629-33-4 hexyl formate -469000 487.28 +629-37-8 1-nitrooctane -219210 547.91 +629-41-4 1,8-octanediol -512910 569.4 +629-45-8 dibutyl disulfide -159900 571.41 +629-49-2 2-dodecyne -18710 595.17 +629-50-5 tridecane -311770 664.9 +629-58-3 pentadecyl acetate -712800 875.79 +629-59-4 tetradecane -332440 704.25 +629-60-7 tridecanenitrile -146770 668.49 +629-62-9 pentadecane -353110 743.57 +629-63-0 tetradecanenitrile -167410 707.44 +629-64-1 diheptyl ether -456800 738.81 +629-65-2 diheptyl sulfide -290960 762.33 +629-66-3 2-nonadecanone -549000 930.01 +629-70-9 hexadecyl acetate -733500 915.28 +629-72-1 1-bromopentadecane -326600 791.33 +629-73-2 1-hexadecene -248600 779.06 +629-74-3 1-hexadecyne -83000 761.75 +629-75-4 2-hexadecyne -101270 750.98 +629-76-5 1-pentadecanol -501800 793.39 +629-78-7 heptadecane -394450 822.22 +629-79-8 hexadecanenitrile -208690 785.35 +629-80-1 hexadecanal -456400 814.56 +629-82-3 dioctyl ether -498100 817.79 +629-89-0 1-octadecyne -124400 840.06 +629-90-3 heptadecanal -477200 853.71 +629-92-5 nonadecane -435790 900.86 +629-93-6 1-iodooctadecane -337980 912.76 +629-94-7 heneicosane -476770 974 +629-96-9 1-eicosanol -605200 989.49 +629-97-0 docosane -497410 1013 +629-99-2 pentacosane -559330 1129.8 +630-01-3 hexacosane -579970 1168.8 +630-02-4 octacosane -621250 1246.7 +630-03-5 nonacosane -641890 1285.6 +630-04-6 hentriacontane -683170 1363.5 +630-05-7 tritriacontane -724450 1441.4 +630-06-8 hexatriacontane -786370 1558.3 +630-07-9 pentatriacontane -765730 1519.3 +630-08-0 carbon monoxide -110530 197.87 +630-13-7 2,2-diiodopropane 39740 345.22 +630-16-0 1,1,1,2-tetrabromoethane 11960 399.22 +630-17-1 1-bromo-2,2-dimethylpropane -128950 362.94 +630-18-2 2,2-dimethylpropanenitrile -2500 331.21 +630-19-3 2,2-dimethylpropanal -249600 301.23 +630-20-6 1,1,1,2-tetrachloroethane -149400 356.22 +631-28-7 1,2,3-tribromo-2-methylpropane -55650 426.08 +631-65-2 2-chloro-3-methylbutane -190000 307.55 +632-05-3 1,2,3-tribromobutane -57460 445.9 +632-15-5 3,4-dimethylthiophene 52300 346.38 +632-16-6 2,3-dimethylthiophene 53400 352.09 +632-51-9 tetraphenylethylene 438000 694.68 +634-66-2 1,2,3,4-tetrachlorobenzene -9600 397.3 +634-90-2 1,2,3,5-tetrachlorobenzene -20100 399.64 +635-81-4 1,2,4,5-tetraethylbenzene -123260 583.38 +637-78-5 isopropyl propanoate -501200 434.04 +637-92-3 ethyl tert-butyl ether -316500 398.41 +637-97-8 2-iodopentane -74940 396.86 +638-00-6 2,4-dimethylthiophene 51000 359.8 +638-02-8 2,5-dimethylthiophene 52100 353.09 +638-04-0 cis-1,3-dimethylcyclohexane -184600 371.25 +638-11-9 isopropyl butanoate -521500 473.19 +638-28-8 2-chlorohexane -188190 413.61 +638-45-9 1-iodohexane -90300 445.33 +638-46-0 ethyl butyl sulfide -125200 452.33 +638-49-3 pentyl formate -448200 448.12 +638-53-9 tridecanoic acid -660000 721.96 +638-59-5 tetradecyl acetate -692100 836.64 +638-60-8 2-tetradecene -59990 803.76 +638-65-3 octadecanenitrile -249970 863.25 +638-66-4 octadecanal -498000 893.2 +638-67-5 tricosane -518050 1051.9 +638-68-6 triacontane -662530 1324.6 +641-91-8 1,2,5-trimethylnaphthalene 57000 442.68 +642-32-0 1,2,3,4-tetraethylbenzene -123260 581.4 +644-35-9 2-propylphenol -169870 426.63 +645-49-8 cis-stilbene 245180 453.91 +645-56-7 4-propylphenol -169870 426.63 +646-04-8 trans-2-pentene -31100 343.34 +646-05-9 1-pentene-3-yne 249000 313.41 +646-14-0 1-nitrohexane -177930 470.01 +646-30-0 nonadecanoic acid -785000 951.79 +646-31-1 tetracosane -538690 1090.9 +659-70-1 isopentyl isovalerate -583000 590.21 +661-11-0 1-fluoroheptane -366300 463.62 +661-53-0 2-fluoro-2-methylbutane -351390 343.59 +666-21-7 2,3-difluorobutane -528670 356.15 +674-76-0 4-methyl-trans-2-pentene -61300 368.08 +674-82-8 diketene -190200 304.33 +676-44-8 1-fluoroeicosane -634500 979.32 +677-56-5 1,1,1,2,2,3-hexafluoropropane -1320100 287.82 +679-86-7 1,1,2,2,3-pentafluoropropane -1099800 382.94 +680-00-2 1,1,2,2,3,3-hexafluoropropane -1402300 401.15 +680-31-9 hexamethyl phosphoramide -467000 +684-16-2 hexafluoroacetone -1460000 392.77 +684-84-4 2-methyl-1,3-butanediol -471000 401.8 +686-65-7 1,2-difluorobutane -523390 365.68 +688-74-4 tributyl borate -1147000 +689-97-4 vinylacetylene 304600 279.62 +690-08-4 4,4-dimethyl-trans-2-pentene -90200 346.79 +690-37-9 2,4,4-trimethyl-2-pentanol -378180 440.77 +690-39-1 1,1,1,3,3,3-hexafluoropropane -1299400 385.29 +690-92-6 2,2-dimethyl-cis-3-hexene -91000 452.29 +690-93-7 2,2-dimethyl-trans-3-hexene -109500 390.24 +691-37-2 4-methyl-1-pentene -51500 368.08 +691-38-3 4-methyl-cis-2-pentene -57300 373.11 +691-42-9 1,3-difluorobutane -523390 365.68 +692-24-0 2-methyl-trans-3-hexene -82400 390.66 +692-45-5 vinyl formate -262000 305.97 +692-70-6 2,5-dimethyl-trans-3-hexene -111900 408.08 +692-96-6 2-methyl-trans-3-heptene -103200 429.08 +693-02-7 1-hexyne 123700 369.21 +693-39-0 1-nitroheptane -198570 508.96 +693-54-9 2-decanone -362900 575.95 +693-58-3 1-bromononane -202760 557.62 +693-65-2 di-pentyl ether -374200 581.19 +693-67-4 1-bromoundecane -244040 635.52 +693-83-4 didecyl sulfide -414630 996.82 +693-89-0 1-methylcyclopentene -3700 326.28 +694-35-9 3-ethylcyclopentene -8100 394.61 +696-29-7 isopropylcyclohexane -195000 409.4 +697-82-5 2,3,5-trimethylphenol -192810 414.28 +698-71-5 3-methyl-5-ethylphenol -181340 420.46 +700-12-9 pentamethylbenzene -61200 444.82 +713-36-0 2-methyldiphenylmethane 133100 495.07 +719-79-9 1,1-diphenylbutane 93000 +753-89-9 1-chloro-2,2-dimethylpropane -189000 285.01 +757-88-0 1,1-dimethylpropyl formate -483300 412.57 +760-20-3 3-methyl-1-pentene -49000 377.13 +760-21-4 trans-3-hexene -52300 377.13 +760-23-6 3,4-dichloro-1-butene -64400 371.44 +762-50-5 1-chloro-2-fluoroethane -290000 304.32 +762-62-9 4,4-dimethyl-1-pentene -80400 354.1 +762-63-0 4,4-dimethyl-cis-2-pentene -74100 253.78 +762-75-4 tert-butyl formate -465100 372.41 +763-29-1 2-methyl-1-pentene -59300 381.83 +763-30-4 2-methyl-1,4-pentadiene 73900 376.35 +763-69-9 ethyl-3-ethoxypropionate -633000 534.85 +764-35-2 2-hexyne 105130 373 +764-84-1 1,1,1-trifluorododecane -888090 679.64 +764-93-2 1-decyne 41000 526.16 +765-03-7 1-dodecyne -300 604.8 +765-04-8 1,11-undecanediol -574830 686.26 +765-09-3 1-bromotridecane -285320 713.43 +765-10-6 1-tetradecyne -41700 683.11 +765-13-9 1-pentadecyne -62400 722.26 +765-27-5 1-eicosyne -165700 918.7 +765-47-9 1,2-dimethylcyclopentene -39200 351.34 +766-07-4 cyclohexyl peroxide -220000 380.71 +766-90-5 cis-1-propenylbenzene 121300 385.09 +767-59-9 1-methylindene 122000 355.27 +767-99-7 cis-(1-methyl-1-propenyl)benzene 94230 428.37 +768-00-3 trans-(1-methyl-1-propenyl)benzene 94230 428.37 +768-49-0 (2-methyl-1-propenyl)benzene 94230 428.37 +778-22-3 2,2-diphenylpropane 101900 456.78 +811-94-9 1,2,2-trifluoropropane -702330 329.07 +811-95-0 1,1,2-trichloro-1-fluoroethane -336690 233.75 +811-97-2 1,1,1,2-tetrafluoroethane -907100 317.32 +812-03-3 1,1,1,2-tetrachloropropane -182240 358.15 +812-04-4 1,1-dichloro-1,2,2-trifluoroethane -718450 347.44 +813-75-2 1,2,2,3-tetrafluoropropane -898440 360.77 +814-40-4 ethyl methyl sulfate -721200 +814-78-8 methyl isopropenyl ketone -180000 360.52 +816-79-5 3-ethyl-2-pentene -83200 408.47 +817-46-9 2-propyl-1-hexanol -386600 547.94 +817-60-7 2-ethyl-1-heptanol -386600 547.94 +817-91-4 4-methyl-1-heptanol -365960 508.99 +818-49-5 4-methyl-1-hexanol -345320 470.03 +818-61-1 2-hydroxyethyl acrylate -493000 449.96 +818-81-5 2-methyl-1-octanol -386600 547.94 +818-92-8 3-fluoro-1-propene -175930 299.95 +819-97-6 sec-butyl butanoate -543000 519.39 +820-05-3 4,6-dimethyl-1-heptanol -391880 538.41 +820-55-3 1,1-dichloropentane -192000 424.22 +821-11-4 trans-2-butene-1,4-diol -300000 387.56 +821-25-0 1,1-dichloroheptane -233300 503.53 +821-55-6 2-nonanone -340800 536.46 +821-88-5 1,1-dichlorononane -274500 583.18 +821-93-2 1,1-dichlorotridecane -357000 741.8 +821-95-4 1-undecene -145300 583.16 +822-01-5 1,1-dichloroundecane -315800 662.15 +822-13-9 1-chlorotridecane -334890 670.65 +822-15-1 1,1-dichloropentadecane -398300 821.12 +822-20-8 heptadecyl acetate -754200 954.44 +822-23-1 octadecyl acetate -774900 993.92 +822-24-2 eicosyl acetate -816200 1072.9 +822-27-5 dioctyl disulfide -325000 884.97 +822-35-5 cyclobutene 156700 262.06 +822-50-4 trans-1,2-dimethylcyclopentane -136600 366.98 +826-77-7 4,6-dimethylquinoline 167080 369.52 +827-52-1 cyclohexylbenzene -20920 429.36 +829-26-5 2,3,6-trimethylnaphthalene 57000 442.68 +865-58-7 3-bromo-3-methyl-1-butene -3520 358.34 +870-63-3 1-bromo-3-methyl-2-butene -12770 391.07 +871-28-3 1-pentene-4-yne 269000 306.7 +871-83-0 2-methylnonane -256500 539.32 +872-05-9 1-decene -124690 544.08 +872-10-6 dipentyl sulfide -208530 605.92 +872-50-4 N-methyl-2-pyrrolidone -195390 338.97 +872-55-9 2-ethylthiophene 64900 361.14 +872-93-5 3-methyl sulfolane -420000 372.67 +873-66-5 trans-1-propenylbenzene 117200 380.06 +874-41-9 4-ethyl-m-xylene -30800 437.53 +877-43-0 2,6-dimethylquinoline 167080 369.52 +877-44-1 1,2,4-triethylbenzene -71090 519.46 +879-12-9 1,2,3-trimethylnaphthalene 57000 442.68 +917-92-0 3,3-dimethyl-1-butyne 103000 335.67 +918-02-5 dimethyl-tert-butylamine -105500 376.62 +918-82-1 3,3-dimethyl-1-pentyne 83300 384.21 +918-84-3 3-chloro-3-methylpentane -191660 384.27 +921-04-0 dimethyl-sec-butylamine -102400 404.73 +921-47-1 2,3,4-trimethylhexane -235400 477.7 +922-17-8 3,4-hexanediol -493000 436.19 +922-28-1 3,4-dimethylheptane -233800 495.14 +922-59-8 3-methyl-1-pentyne 116900 364.18 +922-62-3 3-methyl-cis-2-pentene -63000 379.14 +925-60-0 propyl acrylate -364000 446.91 +926-41-0 neopentyl acetate -522400 452.73 +926-54-5 2-methyl-1,trans-3-pentadiene 65690 374.37 +926-56-7 4-methyl-1,3-pentadiene 65690 374.37 +926-63-6 dimethyl-propylamine -70800 394.35 +926-82-9 3,5-dimethylheptane -238900 487.76 +927-62-8 dimethylbutylamine -91600 432.77 +927-73-1 4-chloro-1-butene -16200 340.63 +928-40-5 1,5-hexanediol -484700 455.84 +928-49-4 3-hexyne 106000 375.92 +928-50-7 5-chloro-1-pentene -36840 379.58 +929-06-6 2-aminoethoxyethanol -365000 445.64 +929-98-6 dinonyl sulfide -373420 918.75 +930-18-7 1,cis-2-dimethylcyclopropane 700 309.8 +930-27-8 3-methylfuran -67200 310.34 +930-89-2 1-methyl-cis-2-ethylcyclopentane -168310 374.84 +930-90-5 1-methyl-trans-2-ethylcyclopentane -168310 374.84 +932-39-8 1,cis-2-diethylcyclopentane -188950 413.79 +932-40-1 1,trans-2-diethylcyclopentane -188950 413.79 +932-43-4 1-methyl-cis-2-propylcyclopentane -188950 413.79 +932-44-5 1-methyl-trans-2-propylcyclopentane -188950 413.79 +933-98-2 3-ethyl-o-xylene -25650 421.93 +934-74-7 5-ethyl-m-xylene -35400 426.8 +934-80-5 4-ethyl-o-xylene -32090 437.23 +936-89-0 2,4-diethylphenol -201980 459.41 +939-27-5 2-ethylnaphthalene 95900 421.87 +992-94-9 methyl silane -29100 256.84 +993-00-0 methyl chlorosilane -215000 298.78 +993-07-7 trimethyl silane -156610 331.56 +994-05-8 methyl tert-pentyl ether -312000 407.8 +998-35-6 5-propylnonane -293000 612.93 +998-65-2 5-ethyl-1-heptanol -386600 547.94 +998-76-5 1,2-diiodopentane 1930 452.47 +999-21-3 diallyl maleate -517000 641.35 +999-78-0 4,4-dimethyl-2-pentyne 63600 379.52 +999-97-3 hexamethyldisilazane -476600 +1002-17-1 2,9-dimethyldecane -304700 598.85 +1002-43-3 3-methylundecane -295500 622.99 +1002-69-3 1-chlorodecane -274890 547.35 +1002-84-2 pentadecanoic acid -702000 789.1 +1003-17-4 2,2-dimethyltetrahydrofuran -223450 357.52 +1003-30-1 2-ethyltetrahydrofuran -238690 287.99 +1003-38-9 2,5-dimethyltetrahydrofuran -259030 245.63 +1005-64-7 trans-(1-butenyl)benzene 104020 432.52 +1006-59-3 2,6-diethylphenol -201980 459.41 +1007-26-7 1-phenyl-2,2-dimethylpropane -46400 440.8 +1067-08-9 3-methyl-3-ethylpentane -214900 424.45 +1067-20-5 3,3-diethylpentane -232800 437.11 +1068-19-5 4,4-dimethylheptane -241200 467.3 +1068-87-7 2,4-dimethyl-3-ethylpentane -227900 471.66 +1069-53-0 2,3,5-trimethylhexane -242600 475.01 +1070-01-5 tridecylamine -595000 1340.7 +1070-32-2 3-methyl-1-heptanol -365960 508.99 +1070-78-6 1,1,1,3-tetrachloropropane -176960 367.67 +1070-87-7 2,2,4,4-tetramethylpentane -242300 431.07 +1071-26-7 2,2-dimethylheptane -246100 472.33 +1071-31-4 2,2,7,7-tetramethyloctane -325600 547.19 +1071-81-4 2,2,5,5-tetramethylhexane -285270 471.57 +1071-84-7 1,1,1-trichlorononane -286700 597.85 +1072-05-5 2,6-dimethylheptane -242800 482.06 +1072-16-8 2,7-dimethyloctane -264010 517.18 +1072-33-9 tridecyl acetate -671400 797.15 +1072-43-1 2-methylthiacyclopropane 46110 +1074-17-5 1-methyl-2-propylbenzene -19780 432.9 +1074-43-7 1-methyl-3-propylbenzene -24140 437.73 +1074-55-1 1-methyl-4-propylbenzene -23140 431.02 +1074-92-6 1-methyl-2-tert-butyl benzene -48700 434.76 +1075-38-3 1-methyl-3-tert-butylbenzene -54600 436.1 +1077-16-3 hexylbenzene -54600 518.86 +1078-71-3 heptylbenzene -75300 558.01 +1081-75-0 1,3-diphenylpropane 123700 539.42 +1081-77-2 nonylbenzene -116800 635.98 +1111-74-6 dimethyl silane -94700 301.06 +1115-08-8 3-methyl-1,4-pentadiene 78410 370.99 +1116-76-3 trioctylamine -471160 1106.9 +1117-86-8 1,2-octanediol -518190 559.88 +1118-00-9 methyl 2,2-dimethylpropyl ether -296100 392.71 +1119-16-0 4-methylpentanal -256000 405.65 +1119-51-3 5-bromo-1-pentene 5230 397.21 +1119-65-9 2-heptyne 84800 411.72 +1119-85-3 1,4-dicyano-2-butene 261000 393.37 +1119-86-4 1,2-decanediol -559470 637.78 +1119-87-5 1,2-dodecanediol -600750 715.69 +1120-06-5 2-decanol -407240 586.89 +1120-21-4 undecane -270430 585.72 +1120-24-7 dimethyldecylamine -223480 639.51 +1120-36-1 1-tetradecene -207300 700.42 +1120-48-5 dioctylamine -320100 819.91 +1120-49-6 didecylamine -402660 975.72 +1120-62-3 3-methylcyclopentene 5000 330.64 +1123-73-5 2-methyl-3-ethylphenol -181340 420.46 +1123-94-0 3-methyl-4-ethylphenol -181340 420.46 +1124-20-5 1-methyl-3-(1-methylethenyl)benzene 81340 379.23 +1127-76-0 1-ethylnaphthalene 96650 419.19 +1134-62-9 2-butylnaphthalene 52300 501.18 +1184-60-7 2-fluoro-1-propene -185720 295.79 +1185-33-7 2,2-dimethyl-1-butanol -330000 395.53 +1186-53-4 2,2,3,4-tetramethylpentane -235000 451.53 +1189-99-7 2,5,5-trimethylheptane -269370 509.17 +1190-22-3 1,3-dichlorobutane -162650 369.13 +1190-76-7 cis-crotonitrile 134000 309.29 +1190-83-6 2,2,6-trimethylheptane -274640 500.05 +1191-25-9 hydroxycaproic acid -683000 468.86 +1191-96-4 ethylcyclopropane 3200 330.6 +1192-18-3 cis-1,2-dimethylcyclopentane -129500 366.31 +1195-32-0 1-methyl-4-(1-methylethenyl)benzene 81340 379.23 +1196-58-3 3-phenylpentane -37400 467.96 +1198-37-4 2,4-dimethylquinoline 167080 369.52 +1303-86-2 boron oxide -835960 283.9 +1304-28-5 barium oxide -123850 235.99 +1304-56-9 beryllium oxide 136400 197.69 +1305-62-0 calcium hydroxide -610760 285.61 +1305-78-8 calcium oxide 43930 219.72 +1309-48-4 magnesium oxide 58160 213.27 +1310-58-3 potassium hydroxide -232630 236.39 +1310-65-2 lithium hydroxide -234300 210.7 +1310-73-2 sodium hydroxide -197760 228.29 +1310-82-3 rubidium hydroxide -238000 248.39 +1312-41-0 indium antimonide 344300 +1313-27-5 molybdenum oxide -346440 284 +1314-08-5 palladium (II) oxide 348900 217.32 +1314-11-0 strontium oxide -13390 226.37 +1314-23-4 zirconium (IV) oxide -286190 273.88 +1314-35-8 tungsten (VI) oxide -292880 286.39 +1314-68-7 rhenium heptoxide -1100000 436.31 +1314-85-8 phosphorus sesquisulfide -151040 319.31 +1314-87-0 lead sulfide 131800 251.42 +1314-96-1 strontium sulfide 108200 239.41 +1317-36-8 lead oxide 70290 240.05 +1317-37-9 iron (II) sulfide 370770 252.32 +1317-38-0 copper (II) oxide 306270 234.61 +1318-23-6 aluminum oxyhydroxide (α) -460240 254.42 +1320-27-0 1-pentylnaphthalene 32430 538.12 +1323-65-5 dinonylphenol -487000 1122.5 +1333-74-0 hydrogen 0 130.68 +1333-82-0 chromium (VI) oxide -292880 266.37 +1344-57-6 uranium (IV) oxide -465700 274.81 +1345-25-1 iron (II) oxide 251040 241.9 +1446-61-3 dehydroabietylamine -123000 525.6 +1454-84-8 1-nonadecanol -584500 950.34 +1454-85-9 1-heptadecanol -543100 871.7 +1455-21-6 nonyl mercaptan -190800 572.47 +1458-98-6 3-bromo-2-methyl-1-propene 16080 354.1 +1459-09-2 1-phenylhexadecane -261120 910.22 +1459-10-5 tetradecylbenzene -220400 831.41 +1462-11-9 5-methyl-1,5-hexanediol -501020 491.58 +1463-17-8 2,8-dimethylquinoline 167080 369.52 +1476-11-5 1,4-dichloro-cis-2-butene 78200 536.45 +1480-63-3 1-fluorononadecane -613800 939.83 +1484-87-3 3,3,5-trimethyl-1-hexanol -395350 509.07 +1489-47-0 4-methyl-1-nonanol -407240 586.89 +1495-50-7 cyanogen fluoride 35980 225.4 +1501-60-6 2-methyl-1,cis-3-pentadiene 65690 374.37 +1511-82-6 1,1,1-trifluorooctadecane -1011900 913.36 +1518-75-8 3-propylthiophene 42360 389.86 +1530-03-6 1,1-diphenylpropane 117000 692.63 +1530-04-7 1,1-diphenylhexane 45000 +1530-05-8 1,1-diphenylheptane 21000 +1530-06-9 1,1-diphenyloctane -3000 +1530-07-0 1,1-diphenyldecane -51000 +1530-08-1 1,1-diphenylundecane -75000 +1536-21-6 1-fluorotridecane -490100 701.56 +1545-17-1 1-fluoroheptadecane -572600 860.52 +1551-21-9 methyl isopropyl sulfide -89300 363.69 +1551-27-5 2-propylthiophene 42360 389.86 +1551-32-2 2-ethylthiacyclopentane -84600 +1555-17-5 1-fluoropentadecane -531300 781.21 +1560-09-4 cis-(1-butenyl)benzene 104020 432.52 +1560-86-7 2-methylnonadecane -461410 925.52 +1560-88-9 2-methyloctadecane -440770 886.57 +1560-89-0 2-methylheptadecane -420130 847.62 +1560-92-5 2-methylhexadecane -399490 808.67 +1560-93-6 2-methylpentadecane -378850 769.71 +1560-95-8 2-methyltetradecane -358210 730.76 +1560-96-9 2-methyltridecane -337570 691.81 +1560-97-0 2-methyldodecane -316930 652.86 +1565-81-7 3-decanol -407240 586.89 +1573-28-0 3,6-dimethyl-3-heptanol -395350 509.07 +1574-41-0 cis-1,3-pentadiene 82800 323.01 +1590-87-0 disilane 80300 272.02 +1595-04-6 1-methyl-3-butylbenzene -46100 477.02 +1595-05-7 1-methyl-4-butylbenzene -45900 470.31 +1595-06-8 1-methyl-2-sec-butylbenzene -44000 462.26 +1595-11-5 1-methyl-2-butylbenzene -41700 472.32 +1595-16-0 1-methyl-4-sec-butylbenzene -49600 460.92 +1599-67-3 1-docosene -371980 1008.4 +1599-68-4 1-heneicosene -351340 969.4 +1603-53-8 1,1-diphenyldodecane -99000 +1608-26-0 phosphine, tris(dimethylamino) -288700 1475.05 +1613-45-2 5-methyl-3-thiahexane -134600 428.11 +1613-46-3 propyl butyl sulfide -145940 494.46 +1613-51-0 thiacyclohexane -63300 323.08 +1615-75-4 1-chloro-1-fluoroethane -313800 300.63 +1617-31-8 3-methyl-3-butenoic acid -385800 379.58 +1617-32-9 trans-3-pentenoic acid -369100 432.47 +628-00-2 2-heptanethiol -158500 484.44 +1630-77-9 cis-1,2-difluoroethene -322200 268.81 +1630-78-0 trans-1,2-difluoroethene -322200 268.14 +1630-94-0 1,1-dimethylcyclopropane -8200 307.79 +1632-16-2 2-ethyl-1-hexene -97400 458.52 +1632-70-8 5-methylundecane -295300 621.65 +1632-71-9 5-methyl-4-ethylnonane -292100 607.23 +1634-04-4 methyl tert-butyl ether -283200 358.92 +1634-09-9 1-butylnaphthalene 53050 498.5 +1636-41-5 4,5-diethyloctane -289400 603.21 +1636-43-7 5,6-dimethyldecane -294900 604.88 +1636-44-8 4-ethyldecane -293200 620.31 +1638-22-8 4-butylphenol -190510 465.58 +1638-26-2 1,1-dimethylcyclopentane -138200 359.6 +1639-09-4 heptyl mercaptan -149500 493.83 +1640-89-7 ethylcyclopentane -126900 378.05 +1647-08-1 4,4-dimethyl-1-hexene -97200 405.93 +1647-23-0 1-bromo-3,3-dimethylbutane -151400 421.71 +1649-08-7 1,2-dichloro-1,1-difluoroethane -528400 349.69 +1649-73-6 1-fluorooctadecane -593200 900.34 +1653-17-4 1,1,3,3-tetrachloropropane -178770 387.5 +1653-30-1 2-undecanol -427880 664.35 +1653-31-2 2-tridecanol -469160 741.72 +1653-34-5 2-pentadecanol -510440 819.08 +1653-40-3 6-methyl-1-heptanol -365960 508.99 +1656-48-0 bis(cyanoethyl) ether 20400 420.02 +1674-33-5 1,2-dichloropentane -183290 408.08 +1678-80-4 1,cis-2,cis-4-trimethylcyclohexane -215450 391.36 +1678-81-5 1,trans-2,cis-3-trimethylcyclohexane -215450 391.36 +1678-91-7 ethylcyclohexane -171600 382.99 +1678-92-8 propylcyclohexane -193200 419.97 +1678-93-9 butylcyclohexane -213170 459.59 +1679-06-7 2-hexanethiol -137900 445.28 +1679-07-8 cyclopentanethiol -47800 362.65 +1679-08-9 2,2-dimethyl-1-propanethiol -128700 385.67 +1679-09-0 2-methyl-2-butanethiol -126800 387.01 +1680-53-1 1-methyl-4-isopropylnaphthalene 51300 509.67 +1680-58-6 1-sec-butylnaphthalene 51300 509.67 +1687-61-2 3-methyl-6-ethylphenol -181340 420.46 +1687-64-5 2-methyl-6-ethylphenol -181340 420.46 +1687-65-6 2-methyl-5-ethylphenol -181340 420.46 +1708-29-8 2,5-dihydrofuran -108800 284.81 +1712-64-7 isopropyl nitrate -191000 373.92 +1717-00-6 1,1-dichloro-1-fluoroethane -339700 319 +1721-89-7 2,3-dimethylquinoline 167080 369.52 +1726-12-1 1,1-diphenylpentane 69000 +1726-13-2 1,1-diphenylnonane -27000 +1731-81-3 undecyl acetate -630000 718.51 +1740-97-2 2-methyl-4-isopropylphenol -207260 449.88 +1741-83-9 methyl pentyl sulfide -122700 451.32 +1758-85-6 1-methyl-2,4-diethylbenzene -48700 476.68 +1758-88-9 2-ethyl-p-xylene -32180 437.26 +1759-58-6 trans-1,3-dimethylcyclopentane -133500 367.65 +1759-81-5 4-methylcyclopentene 11100 328.96 +1772-10-7 1-methyl-3-sec-butylbenzene -49800 467.29 +1790-22-3 1,2,4-trichlorobutane -178390 402.55 +1795-01-3 3-ethylthiophene 62900 361.14 +1795-04-6 2,3,4-trimethylthiophene -1220 280.05 +1795-05-7 2,3,5-trimethylthiophene 19420 377.52 +1795-09-1 2-methylthiacyclopentane -63890 +1795-15-9 octylcyclohexane -296400 617.71 +1795-16-0 decylcyclohexane -337800 696.56 +1795-17-1 dodecylcyclohexane -379100 775.53 +1795-18-2 tetradecylcyclohexane -420400 854.51 +1795-20-6 octylcyclopentane -251000 609.95 +1795-21-7 decylcyclopentane -292200 688.26 +1795-22-8 tetradecylcyclopentane -375000 844.2 +1795-26-2 1,cis-3,trans-5-trimethylcyclohexane -206500 400.68 +1795-27-3 1,cis-3,cis-5-trimethylcyclohexane -215200 390.95 +1809-05-8 3-iodopentane -74940 396.86 +1814-88-6 1,1,1,2,2-pentafluoropropane -1103300 353.59 +1825-14-5 dl-2,4-pentanediol -479000 374.97 +1838-73-9 3-methyl-4-heptanol -371240 499.46 +1839-88-9 1,cis-2,cis-3-trimethylcyclohexane -215450 391.36 +1842-05-3 1,1-dichloro-1,2-difluoroethane -517060 325.27 +1871-58-5 1,2,3-trichloro-2-methylpropane -181860 373.2 +1873-54-7 3-ethylquinoline 178550 375.69 +1878-18-8 2-methyl-1-butanethiol -114700 410.49 +1889-67-4 2,3-dimethyl-2,3-diphenylbutane 59200 575.51 +1975-78-6 decanenitrile -84850 551.63 +2004-70-8 trans-1,3-pentadiene 75800 315.97 +2016-42-4 tetradecylamine -298200 757.8 +2016-57-1 decylamine -215800 600.52 +2027-17-0 2-isopropylnaphthalene 71470 464.38 +2027-19-2 2-propylnaphthalene 73470 461.02 +2039-89-6 2-ethenyl-1,4-dimethylbenzene 89290 422.16 +2039-90-9 2-ethenyl-1,3-dimethylbenzene 89290 422.16 +2040-95-1 butylcyclopentane -168300 454.01 +2040-96-2 propylcyclopentane -148070 418.48 +2044-21-5 dinonylamine -361380 897.81 +2044-22-6 trinonylamine -533080 1223.8 +2049-94-7 1-phenyl-3-methylbutane -41000 474 +2049-95-8 2-phenyl-2-methylbutane -42590 439.19 +2050-00-2 1,1-dimethylpropyl butanoate -581000 526.34 +2050-24-0 1-methyl-3,5-diethylbenzene -51200 476.68 +2050-77-3 1-iododecane -172860 601.14 +2050-92-2 dipentylamine -196260 586.19 +2051-05-0 dipentyl sulfite -676300 +2051-30-1 2,6-dimethyloctane -261120 528.72 +2051-31-2 4-decanol -407240 586.89 +2051-32-3 3-ethyl-3-octanol -410710 557.54 +2051-33-4 5-methyl-2-isopropyl-1-hexanol -417800 567.84 +2077-29-4 cis-1-methyl-4-(1-propenyl)benzene 92550 426.35 +2077-30-7 trans-1-methyl-4-(1-propenyl)benzene 92550 426.35 +2077-31-8 cis-1-methyl-3-(1-propenyl)benzene 92550 426.35 +2077-33-0 cis-1-methyl-2-(1-propenyl)benzene 92550 426.35 +2079-95-0 1-tetradecanethiol -294400 768.91 +2084-18-6 3-methyl-2-butanethiol -121000 394.72 +2084-19-7 2-pentanethiol -117200 406.13 +2094-75-9 2,2-dimethylbutanal -262100 367.48 +2109-98-0 2,3-dimethylbutanal -268200 372.92 +2121-69-9 meso-2,4-dimethyl-1,5-pentanediol -502830 511.4 +2131-18-2 pentadecylbenzene -241200 870.23 +2131-38-6 1,3,7-trimethylnaphthalene 57000 442.68 +2131-39-7 1,3,5-trimethylnaphthalene 57000 442.68 +2131-41-1 1,4,5-trimethylnaphthalene 57000 442.68 +2131-42-2 1,4,6-trimethylnaphthalene 57000 442.68 +2131-43-3 1,2,5,6-tetramethylnaphthalene 51300 509.67 +2141-58-4 cis-dicyano-1-butene 271000 379.95 +2141-59-5 trans-dicyano-1-butene 267000 373.25 +2146-38-5 1-ethylcyclopentene -19700 355.7 +2157-31-5 2,2-dimethyl-1,3-pentanediol -507800 477.02 +2162-91-6 diethylpentylamine -161560 522.66 +2177-47-1 2-methylindene 115000 361.98 +2189-60-8 octylbenzene -96100 596.83 +2190-48-9 3-chloro-3-methyl-1-butene -45590 340.71 +2198-72-3 4-propyl-4-heptanol -410710 557.54 +2203-80-7 5-methyl-1-hexyne 93700 395.28 +2207-01-4 cis-1,2-dimethylcyclohexane -172100 374.27 +2207-03-6 trans-1,3-dimethylcyclohexane -176500 375.61 +2207-04-7 trans-1,4-dimethylcyclohexane -184500 366.22 +2210-28-8 propyl methacrylate -402000 482.71 +2211-67-8 dl-2,3-dichlorobutane -167930 359.6 +2211-68-9 2-chloro-trans-2-butene -34200 334.49 +2211-69-0 2-chloro-cis-2-butene -34200 334.49 +2211-70-3 2-chloro-1-butene -25990 336.47 +2213-23-2 2,4-dimethylheptane -241000 485.07 +2213-32-3 2,4-dimethyl-1-pentene -80800 399.15 +2216-21-9 1-nitrononane -228900 742.49 +2216-25-3 1-nitroundecane -281130 664.77 +2216-30-0 2,5-dimethylheptane -240700 494.13 +2216-32-2 4-ethylheptane -231800 495.47 +2216-33-3 3-methyloctane -233700 504.86 +2216-34-4 4-methyloctane -235200 503.19 +2216-81-1 heptyl propanoate -565100 600.38 +2217-17-6 2,4,5,7-tetramethyloctane -307400 577.04 +2219-73-0 2-methyl-4-ethylphenol -181340 420.46 +2219-78-5 3,4-dimethyl-6-ethylphenol -213450 453.24 +2219-79-6 2,4-dimethyl-6-ethylphenol -213450 453.24 +2234-20-0 1-ethenyl-2,4-dimethylbenzene 89290 422.16 +2243-27-8 nonanenitrile -64210 512.68 +2244-07-7 undecanenitrile -105490 525.24 +2245-38-7 1,6,7-trimethylnaphthalene 57000 442.68 +2308-38-5 tert-butyl butanoate -562800 486.18 +2311-14-0 1,1,1-tribromoethane -4700 354.31 +2313-61-3 4-methyl-2-hexanol -350600 460.51 +2313-65-7 3-methyl-2-hexanol -350600 460.51 +2315-43-7 dimethyl-3-methylbutylamine -125560 435.23 +2345-27-9 2-tetradecanone -445600 733.57 +2345-28-0 2-pentadecanone -466300 772.72 +2346-81-8 3-chlorohexane -188190 413.61 +2358-38-5 1,1-difluorobutane -542100 361.75 +2366-36-1 1,1,1-trichloro-2-fluoroethane -302000 350.1 +2366-52-1 1-fluorobutane -304400 344.48 +2370-12-9 2,2-dimethyl-1-pentanol -348790 440.69 +2370-13-0 2,2-dimethyl-1-hexanol -369430 479.64 +2370-14-1 2,2-dimethyl-1-octanol -410710 557.54 +2384-70-5 2-decyne 22570 517.27 +2384-85-2 3-decyne 22570 517.27 +2398-09-6 1,cis-3-dimethylcyclobutane -36200 312.73 +2398-10-9 1,trans-3-dimethylcyclobutane -36200 312.73 +2398-68-7 eicosylbenzene -343440 1062.3 +2400-66-0 eicosanal -539500 971.51 +2402-06-4 1,trans-2-dimethylcyclopropane -3200 316.85 +2404-52-6 phosphorus (V) sulfide trifluoride -1009070 298.15 +2406-52-2 stannane 162800 227.01 +2411-36-1 triheptylamine -409240 990.08 +2415-72-7 propylcyclopropane -17400 384.51 +2416-94-6 2,3,6-trimethylphenol -192810 414.28 +2423-01-0 1-butylcyclopentene -61200 +2425-54-9 1-chlorotetradecane -354890 711.75 +2425-74-3 tert-butylformamide -284000 375.64 +2430-22-0 7-methyl-1-octanol -386600 547.94 +2430-73-1 1,4-nonanediol -538830 598.83 +2436-92-2 3,4-dimethylquinoline 167080 369.52 +2437-25-4 dodecanenitrile -126130 629.54 +2437-56-1 1-tridecene -186600 661.27 +2438-20-2 2-methylbutyl propanoate -529900 516.7 +2439-54-5 methyloctylamine -175620 547.24 +2439-55-6 methyloctadecylamine -382020 936.76 +2443-03-0 1-methyl-trans-3-propylcyclopentane -188950 413.79 +2443-04-1 1-methyl-cis-3-propylcyclopentane -188950 413.79 +2443-89-2 1,1-diiodo-2,2-dimethylpropane -6820 413.6 +2443-91-6 1,1-dibromo-2,2-dimethylpropane -99150 443.33 +2445-76-3 hexyl propanoate -544300 560.89 +2451-00-5 1-methyl-7-ethylnaphthalene 69000 456.09 +2456-27-1 dinonyl ether -539400 896.77 +2456-28-2 didecyl ether -580700 975.41 +2470-68-0 diheptylamine -278820 742 +2473-01-0 1-chlorononane -254890 506.25 +2473-03-2 1-chloroundecane -294890 588.45 +2532-58-3 cis-1,3-dimethylcyclopentane -135900 366.65 +2532-64-1 1,cis-2,trans-3,trans-4-tetramethylcyclopentane -229630 329.07 +2532-65-2 1,cis-2,cis-3,cis-4-tetramethylcyclopentane -229630 329.07 +2532-67-4 1,trans-2,cis-3,trans-4-tetramethylcyclopentane -229630 329.07 +2532-68-5 1,cis-2,trans-3,cis-4-tetramethylcyclopentane -229630 329.07 +2532-69-6 1,cis-2,cis-3,trans-4-tetramethylcyclopentane -229630 329.07 +2550-21-2 3-methyl-2-hexanone -305670 445.84 +2551-62-4 sulfur hexafluoride -1220470 291.54 +2568-33-4 3-methyl-1,3-butanediol -480000 178.22 +2570-26-5 pentadecylamine -318800 796.95 +2586-89-2 3-heptyne 82800 411.72 +2612-27-3 2-isopropyl-1,3-propanediol -472000 506.62 +2612-28-4 2-propyl-1,3-propanediol -472100 498.11 +2612-29-5 2-ethyl-1,3-propanediol -456000 619.61 +2613-61-8 2,4,6-trimethylheptane -253220 509.87 +2613-65-2 1-methyl-trans-3-ethylcyclopentane -168310 374.84 +2613-66-3 1-methyl-cis-3-ethylcyclopentane -168310 374.84 +2613-69-6 1,cis-2,cis-3-trimethylcyclopentane -188650 332.48 +2613-72-1 1,cis-2,cis-4-trimethylcyclopentane -188650 332.48 +2625-29-8 1-nitro-2,2-dimethylbutane -186680 431.14 +2625-35-6 2-nitro-3-methylbutane -167850 412.01 +2639-63-6 hexyl butanoate -566600 601.05 +2639-64-7 nonyl butanoate -628900 718.84 +2679-87-0 ethyl sec-butyl ether -304600 420.89 +2690-08-6 dioctyl sulfide -332170 840.54 +2696-92-6 nitrosyl chloride 51710 261.68 +2699-79-8 sulfuryl fluoride -758560 283.63 +2717-39-7 1,4,5,8-tetramethylnaphthalene 51300 509.67 +2717-42-2 1,2,4-trimethylnaphthalene 57000 442.68 +2719-52-0 2-phenylpentane -37600 467.63 +2721-38-2 1,1-diethylcyclopentane -153370 525.68 +2738-19-4 2-methyl-2-hexene -85800 399.75 +2765-11-9 pentadecanal -435600 775.41 +2765-18-6 1-propylnaphthalene 74680 459.61 +2768-16-3 5-methyl-1-nonanol -407240 586.89 +2769-64-4 butyl isocyanide 40000 429.49 +2787-43-1 3-methyl-1,trans-3-pentadiene 65690 374.37 +2787-45-3 3-methyl-1,cis-3-pentadiene 65690 374.37 +2801-84-5 2,4-dimethyldecane -301500 607.9 +2807-30-9 ethylene glycol monopropyl ether -421000 437.69 +2809-67-8 2-octyne 63850 439.37 +2837-89-0 2-chloro-1,1,1,2-tetrafluoroethane -924700 349.43 +2847-72-5 4-methyldecane -274600 582.5 +2851-83-4 ethyl dodecyl sulfide -290080 766.83 +2855-08-5 1-chloro-3,3-dimethylbutane -191660 384.27 +2869-34-3 tridecylamine -277600 718.31 +2870-04-4 2-ethyl-m-xylene -26230 421.67 +2876-35-9 2-tert-butylnaphthalene 51300 509.67 +2876-44-0 2-octylnaphthalene -36530 635.22 +2876-45-1 2-heptylnaphthalene -14530 599.42 +2876-46-2 2-hexylnaphthalene 14400 579.59 +2876-51-9 1-octylnaphthalene -36000 631.8 +2876-52-0 1-heptylnaphthalene -14000 596 +2876-53-1 1-hexylnaphthalene 14400 579.59 +2882-96-4 3-methylpentadecane -378850 769.71 +2882-97-5 2,3-dimethylpentadecane -404770 799.14 +2882-98-6 nonylcyclopentane -271600 649.11 +2883-02-5 nonylcyclohexane -317100 657.17 +2884-06-2 2,3-dimethylnonane -277300 570.09 +2885-00-9 1-octadecanethiol -377000 925.52 +2917-26-2 1-hexadecanethiol -335700 847.21 +2922-51-2 2-heptadecanone -507600 851.7 +2935-44-6 2,5-hexanediol -500000 412.71 +2938-98-9 2-methyl-1,4-butanediol -456000 452.11 +2980-69-0 4-methylundecane -295300 621.65 +2980-71-4 2-methyl-1-nonene -134090 536.76 +2987-16-8 3,3-dimethylbutanal -254700 392.3 +3001-66-9 2-octanethiol -179100 523.92 +3002-57-1 dimethylheptadecylamine -367960 912.18 +3007-31-6 didodecylamine -485220 1131.5 +3017-68-3 2-bromo-cis-2-butene 7870 352.12 +3017-69-4 1-bromo-2-methyl-1-propene 7870 352.12 +3017-70-7 2-bromo-3-methyl-2-butene -22560 386.91 +3017-71-8 2-bromo-trans-2-butene 7870 352.12 +3031-05-8 1,2,6-trimethylnaphthalene 57000 442.68 +3031-08-1 1,3,6-trimethylnaphthalene 57000 442.68 +3031-15-0 1,2,3,4-tetramethylnaphthalene 51300 509.67 +3031-16-1 1,2,5,8-tetramethylnaphthalene 51300 509.67 +3042-50-0 1,4-dimethyl-2-propylbenzene -52700 476.68 +3043-33-2 2-methyl-2,3-pentadiene 103040 364.01 +3054-92-0 2,3,4-trimethyl-3-pentanol -379990 460.59 +3071-00-9 dieicosylamine -815460 1754.8 +3073-66-3 1,1,3-trimethylcyclohexane -179870 503.25 +3074-61-1 1-propylcyclopentene -40400 +3074-71-3 2,3-dimethylheptane -235900 492.79 +3074-75-7 4-ethyl-2-methylhexane -236200 488.43 +3074-76-8 3-ethyl-3-methylhexane -231300 485.07 +3074-77-9 3-ethyl-4-methylhexane -238700 461.93 +3121-79-7 4,4-dimethyl-1-pentanol -348790 440.69 +3121-82-2 2,2-dimethyl-1,5-pentanediol -502000 488.29 +3155-43-9 1,18-octadecanediol -719310 958.93 +3162-62-7 1,1-dichlorodecane -295100 622.67 +3173-53-3 cyclohexyl isocyanate -140000 377.73 +3174-67-2 1,3-pentanediol -462000 423.8 +3175-23-3 1,2,2-trichloropropane -161220 334.25 +3178-29-8 4-propylheptane -251080 526.88 +3180-09-4 2-butylphenol -190510 465.58 +3195-86-6 2-ethylthiacyclopropane 20900 +3208-16-0 2-ethylfuran -97900 304.31 +3221-61-2 2-methyloctane -235900 499.16 +3228-01-1 3-methyl-2-isopropylphenol -207260 449.88 +3228-02-2 3-methyl-4-isopropylphenol -207260 449.88 +3228-03-3 3-methyl-5-isopropylphenol -207260 449.88 +3234-49-9 1,2-dibromopentane -99150 443.33 +3238-38-8 2,3,4,6-tetramethylphenol -224920 447.07 +3302-16-7 3,3-dimethylbutanenitrile -26400 365.34 +3377-86-4 2-bromohexane -146120 431.24 +3377-87-5 3-bromohexane -146120 431.24 +3386-33-2 1-chlorooctadecane -434890 876.14 +3404-58-8 3-ethyl-1-hexene -88600 452.49 +3404-61-3 3-methyl-1-hexene -69500 408.37 +3404-63-5 2-ethyl-1,3-butadiene 73900 376.35 +3404-67-9 3-methyl-2-ethyl-1-pentene -98800 446.95 +3404-71-5 2-ethyl-1-pentene -76600 414.21 +3404-72-6 2,3-dimethyl-1-pentene -82300 394.11 +3404-73-7 3,3-dimethyl-1-pentene -73200 378.25 +3404-77-1 3,3-dimethyl-1-hexene -94000 416.67 +3404-78-2 2,5-dimethyl-2-hexene -115300 417.17 +3404-80-6 4-methyl-2-ethyl-1-pentene -103400 431.52 +3405-42-3 methyldipropylamine -120280 444.75 +3452-07-1 1-eicosene -331300 936.01 +3452-09-3 1-nonyne 61700 487 +3452-97-9 3,5,5-trimethyl-1-hexanol -395350 509.07 +3454-07-7 p-ethylstyrene 100760 428.33 +3457-57-6 1-nitro-2-methylbutane -162570 421.53 +3495-46-3 3-amino-3-methylpentane -152100 369.01 +3508-00-7 1-bromoheptadecane -367880 869.24 +3518-51-2 butyl methyl sulfate -762700 +3522-86-9 3-sec-butylphenol -195790 456.05 +3522-94-9 2,2,5-trimethylhexane -253300 461.93 +3524-73-0 5-methyl-1-hexene -69800 407.36 +3525-25-5 3-ethyl-1-heptanol -386600 547.94 +3539-29-5 methyl octyl sulfate -845900 +3581-69-9 2,2-dimethylpropyl propanoate -540400 492.22 +3586-58-1 2-methylenebutanoic acid -450600 159.12 +3638-35-5 isopropylcyclopropane -19200 378.47 +3675-68-1 1,1,2-tribromobutane -57460 445.9 +3675-69-2 1,2,2-tribromobutane -55650 426.08 +3683-19-0 4-methyl-cis-2-hexene -75700 413.13 +3683-22-5 4-methyl-trans-2-hexene -80500 397.03 +3698-93-9 propyl octyl sulfide -228280 650.84 +3698-94-0 ethyl octyl sulfide -207650 610.42 +3698-95-1 methyl octyl sulfide -183600 569.12 +3710-31-4 1,2-heptanediol -503500 500.97 +3710-43-8 2,4-dimethylfuran -97900 336.61 +3717-68-8 4-methyl-1,1-diphenylethane 103600 512.49 +3724-61-6 dodecyl butanoate -691000 836.97 +3730-60-7 2,5-dimethyl-2-hexanol -374710 470.11 +3741-00-2 pentylcyclopentane -189000 492.83 +3742-38-9 4-ethylcyclopentene -900 418.76 +3756-30-7 3-iodo-2-methyl-1-propene 66620 358.67 +3769-23-1 4-methyl-1-hexene -68300 412.39 +3772-13-2 2,2-dimethylthiacyclopropane 11590 +3788-32-7 isobutylcyclopentane -173890 446.63 +3814-34-4 1-bromo-2-ethylbutane -154870 392.36 +3850-30-4 2-amino-3,3-dimethyl butane -153100 373.84 +3855-26-3 4-methyl-2-ethylphenol -181340 420.46 +3875-51-2 isopropylcyclopentane -203780 240.18 +3875-52-3 tert-butylcyclopentane -177360 417.28 +3876-97-9 1,2,8-trimethylnaphthalene 57000 442.68 +3877-15-4 methyl propyl sulfide -81900 371.97 +3899-36-3 3-methyl-trans-3-hexene -83000 409.14 +3922-24-5 1,1,1-trichlorotridecane -369200 756.81 +3922-25-6 1,1,1-trichloroundecane -327900 677.5 +3922-26-7 1,1,1-trichloroheptane -245400 518.87 +3922-27-8 1,1,1-trichloropentane -204200 439.22 +3931-89-3 phosphorus thiobromide -263590 372.84 +3937-56-2 1,9-nonanediol -533550 608.35 +3950-21-8 meso-2,4-pentanediol -479000 374.97 +3965-59-1 2,4-dimethyl-1-hexanol -371240 499.46 +3968-85-2 1-phenyl-2-methylbutane -41000 474 +3970-59-0 2,4-dimethyl-3-ethyl-3-pentanol -400630 499.54 +3970-60-3 2,2,5-trimethyl-3-hexanol -400630 499.54 +3970-62-5 2,2-dimethyl-3-pentanol -354070 431.16 +3982-64-7 1,3-dimethyl-5-propylbenzene -57300 466.29 +3982-66-9 1,2-dimethyl-4-propylbenzene -54900 476.68 +3982-67-0 1,3,5-trimethyl-2-ethylbenzene -58300 458.57 +3982-91-0 phosphorus thiochloride -380740 337.36 +4028-56-2 meso-2,3-dichlorobutane -167930 359.6 +4032-92-2 2,4,4-trimethylheptane -261460 509.17 +4032-93-3 2,3,6-trimethylheptane -263420 515.67 +4032-94-4 2,4-dimethyloctane -256270 528.69 +4038-04-4 3-ethyl-1-pentene -67800 403.37 +4050-45-7 trans-2-hexene -53300 383.84 +4074-43-5 3-butylphenol -190510 465.58 +4074-46-8 4-methyl-2-propylphenol -201980 459.41 +4088-36-2 ethyloctylamine -196260 586.19 +4088-37-3 diethyloctylamine -223480 639.51 +4089-71-8 3-methyl-1,6-hexanediol -494900 529.81 +4095-22-1 2-isopropylthiophene 42360 389.86 +4109-96-0 silane, dichloro -320490 286.73 +4110-44-5 3,3-dimethyloctane -262210 522.25 +4110-50-3 ethyl propyl sulfide -104400 413.17 +4113-08-0 hexadecyl formate -676200 880.49 +4127-45-1 1,1,2-trimethylcyclopropane -63700 229.22 +4132-72-3 1,4-dimethyl-2-isopropylbenzene -55600 462.6 +4132-77-8 1,2-dimethyl-4-isopropylbenzene -59300 464.61 +4166-46-5 2,3-dimethyl-3-hexanol -374710 470.11 +4167-74-2 4-isobutylphenol -195790 456.05 +4167-75-3 2-isobutylphenol -195790 456.05 +4168-40-5 1,1-dichlorotetradecane -377600 781.63 +4181-95-7 tetracontane -868930 1714.1 +4200-95-7 heptadecylamine -360000 875.6 +4209-22-7 1-bromotriacontane -636200 1375.6 +4209-90-9 2,2-dimethyl-3-hexanol -374710 470.11 +4209-91-0 3,5-dimethyl-3-hexanol -374710 470.11 +4218-48-8 1-ethyl-4-isopropylbenzene -47500 460.58 +4259-00-1 1,1,2-trimethylcyclopentane -153070 444.37 +4265-25-2 2-methylbenzofuran -8250 303.82 +4271-27-6 diethyldodecylamine -306040 795.32 +4276-49-7 1-bromoeicosane -429800 986.1 +4276-50-0 1-bromoheneicosane -450440 1025 +4276-51-1 1-bromohexacosane -553640 1219.8 +4279-22-5 2,2-dichlorobutane -166120 339.78 +4282-40-0 1-iodoheptane -110940 484.29 +4282-42-2 1-iodononane -152220 562.19 +4282-44-4 1-iodoundecane -193500 640.1 +4283-80-1 2-bromo-2-methylpentane -149590 401.89 +4283-83-4 3-bromo-2-methylpentane -151400 421.71 +4291-98-9 1-pentylcyclopentene -82000 +4291-99-0 1-hexylcyclopentene -102800 +4292-00-6 1-heptylcyclopentene -123600 +4292-19-7 1-iodododecane -214140 679.05 +4292-75-5 hexylcyclohexane -255100 538.8 +4292-92-6 pentylcyclohexane -234400 499.35 +4325-48-8 2-chloro-2-methylpentane -191660 384.27 +4340-76-5 2-eicosanol -613640 1012.5 +4358-75-2 2-amino-2,3-dimethylbutane -156300 363.1 +4371-48-6 2-methyl-3-isopropylphenol -207260 449.88 +4375-96-6 2-iodo-1-propene 87260 319.72 +4385-04-0 dimethylhexylamine -140920 483.7 +4427-56-9 4-methyl-2-isopropylphenol -207260 449.88 +4432-77-3 ethyl-tert-butylamine -134700 350.42 +4434-66-6 1-bromononadecane -409160 947.14 +4443-55-4 eicosylcyclohexane -525650 1138.3 +4444-68-2 diethylbutylamine -140920 483.7 +4445-06-1 octadecylcyclohexane -484370 1060.4 +4445-07-2 octadecylbenzene -302160 984.44 +4457-00-5 hexylcyclopentane -209700 531.98 +4457-71-0 3-methyl-1,5-pentanediol -474100 491.4 +4458-31-5 diethylpropylamine -120280 444.75 +4458-32-6 methylethylpropylamine -97300 413.65 +4481-30-5 2-phenyl-3-methylbutane -44400 459.01 +4485-77-2 dinonyl disulfide -367000 963.28 +4516-69-2 1,1,3-trimethylcyclopentane -153070 444.37 +4553-62-2 methylglutaronitrile 142000 389.89 +4588-18-5 2-methyl-1-octene -113450 497.81 +4609-87-4 1-nitrodecane -260490 625.82 +4609-89-6 2-nitropentane -162570 421.53 +4614-03-3 2-sec-butylnaphthalene 51300 509.67 +4616-73-3 eicosanenitrile -291250 941.16 +4628-21-1 1-chloro-cis-2-butene -24410 338.65 +4669-01-6 pentadecylcyclopentane -395600 883.36 +4706-81-4 2-tetradecanol -489800 780.4 +4706-89-2 1,3-dimethyl-4-isopropylbenzene -55600 462.6 +4706-90-5 1,3-dimethyl-5-isopropylbenzene -61700 460.25 +4730-22-7 6-methyl-2-heptanol -371240 499.46 +4737-41-1 1-chloro-2-ethylbutane -188190 413.61 +4740-00-5 3-methylthiacyclopentane -60170 +4747-21-1 methylisopropylamine -78800 339.27 +4753-80-4 thiacycloheptane -65520 362.53 +4773-83-5 1,2,3-trimethylindene 51700 415.81 +4806-58-0 1,cis-2,cis-3-trimethylcyclopropane -135050 -10.09 +4806-59-1 1,cis-2,trans-3-trimethylcyclopropane -135050 -10.09 +4806-61-5 ethylcyclobutane -27500 341.91 +4810-09-7 3-methyl-1-heptene -90300 446.79 +4850-28-6 1,cis-2,trans-4-trimethylcyclopentane -188650 332.48 +4850-32-2 sec-butylcyclopentane -173890 446.63 +4860-03-1 1-chlorohexadecane -394890 793.95 +4862-03-7 1-chloropentadecane -374890 752.85 +4894-61-5 1-chloro-trans-2-butene -24410 338.65 +4905-79-7 1,1,1-trichlorooctane -266100 558.03 +4911-70-0 2,3-dimethyl-2-pentanol -354070 431.16 +4914-89-0 3-methyl-cis-3-hexene -81500 414.17 +4914-91-4 3,4-dimethyl-cis-2-pentene -85600 408.6 +4914-92-5 3,4-dimethyl-trans-2-pentene -85600 408.6 +4920-99-4 1-ethyl-3-isopropylbenzene -47700 467.29 +4923-77-7 1-methyl-cis-2-ethylcyclohexane -196000 430.73 +4923-78-8 1-methyl-trans-2-ethylcyclohexane -200000 417.32 +4926-76-5 1-methyl-trans-3-ethylcyclohexane -208000 390.48 +4926-78-7 1-methyl-cis-4-ethylcyclohexane -199000 420.67 +4926-90-3 1-methyl-1-ethylcyclohexane -200000 409.87 +4957-14-6 4',4"-dimethyldiphenylmethane 101000 527.88 +5008-69-5 4-methyl-2-thiapentane -109940 402.64 +5008-72-0 4-methyl-3-thiahexane -133200 432.81 +5008-73-1 2-methyl-3-thiahexane -134900 427.1 +5026-76-6 6-methyl-1-heptene -90300 446.79 +5145-99-3 2-methyl-3-thiapentane -109940 402.64 +5160-99-6 1-methyl-3-isobutylbenzene -53300 474 +5161-04-6 1-methyl-4-isobutylbenzene -53100 477.69 +5161-11-5 3,cis-4-dimethylthiacyclopentane -82100 +5161-12-6 3,trans-4-dimethylthiacyclopentane -89300 +5161-13-7 2,cis-5-dimethylthiacyclopentane -83100 +5161-14-8 2,trans-5-dimethylthiacyclopentane -90400 +5161-75-1 2,2-dimethylthiacyclopentane -94800 +5161-76-2 3,3-dimethylthiacyclopentane -91800 +5161-77-3 2,cis-3-dimethylthiacyclopentane -83100 +5161-78-4 2,trans-3-dimethylthiacyclopentane -90300 +5161-79-5 2,cis-4-dimethylthiacyclopentane -82700 +5161-80-8 2,trans-4-dimethylthiacyclopentane -89900 +5162-44-7 4-bromo-1-butene 25870 358.26 +5162-48-1 2,2,4-trimethyl-3-pentanol -379990 460.59 +5166-35-8 3-chloro-2-methyl-1-butene -51910 365.9 +5171-84-6 3,3,4,4-tetramethylhexane -252590 489.82 +5194-50-3 cis-2,trans-4-hexadiene 47400 357.13 +5194-51-4 trans-2,trans-4-hexadiene 43300 356.8 +5205-34-5 5-decanol -407240 586.89 +5277-11-2 dimethylheptylamine -161560 522.66 +5329-79-3 2-aminohexane -143800 414.55 +5340-36-3 3-methyl-3-octanol -390070 518.59 +5340-41-0 2,2,3-trimethyl-3-hexanol -398820 479.72 +5340-62-5 5,5-dimethyl-3-ethyl-3-hexanol -419460 518.67 +5341-95-7 meso-2,3-butanediol -477000 418.66 +5343-96-4 1,2-dimethylpropyl acetate -525600 460.11 +5344-20-7 1-amino-4-methylpentane -139700 428.31 +5379-20-4 1-ethenyl-3,5-dimethylbenzene 89290 422.16 +5396-09-8 2,3,5,5-tetramethyl-3-hexanol -424740 509.14 +5396-58-7 2-methyl-2,3-butanediol -498000 293.53 +5398-25-4 2,3-dibromopentane -104430 433.81 +5399-02-0 heptadecanenitrile -229330 824.3 +5434-27-5 1,3-dibromo-2,2-dimethylpropane -107900 404.46 +5451-52-5 decyl formate -552000 644.56 +5451-63-8 tetradecyl formate -634800 801.85 +5451-75-2 octadecyl formate -717600 959.13 +5451-92-3 nonyl formate -531300 605.07 +5454-09-1 decyl butanoate -649600 758.33 +5454-19-3 decyl propanoate -627300 718.51 +5454-24-0 undecyl formate -572700 684.05 +5454-79-5 cis-3-methylcyclohexanol -350900 391.84 +5458-33-3 undecyl propanoate -648000 757.66 +5461-02-9 undecyl butanoate -670300 797.49 +5582-82-1 3-methyl-3-heptanol -369430 479.64 +5617-41-4 heptylcyclohexane -275700 577.25 +5617-42-5 heptylcyclopentane -230300 571.13 +5634-22-0 docosylbenzene -384720 1140.2 +5634-30-0 dodecylcyclopentane -333600 766.23 +5675-51-4 1,12-dodecanediol -595470 725.21 +5683-44-3 3-methyl-2,4-pentanediol -497700 428.61 +5714-22-7 sulfur decafluoride -2064390 396.95 +5750-00-5 2-chloro-3,3-dimethylbutane -196940 374.74 +5780-13-2 meso-2,3-dibromobutane -83790 394.85 +5813-64-9 2,2-dimethylpropylamine -112700 392.98 +5814-85-7 1,2-diphenylpropane 117000 525.13 +5857-69-2 2,2,3,4,4-pentamethyl-3-pentanol -428210 479.8 +5867-91-4 methyl propyl sulfate -742000 464.68 +5867-93-6 methyl pentyl sulfate -783500 +5867-94-7 ethyl propyl sulfate -775600 +5867-95-8 butyl ethyl sulfate -796400 +5867-98-1 dipentyl sulfate -879500 +5870-93-9 heptyl butanoate -587400 640.2 +5877-76-9 ethylhexadecylamine -361380 897.81 +5881-17-4 3-ethyloctane -251080 536 +5910-75-8 ditridecylamine -526500 1209.4 +5910-77-0 tritridecylamine -780760 1691.2 +5911-04-6 3-methylnonane -254700 543.01 +5911-05-7 4-ethylnonane -272500 581.16 +5932-79-6 4-nonanol -386600 547.94 +5954-71-2 2,cis-3-dimethylthiacyclopropane 11590 +5955-98-6 2,trans-3-dimethylthiacyclopropane 3890 +5969-12-0 2,6-heptanediol -484700 572.21 +5970-63-8 2-methyl-2-ethyl-1-pentanol -369430 479.64 +5989-27-5 d-limonene -6400 +6006-15-1 diethylisopropylamine -125560 435.23 +6006-33-3 tridecylcyclohexane -399800 815.02 +6006-34-4 tridecylcyclopentane -354300 805.05 +6006-95-7 pentadecylcyclohexane -441100 894 +6032-29-7 2-pentanol -313800 397.13 +6079-57-8 4,4-dimethyl-2-thiapentane -143100 381.89 +6094-02-6 2-methyl-1-hexene -77900 400.69 +6108-61-8 cis-2,cis-4-hexadiene 47400 357.13 +6117-80-2 cis-2-butene-1,4-diol -295000 387.56 +6117-98-2 2,3-dimethyldodecane -342850 682.28 +6117-99-3 2,4-dimethyldodecane -342850 682.28 +6137-03-7 3-ethyl-2-pentanone -305670 445.84 +6144-93-0 4,4-dimethyl-2-pentanol -354070 431.16 +6158-45-8 1-isopropylnaphthalene 72470 467.73 +6161-67-7 4-methyl-3-ethylphenol -181340 420.46 +6163-64-0 3,3-dimethyl-2-thiabutane -113410 373.29 +6163-66-2 di-tert-butyl ether -364840 428.62 +6165-37-3 4-propylnonane -293000 612.93 +6175-49-1 2-dodecanone -404300 654.59 +6196-60-7 3-methyl-3-ethyl-1-pentene -89700 431.09 +6196-80-1 1-iodo-4-methylpentane -95580 435.81 +6221-93-8 dodecyl propanoate -668700 797.15 +6221-95-0 tetradecyl propanoate -710100 875.79 +6221-96-1 hexadecyl propanoate -751500 954.77 +6221-98-3 tetradecyl butanoate -732400 915.62 +6221-99-4 hexadecyl butanoate -773800 994.26 +6236-88-0 1-methyl-trans-4-ethylcyclohexane -206000 397.19 +6261-19-4 1-chloro-cis-2-pentene -45050 377.6 +6261-25-2 1-chloro-trans-2-pentene -45050 377.6 +6294-31-1 dihexyl sulfide -249740 684.13 +6305-71-1 2,4-dimethyl-1-pentanol -350600 460.51 +6308-94-7 diethyldecylamine -264760 717.42 +6339-13-5 2-methylpentanenitrile -16100 397.87 +6366-35-4 1-chloro-2,2-dimethylbutane -191660 384.27 +6414-96-6 5,5-dimethylnonane -282000 551.98 +6418-41-3 3-methyltridecane -337570 691.81 +6418-43-5 3-methylhexadecane -399490 808.67 +6418-44-6 3-methylheptadecane -420130 847.62 +6418-45-7 3-methylnonadecane -461410 925.52 +6422-18-0 1-chlorotetracosane -554890 1122.7 +6443-92-1 cis-2-heptene -69500 422.66 +6464-40-0 dl-threo-4-methyl-2,3-pentanediol -487470 462.92 +6481-95-4 4,4-dimethyl-1-hexanol -369430 479.64 +6561-44-0 3-methyloctadecane -440770 886.57 +6569-51-3 borazine -510030 288.92 +6570-87-2 3,4-dimethyl-1-pentanol -350600 460.51 +6570-88-3 2,3,4-trimethyl-1-pentanol -376520 489.94 +6702-10-9 dl-erythro-4-methyl-2,3-pentanediol -497700 428.61 +6703-82-8 heneicosylcyclopentane -519490 1118.3 +6742-54-7 undecylbenzene -158300 713.95 +6765-39-5 1-heptadecene -269300 818.22 +6785-23-5 undecylcyclopentane -313000 727.08 +6790-27-8 3-dodecyne -18710 595.17 +6795-87-5 methyl sec-butyl ether -270500 381.73 +6795-88-6 methyl 1-methylbutyl ether -292500 421.22 +6812-38-0 hexadecylcyclohexane -461800 933.49 +6812-39-1 hexadecylcyclopentane -416300 922.17 +6863-58-7 di-sec-butyl ether -360660 463.98 +6876-18-2 2-methyl-3-isopropylheptane -269100 549.97 +6876-23-9 trans-1,2-dimethylcyclohexane -179900 371.25 +6886-16-4 2,5-dimethyl-1-hexanol -371240 499.46 +6915-15-7 malic acid -990000 451.61 +6920-22-5 1,2-hexanediol -482700 462.55 +6920-24-7 1,2-hexadecanediol -683310 871.5 +6931-70-0 2,3-dimethyl-2,3-pentanediol -528800 388.88 +6938-66-5 1-bromodocosane -471080 1064 +6946-24-3 1-bromotetracosane -512360 1141.9 +6975-92-4 2,5-dimethyl-1-hexene -105700 423.81 +6975-98-0 2-methyldecane -275650 582.43 +6982-25-8 dl-2,3-butanediol -477000 418.66 +7094-26-0 1,1,2-trimethylcyclohexane -179870 503.25 +7094-27-1 1,1,4-trimethylcyclohexane -179870 503.25 +7116-86-1 5,5-dimethyl-1-hexene -100800 393.86 +7145-20-2 2,3-dimethyl-2-hexene -108500 460.47 +7146-60-3 2,3-dimethyloctane -256600 532.61 +7154-75-8 4-methyl-1-pentyne 113500 357.13 +7154-79-2 2,2,3,3-tetramethylpentane -237100 437.11 +7154-80-5 3,3,5-trimethylheptane -258570 515.07 +7188-38-7 tert-butyl isocyanide 40000 419.96 +7194-84-5 heptatriacontane -807010 1597.2 +7194-85-6 octatriacontane -827650 1636.2 +7194-86-7 nonatriacontane -848290 1675.1 +7212-53-5 5-methyl-1-heptanol -365960 508.99 +7220-26-0 3-ethyl-2,4-dimethylhexane -252840 518.59 +7225-71-0 1-undecylnaphthalene -102000 739.2 +7239-24-9 dimethylisobutylamine -98300 418.48 +7286-40-0 3-nitrohexane -183210 460.48 +7289-44-3 methyl undecyl sulfide -245500 686.91 +7289-45-4 methyl tetradecyl sulfide -307400 804.37 +7294-05-5 2,2,3-trimethyl-3-pentanol -378180 440.77 +7307-55-3 undecylamine -236400 639.67 +7307-58-6 diethyltetradecylamine -347320 873.23 +7309-44-6 ethyl hexyl sulfide -166400 532.21 +7311-30-0 methyldodecylamine -258180 703.05 +7317-85-3 ethyloctadecylamine -402660 975.72 +7318-67-4 1,cis-4-hexadiene 75480 378.53 +7319-00-8 1,trans-4-hexadiene 75480 378.53 +7348-71-2 1-bromo-trans-2-pentene -2980 395.23 +7348-78-9 1-bromo-cis-2-pentene -2980 395.23 +7357-93-9 3-methyl-2-ethyl-1-butene -81100 398.14 +7372-86-3 2-methyl-6-ethylnaphthalene 61300 456.43 +7373-13-9 2-octadecanone -528300 890.85 +7378-99-6 dimethyloctylamine -182200 561.61 +7379-12-6 2-methyl-3-hexanone -305670 445.84 +7385-78-6 3,4-dimethyl-1-pentene -74800 398.78 +7385-82-2 5-methyl-trans-2-hexene -82300 391 +7399-49-7 1-methyl-2-(1-methylethenyl)benzene 81340 379.23 +7415-31-8 1,3-dichloro-trans-2-butene -79000 353.46 +7417-48-3 3-methyl-1,2-pentadiene 111250 365.99 +7423-69-0 3,5-dimethyl-1-hexene -96900 432.83 +7429-90-5 aluminum 329700 164.58 +7429-91-6 dysprosium 290400 195.74 +7439-88-5 iridium 665300 194.48 +7439-89-6 iron 415470 180.47 +7439-90-9 krypton 0 164.09 +7439-91-0 lanthanum 431000 182.44 +7439-92-1 lead 195200 175.39 +7439-93-2 lithium 159300 138.82 +7439-94-3 lutetium 427600 184.49 +7439-95-4 magnesium 147100 148.65 +7439-96-5 manganese 283260 173.71 +7439-97-6 mercury 61380 174.84 +7439-98-7 molybdenum 658100 181.64 +7440-00-8 neodymium 327600 190.06 +7440-01-9 neon 0 146.33 +7440-02-0 nickel 430120 182.22 +7440-03-1 niobium 733040 186.2 +7440-04-2 osmium 791000 187.28 +7440-05-3 palladium 378200 166.73 +7440-06-4 platinum 565300 191.86 +7440-09-7 potassium 89000 160.35 +7440-10-0 praseodymium 355600 189.38 +7440-13-3 protactinium 607000 199.48 +7440-14-4 radium 159000 168.27 +7440-15-5 rhenium 769900 188.84 +7440-16-6 rhodium 556900 186.12 +7440-17-7 rubidium 80900 170.02 +7440-18-8 ruthenium 642700 185.8 +7440-19-9 samarium 206700 183.3 +7440-20-2 scandium 377800 174.8 +7440-21-3 silicon 450000 167.97 +7440-22-4 silver 284900 173.02 +7440-23-5 sodium 107300 153.51 +7440-24-6 strontium 164000 160.95 +7440-25-7 tantalum 781990 185.25 +7440-26-8 technetium 678000 +7440-27-9 terbium 388700 204.01 +7440-28-0 thallium 182200 180.92 +7440-29-1 thorium 602000 190.32 +7440-30-4 thulium 232200 190.38 +7440-31-5 tin (white) 301200 168.57 +7440-32-6 titanium 473630 180.26 +7440-33-7 tungsten 851030 173.9 +7440-34-8 actinium 406000 190.66 +7440-36-0 antimony 262300 180.53 +7440-37-1 argon 0 154.85 +7440-38-2 arsenic 302500 174.19 +7440-39-3 barium 179080 170.77 +7440-41-7 beryllium 324000 136.34 +7440-42-8 boron 560000 153.5 +7440-43-9 cadmium 111800 +7440-45-1 cerium 423000 199.45 +7440-46-2 cesium 76500 175.68 +7440-47-3 chromium 397480 174.49 +7440-48-4 cobalt 426680 179.45 +7440-50-8 copper 337600 166.38 +7440-52-0 erbium 317100 195.29 +7440-53-1 europium 175300 188.82 +7440-54-2 gadolinium 397500 194.55 +7440-55-3 gallium 272000 169.36 +7440-56-4 germanium 372000 167.93 +7440-57-5 gold 366100 180.89 +7440-58-6 hafnium 618400 186.94 +7440-59-7 helium-4 0 126.15 +7440-60-0 holmium 300800 195.74 +7440-61-1 uranium 533000 199.79 +7440-62-2 vanadium 515470 182.26 +7440-63-3 xenon 0 169.69 +7440-64-4 ytterbium 152300 173.6 +7440-65-5 yttrium 421300 179.23 +7440-66-6 zinc 130420 160.9 +7440-67-7 zirconium 610030 181.47 +7440-69-9 bismuth 207100 187.17 +7440-70-2 calcium 177800 154.89 +7440-74-6 indium 243300 173.85 +7443-52-9 trans-2-methylcyclohexanol -352600 391.84 +7443-55-2 trans-3-methylcyclohexanol -329100 391.84 +7443-70-1 cis-2-methylcyclohexanol -327000 391.84 +7446-09-5 sulfur dioxide -296840 248.22 +7446-11-9 sulfur trioxide -395770 256.77 +7446-70-0 aluminum chloride -584590 314.52 +7447-40-7 potassium chloride -214680 239.1 +7447-41-8 lithium chloride -195720 212.92 +7461-19-0 1-bromohexatriacontane -760040 1609.3 +7487-94-7 mercuric chloride -146290 294.66 +7515-62-0 5-bromo-trans-2-pentene -2980 395.23 +7516-82-7 methyldecylamine -216900 625.15 +7525-62-4 m-ethylstyrene 100760 428.33 +7550-35-8 lithium bromide -153970 224.38 +7550-45-0 titanium tetrachloride -763160 354.85 +7553-56-2 iodine 62420 260.68 +7564-63-8 o-ethylstyrene 100760 428.33 +7580-67-8 lithium hydride 140620 170.94 +7596-92-1 1-bromodotriacontane -677480 1453.5 +7611-86-1 cis-1-chloro-1-butene -24410 338.65 +7611-87-2 trans-1-chloro-1-butene -24410 338.65 +7611-88-3 cis-1-chloro-2-methyl-1-butene -54840 373.45 +7611-89-4 trans-1-chloro-2-methyl-1-butene -54840 373.45 +7616-94-6 perchloryl fluoride -21420 278.99 +7632-51-1 vanadium tetrachloride -525500 363.08 +7637-07-2 boron trifluoride -1135620 254.42 +7642-04-8 cis-2-octene -89500 466.84 +7642-09-3 cis-3-hexene -47300 376.8 +7642-10-6 cis-3-heptene -69200 421.65 +7642-15-1 cis-4-octene -89500 466.84 +7646-69-7 sodium hydride 124270 188.23 +7646-78-8 stannic chloride -471500 365.53 +7646-79-9 cobalt chloride -93720 298.43 +7646-85-7 zinc chloride -266100 +7647-01-0 hydrogen chloride -92300 188.98 +7647-14-5 sodium chloride -181420 229.64 +7647-15-6 sodium bromide -143930 241.06 +7647-17-8 cesium chloride -240160 256.15 +7647-19-0 phosphorus (V) fluoride -1594410 300.83 +7661-55-4 5-methylquinoline 199190 336.74 +7664-39-3 hydrogen fluoride -272550 173.78 +7664-41-7 ammonia -45900 192.78 +7664-93-9 sulfuric acid -735130 298.8 +7667-55-2 1,cis-2,trans-3-trimethylcyclohexane -215450 391.36 +7667-58-5 1,cis-2,trans-4-trimethylcyclohexane -215450 391.36 +7667-59-6 1,trans-2,cis-4-trimethylcyclohexane -215450 391.36 +7667-60-9 1,trans-2,trans-4-trimethylcyclohexane -215450 391.36 +7681-11-0 potassium iodide -125520 258.29 +7681-49-4 sodium fluoride -290450 217.45 +7688-21-3 cis-2-hexene -50300 385.52 +7693-26-7 potassium hydride 123010 198.04 +7697-37-2 nitric acid -134310 266.41 +7698-05-7 deuterium chloride -93350 192.74 +7704-34-9 sulfur 276980 167.82 +7705-07-9 titanium (III) chloride -539320 316.86 +7705-08-0 ferric chloride -253130 344.19 +7713-69-1 methyl-sec-butylamine -97600 384.39 +7718-54-9 nickel (II) chloride -73930 294.27 +7719-09-7 thionyl chloride -212500 310.08 +7719-12-2 phosphorus (III) chloride -287000 311.31 +7719-83-7 N-dohexacontane -1323000 2571 +7719-87-1 N-tetrahexacontane -1364300 2648.9 +7719-89-3 N-hexahexacontane -1405600 2726.9 +7719-90-6 N-heptahexacontane -1426200 2765.8 +7719-93-9 N-heptacontane -1488100 2882.7 +7720-83-4 titanium (IV) iodide -277270 433.03 +7721-01-9 tantalum (V) chloride -764830 413.01 +7722-84-1 hydrogen peroxide -136110 232.99 +7723-14-0 phosphorus (white) 316390 163.21 +7726-95-6 bromine 30910 245.4 +7727-15-3 aluminum bromide -410450 349.47 +7727-18-6 vanadium oxytrichloride -695600 344.75 +7727-37-9 nitrogen 0 191.61 +7731-28-4 cis-4-methylcyclohexanol -347500 380.84 +7731-29-5 trans-4-methylcyclohexanol -367200 380.84 +7732-18-5 water -241830 188.84 +7757-82-6 sodium sulfate -1033620 346.55 +7758-02-3 potassium bromide -180080 250.55 +7758-89-6 cuprous chloride 91090 237.19 +7758-94-3 ferrous chloride -141000 299.26 +7758-95-4 lead chloride -174050 317.22 +7766-48-5 5-iodo-1-pentene 55770 401.78 +7766-51-0 4-iodo-1-butene 76410 362.83 +7774-29-0 mercuric iodide -16130 336.08 +7778-80-5 potassium sulfate -1094120 366.18 +7782-39-0 deuterium 0 144.96 +7782-41-4 fluorine 0 202.79 +7782-42-5 graphite 716670 158.1 +7782-44-7 oxygen 0 205.15 +7782-49-2 selenium (vitreous) 227100 176.94 +7782-50-5 chlorine 0 223.08 +7782-65-2 germane 90800 216.65 +7782-77-6 nitrous acid -76740 249.42 +7782-79-8 hydrazoic acid 294100 238.72 +7783-03-1 tungstic acid -905840 351.95 +7783-06-4 hydrogen sulfide -20500 205.76 +7783-07-5 hydrogen selenide 29700 219.41 +7783-09-7 hydrogen telluride 99600 +7783-26-8 trisilane 120900 +7783-30-4 mercurous iodide 133470 280.62 +7783-39-3 mercury (II) fluoride -293650 271.61 +7783-40-6 magnesium fluoride -726760 256.51 +7783-41-7 fluorine oxide 24520 247.46 +7783-42-8 thionyl fluoride -543920 279.13 +7783-44-0 difluorine dioxide 19200 277.21 +7783-46-2 lead fluoride -435140 292.71 +7783-48-4 strontium fluoride -766090 288.02 +7783-50-8 iron (III) fluoride -820900 304.22 +7783-54-2 nitrogen trifluoride -132090 260.78 +7783-55-3 phosphorus (III) fluoride -958440 273.08 +7783-58-6 germanium (IV) fluoride -1190200 301.84 +7783-59-7 lead (IV) fluoride -1133450 333.62 +7783-60-0 sulfur tetrafluoride -763160 299.65 +7783-61-1 silicon tetrafluoride -1614940 282.76 +7783-63-3 titanium (IV) fluoride -1551430 314.89 +7783-64-4 zirconium (IV) fluoride -1673600 319.65 +7783-66-6 iodine pentafluoride -840320 334.66 +7783-68-8 niobium (V) fluoride -1739700 321.68 +7783-72-4 vanadium (V) fluoride -1433900 322.32 +7783-75-7 iridium (VI) fluoride -544000 362.14 +7783-77-9 molybdenum fluoride -1557660 350.81 +7783-79-1 selenium hexafluoride -1117000 315.41 +7783-80-4 tellurium hexafluoride -1318000 +7783-81-5 uranium fluoride -2147400 377.84 +7783-82-6 tungsten fluoride -1721720 341.08 +7783-86-0 iron (II) iodide 87860 349.57 +7784-18-1 aluminum fluoride -1209320 276.72 +7784-23-8 aluminum iodide -193300 373.64 +7784-33-0 arsenic (III) bromide -130000 360.58 +7784-34-1 arsenic trichloride -261500 327.36 +7784-35-2 arsenic trifluoride -785800 288.88 +7784-42-1 arsine 66400 222.63 +7786-30-3 magnesium chloride -392460 277.03 +7787-32-8 barium fluoride -803750 301.82 +7787-47-5 beryllium chloride -360240 252.3 +7787-49-7 beryllium fluoride -796010 227.62 +7787-52-2 beryllium hydride 125520 173.18 +7787-53-3 beryllium iodide -64020 291.58 +7787-60-2 bismuth trichloride -265700 358.79 +7787-71-5 bromine trifluoride -255590 292.4 +7789-19-7 copper (II) fluoride -266940 267.08 +7789-20-0 deuterium oxide -249200 198.34 +7789-23-3 potassium fluoride -326770 226.62 +7789-24-4 lithium fluoride -340790 200.31 +7789-25-5 nitrosyl fluoride -65690 248.08 +7789-26-6 fluorine nitrate 10450 292.91 +7789-27-7 thallium (I) fluoride -182400 +7789-28-8 iron (II) fluoride -389530 265.19 +7789-30-2 bromine pentafluoride -428720 323.69 +7789-33-5 iodine bromide 40880 258.95 +7789-40-4 thallous bromide -37700 +7789-41-5 calcium bromide -384930 314.76 +7789-46-0 iron (II) bromide -41420 337.34 +7789-47-1 mercuric bromide -85450 320.1 +7789-48-2 magnesium bromide -302920 301.04 +7789-57-3 silane, tribromo -302920 348.04 +7789-59-5 phosphorus (V) oxybromide -389110 359.85 +7789-60-8 phosphorus tribromide -146020 348.25 +7789-61-9 antimony tribromide -194600 372.29 +7789-66-4 tetrabromosilane -415470 379.36 +7789-67-5 stannic bromide -314600 411.95 +7789-68-6 titanium (IV) bromide -550200 398.57 +7789-75-5 calcium fluoride -784500 273.8 +7789-89-1 1,1,1-trichloropropane -162900 359.91 +7790-30-9 thallium iodide 7100 +7790-89-8 chlorine monofluoride -50290 217.94 +7790-91-2 chlorine trifluoride -158870 281.6 +7790-92-3 hypochlorous acid -74480 236.51 +7790-99-0 iodine chloride 17510 247.57 +7791-12-0 thallium chloride -67800 +7791-21-1 chlorine monoxide 81000 271.72 +7791-25-5 sulfuryl chloride -354800 311.1 +7795-80-4 2-methyl-2,3-pentanediol -506000 374.88 +7796-36-3 cis-1-iodo-1-propene 88840 321.9 +7796-54-5 trans-1-iodo-1-propene 88840 321.9 +7803-51-2 phosphine 5440 210.24 +7803-52-3 stibine 145100 232.66 +7803-62-5 silane 34310 204.64 +10022-50-1 nitryl fluoride -108780 260.26 +10024-97-2 nitrous oxide 82050 219.96 +10025-67-9 sulfur monochloride -16740 327.21 +10025-78-2 silane, trichloro -496220 313.71 +10025-82-8 indium (III) chloride -374000 +10025-87-3 phosphorus oxychloride -559820 325.47 +10026-04-7 silicon tetrachloride -662750 330.94 +10026-08-1 thorium (IV) chloride -964400 390.7 +10026-10-5 uranium (IV) chloride -809600 419 +10026-11-6 zirconium chloride -869980 367.85 +10026-12-7 niobium (V) chloride -703330 404.05 +10026-13-8 phosphorus pentachloride -360180 364.3 +10026-17-2 cobalt (II) fluoride -356480 277.98 +10028-15-6 ozone 142670 238.94 +10031-18-2 mercurous bromide 104180 271.41 +10031-22-8 lead bromide -104390 339.4 +10034-85-2 hydrogen iodide 26360 206.59 +10035-10-6 hydrogen bromide -36440 198.7 +10036-47-2 tetrafluorohydrazine -8370 301.2 +10038-98-9 germanium chloride -495800 348.12 +10042-59-8 2-propyl-1-heptanol -407240 586.89 +10043-11-5 boron nitride 476980 212.42 +10043-35-3 boric acid -992230 295.48 +10043-52-4 calcium chloride -471540 290.27 +10043-92-2 radon 0 176.1 +10049-04-4 chlorine dioxide 98040 269.33 +10049-06-6 titanium (II) chloride -237230 278.3 +10049-14-6 uranium (IV) fluoride -1598700 368.58 +10076-31-0 dimethyl-2,2-dimethylpropylamine -129030 405.88 +10086-64-3 1-fluoro-2-methylbutane -347920 372.93 +10097-28-6 silicon monoxide -99600 211.27 +10099-66-8 lutetium chloride -649000 +10101-63-0 lead iodide -3180 359.56 +10102-03-1 nitrogen pentoxide 11300 346.56 +10102-43-9 nitric oxide 90290 210.76 +10102-44-0 nitrogen dioxide 33100 240.04 +10102-68-8 calcium iodide -258150 327.57 +10136-83-1 1-methyl-6-isopropylnaphthalene 51300 509.67 +10143-23-4 2,3-dimethyl-1-pentanol -350600 460.51 +10192-32-2 1-tetracosene -413260 1086.3 +10203-28-8 2-dodecanol -448520 703.03 +10241-04-0 cobalt (III) chloride -163590 334.15 +10241-05-1 molybdenum (V) chloride -447690 397.87 +10250-52-9 1,1-diiodopropane 43210 374.57 +10250-55-2 1,1-diiodo-2-methylpropane 17290 404 +10288-13-8 1,2-dibromo-3-methylbutane -104430 433.81 +10294-33-4 boron tribromide -204180 324.38 +10294-34-5 boron trichloride -402960 290.24 +10294-54-9 cesium sulfate -1122570 406.32 +10297-57-1 2-methyl-2-nonanol -410710 557.54 +10315-59-0 ethyl methyl sulfite -517900 +10342-97-9 methyldiisopropylamine -130840 425.7 +10359-64-5 3-methyl-2-thiapentane -109940 402.64 +10361-37-2 barium chloride -498730 326.26 +10361-92-9 yttrium chloride -750200 +10377-48-7 lithium sulfate -1041820 322.9 +10377-51-2 lithium iodide -91000 232.29 +10377-58-9 magnesium iodide -160250 317.49 +10403-60-8 2,3,3-trichlorobutane -187140 363.68 +10422-35-2 1-bromo-2-methylbutane -125480 392.29 +10428-64-5 1,2-dibromo-2-methylbutane -102620 413.98 +10476-81-0 strontium bromide -407100 319.73 +10476-85-4 strontium chloride -473210 312.65 +10476-86-5 strontium iodide -274890 335.86 +10486-19-8 1-tridecanal -394100 696.76 +10496-15-8 dihexyl disulfide -243000 728.36 +10496-16-9 diheptyl disulfide -284000 806.66 +10496-18-1 didecyl disulfide -408000 1041.6 +10523-96-3 4-chloro-2-methyl-1-butene -46630 375.42 +10524-01-3 4-chloro-3-methyl-1-butene -42120 370.06 +10524-07-9 5-chloro-trans-2-pentene -45050 377.6 +10524-08-0 4-chloro-1-pentene -42120 370.06 +10524-70-6 3,3-dimethyl-1-hexanol -369430 479.64 +10525-37-8 eicosylamine -421800 993.39 +10544-72-6 nitrogen tetraoxide 9080 304.38 +10544-73-7 nitrogen trioxide 82840 308.55 +10545-99-0 sulfur dichloride -17570 281.63 +10553-31-8 barium bromide -424680 342.6 +10557-44-5 2,5-dimethyl-cis-3-hexene -103900 434.91 +10570-69-1 2,6-dimethyl-4-ethylphenol -213450 453.24 +10574-36-4 3-methyl-cis-2-hexene -84300 404.78 +10574-37-5 2,3-dimethyl-2-pentene -87700 422.05 +10575-56-1 3,4,4-trimethyl-2-pentanol -379990 460.59 +12007-33-9 boron sulfide 67000 +12018-01-8 chromium (IV) oxide -75310 269.43 +12024-08-7 gallium oxide 279500 230.68 +12025-32-0 germanium (II) sulfide 92000 230.84 +12030-14-7 indium (II) sulfide 238000 +12031-80-0 lithium peroxide -242670 273.64 +12032-36-9 magnesium sulfide 145230 225.48 +12034-57-0 niobium (II) oxide 198740 238.92 +12034-59-2 niobium (IV) oxide -200000 272.86 +12035-90-4 tantalum oxide 192460 241.15 +12035-97-1 uranium monoxide 21000 +12035-98-2 vanadium (II) oxide 127610 230.87 +12036-14-5 tantalum (IV) oxide -200830 280.34 +12036-21-4 vanadium (IV) oxide -232630 265.24 +12036-22-5 tungsten (IV) oxide 76570 285.44 +12039-90-6 zirconium silicide 474000 +12057-24-8 lithium oxide -166940 229.18 +12058-07-0 molybdenum oxide 310960 241.86 +12136-26-4 indium monoxide 387000 236.18 +12137-18-7 rhodium monoxide 385000 +12137-20-1 titanium (II) oxide 54390 233.44 +12185-10-3 phosphorus (white) 58900 280.07 +12232-99-4 sodium bismuthate -648520 440.54 +12317-46-3 palladium (II) chloride, (bicyclo[2.2.1]hepta-2,5-diene) 80900 916.9 +12440-00-5 phosphorous (III) oxide -2214310 345.71 +12504-41-5 silicon monosulfide 105960 223.79 +13023-60-4 2,2-diethyl-1-butanol -369430 479.64 +13024-80-1 hexacosylbenzene -467280 1296.1 +13116-53-5 1,2,2,3-tetrachloropropane -176960 367.67 +13116-60-4 1,1,2,2-tetrachloropropane -182240 358.15 +13135-31-4 titanium (III) bromide -374890 359.03 +13150-81-7 2,6-dimethyldecane -302200 608.24 +13151-04-7 5-methyl-1-heptene -87200 457.18 +13151-05-8 4-methyl-1-heptene -88900 451.48 +13151-17-2 5-methyl-cis-2-hexene -77800 406.09 +13151-27-4 2-methyl-1-decene -154730 575.72 +13151-34-3 3-methyldecane -275650 580.99 +13151-35-4 5-methyldecane -274600 582.5 +13154-12-6 cis-1-bromo-1-hexene -23620 434.18 +13154-13-7 trans-1-bromo-1-hexene -23620 434.18 +13175-27-4 1,6-heptanediol -505500 494.26 +13205-44-2 borane carbonyl -111200 248.86 +13205-60-2 ethylisobutylamine -119900 417.77 +13231-81-7 3-methyl-1-hexanol -345320 470.03 +13254-34-7 2,6-dimethyl-2-heptanol -395350 509.07 +13279-85-1 1,1,1-trichlorobutane -183600 399.4 +13279-87-3 1,1,3-trichlorobutane -183670 393.03 +13281-11-3 2-nonanethiol -199800 563.08 +13283-01-7 tungsten (VI) chloride -493710 419.11 +13286-90-3 5-methyl-2-thiahexane -129700 444.54 +13286-91-4 3-methyl-2-thiahexane -130700 441.19 +13286-92-5 3,3-dimethyl-2-thiapentane -137400 401.01 +13287-19-9 2-methyl-3-isopropyloctane -289700 589.79 +13320-56-4 1,1-dibromopentane -99150 443.33 +13320-71-3 molybdenum (IV) chloride -384930 372.04 +13360-61-7 1-pentadecene -228000 739.58 +13360-63-9 ethylbutylamine -113200 432.06 +13361-63-2 4,4-dimethyl-1-pentyne 81700 382.87 +13362-52-2 1,13-tridecanediol -616110 764.16 +13362-80-6 4,8-dimethylquinoline 167080 369.52 +13364-16-4 1-amino-2-methylpentane -137700 435.01 +13373-83-6 octadecyl butanoate -815100 1073.2 +13373-97-2 1-eicosanethiol -418200 1004.2 +13389-42-9 trans-2-octene -94500 465.5 +13400-13-0 cesium fluoride -356480 243.29 +13402-60-3 2-decanethiol -220400 602.23 +13417-08-8 methylhexadecylamine -340740 858.86 +13423-15-9 3-methyltetrahydrofuran -218050 249.04 +13432-25-2 2,4-dimethyl-3-hexanol -376520 489.94 +13444-87-6 nitrosyl bromide 82130 273.53 +13445-50-6 diphosphine 20900 +13446-56-5 molybdenum (II) bromide 167360 321.06 +13446-57-6 molybdenum (III) bromide -8370 375.09 +13450-92-5 germanium bromide -300000 395.88 +13450-95-8 germanium (IV) iodide -56900 429.06 +13453-69-5 lithium metaborate -646850 274.84 +13456-23-0 1,1-diphenylhexadecane -195000 +13460-50-9 metaboric acid (b form) -561900 239.83 +13463-30-4 lead (IV) chloride -552400 381.68 +13463-39-3 nickel carbonyl -601580 415.54 +13463-40-6 iron pentacarbonyl -727850 439.27 +13463-67-7 titanium (IV) oxide -305430 260.11 +13465-07-1 hydrogen disulfide 15500 +13465-09-3 indium (III) bromide -282000 +13465-10-6 indium (I) chloride -75000 +13465-71-9 silane, trifluoro -1200810 277.26 +13465-72-0 silane, triiodo -74470 375 +13465-73-1 silane, monobromo -78240 262.46 +13465-78-6 silane, monochloro -141840 250.75 +13465-84-4 silane, tetraiodo -110460 416.43 +13470-08-1 titanium (III) fluoride -1188670 291.41 +13470-11-6 tungsten (V) bromide -199160 461.36 +13470-12-7 tungsten (II) chloride -12550 309.36 +13470-13-8 tungsten (IV) chloride -335970 379.23 +13470-14-9 tungsten (V) chloride -412540 405.64 +13475-78-0 5-ethyl-2-methylheptane -258240 522.92 +13475-79-1 2,4-dimethyl-3-isopropylpentane -258030 487.7 +13475-81-5 2,2,3,3-tetramethylhexane -257860 486.46 +13475-82-6 2,2,4,6,6-pentamethylheptane -315580 542.73 +13478-20-1 phosphorus oxyfluoride -1254300 285.18 +13478-41-6 copper (I) fluoride -12550 226.48 +13478-45-0 niobium (V) bromide -443590 449.2 +13494-80-9 tellurium 196700 182.52 +13494-92-3 iodine dioxide 159320 281.47 +13499-05-3 hafnium (IV) chloride -884500 +13501-73-0 3,5-dimethyl-1-hexanol -371240 499.46 +13510-35-5 indium (III) iodide -120500 +13517-10-7 boron triiodide 71130 348.78 +13520-59-7 molybdenum (IV) bromide -171130 418.99 +13520-76-8 tungsten (VI) dioxydichloride -671530 353.87 +13520-78-0 tungsten (VI) oxytetrachloride -573490 377.02 +13520-79-1 tungsten (VI) oxytetrafluoride -1336620 334.65 +13537-33-2 silane, monofluoro -376560 238.39 +13540-50-6 2',5'-dimethyldiphenylmethane 101000 527.88 +13540-56-2 3',4'-dimethyldiphenylmethane 97190 515.11 +13550-49-7 deuteroammonia -58580 203.93 +13595-30-7 vanadium (IV) bromide -336800 +13598-22-6 beryllium sulfide 263590 210.34 +13598-42-0 silane, iodo -2090 271.01 +13632-93-4 1-methyl-2,3-diethylbenzene -42000 461.25 +13632-94-5 1-methyl-2,5-diethylbenzene -44500 461.25 +13632-95-6 1-methyl-2,6-diethyl benzene -51200 476.68 +13637-63-3 chlorine pentafluoride -238490 310.74 +13637-68-8 molybdenum (VI) dioxydichloride -633040 337.89 +13643-05-5 4-methyl-1,2-pentadiene 65230 358.64 +13678-54-1 2-methyl-4-ethyl thiophene 30890 383.69 +13701-67-2 diborane, tetrachloro -489110 359.09 +13701-86-5 tungsten (VI) bromide -243090 482.65 +13701-91-2 lead (IV) bromide -456360 426.22 +13706-19-9 molybdenum (VI) chloride -439320 419.75 +13709-35-8 difluorodisulfane -336430 294.08 +13709-47-2 scandium fluoride -1247000 295.18 +13709-49-4 yttrium fluoride -1288700 312.03 +13709-52-9 hafnium fluoride -1669800 +13709-59-6 thorium (IV) fluoride -1759000 339.99 +13709-94-9 potassium metaborate -674040 297.49 +13714-85-7 4-methyl-trans-3-heptene -105300 442.53 +13718-50-8 barium iodide -302920 348.66 +13732-80-4 1-methyl-3,4-diethylbenzene -54200 466.29 +13760-02-6 silane, diiodo -38070 326.79 +13762-26-0 zirconium dichloride -186190 292.69 +13763-23-0 uranium (VI) chloride -1013000 431 +13764-18-6 1,4,6,7-tetramethylnaphthalene 51300 509.67 +13765-26-9 gadolinium (III) fluoride -1297000 +13768-94-0 silane, dibromo -190370 310.04 +13775-06-9 uranium (III) fluoride -1058500 332.25 +13776-62-0 trans-difluorodiazine 81170 262.66 +13779-87-8 zirconium triiodide -221750 397.91 +13780-57-9 sulfur chloride pentafluoride -1038890 319.93 +13783-04-5 titanium (II) bromide -179070 308.65 +13783-07-8 titanium (II) iodide -19660 323.63 +13812-43-6 cis-difluorodiazine 68620 259.81 +13814-25-0 sulfur (II) fluoride -296650 257.7 +13818-89-8 digermane 162300 +13819-84-6 molybdenum (V) fluoride -1241390 347.75 +13824-36-7 silane, difluoro -790780 262.12 +13840-33-0 lithium hypochlorite -14230 256.45 +13842-84-7 thorium (III) fluoride -1166100 337.54 +13863-41-7 bromine chloride 14640 240.01 +13863-59-7 bromine fluoride -58460 228.97 +13873-84-2 iodine fluoride -94760 236.3 +13939-06-5 molybdenum hexacarbonyl -912100 490.44 +13952-84-6 sec-butylamine -104650 357.04 +13965-73-6 diborane, tetrafluoro -1431760 318.61 +13966-94-4 indium (I) iodide 7500 267.47 +13986-26-0 zirconium iodide -362330 446.69 +13991-37-2 trans-2-pentenoic acid -375300 411.68 +14049-36-6 silane, chlorotrifluoro -1317960 308.67 +14055-74-4 molybdenum (II) iodide 257730 339.38 +14055-75-5 molybdenum (III) iodide 182840 403.62 +14055-76-6 molybdenum (IV) iodide 124680 452.9 +14069-89-7 sec-butyl isocyanide 40000 437.67 +14075-53-7 potassium fluoroborate -1552260 315.47 +14130-05-3 nonadecylamine -401200 954.24 +14130-06-4 docosylamine -463620 1064.6 +14130-07-5 tricosylamine -484260 1103.5 +14130-08-6 tetracosylamine -504900 1142.5 +14130-09-7 pentacosylamine -525540 1181.4 +14130-10-0 hexacosylamine -546180 1220.4 +14130-11-1 heptacosylamine -566820 1259.3 +14130-12-2 octacosylamine -587460 1298.3 +14130-15-5 heneicosylamine -442980 1025.6 +14167-59-0 tetratriacontane -745090 1480.4 +14188-79-5 2-decylnaphthalene -80530 706.82 +14189-13-0 2-ethyl-1,5-pentanediol -492900 536.52 +14250-79-4 2,2-dimethyl-1-heptanol -390070 518.59 +14255-23-3 2,4-dimethyl-2-hexene -108100 441.32 +14255-24-4 4-methyl-cis-3-heptene -105300 442.53 +14255-44-8 2-nitrohexane -183210 460.48 +14280-53-6 indium (I) bromide -56900 259.35 +14290-92-7 2,2-dimethyl-3-thiapentane -144200 378.2 +14310-20-4 4-methyl-1,2-diphenylethane 112300 533.49 +14402-50-7 2-dodecanethiol -261600 680.87 +14411-75-7 1,3-dimethyl-2-isopropylbenzene -45900 452.2 +14476-30-3 1,2,2-tribromopropane -35010 387.13 +14531-16-9 5-methyl-5-ethylnonane -297500 593.81 +14558-12-4 1,3,5,8-tetramethylnaphthalene 51300 509.67 +14596-92-0 1,cis-3-hexadiene 75480 378.53 +14602-62-1 1,1,2-tribromopropane -36820 406.95 +14609-79-1 2,2,4,4-tetramethyl-3-pentanol -404100 470.19 +14610-37-8 methylisobutylamine -93500 398.14 +14676-29-0 3-ethyl-2-methylheptane -253380 528.69 +14686-13-6 trans-2-heptene -73300 423.33 +14686-14-7 trans-3-heptene -73500 423.33 +14691-44-2 trigermane 226800 +14720-74-2 2,2,4-trimethylheptane -263840 505.98 +14722-40-8 1,15-pentadecanediol -657390 842.07 +14739-73-2 2,2,3,5,5-pentamethylhexane -293200 505.02 +14752-75-1 heptadecylbenzene -281520 945.49 +14753-05-0 1-chloro-2-methylpentane -188190 413.61 +14779-92-1 8-methyl-2-nonanol -412520 577.37 +14808-60-7 silicon dioxide (α quartz) -305430 228.97 +14832-90-7 selenium monoxide 53400 234.23 +14850-22-7 cis-3-octene -89500 482.27 +14850-23-8 trans-4-octene -94500 459.13 +14852-31-4 2-hexadecanol -531080 857.77 +14919-01-8 trans-3-octene -94500 465.17 +14920-89-9 2,3-dimethylfuran -97900 336.61 +14965-52-7 silane, trichlorofluoro -840980 336.05 +14977-61-8 chromium oxychloride -538100 329.61 +14979-39-6 4-methyl-3-heptanol -371240 499.46 +15013-37-3 4-methyl-2-thiahexane -129000 446.89 +15232-76-5 3-octyne 63850 439.37 +15306-27-1 1-heptacosene -475180 1203.1 +15331-16-5 1,1,2-tribromo-2-methylpropane -60930 416.55 +15340-96-2 3,7-dimethyl-2-octanol -417800 567.84 +15501-33-4 1-iodo-2,2-dimethylpropane -78410 367.51 +15600-49-4 iron (III) iodide 71000 +15672-88-5 1-iodo-3,3-dimethylbutane -100860 426.28 +15673-00-4 1-amino-3,3-dimethylbutane -149800 376.72 +15679-01-3 1,cis-2-dimethylcyclobutane -15500 382.16 +15679-02-4 1,trans-2-dimethylcyclobutane -15500 382.16 +15831-18-2 vanadium tetraiodide -122590 +15833-75-7 3,3-dimethyltetrahydrofuran -223450 357.52 +15840-60-5 2-methyl-cis-3-hexene -77200 408.1 +15869-80-4 3-ethylheptane -231500 497.82 +15869-85-9 5-methylnonane -253970 536 +15869-86-0 4-ethyloctane -251080 541.74 +15869-87-1 2,2-dimethyloctane -267000 512.15 +15869-89-3 2,5-dimethyloctane -261120 528.72 +15869-92-8 3,4-dimethyloctane -253380 531.64 +15869-93-9 3,5-dimethyloctane -258240 531.64 +15869-94-0 3,6-dimethyloctane -258240 525.87 +15869-95-1 4,4-dimethyloctane -262210 522.25 +15869-96-2 4,5-dimethyloctane -253380 525.9 +15870-10-7 2-methyl-1-heptene -92810 458.86 +15877-57-3 3-methylpentanal -253500 414.04 +15890-40-1 1,cis-2,trans-3-trimethylcyclopentane -188650 332.48 +15918-08-8 2-propyl-1-pentene -92810 458.86 +16020-17-0 1,2,4,7-tetramethylnaphthalene 51300 509.67 +16021-20-8 1-ethyl-2-propylbenzene -38000 475.01 +16106-59-5 4,5-dimethyl-1-hexene -93000 445.91 +16130-73-7 diheptadecylamine -691620 1521 +16136-84-8 cis-1-chloro-1-propene -3770 299.7 +16136-85-9 trans-1-chloro-1-propene -3770 299.7 +16165-33-6 diundecylamine -443940 1053.6 +16325-63-6 2,4,4-trimethyl-1-pentanol -374710 470.11 +16325-64-7 3,4,4-trimethyl-1-pentanol -374710 470.11 +16331-21-8 1-bromooctacosane -594920 1297.7 +16416-41-4 trans-1-bromo-3-methyl-1-butene -8260 385.7 +16416-44-7 cis-1-bromo-3-methyl-1-butene -8260 385.7 +16432-53-4 1,4-hexanediol -482700 462.55 +16435-49-7 2-methyl-1-dodecene -196010 653.62 +16491-15-9 1,5-dimethylcyclopentene -29100 361.41 +16538-47-9 cis-1-iodo-1-hexene 26920 438.75 +16631-63-3 1-methyl-1-propylcyclopentane -153370 525.68 +16644-66-9 1,1,1-tribromopentane -76290 465.03 +16644-98-7 trans-1-iodo-1-hexene 26920 438.75 +16666-42-5 cis-2-pentenoic acid -375300 411.68 +16724-63-3 dihexadecylamine -650340 1443.1 +16727-91-6 1-isobutylnaphthalene 51300 509.67 +16745-94-1 3,4-dimethyl-1-hexene -93000 445.91 +16746-02-4 2-isopropyl-1-pentene -98090 449.33 +16746-85-3 4-ethyl-1-hexene -86900 458.19 +16746-86-4 2,3-dimethyl-1-hexene -98100 449.3 +16746-87-5 2,4-dimethyl-1-hexene -101600 437.56 +16747-25-4 2,2,3-trimethylhexane -241210 467.2 +16747-26-5 2,2,4-trimethylhexane -243200 467.97 +16747-28-7 2,3,3-trimethylhexane -239300 461.6 +16747-30-1 2,4,4-trimethylhexane -240000 468.64 +16747-31-2 3,3,4-trimethylhexane -235400 468.3 +16747-32-3 2,2-dimethyl-3-ethylpentane -231300 461.6 +16747-33-4 2,3-dimethyl-3-ethylpentane -233800 455.56 +16747-38-9 2,3,3,4-tetramethylpentane -236300 437.45 +16747-42-5 2,2,4,5-tetramethylhexane -266140 492.93 +16747-44-7 2,2,3,3,4-pentamethylpentane -247190 473.41 +16747-45-8 2,2,3,4,4-pentamethylpentane -247020 464.29 +16747-50-5 1-methyl-1-ethylcyclopentane -154900 401.87 +16751-58-9 3-aminohexane -141800 421.26 +16789-46-1 3-ethyl-2-methylhexane -234600 487.42 +16789-51-8 3-ethyl-3-hexene -104000 446.89 +16812-54-7 nickel sulfide 357420 252.31 +16813-18-6 2-heptadecanol -551720 896.45 +16883-48-0 1,trans-2,cis-4-trimethylcyclopentane -188650 332.48 +16891-99-9 1-nitrododecane -301770 703.72 +16900-07-5 butyl octyl sulfide -249740 689.9 +16900-08-6 butyl dodecyl sulfide -332210 846.28 +16921-96-3 iodine heptafluoride -961070 347.74 +16962-07-5 aluminum borohydride 13000 380.64 +16967-04-7 butyl hexyl sulfide -208530 611.82 +16980-85-1 1-pentacosene -433900 1125.2 +17042-16-9 4-methyl-3-hexanone -305670 445.84 +17057-91-9 1,3,8-trimethylnaphthalene 57000 442.68 +17057-92-0 1-methyl-5-ethylnaphthalene 69000 456.09 +17057-94-2 2-methyl-4-ethylnaphthalene 63000 456.09 +17059-44-8 1,2-dimethyl-3-propylbenzene -46700 461.25 +17059-45-9 1,3-dimethyl-2-propylbenzene -44500 461.25 +17059-53-9 1-methyl-6-ethylnaphthalene 69000 456.09 +17059-55-1 2-methyl-7-ethylnaphthalene 60920 455.15 +17085-91-5 1-tert-butylnaphthalene 51300 509.67 +17085-96-0 3-ethyldecane -293400 615.95 +17179-41-8 1-methyl-3-ethylnaphthalene 69000 456.09 +17194-00-2 barium hydroxide -626560 315.55 +17301-94-9 4-methylnonane -253970 541.74 +17302-01-1 3-ethyl-3-methylheptane -256940 522.25 +17302-02-2 3,3-diethylhexane -252300 482.64 +17302-04-4 4-ethyl-4-methylheptane -256940 522.25 +17302-11-3 3-ethylnonane -272700 576.8 +17302-12-4 5-ethylnonane -272500 575.12 +17302-13-5 4-propyloctane -272300 573.78 +17302-14-6 2,2-dimethylnonane -287600 552.65 +17302-15-7 3,3-dimethylnonane -282200 560.03 +17302-16-8 3-methyl-3-ethyloctane -276900 557.01 +17302-17-9 3,3-diethylheptane -271900 542.59 +17302-18-0 4,4-dimethylnonane -282000 558.01 +17302-19-1 4-methyl-4-ethyloctane -276800 560.03 +17302-20-4 4-methyl-4-propylheptane -276600 543.26 +17302-21-5 4,4-diethylheptane -271700 543.93 +17302-22-6 3,4-dimethylnonane -274400 572.77 +17302-23-7 4,5-dimethylnonane -274200 571.43 +17302-24-8 2,4-dimethylnonane -280900 568.41 +17302-25-9 3,5-dimethylnonane -278600 573.44 +17302-26-0 4,6-dimethylnonane -278400 566.06 +17302-27-1 2,5-dimethylnonane -281500 569.08 +17302-28-2 2,6-dimethylnonane -281500 569.08 +17302-29-3 2,7-dimethylnonane -281700 570.42 +17302-30-6 2,8-dimethylnonane -284000 559.69 +17302-31-7 3,6-dimethylnonane -279200 574.11 +17302-32-8 3,7-dimethylnonane -279400 569.75 +17302-33-9 6-methylundecane -295300 615.95 +17302-36-2 5-ethyldecane -293200 620.31 +17302-37-3 2,2-dimethyldecane -308200 592.14 +17302-38-4 3,3-dimethyldecane -302800 599.52 +17302-39-5 3-methyl-3-ethylnonane -297600 596.16 +17302-40-8 3,3-diethyloctane -292600 581.74 +17312-39-9 4,4-dimethyldecane -302700 597.17 +17312-40-2 4-methyl-4-ethylnonane -297500 599.52 +17312-41-3 4-methyl-4-propyloctane -297300 591.47 +17312-42-4 4,4-diethyloctane -292400 588.78 +17312-43-5 4-ethyl-4-propylheptane -292300 586.44 +17312-44-6 2,3-dimethyldecane -298000 609.58 +17312-45-7 3,4-dimethyldecane -295100 612.26 +17312-46-8 4,5-dimethyldecane -294900 610.58 +17312-48-0 3,5-dimethyldecane -299200 612.93 +17312-49-1 4,6-dimethyldecane -299000 611.59 +17312-50-4 2,5-dimethyldecane -302200 608.24 +17312-51-5 2,7-dimethyldecane -302200 608.24 +17312-52-6 2,8-dimethyldecane -302400 609.91 +17312-53-7 3,6-dimethyldecane -299900 613.6 +17312-54-8 3,7-dimethyldecane -299900 613.6 +17312-55-9 3,8-dimethyldecane -300100 609.24 +17312-56-0 4,7-dimethyldecane -299700 606.22 +17312-57-1 3-methyldodecane -316930 652.86 +17312-64-0 2,2-dimethylundecane -320400 623.51 +17312-77-5 2,3-dimethylundecane -322210 643.33 +17312-80-0 2,4-dimethylundecane -322210 643.33 +17348-59-3 isopropyl-tert-butyl-ether -358150 419.05 +17352-32-8 nonadecanal -518700 932.36 +17361-44-3 ditetradecylamine -567780 1287.3 +17373-27-2 dimethylnonylamine -202840 600.56 +17373-28-3 dimethylundecylamine -244120 678.47 +17373-29-4 dimethyltridecylamine -285400 756.37 +17453-92-8 5,5-dimethyldecane -302700 597.17 +17616-44-3 1,3-diiodo-2-methylpropane 22570 413.52 +17678-60-3 dimethylpentadecylamine -326680 834.27 +17702-41-9 decaborane 47280 352.82 +17760-40-6 1,1,1-trichlorohexane -224800 479.05 +17773-64-7 2-chloro-3-methyl-1-butene -51910 365.9 +17773-65-8 2-chloro-3-methyl-2-butene -64630 369.29 +17773-66-9 2,2-dichloro-3-methylbutane -192040 369.21 +17839-26-8 ethylpentylamine -134340 469.34 +17851-27-3 1,2,4-trimethyl-6-ethylbenzene -59100 462.6 +18094-01-4 2-methyl-1-tridecene -216650 692.57 +18231-53-3 3,3-dimethyl-2-ethyl-1-butene -101560 419.99 +18283-93-7 tetraborane 66100 +18295-25-5 2-bromo-3-methylbutane -130760 382.76 +18295-27-7 2-iodo-3-methylbutane -80220 387.33 +18300-91-9 pentadecanenitrile -188050 746.39 +18338-40-4 1,2,3-trichlorobutane -183670 393.03 +18371-13-6 2-methyl-2-ethyl-1-butanol -348790 440.69 +18371-24-9 1,3-diiodobutane 22570 413.52 +18433-84-6 pentaborane 103300 +18435-20-6 2,3-dimethyltridecane -363490 721.24 +18435-22-8 3-methyltetradecane -358210 730.76 +18435-23-9 2,3-dimethyltetradecane -384130 760.19 +18435-53-5 1-triacontene -537100 1320 +18435-54-6 1-hentriacontene -557740 1358.9 +18435-55-7 1-dotriacontene -578380 1397.9 +18437-89-3 butyl hexadecyl sulfide -414630 1002.7 +18441-55-9 2,4-dimethyl-5-ethylphenol -213450 453.24 +18441-56-0 2-methyl-4-propylphenol -201980 459.41 +18479-57-7 2,6-dimethyt-2-octanol -415990 548.02 +18480-07-4 strontium hydroxide -595800 301.35 +18495-30-2 1,1,2,3-tetrachloropropane -178770 387.5 +18593-92-5 3-methyl-2-isopropyl-1-butanol -376520 489.94 +18610-33-8 4-chloro-trans-2-pentene -50330 368.08 +18636-94-7 dimethyl-3-pentylamine -125560 435.23 +18675-20-2 2,4-dimethyl-2-octanol -415990 548.02 +18720-62-2 2-methyl-3-heptanol -371240 499.46 +18720-65-5 5-methyl-3-heptanol -371240 499.46 +18720-66-6 6-methyl-3-heptanol -371240 499.46 +18787-63-8 2-hexadecanone -486900 812.21 +18835-32-0 1-tricosene -392620 1047.3 +18835-33-1 1-hexacosene -454540 1164.2 +18835-34-2 1-octacosene -495820 1242.1 +18835-35-3 1-nonacosene -516460 1281 +18868-43-4 molybdenum (IV) oxide -8310 277.09 +18932-14-4 2,2,4-trimethyloctane -284900 545.6 +18936-17-9 2-methylbutanenitrile 4600 360.39 +18938-47-1 3-methyl-3,4-hexanediol -521800 430.06 +18970-44-0 1-ethyl-2-isopropylbenzene -42400 462.26 +19031-61-9 3-fluoro-3-methylpentane -372030 382.54 +19037-72-0 4,4-dimethylcyclopentene -7100 394.61 +19182-11-7 1,2-diethylnaphthalene 51300 509.67 +19182-13-9 1,6-diethylnaphthalene 51300 509.67 +19184-10-2 cis-1-fluoro-1-propene -184140 297.97 +19218-94-1 1-iodotetradecane -255420 756.95 +19264-94-9 3,3-dimethyl-1-pentanol -348790 440.69 +19287-45-7 diborane 41000 233.3 +19313-57-6 butyl decyl sulfide -291000 768.07 +19313-61-2 ethyl decyl sulfide -250370 688.62 +19374-46-0 1,trans-2,cis-3-trimethylcyclopentane -188650 332.48 +19398-53-9 2,4-dibromopentane -104430 433.81 +19398-77-7 3,4-diethylhexane -247570 517.18 +19411-41-7 3,3,4-trimethyl-2-pentanol -379990 460.59 +19447-29-1 2-nonyne 43210 478.32 +19484-26-5 1-tridecanethiol -273800 729.42 +19486-08-9 2,2-dimethylhexadecane -423600 818.27 +19489-10-2 1-methyl-cis-3-ethylcyclohexane -207800 391.15 +19549-70-3 2,2-dimethyl-3-heptanol -395350 509.07 +19549-71-4 2,3-dimethyl-3-heptanol -395350 509.07 +19549-73-6 2,6-dimethyl-3-heptanol -397160 528.89 +19549-74-7 3,5-dimethyl-3-heptanol -395350 509.07 +19549-77-0 2,4-dimethyl-4-heptanol -395350 509.07 +19549-78-1 3,3-dimethyl-4-heptanol -395350 509.07 +19549-79-2 3,5-dimethyl-4-heptanol -397160 528.89 +19550-03-9 2,3-dimethyl-2-hexanol -374710 470.11 +19550-05-1 3,4-dimethyl-2-hexanol -376520 489.94 +19550-07-3 2,5-dimethyl-3-hexanol -376520 489.94 +19550-08-4 3,4-dimethyl-3-hexanol -374710 470.11 +19550-09-5 4,4-dimethyl-3-hexanol -374710 470.11 +19550-30-2 2,3-dimethyl-1-butanol -326600 432.83 +19550-48-2 1,4-dimethylcyclopentene -22700 365.1 +19550-81-3 3,4-dimethyl-cis-2-hexene -109700 435.95 +19550-82-4 3,4-dimethyl-trans-2-hexene -109700 435.95 +19550-83-5 4,4-dimethyl-cis-2-hexene -87200 465.03 +19550-87-9 3,4-dimethyl-cis-3-hexene -107200 464.83 +19550-88-0 3,4-dimethyl-trans-3-hexene -107200 464.83 +19624-22-7 pentaborane 73220 275.74 +19655-56-2 8-ethylquinoline 178550 375.69 +19655-60-8 6-ethylquinoline 178550 375.69 +19780-39-3 3-ethyl-2-heptanol -391880 538.41 +19780-41-7 3-ethyl-3-heptanol -390070 518.59 +19780-44-0 4-ethyl-3-hexanol -371240 499.46 +19780-63-3 2-methyl-3-ethyl-2-pentanol -374710 470.11 +19780-66-6 2-methyl-3-ethyl-1-pentene -100700 440.58 +19780-67-7 2-methyl-3-ethyl-2-pentene -105500 470.53 +19781-10-3 2,3-dimethyl-3-octanol -415990 548.02 +19781-11-4 2,7-dimethyl-4-octanol -417800 567.84 +19781-13-6 4,7-dimethyl-4-octanol -415990 548.02 +19781-24-9 3,3-dimethyl-2-pentanol -354070 431.16 +19781-27-2 6-ethyl-3-octanol -412520 577.37 +19781-63-6 4-ethyl-trans-2-hexene -99800 440.48 +19781-68-1 1-methyl-cis-2-ethylcyclopropane -19500 377.47 +19781-69-2 1-methyl-trans-2-ethylcyclopropane -23500 364.05 +19781-73-8 heptadecylcyclohexane -463730 1021.4 +19812-64-7 1,14-tetradecanediol -636750 803.12 +19841-72-6 2,2-dimethyl-3-octanol -415990 548.02 +19902-98-8 1,cis-3-dimethyl-trans-2-ethylcyclopentane -209290 371.43 +19902-99-9 1,trans-3-dimethyl-cis-2-ethylcyclopentane -209290 371.43 +19903-00-5 1,cis-3-dimethyl-cis-2-ethylcyclopentane -209290 371.43 +19907-40-5 1,trans-2,trans-3,cis-4-tetramethylcyclopentane -229630 329.07 +19961-27-4 ethylisopropylamine -105300 358.56 +20024-90-2 1-ethyl-4-propylbenzene -43100 473.33 +20024-91-3 1-ethyl-3-propylbenzene -43300 479.7 +20038-12-4 4-bromo-2-methyl-1-butene -4560 393.05 +20150-89-4 5,7-dimethylquinoline 167080 369.52 +20184-89-8 3-nonyne 43210 478.32 +20193-20-8 1-ethylpropylamine -112700 390.66 +20193-58-2 molybdenum (III) fluoride -607100 296.07 +20237-34-7 1,trans-3-hexadiene 75480 378.53 +20278-84-6 2,4,5-trimethylheptane -260540 518.59 +20278-85-7 2,3,5-trimethylheptane -260540 518.59 +20278-87-9 3,3,4-trimethylheptane -256560 515.1 +20278-88-0 3,4,4-trimethylheptane -256560 515.1 +20278-89-1 3,4,5-trimethylheptane -252840 518.59 +20281-00-9 cesium oxide -92050 318.25 +20291-60-5 methyl hexyl sulfide -142400 490.47 +20291-61-6 methyl heptyl sulfide -163000 529.63 +20291-91-2 3-ethyl-2,2-dimethylhexane -258950 505.95 +20291-95-6 2,2,5-trimethylheptane -271750 505.95 +20294-76-2 1,2-octadecanediol -724590 949.4 +20309-77-7 1,1,cis-3,cis-4-tetramethylcyclopentane -194050 440.96 +20327-65-5 trans-1-fluoro-1-propene -184140 297.97 +20352-67-4 ethylhexylamine -154980 508.29 +20395-24-8 1,1-dichlorooctane -253900 543.35 +20395-25-9 1,1,3-trichloropropane -157750 363.6 +20487-40-5 tert-butyl propanoate -521700 479.9 +20488-34-0 2-methyl-cis-3-heptene -98200 445.85 +20548-54-3 calcium sulfide 123600 232.59 +20592-10-3 2-ethyl-1-octanol -407240 586.89 +20619-16-3 germanium (II) oxide -46200 224.22 +20654-44-8 2,3-dimethylbutanenitrile -19800 386.47 +20654-46-0 2,2-dimethylbutanenitrile -26200 379.76 +20667-05-4 2-methyl-1,2-pentanediol -495200 402.92 +20668-26-2 3,6-dimethylquinoline 167080 369.52 +20668-28-4 3,7-dimethylquinoline 167080 369.52 +20668-29-5 3,8-dimethylquinoline 167080 369.52 +20668-30-8 5,6-dimethylquinoline 167080 369.52 +20668-33-1 6,7-dimethylquinoline 167080 369.52 +20669-04-9 3,3-dimethyl-2-pentanone -309140 416.5 +20687-01-8 1-iodo-2-methyl-1-propene 58410 356.69 +20710-38-7 3-methyl-trans-2-hexene -84500 404.11 +20748-86-1 2,4-heptanediol -517800 461.19 +20816-12-0 osmium tetroxide -337200 294.39 +20843-07-6 3,4-dimethylfuran -97900 336.61 +20901-21-7 disulfur oxide -56480 267.02 +21020-26-8 3-ethyl-1-pentyne 96800 397.96 +21020-27-9 4-methyl-2-pentyne 97500 361.16 +21035-44-9 ethyl-sec-butylamine -124000 404.02 +21078-72-8 3-methyl-3-nonanol -410710 557.54 +21101-88-2 3-methylpentanenitrile -14300 398.88 +21102-09-0 4,4-dimethyl-3-ethyl-2-pentanol -400630 499.54 +21102-13-6 2,3,4-trimethyl-2-hexanol -400630 499.54 +21109-95-5 barium sulfide 37780 249.39 +21129-09-9 1,2-tetradecanediol -642030 793.59 +21255-83-4 bromine dioxide 151960 271.12 +21308-80-5 bromine oxide 107650 290.83 +21351-79-1 cesium hydroxide -259410 254.86 +21508-07-6 2,3-heptanediol -515800 467.9 +21531-91-9 1,3-hexanediol -482700 462.55 +21542-96-1 dimethyldocosylamine -471160 1106.9 +21570-35-4 2-methyl-4-heptanol -371240 499.46 +21571-91-5 3,3-dichloropentane -186760 378.73 +21651-19-4 tin (II) oxide 15100 232.58 +21895-13-6 2',3"-dimethyldiphenylmethane 101000 527.88 +21895-16-9 3',4"-dimethyldiphenylmethane 97190 515.11 +21895-17-0 2',4"-dimethyldiphenylmethane 101000 527.88 +21908-53-2 mercury (II) oxide 41840 239.04 +21968-17-2 propylisopropylamine -126000 397.31 +22025-20-3 3,3-dimethyl-2-hexanol -374710 470.11 +22037-73-6 3-bromo-1-butene 20590 348.73 +22331-38-0 eicosylcyclopentane -498850 1079.4 +22349-03-7 nonadecylcyclohexane -505010 1099.3 +22417-45-4 4-methyl-2-isobutyl-1-pentanol -468330 565.86 +22438-39-7 methyl decyl sulfide -224900 647.42 +22539-65-7 1,2-dimethyl-3-isopropylbenzene -49600 455.89 +22663-64-5 3-methyl-1-nonanol -407240 586.89 +22768-17-8 3-methyl-cis-3-heptene -105300 442.53 +22768-18-9 3-methyl-trans-3-heptene -105300 442.53 +22768-19-0 3-methyl-cis-2-heptene -105300 442.53 +22768-20-3 3-methyl-trans-2-heptene -105300 442.53 +23009-73-6 1-chloro-2-methyl-trans-2-butene -54840 373.45 +23009-74-7 1-chloro-2-methyl-cis-2-butene -54840 373.45 +23010-04-0 1,2-dichloro-2-methylbutane -186760 378.73 +23010-05-1 1,1-dichloro-2-methylbutane -188570 398.56 +23010-07-3 1,3-dichloro-2-methylbutane -188570 398.56 +23068-94-2 3-bromo-cis-2-pentene -12770 391.07 +23068-95-3 4-bromo-trans-2-pentene -8260 385.7 +23074-36-4 2-bromo-1-butene 16080 354.1 +23079-20-1 1,16-hexadecanediol -678030 881.02 +23171-85-9 2,3,3-trimethyl-2-pentanol -378180 440.77 +23361-67-3 2,2-dimethylpropyl formate -465000 417.94 +23361-69-5 2,2-dimethylpropyl butanoate -562700 531.71 +23412-45-5 molybdenum (IV) fluoride -947680 329.04 +23418-37-3 4-methyl-4-octanol -390070 518.59 +23418-38-4 4-methyl-4-nonanol -410710 557.54 +23425-81-2 1-fluoro-3-methyl-2-butene -235210 371.72 +23433-04-7 1,3-heptanediol -503500 500.97 +23433-05-8 1,3-octanediol -518190 559.88 +23511-78-6 1,1,3-tribromopropane -31540 416.47 +23646-57-3 erythro-4,4-dimethyl-2,3-pentanediol -516800 455.02 +23646-58-4 threo-4,4-dimethyl-2,3-pentanediol -511580 472.53 +23777-80-2 hexaborane 94600 +24094-93-7 chromium nitride 505010 230.73 +24270-66-4 1,1,2,3,3-pentafluoropropane -1253200 396.82 +24298-08-6 2-iodo-trans-2-butene 58410 356.69 +24298-09-7 2-iodo-cis-2-butene 58410 356.69 +24304-00-5 aluminum nitride 523000 228.58 +24308-61-0 2-iodo-1-butene 66620 358.67 +24319-08-2 3-iodo-3-methylpentane -99050 406.46 +24319-07-1 2-iodo-3-methylpentane -100860 426.28 +24319-09-3 2-chloro-3-methylpentane -193470 404.09 +24346-53-0 1-iodo-3-methylpentane -95580 435.81 +24356-00-1 3-chloro-1-pentene -42120 370.06 +24443-15-0 1,3-dibromo-3-methylbutane -102620 413.98 +24448-19-9 3-ethyl-2-hexanol -371240 499.46 +24556-56-7 2-iodo-3,3-dimethylbutane -104330 396.94 +24608-84-2 5-methyl-cis-2-heptene -95100 456.24 +24608-85-3 5-methyl-trans-2-heptene -100100 439.47 +24621-18-9 zirconium tribromide -430950 371.72 +24646-85-3 vanadium nitride 523000 232.26 +24768-42-1 butyl pentyl sulfide -187950 572.64 +24768-43-2 propyl hexyl sulfide -187150 572.67 +24768-44-3 ethyl heptyl sulfide -187020 571.4 +24768-46-5 propyl heptyl sulfide -207780 611.82 +24892-49-7 2,4-dimethyl-2,4-pentanediol -531800 378.81 +24893-35-4 2,3-dimethyl-1,3-butanediol -497400 403.72 +25154-52-3 nonylphenol -291000 674.49 +25265-71-8 dipropylene glycol -628000 512.34 +25276-70-4 1-pentadecanethiol -315100 808.06 +25339-17-7 isodecanol -409000 587.9 +25346-31-0 3-bromo-3-methylpentane -149590 401.89 +25346-32-1 2-chloro-4-methylpentane -193470 404.09 +25346-33-2 1-bromo-2-methylpentane -146120 431.24 +25419-06-1 methylpentylamine -107500 451.18 +25607-16-3 1-methyl-2-ethylnaphthalene 69000 456.09 +25658-42-8 zirconium nitride 713370 233.62 +26143-08-8 trans-1-iodo-1-nonene -35000 555.61 +26153-88-8 dimethylpentylamine -120280 444.75 +26153-91-3 methyl-2,2-dimethylpropylamine -124300 385.31 +26158-99-6 ethyl pentyl sulfide -145810 493.19 +26185-83-1 1-tetratriacontyne -453190 1449.9 +26186-00-5 1-heptadecyne -103700 800.9 +26186-01-6 1-nonadecyne -145000 879.55 +26186-02-7 1-tridecyne -21000 643.95 +26288-16-4 1,1,1-trifluorodecane -846810 601.74 +26356-06-9 2-bromo-3,3-dimethylbutane -154870 392.36 +26423-60-9 3-chloro-cis-2-pentene -54840 373.45 +26423-61-0 3-chloro-trans-2-pentene -54840 373.45 +26423-63-2 4-chloro-cis-2-pentene -50330 368.08 +26438-26-6 1-nonylnaphthalene -47500 698.42 +26438-27-7 1-decylnaphthalene -80000 703.4 +26438-28-8 1-dodecylnaphthalene -124000 775 +26490-07-3 2-isobutylnaphthalene 51300 509.67 +26519-91-5 methylcyclopentadiene 100000 319.02 +26533-31-3 2-methyl-4-nonanol -412520 577.37 +26533-33-5 2-methyl-3-nonanol -412520 577.37 +26533-34-6 2-methyl-3-octanol -391880 538.41 +26533-35-7 3-methyl-4-octanol -391880 538.41 +26533-36-8 2-nonadecanol -593000 973.82 +26718-82-1 heneicosylcyclohexane -546290 1177.2 +26761-40-0 diisodecyl phthalate -1060100 1224.5 +26817-31-2 1-nitrotridecane -322410 742.67 +26825-83-2 1-iodoheptadecane -317340 873.81 +26981-81-7 diethylheptylamine -202840 600.56 +26981-98-6 7-methyl-4-nonanol -412520 577.37 +27370-94-1 cis-1-iodo-1-nonene -35000 555.61 +27424-87-9 1-methyl-4-ethylnaphthalene 69000 456.09 +27522-11-8 2-ethyl-1-pentanol -345320 470.03 +27554-26-3 diisooctyl phthalate -967000 1032 +27563-68-4 methyl hexadecyl sulfide -348700 882.68 +27574-98-7 2,3,4,5,6-pentamethylheptane -295400 557.59 +27644-49-1 3-methyl-2-octanol -391880 538.41 +27802-85-3 3,4,7-trimethylnonane -299700 603.88 +27831-13-6 4-ethenyl-1,2-dimethylbenzene 89290 422.16 +27911-72-4 tritetradecylamine -842680 1808.1 +28028-91-3 cis-1-fluoro-1-heptene -266700 453.78 +28028-92-4 trans-1-fluoro-1-heptene -266700 453.78 +28122-24-9 3-ethyldiphenylmethane 112300 533.49 +28122-25-0 2-ethyldiphenylmethane 112300 533.49 +28122-27-2 3',5'-dimethyldiphenylmethane 101000 527.88 +28122-28-3 2',4'-dimethyldiphenylmethane 101000 527.88 +28122-29-4 2',2"-dimethyldiphenylmethane 101000 527.88 +28148-04-1 1,3-dibromo-2-methylpropane -78510 404.38 +28303-42-6 dodecyl formate -593400 723.2 +28467-75-6 2-tridecyne -39350 634.13 +28623-46-3 nonadecanenitrile -270610 902.2 +28947-77-5 trihexadecylamine -966520 2041.8 +29044-06-2 2-methyl-2,5-hexanediol -536300 381.43 +29136-19-4 nonadecylbenzene -322800 1023.4 +29369-63-9 methyltetradecylamine -299460 780.96 +29394-58-9 1-iodo-2-methylbutane -74940 396.86 +29443-50-3 2,2-diiodobutane 19100 384.17 +29488-27-5 3-isopropylthiophene 37080 380.34 +29559-52-2 1,1,2-trichloro-2-methylpropane -187140 363.68 +29559-54-4 1,1-dichloro-2,2-dimethylpropane -192040 369.21 +29559-55-5 1,3-dichloro-2,2-dimethylpropane -186760 378.73 +29576-14-5 1-bromo-trans-2-butene 17660 356.28 +29664-53-7 methylpentadecylamine -320100 819.91 +29703-52-4 2-eicosanone -569600 969.83 +29772-40-5 2,2,3-trimethyl-3-heptanol -419460 518.67 +29833-69-0 2-methyl-1-pentadecene -257930 770.48 +29843-62-7 2-methyl-5-nonanol -412520 577.37 +29887-11-4 2-ethyl-1,3-pentanediol -499400 690.4 +30122-12-4 1,3-dichloropentane -183290 408.08 +30213-29-7 3,cis-5-dimethylcyclopentene -18700 354.03 +30310-22-6 2-bromo-4-methylpentane -151400 421.71 +30388-40-0 3-methyl-4-propylphenol -201980 459.41 +30427-51-1 diethyloctadecylamine -429880 1029 +30540-31-9 1-bromo-2,3-dimethylbutane -149590 401.89 +30749-25-8 3-isobutylphenol -195790 456.05 +30951-88-3 diethylhexadecylamine -388600 951.13 +31032-94-7 2-methyl-3-ethylnaphthalene 65770 458.64 +31241-42-6 1-nitrotetradecane -343050 781.63 +31294-91-4 3-iodohexane -95580 435.81 +31294-94-7 1-iodo-2-methylpentane -95580 435.81 +31294-95-8 2-iodo-2-methylpentane -99050 406.46 +31294-96-9 2-iodo-4-methylpentane -100860 426.28 +31294-97-0 3-iodo-2-methylpentane -100860 426.28 +31294-98-1 1-iodo-2,2-dimethylbutane -95580 435.81 +31295-00-8 1-iodo-2,3-dimethylbutane -99050 406.46 +31366-00-4 1,2,3-trimethyl-5-ethylbenzene -59800 462.6 +31367-46-1 3-methyl-2-heptanol -371240 499.46 +31805-48-8 3-methyl-2-ethylthiophene 30890 383.69 +31807-55-3 2-methylundecane -297800 617.96 +31841-77-7 5,5-dimethyl-2-hexanol -374710 470.11 +31844-95-8 2-bromo-1-pentene -4560 393.05 +31844-96-9 2-bromo-3-methyl-1-butene -9840 383.52 +31849-75-9 cis-1-bromo-1-pentene -2980 395.23 +31849-76-0 trans-1-bromo-1-pentene -2980 395.23 +31849-78-2 cis-1-bromo-1-butene 17660 356.28 +31950-55-7 4-bromo-3-methyl-1-butene -50 387.68 +31950-56-8 4-bromo-1-pentene -50 387.68 +32018-76-1 2,5-dimethyl-4-ethylphenol -213450 453.24 +32114-79-7 2-methyl-1-isopropylnaphthalene 51300 509.67 +32341-91-6 3-methyl-1,1-diphenylethane 103600 512.49 +32341-92-7 2-methyl-1,1-diphenylethane 103600 512.49 +32442-47-0 2-iodo-3-methyl-1-butene 40700 388.1 +32444-34-1 3-methyl-2-ethyl-1-butanol -350600 460.51 +32620-08-9 trans-1-bromo-1-butene 17660 356.28 +32812-23-0 2,2-dimethyl-1,4-butanediol -481200 458.06 +32814-16-7 cis-1-fluoro-1-octene -287340 492.73 +32814-17-8 trans-1-fluoro-1-octene -287340 492.73 +32970-37-9 3,4-dimethyltetrahydrofuran -259030 245.63 +33234-93-4 7-methyl-1-nonanol -407240 586.89 +33653-28-0 butyl methyl sulfite -559500 +33673-01-7 2-sec-butyl-1,3-propanediol -490800 551.75 +33693-78-6 1,1-dibromo-2-methylpropane -83790 394.85 +33698-87-2 cis-3-pentenoic acid -369100 432.47 +33879-72-0 3-methyl-1,3-pentanediol -495200 402.92 +33933-77-6 7-methyl-4-octanol -391880 538.41 +33933-78-7 5-methyl-5-nonanol -410710 557.54 +33933-79-8 2,4-dimethyl-4-octanol -415990 548.02 +33943-21-4 2-methyl-4-ethyl-3-hexanol -397160 528.89 +34014-79-4 1,3-hexadecanediol -683310 871.5 +34075-28-0 2-nitro-2,3-dimethylbutane -191960 421.61 +34317-39-0 methyl-1,2-dimethylpropylamine -122000 410.73 +34403-05-9 2-methyl-1,2-diphenylethane 112300 533.49 +34403-06-0 3-methyl-1,2-diphenylethane 112300 533.49 +34570-59-7 1,1,2,2-tetrabromopropane -13960 428.65 +34581-76-5 1,1,2,3-tetrabromopropane -10490 458 +34715-98-5 1-nitro-2,2-dimethylpropane -166040 392.18 +34887-14-4 2,2-dichloropentane -186760 378.73 +34949-22-9 1,1-dimethylpropyl propanoate -558700 486.85 +34994-81-5 1-iodoeicosane -379260 990.67 +35073-27-9 2-methylbutyl formate -454500 442.76 +35161-70-7 methylhexylamine -134340 469.34 +35399-81-6 2-amino-3-methylpentane -145500 417.04 +35551-81-6 dipentadecylamine -609060 1365.2 +35599-77-0 1-iodotridecane -234780 718 +35599-78-1 1-iodopentadecane -276060 795.9 +35866-89-8 2,6-dimethyl-4-isopropylheptane -307600 570.67 +35866-96-7 2,4,4,7-tetramethyloctane -309400 573.35 +35895-39-7 3-iodo-cis-2-pentene 37770 395.64 +35902-57-9 ethyldodecylamine -278820 742 +36186-96-6 3-methyl-5-propylphenol -201980 459.41 +36301-29-8 1-methyl-2-isobutylbenzene -47400 472.32 +36343-05-2 methylheptylamine -154980 508.29 +36555-73-4 diethylpentadecylamine -367960 912.18 +36566-80-0 2-methyl-3-hexyne 74600 407.02 +36653-82-4 1-hexadecanol -522500 832.54 +36668-55-0 cis-1-bromo-2-methyl-1-butene -12770 391.07 +36794-64-6 2,3,3-trimethyl-1-butanol -354070 431.16 +36839-67-5 methyl 1-ethylpropyl ether -289900 411.83 +36880-72-5 3-ethyl-cis-2-hexene -104000 446.89 +37549-89-6 2,4-dimethyl-cis-3-hexene -108500 439.98 +37796-58-0 1,4-diethylnaphthalene 51300 509.67 +37810-94-9 1,4-decanediol -559470 637.78 +38146-95-1 1,4-dodecanediol -600750 715.69 +38169-04-9 1-iodo-trans-2-butene 68200 360.85 +38300-67-3 1,2,4-tribromobutane -52180 455.43 +38384-05-3 3-chloro-2-methylpentane -193470 404.09 +38395-42-5 4-ethyl-4-octanol -410710 557.54 +38514-02-2 3-methyl-1-octanol -386600 547.94 +38514-03-3 4-methyl-1-octanol -386600 547.94 +38514-04-4 5-methyl-1-octanol -386600 547.94 +38514-05-5 6-methyl-1-octanol -386600 547.94 +38514-15-7 3-isopropyl-1-heptanol -412520 577.37 +38836-25-8 4-methyl-2,4-hexanediol -506300 482.05 +38842-05-6 1,2,3,5-tetraethylbenzene -122840 587.44 +39036-65-2 1-methyl-2-propylnaphthalene 51300 509.67 +39093-27-1 methylnonylamine -196260 586.19 +39198-07-7 methylethylisopropylamine -110100 378.9 +39220-65-0 1-nitropentadecane -363690 820.58 +39220-66-1 1-nitroheptadecane -404970 898.48 +39497-66-0 2-isopropyl-1,4-butanediol -492800 545.04 +39516-24-0 1,3-dodecanediol -600750 715.69 +39616-19-8 1-bromo-cis-2-butene 17660 356.28 +39622-45-2 1,3-dimethyl-6-ethylnaphthalene 51300 509.67 +39761-57-4 3,4,4-trimethyl-trans-2-pentene -111700 411.53 +39761-61-0 5,5-dimethyl-cis-2-hexene -108400 393.93 +39761-64-3 3,4,4-trimethyl-cis-2-pentene -93700 471.91 +39782-43-9 5,5-dimethyl-trans-2-hexene -113400 377.16 +39825-93-9 1,2-eicosanediol -765870 1027.3 +39924-57-7 cis-1-bromo-1-heptene -44260 473.13 +39924-58-8 cis-1-bromo-1-nonene -85540 551.04 +40117-45-1 2,2,6,6-tetramethylheptane -305000 507.37 +40225-75-0 6-methyl-3-octanol -391880 538.41 +40243-75-2 2,3-dimethylstyrene 89290 422.16 +40276-93-5 3-methyl-1-hexyne 96500 401.65 +40289-98-3 methyl octadecyl sulfide -389900 961.66 +40323-88-4 2-methyl-5-ethyl thiophene 30890 383.69 +40575-41-5 2-methyl-4-octanol -391880 538.41 +40589-14-8 2-methyl-1-nonanol -407240 586.89 +40646-07-9 1,4-heptanediol -503500 500.97 +40723-63-5 1,1,2,2-tetrafluoropropane -903720 351.24 +40775-09-5 heneicosylbenzene -364080 1101.3 +40813-84-1 butyl heptyl sulfide -229160 650.84 +41004-19-7 1-iodo-3-methyl-2-butene 37770 395.64 +41051-72-3 2-methyl-1,2-butanediol -480000 345.72 +41065-95-6 3-ethyl-1-hexanol -365960 508.99 +41593-56-0 phosphorus trifluoroborane -854000 +41781-17-3 1-amino-2,2-dimethylbutane -144800 393.49 +41909-29-9 3-fluoropentane -347920 372.93 +41927-66-6 eicosyl butanoate -856500 1151.9 +41947-84-6 ethyl octadecyl sulfide -413760 1001.3 +42007-73-8 2,7-dimethyl-2-octanol -415990 548.02 +42067-48-1 4-methyl-3-ethyl-cis-2-pentene -101200 464.46 +42067-49-2 4-methyl-3-ethyl-trans-2-pentene -100300 467.48 +42131-85-1 2-chloro-1-pentene -46630 375.42 +42131-98-6 2-chloro-cis-2-pentene -54840 373.45 +42132-00-3 2-chloro-trans-2-pentene -54840 373.45 +42202-42-6 2-nitro-3-methylpentane -188490 450.96 +42217-02-7 1-chloroeicosane -474890 958.34 +42217-03-8 1-chlorodocosane -514890 1040.5 +42245-37-4 1-amino-3-methylpentane -137700 435.01 +42328-76-7 2,4-dimethyl-2-hexanol -374710 470.11 +42474-20-4 1,3-dibromopentane -99150 443.33 +42599-17-7 trans-1-iodo-1-octene -14360 516.66 +42764-74-9 2-methyl-1-heptadecene -299210 848.38 +42789-13-9 1,2-nonanediol -538830 598.83 +42841-80-5 propyl pentyl sulfide -166570 533.62 +42843-49-2 cis-1-bromo-1-octene -64900 512.09 +42856-62-2 2-methyl-1,5-pentanediol -474100 499.58 +42875-41-2 tridecyl formate -614100 762.69 +42910-16-7 triundecylamine -656920 1457.5 +44979-90-0 diethylhexylamine -182200 561.61 +45124-35-4 diethylnonylamine -244120 678.47 +45165-81-9 methyltridecylamine -278820 742 +45275-74-9 dimethyleicosylamine -429880 1029 +45313-33-5 hexatriacontylamine -752580 1609.9 +45324-58-1 trieicosylamine -1214200 2509.2 +49542-74-7 2,4,8-trimethylnonane -308500 594.49 +49557-09-7 2,5,8-trimethylnonane -309100 595.16 +49598-54-1 2,2-dimethyldodecane -341040 662.46 +49623-50-9 1,3-dibromo-2-methylbutane -104430 433.81 +49859-87-2 dimethylnonadecylamine -409240 990.08 +50273-84-2 5-bromo-cis-2-pentene -2980 395.23 +50341-35-0 2,2-dibromobutane -81980 375.03 +50422-80-5 5-methyl-cis-3-heptene -96500 451.55 +50468-22-9 3-methyl-1,2-butanediol -472000 398.45 +50586-18-0 cis-1-chloro-1-hexene -65690 416.56 +50586-19-1 trans-1-chloro-1-hexene -65690 416.56 +50623-57-9 butyl nonanoate -627400 719.51 +50715-02-1 triacontylbenzene -549840 1451.9 +50876-33-0 1,1,3,3-tetramethylcyclopentane -158470 552.85 +51065-65-7 6-methyl-trans-2-heptene -101500 434.78 +51079-52-8 4,6-dimethyl-2-heptanol -397160 528.89 +51079-79-9 4,6,6-trimethyl-2-heptanol -421270 538.49 +51115-64-1 2-methylbutyl butanoate -552200 556.53 +51116-73-5 1-bromo-3-methylpentane -146120 431.24 +51200-80-7 4-methyl-3-ethyl-3-hexanol -395350 509.07 +51200-81-8 2-methyl-3-isopropyl-3-hexanol -471800 536.51 +51200-82-9 4-isopropyl-4-heptanol -415990 548.02 +51200-83-0 2,4-dimethyl-3-isopropyl-3-pentanol -477080 526.99 +51525-97-4 1,1,3,3-tetrabromopropane -10490 458 +51750-65-3 2,2,4,4-tetramethylhexane -257320 486.43 +51751-87-2 trans-1-bromo-1-octene -64900 512.09 +51872-48-1 3-bromo-2-methyl-1-butene -9840 383.52 +51891-58-8 2,2-difluoro-3-methylbutane -552780 365.76 +51932-19-5 methyl-1-methylbutylamine -118300 423.14 +52112-25-1 2-pentadecyne -80630 712.03 +52254-38-3 2-methyl-1-tetradecene -237290 731.53 +52254-50-9 2-methyl-1-nonadecene -340490 926.29 +52315-44-3 1-octylcyclopentene -144300 +52317-98-3 methyl-3-methylbutylamine -114200 436.89 +52356-93-1 cis-1-iodo-1-octene -14360 516.66 +52644-81-2 1-iodohexacosane -503100 1224.4 +52663-48-6 octadecyl propanoate -792900 1033.4 +52670-32-3 2,3,5,6-tetramethylheptane -283800 541.92 +52670-33-4 2,3,3,4,5-pentamethylhexane -266700 512.06 +52670-34-5 2,3,6,7-tetramethyloctane -305200 581.74 +52670-35-6 2,3,3,5,6-pentamethylheptane -300300 563.96 +52670-36-7 2,3,3,4,4,5-hexamethylhexane -272500 519.36 +52688-75-2 3-fluorohexane -368560 411.89 +52688-89-8 1,1,2,2-tetramethylcyclopentane -158470 552.85 +52713-81-2 4-methyl-1-hexyne 93900 402.66 +52812-57-4 cis-1-iodo-2-methyl-1-butene 37770 395.64 +52841-28-8 methylethyl-tert-butylamine -129030 405.88 +52896-87-4 4-isopropylheptane -251120 522.95 +52896-88-5 4-ethyl-2-methylheptane -258240 528.69 +52896-89-6 4-ethyl-3-methylheptane -250500 531.64 +52896-90-9 3-ethyl-5-methylheptane -255390 528.69 +52896-91-0 3-ethyl-4-methylheptane -250500 528.69 +52896-92-1 2,2,3-trimethylheptane -261830 505.98 +52896-93-2 2,3,3-trimethylheptane -259450 509.2 +52896-95-4 2,3,4-trimethylheptane -255680 518.59 +52896-99-8 4-ethyl-2,2-dimethylhexane -260960 500.05 +52897-00-4 3-ethyl-2,3-dimethylhexane -254180 515.07 +52897-01-5 4-ethyl-2,3-dimethylhexane -252840 515.64 +52897-03-7 4-ethyl-2,4-dimethylhexane -256190 509.17 +52897-04-8 3-ethyl-2,5-dimethylhexane -260540 515.64 +52897-05-9 4-ethyl-3,3-dimethylhexane -253680 509.17 +52897-06-0 3-ethyl-3,4-dimethylhexane -251290 515.07 +52897-08-2 2,2,3,4-tetramethylhexane -253340 495.72 +52897-09-3 2,2,3,5-tetramethylhexane -268990 492.9 +52897-10-6 2,3,3,4-tetramethylhexane -253800 502.02 +52897-11-7 2,3,3,5-tetramethylhexane -258700 496.26 +52897-12-8 2,3,4,4-tetramethylhexane -250960 502.02 +52897-15-1 2,3,4,5-tetramethylhexane -258030 499.78 +52897-16-2 3,3-diethyl-2-methylpentane -248910 500.05 +52897-17-3 3-ethyl-2,2,3-trimethylpentane -252590 492.2 +52897-18-4 3-ethyl-2,2,4-trimethylpentane -253340 486.46 +52897-19-5 3-ethyl-2,3,4-trimethylpentane -251420 496.26 +53045-71-9 3-bromo-1-pentene -50 387.68 +53119-51-0 2-methyl-3-ethylthiophene 30890 383.69 +53120-74-4 3,3-dimethyl-1,5-pentanediol -502000 488.29 +53121-23-6 1-iodo-cis-2-butene 68200 360.85 +53161-72-1 1,2-diiodobutane 11900 426.4 +53184-67-1 nonyl propanoate -606600 679.02 +53193-22-9 1-heptadecanethiol -356300 886.7 +53225-40-4 3,trans-4-dimethylcyclopentene -11700 363.08 +53268-66-9 cis-1-chloro-1-heptene -86330 455.51 +53268-67-0 trans-1-chloro-1-heptene -86330 455.51 +53310-02-4 2-amino-2-methylpentane -157100 352.24 +53392-86-2 1,1,1-trifluorooctane -805530 523.83 +53434-74-5 trans-1-bromo-1-heptene -44260 473.13 +53434-75-6 trans-1-bromo-1-nonene -85540 551.04 +53510-18-2 5-methyl-trans-3-heptene -101500 434.78 +53543-44-5 5-chloro-cis-2-pentene -45050 377.6 +53566-37-3 5-methyl-2-hexyne 74400 401.99 +53594-82-4 2,2-dimethylheptadecane -444240 857.22 +53731-22-9 1,1-difluoro-3-methylbutane -549310 395.1 +53731-23-0 1,1-difluoro-2,2-dimethylpropane -552780 365.76 +53731-24-1 3-fluoro-2-methyl-1-butene -232280 364.17 +53731-25-2 2,3-difluoro-2-methylbutane -552780 365.76 +53750-52-0 4-iodo-2-methyl-1-butene 45980 397.62 +53774-20-2 2-methyl-3-butenoic acid -362200 438.24 +53778-43-1 1-methyl-1-ethylcyclopropane -20000 375.79 +53897-51-1 3,4-dimethyl-2-thiapentane -136700 429.25 +53939-51-8 nonadecyl acetate -795600 1033.1 +53971-47-4 2,2,3-trimethylthiacyclopropane -21210 +54004-41-0 4-methyl-2-propyl-1-pentanol -341350 540.39 +54004-43-2 1-methylbutyl propanoate -541700 515.03 +54068-75-6 cis-1-iodo-1-butene 68200 360.85 +54105-66-7 undecylcyclohexane -358400 736.04 +54166-32-4 2,6,6-trimethyloctane -289100 546.61 +54265-17-7 trans-1-bromo-2-methyl-1-butene -12770 391.07 +54268-02-9 1,2,2,3-tetrabromopropane -8680 438.17 +54287-41-1 3-amino-2-methylpentane -145500 417.04 +54334-64-4 diethylundecylamine -285400 756.37 +54549-80-3 1,1-dimethyl-2-ethylcyclopentane -173710 483.32 +54616-49-8 4-ethyl-cis-2-hexene -99800 440.48 +54630-50-1 5-methyl-2-heptanol -371240 499.46 +54630-82-9 dl-2,4-dimethyl-1,5-pentanediol -498600 525.59 +54653-26-8 2,2-dibromopentane -102620 413.98 +54653-27-9 3,3-dibromopentane -102620 413.98 +54653-28-0 3-bromo-trans-2-pentene -12770 391.07 +54653-29-1 2-bromo-cis-2-pentene -12770 391.07 +54653-30-4 2-bromo-trans-2-pentene -12770 391.07 +54774-89-9 2-methyl-1-propylnaphthalene 51300 509.67 +54877-00-8 5-methyl-2,4-hexanediol -508110 501.87 +55073-86-4 2,2,5,5-tetramethyl-3-hexanol -424740 509.14 +55268-63-8 1,1-diphenyltetradecane -147000 +55499-04-2 2,2,3-trimethylnonane -303600 580.73 +55505-23-2 2,2,3-trimethyl-1-butanol -354070 431.16 +55505-24-3 4-methyl-2-isopropyl-1-pentanol -447690 526.91 +55517-75-4 tritriacontylcyclohexane -793970 1644.6 +55757-34-1 1,1,1-trifluorononane -826170 562.79 +55930-45-5 1,4-diiodopentane 1930 452.47 +56039-55-5 3,cis-4-dimethylcyclopentene -4700 360.73 +56065-42-0 3,5-dimethyl-3-octanol -415990 548.02 +56065-43-1 4,6-dimethyl-4-octanol -415990 548.02 +56134-53-3 1-chlorohexacosane -594890 1204.9 +56164-20-6 tridecyl butanoate -711700 876.46 +56255-50-6 2-methyl-1,2-hexanediol -516000 441.33 +56298-90-9 4-methyl-2-heptanol -371240 499.46 +56392-13-3 ethylpentadecylamine -340740 858.86 +56399-98-5 5-iodo-trans-2-pentene 47560 399.8 +56535-63-8 4-bromo-cis-2-pentene -8260 385.7 +57093-84-2 3-ethyl-2-thiapentane -129000 446.89 +57094-91-4 1-iodohentriacontane -606300 1419.1 +57233-31-5 2,2,4-trimethyl-4-heptanol -419460 518.67 +57253-29-9 1-bromo-2-methyl-cis-2-butene -12770 391.07 +57253-30-2 1-bromo-2-methyl-trans-2-butene -12770 391.07 +57303-85-2 dimethyl-2-pentylamine -125560 435.23 +57409-53-7 2,2,3-trimethyl-1-pentanol -374710 470.11 +57716-79-7 2-ethyl-1,4-butanediol -472100 506.29 +57757-60-5 dimethyl-1,1-dimethylpropylamine -129030 405.88 +58046-40-5 2,3,6-trimethyl-3-heptanol -421270 538.49 +58049-91-5 3,3-dimethylcyclopentene -21100 347.65 +58133-26-9 1,1-dibromohexane -119790 482.28 +58175-57-8 2-propyl-1-pentanol -365960 508.99 +58368-66-4 1-methylbutyl formate -466300 440.74 +58368-67-5 1-ethylpropyl formate -468000 442.76 +58795-24-7 5,6-dimethyl-2-heptanol -397160 528.89 +59006-05-2 1-fluoro-2,2-dimethylpropane -351390 343.59 +59104-79-9 1,1-dibromoheptane -140430 521.24 +59104-80-2 1,1-dibromodecane -202350 638.09 +59128-91-5 3-iodo-3-methyl-1-butene 47020 362.91 +59129-74-7 4,5-dimethylquinoline 167080 369.52 +59222-86-5 2,2-dimethyltetradecane -382320 740.37 +59562-82-2 3,3-dimethyl-1,2-butanediol -492000 421.83 +59570-04-6 ethylundecylamine -258180 703.05 +59570-06-8 ethyltridecylamine -299460 780.96 +59643-75-3 2,3-dimethyl-cis-3-hexene -111400 430.25 +59654-13-6 2-iodohexane -95580 435.81 +59734-23-5 5-methyl-4-octanol -391880 538.41 +59871-24-8 trans-1-chloro-1-octene -106970 494.46 +59967-14-5 4-iodo-1-pentene 50490 392.25 +59973-07-8 methyl nonyl sulfide -204300 607.93 +59973-08-9 ethyl nonyl sulfide -228240 649.43 +60186-78-9 3-tridecyne -39350 634.13 +60212-29-5 2-undecyne 1930 556.22 +60212-30-8 3-undecyne 1930 556.22 +60212-32-0 3-tetradecyne -59990 673.08 +60247-14-5 methylethylisobutylamine -125560 435.23 +60302-21-8 4-tert-butylheptane -272200 537.56 +60302-23-0 2,2,4,4,5-pentamethylhexane -275400 508.04 +60302-24-1 2,2,3,3,5,5-hexamethylhexane -296000 514.66 +60302-27-4 2,2,3,3,4,4-hexamethylpentane -253700 457.06 +60302-28-5 2,2-dimethyl-3,3-diethylpentane -242100 502.34 +60415-61-4 1-methylbutyl butanoate -564000 554.18 +60435-70-3 2-methyl-1-heptanol -365960 508.99 +60595-37-1 trans-1-iodo-1-heptene 6280 477.71 +60671-32-1 3-methyl-2-nonanol -412520 577.37 +60836-07-9 2,4,6-trimethyl-4-heptanol -421270 538.49 +60899-39-0 2-dodecylnaphthalene -124530 778.42 +61064-08-2 3,4-dimethyl-1-pentyne 86100 391.93 +61350-03-6 1,1-difluorooctane -624600 520.71 +61394-27-2 3,trans-5-dimethylcyclopentene -16700 354.03 +61827-85-8 1,3-dimethyl-4-propylbenzene -52700 476.68 +61827-86-9 1,2,3-trimethyl-4-ethylbenzene -52900 456.56 +61827-87-0 1,2,4-trimethyl-3-ethylbenzene -52200 456.89 +61827-90-5 heptacosylcyclopentane -643330 1352.1 +61827-91-6 octacosylcyclopentane -663970 1391 +61827-92-7 nonacosylcyclopentane -684610 1430 +61827-93-8 triacontylcyclopentane -705250 1468.9 +61827-94-9 hentriacontylcyclopentane -725890 1507.9 +61827-98-3 pentatriacontylcyclopentane -808450 1663.7 +61827-99-4 hexatriacontylcyclopentane -829090 1702.6 +61828-00-0 1-methyl-1-isopropylcyclopentane -158650 516.16 +61828-01-1 1-methyl-trans-2-isopropylcyclopentane -194230 404.27 +61828-02-2 1-methyl-cis-3-isopropylcyclopentane -194230 404.27 +61828-03-3 1-methyl-trans-3-isopropylcyclopentane -194230 404.27 +61828-04-4 tricosylbenzene -405360 1179.2 +61828-05-5 tetracosylbenzene -426000 1218.2 +61828-06-6 pentacosylbenzene -446640 1257.1 +61828-07-7 docosylcyclohexane -566930 1216.2 +61828-08-8 tricosylcyclohexane -587570 1255.1 +61828-09-9 tetracosylcyclohexane -608210 1294.1 +61828-10-2 pentacosylcyclohexane -628850 1333 +61828-11-3 hexacosylcyclohexane -649490 1372 +61828-12-4 heptacosylcyclohexane -670130 1410.9 +61828-13-5 octacosylcyclohexane -690770 1449.9 +61828-14-6 nonacosylcyclohexane -711410 1488.8 +61828-15-7 triacontylcyclohexane -732050 1527.8 +61828-17-9 dotriacontylcyclohexane -773330 1605.7 +61828-19-1 tetratriacontylcyclohexane -814610 1683.6 +61828-20-4 pentatriacontylcyclohexane -835250 1722.6 +61828-21-5 hexatriacontylcyclohexane -855890 1761.5 +61828-25-9 heptacosylbenzene -487920 1335 +61828-26-0 octacosylbenzene -508560 1374 +61828-27-1 nonacosylbenzene -529200 1412.9 +61828-32-8 pentatriacontylbenzene -653040 1646.6 +61828-33-9 hexatriacontylbenzene -673680 1685.6 +61828-34-0 1,4-tridecanediol -621390 754.64 +61828-35-1 dl-erythro-2,3-pentanediol -481000 368.26 +61828-36-2 dl-threo-2,3-pentanediol -481000 368.26 +61847-78-7 2,4-dimethyl-trans-3-hexene -108500 439.98 +61847-80-1 4-methyl-3-ethyl-1-pentene -93900 442.89 +61847-81-2 1-heneicosyne -184870 943.5 +61847-82-3 1-docosyne -205510 982.45 +61847-83-4 1-tricosyne -226150 1021.4 +61847-84-5 1-tetracosyne -246790 1060.4 +61847-85-6 1-pentacosyne -267430 1099.3 +61847-86-7 1-hexacosyne -288070 1138.3 +61847-87-8 1-heptacosyne -308710 1177.2 +61847-88-9 1-octacosyne -329350 1216.2 +61847-89-0 1-nonacosyne -349990 1255.1 +61847-90-3 1-triacontyne -370630 1294.1 +61847-91-4 1-hentriacontyne -391270 1333 +61847-92-5 1-dotriacontyne -411910 1372 +61847-93-6 1-tritriacontyne -432550 1410.9 +61847-94-7 1-pentatriacontyne -473830 1488.8 +61847-95-8 1-hexatriacontyne -494470 1527.8 +61847-96-9 2-heptadecyne -121910 789.94 +61847-97-0 2-octadecyne -142550 828.89 +61847-98-1 2-nonadecyne -163190 867.84 +61847-99-2 2-eicosyne -183830 906.79 +61868-01-7 1-methyl-cis-2-isopropylcyclopentane -194230 404.27 +61868-02-8 2,3-dimethylhexadecane -425410 838.09 +61868-03-9 2,3-dimethylheptadecane -446050 877.05 +61868-04-0 2,3-dimethyloctadecane -466690 916 +61868-05-1 2,4-dimethyltridecane -363490 721.24 +61868-06-2 2,4-dimethyltetradecane -384130 760.19 +61868-07-3 2,4-dimethylpentadecane -404770 799.14 +61868-08-4 2,4-dimethylhexadecane -425410 838.09 +61868-09-5 2,4-dimethylheptadecane -446050 877.05 +61868-10-8 2,4-dimethyloctadecane -466690 916 +61868-11-9 1-tritriacontene -599020 1436.8 +61868-12-0 1-tetratriacontene -619660 1475.8 +61868-13-1 1-pentatriacontene -640300 1514.7 +61868-14-2 1-hexatriacontene -660940 1553.7 +61868-19-7 2-methyl-1-hexadecene -278570 809.43 +61868-20-0 2-methyl-1-octadecene -319850 887.33 +61868-21-1 2,3-dimethyl-3-ethylheptane -273200 542.25 +61868-22-2 2,3-dimethyl-4-ethylheptane -272700 551.31 +61868-23-3 2,3-dimethyl-5-ethylheptane -279200 554.33 +61868-24-4 2,4-dimethyl-3-ethylheptane -266100 558.69 +61868-25-5 2,4-dimethyl-4-ethylheptane -276600 549.63 +61868-26-6 2,4-dimethyl-5-ethylheptane -277900 549.63 +61868-27-7 2,5-dimethyl-3-ethylheptane -278600 557.68 +61868-28-8 2,5-dimethyl-4-ethylheptane -277900 555.33 +61868-29-9 2,5-dimethyl-5-ethylheptane -283800 543.59 +61868-30-2 2,6-dimethyl-3-ethylheptane -281500 552.98 +61868-31-3 2,6-dimethyl-4-ethylheptane -285000 553.32 +61868-32-4 3,3-dimethyl-4-ethylheptane -265900 547.95 +61868-33-5 3,3-dimethyl-5-ethylheptane -277600 547.28 +61868-34-6 3,4-dimethyl-3-ethylheptane -270100 537.22 +61868-35-7 3,4-dimethyl-4-ethylheptane -270100 542.25 +61868-36-8 3,4-dimethyl-5-ethylheptane -269900 549.97 +61868-37-9 3,5-dimethyl-3-ethylheptane -274400 557.34 +61868-38-0 3,5-dimethyl-4-ethylheptane -263400 557.01 +61868-39-1 4,4-dimethyl-3-ethylheptane -265900 541.58 +61868-40-4 2,2,3,3-tetramethylheptane -279500 511.39 +61868-41-5 2,2,3,4-tetramethylheptane -275000 533.2 +61868-42-6 2,2,3,5-tetramethylheptane -286900 532.52 +61868-43-7 2,2,3,6-tetramethylheptane -289900 527.83 +61868-44-8 2,2,4,4-tetramethylheptane -277800 522.13 +61868-45-9 2,2,4,5-tetramethylheptane -284700 536.21 +61868-46-0 2,2,4,6-tetramethylheptane -291100 532.19 +61868-47-1 2,2,5,5-tetramethylheptane -299500 520.79 +61868-48-2 2,2,5,6-tetramethylheptane -294700 530.85 +61868-49-3 2,3,3,4-tetramethylheptane -271400 522.13 +61868-50-6 2,3,3,5-tetramethylheptane -277100 538.23 +61868-51-7 2,3,3,6-tetramethylheptane -286500 530.51 +61868-52-8 2,3,4,4-tetramethylheptane -271500 532.86 +61868-53-9 2,3,4,5-tetramethylheptane -273700 541.58 +61868-54-0 2,3,4,6-tetramethylheptane -281700 541.24 +61868-55-1 2,3,5,5-tetramethylheptane -282200 540.91 +61868-56-2 2,4,4,5-tetramethylheptane -271400 522.13 +61868-57-3 2,4,4,6-tetramethylheptane -281600 530.85 +61868-58-4 2,4,5,5-tetramethylheptane -282700 530.85 +61868-59-5 3,3,4,4-tetramethylheptane -272600 510.05 +61868-60-8 3,3,4,5-tetramethylheptane -268700 537.89 +61868-61-9 3,3,5,5-tetramethylheptane -272500 526.15 +61868-62-0 3,4,4,5-tetramethylheptane -268500 517.77 +61868-63-1 2,2-dimethyl-3-isopropylhexane -257900 525.82 +61868-64-2 2,3-dimethyl-3-isopropylhexane -262700 527.16 +61868-65-3 2,4-dimethyl-3-isopropylhexane -251900 534.87 +61868-66-4 2,5-dimethyl-3-isopropylhexane -275300 536.55 +61868-67-5 2-methyl-3,3-diethylhexane -259700 543.59 +61868-68-6 2-methyl-3,4-diethylhexane -263600 550.64 +61868-69-7 2-methyl-4,4-diethylhexane -271700 532.19 +61868-70-0 3-methyl-3,4-diethylhexane -259800 536.21 +61868-71-1 3-methyl-4,4-diethylhexane -256800 536.55 +61868-72-2 2,2,3-trimethyl-3-ethylhexane -266500 521.46 +61868-73-3 2,2,3-trimethyl-4-ethylhexane -272500 524.81 +61868-74-4 2,2,4-trimethyl-3-ethylhexane -255200 529.84 +61868-75-5 2,2,4-trimethyl-4-ethylhexane -272700 521.12 +61868-76-6 2,2,5-trimethyl-3-ethylhexane -278700 530.85 +61868-77-7 2,2,5-trimethyl-4-ethylhexane -284900 529.84 +61868-78-8 2,3,3-trimethyl-4-ethylhexane -261100 521.12 +61868-79-9 2,3,4-trimethyl-3-ethylhexane -259800 534.87 +61868-80-2 2,3,4-trimethyl-4-ethylhexane -265300 527.49 +61868-81-3 2,3,5-trimethyl-3-ethylhexane -273000 514.41 +61868-82-4 2,3,5-trimethyl-4-ethylhexane -267300 542.59 +61868-83-5 2,4,4-trimethyl-3-ethylhexane -251600 530.51 +61868-84-6 3,3,4-trimethyl-4-ethylhexane -259700 517.1 +61868-85-7 2,2,3,3,4-pentamethylhexane -266100 500.33 +61868-86-8 2,2,3,3,5-pentamethylhexane -279300 500.66 +61868-87-9 2,2,3,4,4-pentamethylhexane -262300 504.35 +61868-88-0 2,2,3,4,5-pentamethylhexane -276300 516.42 +61868-89-1 2,3,3,4,4-pentamethylhexane -262300 498.98 +61868-90-4 2,2,4-trimethyl-3-isopropylpentane -232400 499.65 +61868-91-5 2,3,4-trimethyl-3-isopropylpentane -241800 495.29 +61868-92-6 2,4-dimethyl-3,3-diethylpentane -238200 516.09 +61868-93-7 2,2,3,4-tetramethyl-3-ethylpentane -245800 499.32 +61868-94-8 3,5,5-trimethyloctane -279500 552.31 +61868-95-9 4,4,5-trimethyloctane -276300 542.25 +61868-96-0 2-methyl-4-propylheptane -278600 559.69 +61868-97-1 3-methyl-4-propylheptane -271500 561.7 +61868-98-2 2-methyl-4-isopropylheptane -280700 550.97 +61868-99-3 3-methyl-4-isopropylheptane -266100 558.69 +61869-00-9 4-methyl-4-isopropylheptane -273100 534.2 +61869-01-0 3,4-diethylheptane -268900 559.69 +61869-02-1 3,5-diethylheptane -274600 555 +61869-03-2 2,2-dimethyl-3-ethylheptane -272400 544.93 +61869-04-3 2,2-dimethyltridecane -361680 701.41 +61869-05-4 2,2-dimethylpentadecane -402960 779.32 +61869-06-5 2,2-dimethyloctadecane -464880 896.18 +61886-61-1 3-pentadecyne -80630 712.03 +61886-62-2 3-hexadecyne -101270 750.98 +61886-63-3 3-heptadecyne -121910 789.94 +61886-64-4 3-octadecyne -142550 828.89 +61886-65-5 3-nonadecyne -163190 867.84 +61886-66-6 3-eicosyne -183830 906.79 +61886-67-7 2-nonylnaphthalene -58530 671.02 +61886-68-8 2-undecylnaphthalene -102530 742.62 +61886-71-3 1-methyl-8-ethylnaphthalene 69000 456.09 +62016-13-1 3-isopropyl-2-methylhexane -255680 509.91 +62016-14-2 2,5,6-trimethyloctane -281300 559.69 +62016-15-3 4-isopropyloctane -274400 565.06 +62016-16-4 2-methyl-3-ethyloctane -274600 566.4 +62016-17-5 2-methyl-4-ethyloctane -278800 567.07 +62016-18-6 2-methyl-5-ethyloctane -279400 567.74 +62016-19-7 2-methyl-6-ethyloctane -279600 563.38 +62016-20-0 3-methyl-4-ethyloctane -271700 569.08 +62016-21-1 3-methyl-5-ethyloctane -276500 572.1 +62016-22-2 3-methyl-6-ethyloctane -277300 568.75 +62016-23-3 4-methyl-3-ethyloctane -271700 563.38 +62016-24-4 4-methyl-5-ethyloctane -271500 567.41 +62016-25-5 4-methyl-6-ethyloctane -276500 566.4 +62016-26-6 2,2,3-trimethyloctane -283000 541.24 +62016-27-7 2,2,5-trimethyloctane -292000 542.92 +62016-28-8 2,2,6-trimethyloctane -292200 544.6 +62016-29-9 2,2,7-trimethyloctane -294500 539.23 +62016-30-2 2,3,3-trimethyloctane -279600 543.93 +62016-31-3 2,3,4-trimethyloctane -275400 555.33 +62016-32-4 2,3,5-trimethyloctane -281100 560.03 +62016-33-5 2,3,6-trimethyloctane -282000 561.7 +62016-34-6 2,3,7-trimethyloctane -284300 556.67 +62016-35-7 2,4,4-trimethyloctane -281800 547.28 +62016-36-8 2,4,5-trimethyloctane -280500 557.34 +62016-37-9 2,4,6-trimethyloctane -284800 559.69 +62016-38-0 2,4,7-trimethyloctane -287800 555 +62016-39-1 2,5,5-trimethyloctane -288900 544.6 +62016-40-4 3,3,4-trimethyloctane -276400 544.93 +62016-41-5 3,3,5-trimethyloctane -279500 552.98 +62016-42-6 3,3,6-trimethyloctane -286800 551.64 +62016-43-7 3,4,4-trimethyloctane -276500 543.93 +62016-44-8 3,4,5-trimethyloctane -272500 557.68 +62016-45-9 3,4,6-trimethyloctane -278300 564.39 +62016-46-0 2,2-dimethyl-4-ethylheptane -282800 544.26 +62016-47-1 2,2-dimethyl-5-ethylheptane -290100 537.22 +62016-48-2 methyl 2-methylbutyl ether -284200 425.92 +62016-49-3 methyl 1,2-dimethylpropyl ether -293800 414.85 +62016-52-8 heptadecylcyclopentane -436930 962.53 +62016-53-9 octadecylcyclopentane -457570 1001.5 +62016-54-0 nonadecylcyclopentane -478210 1040.4 +62016-55-1 docosylcyclopentane -540130 1157.3 +62016-56-2 tricosylcyclopentane -560770 1196.2 +62016-57-3 tetracosylcyclopentane -581410 1235.2 +62016-58-4 hexacosylcyclopentane -622690 1313.1 +62016-59-5 1,cis-3-diethylcyclopentane -188950 413.79 +62016-60-8 1,trans-3-diethylcyclopentane -188950 413.79 +62016-61-9 1,1-dimethyl-3-ethylcyclopentane -173710 483.32 +62016-62-0 1,trans-2-dimethyl-1-ethylcyclopentane -173710 483.32 +62016-63-1 1,cis-2-dimethyl-1-ethylcyclopentane -173710 483.32 +62016-64-2 1,cis-2-dimethyl-cis-4-ethylcyclopentane -209290 371.43 +62016-65-3 1,cis-2-dimethyl-trans-4-ethylcyclopentane -209290 371.43 +62016-66-4 1,trans-2-dimethyl-cis-4-ethylcyclopentane -209290 371.43 +62016-67-5 1,trans-3-dimethyl-1-ethylcyclopentane -173710 483.32 +62016-68-6 1,cis-3-dimethyl-1-ethylcyclopentane -173710 483.32 +62016-70-0 1,1,cis-2,cis-3-tetramethylcyclopentane -194050 440.96 +62016-72-2 1,1,cis-2,cis-4-tetramethylcyclopentane -194050 440.96 +62016-73-3 1,2,2,cis-3-tetramethylcyclopentane -194050 440.96 +62016-74-4 pentacosylcyclopentane -602050 1274.2 +62016-75-5 1-chloroheptadecane -414890 835.04 +62016-76-6 1-chlorononadecane -454890 917.24 +62016-77-7 1-chlorotricosane -534890 1081.6 +62016-78-8 1-chloropentacosane -574890 1163.8 +62016-79-9 1-chloroheptacosane -614890 1246 +62016-80-2 1-chlorooctacosane -634890 1287.1 +62016-81-3 1-chlorononacosane -654890 1328.2 +62016-82-4 1-chlorotriacontane -674890 1369.3 +62016-83-5 1-chlorohentriacontane -694890 1410.4 +62016-84-6 1-chlorodotriacontane -714890 1451.5 +62016-85-7 1-chlorotritriacontane -734890 1492.6 +62016-86-8 1-chlorotetratriacontane -754890 1533.7 +62016-88-0 1-chlorohexatriacontane -794890 1615.9 +62016-89-1 1-chloroheptatriacontane -1003100 1025.7 +62016-90-4 1-chlorooctatriacontane -834890 1698.1 +62016-91-5 1-chlorononatriacontane -854890 1739.2 +62016-92-6 1-chlorotetracontane -874890 1780.3 +62016-93-7 1-chloro-3-methylpentane -188190 413.61 +62016-94-8 1-chloro-4-methylpentane -188190 413.61 +62017-16-7 1,1-dichlorohexane -212600 464.04 +62017-17-8 1,1-dichlorododecane -336400 701.98 +62017-19-0 1,1-dichlorohexadecane -418900 860.94 +62017-20-3 1,1-dichlorooctadecane -460200 940.25 +62017-21-4 1,1-dichlorononadecane -480800 979.74 +62017-22-5 1,1-dichloroeicosane -501400 1019.6 +62017-23-6 1,1-dichloroheneicosane -513530 1031.3 +62017-24-7 1,1-dichlorodocosane -534170 1070.3 +62017-25-8 1,1-dichlorotricosane -554810 1109.2 +62017-26-9 1,1-dichlorotetracosane -575450 1148.2 +62017-27-0 1,1-dichloropentacosane -596090 1187.1 +62017-28-1 1,1-dichlorohexacosane -616730 1226.1 +62017-29-2 1,1-dichloroheptacosane -637370 1265 +62017-30-5 1,1-dichlorooctacosane -658010 1304 +62017-31-6 1,1-dichlorononacosane -678650 1342.9 +62017-32-7 1,1-dichlorotriacontane -699290 1381.9 +62017-33-8 1,1-dichlorohentriacontane -719930 1420.8 +62017-34-9 1,1-dichlorodotriacontane -740570 1459.8 +62017-35-0 1,1-dichlorotritriacontane -761210 1498.7 +62017-36-1 1,1-dichlorotetratriacontane -781850 1537.7 +62017-37-2 1,1-dichloropentatriacontane -802490 1576.7 +62017-38-3 1,1-dichlorohexatriacontane -823130 1615.6 +62017-39-4 1,1-dichloroheptatriacontane -843770 1654.6 +62017-40-7 1,1-dichlorooctatriacontane -864410 1693.5 +62017-41-8 1,1-dichlorononatriacontane -885050 1732.5 +62017-42-9 1,1-dichlorotetracontane -905690 1771.4 +62046-36-0 1,1-dichloroheptadecane -439500 900.77 +62103-66-6 propyl nonyl sulfide -248990 689.9 +62108-44-5 1-bromotricosane -491720 1103 +62108-45-6 1-bromopentacosane -533000 1180.9 +62108-46-7 1-bromoheptacosane -574280 1258.8 +62108-47-8 1-bromononacosane -615560 1336.7 +62108-48-9 1-bromohentriacontane -656840 1414.6 +62108-49-0 1-bromotritriacontane -698120 1492.5 +62108-50-3 1-bromotetratriacontane -718760 1531.4 +62108-51-4 1-bromopentatriacontane -739400 1570.4 +62108-52-5 1-bromoheptatriacontane -780680 1648.3 +62108-53-6 1-bromooctatriacontane -801320 1687.2 +62108-54-7 1-bromononatriacontane -821960 1726.2 +62108-55-8 1-bromotetracontane -842600 1765.1 +62108-56-9 1,1,1-trichlorodecane -307300 637.67 +62108-57-0 1,1,1-trichlorododecane -348600 716.99 +62108-58-1 1,1,1-trichlorotetradecane -389800 796.64 +62108-59-2 1,1,1-trichloropentadecane -410500 836.12 +62108-60-5 1,1,1-trichlorohexadecane -431100 875.61 +62108-61-6 1,1,1-trichloroheptadecane -451700 915.44 +62108-62-7 1,1,1-trichlorooctadecane -472300 955.26 +62108-63-8 1,1,1-trichlorononadecane -493000 994.75 +62108-64-9 1,1,1-trichloroeicosane -513600 1034.6 +62108-65-0 1,1,3-trichloro-2-methylpropane -183670 393.03 +62108-81-0 1-fluoroheptacosane -796720 1239.4 +62108-82-1 1-fluorooctacosane -817360 1278.4 +62108-83-2 1-fluorononacosane -838000 1317.3 +62108-84-3 1-fluorotriacontane -858640 1356.3 +62108-85-4 1-fluorohentriacontane -879280 1395.2 +62108-86-5 1-fluorodotriacontane -899920 1434.2 +62108-87-6 1-fluorotritriacontane -920560 1473.1 +62108-88-7 1-fluorotetratriacontane -941200 1512.1 +62108-89-8 1-fluoropentatriacontane -961840 1551 +62108-90-1 1-fluorohexatriacontane -982480 1590 +62108-91-2 1-fluoroheptatriacontane -814890 2260.3 +62108-92-3 1-fluorooctatriacontane -1023800 1667.9 +62108-93-4 1-fluorononatriacontane -1044400 1706.8 +62108-94-5 1-fluorotetracontane -1065000 1745.8 +62108-95-6 2-fluoro-3-methylbutane -353200 363.41 +62126-74-3 2,4-dimethyl-3-ethylphenol -213450 453.24 +62126-75-4 3,4-dimethyl-5-ethylphenol -213450 453.24 +62126-76-5 3,5-dimethyl-2-ethylphenol -213450 453.24 +62126-77-6 3,5-dimethyl-4-ethylphenol -213450 453.24 +62126-78-7 1-fluoroheneicosane -672880 1005.7 +62126-79-8 1-fluorodocosane -693520 1044.6 +62126-80-1 1-fluorotricosane -714160 1083.6 +62126-81-2 1-fluorotetracosane -734800 1122.6 +62126-82-3 1-fluoropentacosane -755440 1161.5 +62126-83-4 1-fluorohexacosane -776080 1200.5 +62126-84-5 1,1,1-trifluoroheptadecane -991290 874.4 +62126-85-6 1,1,1-trifluorononadecane -1032600 952.31 +62126-86-7 1,1,1-trifluoroeicosane -1053200 991.26 +62126-87-8 1,1-difluorooctatriacontane -1241100 1636.6 +62126-88-9 1,1-difluorononatriacontane -1261600 1676 +62126-89-0 1,1-difluorotetracontane -1282100 1715.4 +62126-90-3 1,2-difluoropropane -553280 324.75 +62126-91-4 1,1-difluoro-2-methylpropane -528670 356.15 +62126-92-5 1,2-difluoro-2-methylpropane -526860 336.33 +62126-93-6 1,3-difluoro-2-methylpropane -523390 365.68 +62126-94-7 1,2-difluoropentane -544030 404.63 +62126-95-8 1,3-difluoropentane -544030 404.63 +62126-96-9 1,4-difluoropentane -544030 404.63 +62126-97-0 1,1,1-trifluoroundecane -867450 640.69 +62126-98-1 1,1,1-trifluorotridecane -908730 718.6 +62126-99-2 1,1,1-trifluorotetradecane -929370 757.55 +62127-00-8 1,1,1-trifluoropentadecane -950010 796.5 +62127-01-9 1,1,1-trifluorohexadecane -970650 835.45 +62127-02-0 1,1-difluorotridecane -727700 719.17 +62127-03-1 1,1-difluorotetradecane -748400 758.65 +62127-04-2 1,1-difluoropentadecane -769000 798.48 +62127-05-3 1,1-difluorohexadecane -789600 838.3 +62127-06-4 1,1-difluoroheptadecane -810200 878.13 +62127-07-5 1,1-difluorooctadecane -830900 917.62 +62127-08-6 1,1-difluorononadecane -851500 957.11 +62127-09-7 1,1-difluoroeicosane -872100 996.93 +62127-10-0 1,1-difluoroheneicosane -892600 966.39 +62127-11-1 1,1-difluorodocosane -913100 1005.8 +62127-12-2 1,1-difluorotricosane -933600 1045.2 +62127-13-3 1,1-difluorotetracosane -954100 1084.7 +62127-14-4 1,1-difluoropentacosane -974600 1124.1 +62127-15-5 1,1-difluorohexacosane -995100 1163.5 +62127-16-6 1,1-difluoroheptacosane -1015600 1202.9 +62127-17-7 1,1-difluorooctacosane -1036100 1242.3 +62127-18-8 1,1-difluorononacosane -1056600 1281.8 +62127-19-9 1,1-difluorotriacontane -1077100 1321.2 +62127-20-2 1,1-difluorohentriacontane -1097600 1360.6 +62127-21-3 1,1-difluorodotriacontane -1118100 1400 +62127-22-4 1,1-difluorotritriacontane -1138600 1439.4 +62127-23-5 1,1-difluorotetratriacontane -1159100 1478.9 +62127-24-6 1,1-difluoropentatriacontane -1179600 1518.3 +62127-25-7 1,1-difluorohexatriacontane -1200100 1557.7 +62127-26-8 1,1-difluoroheptatriacontane -1220600 1597.1 +62127-27-9 1-fluoro-2-methylpentane -368560 411.89 +62127-28-0 1-fluoro-3-methylpentane -368560 411.89 +62127-29-1 1-fluoro-4-methylpentane -368560 411.89 +62127-30-4 2-fluoro-2-methylpentane -372030 382.54 +62127-31-5 2-fluoro-3-methylpentane -373840 402.36 +62127-32-6 2-fluoro-4-methylpentane -373840 402.36 +62127-33-7 3-fluoro-2-methylpentane -373840 402.36 +62127-34-8 1-fluoro-2,2-dimethylbutane -368560 411.89 +62127-35-9 1-fluoro-2,3-dimethylbutane -372030 382.54 +62127-40-6 1,1-difluoropentane -562700 401.58 +62127-41-7 1,1-difluorohexane -583300 441.4 +62127-42-8 1,1-difluorononane -645200 560.54 +62127-43-9 1,1-difluorodecane -665800 600.36 +62127-44-0 1,1-difluoroundecane -686500 639.52 +62127-45-1 1,1-difluorododecane -707100 679.34 +62127-46-2 1,3,3-tribromobutane -55650 426.08 +62127-47-3 2,3,3-tribromobutane -60930 416.55 +62127-48-4 1,3-dibromo-2-(bromomethyl)propane -52180 455.43 +62127-49-5 1,1,1,2-tetrabromopropane -13960 428.65 +62127-50-8 1,1,1,3-tetrabromopropane -8680 438.17 +62127-51-9 1-iodononadecane -358620 951.71 +62127-52-0 1-iodoheneicosane -399900 1029.6 +62127-53-1 1-iododocosane -420540 1068.6 +62127-54-2 1-iodotricosane -441180 1107.5 +62127-55-3 1-iodotetracosane -461820 1146.5 +62127-56-4 1-iodopentacosane -482460 1185.4 +62127-57-5 1-iodoheptacosane -523740 1263.3 +62127-58-6 1,1-dibromo-2-methylbutane -104430 433.81 +62127-59-7 1,1-dibromo-3-methylbutane -104430 433.81 +62127-60-0 2,2-dibromo-3-methylbutane -107900 404.46 +62127-61-1 1,1,1-tribromopropane -35010 387.13 +62127-62-2 1,1,1-tribromobutane -55650 426.08 +62127-63-3 1,1,1-tribromohexane -96930 503.98 +62127-64-4 1,1,1-tribromoheptane -117570 542.94 +62127-65-5 1,1,1-tribromooctane -138210 581.89 +62127-66-6 1,1,1-tribromononane -158850 620.84 +62127-67-7 1,1,1-tribromodecane -179490 659.79 +62127-68-8 1,1,1-tribromoundecane -200130 698.75 +62127-69-9 1,1,1-tribromododecane -220770 737.7 +62127-70-2 1,1,1-tribromotridecane -241410 776.65 +62127-71-3 1,1,1-tribromopentadecane -282690 854.55 +62127-72-4 1,1,1-tribromohexadecane -303330 893.51 +62127-73-5 1,1,1-tribromoheptadecane -323970 932.46 +62127-74-6 1,1,1-tribromooctadecane -344610 971.41 +62127-75-7 1,1,1-tribromononadecane -365250 1010.4 +62127-76-8 1,1,1-tribromoeicosane -385890 1049.3 +62154-74-9 3-iodo-1-butene 71130 353.3 +62154-80-7 1-iodooctacosane -544380 1302.3 +62154-81-8 1-iodononacosane -565020 1341.2 +62154-82-9 1-iodotriacontane -585660 1380.2 +62154-83-0 1-iododotriacontane -626940 1458.1 +62154-84-1 1-iodotritriacontane -647580 1497 +62154-85-2 1-iodotetratriacontane -668220 1405.3 +62154-86-3 1-iodopentatriacontane -688860 1575 +62154-87-4 1-iodohexatriacontane -709500 1613.9 +62154-88-5 1-iodoheptatriacontane -730140 1652.9 +62154-89-6 1-iodooctatriacontane -750780 1691.8 +62154-90-9 1-iodononatriacontane -771420 1730.8 +62154-91-0 1-iodotetracontane -792060 1769.7 +62154-92-1 trans-1-iodo-1-butene 68200 360.85 +62155-02-6 2-undecanethiol -241000 641.72 +62155-03-7 2-tridecanethiol -282300 720.03 +62155-04-8 2-tetradecanethiol -302900 759.52 +62155-05-9 2-pentadecanethiol -323500 798.67 +62155-06-0 2-octadecanethiol -385400 916.47 +62155-07-1 1-nonadecanethiol -397600 965.01 +62155-08-2 2-eicosanethiol -426700 994.77 +62155-09-3 methyl tridecyl sulfide -286800 765.22 +62155-10-6 methyl pentadecyl sulfide -328100 843.53 +62155-11-7 2-thianonadecane -369300 922.17 +62155-12-8 methyl nonadecyl sulfide -410600 1000.5 +62155-14-0 1,1-diphenyltridecane -123000 +62155-15-1 1,1-diphenylpentadecane -171000 +62155-16-2 2',3'-dimethyldiphenylmethane 101000 527.88 +62155-25-3 1,1,1-tribromotetradecane -262050 815.6 +62168-03-0 1,1-dibromotetracosane -491310 1183.4 +62168-04-1 1,1-dibromopentacosane -511950 1222.4 +62168-05-2 1,1-dibromohexacosane -532590 1261.3 +62168-06-3 1,1-dibromoheptacosane -553230 1300.3 +62168-07-4 1,1-dibromooctacosane -573870 1339.2 +62168-08-5 1,1-dibromononacosane -594510 1378.2 +62168-09-6 1,1-dibromotriacontane -615150 1417.1 +62168-10-9 1,1-dibromohentriacontane -635790 1456.1 +62168-11-0 1,1-dibromodotriacontane -656430 1495 +62168-12-1 1,1-dibromotritriacontane -677070 1534 +62168-13-2 1,1-dibromotetratriacontane -697710 1572.9 +62168-15-4 1,1-dibromohexatriacontane -738990 1650.9 +62168-16-5 1,1-dibromoheptatriacontane -759630 1689.8 +62168-17-6 1,1-dibromooctatriacontane -780270 1728.8 +62168-18-7 1,1-dibromononatriacontane -800910 1767.7 +62168-19-8 1,1-dibromotetracontane -821550 1806.7 +62168-25-6 1,1-dibromobutane -78510 404.38 +62168-26-7 1,1-dibromooctane -161070 560.19 +62168-27-8 1,1-dibromononane -181710 599.14 +62168-28-9 1,1-dibromoundecane -222990 677.05 +62168-29-0 1,1-dibromododecane -243630 716 +62168-30-3 1,1-dibromotridecane -264270 754.95 +62168-31-4 1,1-dibromotetradecane -284910 793.9 +62168-32-5 1,1-dibromopentadecane -305550 832.86 +62168-33-6 1,1-dibromohexadecane -326190 871.81 +62168-34-7 1,1-dibromoheptadecane -346830 910.76 +62168-35-8 1,1-dibromooctadecane -367470 949.71 +62168-36-9 1,1-dibromononadecane -388110 988.66 +62168-37-0 1,1-dibromoeicosane -408750 1027.6 +62168-38-1 1,1-dibromoheneicosane -429390 1066.6 +62168-39-2 1,1-dibromodocosane -450030 1105.5 +62168-40-5 1,1-dibromotricosane -470670 1144.5 +62168-41-6 2-bromo-3-methylpentane -151400 421.71 +62168-42-7 1-bromo-2,2-dimethylbutane -146120 431.24 +62183-50-0 2,5-dimethyl-6-ethyloctane -299200 589.45 +62183-51-1 2,6-dimethyl-3-ethyloctane -299900 597.5 +62183-52-2 2,6-dimethyl-4-ethyloctane -303400 597.84 +62183-53-3 2,6-dimethyl-5-ethyloctane -299200 595.49 +62183-54-4 2,6-dimethyl-6-ethyloctane -304500 582.75 +62183-55-5 2,7-dimethyl-3-ethyloctane -302200 592.47 +62183-56-6 2,7-dimethyl-4-ethyloctane -306400 593.14 +62183-57-7 3,3-dimethyl-4-ethyloctane -286600 587.44 +62183-58-8 3,3-dimethyl-5-ethyloctane -298100 591.13 +62183-59-9 3,3-dimethyl-6-ethyloctane -305400 584.09 +62183-60-2 3,4-dimethyl-4-ethyloctane -290800 581.74 +62183-61-3 3,4-dimethyl-5-ethyloctane -290400 593.48 +62183-62-4 3,4-dimethyl-6-ethyloctane -296900 596.5 +62183-63-5 3,5-dimethyl-3-ethyloctane -294900 589.12 +62183-64-6 3,5-dimethyl-4-ethyloctane -283900 600.52 +62183-65-7 3,5-dimethyl-5-ethyloctane -295000 594.15 +62183-66-8 3,5-dimethyl-6-ethyloctane -296300 593.81 +62183-67-9 3,6-dimethyl-3-ethyloctane -302200 588.11 +62183-68-0 3,6-dimethyl-4-ethyloctane -296300 599.85 +62183-69-1 4,4-dimethyl-3-ethyloctane -286600 581.07 +62183-70-4 4,4-dimethyl-5-ethyloctane -286400 585.43 +62183-71-5 4,4-dimethyl-6-ethyloctane -298100 584.76 +62183-72-6 4,5-dimethyl-3-ethyloctane -290400 587.78 +62183-73-7 4,5-dimethyl-4-ethyloctane -290600 580.06 +62183-74-8 2,2,3,3-tetramethyloctane -300200 550.55 +62183-75-9 2,2,3,4-tetramethyloctane -295700 572.35 +62183-76-0 2,2,3,5-tetramethyloctane -307400 570.34 +62183-77-1 2,2,3,6-tetramethyloctane -308200 572.68 +62183-78-2 2,2,3,7-tetramethyloctane -310500 567.65 +62183-79-3 2,2,4,4-tetramethyloctane -298500 561.28 +62183-80-6 2,2,4,5-tetramethyloctane -305200 574.03 +62183-81-7 2,2,4,6-tetramethyloctane -309500 576.37 +62183-82-8 2,2,4,7-tetramethyloctane -312500 571.68 +62183-83-9 2,2,5,5-tetramethyloctane -320100 557.93 +62183-84-0 2,2,5,6-tetramethyloctane -312500 572.68 +62183-85-1 4-methyl-5-propyloctane -291900 599.85 +62183-86-2 2-methyl-4-isopropyloctane -301300 590.46 +62183-87-3 2-methyl-5-isopropyloctane -302000 590.8 +62183-88-4 3-methyl-4-isopropyloctane -286800 598.17 +62183-89-5 3-methyl-5-isopropyloctane -299000 595.49 +62183-90-8 4-methyl-4-isopropyloctane -293800 579.06 +62183-91-9 4-methyl-5-isopropyloctane -286600 596.5 +62183-92-0 3,4-diethyloctane -289600 599.18 +62183-93-1 3,5-diethyloctane -295100 604.21 +62183-94-2 3,6-diethyloctane -295900 600.86 +62183-95-3 2,2-dimethyl-3-ethyloctane -293100 584.09 +62183-96-4 2,2-dimethyl-4-ethyloctane -303500 583.75 +62183-97-5 2,2-dimethyl-5-ethyloctane -310600 581.07 +62183-98-6 2,2-dimethyl-6-ethyloctane -310800 576.71 +62183-99-7 2,3-dimethyl-3-ethyloctane -293900 581.74 +62184-00-3 2,3-dimethyl-4-ethyloctane -293300 591.13 +62184-01-4 2,3-dimethyl-5-ethyloctane -299700 597.84 +62184-02-5 2,3-dimethyl-6-ethyloctane -300500 594.15 +62184-03-6 2,4-dimethyl-3-ethyloctane -286800 598.17 +62184-04-7 2,4-dimethyl-4-ethyloctane -297300 588.78 +62184-05-8 2,4-dimethyl-5-ethyloctane -298400 593.14 +62184-06-9 2,4-dimethyl-6-ethyloctane -303400 592.14 +62184-07-0 2,5-dimethyl-3-ethyloctane -299000 595.49 +62184-08-1 2,5-dimethyl-4-ethyloctane -298400 593.14 +62184-09-2 2,5-dimethyl-5-ethyloctane -304400 586.1 +62184-10-5 2,4,6-trimethylnonane -305300 597.5 +62184-11-6 2,4,7-trimethylnonane -306200 599.52 +62184-12-7 2,5,5-trimethylnonane -309600 583.75 +62184-13-8 2,5,6-trimethylnonane -301800 597.5 +62184-14-9 2,5,7-trimethylnonane -306200 599.52 +62184-15-0 2,6,6-trimethylnonane -309600 583.75 +62184-16-1 2,6,7-trimethylnonane -302000 598.85 +62184-17-2 2,7,7-trimethylnonane -309700 586.44 +62184-18-3 3,3,4-trimethylnonane -297100 584.09 +62184-19-4 3,3,5-trimethylnonane -300100 592.81 +62184-20-7 3,3,6-trimethylnonane -307400 591.47 +62184-21-8 3,3,7-trimethylnonane -307300 589.45 +62184-22-9 3,4,4-trimethylnonane -297100 583.42 +62184-23-0 3,4,5-trimethylnonane -293100 597.5 +62184-24-1 3,4,6-trimethylnonane -298800 602.2 +62184-25-2 3,5,5-trimethylnonane -300200 591.8 +62184-26-3 3,5,6-trimethylnonane -298800 602.2 +62184-27-4 3,5,7-trimethylnonane -303200 598.51 +62184-28-5 3,6,6-trimethylnonane -307300 589.12 +62184-29-6 4,4,5-trimethylnonane -297000 581.74 +62184-30-9 4,4,6-trimethylnonane -300000 590.12 +62184-31-0 4,5,5-trimethylnonane -297000 581.74 +62184-32-1 4-tert-butyloctane -292900 582.75 +62184-33-2 2-methyl-4-propyloctane -299300 604.88 +62184-34-3 2-methyl-5-propyloctane -299900 599.85 +62184-35-4 3-methyl-4-propyloctane -292100 607.23 +62184-36-5 3-methyl-5-propyloctane -297000 604.21 +62184-37-6 2-methyl-4-ethylnonane -299400 606.56 +62184-38-7 2-methyl-5-ethylnonane -300100 606.89 +62184-39-8 2-methyl-6-ethylnonane -300100 606.89 +62184-40-1 2-methyl-7-ethylnonane -300300 602.87 +62184-41-2 3-methyl-4-ethylnonane -292300 608.57 +62184-42-3 3-methyl-5-ethylnonane -297200 611.26 +62184-43-4 3-methyl-6-ethylnonane -297800 612.26 +62184-44-5 3-methyl-7-ethylnonane -298000 607.9 +62184-45-6 4-methyl-3-ethylnonane -292300 602.87 +62184-46-7 4-methyl-5-ethylnonane -292100 607.23 +62184-47-8 4-methyl-6-ethylnonane -297000 609.91 +62184-48-9 4-methyl-7-ethylnonane -297800 606.22 +62184-49-0 5-methyl-3-ethylnonane -297200 605.55 +62184-50-3 2,2,4-trimethylnonane -305600 585.09 +62184-51-4 2,2,5-trimethylnonane -312700 582.41 +62184-52-5 2,2,6-trimethylnonane -312700 582.41 +62184-53-6 2,2,7-trimethylnonane -312900 583.75 +62184-54-7 2,2,8-trimethylnonane -315200 578.72 +62184-55-8 2,3,3-trimethylnonane -300200 583.42 +62184-56-9 2,3,4-trimethylnonane -296100 594.49 +62184-57-0 2,3,5-trimethylnonane -301800 599.18 +62184-58-1 2,3,6-trimethylnonane -302400 599.85 +62184-59-2 2,3,7-trimethylnonane -302600 601.19 +62184-60-5 2,3,8-trimethylnonane -304900 596.16 +62184-61-6 2,4,4-trimethylnonane -302500 586.44 +62184-62-7 2,4,5-trimethylnonane -301100 596.83 +62184-67-2 3-ethylthiacyclopentane -80800 +62184-71-8 4-isopropylnonane -295100 604.21 +62184-72-9 5-isopropylnonane -295100 598.51 +62184-73-0 2-methyl-3-ethylnonane -295300 605.55 +62184-74-1 1-nonylcyclopentene -165100 +62184-75-2 1-decylcyclopentene -185900 +62184-76-3 1-undecylcyclopentene -206700 +62184-77-4 1-dodecylcyclopentene -227500 +62184-78-5 1-tridecylcyclopentene -248200 +62184-79-6 1-tetradecylcyclopentene -269000 +62184-80-9 1-pentadecylcyclopentene -289800 +62184-81-0 1-hexadecylcyclopentene -310600 +62184-82-1 1,3-dimethylcyclopentene -29700 361.41 +62184-89-8 2,2-dimethyl-4,4-diethylhexane -288300 546.52 +62184-91-2 2,3-dimethyl-4,4-diethylhexane -272500 564.97 +62184-92-3 2,4-dimethyl-3,3-diethylhexane -255800 560.94 +62184-93-4 2,4-dimethyl-3,4-diethylhexane -265900 562.62 +62184-94-5 2,5-dimethyl-3,3-diethylhexane -280200 572.35 +62184-95-6 2,5-dimethyl-3,4-diethylhexane -278700 579.73 +62184-96-7 3,3-dimethyl-4,4-diethylhexane -255900 540.15 +62184-97-8 3,4-dimethyl-3,4-diethylhexane -267400 554.91 +62184-98-9 2,2,3,3-tetramethyl-4-ethylhexane -276200 537.47 +62184-99-0 2,2,3,4-tetramethyl-3-ethylhexane -263400 538.47 +62185-00-6 2,2,3,4-tetramethyl-4-ethylhexane -276700 536.13 +62185-01-7 2,2,3,5-tetramethyl-3-ethylhexane -263400 538.47 +62185-02-8 2,2,3,5-tetramethyl-4-ethylhexane -287600 559.6 +62185-03-9 2,2,4,4-tetramethyl-3-ethylhexane -250100 538.14 +62185-04-0 2,2,4,5-tetramethyl-3-ethylhexane -276900 551.55 +62185-05-1 2,2,4,5-tetramethyl-4-ethylhexane -289700 545.85 +62185-06-2 2,2,5,5-tetramethyl-3-ethylhexane -303400 547.53 +62185-07-3 2,3,3,4-tetramethyl-4-ethylhexane -269900 543.17 +62185-08-4 2,3,3,5-tetramethyl-4-ethylhexane -267300 547.19 +62185-09-5 2,3,4,4-tetramethyl-3-ethylhexane -259600 537.13 +62185-10-8 2,3,4,5-tetramethyl-3-ethylhexane -275500 563.29 +62185-11-9 2,2,3,3,4,4-hexamethylhexane -267500 500.91 +62185-12-0 2,2,3,3,4,5-hexamethylhexane -281800 528.41 +62185-13-1 2,2,3,4,4,5-hexamethylhexane -278000 521.03 +62185-14-2 2,2,3,4,5,5-hexamethylhexane -296600 528.08 +62185-15-3 2,2,4-trimethyl-3,3-diethylpentane -229100 522.37 +62185-16-4 2,4-dimethyl-3-ethyl-3-isopropylpentane -225400 522.71 +62185-17-5 2,2,3,4-tetramethyl-3-isopropylpentane -233700 503.93 +62185-18-6 2,2,4,4-tetramethyl-3-isopropylpentane -216400 504.93 +62185-19-7 3,4,4,6-tetramethyloctane -294700 577.71 +62185-20-0 3,4,5,5-tetramethyloctane -289200 575.03 +62185-21-1 3,4,5,6-tetramethyloctane -291400 578.05 +62185-22-2 4,4,5,5-tetramethyloctane -293200 541.16 +62185-23-3 2-methyl-4-tert-butylheptane -299100 568.99 +62185-24-4 3-methyl-4-tert-butylheptane -275700 567.65 +62185-25-5 4-methyl-4-tert-butylheptane -287000 552.9 +62185-26-6 3-ethyl-4-propylheptane -289400 591.8 +62185-27-7 3-ethyl-4-isopropylheptane -284100 588.45 +62185-28-8 4-ethyl-4-isopropylheptane -280300 580.4 +62185-29-9 2,2,3,4-tetramethyl-3-pentanol -404100 470.19 +62185-30-2 2,3-dimethyl-4-propylheptane -293200 583.42 +62185-31-3 2,4-dimethyl-4-propylheptane -297100 581.07 +62185-32-4 2,5-dimethyl-4-propylheptane -298400 593.14 +62185-33-5 2,6-dimethyl-4-propylheptane -305500 585.43 +62185-34-6 3,3-dimethyl-4-propylheptane -286400 580.06 +62185-35-7 3,4-dimethyl-4-propylheptane -290700 573.35 +62185-36-8 3,5-dimethyl-4-propylheptane -283900 594.82 +62185-37-9 2,2-dimethyl-3-isopropylheptane -278600 565.31 +62185-38-0 2,2-dimethyl-4-isopropylheptane -305400 567.65 +62185-39-1 2,3-dimethyl-3-isopropylheptane -283400 566.31 +62185-40-4 2,3-dimethyl-4-isopropylheptane -287800 580.4 +62185-41-5 2,4-dimethyl-3-isopropylheptane -272400 572.68 +62185-42-6 2,4-dimethyl-4-isopropylheptane -293600 568.66 +62185-43-7 2,5-dimethyl-3-isopropylheptane -293700 580.73 +62185-44-8 2,5-dimethyl-4-isopropylheptane -293100 584.09 +62185-45-9 2,6-dimethyl-3-isopropylheptane -296700 576.04 +62185-46-0 3,3-dimethyl-4-isopropylheptane -272100 568.32 +62185-47-1 3,4-dimethyl-4-isopropylheptane -280300 572.35 +62198-55-4 2,3,4-trimethyl-4-ethylheptane -285900 570.34 +62198-56-5 2,3,4-trimethyl-5-ethylheptane -291600 571.68 +62198-57-6 2,3,5-trimethyl-3-ethylheptane -291400 576.04 +62198-58-7 2,3,5-trimethyl-4-ethylheptane -285100 584.42 +62198-59-8 2,3,5-trimethyl-5-ethylheptane -297600 577.04 +62198-60-1 2,3,6-trimethyl-3-ethylheptane -300800 568.32 +62198-61-2 2,3,6-trimethyl-4-ethylheptane -299600 577.04 +62198-62-3 2,3,6-trimethyl-5-ethylheptane -301800 583.08 +62198-63-4 2,4,4-trimethyl-3-ethylheptane -272100 567.99 +62198-64-5 2,4,4-trimethyl-5-ethylheptane -286400 570.34 +62198-65-6 2,4,5-trimethyl-3-ethylheptane -285100 584.42 +62198-66-7 2,4,5-trimethyl-4-ethylheptane -290600 571.01 +62198-67-8 2,4,5-trimethyl-5-ethylheptane -297000 562.96 +62198-68-9 2,4,6-trimethyl-3-ethylheptane -293100 584.09 +62198-69-0 2,4,6-trimethyl-4-ethylheptane -297100 572.68 +62198-70-3 2,5,5-trimethyl-3-ethylheptane -300100 576.71 +62198-71-4 2,5,5-trimethyl-4-ethylheptane -292800 573.69 +62198-72-5 3,3,4-trimethyl-4-ethylheptane -280300 559.6 +62198-73-6 3,3,4-trimethyl-5-ethylheptane -286600 567.65 +62198-74-7 3,3,5-trimethyl-4-ethylheptane -269300 573.02 +62198-75-8 3,3,5-trimethyl-5-ethylheptane -288000 567.65 +62198-76-9 3,4,4-trimethyl-3-ethylheptane -280300 553.9 +62198-77-0 3,4,4-trimethyl-5-ethylheptane -278700 560.61 +62198-78-1 3,4,5-trimethyl-3-ethylheptane -283100 569.67 +62198-79-2 3,4,5-trimethyl-4-ethylheptane -277300 568.99 +62198-80-5 2,2,3,3,4-pentamethylheptane -286600 538.14 +62198-81-6 2,2,3,3,5-pentamethylheptane -297700 545.18 +62198-82-7 2,2,3,3,6-pentamethylheptane -307100 537.13 +62198-83-8 2,2,3,4,4-pentamethylheptane -282800 541.49 +62198-84-9 2,2,3,4,5-pentamethylheptane -294000 558.93 +62198-85-0 2,2,3,4,6-pentamethylheptane -302000 558.26 +62198-86-1 2,2,3,5,5-pentamethylheptane -308500 551.55 +62198-87-2 2,2,3,5,6-pentamethylheptane -310100 558.26 +62198-88-3 2,2,3,6,6-pentamethylheptane -321000 541.49 +62198-89-4 3,5-dimethyl-4-isopropylheptane -269600 577.04 +62198-90-7 2-methyl-3,3-diethylheptane -280400 582.75 +62198-91-8 2-methyl-3,4-diethylheptane -284100 594.15 +62198-92-9 2-methyl-3,5-diethylheptane -297100 590.12 +62198-93-0 2-methyl-4,4-diethylheptane -292200 578.39 +62198-94-1 2-methyl-4,5-diethylheptane -295800 585.43 +62198-95-2 2-methyl-5,5-diethylheptane -299500 568.66 +62198-96-3 3-methyl-3,4-diethylheptane -280200 580.06 +62198-97-4 3-methyl-3,5-diethylheptane -293000 583.75 +62198-98-5 3-methyl-4,4-diethylheptane -277300 582.75 +62198-99-6 3-methyl-4,5-diethylheptane -281300 592.81 +62199-00-2 3-methyl-5,5-diethylheptane -290100 576.37 +62199-01-3 4-methyl-3,3-diethylheptane -277300 574.36 +62199-02-4 4-methyl-3,4-diethylheptane -280300 579.39 +62199-03-5 4-methyl-3,5-diethylheptane -287900 574.03 +62199-04-6 2,2,3-trimethyl-3-ethylheptane -287100 561.28 +62199-05-7 2,2,3-trimethyl-4-ethylheptane -293000 568.66 +62199-06-8 2,2,3-trimethyl-5-ethylheptane -305500 564.97 +62199-07-9 2,2,4-trimethyl-3-ethylheptane -275700 567.65 +62199-08-0 2,2,4-trimethyl-4-ethylheptane -293200 563.96 +62199-09-1 2,2,4-trimethyl-5-ethylheptane -302600 566.31 +62199-10-4 2,2,5-trimethyl-3-ethylheptane -297000 575.7 +62199-11-5 2,2,5-trimethyl-4-ethylheptane -302600 572.01 +62199-12-6 2,2,5-trimethyl-5-ethylheptane -315000 556.92 +62199-13-7 2,2,6-trimethyl-3-ethylheptane -300000 571.01 +62199-14-8 2,2,6-trimethyl-4-ethylheptane -309700 570 +62199-15-9 2,2,6-trimethyl-5-ethylheptane -312700 566.31 +62199-16-0 2,3,3-trimethyl-4-ethylheptane -281600 564.63 +62199-17-1 2,3,3-trimethyl-5-ethylheptane -295700 570.67 +62199-18-2 2,3,4-trimethyl-3-ethylheptane -280200 573.02 +62199-19-3 2,2,5,7-tetramethyloctane -318900 568.66 +62199-20-6 2,2,6,6-tetramethyloctane -320200 560.27 +62199-21-7 2,2,6,7-tetramethyloctane -315400 570 +62199-22-8 2,3,3,4-tetramethyloctane -292100 561.28 +62199-23-9 2,3,3,5-tetramethyloctane -297600 576.04 +62199-24-0 2,3,3,6-tetramethyloctane -304900 575.03 +62199-25-1 2,3,3,7-tetramethyloctane -307200 569.67 +62199-26-2 2,3,4,4-tetramethyloctane -292200 572.01 +62199-27-3 2,3,4,5-tetramethyloctane -294200 579.39 +62199-28-4 2,3,4,6-tetramethyloctane -300000 586.1 +62199-29-5 2,3,4,7-tetramethyloctane -303000 581.07 +62199-30-8 2,3,5,5-tetramethyloctane -302700 578.05 +62199-31-9 2,3,5,6-tetramethyloctane -301500 590.12 +62199-32-0 2,3,5,7-tetramethyloctane -308000 585.43 +62199-33-1 2,3,6,6-tetramethyloctane -310000 577.38 +62199-34-2 2,4,4,5-tetramethyloctane -296800 571.01 +62199-35-3 2,4,4,6-tetramethyloctane -300000 581.07 +62199-36-4 2,4,5,5-tetramethyloctane -303200 567.99 +62199-37-5 2,4,5,6-tetramethyloctane -299400 583.42 +62199-38-6 2,4,6,6-tetramethyloctane -306400 578.72 +62199-39-7 2,5,5,6-tetramethyloctane -304100 570 +62199-40-0 2,5,6,6-tetramethyloctane -304000 570.67 +62199-41-1 3,3,4,4-tetramethyloctane -293300 549.21 +62199-42-2 3,3,4,5-tetramethyloctane -289200 575.7 +62199-43-3 3,3,4,6-tetramethyloctane -301000 575.37 +62199-44-4 3,3,5,5-tetramethyloctane -293000 568.99 +62199-45-5 3,3,5,6-tetramethyloctane -299900 583.08 +62199-46-6 3,3,6,6-tetramethyloctane -314800 561.95 +62199-47-7 3,4,4,5-tetramethyloctane -289000 561.28 +62199-61-5 2,2,4,4,5-pentamethylheptane -292900 547.53 +62199-62-6 2,2,4,4,6-pentamethylheptane -299630 550.88 +62199-63-7 2,2,4,5,5-pentamethylheptane -307400 547.53 +62199-64-8 2,2,4,5,6-pentamethylheptane -306400 557.93 +62199-65-9 2,2,5,5,6-pentamethylheptane -317600 544.17 +62199-66-0 2,3,3,4,4-pentamethylheptane -282800 536.13 +62199-67-1 2,3,3,4,5-pentamethylheptane -284400 554.24 +62199-68-2 2,3,3,4,6-pentamethylheptane -298400 547.19 +62199-69-3 2,3,3,5,5-pentamethylheptane -290600 554.91 +62199-70-6 2,3,4,4,5-pentamethylheptane -284300 551.55 +62199-71-7 2,3,4,4,6-pentamethylheptane -292000 561.62 +62199-72-8 2,3,4,5,5-pentamethylheptane -290400 559.6 +62199-73-9 2,4,4,5,5-pentamethylheptane -293100 538.81 +62199-74-0 3,3,4,4,5-pentamethylheptane -279900 538.14 +62199-75-1 3,3,4,5,5-pentamethylheptane -276500 541.16 +62199-76-2 2,2-dimethyl-3-tert-butylhexane -256500 527.4 +62199-77-3 2-methyl-3-ethyl-3-isopropylhexane -258700 558.93 +62199-78-4 2-methyl-4-ethyl-3-isopropylhexane -268800 585.09 +62199-79-5 2,2,3-trimethyl-3-isopropylhexane -266300 545.52 +62199-80-8 2,2,4-trimethyl-3-isopropylhexane -250100 547.86 +62199-81-9 2,2,5-trimethyl-3-isopropylhexane -284900 551.22 +62199-82-0 2,2,5-trimethyl-4-isopropylhexane -300000 552.9 +62199-83-1 2,3,4-trimethyl-3-isopropylhexane -259400 543.84 +62199-84-2 2,3,5-trimethyl-3-isopropylhexane -283200 555.91 +62199-85-3 2,3,5-trimethyl-4-isopropylhexane -273600 556.58 +62199-86-4 2,4,4-trimethyl-3-isopropylhexane -246500 542.83 +62199-87-5 3,3,4-triethylhexane -266900 573.69 +62199-88-6 2,2-dimethyl,3,3-diethylhexane -262600 548.54 +62199-89-7 2,3-dimethyl-3,4-diethylhexane -269900 572.35 +62211-85-2 4,5,6-trimethylnonane -292900 590.12 +62212-28-6 3,4-dimethyl-3-ethyloctane -290800 576.37 +62417-08-7 2,6-dimethyl-1-octanol -412520 577.37 +62946-68-3 2-propyl-1,4-butanediol -492900 536.52 +63126-48-7 3-ethyl-4-octanol -412520 577.37 +63318-29-6 cis-1-iodo-1-heptene 6280 477.71 +63521-36-8 3,4-dimethyl-1,4-pentanediol -518200 442.14 +63521-37-9 3-methyl-2,3-pentanediol -503000 384.94 +64245-25-6 cis-1-iodo-3-methyl-1-butene 42280 390.28 +64265-26-5 2,4-dimethyltetrahydrofuran -259030 245.63 +64502-86-9 3,4-dimethyl-2-pentanol -355880 450.98 +64531-23-3 cis-1-chloro-1-octene -106970 494.46 +64919-20-6 ethyl pentadecyl sulfide -351920 884.05 +65036-71-7 4,5-dimethyl-cis-2-hexene -101800 441.96 +65591-14-2 eicosyl propanoate -834200 1112.4 +65769-10-0 6,6-dimethyl-1-heptanol -390070 518.59 +65822-93-7 2,4-dimethyl-2-heptanol -395350 509.07 +65927-60-8 2,3,5-trimethyl-3-hexanol -400630 499.54 +66142-53-8 1,1-diiodoundecane -121910 686.19 +66142-59-4 cis-1-bromo-1-undecene -126820 628.94 +66142-60-7 trans-1-bromo-1-undecene -126820 628.94 +66142-61-8 trans-1-chloro-1-undecene -168890 611.32 +66142-62-9 trans-1-fluoro-1-undecene -349260 609.59 +66142-63-0 cis-1-iodo-1-undecene -76280 633.51 +66142-64-1 trans-1-iodo-1-undecene -76280 633.51 +66172-73-4 cis-1-chloro-1-undecene -168890 611.32 +66172-74-5 cis-1-fluoro-1-undecene -349260 609.59 +66213-67-0 cis-1-chloro-3-methyl-1-butene -50330 368.08 +66213-68-1 trans-1-chloro-3-methyl-1-butene -50330 368.08 +66213-69-2 cis-1-chloro-1-pentene -45050 377.6 +66213-70-5 trans-1-chloro-1-pentene -45050 377.6 +66213-72-7 cis-1-fluoro-2-methyl-1-butene -235210 371.72 +66213-73-8 cis-1-fluoro-3-methyl-1-butene -230700 366.35 +66213-74-9 trans-1-fluoro-2-methyl-1-butene -235210 371.72 +66213-75-0 trans-1-fluoro-3-methyl-1-butene -230700 366.35 +66213-76-1 1-fluoro-2-methyl-cis-2-butene -235210 371.72 +66213-77-2 1-fluoro-2-methyl-trans-2-butene -235210 371.72 +66213-78-3 2-fluoro-3-methyl-1-butene -232280 364.17 +66213-79-4 2-fluoro-3-methyl-2-butene -245000 367.56 +66213-80-7 3-fluoro-3-methyl-1-butene -225960 338.98 +66213-81-8 4-fluoro-2-methyl-1-butene -227000 373.7 +66213-82-9 4-fluoro-3-methyl-1-butene -222490 368.33 +66213-83-0 cis-1-fluoro-1-pentene -225420 375.88 +66213-84-1 trans-1-fluoro-1-pentene -225420 375.88 +66213-85-2 1-fluoro-cis-2-pentene -225420 375.88 +66213-86-3 1-fluoro-trans-2-pentene -225420 375.88 +66213-87-4 2-fluoro-cis-2-pentene -235210 371.72 +66213-88-5 2-fluoro-trans-2-pentene -235210 371.72 +66213-89-6 2-fluoro-1-pentene -227000 373.7 +66213-90-9 3-fluoro-cis-2-pentene -235210 371.72 +66213-91-0 1,1-diiodononacosane -493430 1387.3 +66213-93-2 nonacosylamine -608100 1337.2 +66213-94-3 diethylpentacosylamine -574360 1301.7 +66213-95-4 dimethylheptacosylamine -574360 1301.7 +66213-96-5 ethylheptacosylamine -588420 1326.3 +66213-97-6 methyloctacosylamine -588420 1326.3 +66213-98-7 1,1-diiodotriacontane -514070 1426.3 +66214-00-4 triacontylamine -628740 1376.2 +66214-01-5 diethylhexacosylamine -595000 1340.7 +66214-02-6 dimethyloctacosylamine -595000 1340.7 +66214-03-7 ethyloctacosylamine -609060 1365.2 +66214-04-8 methylnonacosylamine -609060 1365.2 +66214-07-1 1,1-diiodohentriacontane -534710 1465.2 +66214-08-2 hentriacontylamine -649380 1415.1 +66214-09-3 diethylheptacosylamine -615640 1379.6 +66214-10-6 dimethylnonacosylamine -615640 1379.6 +66214-11-7 ethylnonacosylamine -629700 1404.2 +66214-12-8 methyltriacontylamine -629700 1404.2 +66214-13-9 1,1-diiododotriacontane -555350 1504.2 +66214-14-0 dotriacontylamine -670020 1454.1 +66214-15-1 diethyloctacosylamine -636280 1418.6 +66214-16-2 dimethyltriacontylamine -636280 1418.6 +66214-17-3 ethyltriacontylamine -650340 1443.1 +66214-18-4 methylhentriacontylamine -650340 1443.1 +66214-19-5 1,1-diiodotritriacontane -575990 1543.1 +66214-22-0 diethylnonacosylamine -656920 1457.5 +66214-23-1 dimethylhentriacontylamine -656920 1457.5 +66214-24-2 ethylhentriacontylamine -670980 1482.1 +66214-25-3 methyldotriacontylamine -670980 1482.1 +66214-26-4 1,1-diiodotetratriacontane -596630 1582.1 +66214-29-7 tetratriacontylamine -711300 1532 +66214-30-0 diethyltriacontylamine -677560 1496.5 +66214-31-1 dimethyldotriacontylamine -677560 1496.5 +66214-32-2 ethyldotriacontylamine -691620 1521 +66214-33-3 methyltritriacontylamine -691620 1521 +66225-12-5 3,5-dimethyl-trans-2-hexene -111300 430.59 +66225-14-7 4,5-dimethyl-trans-2-hexene -106800 425.19 +66225-15-8 3-ethyl-trans-2-hexene -104000 446.89 +66225-16-9 4-methyl-cis-2-heptene -96500 451.55 +66225-17-0 4-methyl-trans-2-heptene -101500 434.78 +66225-18-1 6-methyl-cis-2-heptene -96500 451.55 +66225-19-2 6-methyl-cis-3-heptene -89500 475.03 +66225-20-5 6-methyl-trans-3-heptene -103200 429.08 +66225-22-7 1,1-diiodooctane -59990 569.33 +66225-30-7 2,3-dimethyl-trans-3-hexene -111400 430.25 +66225-31-8 3,5-dimethyl-cis-2-hexene -111300 430.59 +66225-32-9 3-ethyl-2,3-pentanediol -518800 440.13 +66225-33-0 3-ethyl-2,4-pentanediol -506000 508.95 +66225-35-2 2-methyl-2,4-hexanediol -526000 415.98 +66225-37-4 4-methyl-1,5-hexanediol -507200 496.74 +66225-38-5 dimethyl-1,2-dimethylpropylamine -125560 435.23 +66225-39-6 dimethyl-2-methylbutylamine -125560 435.23 +66225-40-9 methylethylbutylamine -120280 444.75 +66225-41-0 methylethyl-sec-butylamine -125560 435.23 +66225-42-1 methylpropylisopropylamine -125560 435.23 +66225-46-5 cis-1-fluoro-1-hexene -246060 414.83 +66225-47-6 trans-1-fluoro-1-hexene -246060 414.83 +66225-50-1 1,1-diiodohexane -18710 491.43 +66225-51-2 3-ethyl-1-pentanol -345320 470.03 +66225-52-3 2,3-dimethyl-1,3-pentanediol -513200 458.91 +66225-53-4 2,4-dimethyl-2,3-pentanediol -522200 436.91 +66225-54-5 4,4-dimethyl-1,2-pentanediol -512000 462.93 +66256-39-1 3,4,4,5-tetramethyl-3-hexanol -424740 509.14 +66256-40-4 3,4,5,5-tetramethyl-3-hexanol -424740 509.14 +66256-41-5 2,2,4-trimethyl-3-ethyl-3-pentanol -424740 509.14 +66256-42-6 2,2,5-trimethyl-4-heptanol -421270 538.49 +66256-43-7 2,2,6-trimethyl-3-heptanol -421270 538.49 +66256-44-8 2,2,6-trimethyl-4-heptanol -421270 538.49 +66256-46-0 2,4,5-trimethyl-4-heptanol -421270 538.49 +66256-47-1 2,4,6-trimethyl-2-heptanol -421270 538.49 +66256-48-2 2,5,6-trimethyl-2-heptanol -421270 538.49 +66256-50-6 3,5,5-trimethyl-3-heptanol -419460 518.67 +66256-60-8 6-methyl-2-nonanol -412520 577.37 +66256-61-9 7-methyl-2-nonanol -412520 577.37 +66256-62-0 4-methyl-2-propyl-1-hexanol -412520 577.37 +66256-63-1 2,2,3,4-tetramethyl-3-hexanol -424740 509.14 +66256-64-2 2,2,3,5-tetramethyl-3-hexanol -424740 509.14 +66256-65-3 2,2,4,4-tetramethyl-3-hexanol -424740 509.14 +66256-66-4 2,3,4,4-tetramethyl-2-hexanol -424740 509.14 +66256-67-5 2,3,4,4-tetramethyl-3-hexanol -424740 509.14 +66256-68-6 2,4,4,5-tetramethyl-3-hexanol -426550 528.97 +66256-69-7 3,3,5,5-tetramethyl-2-hexanol -424740 509.14 +66271-50-9 1-nitrohexadecane -384330 859.53 +66271-53-2 2-hexadecanethiol -344200 837.82 +66271-54-3 ethyl tetradecyl sulfide -331290 844.87 +66271-55-4 propyl tridecyl sulfide -331460 846.28 +66271-56-5 ethyltetradecylamine -320100 819.91 +66271-67-8 cis-1-bromo-1-hexadecene -230020 823.7 +66271-68-9 trans-1-bromo-1-hexadecene -230020 823.7 +66271-69-0 cis-1-chloro-1-hexadecene -272090 806.08 +66271-70-3 trans-1-chloro-1-hexadecene -272090 806.08 +66271-71-4 cis-1-fluoro-1-hexadecene -452460 804.35 +66271-72-5 trans-1-fluoro-1-hexadecene -452460 804.35 +66271-73-6 cis-1-iodo-1-hexadecene -179480 828.28 +66271-74-7 trans-1-iodo-1-hexadecene -179480 828.28 +66271-75-8 1,1-diiodohexadecane -225110 880.95 +66271-76-9 pentadecyl formate -655500 841.34 +66271-77-0 tridecyl propanoate -689400 836.64 +66271-81-6 ethyl tridecyl sulfide -310700 805.88 +66271-82-7 propyl dodecyl sulfide -310830 807.26 +66271-83-8 butyl undecyl sulfide -311580 807.26 +66291-42-7 cis-1-fluoro-1-pentadecene -431820 765.4 +66291-43-8 trans-1-fluoro-1-pentadecene -431820 765.4 +66291-44-9 cis-1-iodo-1-pentadecene -158840 789.32 +66291-45-0 trans-1-iodo-1-pentadecene -158840 789.32 +66291-47-2 cis-1-chloro-1-decene -148250 572.37 +66291-48-3 trans-1-chloro-1-decene -148250 572.37 +66291-49-4 cis-1-fluoro-1-decene -328620 570.64 +66291-50-7 trans-1-fluoro-1-decene -328620 570.64 +66291-51-8 cis-1-iodo-1-decene -55640 594.56 +66291-52-9 trans-1-iodo-1-decene -55640 594.56 +66291-57-4 1,1-diiododecane -101270 647.24 +66291-72-3 cis-1-bromo-1-decene -106180 589.99 +66291-73-4 trans-1-bromo-1-decene -106180 589.99 +66291-74-5 1,1-diiodooctacosane -472790 1348.4 +66291-75-6 diethyltetracosylamine -553720 1262.8 +66291-76-7 dimethylhexacosylamine -553720 1262.8 +66291-77-8 ethylhexacosylamine -567780 1287.3 +66291-78-9 methylheptacosylamine -567780 1287.3 +66291-79-0 dimethylpentacosylamine -533080 1223.8 +66291-80-3 ethylpentacosylamine -547140 1248.4 +66291-81-4 methylhexacosylamine -547140 1248.4 +66291-84-7 1,1-diiodoheptacosane -452150 1309.4 +66291-86-9 diethyltricosylamine -533080 1223.8 +66291-89-2 diethyldocosylamine -512440 1184.8 +66291-90-5 dimethyltetracosylamine -512440 1184.8 +66291-91-6 ethyltetracosylamine -526500 1209.4 +66291-92-7 methylpentacosylamine -526500 1209.4 +66291-94-9 1,1-diiodohexacosane -431510 1270.5 +66292-27-1 1,1-diiodooctadecane -266390 958.85 +66292-28-2 heptadecyl formate -696900 919.98 +66292-29-3 pentadecyl propanoate -730800 915.28 +66292-30-6 1-nitrooctadecane -425610 937.44 +66292-31-7 ethyl hexadecyl sulfide -372500 923.07 +66292-32-8 propyl pentadecyl sulfide -372670 924.48 +66292-33-9 butyl tetradecyl sulfide -373420 924.48 +66292-34-0 methylheptadecylamine -361380 897.81 +66292-44-2 cis-1-bromo-1-octadecene -271300 901.61 +66292-45-3 trans-1-bromo-1-octadecene -271300 901.61 +66292-46-4 cis-1-chloro-1-octadecene -313370 883.98 +66292-47-5 trans-1-chloro-1-octadecene -313370 883.98 +66292-48-6 cis-1-fluoro-1-octadecene -493740 882.26 +66292-49-7 trans-1-fluoro-1-octadecene -493740 882.26 +66292-50-0 cis-1-iodo-1-octadecene -220760 906.18 +66292-51-1 trans-1-iodo-1-octadecene -220760 906.18 +66309-90-8 1,4-dimethyl-5-ethylnaphthalene 51300 509.67 +66324-43-4 1,1-diiodotridecane -163190 764.09 +66324-50-3 cis-1-bromo-1-tridecene -168100 706.85 +66324-51-4 trans-1-bromo-1-tridecene -168100 706.85 +66324-52-5 cis-1-chloro-1-tridecene -210170 689.22 +66324-53-6 trans-1-chloro-1-tridecene -210170 689.22 +66324-54-7 cis-1-fluoro-1-tridecene -390540 687.5 +66324-55-8 trans-1-fluoro-1-tridecene -390540 687.5 +66324-56-9 cis-1-iodo-1-tridecene -117560 711.42 +66324-57-0 trans-1-iodo-1-tridecene -117560 711.42 +66325-78-8 1,1-diiodopentadecane -204470 842 +66325-82-4 1,1-diiodotricosane -369590 1153.6 +66326-05-4 1,1-diiododocosane -348950 1114.7 +66326-06-5 nonadecyl propanoate -813500 1072.9 +66326-07-6 ethyleicosylamine -443940 1053.6 +66326-08-7 methylheneicosylamine -443940 1053.6 +66326-13-4 heneicosanenitrile -311890 980.11 +66326-14-5 1,1-diiodoheneicosane -328310 1075.7 +66326-15-6 eicosyl formate -758900 1038.1 +66326-16-7 1-chloroheneicosane -494890 999.44 +66326-18-9 diethylheptadecylamine -409240 990.08 +66326-20-3 methyleicosylamine -423300 1014.7 +66359-36-2 1-nitrononadecane -446250 976.39 +66359-38-4 1,3-nonadecanediol -745230 988.35 +66359-40-8 ethyl heptadecyl sulfide -393130 962.26 +66359-41-9 propyl hexadecyl sulfide -393250 963.54 +66359-42-0 butyl pentadecyl sulfide -394050 963.5 +66359-43-1 ethylheptadecylamine -382020 936.76 +66359-51-1 cis-1-bromo-1-nonadecene -291940 940.56 +66359-52-2 trans-1-bromo-1-nonadecene -291940 940.56 +66359-53-3 cis-1-chloro-1-nonadecene -334010 922.94 +66359-54-4 trans-1-chloro-1-nonadecene -334010 922.94 +66359-55-5 cis-1-fluoro-1-nonadecene -514380 921.21 +66359-56-6 trans-1-fluoro-1-nonadecene -514380 921.21 +66359-57-7 cis-1-iodo-1-nonadecene -241400 945.13 +66359-58-8 trans-1-iodo-1-nonadecene -241400 945.13 +66359-60-2 1,1-diiodononadecane -287030 997.81 +66359-75-9 diethylheneicosylamine -491800 1145.9 +66359-76-0 dimethyltricosylamine -491800 1145.9 +66359-77-1 ethyltricosylamine -505860 1170.5 +66359-78-2 methyltetracosylamine -505860 1170.5 +66359-84-0 1,1-diiodopentacosane -410870 1231.5 +66374-76-3 cis-1-bromo-1-pentadecene -209380 784.75 +66374-77-4 trans-1-bromo-1-pentadecene -209380 784.75 +66374-78-5 cis-1-chloro-1-pentadecene -251450 767.13 +66374-79-6 trans-1-chloro-1-pentadecene -251450 767.13 +66374-96-7 1,1-diiodotetracosane -390230 1192.6 +66374-97-8 diethyleicosylamine -471160 1106.9 +66374-98-9 ethyldocosylamine -485220 1131.5 +66374-99-0 methyltricosylamine -485220 1131.5 +66375-02-8 diethylnonadecylamine -450520 1068 +66375-03-9 dimethylheneicosylamine -450520 1068 +66375-04-0 ethylheneicosylamine -464580 1092.6 +66375-05-1 methyldocosylamine -464580 1092.6 +66455-35-4 propyl heptadecyl sulfide -413880 1002.7 +66455-36-5 methylnonadecylamine -402660 975.72 +66455-41-2 trans-1-chloro-1-eicosene -354650 961.89 +66455-42-3 cis-1-fluoro-1-eicosene -535020 960.16 +66455-43-4 trans-1-fluoro-1-eicosene -535020 960.16 +66455-44-5 trans-1-iodo-1-eicosene -262040 984.08 +66455-45-6 cis-1-iodo-1-eicosene -262040 984.08 +66455-47-8 1,1-diiodoeicosane -307670 1036.8 +66455-49-0 nonadecyl formate -738300 998.62 +66455-50-3 1-nitroeicosane -466890 1015.3 +66455-60-5 cis-1-bromo-1-eicosene -312580 979.51 +66455-61-6 trans-1-bromo-1-eicosene -312580 979.51 +66455-62-7 cis-1-chloro-1-eicosene -354650 961.89 +66553-05-7 1-amino-2,3-dimethylbutane -141400 430.79 +66553-15-9 2,3-dimethyl-1,2-butanediol -494400 413.79 +66553-16-0 2-ethyl-1,2-butanediol -490200 419.69 +66553-17-1 2-ethyl-1,3-butanediol -484400 465.03 +66553-33-1 1,1-diiodododecane -142550 725.14 +66553-34-2 1-nitro-2,3-dimethylbutane -188490 450.96 +66553-39-7 cis-1-bromo-1-dodecene -147460 667.9 +66553-40-0 trans-1-bromo-1-dodecene -147460 667.9 +66553-41-1 cis-1-chloro-1-dodecene -189530 650.27 +66553-42-2 trans-1-chloro-1-dodecene -189530 650.27 +66553-43-3 cis-1-fluoro-1-dodecene -369900 648.54 +66553-44-4 trans-1-fluoro-1-dodecene -369900 648.54 +66553-45-5 cis-1-iodo-1-dodecene -96920 672.47 +66553-46-6 trans-1-iodo-1-dodecene -96920 672.47 +66553-52-4 ethyldecylamine -237540 664.1 +66553-53-5 methylundecylamine -237540 664.1 +66563-84-6 ethylnonylamine -216900 625.15 +66563-89-1 cis-1-bromo-1-heptadecene -250660 862.66 +66563-90-4 trans-1-bromo-1-heptadecene -250660 862.66 +66563-91-5 cis-1-chloro-1-heptadecene -292730 845.03 +66563-92-6 trans-1-chloro-1-heptadecene -292730 845.03 +66575-72-2 trinonadecylamine -1152300 2392.4 +66575-83-5 triheptadecylamine -1028400 2158.7 +66576-21-4 2,2,3,4,4-pentamethyl-3-ethylpentane -238100 493.19 +66576-22-5 3-methyl-3-ethyl-2-pentanol -374710 470.11 +66576-23-6 4-methyl-3-ethyl-2-pentanol -376520 489.94 +66576-24-7 2,2,3,3-tetramethyl-1-butanol -378180 440.77 +66576-26-9 2,3,4-trimethyl-2-pentanol -379990 460.59 +66576-27-0 3,5-dimethyl-2-hexanol -376520 489.94 +66576-31-6 5,5-dimethyl-3-hexanol -374710 470.11 +66576-36-1 methylnonatriacontylamine -815460 1754.8 +66576-42-9 nonatriacontylamine -814500 1726.7 +66576-43-0 diethylpentatriacontylamine -780760 1691.2 +66576-44-1 dimethylheptatriacontylamine -780760 1691.2 +66576-45-2 ethylheptatriacontylamine -794820 1715.8 +66576-46-3 methyloctatriacontylamine -794820 1715.8 +66576-47-4 1,1-diiodotetracontane -720470 1815.8 +66576-50-9 tetracontylamine -835140 1765.7 +66576-51-0 diethylhexatriacontylamine -801400 1730.2 +66576-52-1 dimethyloctatriacontylamine -801400 1730.2 +66576-53-2 ethyloctatriacontylamine -815460 1754.8 +66576-56-5 3,3-dimethyl-2-ethyl-1-butanol -374710 470.11 +66576-58-7 1,1-diiodononatriacontane -699830 1776.9 +66576-66-7 tripentadecylamine -904600 1924.9 +66576-70-3 1,2-dimethylpropyl propanoate -543600 499.6 +66576-72-5 1,1-diiodohexatriacontane -637910 1660 +66576-85-0 1,1-diiodopentatriacontane -617270 1621 +66576-87-2 pentatriacontylamine -731940 1570.9 +66576-88-3 diethylhentriacontylamine -698200 1535.4 +66576-89-4 dimethyltritriacontylamine -698200 1535.4 +66576-90-7 ethyltritriacontylamine -712260 1560 +66576-91-8 methyltetratriacontylamine -712260 1560 +66576-94-1 octatriacontylamine -793860 1687.8 +66576-95-2 diethyltetratriacontylamine -760120 1652.3 +66576-96-3 dimethylhexatriacontylamine -760120 1652.3 +66576-97-4 dinonadecylamine -774180 1676.9 +66576-98-5 ethylhexatriacontylamine -774180 1676.9 +66576-99-6 methylheptatriacontylamine -774180 1676.9 +66577-00-2 1,2,6,8-tetramethylnaphthalene 51300 509.67 +66577-05-7 1,1-diiodoheptatriacontane -658550 1698.9 +66577-08-0 heptatriacontylamine -773220 1648.8 +66577-09-1 diethyltritriacontylamine -739480 1613.3 +66577-10-4 dimethylpentatriacontylamine -739480 1613.3 +66577-11-5 ethylpentatriacontylamine -753540 1637.9 +66577-12-6 methylhexatriacontylamine -753540 1637.9 +66577-13-7 1,1-diiodooctatriacontane -679190 1737.9 +66577-14-8 2,4-dimethyl-1-ethylnaphthalene 51300 509.67 +66577-15-9 4,6-dimethyl-1-ethylnaphthalene 51300 509.67 +66577-16-0 1-methyl-3-isopropylnaphthalene 51300 509.67 +66577-18-2 3-methyl-2-isopropylnaphthalene 51300 509.67 +66577-19-3 3-methyl-2-propylnaphthalene 51300 509.67 +66577-20-6 1,2,3,6-tetramethylnaphthalene 51300 509.67 +66577-21-7 1,2,4,6-tetramethylnaphthalene 51300 509.67 +66577-22-8 1,2,4,8-tetramethylnaphthalene 51300 509.67 +66577-24-0 diethyldotriacontylamine -718840 1574.4 +66577-25-1 dimethyltetratriacontylamine -718840 1574.4 +66577-26-2 ethyltetratriacontylamine -732900 1599 +66577-27-3 methylpentatriacontylamine -732900 1599 +66577-30-8 ethyl undecyl sulfide -269450 727.64 +66577-31-9 propyl decyl sulfide -269620 729.05 +66577-32-0 butyl nonyl sulfide -270370 729.05 +66577-37-5 1,7-diethylnaphthalene 51300 509.67 +66577-38-6 1,2-dimethyl-4-ethylnaphthalene 51300 509.67 +66577-39-7 1,2-dimethyl-7-ethylnaphthalene 51300 509.67 +66577-40-0 1,3-dimethyl-5-ethylnaphthalene 51300 509.67 +66577-48-8 diethyltridecylamine -326680 834.27 +66577-51-3 trans-1-fluoro-1-heptadecene -473100 843.31 +66577-52-4 cis-1-iodo-1-heptadecene -200120 867.23 +66577-53-5 trans-1-iodo-1-heptadecene -200120 867.23 +66577-55-7 1,1-diiodoheptadecane -245750 919.9 +66577-60-4 2-heptadecanethiol -364800 876.98 +66577-61-5 propyl tetradecyl sulfide -352040 885.33 +66577-62-6 butyl tridecyl sulfide -352790 885.33 +66577-63-7 cis-1-fluoro-1-heptadecene -473100 843.31 +66587-65-3 1,1-diiodobutane 22570 413.52 +66587-66-4 2,3-diiodobutane 17290 404 +66610-91-1 2,3-diethylnaphthalene 51300 509.67 +66610-92-2 1,4-dimethyl-6-ethylnaphthalene 51300 509.67 +66675-34-1 cis-1-fluoro-1-butene -204780 336.93 +66675-35-2 trans-1-fluoro-1-butene -204780 336.93 +66675-38-5 cis-2-fluoro-2-butene -214570 332.77 +66675-39-6 trans-2-fluoro-2-butene -214570 332.77 +66675-46-5 1,1-diiodoheptane -39350 530.38 +66688-32-2 1,4-diiodo-2-methylbutane 1930 452.47 +66688-33-3 2,2-diiodo-3-methylbutane -6820 413.6 +66688-34-4 2,3-diiodo-2-methylbutane -6820 413.6 +66688-35-5 1,1-diiodopentane 1930 452.47 +66688-36-6 1,3-diiodopentane 1930 452.47 +66688-37-7 2,2-diiodopentane -1540 423.13 +66688-38-8 2,3-diiodopentane -3350 442.95 +66688-39-9 3,3-diiodopentane -1540 423.13 +66688-43-5 1,3-difluoro-2-methylbutane -549310 395.1 +66688-44-6 1,3-difluoro-3-methylbutane -547500 375.28 +66688-45-7 1,4-difluoro-2-methylbutane -544030 404.63 +66688-46-8 2,3-difluoropentane -549310 395.1 +66688-47-9 2,4-difluoropentane -549310 395.1 +66688-49-1 1,3-diiodo-2,2-dimethylpropane -1540 423.13 +66688-50-4 1,1-diiodo-2-methylbutane -3350 442.95 +66688-51-5 1,1-diiodo-3-methylbutane -3350 442.95 +66688-52-6 1,2-diiodo-2-methylbutane -1540 423.13 +66688-53-7 1,2-diiodo-3-methylbutane -3350 442.95 +66688-54-8 1,3-diiodo-2-methylbutane -3350 442.95 +66688-55-9 1,3-diiodo-3-methylbutane -1540 423.13 +66688-56-0 1-iodo-trans-2-pentene 47560 399.8 +66688-57-1 2-iodo-cis-2-pentene 37770 395.64 +66688-58-2 2-iodo-trans-2-pentene 37770 395.64 +66688-59-3 2-iodo-1-pentene 45980 397.62 +66688-60-6 3-iodo-trans-2-pentene 37770 395.64 +66688-61-7 3-iodo-1-pentene 50490 392.25 +66688-62-8 4-iodo-cis-2-pentene 42280 390.28 +66688-63-9 4-iodo-trans-2-pentene 42280 390.28 +66688-64-0 5-iodo-cis-2-pentene 47560 399.8 +66688-66-2 1,3-difluoro-2,2-dimethylpropane -547500 375.28 +66688-67-3 1,1-difluoro-2-methylbutane -549310 395.1 +66688-69-5 1,2-difluoro-3-methylbutane -549310 395.1 +66688-68-4 1,2-difluoro-2-methylbutane -547500 375.28 +66688-72-0 cis-1-chloro-1-nonene -127610 533.41 +66688-73-1 trans-1-chloro-1-nonene -127610 533.41 +66688-74-2 cis-1-fluoro-1-nonene -307980 531.69 +66688-75-3 trans-1-fluoro-1-nonene -307980 531.69 +66702-87-2 3-fluoro-trans-2-pentene -235210 371.72 +66702-88-3 3-fluoro-1-pentene -222490 368.33 +66702-89-4 4-fluoro-cis-2-pentene -230700 366.35 +66702-90-7 4-fluoro-trans-2-pentene -230700 366.35 +66702-91-8 4-fluoro-1-pentene -222490 368.33 +66702-92-9 5-fluoro-cis-2-pentene -225420 375.88 +66702-93-0 5-fluoro-trans-2-pentene -225420 375.88 +66702-95-2 trans-1-iodo-2-methyl-1-butene 37770 395.64 +66702-96-3 trans-1-iodo-3-methyl-1-butene 42280 390.28 +66702-97-4 1-iodo-2-methyl-cis-2-butene 37770 395.64 +66702-98-5 1-iodo-2-methyl-trans-2-butene 37770 395.64 +66702-99-6 2-iodo-3-methyl-2-butene 27980 391.48 +66703-00-2 3-iodo-2-methyl-1-butene 40700 388.1 +66703-01-3 4-iodo-3-methyl-1-butene 50490 392.25 +66703-02-4 cis-1-iodo-1-pentene 47560 399.8 +66703-03-5 trans-1-iodo-1-pentene 47560 399.8 +66703-04-6 1-iodo-cis-2-pentene 47560 399.8 +66703-05-7 1,1-diiodononane -80630 608.28 +66719-29-7 2,4-diiodopentane -3350 442.95 +66719-30-0 3,4-dimethyl-4-octanol -415990 548.02 +66719-31-1 3,6-dimethyl-4-octanol -417800 567.84 +66719-32-2 4,5-dimethyl-1-octanol -412520 577.37 +66719-33-3 4,6-dimethyl-1-octanol -412520 577.37 +66719-34-4 4,7-dimethyl-1-octanol -412520 577.37 +66719-35-5 7,7-dimethyl-1-octanol -410710 557.54 +66719-36-6 3-ethyl-1-octanol -407240 586.89 +66719-37-7 2-methyl-3-ethyl-3-heptanol -415990 548.02 +66719-41-3 4-methyl-2-isopropyl-1-hexanol -468330 565.86 +66719-43-5 5-methyl-3-nonanol -412520 577.37 +66719-44-6 5-methyl-4-nonanol -412520 577.37 +66719-47-9 2,2-dimethyl-4-ethyl-3-hexanol -421270 538.49 +66719-48-0 2,4-dimethyl-4-ethyl-3-hexanol -421270 538.49 +66719-50-4 3,4-dimethyl-3-isopropyl-2-pentanol -477080 526.99 +66719-52-6 2,2-dimethyl-4-octanol -415990 548.02 +66719-53-7 2,5-dimethyl-4-octanol -417800 567.84 +66719-54-8 2,6-dimethyl-4-octanol -417800 567.84 +66719-55-9 2,7-dimethyl-3-octanol -417800 567.84 +66719-51-5 4,4-dimethyl-3-isopropyl-1-pentanol -421270 538.49 +66731-94-0 4-methyl-5-ethyl-3-heptanol -417800 567.84 +66731-95-1 5-methyl-2-nonanol -412520 577.37 +66793-71-3 2,5,5-trimethyl-2-hexanol -398820 479.72 +66793-72-4 2,5,5-trimethyl-3-hexanol -400630 499.54 +66793-73-5 3,4,4-trimethyl-1-hexanol -395350 509.07 +66793-74-6 3,4,4-trimethyl-3-hexanol -398820 479.72 +66793-75-7 4,5,5-trimethyl-1-hexanol -395350 509.07 +66793-76-8 ethylheptylamine -175620 547.24 +66793-80-4 4-methyl-3-octanol -391880 538.41 +66793-81-5 5-methyl-2-octanol -391880 538.41 +66793-82-6 6-methyl-4-octanol -391880 538.41 +66793-83-7 7-methyl-2-octanol -391880 538.41 +66793-84-8 7-methyl-3-octanol -391880 538.41 +66793-85-9 3-propyl-1-hexanol -386600 547.94 +66793-86-0 2,3,3,4-tetramethyl-2-pentanol -404100 470.19 +66793-87-1 2,3,4,4-tetramethyl-2-pentanol -404100 470.19 +66793-88-2 3,3,4,4-tetramethyl-2-pentanol -404100 470.19 +66793-89-3 2,2,4-trimethyl-3-hexanol -400630 499.54 +66793-90-6 2,3,4-trimethyl-3-hexanol -400630 499.54 +66793-91-7 2,4,4-trimethyl-2-hexanol -398820 479.72 +66793-92-8 2,4,4-trimethyl-3-hexanol -400630 499.54 +66793-93-9 2,4,5-trimethyl-2-hexanol -400630 499.54 +66793-94-0 3,3-diethyl-2-pentanol -395350 509.07 +66793-95-1 2,2-dimethyl-3-ethyl-1-pentanol -395350 509.07 +66793-96-2 2,2-dimethyl-3-ethyl-3-pentanol -398820 479.72 +66793-97-3 2,3-dimethyl-3-ethyl-2-pentanol -398820 479.72 +66793-98-4 2,4-dimethyl-2-ethyl-1-pentanol -395350 509.07 +66793-99-5 2,2-dimethyl-4-heptanol -395350 509.07 +66794-00-1 2,3-dimethyl-2-heptanol -395350 509.07 +66794-02-3 2-methyl-3-ethyl-2-hexanol -395350 509.07 +66794-03-4 2-methyl-3-ethyl-3-hexanol -395350 509.07 +66794-04-5 3-methyl-2-ethyl-1-hexanol -391880 538.41 +66794-05-6 3-methyl-4-ethyl-3-hexanol -395350 509.07 +66794-06-7 4-methyl-2-ethyl-1-hexanol -391880 538.41 +66794-07-8 5-methyl-2-ethyl-1-hexanol -391880 538.41 +66794-23-8 1,2-diiodo-2-methylpropane 19100 384.17 +66794-46-5 1,2-dimethylpropyl formate -468200 425.65 +66810-87-5 3,5,5-trimethyl-3-hexanol -398820 479.72 +66826-79-7 1,1-diiodotetradecane -183830 803.04 +66826-84-4 propyl undecyl sulfide -290200 768.1 +66827-02-9 cis-1-bromo-1-tetradecene -188740 745.8 +66827-03-0 trans-1-bromo-1-tetradecene -188740 745.8 +66827-04-1 cis-1-chloro-1-tetradecene -230810 728.18 +66827-05-2 trans-1-chloro-1-tetradecene -230810 728.18 +66827-06-3 cis-1-fluoro-1-tetradecene -411180 726.45 +66827-07-4 trans-1-fluoro-1-tetradecene -411180 726.45 +66827-08-5 cis-1-iodo-1-tetradecene -138200 750.37 +66827-09-6 trans-1-iodo-1-tetradecene -138200 750.37 +67363-95-5 3-ethylfuran -97900 304.31 +69498-28-8 1,4-dibromo-2-methylbutane -99150 443.33 +73180-09-3 1-fluorotetradecane -510700 741.38 +74508-07-9 indium (I) fluoride -203400 +81931-81-9 2,3-dimethyl-2-tert-butyl-1-butanol -424740 509.14 +84869-41-0 heptadecyl butanoate -794500 1033.7 +84869-42-1 nonadecyl butanoate -835800 1112.4 +88736-68-9 1,2-dimethylpropyl butanoate -565900 539.09 +90023-96-4 methyl-2-methylbutylamine -112200 443.6 +92089-78-6 2-fluoro-3,3-dimethylbutane -377310 373.01 +92876-99-8 butyl ethyl sulfite -593200 +93716-28-0 3-ethyltetrahydrofuran -238690 287.99 +101947-30-2 1,1 difluorodisulfane -401410 292.83 +111823-35-9 3-methyl-2-isopropyl-1-butene -103370 439.81 +125164-51-4 pentadecyl butanoate -753100 955.11 diff --git a/src/Reactors/Gibbs_Reactor/myShomate.csv b/src/Reactors/Gibbs_Reactor/myShomate.csv new file mode 100644 index 0000000..f24cb6e --- /dev/null +++ b/src/Reactors/Gibbs_Reactor/myShomate.csv @@ -0,0 +1,16 @@ +Clapeyron Database File +Shomate Ideal Like Parameters +species,a,b,c,d,e, +water~|~water08,30.092,0.006832514,6.793435e-6,-2.53448e-9,82139.0, +carbon dioxide,19.8,0.0734,-5.6e-5,1.72e-8, 0.0, +methane,19.25,0.0521,1.2e-5,-1.13e-8, 0.0, +water,32.24,0.00192,1.06e-5,-3.6e-9, 0.0, +ammonia,-1.21,0.0762,-4.86e-5,1.05e-8, 0.0, +acetone~|~propanone,6.3,0.261,-0.000125,2.04e-8, 0.0, +methanol,21.2,0.0709,2.59e-5,-2.85e-8, 0.0, +methylamine~|~methanamine,11.5,0.143,-5.33e-5,4.75e-9, 0.0, +butane~|~n-butane,9.487,0.3313,-0.0001108,-2.822e-9, 0.0, +propane~|~n-propane,-4.224,0.3063,-0.0001586, 3.215e-8, 0.0, +pentane~|~n-pentane,-3.626, 0.4873,-0.000258, 5.305e-8, 0.0, +carbon monoxide, 29.39540801377204, -0.005488151042123037, 1.6144435765260952e-5, -6.860981718946819e-9, 8140.227499333827, +hydrogen, 32.49719230935432, -0.00958761242752708, 9.712916130047293e-6, -2.286601990423482e-9, -144675.51296100245, \ No newline at end of file diff --git a/src/Reactors/Gibbs_Reactor/myShomateCOCO.csv b/src/Reactors/Gibbs_Reactor/myShomateCOCO.csv new file mode 100644 index 0000000..8408518 --- /dev/null +++ b/src/Reactors/Gibbs_Reactor/myShomateCOCO.csv @@ -0,0 +1,16 @@ +Clapeyron Database File +Shomate Ideal Like Parameters +species,a,b,c,d,e, +water~|~water08,33444.6210938e-3,-5.79920578003e-3,0.025168100372e-3,-1.43102997754e-08,2.76249001452e-12, +carbon dioxide,19800e-3,73.4400024414e-3,-0.0560199990869e-3,1.71499996213e-08, 0.0, +methane,37981e-3,-74.6220016479e-3,0.30189999938e-3,0.000283269997453e-3, 9.07109978243e-11, +water,32.24,0.00192,1.06e-5,-3.6e-9, 0.0, +ammonia,-1.21,0.0762,-4.86e-5,1.05e-8, 0.0, +acetone~|~propanone,6.3,0.261,-0.000125,2.04e-8, 0.0, +methanol,21.2,0.0709,2.59e-5,-2.85e-8, 0.0, +methylamine~|~methanamine,11.5,0.143,-5.33e-5,4.75e-9, 0.0, +butane~|~n-butane,9.487,0.3313,-0.0001108,-2.822e-9, 0.0, +propane~|~n-propane,-4.224,0.3063,-0.0001586, 3.215e-8, 0.0, +pentane~|~n-pentane,-3.626, 0.4873,-0.000258, 5.305e-8, 0.0, +carbon monoxide, 29443.7207031e-3, -5.6729388237e-3, 0.0158794000745e-3, -6.43621388008e-09, 0, +hydrogen, 23052.640625e-3, 33.7491416931e-3, -0.0639906972647e-3, 5.10229983774e-08, -1.3769899887e-11, \ No newline at end of file diff --git a/src/Reactors/ReactionManager/KineticReaction.jl b/src/Reactors/ReactionManager/KineticReaction.jl new file mode 100644 index 0000000..a351d21 --- /dev/null +++ b/src/Reactors/ReactionManager/KineticReaction.jl @@ -0,0 +1,12 @@ +Base.@kwdef struct KineticReactionNetwork + Coef_Cr::Array{Float64, 2} #Stoichiometric coefficients of each component in each reaction (-) + Do_r::Array{Float64, 2} # Forward order of the components () + substances_user::Array{String, 1} #Substances in the reaction network + Nc::Int = size(substances_user)[1] #Number of components in the reaction network + Nri::Int = size(Coef_Cr, 1) #Number of reactions in the reaction network (r) + Af_r #Arrhenius constant of each reaction (s⁻¹) + Ef_r #Activation energy of each reaction (J.mol⁻¹) + name::String +end + + diff --git a/src/Reactors/SimplifiedCSTR.jl b/src/Reactors/SimplifiedCSTR.jl new file mode 100644 index 0000000..d18055b --- /dev/null +++ b/src/Reactors/SimplifiedCSTR.jl @@ -0,0 +1,383 @@ +@component function SimpleCSTR(; substances_user, + Nc = length(substances_user), + phase, + model, + Reaction, + ninports, + Ac, + height_out_port, + name + ) + +#Numerical variables + +#Constants +#GravitationalConst = 9.81 # m²/s +gramsToKilograms = 10^(-3) +Rᵍ = 8.314 # J/(mol K) +Nri = Reaction.Nri + +#Properties of individual substances +properties = Dict(subs => load_component_properties(subs) for subs in substances_user) +MWs = [properties[subs]["MW"] for subs in substances_user] +ΔH₀f = [properties[subs]["IGHF"]/10^3 for subs in substances_user] # (IG formation enthalpy) J/mol + + +pars = @parameters begin +Af_r[1:Nri] = Reaction.Af_r, [description = "Arrhenius constant of each reaction at given temperature ()"] +Coef_Cr[1:Nri, 1:Nc] = Reaction.Coef_Cr, [description = "Stoichiometric coefficients of each component in each reaction (-)"] +Do_r[1:Nri, 1:Nc] = Reaction.Do_r, [description = "Forward order of the components (-) "] +Ef_r[1:Nri] = Reaction.Ef_r, [description = "Activation energy of each reaction at given temperature ()"] +A = Ac, [description = "Cross sectional area of the tank (m²)"] +end + +#Ports creation + +InPorts = [matcon(; Nc = Nc, name = Symbol("InPorts$i")) for i in 1:ninports] + +OutPorts = @named begin + Out = matcon(; Nc = Nc) +end + +vars = @variables begin + M(t), [description = "Mass holdup in the tank (kg)"] + N(t), [description = "Total molar holdup in the tank (kmol)"] + V(t), [description = "Volume holdup in the tank (m³)"] + (Nᵢ(t))[1:Nc], [description = "Molar holdup of each component in the tank (mol)"] + (Cᵢ(t))[1:Nc], [description = "Concentration of each component in the tank (mol/m³)"] + ρ(t), [description = "Molar Density of the fluid in the tank (mol/m³)"] + ρʷ(t), [description = "Mass Density of the fluid in the tank (kg/m³)"] + MW(t), [description = "Molecular weight of fluid in the tank (kg/kmol)"] + T(t), [description = "Temperature of vessel contents (K)"] + P_out(t), [description = "Pressure at the outlet stream level (Pa)"] + H(t), [description = "Enthalpy holdup of the fluid in the tank (J)"] + #S(t), [description = "Entropy holdup of the fluid in the tank (J/K)"] + F_out(t), [description = "Outlet molar flow rate (mol/s)"] + Fʷ_out(t), [description = "Outlet molar flow rate (mol/s)"] + Q_out(t), [description = "Outlet volumetric flow rate (m³/s)"] # DoF + height(t), [description = "Liquid level in vessel measured from bottom of the tank (m)"] + + (Cᵢ_in(t))[1:Nc, 1:ninports], [description = "Inlet concentration of each component (mol/m³)"] # DoF through inlet stream + (F_in(t))[1:ninports], [description = "Inlet molar flow rate (mol/s)"] # DoF through inlet stream + (Q_in(t))[1:ninports], [description = "Inlet volumetric flow rate(s) (m³/s)"] + (T_in(t))[1:ninports], [description = "Inlet temperature (K)"] # DoF through inlet stream + (h_in(t))[1:ninports], [description = "Inlet specific enthalpy (J/mol)"] + (ρ_in(t))[1:ninports], [description = "Inlet density (mol/m³)"] + (ρʷ_in(t))[1:ninports], [description = "Inlet density (mol/m³)"] + P_atm(t), [description = "Tank pressure (Pa)"] # Equal to inlet pressures. + Q̇(t), [description = "Heat transfer rate (J/s)"] # Potential DoF + (r(t))[1:Nri], [description = "Rate of each reaction for each component (mol/s/m³)"] + (R(t))[1:Nc], [description = "Overall reaction rate (mol/s/m³)"] +end + + + +#Reaction equations +reaction_rate = [r[i] ~ Af_r[i]*exp(-Ef_r[i]/(Rᵍ*T))*prod(scalarize((Cᵢ[:].^Do_r[i, :]))) for i in 1:Nri] # If there's an inert, the order is just zero, but it has to be written +overall_reaction_rate = [R[i] ~ sum(scalarize(r[:].*Coef_Cr[:, i])) for i in 1:Nc] # If there's an inert, the coefficient is just zero, but it has to be written + + +#Inlet connector variables's equations +atm_pressure = [P_atm ~ InPorts[1].P] +mass_density_eqs = [ρʷ_in[j] ~ InPorts[j].ρʷ for j in 1:ninports] +molar_density_eqs = [ρ_in[j] ~ InPorts[j].ρ for j in 1:ninports] +inletenthalpy = [h_in[j] ~ InPorts[j].H for j in 1:ninports] +inletconcentrations = [Cᵢ_in[i, j] ~ InPorts[j].z₁[i]*ρ_in[j] for j in 1:ninports for i in 1:Nc] +inlettemperature_eqs = [T_in[j] ~ InPorts[j].T for j in 1:ninports] +inletmolarflow_eqs = [F_in[j] ~ InPorts[j].F for j in 1:ninports] +volumetricflow_eqs = [Q_in[j] ~ F_in[j] / ρ_in[j] for j in 1:ninports] + + +#Outlet connector equations: +out_conn = [Out.P ~ - P_out + Out.T ~ - T + Out.F ~ - F_out + Out.Fʷ ~ - Fʷ_out + Out.H ~ - H/N + Out.S ~ 0.0 + Out.ρʷ ~ - ρʷ + Out.ρ ~ - ρ + scalarize(Out.z₁ .~ - Nᵢ/N)... + Out.MW[1] ~ - MW +] + +if phase == :liquid +out_conn_phases = [ + scalarize(Out.z₂ .~ 0.0)... + scalarize(Out.z₃ .~ - Nᵢ/N)... + Out.MW[2] ~ 0.0 + Out.MW[3] ~ -MW + Out.α_g ~ 0.0] + +elseif phase == :vapor + out_conn_phases = [ + scalarize(Out.z₂ .~ - Nᵢ/N)... + scalarize(Out.z₃ .~ 0.0)... + Out.MW[2] ~ -MW + Out.MW[3] ~ 0.0 + Out.α_g ~ -1.0] +end + + +#balances +#mass_balance = [D(M) ~ sum(scalarize(Q_in.*ρʷ_in)) - Q_out*ρʷ] +component_balance = [D(Nᵢ[i]) ~ sum(scalarize(Q_in[:].*Cᵢ_in[i, :])) - Q_out*Cᵢ[i] + R[i]*V for i in 1:Nc] #Neglectable loss to vapor phase head space +energy_balance = [D(H) ~ sum(scalarize(Q_in.*ρ_in.*h_in)) - Q_out*ρ*H/N + Q̇] +jacket_energy_balance = [Q̇ ~ -2.27*4184.0*(T - 288.7)*(1.0 - exp(-8440.26/(2.27*4184)))] +mass_volume_eq = [ρʷ*V ~ M, ρ*V ~ N] #Modified to calculate volume from N +mol_holdup = [N ~ sum(scalarize(Nᵢ))] +mol_to_concentration = [scalarize(Nᵢ .~ Cᵢ*V)...] +height_to_volume = [height*A ~ V] +volumetricflow_to_molarflow = [Q_out ~ F_out/ρ Q_out ~ sum(scalarize(Q_in))] # Modified +volumetricflow_to_massflow = [Q_out ~ Fʷ_out/ρʷ] + +#Thermodynamic properties (outlet) +pressure_out = [phase == :liquid ? P_out ~ P_atm : P_out ~ P_atm] #Estimation considering static pressure (May be off as tank is agitated and not static) +density_eqs = [ρ ~ molar_density_simple(model, P_out, T, Nᵢ)] +mass_density = [ρʷ ~ ρ*MW] +globalEnthalpy_eq = [H ~ enthalpy_simple(model, P_out, T, Nᵢ) + sum(scalarize(ΔH₀f.*Nᵢ))] +molar_mass = [MW ~ sum(scalarize(MWs.*Nᵢ))/N*gramsToKilograms] + + +eqs = [reaction_rate...; overall_reaction_rate...; atm_pressure...; mass_density_eqs...; molar_density_eqs...; inletenthalpy...; inletconcentrations...; inlettemperature_eqs...; inletmolarflow_eqs...; volumetricflow_eqs...; out_conn...; +out_conn_phases...; component_balance...; energy_balance...; jacket_energy_balance...; mass_volume_eq...; mol_holdup...; mol_to_concentration...; height_to_volume...; volumetricflow_to_molarflow...; volumetricflow_to_massflow...; +pressure_out...; density_eqs...; mass_density...; globalEnthalpy_eq...; molar_mass...] + +unfold_pars = [] +for par in pars + unfold_pars = [unfold_pars...; par...] +end + +unfold_vars = [] +for var in vars + unfold_vars = [unfold_vars...; var...] +end + +ODESystem([eqs...;], t, unfold_vars, unfold_pars; name, systems = [InPorts...; OutPorts]) + +end + +#= + + + +struct my_model + Cp + ρ_coefs +end + +function enthalpy_simple(m::my_model, P, T, N) + sum(m.Cp[i]*N[i]*(T - 298.15) for i in eachindex(N)) +end + +function molar_density_simple(m::my_model, P, T, N) + sum(N)/sum(N[i]/(m.ρ_coefs["a"][i] + m.ρ_coefs["b"][i]*T + m.ρ_coefs["c"][i]*T^2 + m.ρ_coefs["d"][i]*T^3) for i in eachindex(N)) +end + +@register_symbolic enthalpy_simple(m::my_model, P::Num, T::Num, N::Vector{Num}) +@register_symbolic molar_density_simple(m::my_model, P::Num, T::Num, N::Vector{Num}) =# + + +#= using ModelingToolkit, JSON, DifferentialEquations +using ModelingToolkit: t_nounits as t, D_nounits as D +using Symbolics +import ModelingToolkit: scalarize, equations, get_unknowns, defaults +using Clapeyron, GCIdentifier +using NonlinearSolve +using JSON +@parameters t +D = Differential(t) +include("C:/Users/Vinic/OneDrive/Pos-Doc/Flowsheeting/ProcessModeling/ProcessSimulator.jl/src/utils") +include("C:/Users/Vinic/OneDrive/Pos-Doc/Flowsheeting/ProcessModeling/ProcessSimulator.jl/src/Sources/Sourceutils.jl") +include("C:/Users/Vinic/OneDrive/Pos-Doc/Flowsheeting/ProcessModeling/ProcessSimulator.jl/src/Reactors/ReactionManager/KineticReaction.jl") +substances_user = ["water", "methanol", "propyleneglycol","methyloxirane"] +Nc = size(substances_user, 1) +properties = Dict(subs => load_component_properties(subs) for subs in substances_user) +# Function to extract parameters for ReidIdeal model +Cps = [69.21, 80.66, 192.50, 118.1] # At 298.00 K +pho_coef = Dict("a" => [78821.04345816873, 38133.33588802956, 18453.26055238924, 25211.86290505424], +"b" => [-114.80261704286386, -85.22435577664774, -26.084451261000222, -73.31971618413455], +"c" => [0.208885275623327, 0.21416405813277503, 0.046784549601356355, 0.18909331028746998], +"d" => [-0.00022293440498512672, -0.0002675908503439664, -4.722426797584051e-5, -0.00022514899466957527]) + +phase = :liquid + +struct my_model + Cp + ρ_coefs +end + +function enthalpy_simple(m::my_model, P, T, N) + sum(m.Cp[i]*N[i]*(T - 298.15) for i in eachindex(N)) +end + +function molar_density_simple(m::my_model, P, T, N) + sum(N)/sum(N[i]/(m.ρ_coefs["a"][i] + m.ρ_coefs["b"][i]*T + m.ρ_coefs["c"][i]*T^2 + m.ρ_coefs["d"][i]*T^3) for i in eachindex(N)) +end + + +mymodel = my_model(Cps, pho_coef) +enthalpy_simple(mymodel, 101325, 298.15, [1.0, 1.0, 1.0, 1.0]) +molar_density_simple(mymodel, 101325, 350.15, [1.0, 1.0, 1.0, 1.0]) + +@register_symbolic enthalpy_simple(m::my_model, P::Num, T::Num, N::Vector{Num}) +@register_symbolic molar_density_simple(m::my_model, P::Num, T::Num, N::Vector{Num}) + + +Reaction = KineticReactionNetwork(;substances_user = substances_user, +Af_r = 4.71e9, Ef_r = 32400*1055.6/453.6, Coef_Cr = [-1.0 0.0 1.0 -1.0], +Do_r = [1.0 0.0 0.0 1.0], name = "Propyleneglycol synthesis") +#["water", "methanol", "propyleneglycol","methyloxirane"] +ninports = 1 +InPorts = [matcon(; Nc = Nc, name = Symbol("InPorts$i")) for i in 1:ninports] + +Ac = 26.51 # m² +height_out_port = 0.0 +Nri = Reaction.Nri + +#Constants +GravitationalConst = 9.81 # m²/s +gramsToKilograms = 10^(-3) +Rᵍ = 8.314 # J/(mol K) + +#Properties of individual substances +MWs = [properties[subs]["MW"] for subs in substances_user] +ΔH₀f = [properties[subs]["IGHF"]/10^3 for subs in substances_user] # (IG formation enthalpy) J/mol + + +pars = @parameters begin +height_out = height_out_port, [description = "Height of the outlet stream port with reference from the bottom of the tank (m)"] +N_InPorts = ninports +Nr = Nri, [description = "Number of reactions"] +Af_r[1:Nri] = Reaction.Af_r, [description = "Arrhenius constant of each reaction at given temperature ()"] +Coef_Cr[1:Nri, 1:Nc] = Reaction.Coef_Cr, [description = "Stoichiometric coefficients of each component in each reaction (-)"] +Do_r[1:Nri, 1:Nc] = Reaction.Do_r, [description = "Forward order of the components (-) "] +Ef_r[1:Nri] = Reaction.Ef_r, [description = "Activation energy of each reaction at given temperature ()"] +N = Nc, [description = "Number of components"] +A = Ac, [description = "Cross sectional area of the tank (m²)"] +end + + +OutPorts = @named begin + Out = matcon(; Nc = Nc) +end + +vars = @variables begin + M(t), [description = "Mass holdup in the tank (kg)"] + N(t), [description = "Total molar holdup in the tank (kmol)"] + V(t), [description = "Volume holdup in the tank (m³)"] + (Nᵢ(t))[1:Nc], [description = "Molar holdup of each component in the tank (mol)"] + (Cᵢ(t))[1:Nc], [description = "Concentration of each component in the tank (mol/m³)"] + (ρ(t)), [description = "Molar Density of the fluid in the tank (mol/m³)"] + (ρʷ(t)), [description = "Mass Density of the fluid in the tank (kg/m³)"] + #h_out(t), [description = "Outlet specific enthalpy (J/mol)"] + MW(t), [description = "Molecular weight of fluid in the tank (kg/kmol)"] + T(t), [description = "Temperature of vessel contents (K)"] + P_out(t), [description = "Pressure at the outlet stream level (Pa)"] + H(t), [description = "Enthalpy holdup of the fluid in the tank (J)"] + #S(t), [description = "Entropy holdup of the fluid in the tank (J/K)"] + F_out(t), [description = "Outlet molar flow rate (mol/s)"] + Fʷ_out(t), [description = "Outlet molar flow rate (mol/s)"] + Q_out(t), [description = "Outlet volumetric flow rate (m³/s)"] # DoF + height(t), [description = "Liquid level in vessel measured from bottom of the tank (m)"] + + (Cᵢ_in(t))[1:Nc, 1:ninports], [description = "Inlet concentration of each component (mol/m³)"] # DoF through inlet stream + (F_in(t))[1:ninports], [description = "Inlet molar flow rate (mol/s)"] # DoF through inlet stream + (Q_in(t))[1:ninports], [description = "Inlet volumetric flow rate(s) (m³/s)"] + (T_in(t))[1:ninports], [description = "Inlet temperature (K)"] # DoF through inlet stream + (h_in(t))[1:ninports], [description = "Inlet specific enthalpy (J/mol)"] + (ρ_in(t))[1:ninports], [description = "Inlet density (mol/m³)"] + (ρʷ_in(t))[1:ninports], [description = "Inlet density (mol/m³)"] + P_atm(t), [description = "Tank pressure (Pa)"] # Equal to inlet pressures. + Q̇(t), [description = "Heat transfer rate (J/s)"] # Potential DoF + (r(t))[1:Nri], [description = "Rate of each reaction for each component (mol/s/m³)"] + (R(t))[1:Nc], [description = "Overall reaction rate (mol/s/m³)"] +end + + + +#Reaction equations +reaction_rate = [r[i] ~ Af_r[i]*exp(-Ef_r[i]/(Rᵍ*T))*prod(scalarize((Cᵢ[:].^Do_r[i, :]))) for i in 1:Nri] # If there's an inert, the order is just zero, but it has to be written +overall_reaction_rate = [R[i] ~ sum(scalarize(r[:].*Coef_Cr[:, i])) for i in 1:Nc] # If there's an inert, the coefficient is just zero, but it has to be written + + +#Inlet connector variables's equations +atm_pressure = [P_atm ~ InPorts[1].P] +mass_density_eqs = [ρʷ_in[j] ~ InPorts[j].ρʷ for j in 1:ninports] +molar_density_eqs = [ρ_in[j] ~ InPorts[j].ρ for j in 1:ninports] +inletenthalpy = [h_in[j] ~ InPorts[j].H for j in 1:ninports] +inletconcentrations = [Cᵢ_in[i, j] ~ InPorts[j].z₁[i]*ρ_in[j] for j in 1:ninports for i in 1:Nc] +inlettemperature_eqs = [T_in[j] ~ InPorts[j].T for j in 1:ninports] +inletmolarflow_eqs = [F_in[j] ~ InPorts[j].F for j in 1:ninports] +volumetricflow_eqs = [Q_in[j] ~ F_in[j] / ρ_in[j] for j in 1:ninports] + + +#Outlet connector equations: +out_conn = [Out.P ~ P_out + Out.T ~ T + Out.F ~ - F_out + Out.Fʷ ~ - Fʷ_out + Out.H ~ H/N + Out.S ~ 0.0 + Out.ρʷ ~ ρʷ + Out.ρ ~ ρ + scalarize(Out.z₁ .~ Nᵢ/N)... + Out.MW[1] ~ MW +] + +if phase == :liquid +out_conn_phases = [ + scalarize(Out.z₂ .~ 0.0)... + scalarize(Out.z₃ .~ Out.z₁)... + Out.MW[2] ~ 0.0 + Out.MW[3] ~ Out.MW[1] + Out.α_g ~ 0.0] + +elseif phase == :vapor + out_conn_phases = [ + scalarize(Out.z₂ .~ Out.z₁)... + scalarize(Out.z₃ .~ 0.0)... + Out.MW[2] ~ Out.MW[1] + Out.MW[3] ~ 0.0 + Out.α_g ~ 1.0] +end + + + +#balances +mass_balance = [D(M) ~ sum(scalarize(Q_in.*ρʷ_in)) - Q_out*ρʷ] +component_balance = [D(Nᵢ[i]) ~ sum(scalarize(Q_in.*Cᵢ_in[i, :])) - Q_out*Cᵢ[i] + R[i]*V for i in 1:Nc] #Neglectable loss to vapor phase head space +energy_balance = [D(H) ~ sum(scalarize(Q_in.*ρ_in.*h_in)) - Q_out*ρ*H/N + Q̇] +jacket_energy_balance = [Q̇ ~ -2.27*4184.0*(T - 288.7)*(1.0 - exp(-8440.26/(2.27*4184)))] +mass_volume_eq = [ρ*V ~ N] +mol_holdup = [N ~ sum(scalarize(Nᵢ))] +mol_to_concentration = [scalarize(Nᵢ .~ Cᵢ*V)...] +height_to_volume = [height*A ~ V] +volumetricflow_to_molarflow = [Q_out ~ F_out/ρ] +volumetricflow_to_massflow = [Q_out ~ Fʷ_out/ρʷ] + +#Thermodynamic properties (outlet) +pressure_out = [phase == :liquid ? P_out ~ P_atm + ρʷ*GravitationalConst*(height - height_out) : P_out ~ P_atm] #Estimation considering static pressure (May be off as tank is agitated and not static) +density_eqs = [ρ ~ molar_density_simple(mymodel, P_out, T, Nᵢ)] +mass_density = [ρʷ ~ ρ*MW] +globalEnthalpy_eq = [H ~ enthalpy_simple(mymodel, P_out, T, Nᵢ) + sum(scalarize(ΔH₀f.*Nᵢ))] +molar_mass = [MW ~ sum(scalarize(MWs.*Nᵢ)/N)*gramsToKilograms] + + +eqs = [reaction_rate...; overall_reaction_rate...; atm_pressure...; mass_density_eqs...; molar_density_eqs...; inletenthalpy...; inletconcentrations...; inlettemperature_eqs...; inletmolarflow_eqs...; volumetricflow_eqs...; out_conn...; +out_conn_phases...; mass_balance...; component_balance...; energy_balance...; jacket_energy_balance...; mass_volume_eq...; mol_holdup...; mol_to_concentration...; height_to_volume...; volumetricflow_to_molarflow...; volumetricflow_to_massflow...; +pressure_out...; density_eqs...; mass_density...; globalEnthalpy_eq...; molar_mass...] + +eqs_cstr = [reaction_rate...; overall_reaction_rate...; atm_pressure...; mass_density_eqs...; molar_density_eqs...; inletenthalpy...; inletconcentrations...; inlettemperature_eqs...; +inletmolarflow_eqs...; volumetricflow_eqs...; mass_balance...; component_balance...; energy_balance...; jacket_energy_balance...; mass_volume_eq...; mol_holdup...; mol_to_concentration...; height_to_volume...; volumetricflow_to_molarflow...; volumetricflow_to_massflow...; +pressure_out...; density_eqs...; mass_density...; globalEnthalpy_eq...; molar_mass...] + +unfold_pars = [] +for par in pars + unfold_pars = [unfold_pars...; par...] +end + +unfold_vars = [] +for var in vars + unfold_vars = [unfold_vars...; var...] +end =# \ No newline at end of file diff --git a/src/Sources/MaterialSource.jl b/src/Sources/MaterialSource.jl new file mode 100644 index 0000000..74e3ebd --- /dev/null +++ b/src/Sources/MaterialSource.jl @@ -0,0 +1,244 @@ +@component function MaterialSource(;substances_user , + Nc = size(substances_user, 1), + model, + properties = Dict(subs => load_component_properties(subs) for subs in substances_user), + P_user, T_user, + Fₜ_user, zₜ_user, name) + #phase 1 is total, 2 is vapor, 3 is liquid + + @assert sum(zₜ_user) ≈ 1.0 "Sum of fractions is not close to one" + + Tcs = [properties[subs]["Tc"] for subs in substances_user] #Critical temperature (K) + MWs = [properties[subs]["MW"] for subs in substances_user] #Molecular weight (g/mol) + ΔH₀f = [properties[subs]["IGHF"]/10^3 for subs in substances_user] # (IG formation enthalpy) J/mol + gramsToKilograms = 10^(-3) + + vars = @variables begin + P(t), [description = "Pressure (Pa)", input = true] + T(t), [description = "Temperature (K)", input = true] + (zₜ(t))[1:Nc], [description = "Components molar fraction (-)", input = true] + Fₜ(t), [description = "Total molar flow rate (mol/s)", input = true] + Tc(t), [description = "Critical temperature (K)", output = true] + Pc(t), [description = "Critical pressure (Pa)", output = true] + P_buble(t), [description = "Bubble point pressure (Pa)"] + P_dew(t), [description = "Dew point pressure (Pa)"] + α_g(t), [description = "Vapor phase molar fraction"] + α_l(t), [description = "Liquid phase molar fraction"] + αᵂ_g(t), [description = "Vapor phase mass fraction"] + αᵂ_l(t), [description = "Liquid phase mass fraction"] + (Fⱼ(t))[1:3], [description = "Molar flow rate in each phase j (mol/s)"] + (Fᵂⱼ(t))[1:3], [description = "Mass flow rate in each phase j (kg/s)"] + (zⱼᵢ(t))[1:3, 1:Nc], [description = "Component molar fraction in each phase j component i (-)"] + (zᵂⱼᵢ(t))[1:3, 1:Nc], [description = "Component mass fraction in each phase j component i (-)"] + (Fⱼᵢ(t))[1:3, 1:Nc], [description = "Molar flow rate in each phase j and component i (mol/s)"] + (Fᵂⱼᵢ(t))[1:3, 1:Nc], [description = "Mass flow rate in each phase j and component i (mol/s)"] + (Hⱼ(t))[1:3], [description = "Enthalpy in each phase j at T and P (J/mol)"] + (Sⱼ(t))[1:3], [description = "Entropy in each phase j at T and P (J/mol.K)"] + (ρ(t))[1:3], [description = "Molar density in each phase j (mol/m³)"] + (ρʷ(t))[1:3], [description = "Mass density in each phase j(mol/m³)"] + (MWⱼ(t))[1:3], [description = "Molar mass of each phase j (kg/mol)"] + end + + systems = @named begin + Out = matcon(; Nc = Nc, P_start ) + end + + #Connector equations + eqs_conn = [ + P ~ P_user + T ~ T_user + scalarize(zₜ .~ zₜ_user)... + Fₜ ~ Fₜ_user + + #Out stuff + Out.P ~ - P + Out.T ~ - T + Out.F ~ - Fₜ # F is negative as it is leaving the pbject + Out.Fʷ ~ - Fᵂⱼ[1] + Out.H ~ - Hⱼ[1] + Out.S ~ - Sⱼ[1] + scalarize(Out.z₁ .+ zⱼᵢ[1, :] .~ 0.0)... + scalarize(Out.z₂ .+ zⱼᵢ[2, :] .~ 0.0)... + scalarize(Out.z₃ .+ zⱼᵢ[3, :] .~ 0.0)... + Out.α_g ~ - α_g + Out.ρ ~ - ρ[1] + Out.ρʷ ~ - ρʷ[1] + scalarize(Out.MW .~ - MWⱼ)... + ] + + #Global Mass and Molar balances + global_mol_balance = [ + Fⱼ[1] ~ Fₜ + Fⱼ[1] - Fⱼ[2] - Fⱼ[3] ~ 0.0 + #Fᵂⱼ[1] - Fᵂⱼ[2] - Fᵂⱼ[3] ~ 0.0 + α_l + α_g ~ 1.0 + Fⱼ[2] ~ α_g*Fⱼ[1] + + αᵂ_g + αᵂ_l ~ 1.0 + αᵂ_g ~ Fᵂⱼ[2]/Fᵂⱼ[1] + + ] + + # Mass based Equations + + molar_to_mass = [ + scalarize(Fᵂⱼ[:] .~ sum(Fᵂⱼᵢ[:, :], dims = 2))... + ] + + molar_to_mass_2 = [scalarize(Fᵂⱼᵢ[:, i] .~ (MWs[i]*gramsToKilograms)*Fⱼᵢ[:, i] ) for i in 1:Nc] + + molar_to_mass = [molar_to_mass...; molar_to_mass_2...] + + #Component Molar and Mass Balance + component_balance = [scalarize(Fⱼᵢ[:, i] .~ Fⱼ[:].*zⱼᵢ[:, i]) for i in 1:Nc] + + + #Phase check + #Tci, Pci, Vc = crit_mix(model, zₜ_user) #Critical point of the mixture (Removed as too time consuming to calculate) + Tci = minimum(Tcs) + Pci = 0.0 + Pdew, Vᵍdew, Vˡdew, xdew = dew_pressure(model, T_user, zₜ_user) + Pbuble, Vᵍbuble, Vˡbuble, xbuble = bubble_pressure(model, T_user, zₜ_user) + + if T_user ≥ Tci + pc = [α_g ~ 1.0 + Tc ~ Tci + Pc ~ Pci + P_buble ~ Pbuble + P_dew ~ Pdew + Hⱼ[1] ~ enthalpy(model, P_user, T_user, zₜ_user, phase = :vapor) + sum(zₜ_user.*ΔH₀f) + Hⱼ[2] ~ enthalpy(model, P_user, T_user, zₜ_user, phase = :vapor) + sum(zₜ_user.*ΔH₀f) + Hⱼ[3] ~ 0.0 + Sⱼ[1] ~ Sⱼ[2] + Sⱼ[3] ~ 0.0 + Sⱼ[2] ~ entropy(model, P_user, T_user, zₜ_user, phase = :vapor) + scalarize(zⱼᵢ[1, :] .~ zₜ)... + scalarize(zⱼᵢ[2, :] .~ zₜ)... + scalarize(zⱼᵢ[3, :] .~ 0.0)... + scalarize(zᵂⱼᵢ[3, :] .~ 0.0)... # Mass base + scalarize(zᵂⱼᵢ[1, :] .~ zᵂⱼᵢ[2, :])... # Mass base + scalarize(Fᵂⱼᵢ[2, :] .~ Fᵂⱼ[2].*zᵂⱼᵢ[2, :])... # Mass base + ρ[1] ~ molar_density(model, P_user, T_user, zₜ_user, phase = :vapor) + ρ[2] ~ molar_density(model, P_user, T_user, zₜ_user, phase = :vapor) + ρ[3] ~ 0.0 + ρʷ[1] ~ mass_density(model, P_user, T_user, zₜ_user, phase = :vapor) + ρʷ[2] ~ mass_density(model, P_user, T_user, zₜ_user, phase = :vapor) + ρʷ[3] ~ 0.0 + MWⱼ[1] ~ sum(MWs.*zⱼᵢ[2, :]*gramsToKilograms) + MWⱼ[2] ~ sum(MWs.*zⱼᵢ[2, :]*gramsToKilograms) + MWⱼ[3] ~ 0.0 + ] + else + + if P_user < Pdew + pc = [α_g ~ 1.0 + Tc ~ Tci + Pc ~ Pci + P_buble ~ Pbuble + P_dew ~ Pdew + Hⱼ[1] ~ enthalpy(model, P_user, T_user, zₜ_user, phase = :vapor) + sum(zₜ_user.*ΔH₀f) + Hⱼ[2] ~ enthalpy(model, P_user, T_user, zₜ_user, phase = :vapor) + sum(zₜ_user.*ΔH₀f) + Hⱼ[3] ~ 0.0 + Sⱼ[1] ~ Sⱼ[2] + Sⱼ[2] ~ entropy(model, P_user, T_user, zₜ_user, phase = :vapor) + Sⱼ[3] ~ 0.0 + scalarize(zⱼᵢ[1, :] .~ zₜ)... + scalarize(zⱼᵢ[2, :] .~ zₜ)... + scalarize(zⱼᵢ[3, :] .~ 0.0)... + scalarize(zᵂⱼᵢ[3, :] .~ 0.0)... # Mass base + scalarize(zᵂⱼᵢ[1, :] .~ zᵂⱼᵢ[2, :])... # Mass base + scalarize(Fᵂⱼᵢ[2, :] .~ Fᵂⱼ[2].*zᵂⱼᵢ[2, :])... # Mass base + ρ[1] ~ molar_density(model, P_user, T_user, zₜ_user, phase = :vapor) + ρ[2] ~ molar_density(model, P_user, T_user, zₜ_user, phase = :vapor) + ρ[3] ~ 0.0 + ρʷ[1] ~ mass_density(model, P_user, T_user, zₜ_user, phase = :vapor) + ρʷ[2] ~ mass_density(model, P_user, T_user, zₜ_user, phase = :vapor) + ρʷ[3] ~ 0.0 + MWⱼ[1] ~ sum(MWs.*zⱼᵢ[2, :]*gramsToKilograms) + MWⱼ[2] ~ sum(MWs.*zⱼᵢ[2, :]*gramsToKilograms) + MWⱼ[3] ~ 0.0 + + ] + + elseif P_user > Pbuble + pc = [α_g ~ 0.0 + Tc ~ Tci + Pc ~ Pci + P_buble ~ Pbuble + P_dew ~ Pdew + Hⱼ[1] ~ enthalpy(model, P_user, T_user, zₜ_user, phase = :liquid) + sum(zₜ_user.*ΔH₀f) + Hⱼ[3] ~ enthalpy(model, P_user, T_user, zₜ_user, phase = :liquid) + sum(zₜ_user.*ΔH₀f) + Hⱼ[2] ~ 0.0 + Sⱼ[1] ~ entropy(model, P_user, T_user, zₜ_user, phase = :liquid) + Sⱼ[3] ~ entropy(model, P_user, T_user, zₜ_user, phase = :liquid) + Sⱼ[2] ~ 0.0 + scalarize(zⱼᵢ[1, :] .~ zₜ)... + scalarize(zⱼᵢ[3, :] .~ zₜ)... + scalarize(zⱼᵢ[2, :] .~ 0.0)... + scalarize(zᵂⱼᵢ[2, :] .~ 0.0)... # Mass base + scalarize(zᵂⱼᵢ[1, :] .- zᵂⱼᵢ[3, :] .~ 0.0)... # Mass base + scalarize(Fᵂⱼᵢ[3, :] .~ Fᵂⱼ[3].*zᵂⱼᵢ[3, :])... # Mass base + ρ[1] ~ molar_density(model, P_user, T_user, zₜ_user, phase = :liquid) + ρ[3] ~ molar_density(model, P_user, T_user, zₜ_user, phase = :liquid) + ρ[2] ~ 0.0 + ρʷ[1] ~ mass_density(model, P_user, T_user, zₜ_user, phase = :liquid) + ρʷ[3] ~ mass_density(model, P_user, T_user, zₜ_user, phase = :liquid) + ρʷ[2] ~ 0.0 + MWⱼ[1] ~ sum(scalarize(MWs.*zⱼᵢ[3, :])*gramsToKilograms) + MWⱼ[3] ~ sum(scalarize(MWs.*zⱼᵢ[3, :])*gramsToKilograms) + MWⱼ[2] ~ 0.0 + + ] + else + #flash calculation of the two phases (assuming liquid and gas only) + xᵢⱼ, nᵢⱼ, G = tp_flash(model, P_user, T_user, zₜ_user, DETPFlash(; equilibrium = :vle)) #Phase i, component j + H_l = enthalpy(model, P_user, T_user, xᵢⱼ[1, :], phase = :liquid) + H_g = enthalpy(model, P_user, T_user, xᵢⱼ[2, :], phase = :vapor) + S_l = entropy(model, P_user, T_user, xᵢⱼ[1, :], phase = :liquid) + S_g = entropy(model, P_user, T_user, xᵢⱼ[2, :], phase = :vapor) + V_l = volume(model, P_user, T_user, nᵢⱼ[1, :], phase = :liquid) + V_g = volume(model, P_user, T_user, nᵢⱼ[2, :], phase = :vapor) + + pc = [α_g ~ sum(nᵢⱼ[2, :])/(sum(nᵢⱼ[1, :]) + sum(nᵢⱼ[2, :])) # Vapor phase is the second entry + Tc ~ Tci + Pc ~ Pci + P_buble ~ Pbuble + P_dew ~ Pdew + Hⱼ[2] ~ H_g + sum(xᵢⱼ[2, :].*ΔH₀f) + Hⱼ[3] ~ H_l + sum(xᵢⱼ[1, :].*ΔH₀f) + Hⱼ[1] ~ sum(nᵢⱼ[2, :])*Hⱼ[2] + sum(nᵢⱼ[1, :])*Hⱼ[3] + Sⱼ[2] ~ S_g + Sⱼ[3] ~ S_l + Sⱼ[1] ~ sum(nᵢⱼ[2, :])*Sⱼ[2] + sum(nᵢⱼ[1, :])*Sⱼ[3] + scalarize(zⱼᵢ[1, :] .~ zₜ)... #Global phase + scalarize(zⱼᵢ[3, :] .~ xᵢⱼ[1, :])... #Liquid phase + scalarize(zⱼᵢ[2, :] .~ xᵢⱼ[2, :])... #Vapor phase + scalarize(Fᵂⱼᵢ[1, :] .~ Fᵂⱼ[1].*zᵂⱼᵢ[1, :])... # Mass base + scalarize(Fᵂⱼᵢ[2, :] .~ Fᵂⱼ[2].*zᵂⱼᵢ[2, :])... # Mass base + scalarize(Fᵂⱼᵢ[3, :] .~ Fᵂⱼ[3].*zᵂⱼᵢ[3, :])... # Mass base + ρ[1] ~ (sum(nᵢⱼ[2, :]) + sum(nᵢⱼ[1, :]))/(V_l + V_g) + ρ[2] ~ sum(nᵢⱼ[2, :])/V_g + ρ[3] ~ sum(nᵢⱼ[1, :])/V_l + ρʷ[1] ~ (sum(nᵢⱼ[2, :].*MWs)*gramsToKilograms + sum(nᵢⱼ[1, :].*MWs)*gramsToKilograms)/(V_l + V_g) + ρʷ[2] ~ sum(nᵢⱼ[2, :].*MWs)*gramsToKilograms/(V_g) + ρʷ[3] ~ sum(nᵢⱼ[1, :].*MWs)*gramsToKilograms/(V_l) + MWⱼ[1] ~ sum(MWs.*zⱼᵢ[1, :]*gramsToKilograms) + MWⱼ[2] ~ sum(MWs.*zⱼᵢ[2, :]*gramsToKilograms) + MWⱼ[3] ~ sum(MWs.*zⱼᵢ[3, :]*gramsToKilograms) + + ] + end + + end + + #phase 1 is total, 2 is vapor, 3 is liquid + eqs = [eqs_conn..., global_mol_balance..., molar_to_mass..., component_balance..., pc...] + + unfold_vars = [] + for var in vars + unfold_vars = [unfold_vars...; var...] + end + + ODESystem([eqs...;], t, unfold_vars, []; name, systems) +end + diff --git a/src/Sources/Sourceutils.jl b/src/Sources/Sourceutils.jl new file mode 100644 index 0000000..4a91b20 --- /dev/null +++ b/src/Sources/Sourceutils.jl @@ -0,0 +1,116 @@ +@connector function matcon(; Nc, name, + P_start, + T_start, + F_start, + Fʷ_start, + H_start, + S_start, + z₁_start, + z₂_start, + z₃_start, + α_g_start, + ρ_start, + ρʷ_start, + MW_start + ) + + vars = @variables begin + P(t), [guess = P_start, connect = Flow, description = "Pressure (Pa)"] + T(t), [connect = Flow] # Temperature (K) + F(t), [connect = Flow] # Molar Flow rate (mol/s) + Fʷ(t), [connect = Flow] # Mass Flow rate (kg/s) + H(t), [connect = Flow] # Enthalpy (J/mol) + S(t), [connect = Flow] # Entropy (J/mol.K) + (z₁(t))[1:Nc], [connect = Flow] # component molar fraction global (mol/mol) + (z₂(t))[1:Nc], [connect = Flow] # component molar fraction in vapor phase (mol/mol) + (z₃(t))[1:Nc], [connect = Flow] # component molar fraction in liquid phase (mol/mol) + α_g(t), [connect = Flow] # gas phase fraction (mol/mol) + ρ(t), [connect = Flow] # Molar density (mol/m³) + ρʷ(t), [connect = Flow] # Mass density (kg/m³) + (MW(t))[1:3], [connect = Flow] # Molar mass (g/mol) + end + + unfold_vars = [] + for var in vars + unfold_vars = [unfold_vars...; var...] + end + + ODESystem(Equation[], t, unfold_vars, []; name) + +end + +@component function Display(; Nc, name) + + vars = @variables begin + P(t) # Pressure (Pa) + T(t) # Temperature (K) + F(t) # Molar Flow rate (mol/s) + Fʷ(t) # Mass Flow rate (kg/s) + H(t) # Enthalpy (J/mol) + S(t) # Entropy (J/mol.K) + (z₁(t))[1:Nc] # component molar fraction global (mol/mol) + (z₂(t))[1:Nc] # component molar fraction in vapor phase (mol/mol) + (z₃(t))[1:Nc] # component molar fraction in liquid phase (mol/mol) + α_g(t) # gas phase fraction (mol/mol) + ρ(t) # Molar density (mol/m³) + ρʷ(t) # Mass density (kg/m³) + (MW(t))[1:3] # Molar mass (g/mol) + end + + systems = @named begin + InPort = matcon(; Nc = Nc) + end + + eqs_conn = [ + #InPort data + InPort.P ~ + P + InPort.T ~ + T + InPort.F ~ + F + InPort.Fʷ ~ + Fʷ + InPort.H ~ + H + InPort.S ~ + S + scalarize(InPort.z₁ .- z₁ .~ 0.0)... + scalarize(InPort.z₂ .- z₂ .~ 0.0)... + scalarize(InPort.z₃ .- z₃ .~ 0.0)... + InPort.α_g ~ + α_g + InPort.ρ ~ + ρ + InPort.ρʷ ~ + ρʷ + scalarize(InPort.MW .~ + MW)... + ] + + unfold_vars = [] + for var in vars + unfold_vars = [unfold_vars...; var...] + end + + ODESystem(eqs_conn, t, unfold_vars, []; name, systems) + +end + + + + + + + + + +#= function ModelingToolkit.connect(::Type{matcon}, con...) + eqs = [] + for i in length(con) - 1 + push!(eqs, con[i].P ~ con[i+1].P ) + push!(eqs, con[i].T ~ con[i+1].T ) + push!(eqs, con[i].F ~ -con[i+1].F ) + push!(eqs, con[i].Fʷ ~ -con[i+1].Fʷ ) + push!(eqs, con[i].H ~ con[i+1].H ) + push!(eqs, con[i].S ~ con[i+1].S ) + push!(eqs, scalarize(con[i].z₁ .~ con[i+1].z₁)...) + push!(eqs, scalarize(con[i].z₂ .~ con[i+1].z₂)...) + push!(eqs, scalarize(con[i].z₃ .~ con[i+1].z₃)...) + push!(eqs, con[i].α_g ~ con[i+1].α_g ) + push!(eqs, con[i].ρ ~ con[i+1].ρ ) + push!(eqs, con[i].ρʷ ~ con[i+1].ρʷ ) + push!(eqs, scalarize(con[i].MW .~ con[i+1].MW)...) + end + return eqs +end =# diff --git a/src/database/carbon monoxide.json b/src/database/carbon monoxide.json new file mode 100644 index 0000000..0d8a6de --- /dev/null +++ b/src/database/carbon monoxide.json @@ -0,0 +1,40 @@ +{ + "SN": 5, + "name": "carbonmonoxide", + "CAS": "630-08-0", + "Tc": 132.85, + "Pc": 3494000, + "Vc": 0.0931, + "Cc": 0.292, + "Tb": 81.66, + "Tm": 68.15, + "TT": 68.15, + "TP": 15400, + "MW": 28.01, + "LVB": 0.03488, + "AF": 0.045, + "SP": 6402, + "DM": 3.74E-31, + "SH": -110530000.0, + "IGHF": -1.1053E+08, + "GEF": -1.3715E+08, + "AS": 197556, + "HFMP": 840984, + "HOC": -2.83E+08, + "LiqDen": [105, 2.2423, 0.2437, 132.93, 0.24196, 0], + "VP": [101, 42.283, -1035.1, -4.2012, 0.000062546, 2], + "LiqCp": [16, 63364, -10524, 359.6, -3.9494, 0.014624], + "HOV": [106, 8585000, 0.4921, -0.326, 0.2231, 0], + "VapCp": [16, 29100, -1979.753, 10.58274, -0.0000790406, -1.99685E-07], + "ReidCp": [32.52617776221547,-0.03253449222483362,9.827694814657128e-5,-1.080880140359921e-7,4.2819482483489174e-11], + "LiqVis": [101, -82.158, 1037.8, 14.229, -0.00028204, 2], + "VapVis": [102, 0.0000012713, 0.51494, 105.97, -231.11, 0], + "LiqK": [16, -0.23621, -3.5251, -0.55788, -0.0039362, -0.0000082725], + "VapK": [102, 0.00061581, 0.6828, 61.287, 221.32, 0], + "Racketparam": 0.2918, + "UniquacR": 1.0679, + "UniquacQ": 1.112, + "ChaoSeadAF": 0.093, + "ChaoSeadSP": 6402.36, + "ChaoSeadLV": 0.0354426 +} \ No newline at end of file diff --git a/src/database/methane.json b/src/database/methane.json new file mode 100644 index 0000000..f4d6fff --- /dev/null +++ b/src/database/methane.json @@ -0,0 +1,40 @@ +{ + "SN": 31, + "name": "methane", + "CAS": "74-82-8", + "Tc": 190.56, + "Pc": 4599000, + "Vc": 0.0986, + "Cc": 0.286, + "Tb": 111.66, + "Tm": 90.694, + "TT": 90.694, + "TP": 11696, + "MW": 16.043, + "LVB": 0.03554, + "AF": 0.011, + "SP": 11600, + "DM": 0, + "SH": -74520000.0, + "IGHF": -74520000.0, + "GEF": -50490000.0, + "AS": 186270, + "HFMP": 941400, + "HOC": -802620000.0, + "LiqDen": [105, 1.894, 0.23603, 191.05, 0.21974, 0], + "VP": [101, 39.98844, -1337.308, -3.580049, 0.0000320698, 2], + "LiqCp": [16, 61157, 5034.1, -48.913, -0.22998, 0.0022243], + "HOV": [106, 14418000.0, 2.3055, -5.4199, 5.658, -2.1286], + "VapCp": [16, 33151.9, -1220.001, 12.0907, -0.000384791, 9.896403E-08], + "ReidCp": [37.98046523972399,-0.07462230199792531, 0.00030189813766514414, -2.832737414004808e-7, 9.071078716405182e-11], + "LiqVis": [101, -45.328, 724.39, 6.5917, -0.00010373, 2], + "VapVis": [102, 5.3432E-07, 0.58831, 114.58, -1338.5, 0], + "LiqK": [16, 0.011567, -46.041, 0.10435, -0.012133, -0.0000051716], + "VapK": [102, 0.0000074705, 1.4432, -57.569, 587.82, 0], + "Racketparam": 0.2876, + "UniquacR": 1.1239, + "UniquacQ": 1.152, + "ChaoSeadAF": 0, + "ChaoSeadSP": 11618.44, + "ChaoSeadLV": 0.0378392 +} diff --git a/src/database/methanol.json b/src/database/methanol.json new file mode 100644 index 0000000..cbe66d0 --- /dev/null +++ b/src/database/methanol.json @@ -0,0 +1,40 @@ +{ + "SN": 32, + "name": "methanol", + "CAS": "67-56-1", + "Tc": 512.64, + "Pc": 8097000, + "Vc": 0.118, + "Cc": 0.224, + "Tb": 337.69, + "Tm": 175.47, + "TT": 175.47, + "TP": 0.111264, + "MW": 32.042, + "LVB": 0.04073, + "AF": 0.565, + "SP": 29440, + "DM": 5.67E-30, + "SH": -74520000.0, + "IGHF": -2.0094E+08, + "GEF": -1.6232E+08, + "AS": 239880, + "HFMP": 3215000, + "HOC": -6.382E+08, + "LiqDen": [105, 1.7918, 0.23929, 512.64, 0.21078, 0], + "VP": [101, 73.40342, -6548.076, -7.409987, 5.72492E-06, 2], + "LiqCp": [16, 62799, 1254.2, -5.9906, 0.052937, -0.00004711], + "HOV": [106, 5.8058E+07, 0.87168, -0.81501, 0.1695, 0.17846], + "VapCp": [16, 36313.16, -680.4577, 11.10203, 0.000756766, -2.902645E-07], + "ReidCp": [39.19437678197436,-0.05808483585041852,0.0003501220208504329,-3.6941157412454843e-7,1.276270011886522e-10], + "LiqVis": [101, -32.996, 1981.4, 3.3666, -0.0000039246, 2], + "VapVis": [102, 3.0654E-07, 0.69658, 204.87, 24.304, 0], + "LiqK": [16, -0.056817, 13.156, -1.2214, -0.00028282, -0.0000010129], + "VapK": [102, 7.8368E-07, 1.7569, 108.12, -21101, 0], + "Racketparam": 0, + "UniquacR": 1.43, + "UniquacQ": 1.43, + "ChaoSeadAF": 0.5589, + "ChaoSeadSP": 29546.4, + "ChaoSeadLV": 0.0407027 +} diff --git a/src/database/methyloxirane.json b/src/database/methyloxirane.json new file mode 100644 index 0000000..9d9a7ed --- /dev/null +++ b/src/database/methyloxirane.json @@ -0,0 +1,41 @@ + +{ + "SN": 409, + "name": "methyloxirane", + "CAS": "75-56-9", + "Tc": 482.25, + "Pc": 4920000, + "Vc": 0.186, + "Cc": 0.228, + "Tb": 307.05, + "Tm": 161.22, + "TT": 161.22, + "TP": 0.965624, + "MW": 58.0791, + "LVB": 0.0705481, + "AF": 0.268304, + "SP": 19050, + "DM": 6.7E-30, + "SH": -61100000.0, + "IGHF": -93720000, + "GEF": -25800000, + "AS": 286700, + "HFMP": 6531000, + "HOC": -1790000000, + "LiqDen": [105, 1.5769, 0.28598, 482.25, 0.29139, 0], + "VP": [101, 83.693, -5715.8, -9.522, 0.00001033, 2], + "LiqCp": [16, 78704, 274.26, 7.2963, 0.0088641, -0.0000023407], + "HOV": [106, 52413050, 1.339985, -1.496096, 0.72766, -0.151947], + "VapCp": [16, 42195, -578.73, 12.252, 0.00010777, -4.7082E-08], + "ReidCp": [34.91747774761048, -1.4935581577635826e-02, 7.56101594841365e-04, -1.0894144551347726e-06, 4.896983427747592e-10], + "LiqVis": [101, 20.905, 283.5, -5.5156, 0.000016261, 2], + "VapVis": [102, 1.1059E-07, 0.81831, 109.91, -5863.4, 0], + "LiqK": [16, 0.10066, 294.75, -5.9561, 0.019433, -0.000039547], + "VapK": [102, 0.00022671, 0.95467, 579.31, 32798, 0], + "Racketparam": 0.228, + "UniquacR": 2.2663, + "UniquacQ": 1.856, + "ChaoSeadAF": 0.268304, + "ChaoSeadSP": 19050, + "ChaoSeadLV": 0.0705481 +} diff --git a/src/database/propyleneglycol.json b/src/database/propyleneglycol.json new file mode 100644 index 0000000..6315807 --- /dev/null +++ b/src/database/propyleneglycol.json @@ -0,0 +1,40 @@ +{ + "SN": 32, + "name": "propylene glycol", + "CAS": "57-55-6", + "Tc": 625.00, + "Pc": 6070.00e3, + "Vc": 0, + "Cc": 0, + "Tb": 0, + "Tm": 0, + "TT": 0, + "TP": 0, + "MW": 76.09, + "LVB": 0, + "AF": 0, + "SP": 0, + "DM": 0, + "SH": 0, + "IGHF": -4.3530E+08, + "GEF": 0, + "AS": 0, + "HFMP": 0, + "HOC": 0, + "LiqDen": 0, + "VP": 0, + "LiqCp": 0, + "HOV": 0, + "VapCp":0, + "ReidCp": [25.7415, 0.2355,0.0001578, -4.0939e-7, 2.1166e-10], + "LiqVis": 0, + "VapVis": 0, + "LiqK": 0, + "VapK": 0, + "Racketparam": 0, + "UniquacR": 0, + "UniquacQ": 0, + "ChaoSeadAF": 0, + "ChaoSeadSP": 0, + "ChaoSeadLV": 0 +} diff --git a/src/database/water.json b/src/database/water.json new file mode 100644 index 0000000..ec25719 --- /dev/null +++ b/src/database/water.json @@ -0,0 +1,40 @@ +{ + "SN": 14, + "name": "water", + "CAS": "7732-18-5", + "Tc": 647.14, + "Pc": 22064000, + "Vc": 0.05595, + "Cc": 0.229, + "Tb": 373.15, + "Tm": 273.15, + "TT": 273.16, + "TP": 611.73, + "MW": 18.015, + "LVB": 0.01807, + "AF": 0.344, + "SP": 47860, + "DM": 6.17E-30, + "SH": 0.0, + "IGHF": -2.41814E+08, + "GEF": -2.2859E+08, + "AS": 188724, + "HFMP": 6001740, + "HOC": 0, + "LiqDen": [106, 32.51621, -3.213004, 7.92411, -7.359898, 2.703522], + "VP": [101, 74.55502, -7295.586, -7.442448, 0.0000042881, 2], + "LiqCp": [16, 75539, -22297, 136.02, -0.25622, 0.00018273], + "HOV": [106, 5.964E+07, 0.86515, -1.1134, 0.67764, -0.026925], + "VapCp": [16, 33200, -878.9001, 8.436956, 0.00207627, -6.467085E-07], + "ReidCp": [36.54206320678348,-0.03480434051958945,0.000116818199785053,-1.3003819534791665e-7,5.2547403746728466e-11], + "LiqVis": [101, -133.7, 6785.7, 18.47, -0.000014736, 2], + "VapVis": [102, 7.002327E-08, 0.934576, 195.6338, -13045.99, 0], + "LiqK": [16, -1.5697, -55.141, 0.7832, 0.0011484, -0.0000018151], + "VapK": [102, 0.0000065986, 1.3947, 59.478, -15484, 0], + "Racketparam": 0.2338, + "UniquacR": 0.92, + "UniquacQ": 1.4, + "ChaoSeadAF": 0.328, + "ChaoSeadSP": 47812.7, + "ChaoSeadLV": 0.0180674 +} diff --git a/src/utils b/src/utils new file mode 100644 index 0000000..e07f393 --- /dev/null +++ b/src/utils @@ -0,0 +1,56 @@ +""" + load_component_properties(filepath::String) + +Load component properties from a file. + +# Arguments +- `filepath::String`: Path to the file containing the component properties. + +# Returns +- `properties::Dict`: A dictionary containing the component properties. +""" +function load_component_properties(component_name::String) + file_path = abspath(joinpath(@__DIR__, "database/$(component_name).json")) + if isfile(file_path) + return JSON.parsefile(file_path) + else + error("Component file does not exist: $file_path") + end +end + + +function read_reidcp(data, substances) + a = [] + b = [] + c = [] + d = [] + e = [] + + for i in eachindex(substances) + reidcp = data[substances[i]]["ReidCp"] + push!(a, Float64(reidcp[1])) + push!(b, Float64(reidcp[2])) + push!(c, Float64(reidcp[3])) + push!(d, Float64(reidcp[4])) + push!(e, Float64(reidcp[5])) + end + + return (a = Float64.(a), b = Float64.(b), c = Float64.(c), d = Float64.(d), e = Float64.(e)) +end + + +struct my_model + Cp + ρ_coefs +end + +function enthalpy_simple(m::my_model, P, T, N) + sum(m.Cp[i]*N[i]*(T - 298.15) for i in eachindex(N)) +end + +function molar_density_simple(m::my_model, P, T, N) + sum(N)/sum(N[i]/(m.ρ_coefs["a"][i] + m.ρ_coefs["b"][i]*T + m.ρ_coefs["c"][i]*T^2 + m.ρ_coefs["d"][i]*T^3) for i in eachindex(N)) +end + +@register_symbolic enthalpy_simple(m::my_model, P::Num, T::Num, N::Vector{Num}) +@register_symbolic molar_density_simple(m::my_model, P::Num, T::Num, N::Vector{Num}) diff --git a/test/Reactor_tests/CSTR_test.jl b/test/Reactor_tests/CSTR_test.jl new file mode 100644 index 0000000..e6a2156 --- /dev/null +++ b/test/Reactor_tests/CSTR_test.jl @@ -0,0 +1,73 @@ +using ProcessSimulator +using ModelingToolkit, DifferentialEquations, Clapeyron +import ModelingToolkit: get_unknowns, get_observed, get_defaults, get_eqs +using ModelingToolkit: t_nounits as t, D_nounits as D +using JSON +using NonlinearSolve +using Test + + +# Test for CSTR + +#---------- Source objct +substances = ["water", "methanol", "propyleneglycol","methyloxirane"] +properties = Dict(subs => load_component_properties(subs) for subs in substances) +idealmodel = ReidIdeal(substances; userlocations = read_reidcp(properties, substances)) +PCSAFT_model = PCPSAFT(substances, idealmodel = idealmodel) + +@named source = MaterialSource(;substances_user = substances, +model = PCSAFT_model, +P_user = 101325, T_user = 297.0, +Fₜ_user = (36.3 + 453.6 + 45.4)*1e3/3600, +zₜ_user = [0.8473, 1.0 - (0.0678 + 0.8473), 0.0, 0.0678]) + + +#----------------- CSTR object +Reaction = KineticReactionNetwork(;substances_user = substances, +Af_r = 4.71e9, Ef_r = 32400*1055.6/453.6, Coef_Cr = [-1.0 0.0 1.0 -1.0], +Do_r = [1.0 0.0 0.0 1.0], name = "Propyleneglycol synthesis") + +#explicit enthalpy and density model +Cps = [69.21, 80.66, 192.50, 118.1] # At 298.00 K +pho_coef = Dict("a" => [78821.04345816873, 38133.33588802956, 18453.26055238924, 25211.86290505424], +"b" => [-114.80261704286386, -85.22435577664774, -26.084451261000222, -73.31971618413455], +"c" => [0.208885275623327, 0.21416405813277503, 0.046784549601356355, 0.18909331028746998], +"d" => [-0.00022293440498512672, -0.0002675908503439664, -4.722426797584051e-5, -0.00022514899466957527]) + + +mymodel = my_model(Cps, pho_coef) + + +@named Display_CSTR = Display(; Nc = 4) + +@named R_101 = SimpleCSTR(; substances_user = substances, + phase = :liquid, + model = mymodel, + Reaction = Reaction, + ninports = 1, + Ac = 1.93, #m² + height_out_port = 0.0 #m + ) + +cons = [connect(source.Out, R_101.InPorts1), + connect(R_101.Out, Display_CSTR.InPort)] + +flowsheet = compose(ODESystem(cons, t; name = :mycon), [R_101, source, Display_CSTR]) +sistema = structural_simplify(flowsheet) +equations(sistema) +unknowns(sistema) +alg_equations(sistema) + +u0 = [sistema.R_101.Nᵢ[1] => 1.9*57252.65, sistema.R_101.Nᵢ[2] => 0.0, + sistema.R_101.Nᵢ[3] => 0.0, sistema.R_101.Nᵢ[4] => 0.0, + sistema.R_101.T => 297.0] + +prob = ODEProblem(sistema, u0, (0.0, 1.0)) + + +#= using ProcessSimulator +using Test + +y = Gibbs(2.0) + +@test y == 4.0 =# \ No newline at end of file diff --git a/test/Reactor_tests/gibbs_tests.jl b/test/Reactor_tests/gibbs_tests.jl deleted file mode 100644 index d8c9d28..0000000 --- a/test/Reactor_tests/gibbs_tests.jl +++ /dev/null @@ -1,6 +0,0 @@ -using ProcessSimulator -using Test - -y = Gibbs(2.0) - -@test y == 4.0 \ No newline at end of file diff --git a/test/Sources_tests/mat_con_tests.jl b/test/Sources_tests/mat_con_tests.jl new file mode 100644 index 0000000..168e35d --- /dev/null +++ b/test/Sources_tests/mat_con_tests.jl @@ -0,0 +1 @@ +using ProcessSimulator diff --git a/test/Sources_tests/source_tests.jl b/test/Sources_tests/source_tests.jl new file mode 100644 index 0000000..f91e0c9 --- /dev/null +++ b/test/Sources_tests/source_tests.jl @@ -0,0 +1,34 @@ +using ProcessSimulator +using ModelingToolkit, DifferentialEquations, Clapeyron +import ModelingToolkit: get_unknowns, get_observed, get_defaults, get_eqs +using ModelingToolkit: t_nounits as t, D_nounits as D +using JSON +using NonlinearSolve +using Test + +substances = ["water", "methanol", "propyleneglycol","methyloxirane"] +properties = Dict(subs => load_component_properties(subs) for subs in substances) +idealmodel = ReidIdeal(substances; userlocations = read_reidcp(properties, substances)) +PCSAFT_model = PCPSAFT(substances, idealmodel = idealmodel) + +@named source = MaterialSource(; substances_user = substances, +model = PCSAFT_model, +P_user = 101325, T_user = 297.0, +Fₜ_user = (36.3 + 453.6 + 45.4)*1e3/3600, +zₜ_user = [0.8473, 1.0 - (0.0678 + 0.8473), 0.0, 0.0678]) + +@named myDisplay = Display(; Nc = 4) + +connections = ODESystem([connect(source.Out, myDisplay.InPort)], t, [], [] ; name = :connection) + +system = compose(connections, [source, myDisplay]) + + +sys = structural_simplify(system) +variables = get_unknowns(sys) +u0 = [x => 0.5 for x in variables] +prob = SteadyStateProblem(sys, u0) +sol = solve(prob, SSRootfind()) +sol[myDisplay.z₃] + +