dfttoolkit.utils package

Submodules

dfttoolkit.utils.file_crawler module

dfttoolkit.utils.file_crawler.find_aims_output_file(calc_dir, allow_all_out_files=False)[source]

Searches directory for output files

dfttoolkit.utils.file_crawler.find_all_aims_output_files(directory, include_restart=True, allow_all_out_files=False)[source]

Recursively searches for AIMS output files and returns their full filenames as a list

dfttoolkit.utils.file_crawler.find_file(calc_dir, allow_all_out_files=False, list_of_filenames=[])[source]

Searches directory for output files

dfttoolkit.utils.file_crawler.find_vasp_output_file(calc_dir)[source]

Searches directory for output files

dfttoolkit.utils.file_utils module

class dfttoolkit.utils.file_utils.ClassPropertyDescriptor(fget, fset=None)[source]

Bases: object

setter(func)[source]
class dfttoolkit.utils.file_utils.MultiDict(*args: Tuple[str, Any])[source]

Bases: MutableMapping

Dictionary that can assign ‘multiple values’ to a single key.

Very basic implementation that works by having each value as a list, and appending new values to the list

reversed_items()[source]

Yields (key, value) pairs in reverse key order and reversed values

dfttoolkit.utils.file_utils.aims_bin_path_prompt(change_bin: bool | str, save_dir) str[source]

Prompt the user to enter the path to the FHI-aims binary, if not already found in .aims_bin_loc.txt

If it is found in .aims_bin_loc.txt, the path will be read from there, unless change_bin is True, in which case the user will be prompted to enter the path again.

Parameters:
  • change_bin (Union[bool, str]) – whether the user wants to change the binary path. If str == “change_bin”, the user will be prompted to enter the path to the binary again.

  • save_dir (str) – the directory to save or look for the .aims_bin_loc.txt file

Returns:

binary – path to the location of the FHI-aims binary

Return type:

str

dfttoolkit.utils.file_utils.classproperty(func)[source]

Combine class methods and properties to make a classproperty

dfttoolkit.utils.geometry_utils module

dfttoolkit.utils.geometry_utils.read_xyz_animation(filename) list[source]

Reads an XYZ animation file, i.e. an XYZ file containing serveral geometries.

Parameters:

filename (str) – path to xyz animation file

Returns:

list of XYZGeometries

Return type:

list

dfttoolkit.utils.math_utils module

dfttoolkit.utils.math_utils.apply_gaussian_window(data, std=0.4)[source]

Apply a Gaussian window to an array.

Parameters:
  • data (np.array) – Input data array to be windowed.

  • std (float) – Standard deviation of the Gaussian window.

Returns:

windowed_data – Windowed data array.

Return type:

np.array

dfttoolkit.utils.math_utils.apply_hann_window(data)[source]

Apply a Hann window to an array.

Parameters:

data (np.ndarray) – Input data array to be windowed.

Returns:

Windowed data array.

Return type:

np.ndarray

dfttoolkit.utils.math_utils.gaussian_window(N, std=0.4)[source]

Generate a Gaussian window.

Parameters:
  • N (int) – Number of points in the window.

  • std (float) – Standard deviation of the Gaussian window, normalized such that the maximum value occurs at the center of the window.

Returns:

window – Gaussian window of length N.

Return type:

np.array

dfttoolkit.utils.math_utils.get_angle_between_vectors(vector_1: ndarray[Any, dtype[_ScalarType_co]], vector_2: ndarray[Any, dtype[_ScalarType_co]]) ndarray[Any, dtype[_ScalarType_co]][source]

Determines angle between two vectors.

Parameters:
  • vector_1 (npt.NDArray)

  • vector_2 (npt.NDArray)

Returns:

angle – Angle in radiants.

Return type:

float

dfttoolkit.utils.math_utils.get_autocorrelation_function_manual_lag(signal: ndarray[Any, dtype[_ScalarType_co]], max_lag: int) ndarray[Any, dtype[_ScalarType_co]][source]

Alternative method to determine the autocorrelation function for a given signal that used numpy.corrcoef. This function allows to set the lag manually.

Parameters:
  • signal (1D npt.NDArray) – Siganl for which the autocorrelation function should be calculated.

  • max_lag (Union[None, int]) – Autocorrelation will be calculated for a range of 0 to max_lag, where max_lag is the largest lag for the calculation of the autocorrelation function

Returns:

autocorrelation – Autocorrelation function from 0 to max_lag.

Return type:

npt.NDArray

dfttoolkit.utils.math_utils.get_cartesian_coords(frac_coords: ndarray[Any, dtype[_ScalarType_co]], lattice_vectors: ndarray[Any, dtype[_ScalarType_co]]) ndarray[Any, dtype[_ScalarType_co]][source]

Transform fractional coordinates into cartesian coordinates.

Parameters:
  • frac_coords ([N x N_dim] numpy array) – Fractional coordinates of atoms (can be Nx2 or Nx3)

  • lattice_vectors ([N_dim x N_dim] numpy array:) – Matrix of lattice vectors: Each ROW corresponds to one lattice vector!

Returns:

cartesian_coords – Cartesian coordinates of atoms

Return type:

[N x N_dim] numpy array

dfttoolkit.utils.math_utils.get_cross_correlation_function(signal_0: ndarray[Any, dtype[_ScalarType_co]], signal_1: ndarray[Any, dtype[_ScalarType_co]], detrend: bool = False) ndarray[Any, dtype[_ScalarType_co]][source]

Calculate the autocorrelation function for a given signal.

Parameters:
  • signal_0 (1D npt.NDArray) – First siganl for which the correlation function should be calculated.

  • signal_1 (1D npt.NDArray) – Second siganl for which the correlation function should be calculated.

Returns:

correlation – Autocorrelation function from 0 to max_lag.

Return type:

npt.NDArray

dfttoolkit.utils.math_utils.get_fourier_transform(signal: ndarray[Any, dtype[_ScalarType_co]], time_step: float) tuple[source]

Calculate the fourier transform of a given siganl.

Parameters:
  • signal (1D npt.NDArray) – Siganl for which the autocorrelation function should be calculated.

  • time_step (float) – Time step of the signal in seconds.

Returns:

Frequencs and absolute values of the fourier transform.

Return type:

(npt.NDArray, npt.NDArray)

dfttoolkit.utils.math_utils.get_fractional_coords(cartesian_coords: ndarray[Any, dtype[_ScalarType_co]], lattice_vectors: ndarray[Any, dtype[_ScalarType_co]]) ndarray[Any, dtype[_ScalarType_co]][source]

Transform cartesian coordinates into fractional coordinates.

Parameters:
  • cartesian_coords ([N x N_dim] numpy array) – Cartesian coordinates of atoms (can be Nx2 or Nx3)

  • lattice_vectors ([N_dim x N_dim] numpy array:) – Matrix of lattice vectors: Each ROW corresponds to one lattice vector!

Returns:

fractional_coords – Fractional coordinates of atoms

Return type:

[N x N_dim] numpy array

dfttoolkit.utils.math_utils.get_mirror_matrix(normal_vector: ndarray[Any, dtype[_ScalarType_co]]) ndarray[Any, dtype[_ScalarType_co]][source]

Generates a transformation matrix for mirroring through plane given by the normal vector.

Parameters:

normal_vector (npt.NDArray) – Normal vector of the mirror plane.

Returns:

M – Mirror matrix

Return type:

npt.NDArray

dfttoolkit.utils.math_utils.get_moving_average(signal: ndarray[Any, dtype[float64]], window_size: int)[source]

Cacluated the moving average and the variance around the moving average.

Parameters:
  • signal (npt.NDArray[np.float64]) – Signal for which the moving average should be calculated.

  • window_size (int) – Window size for the mocing average.

Returns:

  • moving_avg (TYPE) – Moving average.

  • variance (TYPE) – Variance around the moving average.

dfttoolkit.utils.math_utils.get_rotation_matrix(vec_start: ndarray[Any, dtype[_ScalarType_co]], vec_end: ndarray[Any, dtype[_ScalarType_co]]) ndarray[Any, dtype[_ScalarType_co]][source]

Given a two (unit) vectors, vec_start and vec_end, this function calculates the rotation matrix U, so that U * vec_start = vec_end.

U the is rotation matrix that rotates vec_start to point in the direction of vec_end.

https://math.stackexchange.com/questions/180418/calculate-rotation-matrix-to-align-vector-a-to-vector-b-in-3d/897677

Parameters:
  • vec_start (npt.NDArray[np.float64]) – Two vectors that should be aligned. Both vectors must have a l2-norm of 1.

  • vec_end (npt.NDArray[np.float64]) – Two vectors that should be aligned. Both vectors must have a l2-norm of 1.

  • Returns

  • --------

  • R – The rotation matrix U as npt.NDArray with shape (3,3)

dfttoolkit.utils.math_utils.get_rotation_matrix_around_axis(axis: ndarray[Any, dtype[_ScalarType_co]], phi: float) ndarray[Any, dtype[_ScalarType_co]][source]

Generates a rotation matrix around a given vector.

Parameters:
  • axis (npt.NDArray) – Axis around which the rotation is done.

  • phi (float) – Angle of rotation around axis in radiants.

Returns:

R – Rotation matrix

Return type:

npt.NDArray

dfttoolkit.utils.math_utils.get_rotation_matrix_around_z_axis(phi: float) ndarray[Any, dtype[_ScalarType_co]][source]

Generates a rotation matrix around the z axis.

Parameters:

phi (float) – Angle of rotation around axis in radiants.

Returns:

Rotation matrix

Return type:

npt.NDArray

dfttoolkit.utils.math_utils.hann_window(N)[source]

Generate a Hann window.

Parameters:

N (int) – Number of points in the window.

Returns:

Hann window of length N.

Return type:

np.ndarray

dfttoolkit.utils.math_utils.lorentzian(x: float | ndarray[Any, dtype[_ScalarType_co]], a: float, b: float, c: float) float | ndarray[Any, dtype[_ScalarType_co]][source]

Returns a Lorentzian function.

Parameters:
  • x (Union[float, npt.NDArray]) – Argument x of f(x) –> y.

  • a (float) – Maximum of Lorentzian.

  • b (float) – Width of Lorentzian.

  • c (float) – Magnitude of Lorentzian.

Returns:

f – Outupt of a Lorentzian function.

Return type:

Union[float, npt.NDArray]

dfttoolkit.utils.math_utils.mae(delta: ndarray) floating[source]

Calculated the mean absolute error from a list of value differnces.

Parameters:

delta (np.ndarray) – Array containing differences

Returns:

mean absolute error

Return type:

float

dfttoolkit.utils.math_utils.norm_matrix_by_dagonal(matrix: ndarray[Any, dtype[_ScalarType_co]]) ndarray[Any, dtype[_ScalarType_co]][source]

Norms a matrix such that the diagonal becomes 1.

a_11 a_12 a_13 | | 1 a’_12 a’_13 |
a_21 a_22 a_23 | –> | a’_21 1 a’_23 |
a_31 a_32 a_33 | | a’_31 a’_32 1 |
Parameters:

matrix (npt.NDArray) – Matrix that should be normed.

Returns:

matrix – Normed matrix.

Return type:

npt.NDArray

dfttoolkit.utils.math_utils.rel_mae(delta: ndarray, target_val: ndarray) floating[source]

Calculated the relative mean absolute error from a list of value differnces, given the target values.

Parameters:
  • delta (np.ndarray) – Array containing differences

  • target_val (np.ndarray) – Array of target values against which the difference should be compared

Returns:

relative mean absolute error

Return type:

float

dfttoolkit.utils.math_utils.rel_rmse(delta: ndarray, target_val: ndarray) float[source]

Calculated the relative root mean sqare error from a list of value differnces, given the target values.

Parameters:
  • delta (np.ndarray) – Array containing differences

  • target_val (np.ndarray) – Array of target values against which the difference should be compared

Returns:

relative root mean sqare error

Return type:

float

dfttoolkit.utils.math_utils.rmse(delta: ndarray) float[source]

Calculated the root mean sqare error from a list of value differnces.

Parameters:

delta (np.ndarray) – Array containing differences

Returns:

root mean square error

Return type:

float

dfttoolkit.utils.periodic_table module

class dfttoolkit.utils.periodic_table.Element(name: str, **properties: Any)[source]

Bases: object

Hold and access data for individual elements

name

Elemental name

Type:

str

symbol

Chemical symbol

Type:

str

atomic_number

Atomic number of the element

atomic_mass

Average atomic mass of an element

class dfttoolkit.utils.periodic_table.PeriodicTable[source]

Bases: object

Hold and access data for elements in the periodic table

elements

Data on physical properties of elements

Type:

dict

order

Element names ordered by their atomic number

Type:

List[str]

element_names = ['hydrogen', 'helium', 'lithium', 'beryllium', 'boron', 'carbon', 'nitrogen', 'oxygen', 'fluorine', 'neon', 'sodium', 'magnesium', 'aluminium', 'silicon', 'phosphorus', 'sulfur', 'chlorine', 'argon', 'potassium', 'calcium', 'scandium', 'titanium', 'vanadium', 'chromium', 'manganese', 'iron', 'cobalt', 'nickel', 'copper', 'zinc', 'gallium', 'germanium', 'arsenic', 'selenium', 'bromine', 'krypton', 'rubidium', 'strontium', 'yttrium', 'zirconium', 'niobium', 'molybdenum', 'technetium', 'ruthenium', 'rhodium', 'palladium', 'silver', 'cadmium', 'indium', 'tin', 'antimony', 'tellurium', 'iodine', 'xenon', 'cesium', 'barium', 'lanthanum', 'cerium', 'praseodymium', 'neodymium', 'promethium', 'samarium', 'europium', 'gadolinium', 'terbium', 'dysprosium', 'holmium', 'erbium', 'thulium', 'ytterbium', 'lutetium', 'hafnium', 'tantalum', 'tungsten', 'rhenium', 'osmium', 'iridium', 'platinum', 'gold', 'mercury', 'thallium', 'lead', 'bismuth', 'polonium', 'astatine', 'radon', 'francium', 'radium', 'actinium', 'thorium', 'protactinium', 'uranium', 'neptunium', 'plutonium', 'americium', 'curium', 'berkelium', 'californium', 'einsteinium', 'fermium', 'mendelevium', 'nobelium', 'lawrencium', 'rutherfordium', 'dubnium', 'seaborgium', 'bohrium', 'hassium', 'meitnerium', 'darmstadtium', 'roentgenium', 'copernicium', 'nihonium', 'flerovium', 'moscovium', 'livermorium', 'tennessine', 'oganesson', 'ununennium']
element_symbols = ['H', 'He', 'Li', 'Be', 'B', 'C', 'N', 'O', 'F', 'Ne', 'Na', 'Mg', 'Al', 'Si', 'P', 'S', 'Cl', 'Ar', 'K', 'Ca', 'Sc', 'Ti', 'V', 'Cr', 'Mn', 'Fe', 'Co', 'Ni', 'Cu', 'Zn', 'Ga', 'Ge', 'As', 'Se', 'Br', 'Kr', 'Rb', 'Sr', 'Y', 'Zr', 'Nb', 'Mo', 'Tc', 'Ru', 'Rh', 'Pd', 'Ag', 'Cd', 'In', 'Sn', 'Sb', 'Te', 'I', 'Xe', 'Cs', 'Ba', 'La', 'Ce', 'Pr', 'Nd', 'Pm', 'Sm', 'Eu', 'Gd', 'Tb', 'Dy', 'Ho', 'Er', 'Tm', 'Yb', 'Lu', 'Hf', 'Ta', 'W', 'Re', 'Os', 'Ir', 'Pt', 'Au', 'Hg', 'Tl', 'Pb', 'Bi', 'Po', 'At', 'Rn', 'Fr', 'Ra', 'Ac', 'Th', 'Pa', 'U', 'Np', 'Pu', 'Am', 'Cm', 'Bk', 'Cf', 'Es', 'Fm', 'Md', 'No', 'Lr', 'Rf', 'Db', 'Sg', 'Bh', 'Hs', 'Mt', 'Ds', 'Rg', 'Cn', 'Nh', 'Fl', 'Mc', 'Lv', 'Ts', 'Og', 'Uue']
elements = {'Ac': Element({'name': 'actinium', 'symbol': 'Ac', 'atomic_number': 89, 'atomic_mass': 227, 'appearance': None, 'block': 'f', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_089_actinium/element_089_actinium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_089_actinium/element_089_actinium_srp_th.png', 'boil': 3500, 'category': 'actinide', 'cpk-hex': '70abfa', 'density': 10, 'discovered_by': 'Friedrich Oskar Giesel', 'electron_affinity': 33.77, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d10 6p6 7s2 6d1', 'electron_configuration_semantic': '[Rn] 6d1 7s2', 'electronegativity_pauling': 1.1, 'group': 3, 'image': {'attribution': 'Oak Ridge National Laboratory, CC BY 2.0 <https://creativecommons.org/licenses/by/2.0>, via Wikimedia Commons, source: https://www.flickr.com/photos/oakridgelab/31481701837/', 'title': 'Actinium-225 medical radioisotope held in a v-vial at ORNL. The blue glow comes from the ionization of surrounding air by alpha particles', 'url': 'https://upload.wikimedia.org/wikipedia/commons/2/27/Actinium_sample_%2831481701837%29.png'}, 'ionization_energies': [499, 1170], 'melt': 1500, 'molar_heat': 27.2, 'named_by': None, 'number': 89, 'period': 7, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 18, 9, 2], 'source': 'https://en.wikipedia.org/wiki/Actinium', 'spectral_img': None, 'summary': 'Actinium is a radioactive chemical element with symbol Ac (not to be confused with the abbreviation for an acetyl group) and atomic number 89, which was discovered in 1899. It was the first non-primordial radioactive element to be isolated. Polonium, radium and radon were observed before actinium, but they were not isolated until 1902.', 'wxpos': 3, 'wypos': 7, 'xpos': 3, 'ypos': 10}), 'Ag': Element({'name': 'silver', 'symbol': 'Ag', 'atomic_number': 47, 'atomic_mass': 107.86822, 'appearance': 'lustrous white metal', 'block': 'd', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_047_silver/element_047_silver.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_047_silver/element_047_silver_srp_th.png', 'boil': 2435, 'category': 'transition metal', 'cpk-hex': 'c0c0c0', 'density': 10.49, 'discovered_by': 'unknown, before 5000 BC', 'electron_affinity': 125.862, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s1 4d10', 'electron_configuration_semantic': '[Kr] 4d10 5s1', 'electronegativity_pauling': 1.93, 'group': 11, 'image': {'attribution': 'Jurii, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: http://images-of-elements.com/silver.php', 'title': 'Natural silver nugget, 1 cm long.', 'url': 'https://upload.wikimedia.org/wikipedia/commons/e/e4/Silver-nugget.jpg'}, 'ionization_energies': [731, 2070, 3361], 'melt': 1234.93, 'molar_heat': 25.35, 'named_by': None, 'number': 47, 'period': 5, 'phase': 'Solid', 'shells': [2, 8, 18, 18, 1], 'source': 'https://en.wikipedia.org/wiki/Silver', 'spectral_img': None, 'summary': 'Silver is a chemical element with symbol Ag (Greek:άργυρος árguros, Latin:argentum, both from the Indo-European root *h₂erǵ- for "grey" or "shining") and atomic number 47. A soft, white, lustrous transition metal, it possesses the highest electrical conductivity, thermal conductivity and reflectivity of any metal. The metal occurs naturally in its pure, free form (native silver), as an alloy with gold and other metals, and in minerals such as argentite and chlorargyrite.', 'wxpos': 25, 'wypos': 5, 'xpos': 11, 'ypos': 5}), 'Al': Element({'name': 'aluminium', 'symbol': 'Al', 'atomic_number': 13, 'atomic_mass': 26.98153857, 'appearance': 'silvery gray metallic', 'block': 'p', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_013_aluminum/element_013_aluminum.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_013_aluminum/element_013_aluminum_srp_th.png', 'boil': 2743, 'category': 'post-transition metal', 'cpk-hex': 'bfa6a6', 'density': 2.7, 'discovered_by': None, 'electron_affinity': 41.762, 'electron_configuration': '1s2 2s2 2p6 3s2 3p1', 'electron_configuration_semantic': '[Ne] 3s2 3p1', 'electronegativity_pauling': 1.61, 'group': 13, 'image': {'attribution': 'Jurii, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/aluminium.php ', 'title': 'Pure aluminium foil. Original size in cm: 5 x 5', 'url': 'https://upload.wikimedia.org/wikipedia/commons/3/3e/Aluminium.jpg'}, 'ionization_energies': [577.5, 1816.7, 2744.8, 11577, 14842, 18379, 23326, 27465, 31853, 38473, 42647, 201266, 222316], 'melt': 933.47, 'molar_heat': 24.2, 'named_by': 'Humphry Davy', 'number': 13, 'period': 3, 'phase': 'Solid', 'shells': [2, 8, 3], 'source': 'https://en.wikipedia.org/wiki/Aluminium', 'spectral_img': None, 'summary': "Aluminium (or aluminum; see different endings) is a chemical element in the boron group with symbol Al and atomic number 13. It is a silvery-white, soft, nonmagnetic, ductile metal. Aluminium is the third most abundant element (after oxygen and silicon), and the most abundant metal, in the Earth's crust.", 'wxpos': 27, 'wypos': 3, 'xpos': 13, 'ypos': 3}), 'Am': Element({'name': 'americium', 'symbol': 'Am', 'atomic_number': 95, 'atomic_mass': 243, 'appearance': 'silvery white', 'block': 'f', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_095_americium/element_095_americium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_095_americium/element_095_americium_srp_th.png', 'boil': 2880, 'category': 'actinide', 'cpk-hex': '545cf2', 'density': 12, 'discovered_by': 'Glenn T. Seaborg', 'electron_affinity': 9.93, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d10 6p6 7s2 5f7', 'electron_configuration_semantic': '[Rn] 5f7 7s2', 'electronegativity_pauling': 1.13, 'group': 3, 'image': {'attribution': 'Bionerd, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons', 'title': 'A small disc of Am-241 under the microscope.', 'url': 'https://upload.wikimedia.org/wikipedia/commons/e/ee/Americium_microscope.jpg'}, 'ionization_energies': [578], 'melt': 1449, 'molar_heat': 62.7, 'named_by': None, 'number': 95, 'period': 7, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 25, 8, 2], 'source': 'https://en.wikipedia.org/wiki/Americium', 'spectral_img': 'https://en.wikipedia.org/wiki/File:Americium_spectrum_visible.png', 'summary': 'Americium is a radioactive transuranic chemical element with symbol Am and atomic number 95. This member of the actinide series is located in the periodic table under the lanthanide element europium, and thus by analogy was named after the Americas. Americium was first produced in 1944 by the group of Glenn T.Seaborg from Berkeley, California, at the metallurgical laboratory of University of Chicago.', 'wxpos': 9, 'wypos': 7, 'xpos': 9, 'ypos': 10}), 'Ar': Element({'name': 'argon', 'symbol': 'Ar', 'atomic_number': 18, 'atomic_mass': 39.9481, 'appearance': 'colorless gas exhibiting a lilac/violet glow when placed in a high voltage electric field', 'block': 'p', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_018_argon/element_018_argon.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_018_argon/element_018_argon_srp_th.png', 'boil': 87.302, 'category': 'noble gas', 'cpk-hex': '80d1e3', 'density': 1.784, 'discovered_by': 'Lord Rayleigh', 'electron_affinity': -96, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6', 'electron_configuration_semantic': '[Ne] 3s2 3p6', 'electronegativity_pauling': None, 'group': 18, 'image': {'attribution': 'Jurii, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/argon.php', 'title': 'Vial of glowing ultrapure argon. Original size in cm: 1 x 5', 'url': 'https://upload.wikimedia.org/wikipedia/commons/5/53/Argon-glow.jpg'}, 'ionization_energies': [1520.6, 2665.8, 3931, 5771, 7238, 8781, 11995, 13842, 40760, 46186, 52002, 59653, 66199, 72918, 82473, 88576, 397605, 427066], 'melt': 83.81, 'molar_heat': None, 'named_by': None, 'number': 18, 'period': 3, 'phase': 'Gas', 'shells': [2, 8, 8], 'source': 'https://en.wikipedia.org/wiki/Argon', 'spectral_img': 'https://en.wikipedia.org/wiki/File:Argon_Spectrum.png', 'summary': "Argon is a chemical element with symbol Ar and atomic number 18. It is in group 18 of the periodic table and is a noble gas. Argon is the third most common gas in the Earth's atmosphere, at 0.934% (9,340 ppmv), making it over twice as abundant as the next most common atmospheric gas, water vapor (which averages about 4000 ppmv, but varies greatly), and 23 times as abundant as the next most common non-condensing atmospheric gas, carbon dioxide (400 ppmv), and more than 500 times as abundant as the next most common noble gas, neon (18 ppmv).", 'wxpos': 32, 'wypos': 3, 'xpos': 18, 'ypos': 3}), 'As': Element({'name': 'arsenic', 'symbol': 'As', 'atomic_number': 33, 'atomic_mass': 74.9215956, 'appearance': 'metallic grey', 'block': 'p', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_033_arsenic/element_033_arsenic.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_033_arsenic/element_033_arsenic_srp_th.png', 'boil': None, 'category': 'metalloid', 'cpk-hex': 'bd80e3', 'density': 5.727, 'discovered_by': 'Bronze Age', 'electron_affinity': 77.65, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p3', 'electron_configuration_semantic': '[Ar] 3d10 4s2 4p3', 'electronegativity_pauling': 2.18, 'group': 15, 'image': {'attribution': 'Hi-Res Images ofChemical Elements, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/arsenic.php', 'title': 'Ultrapure Metallic Arsenic under Argon, 1 - 2 grams. Original size of each piece in cm: 0.5 x 1', 'url': 'https://upload.wikimedia.org/wikipedia/commons/3/3b/Arsenic_%2833_As%29.jpg'}, 'ionization_energies': [947, 1798, 2735, 4837, 6043, 12310], 'melt': None, 'molar_heat': 24.64, 'named_by': None, 'number': 33, 'period': 4, 'phase': 'Solid', 'shells': [2, 8, 18, 5], 'source': 'https://en.wikipedia.org/wiki/Arsenic', 'spectral_img': None, 'summary': 'Arsenic is a chemical element with symbol As and atomic number 33. Arsenic occurs in many minerals, usually in conjunction with sulfur and metals, and also as a pure elemental crystal. Arsenic is a metalloid.', 'wxpos': 29, 'wypos': 4, 'xpos': 15, 'ypos': 4}), 'At': Element({'name': 'astatine', 'symbol': 'At', 'atomic_number': 85, 'atomic_mass': 210, 'appearance': 'unknown, probably metallic', 'block': 'p', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_085_astatine/element_085_astatine.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_085_astatine/element_085_astatine_srp_th.png', 'boil': 610, 'category': 'metalloid', 'cpk-hex': '754f45', 'density': 6.35, 'discovered_by': 'Dale R. Corson', 'electron_affinity': 233, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d10 6p5', 'electron_configuration_semantic': '[Xe] 4f14 5d10 6s2 6p5', 'electronegativity_pauling': 2.2, 'group': 17, 'image': {'attribution': 'Chemical ELements A Virtual Museum, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0> source: https://images-of-elements.com/astatine.php', 'title': 'This is only an illustration, not astatine itself. Crystals similar to iodine, but darker in color than these, which due to the extreme radioactivity glow blue and evaporate to dark purple gas', 'url': 'https://images-of-elements.com/astatine.jpg'}, 'ionization_energies': [899.003], 'melt': 575, 'molar_heat': None, 'named_by': None, 'number': 85, 'period': 6, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 18, 7], 'source': 'https://en.wikipedia.org/wiki/Astatine', 'spectral_img': None, 'summary': 'Astatine is a very rare radioactive chemical element with the chemical symbol At and atomic number 85. It occurs on Earth as the decay product of various heavier elements. All its isotopes are short-lived; the most stable is astatine-210, with a half-life of 8.1 hours.', 'wxpos': 31, 'wypos': 6, 'xpos': 17, 'ypos': 6}), 'Au': Element({'name': 'gold', 'symbol': 'Au', 'atomic_number': 79, 'atomic_mass': 196.9665695, 'appearance': 'metallic yellow', 'block': 'd', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_079_gold/element_079_gold.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_079_gold/element_079_gold_srp_th.png', 'boil': 3243, 'category': 'transition metal', 'cpk-hex': 'ffd123', 'density': 19.3, 'discovered_by': 'Middle East', 'electron_affinity': 222.747, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s1 4f14 5d10', 'electron_configuration_semantic': '[Xe] 4f14 5d10 6s1', 'electronegativity_pauling': 2.54, 'group': 11, 'image': {'attribution': 'Hi-Res Images ofChemical Elements, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/gold.php', 'title': 'Ultrapure Gold Leaf', 'url': 'https://upload.wikimedia.org/wikipedia/commons/8/8a/Gold_%2879_Au%29.jpg'}, 'ionization_energies': [890.1, 1980], 'melt': 1337.33, 'molar_heat': 25.418, 'named_by': None, 'number': 79, 'period': 6, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 18, 1], 'source': 'https://en.wikipedia.org/wiki/Gold', 'spectral_img': None, 'summary': 'Gold is a chemical element with symbol Au (from Latin:aurum) and atomic number 79. In its purest form, it is a bright, slightly reddish yellow, dense, soft, malleable and ductile metal. Chemically, gold is a transition metal and a group 11 element.', 'wxpos': 25, 'wypos': 6, 'xpos': 11, 'ypos': 6}), 'B': Element({'name': 'boron', 'symbol': 'B', 'atomic_number': 5, 'atomic_mass': 10.81, 'appearance': 'black-brown', 'block': 'p', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_005_boron/element_005_boron.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_005_boron/element_005_boron_srp_th.png', 'boil': 4200, 'category': 'metalloid', 'cpk-hex': 'ffb5b5', 'density': 2.08, 'discovered_by': 'Joseph Louis Gay-Lussac', 'electron_affinity': 26.989, 'electron_configuration': '1s2 2s2 2p1', 'electron_configuration_semantic': '[He] 2s2 2p1', 'electronegativity_pauling': 2.04, 'group': 13, 'image': {'attribution': 'Jurii, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/boron.php', 'title': 'Pure Crystalline Boron, front and back side. Original size in cm: 2 x 3', 'url': 'https://upload.wikimedia.org/wikipedia/commons/a/a2/Boron.jpg'}, 'ionization_energies': [800.6, 2427.1, 3659.7, 25025.8, 32826.7], 'melt': 2349, 'molar_heat': 11.087, 'named_by': None, 'number': 5, 'period': 2, 'phase': 'Solid', 'shells': [2, 3], 'source': 'https://en.wikipedia.org/wiki/Boron', 'spectral_img': None, 'summary': "Boron is a metalloid chemical element with symbol B and atomic number 5. Produced entirely by cosmic ray spallation and supernovae and not by stellar nucleosynthesis, it is a low-abundance element in both the Solar system and the Earth's crust. Boron is concentrated on Earth by the water-solubility of its more common naturally occurring compounds, the borate minerals.", 'wxpos': 27, 'wypos': 2, 'xpos': 13, 'ypos': 2}), 'Ba': Element({'name': 'barium', 'symbol': 'Ba', 'atomic_number': 56, 'atomic_mass': 137.3277, 'appearance': None, 'block': 's', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_056_barium/element_056_barium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_056_barium/element_056_barium_srp_th.png', 'boil': 2118, 'category': 'alkaline earth metal', 'cpk-hex': '00c900', 'density': 3.51, 'discovered_by': 'Carl Wilhelm Scheele', 'electron_affinity': 13.954, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2', 'electron_configuration_semantic': '[Xe] 6s2', 'electronegativity_pauling': 0.89, 'group': 2, 'image': {'attribution': 'Hi-Res Images ofChemical Elements, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/barium.php', 'title': '1.5 Grams Barium with a Grey Oxide Layer under Argon. Original size in cm: 0.7 x 1', 'url': 'https://upload.wikimedia.org/wikipedia/commons/f/f5/Barium_%2856_Ba%29.jpg'}, 'ionization_energies': [502.9, 965.2, 3600], 'melt': 1000, 'molar_heat': 28.07, 'named_by': None, 'number': 56, 'period': 6, 'phase': 'Solid', 'shells': [2, 8, 18, 18, 8, 2], 'source': 'https://en.wikipedia.org/wiki/Barium', 'spectral_img': None, 'summary': 'Barium is a chemical element with symbol Ba and atomic number 56. It is the fifth element in Group 2, a soft silvery metallic alkaline earth metal. Because of its high chemical reactivity barium is never found in nature as a free element.', 'wxpos': 2, 'wypos': 6, 'xpos': 2, 'ypos': 6}), 'Be': Element({'name': 'beryllium', 'symbol': 'Be', 'atomic_number': 4, 'atomic_mass': 9.01218315, 'appearance': 'white-gray metallic', 'block': 's', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_004_beryllium/element_004_beryllium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_004_beryllium/element_004_beryllium_srp_th.png', 'boil': 2742, 'category': 'alkaline earth metal', 'cpk-hex': 'c2ff00', 'density': 1.85, 'discovered_by': 'Louis Nicolas Vauquelin', 'electron_affinity': -48, 'electron_configuration': '1s2 2s2', 'electron_configuration_semantic': '[He] 2s2', 'electronegativity_pauling': 1.57, 'group': 2, 'image': {'attribution': 'Hi-Res Images ofChemical Elements, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/beryllium.php', 'title': 'Pure Beryllium bead, 2.5 grams. Original size in cm: 1 x 1.5', 'url': 'https://upload.wikimedia.org/wikipedia/commons/e/e2/Beryllium_%28Be%29.jpg'}, 'ionization_energies': [899.5, 1757.1, 14848.7, 21006.6], 'melt': 1560, 'molar_heat': 16.443, 'named_by': None, 'number': 4, 'period': 2, 'phase': 'Solid', 'shells': [2, 2], 'source': 'https://en.wikipedia.org/wiki/Beryllium', 'spectral_img': None, 'summary': 'Beryllium is a chemical element with symbol Be and atomic number 4. It is created through stellar nucleosynthesis and is a relatively rare element in the universe. It is a divalent element which occurs naturally only in combination with other elements in minerals.', 'wxpos': 2, 'wypos': 2, 'xpos': 2, 'ypos': 2}), 'Bh': Element({'name': 'bohrium', 'symbol': 'Bh', 'atomic_number': 107, 'atomic_mass': 270, 'appearance': None, 'block': 'd', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_107_bohrium/element_107_bohrium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_107_bohrium/element_107_bohrium_srp_th.png', 'boil': None, 'category': 'transition metal', 'cpk-hex': 'e00038', 'density': 37.1, 'discovered_by': 'Gesellschaft für Schwerionenforschung', 'electron_affinity': None, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d10 6p6 7s2 5f14 6d5', 'electron_configuration_semantic': '*[Rn] 5f14 6d5 7s2', 'electronegativity_pauling': None, 'group': 7, 'image': {'attribution': 'Chemical Elements A Virtual Museum under a Creative Commons Attribution 3.0 Unported License, source: https://images-of-elements.com/bohrium.php', 'title': 'No Image Found', 'url': 'https://images-of-elements.com/s/transactinoid.png'}, 'ionization_energies': [], 'melt': None, 'molar_heat': None, 'named_by': None, 'number': 107, 'period': 7, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 32, 13, 2], 'source': 'https://en.wikipedia.org/wiki/Bohrium', 'spectral_img': None, 'summary': 'Bohrium is a chemical element with symbol Bh and atomic number 107. It is named after Danish physicist Niels Bohr. It is a synthetic element (an element that can be created in a laboratory but is not found in nature) and radioactive; the most stable known isotope, 270Bh, has a half-life of approximately 61 seconds.', 'wxpos': 21, 'wypos': 7, 'xpos': 7, 'ypos': 7}), 'Bi': Element({'name': 'bismuth', 'symbol': 'Bi', 'atomic_number': 83, 'atomic_mass': 208.980401, 'appearance': 'lustrous silver', 'block': 'p', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_083_bismuth/element_083_bismuth.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_083_bismuth/element_083_bismuth_srp_th.png', 'boil': 1837, 'category': 'post-transition metal', 'cpk-hex': '9e4fb5', 'density': 9.78, 'discovered_by': 'Claude François Geoffroy', 'electron_affinity': 90.924, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d10 6p3', 'electron_configuration_semantic': '[Xe] 4f14 5d10 6s2 6p3', 'electronegativity_pauling': 2.02, 'group': 15, 'image': {'attribution': 'Jurii, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/bismuth.php', 'title': 'Bismuth Crystal', 'url': 'https://upload.wikimedia.org/wikipedia/commons/a/a5/Bismuth-2.jpg'}, 'ionization_energies': [703, 1610, 2466, 4370, 5400, 8520], 'melt': 544.7, 'molar_heat': 25.52, 'named_by': None, 'number': 83, 'period': 6, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 18, 5], 'source': 'https://en.wikipedia.org/wiki/Bismuth', 'spectral_img': None, 'summary': 'Bismuth is a chemical element with symbol Bi and atomic number 83. Bismuth, a pentavalent post-transition metal, chemically resembles arsenic and antimony. Elemental bismuth may occur naturally, although its sulfide and oxide form important commercial ores.', 'wxpos': 29, 'wypos': 6, 'xpos': 15, 'ypos': 6}), 'Bk': Element({'name': 'berkelium', 'symbol': 'Bk', 'atomic_number': 97, 'atomic_mass': 247, 'appearance': 'silvery', 'block': 'f', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_097_berkelium/element_097_berkelium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_097_berkelium/element_097_berkelium_srp_th.png', 'boil': 2900, 'category': 'actinide', 'cpk-hex': '8a4fe3', 'density': 14.78, 'discovered_by': 'Lawrence Berkeley National Laboratory', 'electron_affinity': -165.24, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d10 6p6 7s2 5f9', 'electron_configuration_semantic': '[Rn] 5f9 7s2', 'electronegativity_pauling': 1.3, 'group': 3, 'image': {'attribution': 'ORNL, Department of Energy, Public domain, via Wikimedia Commons', 'title': 'It took 250 days to make enough berkelium, shown here (in dissolved state), to synthesize element 117', 'url': 'https://upload.wikimedia.org/wikipedia/commons/f/fc/Berkelium.jpg'}, 'ionization_energies': [601], 'melt': 1259, 'molar_heat': None, 'named_by': None, 'number': 97, 'period': 7, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 27, 8, 2], 'source': 'https://en.wikipedia.org/wiki/Berkelium', 'spectral_img': None, 'summary': 'Berkelium is a transuranic radioactive chemical element with symbol Bk and atomic number 97. It is a member of the actinide and transuranium element series. It is named after the city of Berkeley, California, the location of the University of California Radiation Laboratory where it was discovered in December 1949.', 'wxpos': 11, 'wypos': 7, 'xpos': 11, 'ypos': 10}), 'Br': Element({'name': 'bromine', 'symbol': 'Br', 'atomic_number': 35, 'atomic_mass': 79.904, 'appearance': None, 'block': 'p', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_035_bromine/element_035_bromine.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_035_bromine/element_035_bromine_srp_th.png', 'boil': 332, 'category': 'diatomic nonmetal', 'cpk-hex': 'a62929', 'density': 3.1028, 'discovered_by': 'Antoine Jérôme Balard', 'electron_affinity': 324.537, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p5', 'electron_configuration_semantic': '[Ar] 3d10 4s2 4p5', 'electronegativity_pauling': 2.96, 'group': 17, 'image': {'attribution': 'Jurii, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/bromine.php', 'title': '99.5 % pure liquid Bromine in a 4 x 1 cm big glass ampoule, cast in acrylic', 'url': 'https://upload.wikimedia.org/wikipedia/commons/8/87/Bromine-ampoule.jpg'}, 'ionization_energies': [1139.9, 2103, 3470, 4560, 5760, 8550, 9940, 18600], 'melt': 265.8, 'molar_heat': None, 'named_by': None, 'number': 35, 'period': 4, 'phase': 'Liquid', 'shells': [2, 8, 18, 7], 'source': 'https://en.wikipedia.org/wiki/Bromine', 'spectral_img': None, 'summary': 'Bromine (from Ancient Greek:βρῶμος, brómos, meaning "stench") is a chemical element with symbol Br, and atomic number 35. It is a halogen. The element was isolated independently by two chemists, Carl Jacob Löwig and Antoine Jerome Balard, in 1825–1826.', 'wxpos': 31, 'wypos': 4, 'xpos': 17, 'ypos': 4}), 'C': Element({'name': 'carbon', 'symbol': 'C', 'atomic_number': 6, 'atomic_mass': 12.011, 'appearance': None, 'block': 'p', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_006_carbon/element_006_carbon.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_006_carbon/element_006_carbon_srp_th.png', 'boil': None, 'category': 'polyatomic nonmetal', 'cpk-hex': '909090', 'density': 1.821, 'discovered_by': 'Ancient Egypt', 'electron_affinity': 121.7763, 'electron_configuration': '1s2 2s2 2p2', 'electron_configuration_semantic': '[He] 2s2 2p2', 'electronegativity_pauling': 2.55, 'group': 14, 'image': {'attribution': 'Texas Lane, CC BY-SA 4.0 <https://creativecommons.org/licenses/by-sa/4.0>, via Wikimedia Commons', 'title': 'Element 6 - Carbon', 'url': 'https://upload.wikimedia.org/wikipedia/commons/6/68/Pure_Carbon.png'}, 'ionization_energies': [1086.5, 2352.6, 4620.5, 6222.7, 37831, 47277], 'melt': None, 'molar_heat': 8.517, 'named_by': None, 'number': 6, 'period': 2, 'phase': 'Solid', 'shells': [2, 4], 'source': 'https://en.wikipedia.org/wiki/Carbon', 'spectral_img': 'https://en.wikipedia.org/wiki/File:Carbon_Spectra.jpg', 'summary': 'Carbon (from Latin:carbo "coal") is a chemical element with symbol C and atomic number 6. On the periodic table, it is the first (row 2) of six elements in column (group) 14, which have in common the composition of their outer electron shell. It is nonmetallic and tetravalent—making four electrons available to form covalent chemical bonds.', 'wxpos': 28, 'wypos': 2, 'xpos': 14, 'ypos': 2}), 'Ca': Element({'name': 'calcium', 'symbol': 'Ca', 'atomic_number': 20, 'atomic_mass': 40.0784, 'appearance': None, 'block': 's', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_020_calcium/element_020_calcium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_020_calcium/element_020_calcium_srp_th.png', 'boil': 1757, 'category': 'alkaline earth metal', 'cpk-hex': '3dff00', 'density': 1.55, 'discovered_by': 'Humphry Davy', 'electron_affinity': 2.37, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2', 'electron_configuration_semantic': '[Ar] 4s2', 'electronegativity_pauling': 1, 'group': 2, 'image': {'attribution': 'Jurii, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/calcium.php', 'title': 'Calcium Grains, grain size about 1 mm', 'url': 'https://upload.wikimedia.org/wikipedia/commons/7/72/Calcium.jpg'}, 'ionization_energies': [589.8, 1145.4, 4912.4, 6491, 8153, 10496, 12270, 14206, 18191, 20385, 57110, 63410, 70110, 78890, 86310, 94000, 104900, 111711, 494850, 527762], 'melt': 1115, 'molar_heat': 25.929, 'named_by': None, 'number': 20, 'period': 4, 'phase': 'Solid', 'shells': [2, 8, 8, 2], 'source': 'https://en.wikipedia.org/wiki/Calcium', 'spectral_img': 'https://en.wikipedia.org/wiki/File:Calcium_Spectrum.png', 'summary': "Calcium is a chemical element with symbol Ca and atomic number 20. Calcium is a soft gray alkaline earth metal, fifth-most-abundant element by mass in the Earth's crust. The ion Ca2+ is also the fifth-most-abundant dissolved ion in seawater by both molarity and mass, after sodium, chloride, magnesium, and sulfate.", 'wxpos': 2, 'wypos': 4, 'xpos': 2, 'ypos': 4}), 'Cd': Element({'name': 'cadmium', 'symbol': 'Cd', 'atomic_number': 48, 'atomic_mass': 112.4144, 'appearance': 'silvery bluish-gray metallic', 'block': 'd', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_048_cadmium/element_048_cadmium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_048_cadmium/element_048_cadmium_srp_th.png', 'boil': 1040, 'category': 'transition metal', 'cpk-hex': 'ffd98f', 'density': 8.65, 'discovered_by': 'Karl Samuel Leberecht Hermann', 'electron_affinity': -68, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10', 'electron_configuration_semantic': '[Kr] 4d10 5s2', 'electronegativity_pauling': 1.69, 'group': 12, 'image': {'attribution': 'Chemical Elements A Virtual Museum under a Creative Commons Attribution 3.0 Unported License, source: https://images-of-elements.com/cadmium.php', 'title': '48 Cd Cadmium', 'url': 'https://images-of-elements.com/cadmium-4.jpg'}, 'ionization_energies': [867.8, 1631.4, 3616], 'melt': 594.22, 'molar_heat': 26.02, 'named_by': 'Isotopes of cadmium', 'number': 48, 'period': 5, 'phase': 'Solid', 'shells': [2, 8, 18, 18, 2], 'source': 'https://en.wikipedia.org/wiki/Cadmium', 'spectral_img': None, 'summary': 'Cadmium is a chemical element with symbol Cd and atomic number 48. This soft, bluish-white metal is chemically similar to the two other stable metals in group 12, zinc and mercury. Like zinc, it prefers oxidation state +2 in most of its compounds and like mercury it shows a low melting point compared to transition metals.', 'wxpos': 26, 'wypos': 5, 'xpos': 12, 'ypos': 5}), 'Ce': Element({'name': 'cerium', 'symbol': 'Ce', 'atomic_number': 58, 'atomic_mass': 140.1161, 'appearance': 'silvery white', 'block': 'f', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_058_cerium/element_058_cerium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_058_cerium/element_058_cerium_srp_th.png', 'boil': 3716, 'category': 'lanthanide', 'cpk-hex': 'ffffc7', 'density': 6.77, 'discovered_by': 'Martin Heinrich Klaproth', 'electron_affinity': 55, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 5d1 4f1', 'electron_configuration_semantic': '[Xe] 4f1 5d1 6s2', 'electronegativity_pauling': 1.12, 'group': 3, 'image': {'attribution': 'Jurii, CC BY 1.0 <https://creativecommons.org/licenses/by/1.0>, via Wikimedia Commons, source: https://images-of-elements.com/cerium.php', 'title': 'Ultrapure Cerium under Argon, 1.5 grams. Original size in cm: 1 x 1', 'url': 'https://upload.wikimedia.org/wikipedia/commons/0/0d/Cerium2.jpg'}, 'ionization_energies': [534.4, 1050, 1949, 3547, 6325, 7490], 'melt': 1068, 'molar_heat': 26.94, 'named_by': None, 'number': 58, 'period': 6, 'phase': 'Solid', 'shells': [2, 8, 18, 19, 9, 2], 'source': 'https://en.wikipedia.org/wiki/Cerium', 'spectral_img': None, 'summary': 'Cerium is a chemical element with symbol Ce and atomic number 58. It is a soft, silvery, ductile metal which easily oxidizes in air. Cerium was named after the dwarf planet Ceres (itself named after the Roman goddess of agriculture).', 'wxpos': 4, 'wypos': 6, 'xpos': 4, 'ypos': 9}), 'Cf': Element({'name': 'californium', 'symbol': 'Cf', 'atomic_number': 98, 'atomic_mass': 251, 'appearance': 'silvery', 'block': 'f', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_098_californium/element_098_californium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_098_californium/element_098_californium_srp_th.png', 'boil': 1743, 'category': 'actinide', 'cpk-hex': 'a136d4', 'density': 15.1, 'discovered_by': 'Lawrence Berkeley National Laboratory', 'electron_affinity': -97.31, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d10 6p6 7s2 5f10', 'electron_configuration_semantic': '[Rn] 5f10 7s2', 'electronegativity_pauling': 1.3, 'group': 3, 'image': {'attribution': 'United States Department of Energy (see File:Einsteinium.jpg), Public domain, via Wikimedia Commons', 'title': 'A disc of californium metal (249Cf, 10 mg). The source implies that the disc has a diameter about twice the thickness of a typical pin, or on the order of 1 mm', 'url': 'https://upload.wikimedia.org/wikipedia/commons/9/93/Californium.jpg'}, 'ionization_energies': [608], 'melt': 1173, 'molar_heat': None, 'named_by': None, 'number': 98, 'period': 7, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 28, 8, 2], 'source': 'https://en.wikipedia.org/wiki/Californium', 'spectral_img': None, 'summary': 'Californium is a radioactive metallic chemical element with symbol Cf and atomic number 98. The element was first made in 1950 at the University of California Radiation Laboratory in Berkeley, by bombarding curium with alpha particles (helium-4 ions). It is an actinide element, the sixth transuranium element to be synthesized, and has the second-highest atomic mass of all the elements that have been produced in amounts large enough to see with the unaided eye (after einsteinium).', 'wxpos': 12, 'wypos': 7, 'xpos': 12, 'ypos': 10}), 'Cl': Element({'name': 'chlorine', 'symbol': 'Cl', 'atomic_number': 17, 'atomic_mass': 35.45, 'appearance': 'pale yellow-green gas', 'block': 'p', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_017_chlorine/element_017_chlorine.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_017_chlorine/element_017_chlorine_srp_th.png', 'boil': 239.11, 'category': 'diatomic nonmetal', 'cpk-hex': '1ff01f', 'density': 3.2, 'discovered_by': 'Carl Wilhelm Scheele', 'electron_affinity': 348.575, 'electron_configuration': '1s2 2s2 2p6 3s2 3p5', 'electron_configuration_semantic': '[Ne] 3s2 3p5', 'electronegativity_pauling': 3.16, 'group': 17, 'image': {'attribution': 'Benjah-bmm27, Public domain, via Wikimedia Commons', 'title': 'A Sample of Chlorine', 'url': 'https://upload.wikimedia.org/wikipedia/commons/9/9a/Chlorine-sample-flip.jpg'}, 'ionization_energies': [1251.2, 2298, 3822, 5158.6, 6542, 9362, 11018, 33604, 38600, 43961, 51068, 57119, 63363, 72341, 78095, 352994, 380760], 'melt': 171.6, 'molar_heat': None, 'named_by': None, 'number': 17, 'period': 3, 'phase': 'Gas', 'shells': [2, 8, 7], 'source': 'https://en.wikipedia.org/wiki/Chlorine', 'spectral_img': 'https://en.wikipedia.org/wiki/File:Chlorine_spectrum_visible.png', 'summary': 'Chlorine is a chemical element with symbol Cl and atomic number 17. It also has a relative atomic mass of 35.5. Chlorine is in the halogen group (17) and is the second lightest halogen following fluorine.', 'wxpos': 31, 'wypos': 3, 'xpos': 17, 'ypos': 3}), 'Cm': Element({'name': 'curium', 'symbol': 'Cm', 'atomic_number': 96, 'atomic_mass': 247, 'appearance': 'silvery metallic, glows purple in the dark', 'block': 'f', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_096_curium/element_096_curium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_096_curium/element_096_curium_srp_th.png', 'boil': 3383, 'category': 'actinide', 'cpk-hex': '785ce3', 'density': 13.51, 'discovered_by': 'Glenn T. Seaborg', 'electron_affinity': 27.17, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d10 6p6 7s2 5f7 6d1', 'electron_configuration_semantic': '[Rn] 5f7 6d1 7s2', 'electronegativity_pauling': 1.28, 'group': 3, 'image': {'attribution': 'European Union, The Actinide Group, Institute for Transuranium Elements (JRC-ITU), source: https://images-of-elements.com/curium.php', 'title': 'A piece of curium, which emitts strong radiation that makes it glow', 'url': 'https://images-of-elements.com/s/curium-glow.jpg'}, 'ionization_energies': [581], 'melt': 1613, 'molar_heat': None, 'named_by': None, 'number': 96, 'period': 7, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 25, 9, 2], 'source': 'https://en.wikipedia.org/wiki/Curium', 'spectral_img': None, 'summary': 'Curium is a transuranic radioactive chemical element with symbol Cm and atomic number 96. This element of the actinide series was named after Marie and Pierre Curie both were known for their research on radioactivity. Curium was first intentionally produced and identified in July 1944 by the group of Glenn T. Seaborg at the University of California, Berkeley.', 'wxpos': 10, 'wypos': 7, 'xpos': 10, 'ypos': 10}), 'Cn': Element({'name': 'copernicium', 'symbol': 'Cn', 'atomic_number': 112, 'atomic_mass': 285, 'appearance': None, 'block': 'd', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_112_copernicium/element_112_copernicium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_112_copernicium/element_112_copernicium_srp_th.png', 'boil': 3570, 'category': 'transition metal', 'cpk-hex': None, 'density': 14, 'discovered_by': 'Gesellschaft für Schwerionenforschung', 'electron_affinity': None, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d10 6p6 7s2 5f14 6d10', 'electron_configuration_semantic': '*[Rn] 5f14 6d10 7s2', 'electronegativity_pauling': None, 'group': 12, 'image': {'attribution': 'Chemical Elements A Virtual Museum under a Creative Commons Attribution 3.0 Unported License, source: https://images-of-elements.com/copernicium.php', 'title': 'No Image Found', 'url': 'https://images-of-elements.com/s/transactinoid.png'}, 'ionization_energies': [], 'melt': None, 'molar_heat': None, 'named_by': None, 'number': 112, 'period': 7, 'phase': 'Liquid', 'shells': [2, 8, 18, 32, 32, 18, 2], 'source': 'https://en.wikipedia.org/wiki/Copernicium', 'spectral_img': None, 'summary': 'Copernicium is a chemical element with symbol Cn and atomic number 112. It is an extremely radioactive synthetic element that can only be created in a laboratory. The most stable known isotope, copernicium-285, has a half-life of approximately 29 seconds, but it is possible that this copernicium isotope may have a nuclear isomer with a longer half-life, 8.9 min.', 'wxpos': 26, 'wypos': 7, 'xpos': 12, 'ypos': 7}), 'Co': Element({'name': 'cobalt', 'symbol': 'Co', 'atomic_number': 27, 'atomic_mass': 58.9331944, 'appearance': 'hard lustrous gray metal', 'block': 'd', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_027_cobalt/element_027_cobalt.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_027_cobalt/element_027_cobalt_srp_th.png', 'boil': 3200, 'category': 'transition metal', 'cpk-hex': 'f090a0', 'density': 8.9, 'discovered_by': 'Georg Brandt', 'electron_affinity': 63.898, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d7', 'electron_configuration_semantic': '[Ar] 3d7 4s2', 'electronegativity_pauling': 1.88, 'group': 9, 'image': {'attribution': 'Hi-Res Images ofChemical Elements, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/cobalt.php', 'title': 'Fractions from a cobalt, 7 and 4 grams. Original size in cm: 2 x 2', 'url': 'https://upload.wikimedia.org/wikipedia/commons/6/62/Cobalt_ore_2.jpg'}, 'ionization_energies': [760.4, 1648, 3232, 4950, 7670, 9840, 12440, 15230, 17959, 26570, 29400, 32400, 36600, 39700, 42800, 49396, 52737, 134810, 145170, 154700, 167400, 178100, 189300, 204500, 214100, 920870, 966023], 'melt': 1768, 'molar_heat': 24.81, 'named_by': None, 'number': 27, 'period': 4, 'phase': 'Solid', 'shells': [2, 8, 15, 2], 'source': 'https://en.wikipedia.org/wiki/Cobalt', 'spectral_img': None, 'summary': "Cobalt is a chemical element with symbol Co and atomic number 27. Like nickel, cobalt in the Earth's crust is found only in chemically combined form, save for small deposits found in alloys of natural meteoric iron. The free element, produced by reductive smelting, is a hard, lustrous, silver-gray metal.", 'wxpos': 23, 'wypos': 4, 'xpos': 9, 'ypos': 4}), 'Cr': Element({'name': 'chromium', 'symbol': 'Cr', 'atomic_number': 24, 'atomic_mass': 51.99616, 'appearance': 'silvery metallic', 'block': 'd', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_024_chromium/element_024_chromium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_024_chromium/element_024_chromium_srp_th.png', 'boil': 2944, 'category': 'transition metal', 'cpk-hex': '8a99c7', 'density': 7.19, 'discovered_by': 'Louis Nicolas Vauquelin', 'electron_affinity': 65.21, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s1 3d5', 'electron_configuration_semantic': '[Ar] 3d5 4s1', 'electronegativity_pauling': 1.66, 'group': 6, 'image': {'attribution': 'Jurii, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/chromium.php', 'title': 'Piece of Chromium Metal', 'url': 'https://upload.wikimedia.org/wikipedia/commons/a/a1/Chromium.jpg'}, 'ionization_energies': [652.9, 1590.6, 2987, 4743, 6702, 8744.9, 15455, 17820, 20190, 23580, 26130, 28750, 34230, 37066, 97510, 105800, 114300, 125300, 134700, 144300, 157700, 166090, 721870, 761733], 'melt': 2180, 'molar_heat': 23.35, 'named_by': None, 'number': 24, 'period': 4, 'phase': 'Solid', 'shells': [2, 8, 13, 1], 'source': 'https://en.wikipedia.org/wiki/Chromium', 'spectral_img': None, 'summary': 'Chromium is a chemical element with symbol Cr and atomic number 24. It is the first element in Group 6. It is a steely-gray, lustrous, hard and brittle metal which takes a high polish, resists tarnishing, and has a high melting point.', 'wxpos': 20, 'wypos': 4, 'xpos': 6, 'ypos': 4}), 'Cs': Element({'name': 'cesium', 'symbol': 'Cs', 'atomic_number': 55, 'atomic_mass': 132.905451966, 'appearance': 'silvery gold', 'block': 's', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_055_cesium/element_055_cesium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_055_cesium/element_055_cesium_srp_th.png', 'boil': 944, 'category': 'alkali metal', 'cpk-hex': '57178f', 'density': 1.93, 'discovered_by': 'Robert Bunsen', 'electron_affinity': 45.505, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s1', 'electron_configuration_semantic': '[Xe] 6s1', 'electronegativity_pauling': 0.79, 'group': 1, 'image': {'attribution': 'Dnn87 Contact email: Dnn87yahoo.dk, CC BY-SA 3.0 <https://creativecommons.org/licenses/by-sa/3.0>, via Wikimedia Commons', 'title': 'Cesium/Caesium metal', 'url': 'https://upload.wikimedia.org/wikipedia/commons/3/3d/Cesium.jpg'}, 'ionization_energies': [375.7, 2234.3, 3400], 'melt': 301.7, 'molar_heat': 32.21, 'named_by': None, 'number': 55, 'period': 6, 'phase': 'Solid', 'shells': [2, 8, 18, 18, 8, 1], 'source': 'https://en.wikipedia.org/wiki/Cesium', 'spectral_img': None, 'summary': 'Caesium or cesium is a chemical element with symbol Cs and atomic number 55. It is a soft, silvery-gold alkali metal with a melting point of 28 °C (82 °F), which makes it one of only five elemental metals that are liquid at or near room temperature. Caesium is an alkali metal and has physical and chemical properties similar to those of rubidium and potassium.', 'wxpos': 1, 'wypos': 6, 'xpos': 1, 'ypos': 6}), 'Cu': Element({'name': 'copper', 'symbol': 'Cu', 'atomic_number': 29, 'atomic_mass': 63.5463, 'appearance': 'red-orange metallic luster', 'block': 'd', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_029_copper/element_029_copper.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_029_copper/element_029_copper_srp_th.png', 'boil': 2835, 'category': 'transition metal', 'cpk-hex': 'c88033', 'density': 8.96, 'discovered_by': 'Middle East', 'electron_affinity': 119.235, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s1 3d10', 'electron_configuration_semantic': '[Ar] 3d10 4s1', 'electronegativity_pauling': 1.9, 'group': 11, 'image': {'attribution': "Native_Copper_Macro_Digon3.jpg: 'Jonathan Zander (Digon3)' derivative work: Materialscientist, CC BY-SA 2.5 <https://creativecommons.org/licenses/by-sa/2.5>, via Wikimedia Commons", 'title': 'Macro of Native Copper about 1 ½ inches (4 cm) in size', 'url': 'https://upload.wikimedia.org/wikipedia/commons/f/f0/NatCopper.jpg'}, 'ionization_energies': [745.5, 1957.9, 3555, 5536, 7700, 9900, 13400, 16000, 19200, 22400, 25600, 35600, 38700, 42000, 46700, 50200, 53700, 61100, 64702, 163700, 174100, 184900, 198800, 210500, 222700, 239100, 249660, 1067358, 1116105], 'melt': 1357.77, 'molar_heat': 24.44, 'named_by': None, 'number': 29, 'period': 4, 'phase': 'Solid', 'shells': [2, 8, 18, 1], 'source': 'https://en.wikipedia.org/wiki/Copper', 'spectral_img': None, 'summary': 'Copper is a chemical element with symbol Cu (from Latin:cuprum) and atomic number 29. It is a soft, malleable and ductile metal with very high thermal and electrical conductivity. A freshly exposed surface of pure copper has a reddish-orange color.', 'wxpos': 25, 'wypos': 4, 'xpos': 11, 'ypos': 4}), 'Db': Element({'name': 'dubnium', 'symbol': 'Db', 'atomic_number': 105, 'atomic_mass': 268, 'appearance': None, 'block': 'd', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_105_dubnium/element_105_dubnium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_105_dubnium/element_105_dubnium_srp_th.png', 'boil': None, 'category': 'transition metal', 'cpk-hex': 'd1004f', 'density': 29.3, 'discovered_by': 'Joint Institute for Nuclear Research', 'electron_affinity': None, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d10 6p6 7s2 5f14 6d3', 'electron_configuration_semantic': '*[Rn] 5f14 6d3 7s2', 'electronegativity_pauling': None, 'group': 5, 'image': {'attribution': 'Chemical Elements A Virtual Museum under a Creative Commons Attribution 3.0 Unported License, source: https://images-of-elements.com/dubnium.php', 'title': 'No Image Found', 'url': 'https://images-of-elements.com/s/transactinoid.png'}, 'ionization_energies': [], 'melt': None, 'molar_heat': None, 'named_by': None, 'number': 105, 'period': 7, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 32, 11, 2], 'source': 'https://en.wikipedia.org/wiki/Dubnium', 'spectral_img': None, 'summary': 'Dubnium is a chemical element with symbol Db and atomic number 105. It is named after the town of Dubna in Russia (north of Moscow), where it was first produced. It is a synthetic element (an element that can be created in a laboratory but is not found in nature) and radioactive; the most stable known isotope, dubnium-268, has a half-life of approximately 28 hours.', 'wxpos': 19, 'wypos': 7, 'xpos': 5, 'ypos': 7}), 'Ds': Element({'name': 'darmstadtium', 'symbol': 'Ds', 'atomic_number': 110, 'atomic_mass': 281, 'appearance': None, 'block': 'd', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_110_darmstadtium/element_110_darmstadtium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_110_darmstadtium/element_110_darmstadtium_srp_th.png', 'boil': None, 'category': 'unknown, probably transition metal', 'cpk-hex': None, 'density': 34.8, 'discovered_by': 'Gesellschaft für Schwerionenforschung', 'electron_affinity': None, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d10 6p6 7s2 5f14 6d8', 'electron_configuration_semantic': '*[Rn] 5f14 6d9 7s1', 'electronegativity_pauling': None, 'group': 10, 'image': {'attribution': 'Chemical Elements A Virtual Museum under a Creative Commons Attribution 3.0 Unported License, source: https://images-of-elements.com/darmstadtium.php', 'title': 'No Image Found', 'url': 'https://images-of-elements.com/s/transactinoid.png'}, 'ionization_energies': [], 'melt': None, 'molar_heat': None, 'named_by': None, 'number': 110, 'period': 7, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 32, 16, 2], 'source': 'https://en.wikipedia.org/wiki/Darmstadtium', 'spectral_img': None, 'summary': 'Darmstadtium is a chemical element with symbol Ds and atomic number 110. It is an extremely radioactive synthetic element. The most stable known isotope, darmstadtium-281, has a half-life of approximately 10 seconds.', 'wxpos': 24, 'wypos': 7, 'xpos': 10, 'ypos': 7}), 'Dy': Element({'name': 'dysprosium', 'symbol': 'Dy', 'atomic_number': 66, 'atomic_mass': 162.5001, 'appearance': 'silvery white', 'block': 'f', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_066_dysprosium/element_066_dysprosium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_066_dysprosium/element_066_dysprosium_srp_th.png', 'boil': 2840, 'category': 'lanthanide', 'cpk-hex': '1fffc7', 'density': 8.54, 'discovered_by': 'Lecoq de Boisbaudran', 'electron_affinity': 33.96, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f10', 'electron_configuration_semantic': '[Xe] 4f10 6s2', 'electronegativity_pauling': 1.22, 'group': 3, 'image': {'attribution': 'Jurii, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/dysprosium.php', 'title': 'Pure Dysprosium Dendrites', 'url': 'https://upload.wikimedia.org/wikipedia/commons/5/55/Dysprosium-2.jpg'}, 'ionization_energies': [573, 1130, 2200, 3990], 'melt': 1680, 'molar_heat': 27.7, 'named_by': None, 'number': 66, 'period': 6, 'phase': 'Solid', 'shells': [2, 8, 18, 28, 8, 2], 'source': 'https://en.wikipedia.org/wiki/Dysprosium', 'spectral_img': None, 'summary': 'Dysprosium is a chemical element with the symbol Dy and atomic number 66. It is a rare earth element with a metallic silver luster. Dysprosium is never found in nature as a free element, though it is found in various minerals, such as xenotime.', 'wxpos': 12, 'wypos': 6, 'xpos': 12, 'ypos': 9}), 'Er': Element({'name': 'erbium', 'symbol': 'Er', 'atomic_number': 68, 'atomic_mass': 167.2593, 'appearance': 'silvery white', 'block': 'f', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_068_erbium/element_068_erbium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_068_erbium/element_068_erbium_srp_th.png', 'boil': 3141, 'category': 'lanthanide', 'cpk-hex': '00e675', 'density': 9.066, 'discovered_by': 'Carl Gustaf Mosander', 'electron_affinity': 30.1, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f12', 'electron_configuration_semantic': '[Xe] 4f12 6s2', 'electronegativity_pauling': 1.24, 'group': 3, 'image': {'attribution': 'Jurii, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/erbium.php', 'title': '9.5 Gramms Pure Erbium, 2 x 2 cm', 'url': 'https://upload.wikimedia.org/wikipedia/commons/2/2a/Erbium-2.jpg'}, 'ionization_energies': [589.3, 1150, 2194, 4120], 'melt': 1802, 'molar_heat': 28.12, 'named_by': None, 'number': 68, 'period': 6, 'phase': 'Solid', 'shells': [2, 8, 18, 30, 8, 2], 'source': 'https://en.wikipedia.org/wiki/Erbium', 'spectral_img': None, 'summary': 'Erbium is a chemical element in the lanthanide series, with symbol Er and atomic number 68. A silvery-white solid metal when artificially isolated, natural erbium is always found in chemical combination with other elements on Earth. As such, it is a rare earth element which is associated with several other rare elements in the mineral gadolinite from Ytterby in Sweden, where yttrium, ytterbium, and terbium were discovered.', 'wxpos': 14, 'wypos': 6, 'xpos': 14, 'ypos': 9}), 'Es': Element({'name': 'einsteinium', 'symbol': 'Es', 'atomic_number': 99, 'atomic_mass': 252, 'appearance': 'silver-colored', 'block': 'f', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_099_einsteinium/element_099_einsteinium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_099_einsteinium/element_099_einsteinium_srp_th.png', 'boil': 1269, 'category': 'actinide', 'cpk-hex': 'b31fd4', 'density': 8.84, 'discovered_by': 'Lawrence Berkeley National Laboratory', 'electron_affinity': -28.6, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d10 6p6 7s2 5f11', 'electron_configuration_semantic': '[Rn] 5f11 7s2', 'electronegativity_pauling': 1.3, 'group': 3, 'image': {'attribution': 'Haire, R. G., US Department of Energy.Touched up by Materialscientist at en.wikipedia., Public domain, via Wikimedia Commons', 'title': '300 micrograms of Einsteinium 253, which has a half-life of 20 days.', 'url': 'https://upload.wikimedia.org/wikipedia/commons/5/55/Einsteinium.jpg'}, 'ionization_energies': [619], 'melt': 1133, 'molar_heat': None, 'named_by': None, 'number': 99, 'period': 7, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 29, 8, 2], 'source': 'https://en.wikipedia.org/wiki/Einsteinium', 'spectral_img': None, 'summary': 'Einsteinium is a synthetic element with symbol Es and atomic number 99. It is the seventh transuranic element, and an actinide. Einsteinium was discovered as a component of the debris of the first hydrogen bomb explosion in 1952, and named after Albert Einstein.', 'wxpos': 13, 'wypos': 7, 'xpos': 13, 'ypos': 10}), 'Eu': Element({'name': 'europium', 'symbol': 'Eu', 'atomic_number': 63, 'atomic_mass': 151.9641, 'appearance': None, 'block': 'f', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_063_europium/element_063_europium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_063_europium/element_063_europium_srp_th.png', 'boil': 1802, 'category': 'lanthanide', 'cpk-hex': '61ffc7', 'density': 5.264, 'discovered_by': 'Eugène-Anatole Demarçay', 'electron_affinity': 11.2, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f7', 'electron_configuration_semantic': '[Xe] 4f7 6s2', 'electronegativity_pauling': 1.2, 'group': 3, 'image': {'attribution': 'Jurii, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/europium.php', 'title': 'Weakly Oxidized Europium, hence slightly yellowish. 1.5 grams, large piece 0.6 x 1.6 cm.', 'url': 'https://upload.wikimedia.org/wikipedia/commons/6/6a/Europium.jpg'}, 'ionization_energies': [547.1, 1085, 2404, 4120], 'melt': 1099, 'molar_heat': 27.66, 'named_by': None, 'number': 63, 'period': 6, 'phase': 'Solid', 'shells': [2, 8, 18, 25, 8, 2], 'source': 'https://en.wikipedia.org/wiki/Europium', 'spectral_img': None, 'summary': 'Europium is a chemical element with symbol Eu and atomic number 63. It was isolated in 1901 and is named after the continent of Europe. It is a moderately hard, silvery metal which readily oxidizes in air and water.', 'wxpos': 9, 'wypos': 6, 'xpos': 9, 'ypos': 9}), 'F': Element({'name': 'fluorine', 'symbol': 'F', 'atomic_number': 9, 'atomic_mass': 18.9984031636, 'appearance': None, 'block': 'p', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_009_fluorine/element_009_fluorine.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_009_fluorine/element_009_fluorine_srp_th.png', 'boil': 85.03, 'category': 'diatomic nonmetal', 'cpk-hex': '90e050', 'density': 1.696, 'discovered_by': 'André-Marie Ampère', 'electron_affinity': 328.1649, 'electron_configuration': '1s2 2s2 2p5', 'electron_configuration_semantic': '[He] 2s2 2p5', 'electronegativity_pauling': 3.98, 'group': 17, 'image': {'attribution': 'Fulvio314, CC BY-SA 3.0 <https://creativecommons.org/licenses/by-sa/3.0>, via Wikimedia Commons', 'title': 'Liquid Fluorine at -196°C', 'url': 'https://upload.wikimedia.org/wikipedia/commons/2/2c/Fluoro_liquido_a_-196%C2%B0C_1.jpg'}, 'ionization_energies': [1681, 3374.2, 6050.4, 8407.7, 11022.7, 15164.1, 17868, 92038.1, 106434.3], 'melt': 53.48, 'molar_heat': None, 'named_by': 'Humphry Davy', 'number': 9, 'period': 2, 'phase': 'Gas', 'shells': [2, 7], 'source': 'https://en.wikipedia.org/wiki/Fluorine', 'spectral_img': None, 'summary': 'Fluorine is a chemical element with symbol F and atomic number 9. It is the lightest halogen and exists as a highly toxic pale yellow diatomic gas at standard conditions. As the most electronegative element, it is extremely reactive:almost all other elements, including some noble gases, form compounds with fluorine.', 'wxpos': 31, 'wypos': 2, 'xpos': 17, 'ypos': 2}), 'Fe': Element({'name': 'iron', 'symbol': 'Fe', 'atomic_number': 26, 'atomic_mass': 55.8452, 'appearance': 'lustrous metallic with a grayish tinge', 'block': 'd', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_026_iron/element_026_iron.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_026_iron/element_026_iron_srp_th.png', 'boil': 3134, 'category': 'transition metal', 'cpk-hex': 'e06633', 'density': 7.874, 'discovered_by': '5000 BC', 'electron_affinity': 14.785, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d6', 'electron_configuration_semantic': '[Ar] 3d6 4s2', 'electronegativity_pauling': 1.83, 'group': 8, 'image': {'attribution': 'Chemical ELements A Virtual Museum, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0> source: https://images-of-elements.com/iron.php', 'title': 'Fragments of an iron meteorite, about 92% iron. Original size of the single pieces in cm: 0.4 - 0.8', 'url': 'https://images-of-elements.com/iron-2.jpg'}, 'ionization_energies': [762.5, 1561.9, 2957, 5290, 7240, 9560, 12060, 14580, 22540, 25290, 28000, 31920, 34830, 37840, 44100, 47206, 122200, 131000, 140500, 152600, 163000, 173600, 188100, 195200, 851800, 895161], 'melt': 1811, 'molar_heat': 25.1, 'named_by': None, 'number': 26, 'period': 4, 'phase': 'Solid', 'shells': [2, 8, 14, 2], 'source': 'https://en.wikipedia.org/wiki/Iron', 'spectral_img': 'https://en.wikipedia.org/wiki/File:Iron_Spectrum.jpg', 'summary': "Iron is a chemical element with symbol Fe (from Latin:ferrum) and atomic number 26. It is a metal in the first transition series. It is by mass the most common element on Earth, forming much of Earth's outer and inner core.", 'wxpos': 22, 'wypos': 4, 'xpos': 8, 'ypos': 4}), 'Fl': Element({'name': 'flerovium', 'symbol': 'Fl', 'atomic_number': 114, 'atomic_mass': 289, 'appearance': None, 'block': 'p', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_114_flerovium/element_114_flerovium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_114_flerovium/element_114_flerovium_srp_th.png', 'boil': 420, 'category': 'post-transition metal', 'cpk-hex': None, 'density': 14, 'discovered_by': 'Joint Institute for Nuclear Research', 'electron_affinity': None, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d10 6p6 7s2 5f14 6d10 7p2', 'electron_configuration_semantic': '*[Rn] 5f14 6d10 7s2 7p2', 'electronegativity_pauling': None, 'group': 14, 'image': {'attribution': 'Chemical Elements A Virtual Museum under a Creative Commons Attribution 3.0 Unported License, source: https://images-of-elements.com/flerovium.php', 'title': 'No Image Found', 'url': 'https://images-of-elements.com/s/transactinoid.png'}, 'ionization_energies': [], 'melt': 340, 'molar_heat': None, 'named_by': None, 'number': 114, 'period': 7, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 32, 18, 4], 'source': 'https://en.wikipedia.org/wiki/Flerovium', 'spectral_img': None, 'summary': 'Flerovium is a superheavy artificial chemical element with symbol Fl and atomic number 114. It is an extremely radioactive synthetic element. The element is named after the Flerov Laboratory of Nuclear Reactions of the Joint Institute for Nuclear Research in Dubna, Russia, where the element was discovered in 1998.', 'wxpos': 28, 'wypos': 7, 'xpos': 14, 'ypos': 7}), 'Fm': Element({'name': 'fermium', 'symbol': 'Fm', 'atomic_number': 100, 'atomic_mass': 257, 'appearance': None, 'block': 'f', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_100_fermium/element_100_fermium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_100_fermium/element_100_fermium_srp_th.png', 'boil': None, 'category': 'actinide', 'cpk-hex': 'b31fba', 'density': None, 'discovered_by': 'Lawrence Berkeley National Laboratory', 'electron_affinity': 33.96, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d10 6p6 7s2 5f12', 'electron_configuration_semantic': '[Rn] 5f12 7s2', 'electronegativity_pauling': 1.3, 'group': 3, 'image': {'attribution': 'U.S. Department of Energy, Public domain, via Wikimedia Commons', 'title': 'Fermium was first observed in the fallout from the Ivy Mike nuclear test.', 'url': 'https://upload.wikimedia.org/wikipedia/commons/5/58/Ivy_Mike_-_mushroom_cloud.jpg'}, 'ionization_energies': [627], 'melt': 1800, 'molar_heat': None, 'named_by': None, 'number': 100, 'period': 7, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 30, 8, 2], 'source': 'https://en.wikipedia.org/wiki/Fermium', 'spectral_img': None, 'summary': 'Fermium is a synthetic element with symbol Fm and atomic number 100. It is a member of the actinide series. It is the heaviest element that can be formed by neutron bombardment of lighter elements, and hence the last element that can be prepared in macroscopic quantities, although pure fermium metal has not yet been prepared.', 'wxpos': 14, 'wypos': 7, 'xpos': 14, 'ypos': 10}), 'Fr': Element({'name': 'francium', 'symbol': 'Fr', 'atomic_number': 87, 'atomic_mass': 223, 'appearance': None, 'block': 's', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_087_francium/element_087_francium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_087_francium/element_087_francium_srp_th.png', 'boil': 950, 'category': 'alkali metal', 'cpk-hex': '420066', 'density': 1.87, 'discovered_by': 'Marguerite Perey', 'electron_affinity': 46.89, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d10 6p6 7s1', 'electron_configuration_semantic': '[Rn] 7s1', 'electronegativity_pauling': 0.79, 'group': 1, 'image': {'attribution': 'Chemical ELements A Virtual Museum, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0> source: https://images-of-elements.com/francium.jpg', 'title': 'This is only an illustration, not francium itself.', 'url': 'https://images-of-elements.com/francium.jpg'}, 'ionization_energies': [380], 'melt': 300, 'molar_heat': None, 'named_by': None, 'number': 87, 'period': 7, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 18, 8, 1], 'source': 'https://en.wikipedia.org/wiki/Francium', 'spectral_img': None, 'summary': 'Francium is a chemical element with symbol Fr and atomic number 87. It used to be known as eka-caesium and actinium K. It is the second-least electronegative element, behind only caesium. Francium is a highly radioactive metal that decays into astatine, radium, and radon.', 'wxpos': 1, 'wypos': 7, 'xpos': 1, 'ypos': 7}), 'Ga': Element({'name': 'gallium', 'symbol': 'Ga', 'atomic_number': 31, 'atomic_mass': 69.7231, 'appearance': 'silver-white', 'block': 'p', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_031_gallium/element_031_gallium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_031_gallium/element_031_gallium_srp_th.png', 'boil': 2673, 'category': 'post-transition metal', 'cpk-hex': 'c28f8f', 'density': 5.91, 'discovered_by': 'Lecoq de Boisbaudran', 'electron_affinity': 41, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p1', 'electron_configuration_semantic': '[Ar] 3d10 4s2 4p1', 'electronegativity_pauling': 1.81, 'group': 13, 'image': {'attribution': 'Hi-Res Images ofChemical Elements, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/gallium.php', 'title': 'Solid gallium, fresh and after some time (2 months) at room temperature', 'url': 'https://upload.wikimedia.org/wikipedia/commons/b/b1/Solid_gallium_%28Ga%29.jpg'}, 'ionization_energies': [578.8, 1979.3, 2963, 6180], 'melt': 302.9146, 'molar_heat': 25.86, 'named_by': None, 'number': 31, 'period': 4, 'phase': 'Solid', 'shells': [2, 8, 18, 3], 'source': 'https://en.wikipedia.org/wiki/Gallium', 'spectral_img': None, 'summary': 'Gallium is a chemical element with symbol Ga and atomic number 31. Elemental gallium does not occur in free form in nature, but as the gallium(III) compounds that are in trace amounts in zinc ores and in bauxite. Gallium is a soft, silvery metal, and elemental gallium is a brittle solid at low temperatures, and melts at 29.76 °C (85.57 °F) (slightly above room temperature).', 'wxpos': 27, 'wypos': 4, 'xpos': 13, 'ypos': 4}), 'Gd': Element({'name': 'gadolinium', 'symbol': 'Gd', 'atomic_number': 64, 'atomic_mass': 157.253, 'appearance': 'silvery white', 'block': 'f', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_064_gadolinium/element_064_gadolinium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_064_gadolinium/element_064_gadolinium_srp_th.png', 'boil': 3273, 'category': 'lanthanide', 'cpk-hex': '45ffc7', 'density': 7.9, 'discovered_by': 'Jean Charles Galissard de Marignac', 'electron_affinity': 13.22, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f7 5d1', 'electron_configuration_semantic': '[Xe] 4f7 5d1 6s2', 'electronegativity_pauling': 1.2, 'group': 3, 'image': {'attribution': 'Jurii, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/gadolinium.php', 'title': 'Pure (99.95%) Amorphous Gadolinium, about 12 grams, 2 × 1.5 × 0.5 cm, cast in acrylic glass', 'url': 'https://upload.wikimedia.org/wikipedia/commons/c/c2/Gadolinium-2.jpg'}, 'ionization_energies': [593.4, 1170, 1990, 4250], 'melt': 1585, 'molar_heat': 37.03, 'named_by': None, 'number': 64, 'period': 6, 'phase': 'Solid', 'shells': [2, 8, 18, 25, 9, 2], 'source': 'https://en.wikipedia.org/wiki/Gadolinium', 'spectral_img': None, 'summary': 'Gadolinium is a chemical element with symbol Gd and atomic number 64. It is a silvery-white, malleable and ductile rare-earth metal. It is found in nature only in combined (salt) form.', 'wxpos': 10, 'wypos': 6, 'xpos': 10, 'ypos': 9}), 'Ge': Element({'name': 'germanium', 'symbol': 'Ge', 'atomic_number': 32, 'atomic_mass': 72.6308, 'appearance': 'grayish-white', 'block': 'p', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_032_germanium/element_032_germanium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_032_germanium/element_032_germanium_srp_th.png', 'boil': 3106, 'category': 'metalloid', 'cpk-hex': '668f8f', 'density': 5.323, 'discovered_by': 'Clemens Winkler', 'electron_affinity': 118.9352, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p2', 'electron_configuration_semantic': '[Ar] 3d10 4s2 4p2', 'electronegativity_pauling': 2.01, 'group': 14, 'image': {'attribution': 'Jurii, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/germanium.php', 'title': '12 Grams Polycrystalline Germanium, 2*3 cm', 'url': 'https://upload.wikimedia.org/wikipedia/commons/0/08/Polycrystalline-germanium.jpg'}, 'ionization_energies': [762, 1537.5, 3302.1, 4411, 9020], 'melt': 1211.4, 'molar_heat': 23.222, 'named_by': None, 'number': 32, 'period': 4, 'phase': 'Solid', 'shells': [2, 8, 18, 4], 'source': 'https://en.wikipedia.org/wiki/Germanium', 'spectral_img': None, 'summary': 'Germanium is a chemical element with symbol Ge and atomic number 32. It is a lustrous, hard, grayish-white metalloid in the carbon group, chemically similar to its group neighbors tin and silicon. Purified germanium is a semiconductor, with an appearance most similar to elemental silicon.', 'wxpos': 28, 'wypos': 4, 'xpos': 14, 'ypos': 4}), 'H': Element({'name': 'hydrogen', 'symbol': 'H', 'atomic_number': 1, 'atomic_mass': 1.008, 'appearance': 'colorless gas', 'block': 's', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_001_hydrogen/element_001_hydrogen.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_001_hydrogen/element_001_hydrogen_srp_th.png', 'boil': 20.271, 'category': 'diatomic nonmetal', 'cpk-hex': 'ffffff', 'density': 0.08988, 'discovered_by': 'Henry Cavendish', 'electron_affinity': 72.769, 'electron_configuration': '1s1', 'electron_configuration_semantic': '1s1', 'electronegativity_pauling': 2.2, 'group': 1, 'image': {'attribution': 'User:Jurii, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/hydrogen.php', 'title': 'Vial of glowing ultrapure hydrogen, H2. Original size in cm: 1 x 5', 'url': 'https://upload.wikimedia.org/wikipedia/commons/d/d9/Hydrogenglow.jpg'}, 'ionization_energies': [1312], 'melt': 13.99, 'molar_heat': 28.836, 'named_by': 'Antoine Lavoisier', 'number': 1, 'period': 1, 'phase': 'Gas', 'shells': [1], 'source': 'https://en.wikipedia.org/wiki/Hydrogen', 'spectral_img': 'https://en.wikipedia.org/wiki/File:Hydrogen_Spectra.jpg', 'summary': 'Hydrogen is a chemical element with chemical symbol H and atomic number 1. With an atomic weight of 1.00794 u, hydrogen is the lightest element on the periodic table. Its monatomic form (H) is the most abundant chemical substance in the Universe, constituting roughly 75% of all baryonic mass.', 'wxpos': 1, 'wypos': 1, 'xpos': 1, 'ypos': 1}), 'He': Element({'name': 'helium', 'symbol': 'He', 'atomic_number': 2, 'atomic_mass': 4.0026022, 'appearance': 'colorless gas, exhibiting a red-orange glow when placed in a high-voltage electric field', 'block': 's', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_002_helium/element_002_helium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_002_helium/element_002_helium_srp_th.png', 'boil': 4.222, 'category': 'noble gas', 'cpk-hex': 'd9ffff', 'density': 0.1786, 'discovered_by': 'Pierre Janssen', 'electron_affinity': -48, 'electron_configuration': '1s2', 'electron_configuration_semantic': '1s2', 'electronegativity_pauling': None, 'group': 18, 'image': {'attribution': 'Jurii, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/helium.php', 'title': 'Vial of glowing ultrapure helium. Original size in cm: 1 x 5', 'url': 'https://upload.wikimedia.org/wikipedia/commons/0/00/Helium-glow.jpg'}, 'ionization_energies': [2372.3, 5250.5], 'melt': 0.95, 'molar_heat': None, 'named_by': None, 'number': 2, 'period': 1, 'phase': 'Gas', 'shells': [2], 'source': 'https://en.wikipedia.org/wiki/Helium', 'spectral_img': 'https://en.wikipedia.org/wiki/File:Helium_spectrum.jpg', 'summary': 'Helium is a chemical element with symbol He and atomic number 2. It is a colorless, odorless, tasteless, non-toxic, inert, monatomic gas that heads the noble gas group in the periodic table. Its boiling and melting points are the lowest among all the elements.', 'wxpos': 32, 'wypos': 1, 'xpos': 18, 'ypos': 1}), 'Hf': Element({'name': 'hafnium', 'symbol': 'Hf', 'atomic_number': 72, 'atomic_mass': 178.492, 'appearance': 'steel gray', 'block': 'd', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_072_hafnium/element_072_hafnium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_072_hafnium/element_072_hafnium_srp_th.png', 'boil': 4876, 'category': 'transition metal', 'cpk-hex': '4dc2ff', 'density': 13.31, 'discovered_by': 'Dirk Coster', 'electron_affinity': 17.18, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d2', 'electron_configuration_semantic': '[Xe] 4f14 5d2 6s2', 'electronegativity_pauling': 1.3, 'group': 4, 'image': {'attribution': 'Hi-Res Images ofChemical Elements, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/hafnium.php', 'title': 'Electrolytic Hafnium, 22 grams. Original size in cm: 1 x 2 x 3', 'url': 'https://upload.wikimedia.org/wikipedia/commons/1/17/Hafnium_%2872_Hf%29.jpg'}, 'ionization_energies': [658.5, 1440, 2250, 3216], 'melt': 2506, 'molar_heat': 25.73, 'named_by': None, 'number': 72, 'period': 6, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 10, 2], 'source': 'https://en.wikipedia.org/wiki/Hafnium', 'spectral_img': 'https://en.wikipedia.org/wiki/File:Hafnium_spectrum_visible.png', 'summary': 'Hafnium is a chemical element with symbol Hf and atomic number 72. A lustrous, silvery gray, tetravalent transition metal, hafnium chemically resembles zirconium and is found in zirconium minerals. Its existence was predicted by Dmitri Mendeleev in 1869, though it was not identified until 1923, making it the penultimate stable element to be discovered (rhenium was identified two years later).', 'wxpos': 18, 'wypos': 6, 'xpos': 4, 'ypos': 6}), 'Hg': Element({'name': 'mercury', 'symbol': 'Hg', 'atomic_number': 80, 'atomic_mass': 200.5923, 'appearance': 'silvery', 'block': 'd', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_080_mercury/element_080_mercury.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_080_mercury/element_080_mercury_srp_th.png', 'boil': 629.88, 'category': 'transition metal', 'cpk-hex': 'b8b8d0', 'density': 13.534, 'discovered_by': 'unknown, before 2000 BCE', 'electron_affinity': -48, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d10', 'electron_configuration_semantic': '[Xe] 4f14 5d10 6s2', 'electronegativity_pauling': 2, 'group': 12, 'image': {'attribution': 'Hi-Res Images of Chemical Elements, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/mercury.php', 'title': '6 grams pure mercury. Diameter of the inner disc: 2 cm', 'url': 'https://upload.wikimedia.org/wikipedia/commons/b/be/Hydrargyrum_%2880_Hg%29.jpg'}, 'ionization_energies': [1007.1, 1810, 3300], 'melt': 234.321, 'molar_heat': 27.983, 'named_by': None, 'number': 80, 'period': 6, 'phase': 'Liquid', 'shells': [2, 8, 18, 32, 18, 2], 'source': 'https://en.wikipedia.org/wiki/Mercury (Element)', 'spectral_img': None, 'summary': 'Mercury is a chemical element with symbol Hg and atomic number 80. It is commonly known as quicksilver and was formerly named hydrargyrum (/haɪˈdrɑːrdʒərəm/). A heavy, silvery d-block element, mercury is the only metallic element that is liquid at standard conditions for temperature and pressure; the only other element that is liquid under these conditions is bromine, though metals such as caesium, gallium, and rubidium melt just above room temperature.', 'wxpos': 26, 'wypos': 6, 'xpos': 12, 'ypos': 6}), 'Ho': Element({'name': 'holmium', 'symbol': 'Ho', 'atomic_number': 67, 'atomic_mass': 164.930332, 'appearance': 'silvery white', 'block': 'f', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_067_holmium/element_067_holmium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_067_holmium/element_067_holmium_srp_th.png', 'boil': 2873, 'category': 'lanthanide', 'cpk-hex': '00ff9c', 'density': 8.79, 'discovered_by': 'Marc Delafontaine', 'electron_affinity': 32.61, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f11', 'electron_configuration_semantic': '[Xe] 4f11 6s2', 'electronegativity_pauling': 1.23, 'group': 3, 'image': {'attribution': 'Unknown authorUnknown author, CC BY 1.0 <https://creativecommons.org/licenses/by/1.0>, via Wikimedia Commons, source: https://images-of-elements.com/holmium.php', 'title': 'Ultrapure Holmium, 17 grams. Original size in cm: 1.5 x 2.5', 'url': 'https://upload.wikimedia.org/wikipedia/commons/0/0a/Holmium2.jpg'}, 'ionization_energies': [581, 1140, 2204, 4100], 'melt': 1734, 'molar_heat': 27.15, 'named_by': None, 'number': 67, 'period': 6, 'phase': 'Solid', 'shells': [2, 8, 18, 29, 8, 2], 'source': 'https://en.wikipedia.org/wiki/Holmium', 'spectral_img': None, 'summary': 'Holmium is a chemical element with symbol Ho and atomic number 67. Part of the lanthanide series, holmium is a rare earth element. Holmium was discovered by Swedish chemist Per Theodor Cleve.', 'wxpos': 13, 'wypos': 6, 'xpos': 13, 'ypos': 9}), 'Hs': Element({'name': 'hassium', 'symbol': 'Hs', 'atomic_number': 108, 'atomic_mass': 269, 'appearance': None, 'block': 'd', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_108_hassium/element_108_hassium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_108_hassium/element_108_hassium_srp_th.png', 'boil': None, 'category': 'transition metal', 'cpk-hex': 'e6002e', 'density': 40.7, 'discovered_by': 'Gesellschaft für Schwerionenforschung', 'electron_affinity': None, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d10 6p6 7s2 5f14 6d6', 'electron_configuration_semantic': '*[Rn] 5f14 6d6 7s2', 'electronegativity_pauling': None, 'group': 8, 'image': {'attribution': 'Chemical Elements A Virtual Museum under a Creative Commons Attribution 3.0 Unported License, source: https://images-of-elements.com/hassium.php', 'title': 'No Image Found', 'url': 'https://images-of-elements.com/s/transactinoid.png'}, 'ionization_energies': [], 'melt': 126, 'molar_heat': None, 'named_by': None, 'number': 108, 'period': 7, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 32, 14, 2], 'source': 'https://en.wikipedia.org/wiki/Hassium', 'spectral_img': None, 'summary': 'Hassium is a chemical element with symbol Hs and atomic number 108, named after the German state of Hesse. It is a synthetic element (an element that can be created in a laboratory but is not found in nature) and radioactive; the most stable known isotope, 269Hs, has a half-life of approximately 9.7 seconds, although an unconfirmed metastable state, 277mHs, may have a longer half-life of about 130 seconds. More than 100 atoms of hassium have been synthesized to date.', 'wxpos': 22, 'wypos': 7, 'xpos': 8, 'ypos': 7}), 'I': Element({'name': 'iodine', 'symbol': 'I', 'atomic_number': 53, 'atomic_mass': 126.904473, 'appearance': 'lustrous metallic gray, violet as a gas', 'block': 'p', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_053_iodine/element_053_iodine.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_053_iodine/element_053_iodine_srp_th.png', 'boil': 457.4, 'category': 'diatomic nonmetal', 'cpk-hex': '940094', 'density': 4.933, 'discovered_by': 'Bernard Courtois', 'electron_affinity': 295.1531, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p5', 'electron_configuration_semantic': '[Kr] 4d10 5s2 5p5', 'electronegativity_pauling': 2.66, 'group': 17, 'image': {'attribution': 'Benjah-bmm27, Public domain, via Wikimedia Commons', 'title': 'Iodine Sample', 'url': 'https://upload.wikimedia.org/wikipedia/commons/c/c2/Iodine-sample.jpg'}, 'ionization_energies': [1008.4, 1845.9, 3180], 'melt': 386.85, 'molar_heat': None, 'named_by': None, 'number': 53, 'period': 5, 'phase': 'Solid', 'shells': [2, 8, 18, 18, 7], 'source': 'https://en.wikipedia.org/wiki/Iodine', 'spectral_img': None, 'summary': 'Iodine is a chemical element with symbol I and atomic number 53. The name is from Greek ἰοειδής ioeidēs, meaning violet or purple, due to the color of iodine vapor. Iodine and its compounds are primarily used in nutrition, and industrially in the production of acetic acid and certain polymers.', 'wxpos': 31, 'wypos': 5, 'xpos': 17, 'ypos': 5}), 'In': Element({'name': 'indium', 'symbol': 'In', 'atomic_number': 49, 'atomic_mass': 114.8181, 'appearance': 'silvery lustrous gray', 'block': 'p', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_049_indium/element_049_indium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_049_indium/element_049_indium_srp_th.png', 'boil': 2345, 'category': 'post-transition metal', 'cpk-hex': 'a67573', 'density': 7.31, 'discovered_by': 'Ferdinand Reich', 'electron_affinity': 37.043, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p1', 'electron_configuration_semantic': '[Kr] 4d10 5s2 5p1', 'electronegativity_pauling': 1.78, 'group': 13, 'image': {'attribution': 'Jurii, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: http://images-of-elements.com/indium.php', 'title': '1.5 x 1.5 cm liquid indium', 'url': 'https://images-of-elements.com/indium-2.jpg'}, 'ionization_energies': [558.3, 1820.7, 2704, 5210], 'melt': 429.7485, 'molar_heat': 26.74, 'named_by': None, 'number': 49, 'period': 5, 'phase': 'Solid', 'shells': [2, 8, 18, 18, 3], 'source': 'https://en.wikipedia.org/wiki/Indium', 'spectral_img': None, 'summary': "Indium is a chemical element with symbol In and atomic number 49. It is a post-transition metallic element that is rare in Earth's crust. The metal is very soft, malleable and easily fusible, with a melting point higher than sodium, but lower than lithium or tin.", 'wxpos': 27, 'wypos': 5, 'xpos': 13, 'ypos': 5}), 'Ir': Element({'name': 'iridium', 'symbol': 'Ir', 'atomic_number': 77, 'atomic_mass': 192.2173, 'appearance': 'silvery white', 'block': 'd', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_077_iridium/element_077_iridium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_077_iridium/element_077_iridium_srp_th.png', 'boil': 4403, 'category': 'transition metal', 'cpk-hex': '175487', 'density': 22.56, 'discovered_by': 'Smithson Tennant', 'electron_affinity': 150.94, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d7', 'electron_configuration_semantic': '[Xe] 4f14 5d7 6s2', 'electronegativity_pauling': 2.2, 'group': 9, 'image': {'attribution': 'Unknown authorUnknown author, CC BY 1.0 <https://creativecommons.org/licenses/by/1.0>, via Wikimedia Commons, source: https://images-of-elements.com/iridium.php', 'title': 'Pieces of Pure Iridium, 1 gram. Original size: 0.1 - 0.3 cm each', 'url': 'https://upload.wikimedia.org/wikipedia/commons/a/a8/Iridium-2.jpg'}, 'ionization_energies': [880, 1600], 'melt': 2719, 'molar_heat': 25.1, 'named_by': None, 'number': 77, 'period': 6, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 15, 2], 'source': 'https://en.wikipedia.org/wiki/Iridium', 'spectral_img': None, 'summary': 'Iridium is a chemical element with symbol Ir and atomic number 77. A very hard, brittle, silvery-white transition metal of the platinum group, iridium is generally credited with being the second densest element (after osmium) based on measured density, although calculations involving the space lattices of the elements show that iridium is denser. It is also the most corrosion-resistant metal, even at temperatures as high as 2000 °C. Although only certain molten salts and halogens are corrosive to solid iridium, finely divided iridium dust is much more reactive and can be flammable.', 'wxpos': 23, 'wypos': 6, 'xpos': 9, 'ypos': 6}), 'K': Element({'name': 'potassium', 'symbol': 'K', 'atomic_number': 19, 'atomic_mass': 39.09831, 'appearance': 'silvery gray', 'block': 's', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_019_potassium/element_019_potassium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_019_potassium/element_019_potassium_srp_th.png', 'boil': 1032, 'category': 'alkali metal', 'cpk-hex': '8f40d4', 'density': 0.862, 'discovered_by': 'Humphry Davy', 'electron_affinity': 48.383, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s1', 'electron_configuration_semantic': '[Ar] 4s1', 'electronegativity_pauling': 0.82, 'group': 1, 'image': {'attribution': 'Dnn87, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons', 'title': 'Potassium Pieces', 'url': 'https://upload.wikimedia.org/wikipedia/commons/b/b3/Potassium.JPG'}, 'ionization_energies': [418.8, 3052, 4420, 5877, 7975, 9590, 11343, 14944, 16963.7, 48610, 54490, 60730, 68950, 75900, 83080, 93400, 99710, 444880, 476063], 'melt': 336.7, 'molar_heat': 29.6, 'named_by': None, 'number': 19, 'period': 4, 'phase': 'Solid', 'shells': [2, 8, 8, 1], 'source': 'https://en.wikipedia.org/wiki/Potassium', 'spectral_img': 'https://en.wikipedia.org/wiki/File:Potassium_Spectrum.jpg', 'summary': 'Potassium is a chemical element with symbol K (derived from Neo-Latin, kalium) and atomic number 19. It was first isolated from potash, the ashes of plants, from which its name is derived. In the Periodic table, potassium is one of seven elements in column (group) 1 (alkali metals):they all have a single valence electron in their outer electron shell, which they readily give up to create an atom with a positive charge - a cation, and combine with anions to form salts.', 'wxpos': 1, 'wypos': 4, 'xpos': 1, 'ypos': 4}), 'Kr': Element({'name': 'krypton', 'symbol': 'Kr', 'atomic_number': 36, 'atomic_mass': 83.7982, 'appearance': 'colorless gas, exhibiting a whitish glow in a high electric field', 'block': 'p', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_036_krypton/element_036_krypton.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_036_krypton/element_036_krypton_srp_th.png', 'boil': 119.93, 'category': 'noble gas', 'cpk-hex': '5cb8d1', 'density': 3.749, 'discovered_by': 'William Ramsay', 'electron_affinity': -96, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6', 'electron_configuration_semantic': '[Ar] 3d10 4s2 4p6', 'electronegativity_pauling': 3, 'group': 18, 'image': {'attribution': 'Jurii, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/krypton.php', 'title': 'Vial of Glowing Ultrapure Krypton. Original size in cm: 1 x 5.', 'url': 'https://upload.wikimedia.org/wikipedia/commons/9/9c/Krypton-glow.jpg'}, 'ionization_energies': [1350.8, 2350.4, 3565, 5070, 6240, 7570, 10710, 12138, 22274, 25880, 29700, 33800, 37700, 43100, 47500, 52200, 57100, 61800, 75800, 80400, 85300, 90400, 96300, 101400, 111100, 116290, 282500, 296200, 311400, 326200], 'melt': 115.78, 'molar_heat': None, 'named_by': None, 'number': 36, 'period': 4, 'phase': 'Gas', 'shells': [2, 8, 18, 8], 'source': 'https://en.wikipedia.org/wiki/Krypton', 'spectral_img': 'https://en.wikipedia.org/wiki/File:Krypton_Spectrum.jpg', 'summary': 'Krypton (from Greek:κρυπτός kryptos "the hidden one") is a chemical element with symbol Kr and atomic number 36. It is a member of group 18 (noble gases) elements. A colorless, odorless, tasteless noble gas, krypton occurs in trace amounts in the atmosphere, is isolated by fractionally distilling liquefied air, and is often used with other rare gases in fluorescent lamps.', 'wxpos': 32, 'wypos': 4, 'xpos': 18, 'ypos': 4}), 'La': Element({'name': 'lanthanum', 'symbol': 'La', 'atomic_number': 57, 'atomic_mass': 138.905477, 'appearance': 'silvery white', 'block': 'f', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_057_lanthanum/element_057_lanthanum.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_057_lanthanum/element_057_lanthanum_srp_th.png', 'boil': 3737, 'category': 'lanthanide', 'cpk-hex': '70d4ff', 'density': 6.162, 'discovered_by': 'Carl Gustaf Mosander', 'electron_affinity': 53, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 5d1', 'electron_configuration_semantic': '[Xe] 5d16s2', 'electronegativity_pauling': 1.1, 'group': 3, 'image': {'attribution': 'Jurii, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/lanthanum.php', 'title': '1 cm Big Piece of Pure Lanthanum', 'url': 'https://upload.wikimedia.org/wikipedia/commons/f/f7/Lanthanum.jpg'}, 'ionization_energies': [538.1, 1067, 1850.3, 4819, 5940], 'melt': 1193, 'molar_heat': 27.11, 'named_by': None, 'number': 57, 'period': 6, 'phase': 'Solid', 'shells': [2, 8, 18, 18, 9, 2], 'source': 'https://en.wikipedia.org/wiki/Lanthanum', 'spectral_img': None, 'summary': 'Lanthanum is a soft, ductile, silvery-white metallic chemical element with symbol La and atomic number 57. It tarnishes rapidly when exposed to air and is soft enough to be cut with a knife. It gave its name to the lanthanide series, a group of 15 similar elements between lanthanum and lutetium in the periodic table:it is also sometimes considered the first element of the 6th-period transition metals.', 'wxpos': 3, 'wypos': 6, 'xpos': 3, 'ypos': 9}), 'Li': Element({'name': 'lithium', 'symbol': 'Li', 'atomic_number': 3, 'atomic_mass': 6.94, 'appearance': 'silvery-white', 'block': 's', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_003_lithium/element_003_lithium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_003_lithium/element_003_lithium_srp_th.png', 'boil': 1603, 'category': 'alkali metal', 'cpk-hex': 'cc80ff', 'density': 0.534, 'discovered_by': 'Johan August Arfwedson', 'electron_affinity': 59.6326, 'electron_configuration': '1s2 2s1', 'electron_configuration_semantic': '[He] 2s1', 'electronegativity_pauling': 0.98, 'group': 1, 'image': {'attribution': 'Hi-Res Images ofChemical Elements, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/lithium.php', 'title': '0.5 Grams Lithium under Argon. Original size of the largest piece in cm: 0.3 x 4', 'url': 'https://upload.wikimedia.org/wikipedia/commons/e/e2/0.5_grams_lithium_under_argon.jpg'}, 'ionization_energies': [520.2, 7298.1, 11815], 'melt': 453.65, 'molar_heat': 24.86, 'named_by': None, 'number': 3, 'period': 2, 'phase': 'Solid', 'shells': [2, 1], 'source': 'https://en.wikipedia.org/wiki/Lithium', 'spectral_img': None, 'summary': 'Lithium (from Greek:λίθος lithos, "stone") is a chemical element with the symbol Li and atomic number 3. It is a soft, silver-white metal belonging to the alkali metal group of chemical elements. Under standard conditions it is the lightest metal and the least dense solid element.', 'wxpos': 1, 'wypos': 2, 'xpos': 1, 'ypos': 2}), 'Lr': Element({'name': 'lawrencium', 'symbol': 'Lr', 'atomic_number': 103, 'atomic_mass': 266, 'appearance': None, 'block': 'd', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_103_lawrencium/element_103_lawrencium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_103_lawrencium/element_103_lawrencium_srp_th.png', 'boil': None, 'category': 'actinide', 'cpk-hex': 'c70066', 'density': None, 'discovered_by': 'Lawrence Berkeley National Laboratory', 'electron_affinity': -30.04, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d10 6p6 7s2 5f14 7p1', 'electron_configuration_semantic': '[Rn] 5f14 7s2 7p1', 'electronegativity_pauling': 1.3, 'group': 3, 'image': {'attribution': 'Chemical Elements A Virtual Museum under a Creative Commons Attribution 3.0 Unported License, source: https://images-of-elements.com/lawrencium.php', 'title': 'This is only an illustration, not lawrencium itself. Lawrencium can only be made in very small amounts and emits strong radiation', 'url': 'https://images-of-elements.com/lawrencium.jpg'}, 'ionization_energies': [470], 'melt': 1900, 'molar_heat': None, 'named_by': None, 'number': 103, 'period': 7, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 32, 8, 3], 'source': 'https://en.wikipedia.org/wiki/Lawrencium', 'spectral_img': None, 'summary': 'Lawrencium is a synthetic chemical element with chemical symbol Lr (formerly Lw) and atomic number 103. It is named in honor of Ernest Lawrence, inventor of the cyclotron, a device that was used to discover many artificial radioactive elements. A radioactive metal, lawrencium is the eleventh transuranic element and is also the final member of the actinide series.', 'wxpos': 17, 'wypos': 7, 'xpos': 17, 'ypos': 10}), 'Lu': Element({'name': 'lutetium', 'symbol': 'Lu', 'atomic_number': 71, 'atomic_mass': 174.96681, 'appearance': 'silvery white', 'block': 'd', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_071_lutetium/element_071_lutetium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_071_lutetium/element_071_lutetium_srp_th.png', 'boil': 3675, 'category': 'lanthanide', 'cpk-hex': '00ab24', 'density': 9.841, 'discovered_by': 'Georges Urbain', 'electron_affinity': 33.4, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d1', 'electron_configuration_semantic': '[Xe] 4f14 5d1 6s2', 'electronegativity_pauling': 1.27, 'group': 3, 'image': {'attribution': 'Jurii, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/lutetium.php', 'title': '1 cm Big Piece of Pure Lutetium', 'url': 'https://upload.wikimedia.org/wikipedia/commons/e/e8/Lutetium.jpg'}, 'ionization_energies': [523.5, 1340, 2022.3, 4370, 6445], 'melt': 1925, 'molar_heat': 26.86, 'named_by': None, 'number': 71, 'period': 6, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 9, 2], 'source': 'https://en.wikipedia.org/wiki/Lutetium', 'spectral_img': None, 'summary': 'Lutetium is a chemical element with symbol Lu and atomic number 71. It is a silvery white metal, which resists corrosion in dry, but not in moist air. It is considered the first element of the 6th-period transition metals and the last element in the lanthanide series, and is traditionally counted among the rare earths.', 'wxpos': 17, 'wypos': 6, 'xpos': 17, 'ypos': 9}), 'Lv': Element({'name': 'livermorium', 'symbol': 'Lv', 'atomic_number': 116, 'atomic_mass': 293, 'appearance': None, 'block': 'p', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_116_livermorium/element_116_livermorium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_116_livermorium/element_116_livermorium_srp_th.png', 'boil': 1085, 'category': 'unknown, probably post-transition metal', 'cpk-hex': None, 'density': 12.9, 'discovered_by': 'Joint Institute for Nuclear Research', 'electron_affinity': 74.9, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d10 6p6 7s2 5f14 6d10 7p4', 'electron_configuration_semantic': '*[Rn] 5f14 6d10 7s2 7p4', 'electronegativity_pauling': None, 'group': 16, 'image': {'attribution': 'Chemical Elements A Virtual Museum under a Creative Commons Attribution 3.0 Unported License, source: https://images-of-elements.com/livermorium.php', 'title': 'No Image Found', 'url': 'https://images-of-elements.com/s/transactinoid.png'}, 'ionization_energies': [], 'melt': 709, 'molar_heat': None, 'named_by': None, 'number': 116, 'period': 7, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 32, 18, 6], 'source': 'https://en.wikipedia.org/wiki/Livermorium', 'spectral_img': None, 'summary': 'Livermorium is a synthetic superheavy element with symbol Lv and atomic number 116. It is an extremely radioactive element that has only been created in the laboratory and has not been observed in nature. The element is named after the Lawrence Livermore National Laboratory in the United States, which collaborated with the Joint Institute for Nuclear Research in Dubna, Russia to discover livermorium in 2000.', 'wxpos': 30, 'wypos': 7, 'xpos': 16, 'ypos': 7}), 'Mc': Element({'name': 'moscovium', 'symbol': 'Mc', 'atomic_number': 115, 'atomic_mass': 289, 'appearance': None, 'block': 'p', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_115_moscovium/element_115_moscovium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_115_moscovium/element_115_moscovium_srp_th.png', 'boil': 1400, 'category': 'unknown, probably post-transition metal', 'cpk-hex': None, 'density': 13.5, 'discovered_by': 'Joint Institute for Nuclear Research', 'electron_affinity': 35.3, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d10 6p6 7s2 5f14 6d10 7p3', 'electron_configuration_semantic': '*[Rn] 5f14 6d10 7s2 7p3', 'electronegativity_pauling': None, 'group': 15, 'image': {'attribution': 'Chemical Elements A Virtual Museum under a Creative Commons Attribution 3.0 Unported License, source: https://images-of-elements.com/moscovium.php', 'title': 'No Image Found', 'url': 'https://images-of-elements.com/s/transactinoid.png'}, 'ionization_energies': [], 'melt': 670, 'molar_heat': None, 'named_by': None, 'number': 115, 'period': 7, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 32, 18, 5], 'source': 'https://en.wikipedia.org/wiki/Ununpentium', 'spectral_img': None, 'summary': 'Moscovium is the name of a synthetic superheavy element in the periodic table that has the symbol Mc and has the atomic number 115. It is an extremely radioactive element; its most stable known isotope, moscovium-289, has a half-life of only 220 milliseconds. It is also known as eka-bismuth or simply element 115.', 'wxpos': 29, 'wypos': 7, 'xpos': 15, 'ypos': 7}), 'Md': Element({'name': 'mendelevium', 'symbol': 'Md', 'atomic_number': 101, 'atomic_mass': 258, 'appearance': None, 'block': 'f', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_101_mendelevium/element_101_mendelevium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_101_mendelevium/element_101_mendelevium_srp_th.png', 'boil': None, 'category': 'actinide', 'cpk-hex': 'b30da6', 'density': None, 'discovered_by': 'Lawrence Berkeley National Laboratory', 'electron_affinity': 93.91, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d10 6p6 7s2 5f13', 'electron_configuration_semantic': '[Rn] 5f13 7s2', 'electronegativity_pauling': 1.3, 'group': 3, 'image': {'attribution': 'Chemical Elements A Virtual Museum under a Creative Commons Attribution 3.0 Unported License, source: https://images-of-elements.com/mendelevium.php', 'title': 'This is only an illustration, not mendelevium itself. Chemically similar to Thulium, the highly radioactive heavy metal emits very energetic α-radiation.', 'url': 'https://images-of-elements.com/s/mendelevium.jpg'}, 'ionization_energies': [635], 'melt': 1100, 'molar_heat': None, 'named_by': None, 'number': 101, 'period': 7, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 31, 8, 2], 'source': 'https://en.wikipedia.org/wiki/Mendelevium', 'spectral_img': None, 'summary': 'Mendelevium is a synthetic element with chemical symbol Md (formerly Mv) and atomic number 101. A metallic radioactive transuranic element in the actinide series, it is the first element that currently cannot be produced in macroscopic quantities through neutron bombardment of lighter elements. It is the antepenultimate actinide and the ninth transuranic element.', 'wxpos': 15, 'wypos': 7, 'xpos': 15, 'ypos': 10}), 'Mg': Element({'name': 'magnesium', 'symbol': 'Mg', 'atomic_number': 12, 'atomic_mass': 24.305, 'appearance': 'shiny grey solid', 'block': 's', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_012_magnesium/element_012_magnesium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_012_magnesium/element_012_magnesium_srp_th.png', 'boil': 1363, 'category': 'alkaline earth metal', 'cpk-hex': '8aff00', 'density': 1.738, 'discovered_by': 'Joseph Black', 'electron_affinity': -40, 'electron_configuration': '1s2 2s2 2p6 3s2', 'electron_configuration_semantic': '[Ne] 3s2', 'electronegativity_pauling': 1.31, 'group': 2, 'image': {'attribution': 'Warut Roonguthai, CC BY-SA 3.0 <https://creativecommons.org/licenses/by-sa/3.0>, via Wikimedia Commons', 'title': 'Magnesium crystals', 'url': 'https://upload.wikimedia.org/wikipedia/commons/3/3f/Magnesium_crystals.jpg'}, 'ionization_energies': [737.7, 1450.7, 7732.7, 10542.5, 13630, 18020, 21711, 25661, 31653, 35458, 169988, 189368], 'melt': 923, 'molar_heat': 24.869, 'named_by': None, 'number': 12, 'period': 3, 'phase': 'Solid', 'shells': [2, 8, 2], 'source': 'https://en.wikipedia.org/wiki/Magnesium', 'spectral_img': 'https://en.wikipedia.org/wiki/File:Magnesium_Spectra.jpg', 'summary': 'Magnesium is a chemical element with symbol Mg and atomic number 12. It is a shiny gray solid which bears a close physical resemblance to the other five elements in the second column (Group 2, or alkaline earth metals) of the periodic table:they each have the same electron configuration in their outer electron shell producing a similar crystal structure. Magnesium is the ninth most abundant element in the universe.', 'wxpos': 2, 'wypos': 3, 'xpos': 2, 'ypos': 3}), 'Mn': Element({'name': 'manganese', 'symbol': 'Mn', 'atomic_number': 25, 'atomic_mass': 54.9380443, 'appearance': 'silvery metallic', 'block': 'd', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_025_manganese/element_025_manganese.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_025_manganese/element_025_manganese_srp_th.png', 'boil': 2334, 'category': 'transition metal', 'cpk-hex': '9c7ac7', 'density': 7.21, 'discovered_by': 'Torbern Olof Bergman', 'electron_affinity': -50, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d5', 'electron_configuration_semantic': '[Ar] 3d5 4s2', 'electronegativity_pauling': 1.55, 'group': 7, 'image': {'attribution': 'W. Oelen, CC BY-SA 3.0 <https://creativecommons.org/licenses/by-sa/3.0>, via Wikimedia Commons', 'title': 'Two Oieces of Manganese Metal', 'url': 'https://upload.wikimedia.org/wikipedia/commons/6/64/Manganese_element.jpg'}, 'ionization_energies': [717.3, 1509, 3248, 4940, 6990, 9220, 11500, 18770, 21400, 23960, 27590, 30330, 33150, 38880, 41987, 109480, 118100, 127100, 138600, 148500, 158600, 172500, 181380, 785450, 827067], 'melt': 1519, 'molar_heat': 26.32, 'named_by': None, 'number': 25, 'period': 4, 'phase': 'Solid', 'shells': [2, 8, 13, 2], 'source': 'https://en.wikipedia.org/wiki/Manganese', 'spectral_img': None, 'summary': 'Manganese is a chemical element with symbol Mn and atomic number 25. It is not found as a free element in nature; it is often found in combination with iron, and in many minerals. Manganese is a metal with important industrial metal alloy uses, particularly in stainless steels.', 'wxpos': 21, 'wypos': 4, 'xpos': 7, 'ypos': 4}), 'Mo': Element({'name': 'molybdenum', 'symbol': 'Mo', 'atomic_number': 42, 'atomic_mass': 95.951, 'appearance': 'gray metallic', 'block': 'd', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_042_molybdenum/element_042_molybdenum.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_042_molybdenum/element_042_molybdenum_srp_th.png', 'boil': 4912, 'category': 'transition metal', 'cpk-hex': '54b5b5', 'density': 10.28, 'discovered_by': 'Carl Wilhelm Scheele', 'electron_affinity': 72.1, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s1 4d5', 'electron_configuration_semantic': '[Kr] 4d5 5s1', 'electronegativity_pauling': 2.16, 'group': 6, 'image': {'attribution': 'Jurii, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/molybdenum.php', 'title': '99.9 Pure Molybdenum Crystal, about 2 x 3 cm, with anodisation color', 'url': 'https://upload.wikimedia.org/wikipedia/commons/f/f0/Molybdenum.jpg'}, 'ionization_energies': [684.3, 1560, 2618, 4480, 5257, 6640.8, 12125, 13860, 15835, 17980, 20190, 22219, 26930, 29196, 52490, 55000, 61400, 67700, 74000, 80400, 87000, 93400, 98420, 104400, 121900, 127700, 133800, 139800, 148100, 154500], 'melt': 2896, 'molar_heat': 24.06, 'named_by': None, 'number': 42, 'period': 5, 'phase': 'Solid', 'shells': [2, 8, 18, 13, 1], 'source': 'https://en.wikipedia.org/wiki/Molybdenum', 'spectral_img': None, 'summary': 'Molybdenum is a chemical element with symbol Mo and atomic number 42. The name is from Neo-Latin molybdaenum, from Ancient Greek Μόλυβδος molybdos, meaning lead, since its ores were confused with lead ores. Molybdenum minerals have been known throughout history, but the element was discovered (in the sense of differentiating it as a new entity from the mineral salts of other metals) in 1778 by Carl Wilhelm Scheele.', 'wxpos': 20, 'wypos': 5, 'xpos': 6, 'ypos': 5}), 'Mt': Element({'name': 'meitnerium', 'symbol': 'Mt', 'atomic_number': 109, 'atomic_mass': 278, 'appearance': None, 'block': 'd', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_109_meitnerium/element_109_meitnerium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_109_meitnerium/element_109_meitnerium_srp_th.png', 'boil': None, 'category': 'unknown, probably transition metal', 'cpk-hex': 'eb0026', 'density': 37.4, 'discovered_by': 'Gesellschaft für Schwerionenforschung', 'electron_affinity': None, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d10 6p6 7s2 5f14 6d7', 'electron_configuration_semantic': '*[Rn] 5f14 6d7 7s2', 'electronegativity_pauling': None, 'group': 9, 'image': {'attribution': 'Chemical Elements A Virtual Museum under a Creative Commons Attribution 3.0 Unported License, source: https://images-of-elements.com/meitnerium.php', 'title': 'No Image Found', 'url': 'https://images-of-elements.com/s/transactinoid.png'}, 'ionization_energies': [], 'melt': None, 'molar_heat': None, 'named_by': None, 'number': 109, 'period': 7, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 32, 15, 2], 'source': 'https://en.wikipedia.org/wiki/Meitnerium', 'spectral_img': None, 'summary': 'Meitnerium is a chemical element with symbol Mt and atomic number 109. It is an extremely radioactive synthetic element (an element not found in nature that can be created in a laboratory). The most stable known isotope, meitnerium-278, has a half-life of 7.6 seconds.', 'wxpos': 23, 'wypos': 7, 'xpos': 9, 'ypos': 7}), 'N': Element({'name': 'nitrogen', 'symbol': 'N', 'atomic_number': 7, 'atomic_mass': 14.007, 'appearance': 'colorless gas, liquid or solid', 'block': 'p', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_007_nitrogen/element_007_nitrogen.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_007_nitrogen/element_007_nitrogen_srp_th.png', 'boil': 77.355, 'category': 'diatomic nonmetal', 'cpk-hex': '3050f8', 'density': 1.251, 'discovered_by': 'Daniel Rutherford', 'electron_affinity': -6.8, 'electron_configuration': '1s2 2s2 2p3', 'electron_configuration_semantic': '[He] 2s2 2p3', 'electronegativity_pauling': 3.04, 'group': 15, 'image': {'attribution': 'Jurii, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/nitrogen.php', 'title': 'Vial of Glowing Ultrapure Nitrogen, N2. Original size in cm: 1 x 5', 'url': 'https://upload.wikimedia.org/wikipedia/commons/2/2d/Nitrogen-glow.jpg'}, 'ionization_energies': [1402.3, 2856, 4578.1, 7475, 9444.9, 53266.6, 64360], 'melt': 63.15, 'molar_heat': None, 'named_by': 'Jean-Antoine Chaptal', 'number': 7, 'period': 2, 'phase': 'Gas', 'shells': [2, 5], 'source': 'https://en.wikipedia.org/wiki/Nitrogen', 'spectral_img': 'https://en.wikipedia.org/wiki/File:Nitrogen_Spectra.jpg', 'summary': 'Nitrogen is a chemical element with symbol N and atomic number 7. It is the lightest pnictogen and at room temperature, it is a transparent, odorless diatomic gas. Nitrogen is a common element in the universe, estimated at about seventh in total abundance in the Milky Way and the Solar System.', 'wxpos': 29, 'wypos': 2, 'xpos': 15, 'ypos': 2}), 'Na': Element({'name': 'sodium', 'symbol': 'Na', 'atomic_number': 11, 'atomic_mass': 22.989769282, 'appearance': 'silvery white metallic', 'block': 's', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_011_sodium/element_011_sodium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_011_sodium/element_011_sodium_srp_th.png', 'boil': 1156.09, 'category': 'alkali metal', 'cpk-hex': 'ab5cf2', 'density': 0.968, 'discovered_by': 'Humphry Davy', 'electron_affinity': 52.867, 'electron_configuration': '1s2 2s2 2p6 3s1', 'electron_configuration_semantic': '[Ne] 3s1', 'electronegativity_pauling': 0.93, 'group': 1, 'image': {'attribution': 'The original uploader was Dnn87 at English Wikipedia., CC BY-SA 3.0 <https://creativecommons.org/licenses/by-sa/3.0>, via Wikimedia Commons', 'title': 'Na (Sodium) Metal', 'url': 'https://upload.wikimedia.org/wikipedia/commons/2/27/Na_%28Sodium%29.jpg'}, 'ionization_energies': [495.8, 4562, 6910.3, 9543, 13354, 16613, 20117, 25496, 28932, 141362, 159076], 'melt': 370.944, 'molar_heat': 28.23, 'named_by': None, 'number': 11, 'period': 3, 'phase': 'Solid', 'shells': [2, 8, 1], 'source': 'https://en.wikipedia.org/wiki/Sodium', 'spectral_img': 'https://en.wikipedia.org/wiki/File:Sodium_Spectra.jpg', 'summary': 'Sodium /ˈsoʊdiəm/ is a chemical element with symbol Na (from Ancient Greek Νάτριο) and atomic number 11. It is a soft, silver-white, highly reactive metal. In the Periodic table it is in column 1 (alkali metals), and shares with the other six elements in that column that it has a single electron in its outer shell, which it readily donates, creating a positively charged atom - a cation.', 'wxpos': 1, 'wypos': 3, 'xpos': 1, 'ypos': 3}), 'Nb': Element({'name': 'niobium', 'symbol': 'Nb', 'atomic_number': 41, 'atomic_mass': 92.906372, 'appearance': 'gray metallic, bluish when oxidized', 'block': 'd', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_041_niobium/element_041_niobium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_041_niobium/element_041_niobium_srp_th.png', 'boil': 5017, 'category': 'transition metal', 'cpk-hex': '73c2c9', 'density': 8.57, 'discovered_by': 'Charles Hatchett', 'electron_affinity': 88.516, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s1 4d4', 'electron_configuration_semantic': '[Kr] 4d4 5s1', 'electronegativity_pauling': 1.6, 'group': 5, 'image': {'attribution': 'Mauro Cateb, CC BY-SA 3.0 <https://creativecommons.org/licenses/by-sa/3.0>, via Wikimedia Commons', 'title': 'Niobium strips', 'url': 'https://upload.wikimedia.org/wikipedia/commons/c/c2/Niobium_strips.JPG'}, 'ionization_energies': [652.1, 1380, 2416, 3700, 4877, 9847, 12100], 'melt': 2750, 'molar_heat': 24.6, 'named_by': None, 'number': 41, 'period': 5, 'phase': 'Solid', 'shells': [2, 8, 18, 12, 1], 'source': 'https://en.wikipedia.org/wiki/Niobium', 'spectral_img': None, 'summary': 'Niobium, formerly columbium, is a chemical element with symbol Nb (formerly Cb) and atomic number 41. It is a soft, grey, ductile transition metal, which is often found in the pyrochlore mineral, the main commercial source for niobium, and columbite. The name comes from Greek mythology:Niobe, daughter of Tantalus since it is so similar to tantalum.', 'wxpos': 19, 'wypos': 5, 'xpos': 5, 'ypos': 5}), 'Nd': Element({'name': 'neodymium', 'symbol': 'Nd', 'atomic_number': 60, 'atomic_mass': 144.2423, 'appearance': 'silvery white', 'block': 'f', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_060_neodymium/element_060_neodymium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_060_neodymium/element_060_neodymium_srp_th.png', 'boil': 3347, 'category': 'lanthanide', 'cpk-hex': 'c7ffc7', 'density': 7.01, 'discovered_by': 'Carl Auer von Welsbach', 'electron_affinity': 184.87, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f4', 'electron_configuration_semantic': '[Xe] 4f4 6s2', 'electronegativity_pauling': 1.14, 'group': 3, 'image': {'attribution': 'Hi-Res Images ofChemical Elements, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/neodymium.php', 'title': 'Ultrapure Neodymium under Argon, 5 grams. Original length of the large piece in cm: 1', 'url': 'https://upload.wikimedia.org/wikipedia/commons/c/c9/Neodymium_%2860_Nd%29.jpg'}, 'ionization_energies': [533.1, 1040, 2130, 3900], 'melt': 1297, 'molar_heat': 27.45, 'named_by': None, 'number': 60, 'period': 6, 'phase': 'Solid', 'shells': [2, 8, 18, 22, 8, 2], 'source': 'https://en.wikipedia.org/wiki/Neodymium', 'spectral_img': None, 'summary': 'Neodymium is a chemical element with symbol Nd and atomic number 60. It is a soft silvery metal that tarnishes in air. Neodymium was discovered in 1885 by the Austrian chemist Carl Auer von Welsbach.', 'wxpos': 6, 'wypos': 6, 'xpos': 6, 'ypos': 9}), 'Ne': Element({'name': 'neon', 'symbol': 'Ne', 'atomic_number': 10, 'atomic_mass': 20.17976, 'appearance': 'colorless gas exhibiting an orange-red glow when placed in a high voltage electric field', 'block': 'p', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_010_neon/element_010_neon.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_010_neon/element_010_neon_srp_th.png', 'boil': 27.104, 'category': 'noble gas', 'cpk-hex': 'b3e3f5', 'density': 0.9002, 'discovered_by': 'Morris Travers', 'electron_affinity': -116, 'electron_configuration': '1s2 2s2 2p6', 'electron_configuration_semantic': '[He] 2s2 2p6', 'electronegativity_pauling': None, 'group': 18, 'image': {'attribution': 'Jurii, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/neon.php', 'title': 'Vial of Glowing Ultrapure neon. Original size in cm: 1 x 5', 'url': 'https://upload.wikimedia.org/wikipedia/commons/f/f8/Neon-glow.jpg'}, 'ionization_energies': [2080.7, 3952.3, 6122, 9371, 12177, 15238, 19999, 23069.5, 115379.5, 131432], 'melt': 24.56, 'molar_heat': None, 'named_by': None, 'number': 10, 'period': 2, 'phase': 'Gas', 'shells': [2, 8], 'source': 'https://en.wikipedia.org/wiki/Neon', 'spectral_img': 'https://en.wikipedia.org/wiki/File:Neon_spectra.jpg', 'summary': 'Neon is a chemical element with symbol Ne and atomic number 10. It is in group 18 (noble gases) of the periodic table. Neon is a colorless, odorless, inert monatomic gas under standard conditions, with about two-thirds the density of air.', 'wxpos': 32, 'wypos': 2, 'xpos': 18, 'ypos': 2}), 'Nh': Element({'name': 'nihonium', 'symbol': 'Nh', 'atomic_number': 113, 'atomic_mass': 286, 'appearance': None, 'block': 'p', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_113_nihonium/element_113_nihonium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_113_nihonium/element_113_nihonium_srp_th.png', 'boil': 1430, 'category': 'unknown, probably transition metal', 'cpk-hex': None, 'density': 16, 'discovered_by': 'RIKEN', 'electron_affinity': 66.6, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d10 6p6 7s2 5f14 6d10 7p1', 'electron_configuration_semantic': '*[Rn] 5f14 6d10 7s2 7p1', 'electronegativity_pauling': None, 'group': 13, 'image': {'attribution': 'Chemical Elements A Virtual Museum under a Creative Commons Attribution 3.0 Unported License, source: https://images-of-elements.com/nihonium.php', 'title': 'No Image Found', 'url': 'https://images-of-elements.com/s/transactinoid.png'}, 'ionization_energies': [], 'melt': 700, 'molar_heat': None, 'named_by': None, 'number': 113, 'period': 7, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 32, 18, 3], 'source': 'https://en.wikipedia.org/wiki/Ununtrium', 'spectral_img': None, 'summary': 'Nihonium is a chemical element with atomic number 113. It has a symbol Nh. It is a synthetic element (an element that can be created in a laboratory but is not found in nature) and is extremely radioactive; its most stable known isotope, nihonium-286, has a half-life of 20 seconds.', 'wxpos': 27, 'wypos': 7, 'xpos': 13, 'ypos': 7}), 'Ni': Element({'name': 'nickel', 'symbol': 'Ni', 'atomic_number': 28, 'atomic_mass': 58.69344, 'appearance': 'lustrous, metallic, and silver with a gold tinge', 'block': 'd', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_028_nickel/element_028_nickel.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_028_nickel/element_028_nickel_srp_th.png', 'boil': 3003, 'category': 'transition metal', 'cpk-hex': '50d050', 'density': 8.908, 'discovered_by': 'Axel Fredrik Cronstedt', 'electron_affinity': 111.65, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d8', 'electron_configuration_semantic': '[Ar] 3d8 4s2', 'electronegativity_pauling': 1.91, 'group': 10, 'image': {'attribution': 'Materialscientist at English Wikipedia, CC BY-SA 3.0 <https://creativecommons.org/licenses/by-sa/3.0>, via Wikimedia Commons', 'title': 'Nickel Chunk', 'url': 'https://upload.wikimedia.org/wikipedia/commons/5/57/Nickel_chunk.jpg'}, 'ionization_energies': [737.1, 1753, 3395, 5300, 7339, 10400, 12800, 15600, 18600, 21670, 30970, 34000, 37100, 41500, 44800, 48100, 55101, 58570, 148700, 159000, 169400, 182700, 194000, 205600, 221400, 231490, 992718, 1039668], 'melt': 1728, 'molar_heat': 26.07, 'named_by': None, 'number': 28, 'period': 4, 'phase': 'Solid', 'shells': [2, 8, 16, 2], 'source': 'https://en.wikipedia.org/wiki/Nickel', 'spectral_img': None, 'summary': 'Nickel is a chemical element with symbol Ni and atomic number 28. It is a silvery-white lustrous metal with a slight golden tinge. Nickel belongs to the transition metals and is hard and ductile.', 'wxpos': 24, 'wypos': 4, 'xpos': 10, 'ypos': 4}), 'No': Element({'name': 'nobelium', 'symbol': 'No', 'atomic_number': 102, 'atomic_mass': 259, 'appearance': None, 'block': 'f', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_102_nobelium/element_102_nobelium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_102_nobelium/element_102_nobelium_srp_th.png', 'boil': None, 'category': 'actinide', 'cpk-hex': 'bd0d87', 'density': None, 'discovered_by': 'Joint Institute for Nuclear Research', 'electron_affinity': -223.22, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d10 6p6 7s2 5f14', 'electron_configuration_semantic': '[Rn] 5f14 7s2', 'electronegativity_pauling': 1.3, 'group': 3, 'image': {'attribution': 'Chemical Elements A Virtual Museum under a Creative Commons Attribution 3.0 Unported License, source: https://images-of-elements.com/nobelium.php', 'title': 'This is only an illustration, not nobelium itself. Nobelium can only be made in very small amounts and emits strong radiation of various kinds.', 'url': 'https://images-of-elements.com/nobelium.jpg'}, 'ionization_energies': [642], 'melt': 1100, 'molar_heat': None, 'named_by': None, 'number': 102, 'period': 7, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 32, 8, 2], 'source': 'https://en.wikipedia.org/wiki/Nobelium', 'spectral_img': None, 'summary': 'Nobelium is a synthetic chemical element with symbol No and atomic number 102. It is named in honor of Alfred Nobel, the inventor of dynamite and benefactor of science. A radioactive metal, it is the tenth transuranic element and is the penultimate member of the actinide series.', 'wxpos': 16, 'wypos': 7, 'xpos': 16, 'ypos': 10}), 'Np': Element({'name': 'neptunium', 'symbol': 'Np', 'atomic_number': 93, 'atomic_mass': 237, 'appearance': 'silvery metallic', 'block': 'f', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_093_neptunium/element_093_neptunium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_093_neptunium/element_093_neptunium_srp_th.png', 'boil': 4447, 'category': 'actinide', 'cpk-hex': '0080ff', 'density': 20.45, 'discovered_by': 'Edwin McMillan', 'electron_affinity': 45.85, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d10 6p6 7s2 5f4 6d1', 'electron_configuration_semantic': '[Rn] 5f4 6d1 7s2', 'electronegativity_pauling': 1.36, 'group': 3, 'image': {'attribution': 'Los Alamos National Laboratory,, Public domain, via Wikimedia Commons', 'title': 'Neptunium 237 sphere (6 kg)', 'url': 'https://upload.wikimedia.org/wikipedia/commons/e/e5/Neptunium2.jpg'}, 'ionization_energies': [604.5], 'melt': 912, 'molar_heat': 29.46, 'named_by': None, 'number': 93, 'period': 7, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 22, 9, 2], 'source': 'https://en.wikipedia.org/wiki/Neptunium', 'spectral_img': None, 'summary': 'Neptunium is a chemical element with symbol Np and atomic number 93. A radioactive actinide metal, neptunium is the first transuranic element. Its position in the periodic table just after uranium, named after the planet Uranus, led to it being named after Neptune, the next planet beyond Uranus.', 'wxpos': 7, 'wypos': 7, 'xpos': 7, 'ypos': 10}), 'O': Element({'name': 'oxygen', 'symbol': 'O', 'atomic_number': 8, 'atomic_mass': 15.999, 'appearance': None, 'block': 'p', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_008_oxygen/element_008_oxygen.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_008_oxygen/element_008_oxygen_srp_th.png', 'boil': 90.188, 'category': 'diatomic nonmetal', 'cpk-hex': 'ff0d0d', 'density': 1.429, 'discovered_by': 'Carl Wilhelm Scheele', 'electron_affinity': 140.976, 'electron_configuration': '1s2 2s2 2p4', 'electron_configuration_semantic': '[He] 2s2 2p4', 'electronegativity_pauling': 3.44, 'group': 16, 'image': {'attribution': 'Staff Sgt. Nika Glover, U.S. Air Force, Public domain, via Wikimedia Commons', 'title': 'Liquid Oxygen in a Beaker', 'url': 'https://upload.wikimedia.org/wikipedia/commons/a/a0/Liquid_oxygen_in_a_beaker_%28cropped_and_retouched%29.jpg'}, 'ionization_energies': [1313.9, 3388.3, 5300.5, 7469.2, 10989.5, 13326.5, 71330, 84078], 'melt': 54.36, 'molar_heat': None, 'named_by': 'Antoine Lavoisier', 'number': 8, 'period': 2, 'phase': 'Gas', 'shells': [2, 6], 'source': 'https://en.wikipedia.org/wiki/Oxygen', 'spectral_img': 'https://en.wikipedia.org/wiki/File:Oxygen_spectre.jpg', 'summary': 'Oxygen is a chemical element with symbol O and atomic number 8. It is a member of the chalcogen group on the periodic table and is a highly reactive nonmetal and oxidizing agent that readily forms compounds (notably oxides) with most elements. By mass, oxygen is the third-most abundant element in the universe, after hydrogen and helium.', 'wxpos': 30, 'wypos': 2, 'xpos': 16, 'ypos': 2}), 'Og': Element({'name': 'oganesson', 'symbol': 'Og', 'atomic_number': 118, 'atomic_mass': 294, 'appearance': None, 'block': 'p', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_118_oganesson/element_118_oganesson.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_118_oganesson/element_118_oganesson_srp_th.png', 'boil': 350, 'category': 'unknown, predicted to be noble gas', 'cpk-hex': None, 'density': 4.95, 'discovered_by': 'Joint Institute for Nuclear Research', 'electron_affinity': 5.40318, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d10 6p6 7s2 5f14 6d10 7p6', 'electron_configuration_semantic': '*[Rn] 5f14 6d10 7s2 7p6', 'electronegativity_pauling': None, 'group': 18, 'image': {'attribution': 'Chemical Elements A Virtual Museum under a Creative Commons Attribution 3.0 Unported License, source: https://images-of-elements.com/oganesson.php', 'title': 'No Image Found', 'url': 'https://images-of-elements.com/s/transactinoid.png'}, 'ionization_energies': [], 'melt': None, 'molar_heat': None, 'named_by': None, 'number': 118, 'period': 7, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 32, 18, 8], 'source': 'https://en.wikipedia.org/wiki/Oganesson', 'spectral_img': None, 'summary': "Oganesson is IUPAC's name for the transactinide element with the atomic number 118 and element symbol Og. It is also known as eka-radon or element 118, and on the periodic table of the elements it is a p-block element and the last one of the 7th period. Oganesson is currently the only synthetic member of group 18.", 'wxpos': 32, 'wypos': 7, 'xpos': 18, 'ypos': 7}), 'Os': Element({'name': 'osmium', 'symbol': 'Os', 'atomic_number': 76, 'atomic_mass': 190.233, 'appearance': 'silvery, blue cast', 'block': 'd', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_076_osmium/element_076_osmium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_076_osmium/element_076_osmium_srp_th.png', 'boil': 5285, 'category': 'transition metal', 'cpk-hex': '266696', 'density': 22.59, 'discovered_by': 'Smithson Tennant', 'electron_affinity': 103.99, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d6', 'electron_configuration_semantic': '[Xe] 4f14 5d6 6s2', 'electronegativity_pauling': 2.2, 'group': 8, 'image': {'attribution': 'Jurii, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/osmium.php', 'title': 'Pure Osmium Bead', 'url': 'https://upload.wikimedia.org/wikipedia/commons/3/3c/Osmium-bead.jpg'}, 'ionization_energies': [840, 1600], 'melt': 3306, 'molar_heat': 24.7, 'named_by': None, 'number': 76, 'period': 6, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 14, 2], 'source': 'https://en.wikipedia.org/wiki/Osmium', 'spectral_img': None, 'summary': 'Osmium (from Greek osme (ὀσμή) meaning "smell") is a chemical element with symbol Os and atomic number 76. It is a hard, brittle, bluish-white transition metal in the platinum group that is found as a trace element in alloys, mostly in platinum ores. Osmium is the densest naturally occurring element, with a density of 22.59 g/cm3.', 'wxpos': 22, 'wypos': 6, 'xpos': 8, 'ypos': 6}), 'P': Element({'name': 'phosphorus', 'symbol': 'P', 'atomic_number': 15, 'atomic_mass': 30.9737619985, 'appearance': 'colourless, waxy white, yellow, scarlet, red, violet, black', 'block': 'p', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_015_phosphorus/element_015_phosphorus.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_015_phosphorus/element_015_phosphorus_srp_th.png', 'boil': None, 'category': 'polyatomic nonmetal', 'cpk-hex': 'ff8000', 'density': 1.823, 'discovered_by': 'Hennig Brand', 'electron_affinity': 72.037, 'electron_configuration': '1s2 2s2 2p6 3s2 3p3', 'electron_configuration_semantic': '[Ne] 3s2 3p3', 'electronegativity_pauling': 2.19, 'group': 15, 'image': {'attribution': 'Jurii, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/phosphorus.php', 'title': 'Purple Phosphorus', 'url': 'https://upload.wikimedia.org/wikipedia/commons/6/6d/Phosphorus-purple.jpg'}, 'ionization_energies': [1011.8, 1907, 2914.1, 4963.6, 6273.9, 21267, 25431, 29872, 35905, 40950, 46261, 54110, 59024, 271791, 296195], 'melt': None, 'molar_heat': 23.824, 'named_by': None, 'number': 15, 'period': 3, 'phase': 'Solid', 'shells': [2, 8, 5], 'source': 'https://en.wikipedia.org/wiki/Phosphorus', 'spectral_img': None, 'summary': 'Phosphorus is a chemical element with symbol P and atomic number 15. As an element, phosphorus exists in two major forms—white phosphorus and red phosphorus—but due to its high reactivity, phosphorus is never found as a free element on Earth. Instead phosphorus-containing minerals are almost always present in their maximally oxidised state, as inorganic phosphate rocks.', 'wxpos': 29, 'wypos': 3, 'xpos': 15, 'ypos': 3}), 'Pa': Element({'name': 'protactinium', 'symbol': 'Pa', 'atomic_number': 91, 'atomic_mass': 231.035882, 'appearance': 'bright, silvery metallic luster', 'block': 'f', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_091_protactinium/element_091_protactinium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_091_protactinium/element_091_protactinium_srp_th.png', 'boil': 4300, 'category': 'actinide', 'cpk-hex': '00a1ff', 'density': 15.37, 'discovered_by': 'William Crookes', 'electron_affinity': 53.03, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d10 6p6 7s2 5f2 6d1', 'electron_configuration_semantic': '[Rn] 5f2 6d1 7s2', 'electronegativity_pauling': 1.5, 'group': 3, 'image': {'attribution': 'ENERGY.GOV, Public domain, via Wikimedia Commons', 'title': 'This sample of Protactinium-233 (dark circular area in the photo) was photographed in the light from its own radioactive emission (the lighter area) at the National Reactor Testing Station in Idaho.', 'url': 'https://upload.wikimedia.org/wikipedia/commons/a/af/Protactinium-233.jpg'}, 'ionization_energies': [568], 'melt': 1841, 'molar_heat': None, 'named_by': 'Otto Hahn', 'number': 91, 'period': 7, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 20, 9, 2], 'source': 'https://en.wikipedia.org/wiki/Protactinium', 'spectral_img': None, 'summary': 'Protactinium is a chemical element with symbol Pa and atomic number 91. It is a dense, silvery-gray metal which readily reacts with oxygen, water vapor and inorganic acids. It forms various chemical compounds where protactinium is usually present in the oxidation state +5, but can also assume +4 and even +2 or +3 states.', 'wxpos': 5, 'wypos': 7, 'xpos': 5, 'ypos': 10}), 'Pb': Element({'name': 'lead', 'symbol': 'Pb', 'atomic_number': 82, 'atomic_mass': 207.21, 'appearance': 'metallic gray', 'block': 'p', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_082_lead/element_082_lead.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_082_lead/element_082_lead_srp_th.png', 'boil': 2022, 'category': 'post-transition metal', 'cpk-hex': '575961', 'density': 11.34, 'discovered_by': 'Middle East', 'electron_affinity': 34.4204, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d10 6p2', 'electron_configuration_semantic': '[Xe] 4f14 5d10 6s2 6p2', 'electronegativity_pauling': 1.87, 'group': 14, 'image': {'attribution': 'Chemical Elements, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/lead.php', 'title': 'Ultrapure Lead Bead from two sides. Original size in cm: 1.5 x 2', 'url': 'https://upload.wikimedia.org/wikipedia/commons/6/63/Lead-2.jpg'}, 'ionization_energies': [715.6, 1450.5, 3081.5, 4083, 6640], 'melt': 600.61, 'molar_heat': 26.65, 'named_by': None, 'number': 82, 'period': 6, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 18, 4], 'source': 'https://en.wikipedia.org/wiki/Lead_(element)', 'spectral_img': None, 'summary': 'Lead (/lɛd/) is a chemical element in the carbon group with symbol Pb (from Latin:plumbum) and atomic number 82. Lead is a soft, malleable and heavy post-transition metal. Metallic lead has a bluish-white color after being freshly cut, but it soon tarnishes to a dull grayish color when exposed to air.', 'wxpos': 28, 'wypos': 6, 'xpos': 14, 'ypos': 6}), 'Pd': Element({'name': 'palladium', 'symbol': 'Pd', 'atomic_number': 46, 'atomic_mass': 106.421, 'appearance': 'silvery white', 'block': 'd', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_046_palladium/element_046_palladium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_046_palladium/element_046_palladium_srp_th.png', 'boil': 3236, 'category': 'transition metal', 'cpk-hex': '006985', 'density': 12.023, 'discovered_by': 'William Hyde Wollaston', 'electron_affinity': 54.24, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 4d10', 'electron_configuration_semantic': '[Kr] 4d10', 'electronegativity_pauling': 2.2, 'group': 10, 'image': {'attribution': 'Hi-Res Images ofChemical Elements, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/palladium.php', 'title': 'Palladium Crystal, about 1 gram. Original size in cm: 0.5 x 1', 'url': 'https://upload.wikimedia.org/wikipedia/commons/d/d7/Palladium_%2846_Pd%29.jpg'}, 'ionization_energies': [804.4, 1870, 3177], 'melt': 1828.05, 'molar_heat': 25.98, 'named_by': None, 'number': 46, 'period': 5, 'phase': 'Solid', 'shells': [2, 8, 18, 18], 'source': 'https://en.wikipedia.org/wiki/Palladium', 'spectral_img': None, 'summary': 'Palladium is a chemical element with symbol Pd and atomic number 46. It is a rare and lustrous silvery-white metal discovered in 1803 by William Hyde Wollaston. He named it after the asteroid Pallas, which was itself named after the epithet of the Greek goddess Athena, acquired by her when she slew Pallas.', 'wxpos': 24, 'wypos': 5, 'xpos': 10, 'ypos': 5}), 'Pm': Element({'name': 'promethium', 'symbol': 'Pm', 'atomic_number': 61, 'atomic_mass': 145, 'appearance': 'metallic', 'block': 'f', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_061_promethium/element_061_promethium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_061_promethium/element_061_promethium_srp_th.png', 'boil': 3273, 'category': 'lanthanide', 'cpk-hex': 'a3ffc7', 'density': 7.26, 'discovered_by': 'Chien Shiung Wu', 'electron_affinity': 12.45, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f5', 'electron_configuration_semantic': '[Xe] 4f5 6s2', 'electronegativity_pauling': 1.13, 'group': 3, 'image': {'attribution': 'Unknown authorUnknown author, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/promethium.php', 'title': 'Photomontage of what promethium metal might look like (it is too radioactive and real images are not available)', 'url': 'https://upload.wikimedia.org/wikipedia/commons/5/5b/Promethium.jpg'}, 'ionization_energies': [540, 1050, 2150, 3970], 'melt': 1315, 'molar_heat': None, 'named_by': 'Isotopes of promethium', 'number': 61, 'period': 6, 'phase': 'Solid', 'shells': [2, 8, 18, 23, 8, 2], 'source': 'https://en.wikipedia.org/wiki/Promethium', 'spectral_img': None, 'summary': 'Promethium, originally prometheum, is a chemical element with the symbol Pm and atomic number 61. All of its isotopes are radioactive; it is one of only two such elements that are followed in the periodic table by elements with stable forms, a distinction shared with technetium. Chemically, promethium is a lanthanide, which forms salts when combined with other elements.', 'wxpos': 7, 'wypos': 6, 'xpos': 7, 'ypos': 9}), 'Po': Element({'name': 'polonium', 'symbol': 'Po', 'atomic_number': 84, 'atomic_mass': 209, 'appearance': 'silvery', 'block': 'p', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_084_polonium/element_084_polonium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_084_polonium/element_084_polonium_srp_th.png', 'boil': 1235, 'category': 'post-transition metal', 'cpk-hex': 'ab5c00', 'density': 9.196, 'discovered_by': 'Pierre Curie', 'electron_affinity': 136, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d10 6p4', 'electron_configuration_semantic': '[Xe] 4f14 5d10 6s2 6p4', 'electronegativity_pauling': 2, 'group': 16, 'image': {'attribution': 'Chemical ELements A Virtual Museum, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0> source: https://images-of-elements.com/polonium.php', 'title': 'This is only an illustration, not polonium itself. A silvery, radioactive metal, producing so much heat that it gets liquid and ionizes the surrounding air', 'url': 'https://images-of-elements.com/polonium.jpg'}, 'ionization_energies': [812.1], 'melt': 527, 'molar_heat': 26.4, 'named_by': None, 'number': 84, 'period': 6, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 18, 6], 'source': 'https://en.wikipedia.org/wiki/Polonium', 'spectral_img': None, 'summary': 'Polonium is a chemical element with symbol Po and atomic number 84, discovered in 1898 by Marie Curie and Pierre Curie. A rare and highly radioactive element with no stable isotopes, polonium is chemically similar to bismuth and tellurium, and it occurs in uranium ores. Applications of polonium are few.', 'wxpos': 30, 'wypos': 6, 'xpos': 16, 'ypos': 6}), 'Pr': Element({'name': 'praseodymium', 'symbol': 'Pr', 'atomic_number': 59, 'atomic_mass': 140.907662, 'appearance': 'grayish white', 'block': 'f', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_059_praseodymium/element_059_praseodymium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_059_praseodymium/element_059_praseodymium_srp_th.png', 'boil': 3403, 'category': 'lanthanide', 'cpk-hex': 'd9ffc7', 'density': 6.77, 'discovered_by': 'Carl Auer von Welsbach', 'electron_affinity': 93, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f3', 'electron_configuration_semantic': '[Xe] 4f3 6s2', 'electronegativity_pauling': 1.13, 'group': 3, 'image': {'attribution': 'Jurii, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/praseodymium.php', 'title': '1.5 Grams Praseodymium under Argon, 0.5 cm big pieces', 'url': 'https://upload.wikimedia.org/wikipedia/commons/c/c7/Praseodymium.jpg'}, 'ionization_energies': [527, 1020, 2086, 3761, 5551], 'melt': 1208, 'molar_heat': 27.2, 'named_by': None, 'number': 59, 'period': 6, 'phase': 'Solid', 'shells': [2, 8, 18, 21, 8, 2], 'source': 'https://en.wikipedia.org/wiki/Praseodymium', 'spectral_img': None, 'summary': 'Praseodymium is a chemical element with symbol Pr and atomic number 59. Praseodymium is a soft, silvery, malleable and ductile metal in the lanthanide group. It is valued for its magnetic, electrical, chemical, and optical properties.', 'wxpos': 5, 'wypos': 6, 'xpos': 5, 'ypos': 9}), 'Pt': Element({'name': 'platinum', 'symbol': 'Pt', 'atomic_number': 78, 'atomic_mass': 195.0849, 'appearance': 'silvery white', 'block': 'd', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_078_platinum/element_078_platinum.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_078_platinum/element_078_platinum_srp_th.png', 'boil': 4098, 'category': 'transition metal', 'cpk-hex': 'd0d0e0', 'density': 21.45, 'discovered_by': 'Antonio de Ulloa', 'electron_affinity': 205.041, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s1 4f14 5d9', 'electron_configuration_semantic': '[Xe] 4f14 5d9 6s1', 'electronegativity_pauling': 2.28, 'group': 10, 'image': {'attribution': 'Periodictableru, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons', 'title': 'Crystals of Pure Platinum grown by gas phase transport', 'url': 'https://upload.wikimedia.org/wikipedia/commons/6/68/Platinum_crystals.jpg'}, 'ionization_energies': [870, 1791], 'melt': 2041.4, 'molar_heat': 25.86, 'named_by': None, 'number': 78, 'period': 6, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 17, 1], 'source': 'https://en.wikipedia.org/wiki/Platinum', 'spectral_img': None, 'summary': 'Platinum is a chemical element with symbol Pt and atomic number 78. It is a dense, malleable, ductile, highly unreactive, precious, gray-white transition metal. Its name is derived from the Spanish term platina, which is literally translated into "little silver".', 'wxpos': 24, 'wypos': 6, 'xpos': 10, 'ypos': 6}), 'Pu': Element({'name': 'plutonium', 'symbol': 'Pu', 'atomic_number': 94, 'atomic_mass': 244, 'appearance': 'silvery white, tarnishing to dark gray in air', 'block': 'f', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_094_plutonium/element_094_plutonium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_094_plutonium/element_094_plutonium_srp_th.png', 'boil': 3505, 'category': 'actinide', 'cpk-hex': '006bff', 'density': 19.816, 'discovered_by': 'Glenn T. Seaborg', 'electron_affinity': -48.33, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d10 6p6 7s2 5f6', 'electron_configuration_semantic': '[Rn] 5f6 7s2', 'electronegativity_pauling': 1.28, 'group': 3, 'image': {'attribution': 'Los Alamos National Laboratory, Attribution, via Wikimedia Commons', 'title': 'Plutonium Ring', 'url': 'https://upload.wikimedia.org/wikipedia/commons/0/0f/Plutonium_ring.jpg'}, 'ionization_energies': [584.7], 'melt': 912.5, 'molar_heat': 35.5, 'named_by': None, 'number': 94, 'period': 7, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 24, 8, 2], 'source': 'https://en.wikipedia.org/wiki/Plutonium', 'spectral_img': None, 'summary': 'Plutonium is a transuranic radioactive chemical element with symbol Pu and atomic number 94. It is an actinide metal of silvery-gray appearance that tarnishes when exposed to air, and forms a dull coating when oxidized. The element normally exhibits six allotropes and four oxidation states.', 'wxpos': 8, 'wypos': 7, 'xpos': 8, 'ypos': 10}), 'Ra': Element({'name': 'radium', 'symbol': 'Ra', 'atomic_number': 88, 'atomic_mass': 226, 'appearance': 'silvery white metallic', 'block': 's', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_088_radium/element_088_radium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_088_radium/element_088_radium_srp_th.png', 'boil': 2010, 'category': 'alkaline earth metal', 'cpk-hex': '007d00', 'density': 5.5, 'discovered_by': 'Pierre Curie', 'electron_affinity': 9.6485, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d10 6p6 7s2', 'electron_configuration_semantic': '[Rn] 7s2', 'electronegativity_pauling': 0.9, 'group': 2, 'image': {'attribution': 'grenadier, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons', 'title': 'Radium electroplated on a very small sample of copper foil and covered with polyurethane to prevent reaction with the air', 'url': 'https://upload.wikimedia.org/wikipedia/commons/b/bb/Radium226.jpg'}, 'ionization_energies': [509.3, 979], 'melt': 1233, 'molar_heat': None, 'named_by': None, 'number': 88, 'period': 7, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 18, 8, 2], 'source': 'https://en.wikipedia.org/wiki/Radium', 'spectral_img': None, 'summary': 'Radium is a chemical element with symbol Ra and atomic number 88. It is the sixth element in group 2 of the periodic table, also known as the alkaline earth metals. Pure radium is almost colorless, but it readily combines with nitrogen (rather than oxygen) on exposure to air, forming a black surface layer of radium nitride (Ra3N2).', 'wxpos': 2, 'wypos': 7, 'xpos': 2, 'ypos': 7}), 'Rb': Element({'name': 'rubidium', 'symbol': 'Rb', 'atomic_number': 37, 'atomic_mass': 85.46783, 'appearance': 'grey white', 'block': 's', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_037_rubidium/element_037_rubidium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_037_rubidium/element_037_rubidium_srp_th.png', 'boil': 961, 'category': 'alkali metal', 'cpk-hex': '702eb0', 'density': 1.532, 'discovered_by': 'Robert Bunsen', 'electron_affinity': 46.884, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s1', 'electron_configuration_semantic': '[Kr] 5s1', 'electronegativity_pauling': 0.82, 'group': 1, 'image': {'attribution': 'Dnn87, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons', 'title': 'Rubidium Metal Sample', 'url': 'https://upload.wikimedia.org/wikipedia/commons/c/c9/Rb5.JPG'}, 'ionization_energies': [403, 2633, 3860, 5080, 6850, 8140, 9570, 13120, 14500, 26740], 'melt': 312.45, 'molar_heat': 31.06, 'named_by': None, 'number': 37, 'period': 5, 'phase': 'Solid', 'shells': [2, 8, 18, 8, 1], 'source': 'https://en.wikipedia.org/wiki/Rubidium', 'spectral_img': None, 'summary': 'Rubidium is a chemical element with symbol Rb and atomic number 37. Rubidium is a soft, silvery-white metallic element of the alkali metal group, with an atomic mass of 85.4678. Elemental rubidium is highly reactive, with properties similar to those of other alkali metals, such as very rapid oxidation in air.', 'wxpos': 1, 'wypos': 5, 'xpos': 1, 'ypos': 5}), 'Re': Element({'name': 'rhenium', 'symbol': 'Re', 'atomic_number': 75, 'atomic_mass': 186.2071, 'appearance': 'silvery-grayish', 'block': 'd', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_075_rhenium/element_075_rhenium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_075_rhenium/element_075_rhenium_srp_th.png', 'boil': 5869, 'category': 'transition metal', 'cpk-hex': '267dab', 'density': 21.02, 'discovered_by': 'Masataka Ogawa', 'electron_affinity': 5.8273, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d5', 'electron_configuration_semantic': '[Xe] 4f14 5d5 6s2', 'electronegativity_pauling': 1.9, 'group': 7, 'image': {'attribution': 'Hi-Res Images ofChemical Elements, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/rhenium.php', 'title': 'Pure Rhenium Bead, arc melted, 21 grams. Original size in cm: 1.5 x 1.7. Measured radiation dose <0.05 μS/h.', 'url': 'https://upload.wikimedia.org/wikipedia/commons/d/d9/Pure_rhenium_bead%2C_arc_melted%2C_21_grams._Original_size_in_cm_-_1.5_x_1.7.jpg'}, 'ionization_energies': [760, 1260, 2510, 3640], 'melt': 3459, 'molar_heat': 25.48, 'named_by': 'Walter Noddack', 'number': 75, 'period': 6, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 13, 2], 'source': 'https://en.wikipedia.org/wiki/Rhenium', 'spectral_img': None, 'summary': "Rhenium is a chemical element with symbol Re and atomic number 75. It is a silvery-white, heavy, third-row transition metal in group 7 of the periodic table. With an estimated average concentration of 1 part per billion (ppb), rhenium is one of the rarest elements in the Earth's crust.", 'wxpos': 21, 'wypos': 6, 'xpos': 7, 'ypos': 6}), 'Rf': Element({'name': 'rutherfordium', 'symbol': 'Rf', 'atomic_number': 104, 'atomic_mass': 267, 'appearance': None, 'block': 'd', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_104_rutherfordium/element_104_rutherfordium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_104_rutherfordium/element_104_rutherfordium_srp_th.png', 'boil': 5800, 'category': 'transition metal', 'cpk-hex': 'cc0059', 'density': 23.2, 'discovered_by': 'Joint Institute for Nuclear Research', 'electron_affinity': None, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d10 6p6 7s2 5f14 6d2', 'electron_configuration_semantic': '[Rn] 5f14 6d2 7s2', 'electronegativity_pauling': None, 'group': 4, 'image': {'attribution': 'Image © CERN, Chemical Elements A Virtual Museum under a Creative Commons Attribution 3.0 Unported License, source: https://images-of-elements.com/rutherfordium.php', 'title': 'Decay traces in a spark chamber, not of rutherfordium, but of a pion. This is a completely different, unrelated particle, but the decay of rutherfordium would make streaks there, too.', 'url': 'https://images-of-elements.com/s/rutherfordium.jpg'}, 'ionization_energies': [580], 'melt': 2400, 'molar_heat': None, 'named_by': None, 'number': 104, 'period': 7, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 32, 10, 2], 'source': 'https://en.wikipedia.org/wiki/Rutherfordium', 'spectral_img': None, 'summary': 'Rutherfordium is a chemical element with symbol Rf and atomic number 104, named in honor of physicist Ernest Rutherford. It is a synthetic element (an element that can be created in a laboratory but is not found in nature) and radioactive; the most stable known isotope, 267Rf, has a half-life of approximately 1.3 hours. In the periodic table of the elements, it is a d - block element and the second of the fourth - row transition elements.', 'wxpos': 18, 'wypos': 7, 'xpos': 4, 'ypos': 7}), 'Rg': Element({'name': 'roentgenium', 'symbol': 'Rg', 'atomic_number': 111, 'atomic_mass': 282, 'appearance': None, 'block': 'd', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_111_roentgenium/element_111_roentgenium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_111_roentgenium/element_111_roentgenium_srp_th.png', 'boil': None, 'category': 'unknown, probably transition metal', 'cpk-hex': None, 'density': 28.7, 'discovered_by': 'Gesellschaft für Schwerionenforschung', 'electron_affinity': 151, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d10 6p6 7s2 5f14 6d9', 'electron_configuration_semantic': '*[Rn] 5f14 6d10 7s1', 'electronegativity_pauling': None, 'group': 11, 'image': {'attribution': 'Chemical Elements A Virtual Museum under a Creative Commons Attribution 3.0 Unported License, source: https://images-of-elements.com/roentgenium.php', 'title': 'No Image Found', 'url': 'https://images-of-elements.com/s/transactinoid.png'}, 'ionization_energies': [], 'melt': None, 'molar_heat': None, 'named_by': None, 'number': 111, 'period': 7, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 32, 17, 2], 'source': 'https://en.wikipedia.org/wiki/Roentgenium', 'spectral_img': None, 'summary': 'Roentgenium is a chemical element with symbol Rg and atomic number 111. It is an extremely radioactive synthetic element (an element that can be created in a laboratory but is not found in nature); the most stable known isotope, roentgenium-282, has a half-life of 2.1 minutes. Roentgenium was first created in 1994 by the GSI Helmholtz Centre for Heavy Ion Research near Darmstadt, Germany.', 'wxpos': 25, 'wypos': 7, 'xpos': 11, 'ypos': 7}), 'Rh': Element({'name': 'rhodium', 'symbol': 'Rh', 'atomic_number': 45, 'atomic_mass': 102.905502, 'appearance': 'silvery white metallic', 'block': 'd', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_045_rhodium/element_045_rhodium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_045_rhodium/element_045_rhodium_srp_th.png', 'boil': 3968, 'category': 'transition metal', 'cpk-hex': '0a7d8c', 'density': 12.41, 'discovered_by': 'William Hyde Wollaston', 'electron_affinity': 110.27, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s1 4d8', 'electron_configuration_semantic': '[Kr] 4d8 5s1', 'electronegativity_pauling': 2.28, 'group': 9, 'image': {'attribution': 'Hi-Res Images ofChemical Elements, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/rhodium.php', 'title': 'Pure Rhodium Bead, 1 gram. Original size in cm: 0.5', 'url': 'https://upload.wikimedia.org/wikipedia/commons/5/54/Rhodium_%28Rh%29.jpg'}, 'ionization_energies': [719.7, 1740, 2997], 'melt': 2237, 'molar_heat': 24.98, 'named_by': None, 'number': 45, 'period': 5, 'phase': 'Solid', 'shells': [2, 8, 18, 16, 1], 'source': 'https://en.wikipedia.org/wiki/Rhodium', 'spectral_img': None, 'summary': 'Rhodium is a chemical element with symbol Rh and atomic number 45. It is a rare, silvery-white, hard, and chemically inert transition metal. It is a member of the platinum group.', 'wxpos': 23, 'wypos': 5, 'xpos': 9, 'ypos': 5}), 'Rn': Element({'name': 'radon', 'symbol': 'Rn', 'atomic_number': 86, 'atomic_mass': 222, 'appearance': 'colorless gas, occasionally glows green or red in discharge tubes', 'block': 'p', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_086_radon/element_086_radon.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_086_radon/element_086_radon_srp_th.png', 'boil': 211.5, 'category': 'noble gas', 'cpk-hex': '428296', 'density': 9.73, 'discovered_by': 'Friedrich Ernst Dorn', 'electron_affinity': -68, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d10 6p6', 'electron_configuration_semantic': '[Xe] 4f14 5d10 6s2 6p6', 'electronegativity_pauling': 2.2, 'group': 18, 'image': {'attribution': 'Chemical ELements A Virtual Museum, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0> source: https://images-of-elements.com/radon.php', 'title': 'This is only an illustration, not radon itself. Radon is said to glow red in discharge tubes, although it practically is never used for this, due to its strong radioactivity.', 'url': 'https://images-of-elements.com/radon.jpg'}, 'ionization_energies': [1037], 'melt': 202, 'molar_heat': None, 'named_by': None, 'number': 86, 'period': 6, 'phase': 'Gas', 'shells': [2, 8, 18, 32, 18, 8], 'source': 'https://en.wikipedia.org/wiki/Radon', 'spectral_img': 'https://en.wikipedia.org/wiki/File:Radon_spectrum.png', 'summary': 'Radon is a chemical element with symbol Rn and atomic number 86. It is a radioactive, colorless, odorless, tasteless noble gas, occurring naturally as a decay product of radium. Its most stable isotope, 222Rn, has a half-life of 3.8 days.', 'wxpos': 32, 'wypos': 6, 'xpos': 18, 'ypos': 6}), 'Ru': Element({'name': 'ruthenium', 'symbol': 'Ru', 'atomic_number': 44, 'atomic_mass': 101.072, 'appearance': 'silvery white metallic', 'block': 'd', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_044_ruthenium/element_044_ruthenium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_044_ruthenium/element_044_ruthenium_srp_th.png', 'boil': 4423, 'category': 'transition metal', 'cpk-hex': '248f8f', 'density': 12.45, 'discovered_by': 'Karl Ernst Claus', 'electron_affinity': 100.96, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s1 4d7', 'electron_configuration_semantic': '[Kr] 4d7 5s1', 'electronegativity_pauling': 2.2, 'group': 8, 'image': {'attribution': 'Hi-Res Images ofChemical Elements, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/ruthenium.php', 'title': 'Ruthenium Crystal, 0.6 grams, 0.6 x 1.3 cm size', 'url': 'https://upload.wikimedia.org/wikipedia/commons/a/a8/Ruthenium_crystal.jpg'}, 'ionization_energies': [710.2, 1620, 2747], 'melt': 2607, 'molar_heat': 24.06, 'named_by': None, 'number': 44, 'period': 5, 'phase': 'Solid', 'shells': [2, 8, 18, 15, 1], 'source': 'https://en.wikipedia.org/wiki/Ruthenium', 'spectral_img': None, 'summary': 'Ruthenium is a chemical element with symbol Ru and atomic number 44. It is a rare transition metal belonging to the platinum group of the periodic table. Like the other metals of the platinum group, ruthenium is inert to most other chemicals.', 'wxpos': 22, 'wypos': 5, 'xpos': 8, 'ypos': 5}), 'S': Element({'name': 'sulfur', 'symbol': 'S', 'atomic_number': 16, 'atomic_mass': 32.06, 'appearance': 'lemon yellow sintered microcrystals', 'block': 'p', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_016_sulfur/element_016_sulfur.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_016_sulfur/element_016_sulfur_srp_th.png', 'boil': 717.8, 'category': 'polyatomic nonmetal', 'cpk-hex': 'ffff30', 'density': 2.07, 'discovered_by': 'Ancient china', 'electron_affinity': 200.4101, 'electron_configuration': '1s2 2s2 2p6 3s2 3p4', 'electron_configuration_semantic': '[Ne] 3s2 3p4', 'electronegativity_pauling': 2.58, 'group': 16, 'image': {'attribution': 'James St. John, CC BY 2.0 <https://creativecommons.org/licenses/by/2.0>, via Wikimedia Commons', 'title': 'Native Sulfur From Russia', 'url': 'https://upload.wikimedia.org/wikipedia/commons/2/23/Native_sulfur_%28Vodinskoe_Deposit%3B_quarry_near_Samara%2C_Russia%29_9.jpg'}, 'ionization_energies': [999.6, 2252, 3357, 4556, 7004.3, 8495.8, 27107, 31719, 36621, 43177, 48710, 54460, 62930, 68216, 311048, 337138], 'melt': 388.36, 'molar_heat': 22.75, 'named_by': None, 'number': 16, 'period': 3, 'phase': 'Solid', 'shells': [2, 8, 6], 'source': 'https://en.wikipedia.org/wiki/Sulfur', 'spectral_img': 'https://en.wikipedia.org/wiki/File:Sulfur_Spectrum.jpg', 'summary': 'Sulfur or sulphur (see spelling differences) is a chemical element with symbol S and atomic number 16. It is an abundant, multivalent non-metal. Under normal conditions, sulfur atoms form cyclic octatomic molecules with chemical formula S8.', 'wxpos': 30, 'wypos': 3, 'xpos': 16, 'ypos': 3}), 'Sb': Element({'name': 'antimony', 'symbol': 'Sb', 'atomic_number': 51, 'atomic_mass': 121.7601, 'appearance': 'silvery lustrous gray', 'block': 'p', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_051_antimony/element_051_antimony.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_051_antimony/element_051_antimony_srp_th.png', 'boil': 1908, 'category': 'metalloid', 'cpk-hex': '9e63b5', 'density': 6.697, 'discovered_by': 'unknown, before 3000 BC', 'electron_affinity': 101.059, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p3', 'electron_configuration_semantic': '[Kr] 4d10 5s2 5p3', 'electronegativity_pauling': 2.05, 'group': 15, 'image': {'attribution': 'Unknown authorUnknown author, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/antimony.php', 'title': 'Antimony crystal, 2 grams, 1 cm', 'url': 'https://upload.wikimedia.org/wikipedia/commons/5/5c/Antimony-4.jpg'}, 'ionization_energies': [834, 1594.9, 2440, 4260, 5400, 10400], 'melt': 903.78, 'molar_heat': 25.23, 'named_by': None, 'number': 51, 'period': 5, 'phase': 'Solid', 'shells': [2, 8, 18, 18, 5], 'source': 'https://en.wikipedia.org/wiki/Antimony', 'spectral_img': None, 'summary': 'Antimony is a chemical element with symbol Sb (from Latin:stibium) and atomic number 51. A lustrous gray metalloid, it is found in nature mainly as the sulfide mineral stibnite (Sb2S3). Antimony compounds have been known since ancient times and were used for cosmetics; metallic antimony was also known, but it was erroneously identified as lead upon its discovery.', 'wxpos': 29, 'wypos': 5, 'xpos': 15, 'ypos': 5}), 'Sc': Element({'name': 'scandium', 'symbol': 'Sc', 'atomic_number': 21, 'atomic_mass': 44.9559085, 'appearance': 'silvery white', 'block': 'd', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_021_scandium/element_021_scandium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_021_scandium/element_021_scandium_srp_th.png', 'boil': 3109, 'category': 'transition metal', 'cpk-hex': 'e6e6e6', 'density': 2.985, 'discovered_by': 'Lars Fredrik Nilson', 'electron_affinity': 18, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d1', 'electron_configuration_semantic': '[Ar] 3d1 4s2', 'electronegativity_pauling': 1.36, 'group': 3, 'image': {'attribution': 'JanDerChemiker, CC BY-SA 3.0 <https://creativecommons.org/licenses/by-sa/3.0>, via Wikimedia Commons', 'title': 'Crystal of Scandium. About 1g', 'url': 'https://upload.wikimedia.org/wikipedia/commons/f/f5/Scandium%2C_Sc.jpg'}, 'ionization_energies': [633.1, 1235, 2388.6, 7090.6, 8843, 10679, 13310, 15250, 17370, 21726, 24102, 66320, 73010, 80160, 89490, 97400, 105600, 117000, 124270, 547530, 582163], 'melt': 1814, 'molar_heat': 25.52, 'named_by': None, 'number': 21, 'period': 4, 'phase': 'Solid', 'shells': [2, 8, 9, 2], 'source': 'https://en.wikipedia.org/wiki/Scandium', 'spectral_img': None, 'summary': 'Scandium is a chemical element with symbol Sc and atomic number 21. A silvery-white metallic d-block element, it has historically been sometimes classified as a rare earth element, together with yttrium and the lanthanoids. It was discovered in 1879 by spectral analysis of the minerals euxenite and gadolinite from Scandinavia.', 'wxpos': 17, 'wypos': 4, 'xpos': 3, 'ypos': 4}), 'Se': Element({'name': 'selenium', 'symbol': 'Se', 'atomic_number': 34, 'atomic_mass': 78.9718, 'appearance': 'black, red, and gray (not pictured) allotropes', 'block': 'p', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_034_selenium/element_034_selenium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_034_selenium/element_034_selenium_srp_th.png', 'boil': 958, 'category': 'polyatomic nonmetal', 'cpk-hex': 'ffa100', 'density': 4.81, 'discovered_by': 'Jöns Jakob Berzelius', 'electron_affinity': 194.9587, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p4', 'electron_configuration_semantic': '[Ar] 3d10 4s2 4p4', 'electronegativity_pauling': 2.55, 'group': 16, 'image': {'attribution': 'Hi-Res Images ofChemical Elements, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/selenium.php', 'title': 'Ultrapure Black, Amorphous Selenium, 3 - 4 grams. Original size in cm: 2', 'url': 'https://upload.wikimedia.org/wikipedia/commons/7/7f/Selenium.jpg'}, 'ionization_energies': [941, 2045, 2973.7, 4144, 6590, 7880, 14990], 'melt': 494, 'molar_heat': 25.363, 'named_by': None, 'number': 34, 'period': 4, 'phase': 'Solid', 'shells': [2, 8, 18, 6], 'source': 'https://en.wikipedia.org/wiki/Selenium', 'spectral_img': None, 'summary': 'Selenium is a chemical element with symbol Se and atomic number 34. It is a nonmetal with properties that are intermediate between those of its periodic table column-adjacent chalcogen elements sulfur and tellurium. It rarely occurs in its elemental state in nature, or as pure ore compounds.', 'wxpos': 30, 'wypos': 4, 'xpos': 16, 'ypos': 4}), 'Sg': Element({'name': 'seaborgium', 'symbol': 'Sg', 'atomic_number': 106, 'atomic_mass': 269, 'appearance': None, 'block': 'd', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_106_seaborgium/element_106_seaborgium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_106_seaborgium/element_106_seaborgium_srp_th.png', 'boil': None, 'category': 'transition metal', 'cpk-hex': 'd90045', 'density': 35, 'discovered_by': 'Lawrence Berkeley National Laboratory', 'electron_affinity': None, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d10 6p6 7s2 5f14 6d4', 'electron_configuration_semantic': '*[Rn] 5f14 6d4 7s2', 'electronegativity_pauling': None, 'group': 6, 'image': {'attribution': 'Chemical Elements A Virtual Museum under a Creative Commons Attribution 3.0 Unported License, source: https://images-of-elements.com/seaborgium.php', 'title': 'No Image Found', 'url': 'https://images-of-elements.com/s/transactinoid.png'}, 'ionization_energies': [], 'melt': None, 'molar_heat': None, 'named_by': None, 'number': 106, 'period': 7, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 32, 12, 2], 'source': 'https://en.wikipedia.org/wiki/Seaborgium', 'spectral_img': None, 'summary': 'Seaborgium is a synthetic element with symbol Sg and atomic number 106. Its most stable isotope 271Sg has a half-life of 1.9 minutes. A more recently discovered isotope 269Sg has a potentially slightly longer half-life (ca.', 'wxpos': 20, 'wypos': 7, 'xpos': 6, 'ypos': 7}), 'Si': Element({'name': 'silicon', 'symbol': 'Si', 'atomic_number': 14, 'atomic_mass': 28.085, 'appearance': 'crystalline, reflective with bluish-tinged faces', 'block': 'p', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_014_silicon/element_014_silicon.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_014_silicon/element_014_silicon_srp_th.png', 'boil': 3538, 'category': 'metalloid', 'cpk-hex': 'f0c8a0', 'density': 2.329, 'discovered_by': 'Jöns Jacob Berzelius', 'electron_affinity': 134.0684, 'electron_configuration': '1s2 2s2 2p6 3s2 3p2', 'electron_configuration_semantic': '[Ne] 3s2 3p2', 'electronegativity_pauling': 1.9, 'group': 14, 'image': {'attribution': 'Jurii, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/silicon.php', 'title': 'Chunk of Ultrapure Silicon, 2 x 2 cm', 'url': 'https://upload.wikimedia.org/wikipedia/commons/2/2c/Silicon.jpg'}, 'ionization_energies': [786.5, 1577.1, 3231.6, 4355.5, 16091, 19805, 23780, 29287, 33878, 38726, 45962, 50502, 235196, 257923], 'melt': 1687, 'molar_heat': 19.789, 'named_by': 'Thomas Thomson (chemist)', 'number': 14, 'period': 3, 'phase': 'Solid', 'shells': [2, 8, 4], 'source': 'https://en.wikipedia.org/wiki/Silicon', 'spectral_img': 'https://en.wikipedia.org/wiki/File:Silicon_Spectra.jpg', 'summary': "Silicon is a chemical element with symbol Si and atomic number 14. It is a tetravalent metalloid, more reactive than germanium, the metalloid directly below it in the table. Controversy about silicon's character dates to its discovery.", 'wxpos': 28, 'wypos': 3, 'xpos': 14, 'ypos': 3}), 'Sm': Element({'name': 'samarium', 'symbol': 'Sm', 'atomic_number': 62, 'atomic_mass': 150.362, 'appearance': 'silvery white', 'block': 'f', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_062_samarium/element_062_samarium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_062_samarium/element_062_samarium_srp_th.png', 'boil': 2173, 'category': 'lanthanide', 'cpk-hex': '8fffc7', 'density': 7.52, 'discovered_by': 'Lecoq de Boisbaudran', 'electron_affinity': 15.63, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f6', 'electron_configuration_semantic': '[Xe] 4f6 6s2', 'electronegativity_pauling': 1.17, 'group': 3, 'image': {'attribution': 'Unknown authorUnknown author, CC BY 1.0 <https://creativecommons.org/licenses/by/1.0>, via Wikimedia Commons, source: https://images-of-elements.com/samarium.php', 'title': 'Ultrapure Sublimated Samarium, 2 grams. Original size in cm: 0.8 x 1.5', 'url': 'https://upload.wikimedia.org/wikipedia/commons/8/88/Samarium-2.jpg'}, 'ionization_energies': [544.5, 1070, 2260, 3990], 'melt': 1345, 'molar_heat': 29.54, 'named_by': None, 'number': 62, 'period': 6, 'phase': 'Solid', 'shells': [2, 8, 18, 24, 8, 2], 'source': 'https://en.wikipedia.org/wiki/Samarium', 'spectral_img': None, 'summary': 'Samarium is a chemical element with symbol Sm and atomic number 62. It is a moderately hard silvery metal that readily oxidizes in air. Being a typical member of the lanthanide series, samarium usually assumes the oxidation state +3.', 'wxpos': 8, 'wypos': 6, 'xpos': 8, 'ypos': 9}), 'Sn': Element({'name': 'tin', 'symbol': 'Sn', 'atomic_number': 50, 'atomic_mass': 118.7107, 'appearance': 'silvery-white (beta, β) or gray (alpha, α)', 'block': 'p', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_050_tin/element_050_tin.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_050_tin/element_050_tin_srp_th.png', 'boil': 2875, 'category': 'post-transition metal', 'cpk-hex': '668080', 'density': 7.365, 'discovered_by': 'unknown, before 3500 BC', 'electron_affinity': 107.2984, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p2', 'electron_configuration_semantic': '[Kr] 4d10 5s2 5p2', 'electronegativity_pauling': 1.96, 'group': 14, 'image': {'attribution': 'Jurii, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: http://images-of-elements.com/tin.php', 'title': 'Tin blob', 'url': 'https://upload.wikimedia.org/wikipedia/commons/6/6a/Tin-2.jpg'}, 'ionization_energies': [708.6, 1411.8, 2943, 3930.3, 7456], 'melt': 505.08, 'molar_heat': 27.112, 'named_by': None, 'number': 50, 'period': 5, 'phase': 'Solid', 'shells': [2, 8, 18, 18, 4], 'source': 'https://en.wikipedia.org/wiki/Tin', 'spectral_img': None, 'summary': 'Tin is a chemical element with the symbol Sn (for Latin:stannum) and atomic number 50. It is a main group metal in group 14 of the periodic table. Tin shows a chemical similarity to both neighboring group-14 elements, germanium and lead, and has two possible oxidation states, +2 and the slightly more stable +4.', 'wxpos': 28, 'wypos': 5, 'xpos': 14, 'ypos': 5}), 'Sr': Element({'name': 'strontium', 'symbol': 'Sr', 'atomic_number': 38, 'atomic_mass': 87.621, 'appearance': None, 'block': 's', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_038_strontium/element_038_strontium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_038_strontium/element_038_strontium_srp_th.png', 'boil': 1650, 'category': 'alkaline earth metal', 'cpk-hex': '00ff00', 'density': 2.64, 'discovered_by': 'William Cruickshank (chemist)', 'electron_affinity': 5.023, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2', 'electron_configuration_semantic': '[Kr] 5s2', 'electronegativity_pauling': 0.95, 'group': 2, 'image': {'attribution': 'Jurii, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/strontium.php', 'title': 'Strontium Pieces under Paraffin Oil.', 'url': 'https://upload.wikimedia.org/wikipedia/commons/8/84/Strontium-1.jpg'}, 'ionization_energies': [549.5, 1064.2, 4138, 5500, 6910, 8760, 10230, 11800, 15600, 17100, 31270], 'melt': 1050, 'molar_heat': 26.4, 'named_by': None, 'number': 38, 'period': 5, 'phase': 'Solid', 'shells': [2, 8, 18, 8, 2], 'source': 'https://en.wikipedia.org/wiki/Strontium', 'spectral_img': None, 'summary': 'Strontium is a chemical element with symbol Sr and atomic number 38. An alkaline earth metal, strontium is a soft silver-white or yellowish metallic element that is highly reactive chemically. The metal turns yellow when it is exposed to air.', 'wxpos': 2, 'wypos': 5, 'xpos': 2, 'ypos': 5}), 'Ta': Element({'name': 'tantalum', 'symbol': 'Ta', 'atomic_number': 73, 'atomic_mass': 180.947882, 'appearance': 'gray blue', 'block': 'd', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_073_tantalum/element_073_tantalum.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_073_tantalum/element_073_tantalum_srp_th.png', 'boil': 5731, 'category': 'transition metal', 'cpk-hex': '4da6ff', 'density': 16.69, 'discovered_by': 'Anders Gustaf Ekeberg', 'electron_affinity': 31, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d3', 'electron_configuration_semantic': '[Xe] 4f14 5d3 6s2', 'electronegativity_pauling': 1.5, 'group': 5, 'image': {'attribution': 'Jurii, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/tantalum.php', 'title': 'Piece of tantalum, 1 cm in size', 'url': 'https://upload.wikimedia.org/wikipedia/commons/6/61/Tantalum.jpg'}, 'ionization_energies': [761, 1500], 'melt': 3290, 'molar_heat': 25.36, 'named_by': None, 'number': 73, 'period': 6, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 11, 2], 'source': 'https://en.wikipedia.org/wiki/Tantalum', 'spectral_img': 'https://en.wikipedia.org/wiki/File:Tantalum_spectrum_visible.png', 'summary': 'Tantalum is a chemical element with symbol Ta and atomic number 73. Previously known as tantalium, its name comes from Tantalus, an antihero from Greek mythology. Tantalum is a rare, hard, blue-gray, lustrous transition metal that is highly corrosion-resistant.', 'wxpos': 19, 'wypos': 6, 'xpos': 5, 'ypos': 6}), 'Tb': Element({'name': 'terbium', 'symbol': 'Tb', 'atomic_number': 65, 'atomic_mass': 158.925352, 'appearance': 'silvery white', 'block': 'f', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_065_terbium/element_065_terbium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_065_terbium/element_065_terbium_srp_th.png', 'boil': 3396, 'category': 'lanthanide', 'cpk-hex': '30ffc7', 'density': 8.23, 'discovered_by': 'Carl Gustaf Mosander', 'electron_affinity': 112.4, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f9', 'electron_configuration_semantic': '[Xe] 4f9 6s2', 'electronegativity_pauling': 1.1, 'group': 3, 'image': {'attribution': 'Unknown authorUnknown author, CC BY 1.0 <https://creativecommons.org/licenses/by/1.0>, via Wikimedia Commons, source: https://images-of-elements.com/terbium.php', 'title': 'Pure Terbium, 3 grams. Original size: 1 cm', 'url': 'https://upload.wikimedia.org/wikipedia/commons/9/9a/Terbium-2.jpg'}, 'ionization_energies': [565.8, 1110, 2114, 3839], 'melt': 1629, 'molar_heat': 28.91, 'named_by': None, 'number': 65, 'period': 6, 'phase': 'Solid', 'shells': [2, 8, 18, 27, 8, 2], 'source': 'https://en.wikipedia.org/wiki/Terbium', 'spectral_img': None, 'summary': 'Terbium is a chemical element with symbol Tb and atomic number 65. It is a silvery-white rare earth metal that is malleable, ductile and soft enough to be cut with a knife. Terbium is never found in nature as a free element, but it is contained in many minerals, including cerite, gadolinite, monazite, xenotime and euxenite.', 'wxpos': 11, 'wypos': 6, 'xpos': 11, 'ypos': 9}), 'Tc': Element({'name': 'technetium', 'symbol': 'Tc', 'atomic_number': 43, 'atomic_mass': 98, 'appearance': 'shiny gray metal', 'block': 'd', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_043_technetium/element_043_technetium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_043_technetium/element_043_technetium_srp_th.png', 'boil': 4538, 'category': 'transition metal', 'cpk-hex': '3b9e9e', 'density': 11, 'discovered_by': 'Emilio Segrè', 'electron_affinity': 53, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d5', 'electron_configuration_semantic': '[Kr] 4d5 5s2', 'electronegativity_pauling': 1.9, 'group': 7, 'image': {'attribution': 'GFDL, CC BY-SA 4.0 <https://creativecommons.org/licenses/by-sa/4.0>, via Wikimedia Commons', 'title': 'Technetium Sample inside a sealed glass ampoule, filled with argon gas. 6x1 mm goldfoil covered with 99Tc powder (electroplated).', 'url': 'https://upload.wikimedia.org/wikipedia/commons/a/ab/Technetium-sample-cropped.jpg'}, 'ionization_energies': [702, 1470, 2850], 'melt': 2430, 'molar_heat': 24.27, 'named_by': None, 'number': 43, 'period': 5, 'phase': 'Solid', 'shells': [2, 8, 18, 13, 2], 'source': 'https://en.wikipedia.org/wiki/Technetium', 'spectral_img': None, 'summary': 'Technetium (/tɛkˈniːʃiəm/) is a chemical element with symbol Tc and atomic number 43. It is the element with the lowest atomic number in the periodic table that has no stable isotopes:every form of it is radioactive. Nearly all technetium is produced synthetically, and only minute amounts are found in nature.', 'wxpos': 21, 'wypos': 5, 'xpos': 7, 'ypos': 5}), 'Te': Element({'name': 'tellurium', 'symbol': 'Te', 'atomic_number': 52, 'atomic_mass': 127.603, 'appearance': None, 'block': 'p', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_052_tellurium/element_052_tellurium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_052_tellurium/element_052_tellurium_srp_th.png', 'boil': 1261, 'category': 'metalloid', 'cpk-hex': 'd47a00', 'density': 6.24, 'discovered_by': 'Franz-Joseph Müller von Reichenstein', 'electron_affinity': 190.161, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p4', 'electron_configuration_semantic': '[Kr] 4d10 5s2 5p4', 'electronegativity_pauling': 2.1, 'group': 16, 'image': {'attribution': 'Unknown authorUnknown author, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/tellurium.php', 'title': 'Metallic tellurium, diameter 3.5 cm', 'url': 'https://upload.wikimedia.org/wikipedia/commons/c/c1/Tellurium2.jpg'}, 'ionization_energies': [869.3, 1790, 2698, 3610, 5668, 6820, 13200], 'melt': 722.66, 'molar_heat': 25.73, 'named_by': None, 'number': 52, 'period': 5, 'phase': 'Solid', 'shells': [2, 8, 18, 18, 6], 'source': 'https://en.wikipedia.org/wiki/Tellurium', 'spectral_img': None, 'summary': 'Tellurium is a chemical element with symbol Te and atomic number 52. It is a brittle, mildly toxic, rare, silver-white metalloid. Tellurium is chemically related to selenium and sulfur.', 'wxpos': 30, 'wypos': 5, 'xpos': 16, 'ypos': 5}), 'Th': Element({'name': 'thorium', 'symbol': 'Th', 'atomic_number': 90, 'atomic_mass': 232.03774, 'appearance': 'silvery, often with black tarnish', 'block': 'f', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_090_thorium/element_090_thorium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_090_thorium/element_090_thorium_srp_th.png', 'boil': 5061, 'category': 'actinide', 'cpk-hex': '00baff', 'density': 11.724, 'discovered_by': 'Jöns Jakob Berzelius', 'electron_affinity': 112.72, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d10 6p6 7s2 6d2', 'electron_configuration_semantic': '[Rn] 6d2 7s2', 'electronegativity_pauling': 1.3, 'group': 3, 'image': {'attribution': 'W. Oelen, CC BY-SA 3.0 <https://creativecommons.org/licenses/by-sa/3.0>, via Wikimedia Commons', 'title': 'Thorium Metal in Ampoule, corroded', 'url': 'https://upload.wikimedia.org/wikipedia/commons/f/f7/Thorium-1.jpg'}, 'ionization_energies': [587, 1110, 1930, 2780], 'melt': 2023, 'molar_heat': 26.23, 'named_by': None, 'number': 90, 'period': 7, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 18, 10, 2], 'source': 'https://en.wikipedia.org/wiki/Thorium', 'spectral_img': None, 'summary': 'Thorium is a chemical element with symbol Th and atomic number 90. A radioactive actinide metal, thorium is one of only two significantly radioactive elements that still occur naturally in large quantities as a primordial element (the other being uranium). It was discovered in 1828 by the Norwegian Reverend and amateur mineralogist Morten Thrane Esmark and identified by the Swedish chemist Jöns Jakob Berzelius, who named it after Thor, the Norse god of thunder.', 'wxpos': 4, 'wypos': 7, 'xpos': 4, 'ypos': 10}), 'Ti': Element({'name': 'titanium', 'symbol': 'Ti', 'atomic_number': 22, 'atomic_mass': 47.8671, 'appearance': 'silvery grey-white metallic', 'block': 'd', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_022_titanium/element_022_titanium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_022_titanium/element_022_titanium_srp_th.png', 'boil': 3560, 'category': 'transition metal', 'cpk-hex': 'bfc2c7', 'density': 4.506, 'discovered_by': 'William Gregor', 'electron_affinity': 7.289, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d2', 'electron_configuration_semantic': '[Ar] 3d2 4s2', 'electronegativity_pauling': 1.54, 'group': 4, 'image': {'attribution': 'Hi-Res Images ofChemical Elements, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/titanium.php', 'title': 'Titanium Crystal made with the van Arkel-de Booer Process. 87 grams, Original size in cm: 2.5 x 4', 'url': 'https://upload.wikimedia.org/wikipedia/commons/e/ec/Titanium.jpg'}, 'ionization_energies': [658.8, 1309.8, 2652.5, 4174.6, 9581, 11533, 13590, 16440, 18530, 20833, 25575, 28125, 76015, 83280, 90880, 100700, 109100, 117800, 129900, 137530, 602930, 639294], 'melt': 1941, 'molar_heat': 25.06, 'named_by': 'Martin Heinrich Klaproth', 'number': 22, 'period': 4, 'phase': 'Solid', 'shells': [2, 8, 10, 2], 'source': 'https://en.wikipedia.org/wiki/Titanium', 'spectral_img': None, 'summary': 'Titanium is a chemical element with symbol Ti and atomic number 22. It is a lustrous transition metal with a silver color, low density and high strength. It is highly resistant to corrosion in sea water, aqua regia and chlorine.', 'wxpos': 18, 'wypos': 4, 'xpos': 4, 'ypos': 4}), 'Tl': Element({'name': 'thallium', 'symbol': 'Tl', 'atomic_number': 81, 'atomic_mass': 204.38, 'appearance': 'silvery white', 'block': 'p', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_081_thallium/element_081_thallium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_081_thallium/element_081_thallium_srp_th.png', 'boil': 1746, 'category': 'post-transition metal', 'cpk-hex': 'a6544d', 'density': 11.85, 'discovered_by': 'William Crookes', 'electron_affinity': 36.4, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d10 6p1', 'electron_configuration_semantic': '[Xe] 4f14 5d10 6s2 6p1', 'electronegativity_pauling': 1.62, 'group': 13, 'image': {'attribution': 'Hi-Res Images ofChemical Elements, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/thallium.php', 'title': '8 grams pure thallium under argon. Original size in cm: 0.7 x 1.5', 'url': 'https://upload.wikimedia.org/wikipedia/commons/5/55/Thallium_%2881_Tl%29.jpg'}, 'ionization_energies': [589.4, 1971, 2878], 'melt': 577, 'molar_heat': 26.32, 'named_by': None, 'number': 81, 'period': 6, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 18, 3], 'source': 'https://en.wikipedia.org/wiki/Thallium', 'spectral_img': None, 'summary': 'Thallium is a chemical element with symbol Tl and atomic number 81. This soft gray post-transition metal is not found free in nature. When isolated, it resembles tin, but discolors when exposed to air.', 'wxpos': 27, 'wypos': 6, 'xpos': 13, 'ypos': 6}), 'Tm': Element({'name': 'thulium', 'symbol': 'Tm', 'atomic_number': 69, 'atomic_mass': 168.934222, 'appearance': 'silvery gray', 'block': 'f', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_069_thulium/element_069_thulium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_069_thulium/element_069_thulium_srp_th.png', 'boil': 2223, 'category': 'lanthanide', 'cpk-hex': '00d452', 'density': 9.32, 'discovered_by': 'Per Teodor Cleve', 'electron_affinity': 99, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f13', 'electron_configuration_semantic': '[Xe] 4f13 6s2', 'electronegativity_pauling': 1.25, 'group': 3, 'image': {'attribution': 'Jurii, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/thulium.php', 'title': 'Ultrapure (99.997%) Crystalline Thulium, 22.3 grams, 3 × 3 × 2 cm in size', 'url': 'https://upload.wikimedia.org/wikipedia/commons/6/6b/Thulium-2.jpg'}, 'ionization_energies': [596.7, 1160, 2285, 4120], 'melt': 1818, 'molar_heat': 27.03, 'named_by': None, 'number': 69, 'period': 6, 'phase': 'Solid', 'shells': [2, 8, 18, 31, 8, 2], 'source': 'https://en.wikipedia.org/wiki/Thulium', 'spectral_img': None, 'summary': 'Thulium is a chemical element with symbol Tm and atomic number 69. It is the thirteenth and antepenultimate (third-last) element in the lanthanide series. Like the other lanthanides, the most common oxidation state is +3, seen in its oxide, halides and other compounds.', 'wxpos': 15, 'wypos': 6, 'xpos': 15, 'ypos': 9}), 'Ts': Element({'name': 'tennessine', 'symbol': 'Ts', 'atomic_number': 117, 'atomic_mass': 294, 'appearance': None, 'block': 'p', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_117_tennessine/element_117_tennessine.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_117_tennessine/element_117_tennessine_srp_th.png', 'boil': 883, 'category': 'unknown, probably metalloid', 'cpk-hex': None, 'density': 7.17, 'discovered_by': 'Joint Institute for Nuclear Research', 'electron_affinity': 165.9, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d10 6p6 7s2 5f14 6d10 7p5', 'electron_configuration_semantic': '*[Rn] 5f14 6d10 7s2 7p5', 'electronegativity_pauling': None, 'group': 17, 'image': {'attribution': 'Chemical Elements A Virtual Museum under a Creative Commons Attribution 3.0 Unported License, source: https://images-of-elements.com/tenessine.php', 'title': 'No Image Found', 'url': 'https://images-of-elements.com/s/transactinoid.png'}, 'ionization_energies': [], 'melt': 723, 'molar_heat': None, 'named_by': None, 'number': 117, 'period': 7, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 32, 18, 7], 'source': 'https://en.wikipedia.org/wiki/Tennessine', 'spectral_img': None, 'summary': 'Tennessine is a superheavy artificial chemical element with an atomic number of 117 and a symbol of Ts. Also known as eka-astatine or element 117, it is the second-heaviest known element and penultimate element of the 7th period of the periodic table. As of 2016, fifteen tennessine atoms have been observed:six when it was first synthesized in 2010, seven in 2012, and two in 2014.', 'wxpos': 31, 'wypos': 7, 'xpos': 17, 'ypos': 7}), 'U': Element({'name': 'uranium', 'symbol': 'U', 'atomic_number': 92, 'atomic_mass': 238.028913, 'appearance': None, 'block': 'f', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_092_uranium/element_092_uranium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_092_uranium/element_092_uranium_srp_th.png', 'boil': 4404, 'category': 'actinide', 'cpk-hex': '008fff', 'density': 19.1, 'discovered_by': 'Martin Heinrich Klaproth', 'electron_affinity': 50.94, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d10 6p6 7s2 5f3 6d1', 'electron_configuration_semantic': '[Rn] 5f3 6d1 7s2', 'electronegativity_pauling': 1.38, 'group': 3, 'image': {'attribution': 'Unknown authorUnknown author, Public domain, via Wikimedia Commons', 'title': 'A biscuit of uranium metal after reduction via the Ames Process. c.1943.', 'url': 'https://upload.wikimedia.org/wikipedia/commons/b/b2/Ames_Process_uranium_biscuit.jpg'}, 'ionization_energies': [597.6, 1420], 'melt': 1405.3, 'molar_heat': 27.665, 'named_by': None, 'number': 92, 'period': 7, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 21, 9, 2], 'source': 'https://en.wikipedia.org/wiki/Uranium', 'spectral_img': None, 'summary': 'Uranium is a chemical element with symbol U and atomic number 92. It is a silvery-white metal in the actinide series of the periodic table. A uranium atom has 92 protons and 92 electrons, of which 6 are valence electrons.', 'wxpos': 6, 'wypos': 7, 'xpos': 6, 'ypos': 10}), 'Uue': Element({'name': 'ununennium', 'symbol': 'Uue', 'atomic_number': 119, 'atomic_mass': 315, 'appearance': None, 'block': 's', 'bohr_model_3d': None, 'bohr_model_image': None, 'boil': 630, 'category': 'unknown, but predicted to be an alkali metal', 'cpk-hex': None, 'density': 3, 'discovered_by': 'GSI Helmholtz Centre for Heavy Ion Research', 'electron_affinity': 63.87, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d10 6p6 7s2 5f14 6d10 7p6 8s1', 'electron_configuration_semantic': '*[Uuo] 8s1', 'electronegativity_pauling': None, 'group': 1, 'image': {'attribution': 'Chemical Elements A Virtual Museum under a Creative Commons Attribution 3.0 Unported License, source: https://images-of-elements.com', 'title': 'No Image Found', 'url': 'https://images-of-elements.com/s/transactinoid.png'}, 'ionization_energies': [], 'melt': None, 'molar_heat': None, 'named_by': None, 'number': 119, 'period': 8, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 32, 18, 8, 1], 'source': 'https://en.wikipedia.org/wiki/Ununennium', 'spectral_img': None, 'summary': 'Ununennium, also known as eka-francium or simply element 119, is the hypothetical chemical element with symbol Uue and atomic number 119. Ununennium and Uue are the temporary systematic IUPAC name and symbol respectively, until a permanent name is decided upon. In the periodic table of the elements, it is expected to be an s-block element, an alkali metal, and the first element in the eighth period.', 'wxpos': 1, 'wypos': 8, 'xpos': 1, 'ypos': 8}), 'V': Element({'name': 'vanadium', 'symbol': 'V', 'atomic_number': 23, 'atomic_mass': 50.94151, 'appearance': 'blue-silver-grey metal', 'block': 'd', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_023_vanadium/element_023_vanadium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_023_vanadium/element_023_vanadium_srp_th.png', 'boil': 3680, 'category': 'transition metal', 'cpk-hex': 'a6a6ab', 'density': 6, 'discovered_by': 'Andrés Manuel del Río', 'electron_affinity': 50.911, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d3', 'electron_configuration_semantic': '[Ar] 3d3 4s2', 'electronegativity_pauling': 1.63, 'group': 5, 'image': {'attribution': 'Jurii, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/vanadium.php', 'title': 'Pieces of Pure Vanadium with Oxide Layer', 'url': 'https://upload.wikimedia.org/wikipedia/commons/0/0a/Vanadium-pieces.jpg'}, 'ionization_energies': [650.9, 1414, 2830, 4507, 6298.7, 12363, 14530, 16730, 19860, 22240, 24670, 29730, 32446, 86450, 94170, 102300, 112700, 121600, 130700, 143400, 151440, 661050, 699144], 'melt': 2183, 'molar_heat': 24.89, 'named_by': 'Isotopes of vanadium', 'number': 23, 'period': 4, 'phase': 'Solid', 'shells': [2, 8, 11, 2], 'source': 'https://en.wikipedia.org/wiki/Vanadium', 'spectral_img': None, 'summary': 'Vanadium is a chemical element with symbol V and atomic number 23. It is a hard, silvery grey, ductile and malleable transition metal. The element is found only in chemically combined form in nature, but once isolated artificially, the formation of an oxide layer stabilizes the free metal somewhat against further oxidation.', 'wxpos': 19, 'wypos': 4, 'xpos': 5, 'ypos': 4}), 'W': Element({'name': 'tungsten', 'symbol': 'W', 'atomic_number': 74, 'atomic_mass': 183.841, 'appearance': 'grayish white, lustrous', 'block': 'd', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_074_tungsten/element_074_tungsten.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_074_tungsten/element_074_tungsten_srp_th.png', 'boil': 6203, 'category': 'transition metal', 'cpk-hex': '2194d6', 'density': 19.25, 'discovered_by': 'Carl Wilhelm Scheele', 'electron_affinity': 78.76, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14 5d4', 'electron_configuration_semantic': '[Xe] 4f14 5d4 6s2', 'electronegativity_pauling': 2.36, 'group': 6, 'image': {'attribution': 'Jurii, CC BY 1.0 <https://creativecommons.org/licenses/by/1.0>, via Wikimedia Commons, source: https://images-of-elements.com/tungsten.php', 'title': 'Tungsten rod with oxidised surface, 80 grams. Original size in cm: 1.3 x 3', 'url': 'https://upload.wikimedia.org/wikipedia/commons/c/c8/Tungsten_rod_with_oxidised_surface.jpg'}, 'ionization_energies': [770, 1700], 'melt': 3695, 'molar_heat': 24.27, 'named_by': None, 'number': 74, 'period': 6, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 12, 2], 'source': 'https://en.wikipedia.org/wiki/Tungsten', 'spectral_img': None, 'summary': 'Tungsten, also known as wolfram, is a chemical element with symbol W and atomic number 74. The word tungsten comes from the Swedish language tung sten, which directly translates to heavy stone. Its name in Swedish is volfram, however, in order to distinguish it from scheelite, which in Swedish is alternatively named tungsten.', 'wxpos': 20, 'wypos': 6, 'xpos': 6, 'ypos': 6}), 'Xe': Element({'name': 'xenon', 'symbol': 'Xe', 'atomic_number': 54, 'atomic_mass': 131.2936, 'appearance': 'colorless gas, exhibiting a blue glow when placed in a high voltage electric field', 'block': 'p', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_054_xenon/element_054_xenon.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_054_xenon/element_054_xenon_srp_th.png', 'boil': 165.051, 'category': 'noble gas', 'cpk-hex': '429eb0', 'density': 5.894, 'discovered_by': 'William Ramsay', 'electron_affinity': -77, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6', 'electron_configuration_semantic': '[Kr] 4d10 5s2 5p6', 'electronegativity_pauling': 2.6, 'group': 18, 'image': {'attribution': 'Jurii, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/xenon.php', 'title': 'Vial of glowing ultrapure xenon. Original size in cm: 1 x 5', 'url': 'https://upload.wikimedia.org/wikipedia/commons/5/5d/Xenon-glow.jpg'}, 'ionization_energies': [1170.4, 2046.4, 3099.4], 'melt': 161.4, 'molar_heat': None, 'named_by': None, 'number': 54, 'period': 5, 'phase': 'Gas', 'shells': [2, 8, 18, 18, 8], 'source': 'https://en.wikipedia.org/wiki/Xenon', 'spectral_img': 'https://en.wikipedia.org/wiki/File:Xenon_Spectrum.jpg', 'summary': "Xenon is a chemical element with symbol Xe and atomic number 54. It is a colorless, dense, odorless noble gas, that occurs in the Earth's atmosphere in trace amounts. Although generally unreactive, xenon can undergo a few chemical reactions such as the formation of xenon hexafluoroplatinate, the first noble gas compound to be synthesized.", 'wxpos': 32, 'wypos': 5, 'xpos': 18, 'ypos': 5}), 'Y': Element({'name': 'yttrium', 'symbol': 'Y', 'atomic_number': 39, 'atomic_mass': 88.905842, 'appearance': 'silvery white', 'block': 'd', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_039_yttrium/element_039_yttrium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_039_yttrium/element_039_yttrium_srp_th.png', 'boil': 3203, 'category': 'transition metal', 'cpk-hex': '94ffff', 'density': 4.472, 'discovered_by': 'Johan Gadolin', 'electron_affinity': 29.6, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d1', 'electron_configuration_semantic': '[Kr] 4d1 5s2', 'electronegativity_pauling': 1.22, 'group': 3, 'image': {'attribution': 'Jan Anskeit, CC BY-SA 4.0 <https://creativecommons.org/licenses/by-sa/4.0>, via Wikimedia Commons', 'title': '6,21g Yttrium, Reinheit mindestens 99%.', 'url': 'https://upload.wikimedia.org/wikipedia/commons/9/90/Piece_of_Yttrium.jpg'}, 'ionization_energies': [600, 1180, 1980, 5847, 7430, 8970, 11190, 12450, 14110, 18400, 19900, 36090], 'melt': 1799, 'molar_heat': 26.53, 'named_by': None, 'number': 39, 'period': 5, 'phase': 'Solid', 'shells': [2, 8, 18, 9, 2], 'source': 'https://en.wikipedia.org/wiki/Yttrium', 'spectral_img': None, 'summary': 'Yttrium is a chemical element with symbol Y and atomic number 39. It is a silvery-metallic transition metal chemically similar to the lanthanides and it has often been classified as a "rare earth element". Yttrium is almost always found combined with the lanthanides in rare earth minerals and is never found in nature as a free element.', 'wxpos': 17, 'wypos': 5, 'xpos': 3, 'ypos': 5}), 'Yb': Element({'name': 'ytterbium', 'symbol': 'Yb', 'atomic_number': 70, 'atomic_mass': 173.0451, 'appearance': None, 'block': 'f', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_070_ytterbium/element_070_ytterbium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_070_ytterbium/element_070_ytterbium_srp_th.png', 'boil': 1469, 'category': 'lanthanide', 'cpk-hex': '00bf38', 'density': 6.9, 'discovered_by': 'Jean Charles Galissard de Marignac', 'electron_affinity': -1.93, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d10 5p6 6s2 4f14', 'electron_configuration_semantic': '[Xe] 4f14 6s2', 'electronegativity_pauling': 1.1, 'group': 3, 'image': {'attribution': 'Jurii, CC BY 1.0 <https://creativecommons.org/licenses/by/1.0>, via Wikimedia Commons, source: https://images-of-elements.com/ytterbium.php', 'title': 'Ytterbium, 0.5 x 1 cm', 'url': 'https://upload.wikimedia.org/wikipedia/commons/c/ce/Ytterbium-3.jpg'}, 'ionization_energies': [603.4, 1174.8, 2417, 4203], 'melt': 1097, 'molar_heat': 26.74, 'named_by': None, 'number': 70, 'period': 6, 'phase': 'Solid', 'shells': [2, 8, 18, 32, 8, 2], 'source': 'https://en.wikipedia.org/wiki/Ytterbium', 'spectral_img': None, 'summary': 'Ytterbium is a chemical element with symbol Yb and atomic number 70. It is the fourteenth and penultimate element in the lanthanide series, which is the basis of the relative stability of its +2 oxidation state. However, like the other lanthanides, its most common oxidation state is +3, seen in its oxide, halides and other compounds.', 'wxpos': 16, 'wypos': 6, 'xpos': 16, 'ypos': 9}), 'Zn': Element({'name': 'zinc', 'symbol': 'Zn', 'atomic_number': 30, 'atomic_mass': 65.382, 'appearance': 'silver-gray', 'block': 'd', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_030_zinc/element_030_zinc.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_030_zinc/element_030_zinc_srp_th.png', 'boil': 1180, 'category': 'transition metal', 'cpk-hex': '7d80b0', 'density': 7.14, 'discovered_by': 'India', 'electron_affinity': -58, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10', 'electron_configuration_semantic': '[Ar] 3d10 4s2', 'electronegativity_pauling': 1.65, 'group': 12, 'image': {'attribution': 'Hi-Res Images ofChemical Elements, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/zinc.php', 'title': '30 grams Zinc, front and back side. Original size in cm: 3', 'url': 'https://upload.wikimedia.org/wikipedia/commons/b/ba/Zinc_%2830_Zn%29.jpg'}, 'ionization_energies': [906.4, 1733.3, 3833, 5731, 7970, 10400, 12900, 16800, 19600, 23000, 26400, 29990, 40490, 43800, 47300, 52300, 55900, 59700, 67300, 71200, 179100], 'melt': 692.68, 'molar_heat': 25.47, 'named_by': None, 'number': 30, 'period': 4, 'phase': 'Solid', 'shells': [2, 8, 18, 2], 'source': 'https://en.wikipedia.org/wiki/Zinc', 'spectral_img': None, 'summary': 'Zinc, in commerce also spelter, is a chemical element with symbol Zn and atomic number 30. It is the first element of group 12 of the periodic table. In some respects zinc is chemically similar to magnesium:its ion is of similar size and its only common oxidation state is +2.', 'wxpos': 26, 'wypos': 4, 'xpos': 12, 'ypos': 4}), 'Zr': Element({'name': 'zirconium', 'symbol': 'Zr', 'atomic_number': 40, 'atomic_mass': 91.2242, 'appearance': 'silvery white', 'block': 'd', 'bohr_model_3d': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_040_zirconium/element_040_zirconium.glb', 'bohr_model_image': 'https://storage.googleapis.com/search-ar-edu/periodic-table/element_040_zirconium/element_040_zirconium_srp_th.png', 'boil': 4650, 'category': 'transition metal', 'cpk-hex': '94e0e0', 'density': 6.52, 'discovered_by': 'Martin Heinrich Klaproth', 'electron_affinity': 41.806, 'electron_configuration': '1s2 2s2 2p6 3s2 3p6 4s2 3d10 4p6 5s2 4d2', 'electron_configuration_semantic': '[Kr] 4d2 5s2', 'electronegativity_pauling': 1.33, 'group': 4, 'image': {'attribution': 'Jurii, CC BY 3.0 <https://creativecommons.org/licenses/by/3.0>, via Wikimedia Commons, source: https://images-of-elements.com/zirconium.php', 'title': 'Two pieces of Zirconium, 1 cm each.', 'url': 'https://upload.wikimedia.org/wikipedia/commons/1/1d/Zirconium-pieces.jpg'}, 'ionization_energies': [640.1, 1270, 2218, 3313, 7752, 9500], 'melt': 2128, 'molar_heat': 25.36, 'named_by': None, 'number': 40, 'period': 5, 'phase': 'Solid', 'shells': [2, 8, 18, 10, 2], 'source': 'https://en.wikipedia.org/wiki/Zirconium', 'spectral_img': None, 'summary': 'Zirconium is a chemical element with symbol Zr and atomic number 40. The name of zirconium is taken from the name of the mineral zircon, the most important source of zirconium. The word zircon comes from the Persian word zargun زرگون, meaning "gold-colored".', 'wxpos': 18, 'wypos': 5, 'xpos': 4, 'ypos': 5})}
classmethod get_atomic_mass(symbol: str) float[source]

Get the atomic mass of an element.

Parameters:

symbol (str) – chemical symbol of the element

Returns:

Atomic mass.

Return type:

float

classmethod get_atomic_number(symbol: str) int[source]

Get the atomic number of an element.

Parameters:

symbol (str) – Chemical symbol of the element

Returns:

Atomic number.

Return type:

int

classmethod get_covalent_radius(symbol: str) float[source]

Get the covalent radius of an element.

Parameters:

symbol (str) – chemical symbol of the element

Returns:

Covalent radius in atomic units.

Return type:

float

classmethod get_element(symbol: str) Element[source]

Retrieve an element as an instance of Element

Parameters:

symbol (str) – Chemical symbol of the element.

Returns:

Instance of Element.

Return type:

Element

classmethod get_name(symbol: str) str[source]

Get the full name of an element.

Parameters:

symbol (str) – Chemical symbol of the element.

Returns:

Full name.

Return type:

str

classmethod get_species_colours(symbol: str) Tuple[float, float, float][source]

Get the JMol colour of an element

Parameters:

symbol (str) – chemical symbol of the element

Returns:

Covalent radius in atomic units.

Return type:

Tuple[float, float, float]

name = 'ununennium'
pt = <_io.TextIOWrapper name='/home/runner/work/dfttoolkit/dfttoolkit/dfttoolkit/utils/periodic_table.yaml' mode='r' encoding='UTF-8'>

dfttoolkit.utils.run_utils module

dfttoolkit.utils.run_utils.no_repeat(original_func=None, *, output_file: str = 'aims.out', calc_dir: str = './', force: bool = False)[source]

Don’t repeat the calculation if aims.out exists in the calculation directory.

Parameters:
  • output_file (str, default='aims.out') – The name of the output file to check for.

  • calc_dir (str, default="./") – The directory where the calculation is performed

  • force (bool, default=False) – If True, the calculation is performed even if aims.out exists in the calculation directory.

Raises:

ValueError – if the calc_dir kwarg is not a directory

dfttoolkit.utils.units module

dfttoolkit.utils.vibrations_utils module

dfttoolkit.utils.vibrations_utils.get_cross_correlation_function(signal_0: ndarray[Any, dtype[_ScalarType_co]], signal_1: ndarray[Any, dtype[_ScalarType_co]], bootstrapping_blocks: int = 1) ndarray[Any, dtype[_ScalarType_co]][source]
dfttoolkit.utils.vibrations_utils.get_cross_spectrum(signal_0: ~numpy.ndarray[~typing.Any, ~numpy.dtype[~numpy._typing._array_like._ScalarType_co]], signal_1: ~numpy.ndarray[~typing.Any, ~numpy.dtype[~numpy._typing._array_like._ScalarType_co]], time_step: float, bootstrapping_blocks: int = 1, bootstrapping_overlap: int = 0, zero_padding: int = 0, cutoff_at_last_maximum: bool = False, window_function: str = 'none') -> (<built-in function array>, <built-in function array>)[source]
Determine the cross spectrum for a given signal using bootstrapping:
  • Splitting the sigmal into blocks and for each block:
    • Determining the cross correlation function of the signal

    • Determining the fourire transform of the autocorrelation function to get the power spectrum for the block

  • Calculating the average power spectrum by averaging of the power spectra of all blocks

Parameters:
  • signal_0 (1D np.array) – First siganl for which the correlation function should be calculated.

  • signal_1 (1D np.array) – Second siganl for which the correlation function should be calculated.

  • time_step (float) – DESCRIPTION.

  • bootstrapping_blocks (int, default=1) – DESCRIPTION

  • bootstrapping_overlap (int, default=0) – DESCRIPTION

  • zero_padding (int, default=0) – Pad the cross correlation function with zeros to increase the frequency resolution of the FFT. This also avoids the effect of varying spectral leakage. However, it artificially broadens the resulting cross spectrum and introduces wiggles.

  • cutoff_at_last_maximum (bool, default=False) – Cut off the cross correlation function at the last maximum to hide spectral leakage.

Returns:

  • frequencies (np.array) – Frequiencies of the power spectrum in units depending on the tims_step.

  • cross_spectrum (np.array) – Power spectrum.

dfttoolkit.utils.vibrations_utils.get_cross_spectrum_mem(signal_0: ndarray[Any, dtype[_ScalarType_co]], signal_1: ndarray[Any, dtype[_ScalarType_co]], time_step, model_order, n_freqs=512)[source]

Estimate the power spectral density (PSD) of a time series using the Maximum Entropy Method (MEM).

Parameters: - x: array-like, time series data. - p: int, model order (number of poles). Controls the smoothness and resolution of the PSD. - n_freqs: int, number of frequency bins for the PSD.

Returns: - freqs: array of frequency bins. - psd: array of PSD values at each frequency.

dfttoolkit.utils.vibrations_utils.get_last_maximum(x: ndarray[Any, dtype[_ScalarType_co]])[source]
dfttoolkit.utils.vibrations_utils.get_line_widths(frequencies, power_spectrum, filter_maximum=True, use_lorentzian=True)[source]
dfttoolkit.utils.vibrations_utils.get_normal_mode_decomposition(velocities: ndarray[Any, dtype[_ScalarType_co]], eigenvectors: ndarray[Any, dtype[_ScalarType_co]], use_numba: bool = True) ndarray[Any, dtype[_ScalarType_co]][source]

Calculate the normal-mode-decomposition of the velocities. This is done by projecting the atomic velocities onto the vibrational eigenvectors. See equation 10 in: https://doi.org/10.1016/j.cpc.2017.08.017

Parameters:
  • velocities (np.array) – Array containing the velocities from an MD trajectory structured in the following way: [number of time steps, number of atoms, number of dimensions].

  • eigenvectors (np.array) – Array of eigenvectors structured in the following way: [number of frequencies, number of atoms, number of dimensions].

Returns:

velocities_projected – Velocities projected onto the eigenvectors structured as follows: [number of time steps, number of frequencies]

Return type:

np.array

dfttoolkit.utils.vibrations_utils.get_peak_parameters(frequencies, power_spectrum)[source]
dfttoolkit.utils.vibrations_utils.lorentzian_fit(frequencies, power_spectrum, p_0=None, filter_maximum=0)[source]

Module contents