diff --git a/atomrdf/data/asmo.owl b/atomrdf/data/asmo.owl index ec013b0..347c68e 100644 --- a/atomrdf/data/asmo.owl +++ b/atomrdf/data/asmo.owl @@ -15,6 +15,7 @@ https://orcid.org/0000-0001-7564-7990 ASMO is an ontology that aims to define the concepts needed to describe commonly used atomic scale simulation methods, i.e. density functional theory, molecular dynamics, Monte Carlo methods, etc. ASMO uses the Provenance Ontology (PROV-O) to describe the simulation process. Atomistic Simulation Methods Ontology (ASMO) + 0.0.1 diff --git a/atomrdf/graph.py b/atomrdf/graph.py index 1852a5a..7baac99 100644 --- a/atomrdf/graph.py +++ b/atomrdf/graph.py @@ -4,7 +4,7 @@ object is stored in triplets. """ -from rdflib import Graph, Literal, Namespace, XSD, RDF, RDFS, BNode, URIRef, FOAF, SKOS, DCTERMS +from rdflib import Graph, Literal, XSD, RDF, RDFS, BNode, URIRef import os import numpy as np @@ -29,11 +29,7 @@ from atomrdf.stores import create_store import atomrdf.json_io as json_io - - -CMSO = Namespace("http://purls.helmholtz-metadaten.de/cmso/") -PLDO = Namespace("http://purls.helmholtz-metadaten.de/pldo/") -PODO = Namespace("http://purls.helmholtz-metadaten.de/podo/") +from atomrdf.namespace import Namespace, CMSO, PLDO, PODO, ASMO #read element data file file_location = os.path.dirname(__file__).split('/') @@ -112,11 +108,38 @@ def add_structure(self, structure): structure.graph = self structure.to_graph() + def _modify_triple(self, triple): + modified_triple = [] + for term in triple: + if type(term).__name__ == 'OntoTerm': + modified_triple.append(term.namespace_object) + else: + modified_triple.append(term) + return tuple(modified_triple) + def add(self, triple): - if str(triple[2].toPython()) != 'None': - self.graph.add(triple) - + """ + Force assumes that you are passing rdflib terms, defined with + RDFLib Namespace + """ + modified_triple = self._modify_triple(triple) + if str(modified_triple[2].toPython()) != 'None': + self.graph.add(modified_triple) + + def triples(self, triple): + modified_triple = self._modify_triple(triple) + return self.graph.triples(modified_triple) + + def value(self, arg1, arg2): + modified_double = self._modify_triple((arg1, arg2)) + return self.graph.value(modified_double[0], modified_double[1]) + + def remove(self, triple): + modified_triple = self._modify_triple(triple) + return self.graph.remove(modified_triple) + + def _initialize_graph(self): """ Create the RDF Graph from the data stored @@ -159,19 +182,19 @@ def add_calculated_quantity(self, sample, propertyname, value, unit=None): def inspect_sample(self): - natoms = self.graph.value(sample, CMSO.hasNumberOfAtoms).toPython() - material = list([k[2] for k in self.graph.triples((sample, CMSO.hasMaterial, None))])[0] - defects = list([k[2] for k in self.graph.triples((material, CMSO.hasDefect, None))]) - composition = list([k[2].toPython() for k in self.graph.triples((material, CMSO.hasElementRatio, None))]) - crystalstructure = self.graph.value(material, CMSO.hasStructure) - spacegroupsymbol = self.graph.value(crystalstructure, CMSO.hasSpaceGroupSymbol).toPython() - - lattice = self.graph.value(sample, CMSO.hasNumberOfAtoms).toPython() - defect_types = list([self.graph.value(d, RDF.type).toPython() for d in defects]) - prop_nodes = list([k[2] for k in self.graph.triples((sample, CMSO.hasCalculatedProperty, None))]) - props = list([self.graph.value(prop_node, RDFS.label) for prop_node in prop_nodes]) - propvals = list([self.graph.value(d, CMSO.hasValue).toPython() for d in prop_nodes]) - units = list([self.graph.value(d, CMSO.hasUnit).toPython() for d in prop_nodes]) + natoms = self.value(sample, CMSO.hasNumberOfAtoms).toPython() + material = list([k[2] for k in self.triples((sample, CMSO.hasMaterial, None))])[0] + defects = list([k[2] for k in self.triples((material, CMSO.hasDefect, None))]) + composition = list([k[2].toPython() for k in self.triples((material, CMSO.hasElementRatio, None))]) + crystalstructure = self.value(material, CMSO.hasStructure) + spacegroupsymbol = self.value(crystalstructure, CMSO.hasSpaceGroupSymbol).toPython() + + lattice = self.value(sample, CMSO.hasNumberOfAtoms).toPython() + defect_types = list([self.value(d, RDF.type).toPython() for d in defects]) + prop_nodes = list([k[2] for k in self.triples((sample, CMSO.hasCalculatedProperty, None))]) + props = list([self.value(prop_node, RDFS.label) for prop_node in prop_nodes]) + propvals = list([self.value(d, CMSO.hasValue).toPython() for d in prop_nodes]) + units = list([self.value(d, CMSO.hasUnit).toPython() for d in prop_nodes]) st = [] st.append(f'Sample with {natoms} atoms.\n') st.append("Material:\n") @@ -330,12 +353,12 @@ def archive(self, package_name, format='turtle', compress=True): #now go through each sample, and copy the file, at the same time fix the paths for sample in self.samples: - filepath = self.graph.value(URIRef(f'{sample}_Position'), CMSO.hasPath).toPython() + filepath = self.value(URIRef(f'{sample}_Position'), CMSO.hasPath).toPython() shutil.copy(filepath, structure_store) #now we have to remove the old path, and fix new for val in ['Position', 'Species']: - self.graph.remove((URIRef(f'{sample}_{val}'), CMSO.hasPath, None)) + self.remove((URIRef(f'{sample}_{val}'), CMSO.hasPath, None)) #assign corrected path new_relpath = "/".join(['rdf_structure_store', filepath.split('/')[-1]]) @@ -428,7 +451,7 @@ def n_samples(self): Number of samples in the Graph """ - return len([x for x in self.graph.triples((None, RDF.type, CMSO.AtomicScaleSample))]) + return len([x for x in self.triples((None, RDF.type, CMSO.AtomicScaleSample))]) @property def samples(self): @@ -436,12 +459,12 @@ def samples(self): Returns a list of all Samples in the graph """ - return [x[0] for x in self.graph.triples((None, RDF.type, CMSO.AtomicScaleSample))] + return [x[0] for x in self.triples((None, RDF.type, CMSO.AtomicScaleSample))] def iterate_graph(self, item, create_new_graph=False): if create_new_graph: self.sgraph = KnowledgeGraph() - triples = list(self.graph.triples((item, None, None))) + triples = list(self.triples((item, None, None))) for triple in triples: self.sgraph.graph.add(triple) self.iterate_graph(triple[2]) @@ -467,7 +490,7 @@ def get_sample(self, sample, no_atoms=False): self.iterate_graph(sample, create_new_graph=True) if no_atoms: - na = self.sgraph.graph.value(sample, CMSO.hasNumberOfAtoms).toPython() + na = self.sgraph.value(sample, CMSO.hasNumberOfAtoms).toPython() return self.sgraph, na return self.sgraph @@ -486,18 +509,18 @@ def get_system_from_sample(self, sample): corresponding system """ - simcell = self.graph.value(sample, CMSO.hasSimulationCell) + simcell = self.value(sample, CMSO.hasSimulationCell) cell_vectors = [[], [], []] - for s in self.graph.triples((simcell, CMSO.hasVector, None)): - cell_vectors[0].append(self.graph.value(s[2], CMSO.hasComponent_x).toPython()) - cell_vectors[1].append(self.graph.value(s[2], CMSO.hasComponent_y).toPython()) - cell_vectors[2].append(self.graph.value(s[2], CMSO.hasComponent_z).toPython()) + for s in self.triples((simcell, CMSO.hasVector, None)): + cell_vectors[0].append(self.value(s[2], CMSO.hasComponent_x).toPython()) + cell_vectors[1].append(self.value(s[2], CMSO.hasComponent_y).toPython()) + cell_vectors[2].append(self.value(s[2], CMSO.hasComponent_z).toPython()) #cell_vectors - filepath = self.graph.value(URIRef(f'{sample}_Position'), CMSO.hasPath).toPython() - position_identifier = self.graph.value(URIRef(f'{sample}_Position'), CMSO.hasIdentifier).toPython() - species_identifier = self.graph.value(URIRef(f'{sample}_Species'), CMSO.hasIdentifier).toPython() + filepath = self.value(URIRef(f'{sample}_Position'), CMSO.hasPath).toPython() + position_identifier = self.value(URIRef(f'{sample}_Position'), CMSO.hasIdentifier).toPython() + species_identifier = self.value(URIRef(f'{sample}_Species'), CMSO.hasIdentifier).toPython() #open the file for reading with open(filepath, 'r') as fin: diff --git a/atomrdf/namespace.py b/atomrdf/namespace.py new file mode 100644 index 0000000..1af9c91 --- /dev/null +++ b/atomrdf/namespace.py @@ -0,0 +1,35 @@ +import os +from rdflib import Literal, URIRef +from rdflib import Namespace as RDFLibNamespace +from pyscal3.atoms import AttrSetter + +from atomrdf.network.network import OntologyNetwork + +class Namespace(AttrSetter, RDFLibNamespace): + def __init__(self, infile, delimiter='/'): + AttrSetter.__init__(self) + self.network = OntologyNetwork(infile, delimiter=delimiter) + #print(type(self.network.onto.tree.base_iri)) + #self.namespace = RDFLibNamespace(self.network.onto.tree.base_iri) + RDFLibNamespace.__init__(self.network.onto.tree.base_iri) + #self.namespace = RDFLibNamespace("http://purls.helmholtz-metadaten.de/cmso/") + self.name = self.network.onto.tree.name + mapdict = {} + + #now iterate over all attributes + for k1 in ['class', 'object_property', 'data_property']: + for k2, val in self.network.onto.attributes[k1].items(): + if val.namespace == self.name: + mapdict[val.name_without_prefix] = val + + #add attributes + self._add_attribute(mapdict) + + +file_location = os.path.dirname(__file__) + +CMSO = Namespace(os.path.join(file_location, 'data/cmso.owl')) +PLDO = Namespace(os.path.join(file_location, 'data/pldo.owl')) +PODO = Namespace(os.path.join(file_location, 'data/podo.owl')) +ASMO = Namespace(os.path.join(file_location, 'data/asmo.owl')) +PROV = RDFLibNamespace("http://www.w3.org/ns/prov#") \ No newline at end of file diff --git a/atomrdf/network/parser.py b/atomrdf/network/parser.py index 1a93d97..0a80ffc 100644 --- a/atomrdf/network/parser.py +++ b/atomrdf/network/parser.py @@ -181,19 +181,33 @@ def _parse_class_basic(self): iri = c.iri #print(iri) #print(iri) - try: - subclasses = self.tree.search(subclass_of=getattr(self.tree, c.name)) - for sb in subclasses: - term = OntoTerm(sb.iri, delimiter=self.delimiter) - term.node_type ='class' - self.attributes['class'][term.name] = term - subclasses = [strip_name(sb.iri, self.delimiter) for sb in subclasses] - classes.append(subclasses) - except: - term = OntoTerm(c.iri, delimiter=self.delimiter) + #CHILDREN + children = self.tree.get_children_of(c) + named_instances = self.tree.get_instances_of(c) + equiv_classes = c.equivalent_to + subclasses = [*children, *named_instances, *equiv_classes] + subclasses.append(c) + for sb in subclasses: + term = OntoTerm(sb.iri, delimiter=self.delimiter) term.node_type ='class' - self.attributes['class'][term.name] = term - classes.append([strip_name(c.iri, self.delimiter)]) + self.attributes['class'][term.name] = term + subclasses = [strip_name(sb.iri, self.delimiter) for sb in subclasses] + classes.append(subclasses) + + + #try: + # subclasses = self.tree.search(subclass_of=getattr(self.tree, c.name)) + # for sb in subclasses: + # term = OntoTerm(sb.iri, delimiter=self.delimiter) + # term.node_type ='class' + # self.attributes['class'][term.name] = term + # subclasses = [strip_name(sb.iri, self.delimiter) for sb in subclasses] + # classes.append(subclasses) + #except: + # term = OntoTerm(c.iri, delimiter=self.delimiter) + # term.node_type ='class' + # self.attributes['class'][term.name] = term + # classes.append([strip_name(c.iri, self.delimiter)]) return classes def _aggregate_keys(self, dd): diff --git a/atomrdf/network/term.py b/atomrdf/network/term.py index 8186658..6fc0f7e 100644 --- a/atomrdf/network/term.py +++ b/atomrdf/network/term.py @@ -91,7 +91,10 @@ def uri(self, val): @property def name_without_prefix(self): - return _get_name(self.uri, self.delimiter) + name = _get_name(self.uri, self.delimiter) + name = name.replace('–', '') + name = name.replace('-', '') + return name @property def name(self): @@ -142,6 +145,9 @@ def query_name_without_prefix(self): return self.name_without_prefix + "value" return self.name_without_prefix + def toPython(self): + return self.uri + def __repr__(self): return str(self.name) diff --git a/atomrdf/structure.py b/atomrdf/structure.py index 58b1672..0cef9e9 100644 --- a/atomrdf/structure.py +++ b/atomrdf/structure.py @@ -21,11 +21,8 @@ import atomrdf.json_io as json_io import atomrdf.properties as prp -from rdflib import Graph, Literal, Namespace, XSD, RDF, RDFS, BNode, URIRef, FOAF, SKOS, DCTERMS - -CMSO = Namespace("http://purls.helmholtz-metadaten.de/cmso/") -PLDO = Namespace("http://purls.helmholtz-metadaten.de/pldo/") -PODO = Namespace("http://purls.helmholtz-metadaten.de/podo/") +from rdflib import Graph, Literal, Namespace, XSD, RDF, RDFS, BNode, URIRef +from atomrdf.namespace import CMSO, PLDO, PODO #read element data file file_location = os.path.dirname(__file__).split('/') @@ -257,37 +254,37 @@ def delete(self, ids=None, indices=None, condition=None, selection=False): c = (val/self.natoms) self.add_vacancy(c, number=val) #now we need to re-add atoms, so at to remove - self.graph.graph.remove((self.sample, CMSO.hasNumberOfAtoms, None)) - self.graph.graph.add((self.sample, CMSO.hasNumberOfAtoms, Literal(actual_natoms-val, datatype=XSD.integer))) + self.graph.remove((self.sample, CMSO.hasNumberOfAtoms, None)) + self.graph.add((self.sample, CMSO.hasNumberOfAtoms, Literal(actual_natoms-val, datatype=XSD.integer))) #revamp composition #remove existing chem composution - chemical_species = self.graph.graph.value(self.sample, CMSO.hasSpecies) + chemical_species = self.graph.value(self.sample, CMSO.hasSpecies) #start by cleanly removing elements - for s in self.graph.graph.triples((chemical_species, CMSO.hasElement, None)): + for s in self.graph.triples((chemical_species, CMSO.hasElement, None)): element = s[2] - self.graph.graph.remove((element, None, None)) - self.graph.graph.remove((chemical_species, None, None)) - self.graph.graph.remove((self.sample, CMSO.hasSpecies, None)) + self.graph.remove((element, None, None)) + self.graph.remove((chemical_species, None, None)) + self.graph.remove((self.sample, CMSO.hasSpecies, None)) #now recalculate and add it again composition = self.schema.material.element_ratio() chemical_species = URIRef(f'{self._name}_ChemicalSpecies') - self.graph.graph.add((self.sample, CMSO.hasSpecies, chemical_species)) - self.graph.graph.add((chemical_species, RDF.type, CMSO.ChemicalSpecies)) + self.graph.add((self.sample, CMSO.hasSpecies, chemical_species)) + self.graph.add((chemical_species, RDF.type, CMSO.ChemicalSpecies)) for e, r in composition.items(): if e in element_indetifiers.keys(): element = URIRef(element_indetifiers[e]) self.graph.add((chemical_species, CMSO.hasElement, element)) - self.graph.add((element, RDF.type, CMSO.Element)) + self.graph.add((element, RDF.type, CMSO.ChemicalElement)) self.graph.add((element, CMSO.hasSymbol, Literal(e, datatype=XSD.string))) self.graph.add((element, CMSO.hasElementRatio, Literal(r, datatype=XSD.float))) #we also have to read in file and clean it up - filepath = self.graph.graph.value(URIRef(f'{self.sample}_Position'), CMSO.hasPath).toPython() - position_identifier = self.graph.graph.value(URIRef(f'{self.sample}_Position'), CMSO.hasIdentifier).toPython() - species_identifier = self.graph.graph.value(URIRef(f'{self.sample}_Species'), CMSO.hasIdentifier).toPython() + filepath = self.graph.value(URIRef(f'{self.sample}_Position'), CMSO.hasPath).toPython() + position_identifier = self.graph.value(URIRef(f'{self.sample}_Position'), CMSO.hasIdentifier).toPython() + species_identifier = self.graph.value(URIRef(f'{self.sample}_Species'), CMSO.hasIdentifier).toPython() #clean up items datadict = { @@ -321,33 +318,33 @@ def substitute_atoms(self, substitution_element, ids=None, indices=None, conditi #operate on the graph if self.graph is not None: - chemical_species = self.graph.graph.value(self.sample, CMSO.hasSpecies) + chemical_species = self.graph.value(self.sample, CMSO.hasSpecies) #start by cleanly removing elements - for s in self.graph.graph.triples((chemical_species, CMSO.hasElement, None)): + for s in self.graph.triples((chemical_species, CMSO.hasElement, None)): element = s[2] - self.graph.graph.remove((element, None, None)) - self.graph.graph.remove((chemical_species, None, None)) - self.graph.graph.remove((self.sample, CMSO.hasSpecies, None)) + self.graph.remove((element, None, None)) + self.graph.remove((chemical_species, None, None)) + self.graph.remove((self.sample, CMSO.hasSpecies, None)) #now recalculate and add it again composition = self.schema.material.element_ratio() chemical_species = URIRef(f'{self._name}_ChemicalSpecies') - self.graph.graph.add((self.sample, CMSO.hasSpecies, chemical_species)) - self.graph.graph.add((chemical_species, RDF.type, CMSO.ChemicalSpecies)) + self.graph.add((self.sample, CMSO.hasSpecies, chemical_species)) + self.graph.add((chemical_species, RDF.type, CMSO.ChemicalSpecies)) for e, r in composition.items(): if e in element_indetifiers.keys(): element = URIRef(element_indetifiers[e]) self.graph.add((chemical_species, CMSO.hasElement, element)) - self.graph.add((element, RDF.type, CMSO.Element)) + self.graph.add((element, RDF.type, CMSO.ChemicalElement)) self.graph.add((element, CMSO.hasSymbol, Literal(e, datatype=XSD.string))) self.graph.add((element, CMSO.hasElementRatio, Literal(r, datatype=XSD.float))) #we also have to read in file and clean it up - filepath = self.graph.graph.value(URIRef(f'{self.sample}_Position'), CMSO.hasPath).toPython() - position_identifier = self.graph.graph.value(URIRef(f'{self.sample}_Position'), CMSO.hasIdentifier).toPython() - species_identifier = self.graph.graph.value(URIRef(f'{self.sample}_Species'), CMSO.hasIdentifier).toPython() + filepath = self.graph.value(URIRef(f'{self.sample}_Position'), CMSO.hasPath).toPython() + position_identifier = self.graph.value(URIRef(f'{self.sample}_Position'), CMSO.hasIdentifier).toPython() + species_identifier = self.graph.value(URIRef(f'{self.sample}_Species'), CMSO.hasIdentifier).toPython() #clean up items datadict = { @@ -441,37 +438,37 @@ def add_interstitial_impurities(self, element, void_type='tetrahedral', lattice_ #now we have to verify the triples correctly and add them in if self.graph is not None: - self.graph.graph.remove((self.sample, CMSO.hasNumberOfAtoms, None)) - self.graph.graph.add((self.sample, CMSO.hasNumberOfAtoms, Literal(sysn.natoms, datatype=XSD.integer))) + self.graph.remove((self.sample, CMSO.hasNumberOfAtoms, None)) + self.graph.add((self.sample, CMSO.hasNumberOfAtoms, Literal(sysn.natoms, datatype=XSD.integer))) #revamp composition #remove existing chem composution - chemical_species = self.graph.graph.value(self.sample, CMSO.hasSpecies) + chemical_species = self.graph.value(self.sample, CMSO.hasSpecies) #start by cleanly removing elements - for s in self.graph.graph.triples((chemical_species, CMSO.hasElement, None)): + for s in self.graph.triples((chemical_species, CMSO.hasElement, None)): element = s[2] - self.graph.graph.remove((element, None, None)) - self.graph.graph.remove((chemical_species, None, None)) - self.graph.graph.remove((self.sample, CMSO.hasSpecies, None)) + self.graph.remove((element, None, None)) + self.graph.remove((chemical_species, None, None)) + self.graph.remove((self.sample, CMSO.hasSpecies, None)) #now recalculate and add it again composition = sysn.schema.material.element_ratio() chemical_species = URIRef(f'{self._name}_ChemicalSpecies') - self.graph.graph.add((self.sample, CMSO.hasSpecies, chemical_species)) - self.graph.graph.add((chemical_species, RDF.type, CMSO.ChemicalSpecies)) + self.graph.add((self.sample, CMSO.hasSpecies, chemical_species)) + self.graph.add((chemical_species, RDF.type, CMSO.ChemicalSpecies)) for e, r in composition.items(): if e in element_indetifiers.keys(): element = URIRef(element_indetifiers[e]) self.graph.add((chemical_species, CMSO.hasElement, element)) - self.graph.add((element, RDF.type, CMSO.Element)) + self.graph.add((element, RDF.type, CMSO.ChemicalElement)) self.graph.add((element, CMSO.hasSymbol, Literal(e, datatype=XSD.string))) self.graph.add((element, CMSO.hasElementRatio, Literal(r, datatype=XSD.float))) #we also have to read in file and clean it up - filepath = self.graph.graph.value(URIRef(f'{self.sample}_Position'), CMSO.hasPath).toPython() - position_identifier = self.graph.graph.value(URIRef(f'{self.sample}_Position'), CMSO.hasIdentifier).toPython() - species_identifier = self.graph.graph.value(URIRef(f'{self.sample}_Species'), CMSO.hasIdentifier).toPython() + filepath = self.graph.value(URIRef(f'{self.sample}_Position'), CMSO.hasPath).toPython() + position_identifier = self.graph.value(URIRef(f'{self.sample}_Position'), CMSO.hasIdentifier).toPython() + species_identifier = self.graph.value(URIRef(f'{self.sample}_Species'), CMSO.hasIdentifier).toPython() #clean up items datadict = { @@ -566,7 +563,7 @@ def _add_chemical_composition(self): if e in element_indetifiers.keys(): element = URIRef(element_indetifiers[e]) self.graph.add((chemical_species, CMSO.hasElement, element)) - self.graph.add((element, RDF.type, CMSO.Element)) + self.graph.add((element, RDF.type, CMSO.ChemicalElement)) self.graph.add((element, CMSO.hasChemicalSymbol, Literal(e, datatype=XSD.string))) self.graph.add((element, CMSO.hasElementRatio, Literal(r, datatype=XSD.float))) @@ -712,7 +709,7 @@ def _add_unit_cell(self): bv = self.schema.material.crystal_structure.unit_cell.bravais_lattice() if bv is not None: bv = URIRef(bv) - self.graph.add((self.unit_cell, CMSO.hasBravaisLattice, bv)) + self.graph.add((self.unit_cell, Namespace("http://purls.helmholtz-metadaten.de/cmso/").hasBravaisLattice, bv)) def _add_lattice_properties(self): """ @@ -788,7 +785,7 @@ def _add_atoms(self): if "positions" in self.atoms.keys(): position = URIRef(f'{self._name}_Position') - self.graph.add((self.sample, CMSO.hasAttribute, position)) + self.graph.add((self.sample, Namespace("http://purls.helmholtz-metadaten.de/cmso/").hasAttribute, position)) self.graph.add((position, RDF.type, CMSO.AtomAttribute)) self.graph.add((position, CMSO.hasName, Literal('Position', datatype=XSD.string))) self.graph.add((position, CMSO.hasIdentifier, Literal(position_identifier, datatype=XSD.string))) @@ -796,7 +793,7 @@ def _add_atoms(self): if "species" in self.atoms.keys(): species = URIRef(f'{self._name}_Species') - self.graph.add((self.sample, CMSO.hasAttribute, species)) + self.graph.add((self.sample, Namespace("http://purls.helmholtz-metadaten.de/cmso/").hasAttribute, species)) self.graph.add((species, RDF.type, CMSO.AtomAttribute)) self.graph.add((species, CMSO.hasName, Literal('Species', datatype=XSD.string))) self.graph.add((species, CMSO.hasIdentifier, Literal(species_identifier, datatype=XSD.string))) @@ -892,7 +889,7 @@ def add_gb(self, gb_dict): self.graph.add((self.material, CMSO.hasDefect, plane_defect)) self.graph.add((plane_defect, PLDO.hasSigmaValue, Literal(gb_dict["sigma"], datatype=XSD.integer))) - self.graph.add((plane_defect, PLDO.hasGBPlane, Literal(gb_dict["GBPlane"], + self.graph.add((plane_defect, PLDO.hasGBplane, Literal(gb_dict["GBPlane"], datatype=XSD.string))) self.graph.add((plane_defect, PLDO.hasRotationAxis, Literal(gb_dict["RotationAxis"], datatype=XSD.string))) diff --git a/atomrdf/workflow/pyiron.py b/atomrdf/workflow/pyiron.py index 255e698..8a01032 100644 --- a/atomrdf/workflow/pyiron.py +++ b/atomrdf/workflow/pyiron.py @@ -51,13 +51,13 @@ def _identify_method(job): if int(input_dict['run']) == 0: method = 'static' md_method = 'MolecularStatics' - ensemble = 'NVE' + ensemble = 'MicrocanonicalEnsemble' elif int(input_dict['run']) > 0: method = 'md_nve' dof.append('AtomicPosition') md_method = 'MolecularDynamics' - ensemble = 'NVE' + ensemble = 'MicrocanonicalEnsemble' elif 'nvt' in input_dict['fix___ensemble']: @@ -66,7 +66,7 @@ def _identify_method(job): temp = float(raw[3]) dof.append('AtomicPosition') md_method = 'MolecularDynamics' - ensemble = 'NVT' + ensemble = 'CanonicalEnsemble' elif 'npt' in input_dict['fix___ensemble']: dof.append('AtomicPosition') @@ -80,7 +80,7 @@ def _identify_method(job): raw = input_dict['fix___ensemble'].split() temp = float(raw[3]) press = float(raw[7]) - ensemble = 'NPT' + ensemble = 'IsothermalisobaricEnsemble' mdict = {} mdict['md'] = {} diff --git a/atomrdf/workflow/workflow.py b/atomrdf/workflow/workflow.py index 6214358..1934944 100644 --- a/atomrdf/workflow/workflow.py +++ b/atomrdf/workflow/workflow.py @@ -26,10 +26,7 @@ from atomrdf.structure import System #Move imports to another file -PROV = Namespace("http://www.w3.org/ns/prov#") -CMSO = Namespace("http://purls.helmholtz-metadaten.de/cmso/") -PODO = Namespace("http://purls.helmholtz-metadaten.de/podo/") -ASO = Namespace("http://purls.helmholtz-metadaten.de/aso/") +from atomrdf.namespace import PROV, CMSO, PODO, ASMO #custom imports as needed import atomrdf.workflow.pyiron as pi @@ -84,63 +81,63 @@ def _add_inherited_properties(self, ): if self.parent_sample is None: return - parent_material = list([k[2] for k in self.kg.graph.triples((self.parent_sample, CMSO.hasMaterial, None))])[0] - parent_defects = list([x[2] for x in self.kg.graph.triples((parent_material, CMSO.hasDefect, None))]) + parent_material = list([k[2] for k in self.kg.triples((self.parent_sample, CMSO.hasMaterial, None))])[0] + parent_defects = list([x[2] for x in self.kg.triples((parent_material, CMSO.hasDefect, None))]) #now for each defect we copy add this to the final sample - material = list([k[2] for k in self.kg.graph.triples((self.sample, CMSO.hasMaterial, None))])[0] + material = list([k[2] for k in self.kg.triples((self.sample, CMSO.hasMaterial, None))])[0] for defect in parent_defects: new_defect = URIRef(defect.toPython()) self.kg.graph.add((material, CMSO.hasDefect, new_defect)) #now fetch all defect based info - for triple in self.kg.graph.triples((defect, None, None)): + for triple in self.kg.triples((defect, None, None)): self.kg.graph.add((new_defect, triple[1], triple[2])) #now add the special props for vacancy - parent_simcell = self.kg.graph.value(self.sample, CMSO.hasSimulationCell) - simcell = self.kg.graph.value(self.parent_sample, CMSO.hasSimulationCell) + parent_simcell = self.kg.value(self.sample, CMSO.hasSimulationCell) + simcell = self.kg.value(self.parent_sample, CMSO.hasSimulationCell) - for triple in self.kg.graph.triples((parent_simcell, PODO.hasVacancyConcentration, None)): + for triple in self.kg.triples((parent_simcell, PODO.hasVacancyConcentration, None)): self.kg.graph.add((simcell, triple[1], triple[2])) - for triple in self.kg.graph.triples((parent_simcell, PODO.hasNumberOfVacancies, None)): + for triple in self.kg.triples((parent_simcell, PODO.hasNumberOfVacancies, None)): self.kg.graph.add((simcell, triple[1], triple[2])) def _get_lattice_properties(self, ): if self.parent_sample is None: return - parent_material = list([k[2] for k in self.kg.graph.triples((self.parent_sample, CMSO.hasMaterial, None))])[0] - parent_crystal_structure = self.kg.graph.value(parent_material, CMSO.hasStructure) - parent_altname = self.kg.graph.value(parent_crystal_structure, CMSO.hasAltName) + parent_material = list([k[2] for k in self.kg.triples((self.parent_sample, CMSO.hasMaterial, None))])[0] + parent_crystal_structure = self.kg.value(parent_material, CMSO.hasStructure) + parent_altname = self.kg.value(parent_crystal_structure, CMSO.hasAltName) #add this to new structure - material = list([k[2] for k in self.kg.graph.triples((self.sample, CMSO.hasMaterial, None))])[0] - crystal_structure = self.kg.graph.value(material, CMSO.hasStructure) + material = list([k[2] for k in self.kg.triples((self.sample, CMSO.hasMaterial, None))])[0] + crystal_structure = self.kg.value(material, CMSO.hasStructure) self.kg.add((crystal_structure, CMSO.hasAltName, parent_altname)) #space group - parent_space_group = self.kg.graph.value(parent_crystal_structure, CMSO.hasSpaceGroup) - space_group = self.kg.graph.value(crystal_structure, CMSO.hasSpaceGroup) - for triple in self.kg.graph.triples((parent_space_group, None, None)): + parent_space_group = self.kg.value(parent_crystal_structure, CMSO.hasSpaceGroup) + space_group = self.kg.value(crystal_structure, CMSO.hasSpaceGroup) + for triple in self.kg.triples((parent_space_group, None, None)): self.kg.graph.add((space_group, triple[1], triple[2])) #unit cell - parent_unit_cell = self.kg.graph.value(parent_crystal_structure, CMSO.hasUnitCell) - parent_bv = self.kg.graph.value(parent_unit_cell, CMSO.hasBravaisLattice) + parent_unit_cell = self.kg.value(parent_crystal_structure, CMSO.hasUnitCell) + parent_bv = self.kg.value(parent_unit_cell, Namespace("http://purls.helmholtz-metadaten.de/cmso/").hasBravaisLattice) - unit_cell = self.kg.graph.value(crystal_structure, CMSO.hasUnitCell) - self.kg.graph.add((unit_cell, CMSO.hasBravaisLattice, parent_bv)) + unit_cell = self.kg.value(crystal_structure, CMSO.hasUnitCell) + self.kg.graph.add((unit_cell, Namespace("http://purls.helmholtz-metadaten.de/cmso/").hasBravaisLattice, parent_bv)) #lattice parameter - parent_lattice_parameter = self.kg.graph.value(parent_unit_cell, CMSO.hasLatticeParameter) - lattice_parameter = self.kg.graph.value(unit_cell, CMSO.hasLatticeParameter) - for triple in self.kg.graph.triples((parent_lattice_parameter, None, None)): + parent_lattice_parameter = self.kg.value(parent_unit_cell, CMSO.hasLatticeParameter) + lattice_parameter = self.kg.value(unit_cell, CMSO.hasLatticeParameter) + for triple in self.kg.triples((parent_lattice_parameter, None, None)): self.kg.graph.add((lattice_parameter, triple[1], triple[2])) #lattice angle - parent_lattice_angle = self.kg.graph.value(parent_unit_cell, CMSO.hasAngle) - lattice_angle = self.kg.graph.value(unit_cell, CMSO.hasAngle) - for triple in self.kg.graph.triples((parent_lattice_angle, None, None)): + parent_lattice_angle = self.kg.value(parent_unit_cell, CMSO.hasAngle) + lattice_angle = self.kg.value(unit_cell, CMSO.hasAngle) + for triple in self.kg.triples((parent_lattice_angle, None, None)): self.kg.graph.add((lattice_angle, triple[1], triple[2])) @@ -202,62 +199,62 @@ def add_method(self, ): if method_type == 'md': method = URIRef(f'method:{main_id}') if mdict['method'] == 'MolecularStatics': - self.kg.add((method, RDF.type, ASO.MolecularStatics)) + self.kg.add((method, RDF.type, ASMO.MolecularStatics)) elif mdict['method'] == 'MolecularDynamics': - self.kg.add((method, RDF.type, ASO.MolecularDynamics)) + self.kg.add((method, RDF.type, ASMO.MolecularDynamics)) elif method_type == 'dft': method = URIRef(f'method:{main_id}') if mdict['method'] == 'DensityFunctionalTheory': - self.kg.add((method, RDF.type, ASO.DensityFunctionalTheory)) - self.kg.add((activity, ASO.hasMethod, method)) + self.kg.add((method, RDF.type, ASMO.DensityFunctionalTheory)) + self.kg.add((activity, ASMO.hasComputationalMethod, method)) if len(mdict['dof']) == 0: - self.kg.add((activity, RDF.type, ASO.RigidEnergyCalculation)) + self.kg.add((activity, RDF.type, ASMO.RigidEnergyCalculation)) else: - self.kg.add((activity, RDF.type, ASO.StructureOptimization)) + self.kg.add((activity, RDF.type, ASMO.StructureOptimization)) for dof in mdict['dof']: - self.kg.add((activity, ASO.hasRelaxationDOF, getattr(ASO, dof))) + self.kg.add((activity, ASMO.hasRelaxationDOF, getattr(ASMO, dof))) if method_type == 'md': - self.kg.add((method, ASO.hasStatisticalEnsemble, getattr(ASO, mdict['ensemble']))) + self.kg.add((method, ASMO.hasStatisticalEnsemble, getattr(ASMO, mdict['ensemble']))) #add temperature if needed if mdict['temperature'] is not None: temperature = URIRef(f'temperature:{main_id}') - self.kg.add((temperature, RDF.type, ASO.InputParameter)) + self.kg.add((temperature, RDF.type, ASMO.InputParameter)) self.kg.add((temperature, RDFS.label, Literal('temperature', datatype=XSD.string))) - self.kg.add((activity, ASO.hasInputParameter, temperature)) - self.kg.add((temperature, ASO.hasValue, Literal(mdict['temperature'], datatype=XSD.float))) - self.kg.add((temperature, ASO.hasUnit, URIRef('http://qudt.org/vocab/unit/K'))) + self.kg.add((activity, ASMO.hasInputParameter, temperature)) + self.kg.add((temperature, ASMO.hasValue, Literal(mdict['temperature'], datatype=XSD.float))) + self.kg.add((temperature, ASMO.hasUnit, URIRef('http://qudt.org/vocab/unit/K'))) if mdict['pressure'] is not None: pressure = URIRef(f'pressure:{main_id}') - self.kg.add((pressure, RDF.type, ASO.InputParameter)) + self.kg.add((pressure, RDF.type, ASMO.InputParameter)) self.kg.add((pressure, RDFS.label, Literal('pressure', datatype=XSD.string))) - self.kg.add((activity, ASO.hasInputParameter, pressure)) - self.kg.add((pressure, ASO.hasValue, Literal(mdict['pressure'], datatype=XSD.float))) - self.kg.add((pressure, ASO.hasUnit, URIRef('http://qudt.org/vocab/unit/GigaPA'))) + self.kg.add((activity, ASMO.hasInputParameter, pressure)) + self.kg.add((pressure, ASMO.hasValue, Literal(mdict['pressure'], datatype=XSD.float))) + self.kg.add((pressure, ASMO.hasUnit, URIRef('http://qudt.org/vocab/unit/GigaPA'))) #potentials need to be mapped potential = URIRef(f'potential:{main_id}') if 'meam' in mdict['potential']['type']: - self.kg.add((potential, RDF.type, ASO.MEAM)) + self.kg.add((potential, RDF.type, ASMO.ModifiedEmbeddedAtomModel)) elif 'eam' in mdict['potential']['type']: - self.kg.add((potential, RDF.type, ASO.EAM)) + self.kg.add((potential, RDF.type, ASMO.EmbeddedAtomModel)) elif 'lj' in mdict['potential']['type']: - self.kg.add((potential, RDF.type, ASO.LennardJones)) + self.kg.add((potential, RDF.type, ASMO.LennardJonesPotential)) elif 'ace' in mdict['potential']['type']: - self.kg.add((potential, RDF.type, ASO.MLPotential)) + self.kg.add((potential, RDF.type, ASMO.MachineLearningPotential)) else: - self.kg.add((potential, RDF.type, ASO.InteratomicPotential)) + self.kg.add((potential, RDF.type, ASMO.InteratomicPotential)) if 'uri' in mdict['potential'].keys(): - self.kg.add((potential, ASO.hasReference, Literal(mdict['potential']['uri']))) + self.kg.add((potential, CMSO.hasReference, Literal(mdict['potential']['uri']))) if 'label' in mdict['potential'].keys(): self.kg.add((potential, RDFS.label, Literal(mdict['potential']['label']))) - self.kg.add((method, ASO.hasInteratomicPotential, potential)) + self.kg.add((method, ASMO.hasInteratomicPotential, potential)) self.kg.add((self.sample, PROV.wasGeneratedBy, activity)) @@ -283,11 +280,11 @@ def add_method(self, ): prop = URIRef(f'{main_id}_{key}') self.kg.add((prop, RDF.type, CMSO.CalculatedProperty)) self.kg.add((prop, RDFS.label, Literal(key))) - self.kg.add((prop, ASO.hasValue, Literal(val["value"]))) + self.kg.add((prop, ASMO.hasValue, Literal(val["value"]))) if "unit" in val.keys(): unit = val['unit'] - self.kg.add((prop, ASO.hasUnit, URIRef(f'http://qudt.org/vocab/unit/{unit}'))) - self.kg.add((prop, CMSO.wasCalculatedBy, activity)) + self.kg.add((prop, ASMO.hasUnit, URIRef(f'http://qudt.org/vocab/unit/{unit}'))) + self.kg.add((prop, ASMO.wasCalculatedBy, activity)) if val['associate_to_sample']: self.kg.add((self.sample, CMSO.hasCalculatedProperty, prop)) diff --git a/examples/01_getting_started.ipynb b/examples/01_getting_started.ipynb index 6a16e36..4b0c35b 100644 --- a/examples/01_getting_started.ipynb +++ b/examples/01_getting_started.ipynb @@ -115,684 +115,684 @@ "\n", "\n", - "\n", - "\n", - "\n", - "\n", + "\n", + "\n", + "\n", + "\n", "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellVector_2\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellVector_2\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_Position\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_Position\n", "\n", - "\n", + "\n", "\n", - "cf27f866-1e2d-4e8e-8113-4bc8db58c1a0\n", - "\n", - "2.87\n", + "b8e7d5ad-f96c-4589-bcb1-e3cce1ca5d0c\n", + "\n", + "Position\n", "\n", - "\n", + "\n", "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellVector_2->cf27f866-1e2d-4e8e-8113-4bc8db58c1a0\n", - "\n", - "\n", - "cmso.hasComponent_y\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_Position->b8e7d5ad-f96c-4589-bcb1-e3cce1ca5d0c\n", + "\n", + "\n", + "cmso.hasName\n", "\n", - "\n", - "\n", - "eff09398-b845-4af8-b07f-aba03a466ce3\n", - "\n", - "0.0\n", + "\n", + "\n", + "f569d83a-6f1d-4cc1-b348-c4cd3a4ed5a0\n", + "\n", + "8Bc122Bf-D66D-4868-Adce-4E933078A807\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellVector_2->eff09398-b845-4af8-b07f-aba03a466ce3\n", - "\n", - "\n", - "cmso.hasComponent_z\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_Position->f569d83a-6f1d-4cc1-b348-c4cd3a4ed5a0\n", + "\n", + "\n", + "cmso.hasIdentifier\n", "\n", - "\n", - "\n", - "6dbff37f-48e3-493d-ae4e-d799c96be735\n", - "\n", - "0.0\n", + "\n", + "\n", + "fbe04f8c-9fd3-4a1d-9be1-8a0b21cc70c6\n", + "\n", + "Rdf_Structure_Store/Ba7B1Ac6-E72C-4B07-Abd2-4B1Db132D563.Json\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellVector_2->6dbff37f-48e3-493d-ae4e-d799c96be735\n", - "\n", - "\n", - "cmso.hasComponent_x\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_Position->fbe04f8c-9fd3-4a1d-9be1-8a0b21cc70c6\n", + "\n", + "\n", + "cmso.hasPath\n", "\n", - "\n", + "\n", "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_Species\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_Species\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_LatticeParameter\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_LatticeParameter\n", "\n", - "\n", + "\n", "\n", - "89f7487a-42bf-4581-8813-23839ffd69e5\n", - "\n", - "Species\n", + "1bed03f8-df16-4f9b-9030-71ad2654ba97\n", + "\n", + "2.87\n", "\n", - "\n", + "\n", "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_Species->89f7487a-42bf-4581-8813-23839ffd69e5\n", - "\n", - "\n", - "cmso.hasName\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_LatticeParameter->1bed03f8-df16-4f9b-9030-71ad2654ba97\n", + "\n", + "\n", + "cmso.hasLength_x\n", "\n", - "\n", - "\n", - "d00c05cc-5443-4313-9598-f8829eaf7b2c\n", - "\n", - "Ea1F11Fc-A7A8-4E59-A63D-5Fe258A28A01\n", + "\n", + "\n", + "ae0521c2-7f78-4f8c-99a0-6c95a7da6127\n", + "\n", + "2.87\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_Species->d00c05cc-5443-4313-9598-f8829eaf7b2c\n", - "\n", - "\n", - "cmso.hasIdentifier\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_LatticeParameter->ae0521c2-7f78-4f8c-99a0-6c95a7da6127\n", + "\n", + "\n", + "cmso.hasLength_y\n", "\n", - "\n", - "\n", - "3bc0708c-567d-4f0e-b192-53307d391977\n", - "\n", - "Rdf_Structure_Store/C91A3F03-A2A6-4C4A-Ae4B-D89B8Ae9427C.Json\n", + "\n", + "\n", + "806fb769-6914-4d60-9907-d960f0594447\n", + "\n", + "2.87\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_Species->3bc0708c-567d-4f0e-b192-53307d391977\n", - "\n", - "\n", - "cmso.hasPath\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_LatticeParameter->806fb769-6914-4d60-9907-d960f0594447\n", + "\n", + "\n", + "cmso.hasLength_z\n", "\n", - "\n", + "\n", "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_Species\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_Species\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c->sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_Species\n", - "\n", - "\n", - "cmso.hasAttribute\n", - "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCell\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCell\n", + "\n", + "\n", + "909ed4b8-c9e8-44ce-b126-a146f2d44d3f\n", + "\n", + "Rdf_Structure_Store/Ba7B1Ac6-E72C-4B07-Abd2-4B1Db132D563.Json\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c->sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCell\n", - "\n", - "\n", - "cmso.hasSimulationCell\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_Species->909ed4b8-c9e8-44ce-b126-a146f2d44d3f\n", + "\n", + "\n", + "cmso.hasPath\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_Material\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_Material\n", + "\n", + "\n", + "fb07e6a8-976d-4614-a92b-9dea7589043d\n", + "\n", + "C1Afc46E-F7F2-4F82-A8Ab-74A06A4536Ca\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c->sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_Material\n", - "\n", - "\n", - "cmso.hasMaterial\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_Species->fb07e6a8-976d-4614-a92b-9dea7589043d\n", + "\n", + "\n", + "cmso.hasIdentifier\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_Position\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_Position\n", + "\n", + "\n", + "cd3254ca-1bbc-4296-beeb-822152956fcd\n", + "\n", + "Species\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c->sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_Position\n", - "\n", - "\n", - "cmso.hasAttribute\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_Species->cd3254ca-1bbc-4296-beeb-822152956fcd\n", + "\n", + "\n", + "cmso.hasName\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_ChemicalSpecies\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_ChemicalSpecies\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellLength\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellLength\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c->sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_ChemicalSpecies\n", - "\n", - "\n", - "cmso.hasSpecies\n", + "\n", + "\n", + "3a91f0d2-1e37-4f2d-aa1c-c9e1bca9aa83\n", + "\n", + "2.87\n", "\n", - "\n", - "\n", - "39a8d450-eaef-4cbf-99cd-605ef6decc83\n", - "\n", - "2\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellLength->3a91f0d2-1e37-4f2d-aa1c-c9e1bca9aa83\n", + "\n", + "\n", + "cmso.hasLength_z\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c->39a8d450-eaef-4cbf-99cd-605ef6decc83\n", - "\n", - "\n", - "cmso.hasNumberOfAtoms\n", + "\n", + "\n", + "964bc111-a94e-49ab-9649-7367636d2dc8\n", + "\n", + "2.87\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellVector_1\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellVector_1\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellLength->964bc111-a94e-49ab-9649-7367636d2dc8\n", + "\n", + "\n", + "cmso.hasLength_x\n", "\n", - "\n", - "\n", - "b584b72e-9680-4131-b58a-b0d1575a3392\n", - "\n", - "0.0\n", + "\n", + "\n", + "5034f1d6-498d-4d82-bfb9-25a9946892b2\n", + "\n", + "2.87\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellVector_1->b584b72e-9680-4131-b58a-b0d1575a3392\n", - "\n", - "\n", - "cmso.hasComponent_z\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellLength->5034f1d6-498d-4d82-bfb9-25a9946892b2\n", + "\n", + "\n", + "cmso.hasLength_y\n", "\n", - "\n", + "\n", "\n", - "cacaa994-00bd-4f0a-9000-de7e1a4f11b0\n", - "\n", - "2.87\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_LatticeAngle\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_LatticeAngle\n", "\n", - "\n", + "\n", + "\n", + "d2d98574-605f-4529-8752-c3a12cbd2a06\n", + "\n", + "90.0\n", + "\n", + "\n", "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellVector_1->cacaa994-00bd-4f0a-9000-de7e1a4f11b0\n", - "\n", - "\n", - "cmso.hasComponent_x\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_LatticeAngle->d2d98574-605f-4529-8752-c3a12cbd2a06\n", + "\n", + "\n", + "cmso.hasAngle_alpha\n", "\n", - "\n", - "\n", - "2de0fcd3-acc1-4c3a-9206-6240e3b82b47\n", - "\n", - "0.0\n", + "\n", + "\n", + "427a6a98-9d98-4c45-a40e-12291f746afd\n", + "\n", + "90.0\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellVector_1->2de0fcd3-acc1-4c3a-9206-6240e3b82b47\n", - "\n", - "\n", - "cmso.hasComponent_y\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_LatticeAngle->427a6a98-9d98-4c45-a40e-12291f746afd\n", + "\n", + "\n", + "cmso.hasAngle_beta\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellAngle\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellAngle\n", + "\n", + "\n", + "0bdfa4a6-fe5c-4316-b1a9-32af3e6b0da5\n", + "\n", + "90.0\n", "\n", - "\n", - "\n", - "7ec331ed-4588-4427-b14e-3352361e8248\n", - "\n", - "90.0\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_LatticeAngle->0bdfa4a6-fe5c-4316-b1a9-32af3e6b0da5\n", + "\n", + "\n", + "cmso.hasAngle_gamma\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellAngle->7ec331ed-4588-4427-b14e-3352361e8248\n", - "\n", - "\n", - "cmso.hasAngle_alpha\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563\n", "\n", - "\n", - "\n", - "b81639ea-6b94-4818-9345-acc54b14c6bd\n", - "\n", - "90.0\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563->sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_Position\n", + "\n", + "\n", + "cmso.hasAttribute\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellAngle->b81639ea-6b94-4818-9345-acc54b14c6bd\n", - "\n", - "\n", - "cmso.hasAngle_gamma\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563->sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_Species\n", + "\n", + "\n", + "cmso.hasAttribute\n", "\n", - "\n", - "\n", - "75c49cbc-bab8-49ce-9a33-60d2eb9e8c9f\n", - "\n", - "90.0\n", + "\n", + "\n", + "999027ba-3551-4ca5-8488-9af31856b31f\n", + "\n", + "2\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellAngle->75c49cbc-bab8-49ce-9a33-60d2eb9e8c9f\n", - "\n", - "\n", - "cmso.hasAngle_beta\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563->999027ba-3551-4ca5-8488-9af31856b31f\n", + "\n", + "\n", + "cmso.hasNumberOfAtoms\n", "\n", - "\n", - "\n", - "CHEBI.18248\n", - "\n", - "CHEBI.18248\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_Material\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_Material\n", "\n", - "\n", - "\n", - "dc348cf0-3bd3-4990-a318-b96c2fb010f5\n", - "\n", - "Fe\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563->sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_Material\n", + "\n", + "\n", + "cmso.hasMaterial\n", "\n", - "\n", - "\n", - "CHEBI.18248->dc348cf0-3bd3-4990-a318-b96c2fb010f5\n", - "\n", - "\n", - "cmso.hasChemicalSymbol\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCell\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCell\n", "\n", - "\n", - "\n", - "49b68ce5-1c67-4f82-86b0-26eecdfc1965\n", - "\n", - "1.0\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563->sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCell\n", + "\n", + "\n", + "cmso.hasSimulationCell\n", "\n", - "\n", - "\n", - "CHEBI.18248->49b68ce5-1c67-4f82-86b0-26eecdfc1965\n", - "\n", - "\n", - "cmso.hasElementRatio\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_ChemicalSpecies\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_ChemicalSpecies\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellLength\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellLength\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563->sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_ChemicalSpecies\n", + "\n", + "\n", + "cmso.hasSpecies\n", "\n", - "\n", - "\n", - "dfd8f163-f2dd-41ba-9b57-ed0d682d1134\n", - "\n", - "2.87\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellVector_3\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellVector_3\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellLength->dfd8f163-f2dd-41ba-9b57-ed0d682d1134\n", - "\n", - "\n", - "cmso.hasLength_x\n", + "\n", + "\n", + "986ba84e-b7c8-4f84-9b25-2d827615ad30\n", + "\n", + "0.0\n", "\n", - "\n", - "\n", - "b6541c08-dc70-45d2-8ff5-5f220368e105\n", - "\n", - "2.87\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellVector_3->986ba84e-b7c8-4f84-9b25-2d827615ad30\n", + "\n", + "\n", + "cmso.hasComponent_y\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellLength->b6541c08-dc70-45d2-8ff5-5f220368e105\n", - "\n", - "\n", - "cmso.hasLength_y\n", + "\n", + "\n", + "3c148a10-0cf0-49eb-ac92-b04209d4dbe6\n", + "\n", + "2.87\n", "\n", - "\n", - "\n", - "fd061cc0-868d-43a8-9719-db713cc38d52\n", - "\n", - "2.87\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellVector_3->3c148a10-0cf0-49eb-ac92-b04209d4dbe6\n", + "\n", + "\n", + "cmso.hasComponent_z\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellLength->fd061cc0-868d-43a8-9719-db713cc38d52\n", - "\n", - "\n", - "cmso.hasLength_z\n", + "\n", + "\n", + "40251ddb-ae28-458d-a9aa-33c7a794c85d\n", + "\n", + "0.0\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellVector_3\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellVector_3\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellVector_3->40251ddb-ae28-458d-a9aa-33c7a794c85d\n", + "\n", + "\n", + "cmso.hasComponent_x\n", "\n", - "\n", - "\n", - "2e4a328a-16fb-43dd-a477-3e0462e83861\n", - "\n", - "2.87\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellVector_2\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellVector_2\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellVector_3->2e4a328a-16fb-43dd-a477-3e0462e83861\n", - "\n", - "\n", - "cmso.hasComponent_z\n", + "\n", + "\n", + "c31f89a4-a898-41d8-b2d4-62cbb4e8e913\n", + "\n", + "0.0\n", "\n", - "\n", - "\n", - "812ab8f5-8597-4b4b-be67-e8d230743eb3\n", - "\n", - "0.0\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellVector_2->c31f89a4-a898-41d8-b2d4-62cbb4e8e913\n", + "\n", + "\n", + "cmso.hasComponent_z\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellVector_3->812ab8f5-8597-4b4b-be67-e8d230743eb3\n", - "\n", - "\n", - "cmso.hasComponent_x\n", + "\n", + "\n", + "372c3d80-9357-4299-a4b3-68d074aaa41e\n", + "\n", + "0.0\n", "\n", - "\n", - "\n", - "996722d6-d6ca-4ca2-85f3-c93b712f71c2\n", - "\n", - "0.0\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellVector_2->372c3d80-9357-4299-a4b3-68d074aaa41e\n", + "\n", + "\n", + "cmso.hasComponent_x\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellVector_3->996722d6-d6ca-4ca2-85f3-c93b712f71c2\n", - "\n", - "\n", - "cmso.hasComponent_y\n", + "\n", + "\n", + "d22e9cba-7e44-4ea4-bd15-c77d300faf24\n", + "\n", + "2.87\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_LatticeParameter\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_LatticeParameter\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellVector_2->d22e9cba-7e44-4ea4-bd15-c77d300faf24\n", + "\n", + "\n", + "cmso.hasComponent_y\n", "\n", - "\n", - "\n", - "e274b296-a0b9-4913-8ad8-b2b7e683c39b\n", - "\n", - "2.87\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_CrystalStructure\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_CrystalStructure\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_LatticeParameter->e274b296-a0b9-4913-8ad8-b2b7e683c39b\n", - "\n", - "\n", - "cmso.hasLength_x\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_Material->sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_CrystalStructure\n", + "\n", + "\n", + "cmso.hasStructure\n", "\n", - "\n", - "\n", - "56f99747-6056-4213-a714-9da0e2867034\n", - "\n", - "2.87\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCell->sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellLength\n", + "\n", + "\n", + "cmso.hasLength\n", "\n", - "\n", + "\n", "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_LatticeParameter->56f99747-6056-4213-a714-9da0e2867034\n", - "\n", - "\n", - "cmso.hasLength_y\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCell->sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellVector_3\n", + "\n", + "\n", + "cmso.hasVector\n", "\n", - "\n", - "\n", - "9e941dec-cb35-42a2-a0e9-792de7580421\n", - "\n", - "2.87\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCell->sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellVector_2\n", + "\n", + "\n", + "cmso.hasVector\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_LatticeParameter->9e941dec-cb35-42a2-a0e9-792de7580421\n", - "\n", - "\n", - "cmso.hasLength_z\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellAngle\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellAngle\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCell->sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellVector_2\n", - "\n", - "\n", - "cmso.hasVector\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCell->sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellAngle\n", + "\n", + "\n", + "cmso.hasAngle\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCell->sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellVector_1\n", - "\n", - "\n", - "cmso.hasVector\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellVector_1\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellVector_1\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCell->sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellAngle\n", - "\n", - "\n", - "cmso.hasAngle\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCell->sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellVector_1\n", + "\n", + "\n", + "cmso.hasVector\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCell->sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellLength\n", - "\n", - "\n", - "cmso.hasLength\n", + "\n", + "\n", + "9e2f70e4-2475-4226-a3f3-51da17718dd3\n", + "\n", + "23.64\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCell->sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellVector_3\n", - "\n", - "\n", - "cmso.hasVector\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCell->9e2f70e4-2475-4226-a3f3-51da17718dd3\n", + "\n", + "\n", + "cmso.hasVolume\n", "\n", - "\n", - "\n", - "a1468bc0-5318-4239-9212-5e2e49138cc1\n", - "\n", - "23.64\n", + "\n", + "\n", + "3f65d6de-b165-46f4-8e86-3f0f65852d53\n", + "\n", + "90.0\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCell->a1468bc0-5318-4239-9212-5e2e49138cc1\n", - "\n", - "\n", - "cmso.hasVolume\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellAngle->3f65d6de-b165-46f4-8e86-3f0f65852d53\n", + "\n", + "\n", + "cmso.hasAngle_alpha\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_CrystalStructure\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_CrystalStructure\n", + "\n", + "\n", + "2702bde3-bec6-4340-9426-7c5e7f760244\n", + "\n", + "90.0\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_Material->sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_CrystalStructure\n", - "\n", - "\n", - "cmso.hasStructure\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellAngle->2702bde3-bec6-4340-9426-7c5e7f760244\n", + "\n", + "\n", + "cmso.hasAngle_beta\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SpaceGroup\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SpaceGroup\n", + "\n", + "\n", + "d208829b-9df7-44b5-8d1a-4725e0629035\n", + "\n", + "90.0\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_CrystalStructure->sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SpaceGroup\n", - "\n", - "\n", - "cmso.hasSpaceGroup\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellAngle->d208829b-9df7-44b5-8d1a-4725e0629035\n", + "\n", + "\n", + "cmso.hasAngle_gamma\n", "\n", - "\n", + "\n", "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_UnitCell\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_UnitCell\n", - "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_CrystalStructure->sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_UnitCell\n", - "\n", - "\n", - "cmso.hasUnitCell\n", + "c2afae52-4df2-486f-8292-65e71d1aeafc\n", + "\n", + "0.0\n", "\n", - "\n", - "\n", - "06ae9c50-c81f-414f-b9d1-21fb271e9679\n", - "\n", - "Bcc\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellVector_1->c2afae52-4df2-486f-8292-65e71d1aeafc\n", + "\n", + "\n", + "cmso.hasComponent_z\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_CrystalStructure->06ae9c50-c81f-414f-b9d1-21fb271e9679\n", - "\n", - "\n", - "cmso.hasAltName\n", + "\n", + "\n", + "ae3fb317-8217-4e60-bf2c-ad7610f80f02\n", + "\n", + "0.0\n", "\n", - "\n", - "\n", - "6a3ea978-0213-4ba3-a926-022049850d08\n", - "\n", - "229\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellVector_1->ae3fb317-8217-4e60-bf2c-ad7610f80f02\n", + "\n", + "\n", + "cmso.hasComponent_y\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SpaceGroup->6a3ea978-0213-4ba3-a926-022049850d08\n", - "\n", - "\n", - "cmso.hasSpaceGroupNumber\n", + "\n", + "\n", + "373d3771-4dd7-46e2-8d98-1510bf40dae1\n", + "\n", + "2.87\n", "\n", - "\n", - "\n", - "088b4a59-ee27-4334-a46a-6e059bdfcfec\n", - "\n", - "Im-3M\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellVector_1->373d3771-4dd7-46e2-8d98-1510bf40dae1\n", + "\n", + "\n", + "cmso.hasComponent_x\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SpaceGroup->088b4a59-ee27-4334-a46a-6e059bdfcfec\n", - "\n", - "\n", - "cmso.hasSpaceGroupSymbol\n", + "\n", + "\n", + "97c02052-6667-4ba7-af0a-457c4f321986\n", + "\n", + "Bcc\n", "\n", - "\n", - "\n", - "2e94ae13-ec23-456e-90d1-1e4bb8f31c5b\n", - "\n", - "Position\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_CrystalStructure->97c02052-6667-4ba7-af0a-457c4f321986\n", + "\n", + "\n", + "cmso.hasAltName\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_Position->2e94ae13-ec23-456e-90d1-1e4bb8f31c5b\n", - "\n", - "\n", - "cmso.hasName\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_UnitCell\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_UnitCell\n", "\n", - "\n", - "\n", - "bcad0372-9d43-463e-9014-4361ecf5efce\n", - "\n", - "Rdf_Structure_Store/C91A3F03-A2A6-4C4A-Ae4B-D89B8Ae9427C.Json\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_CrystalStructure->sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_UnitCell\n", + "\n", + "\n", + "cmso.hasUnitCell\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_Position->bcad0372-9d43-463e-9014-4361ecf5efce\n", - "\n", - "\n", - "cmso.hasPath\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SpaceGroup\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SpaceGroup\n", "\n", - "\n", - "\n", - "b0bac27a-230a-42d0-9a3b-ca118d680cd5\n", - "\n", - "03882Cdc-690B-4Fed-84A9-5D39B735D3B0\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_CrystalStructure->sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SpaceGroup\n", + "\n", + "\n", + "cmso.hasSpaceGroup\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_Position->b0bac27a-230a-42d0-9a3b-ca118d680cd5\n", - "\n", - "\n", - "cmso.hasIdentifier\n", + "\n", + "\n", + "CHEBI.18248\n", + "\n", + "CHEBI.18248\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_UnitCell->sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_LatticeParameter\n", - "\n", - "\n", - "cmso.hasLatticeParameter\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_ChemicalSpecies->CHEBI.18248\n", + "\n", + "\n", + "cmso.hasElement\n", "\n", - "\n", + "\n", "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_LatticeAngle\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_LatticeAngle\n", + "d7c3616e-e837-48c5-a8aa-e9031fa6461f\n", + "\n", + "1.0\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_UnitCell->sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_LatticeAngle\n", - "\n", - "\n", - "cmso.hasAngle\n", - "\n", - "\n", - "\n", - "wiki.Q851536\n", - "\n", - "wiki.Q851536\n", + "\n", + "\n", + "CHEBI.18248->d7c3616e-e837-48c5-a8aa-e9031fa6461f\n", + "\n", + "\n", + "cmso.hasElementRatio\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_UnitCell->wiki.Q851536\n", - "\n", - "\n", - "cmso.hasBravaisLattice\n", + "\n", + "\n", + "1be096a2-de1d-48a1-9d6d-de8c5ee7839e\n", + "\n", + "Fe\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_ChemicalSpecies->CHEBI.18248\n", - "\n", - "\n", - "cmso.hasElement\n", + "\n", + "\n", + "CHEBI.18248->1be096a2-de1d-48a1-9d6d-de8c5ee7839e\n", + "\n", + "\n", + "cmso.hasChemicalSymbol\n", "\n", - "\n", - "\n", - "b971be77-d7c7-4d68-ae9c-1753bbf83e2d\n", - "\n", - "90.0\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_UnitCell->sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_LatticeParameter\n", + "\n", + "\n", + "cmso.hasLatticeParameter\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_LatticeAngle->b971be77-d7c7-4d68-ae9c-1753bbf83e2d\n", - "\n", - "\n", - "cmso.hasAngle_beta\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_UnitCell->sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_LatticeAngle\n", + "\n", + "\n", + "cmso.hasAngle\n", "\n", - "\n", - "\n", - "42fa7b42-4fad-4690-bdf4-e0260c60c699\n", - "\n", - "90.0\n", + "\n", + "\n", + "wiki.Q851536\n", + "\n", + "wiki.Q851536\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_LatticeAngle->42fa7b42-4fad-4690-bdf4-e0260c60c699\n", - "\n", - "\n", - "cmso.hasAngle_alpha\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_UnitCell->wiki.Q851536\n", + "\n", + "\n", + "cmso.hasBravaisLattice\n", "\n", - "\n", + "\n", "\n", - "96382082-0b9a-4eee-a759-20cc89fde7e6\n", - "\n", - "90.0\n", + "62eb30c1-a9b7-4f42-a327-b2ade570b7e5\n", + "\n", + "Im-3M\n", + "\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SpaceGroup->62eb30c1-a9b7-4f42-a327-b2ade570b7e5\n", + "\n", + "\n", + "cmso.hasSpaceGroupSymbol\n", + "\n", + "\n", + "\n", + "7b433011-15be-4a91-b9ce-74198480c778\n", + "\n", + "229\n", "\n", - "\n", + "\n", "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_LatticeAngle->96382082-0b9a-4eee-a759-20cc89fde7e6\n", - "\n", - "\n", - "cmso.hasAngle_gamma\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SpaceGroup->7b433011-15be-4a91-b9ce-74198480c778\n", + "\n", + "\n", + "cmso.hasSpaceGroupNumber\n", "\n", "\n", "\n" ], "text/plain": [ - "" + "" ] }, "execution_count": 4, @@ -860,2055 +860,2055 @@ "\n", "\n", - "\n", - "\n", - "\n", - "\n", + "\n", + "\n", + "\n", + "\n", "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellVector_2\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellVector_2\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_Position\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_Position\n", "\n", - "\n", + "\n", "\n", - "8e49b017-fc3e-4928-9a21-ab9ed7e183ef\n", - "\n", - "2.87\n", + "27384531-74c4-461d-9ce2-659506ccd28d\n", + "\n", + "Position\n", "\n", - "\n", + "\n", "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellVector_2->8e49b017-fc3e-4928-9a21-ab9ed7e183ef\n", - "\n", - "\n", - "cmso.hasComponent_y\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_Position->27384531-74c4-461d-9ce2-659506ccd28d\n", + "\n", + "\n", + "cmso.hasName\n", "\n", - "\n", - "\n", - "add6065a-6a09-4bce-9c7e-32451b3fbac7\n", - "\n", - "0.0\n", + "\n", + "\n", + "cb0c5eae-bad5-46c5-b50f-a8b0c7cd5cf3\n", + "\n", + "E8634432-0Ce9-4637-87F5-C491220D1E88\n", "\n", - "\n", + "\n", "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellVector_2->add6065a-6a09-4bce-9c7e-32451b3fbac7\n", - "\n", - "\n", - "cmso.hasComponent_z\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_Position->cb0c5eae-bad5-46c5-b50f-a8b0c7cd5cf3\n", + "\n", + "\n", + "cmso.hasIdentifier\n", "\n", - "\n", - "\n", - "3658f606-d702-4c2f-b85d-42748a717da8\n", - "\n", - "0.0\n", + "\n", + "\n", + "c0cfd347-3020-45c5-b399-a6c8f6f8a47c\n", + "\n", + "Rdf_Structure_Store/92F0563E-9D7A-4A39-9C15-D909318Feaf3.Json\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellVector_2->3658f606-d702-4c2f-b85d-42748a717da8\n", - "\n", - "\n", - "cmso.hasComponent_x\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_Position->c0cfd347-3020-45c5-b399-a6c8f6f8a47c\n", + "\n", + "\n", + "cmso.hasPath\n", "\n", - "\n", + "\n", "\n", - "CHEBI.28984\n", - "\n", - "CHEBI.28984\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_LatticeParameter\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_LatticeParameter\n", "\n", - "\n", + "\n", "\n", - "8980d6d6-f062-4997-a009-47b9589e90d7\n", - "\n", - "0.25\n", + "716725b6-a6cd-4bbe-bd3e-b998939cad18\n", + "\n", + "2.87\n", "\n", - "\n", + "\n", "\n", - "CHEBI.28984->8980d6d6-f062-4997-a009-47b9589e90d7\n", - "\n", - "\n", - "cmso.hasElementRatio\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_LatticeParameter->716725b6-a6cd-4bbe-bd3e-b998939cad18\n", + "\n", + "\n", + "cmso.hasLength_y\n", "\n", - "\n", - "\n", - "91fc7793-2e23-4246-a869-e738ae8e3a12\n", - "\n", - "Al\n", + "\n", + "\n", + "29525f82-0997-4506-9b86-f056361d8027\n", + "\n", + "2.87\n", "\n", - "\n", - "\n", - "CHEBI.28984->91fc7793-2e23-4246-a869-e738ae8e3a12\n", - "\n", - "\n", - "cmso.hasChemicalSymbol\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_LatticeParameter->29525f82-0997-4506-9b86-f056361d8027\n", + "\n", + "\n", + "cmso.hasLength_z\n", + "\n", + "\n", + "\n", + "60327cb2-0015-4555-8398-480e2c935c08\n", + "\n", + "2.87\n", + "\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_LatticeParameter->60327cb2-0015-4555-8398-480e2c935c08\n", + "\n", + "\n", + "cmso.hasLength_x\n", "\n", - "\n", + "\n", "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_Species\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_Species\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellLength\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellLength\n", "\n", - "\n", + "\n", "\n", - "8d91726a-338a-4f11-889c-67a389e5d0ef\n", - "\n", - "Rdf_Structure_Store/4E73Fc35-0B29-4588-8Bc8-C94E93B57Ee0.Json\n", + "e937222e-3bdc-4745-8b5b-705c494de4be\n", + "\n", + "2.87\n", "\n", - "\n", + "\n", "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_Species->8d91726a-338a-4f11-889c-67a389e5d0ef\n", - "\n", - "\n", - "cmso.hasPath\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellLength->e937222e-3bdc-4745-8b5b-705c494de4be\n", + "\n", + "\n", + "cmso.hasLength_z\n", "\n", - "\n", - "\n", - "4bedc5e5-4980-4fc8-9302-0efe9915d253\n", - "\n", - "Species\n", + "\n", + "\n", + "b91099b7-1170-4e0b-ab1b-4cd5d08668d2\n", + "\n", + "2.87\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_Species->4bedc5e5-4980-4fc8-9302-0efe9915d253\n", - "\n", - "\n", - "cmso.hasName\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellLength->b91099b7-1170-4e0b-ab1b-4cd5d08668d2\n", + "\n", + "\n", + "cmso.hasLength_x\n", "\n", - "\n", - "\n", - "c928c7a9-c402-46ca-a10c-e222144cb452\n", - "\n", - "71E90146-A7B8-4Ac9-9Eb6-A06157Ffad78\n", + "\n", + "\n", + "eee10357-3173-4a3b-8c05-67fe46694185\n", + "\n", + "2.87\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_Species->c928c7a9-c402-46ca-a10c-e222144cb452\n", - "\n", - "\n", - "cmso.hasIdentifier\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellLength->eee10357-3173-4a3b-8c05-67fe46694185\n", + "\n", + "\n", + "cmso.hasLength_y\n", "\n", - "\n", + "\n", "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_Position\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_Position\n", "\n", - "\n", + "\n", "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_Species\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_Species\n", + "688d2358-2ef4-4933-a18a-54bbf62ac346\n", + "\n", + "Position\n", "\n", - "\n", + "\n", "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c->sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_Species\n", - "\n", - "\n", - "cmso.hasAttribute\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_Position->688d2358-2ef4-4933-a18a-54bbf62ac346\n", + "\n", + "\n", + "cmso.hasName\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCell\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCell\n", + "\n", + "\n", + "b11a0e52-5dfe-4c1b-96cc-15c361cdbe19\n", + "\n", + "66Daeb74-Bc32-4B4F-Bb04-Caa79Ab71C16\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c->sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCell\n", - "\n", - "\n", - "cmso.hasSimulationCell\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_Position->b11a0e52-5dfe-4c1b-96cc-15c361cdbe19\n", + "\n", + "\n", + "cmso.hasIdentifier\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_Position\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_Position\n", + "\n", + "\n", + "c31ff5ac-1f82-4119-abcb-3b86ac14c025\n", + "\n", + "Rdf_Structure_Store/08B4Ced3-F682-4804-Abb2-53B441995321.Json\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c->sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_Position\n", - "\n", - "\n", - "cmso.hasAttribute\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_Position->c31ff5ac-1f82-4119-abcb-3b86ac14c025\n", + "\n", + "\n", + "cmso.hasPath\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_Material\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_Material\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SimulationCell\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SimulationCell\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c->sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_Material\n", - "\n", - "\n", - "cmso.hasMaterial\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SimulationCellAngle\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SimulationCellAngle\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_ChemicalSpecies\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_ChemicalSpecies\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SimulationCell->sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SimulationCellAngle\n", + "\n", + "\n", + "cmso.hasAngle\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c->sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_ChemicalSpecies\n", - "\n", - "\n", - "cmso.hasSpecies\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SimulationCellVector_2\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SimulationCellVector_2\n", "\n", - "\n", - "\n", - "cb97bedb-7369-4573-982d-28473efb3638\n", - "\n", - "2\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SimulationCell->sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SimulationCellVector_2\n", + "\n", + "\n", + "cmso.hasVector\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c->cb97bedb-7369-4573-982d-28473efb3638\n", - "\n", - "\n", - "cmso.hasNumberOfAtoms\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SimulationCellVector_1\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SimulationCellVector_1\n", "\n", - "\n", - "\n", - "141e6bac-5e18-4135-8777-c8845a054322\n", - "\n", - "Rdf_Structure_Store/C91A3F03-A2A6-4C4A-Ae4B-D89B8Ae9427C.Json\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SimulationCell->sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SimulationCellVector_1\n", + "\n", + "\n", + "cmso.hasVector\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_Species->141e6bac-5e18-4135-8777-c8845a054322\n", - "\n", - "\n", - "cmso.hasPath\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SimulationCellVector_3\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SimulationCellVector_3\n", "\n", - "\n", - "\n", - "d707d2bd-fc1e-4047-90b5-51c2f68e8de4\n", - "\n", - "Species\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SimulationCell->sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SimulationCellVector_3\n", + "\n", + "\n", + "cmso.hasVector\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_Species->d707d2bd-fc1e-4047-90b5-51c2f68e8de4\n", - "\n", - "\n", - "cmso.hasName\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SimulationCellLength\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SimulationCellLength\n", "\n", - "\n", - "\n", - "00c13110-419e-4995-8eef-996fe9613e04\n", - "\n", - "Ea1F11Fc-A7A8-4E59-A63D-5Fe258A28A01\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SimulationCell->sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SimulationCellLength\n", + "\n", + "\n", + "cmso.hasLength\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_Species->00c13110-419e-4995-8eef-996fe9613e04\n", - "\n", - "\n", - "cmso.hasIdentifier\n", + "\n", + "\n", + "32fcbbea-f960-4387-9b3a-c5f8092744b0\n", + "\n", + "45.5\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SimulationCellAngle\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SimulationCellAngle\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SimulationCell->32fcbbea-f960-4387-9b3a-c5f8092744b0\n", + "\n", + "\n", + "cmso.hasVolume\n", "\n", - "\n", - "\n", - "9e71bafa-fb1e-4f61-8f9e-b5bbea4af391\n", - "\n", - "90.0\n", + "\n", + "\n", + "a3ceb5ab-edcb-41fe-8ece-8117bc6b7fd3\n", + "\n", + "90.0\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SimulationCellAngle->9e71bafa-fb1e-4f61-8f9e-b5bbea4af391\n", - "\n", - "\n", - "cmso.hasAngle_alpha\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SimulationCellAngle->a3ceb5ab-edcb-41fe-8ece-8117bc6b7fd3\n", + "\n", + "\n", + "cmso.hasAngle_alpha\n", "\n", - "\n", - "\n", - "83d85f7d-2b24-487a-aa3e-7aa74a68c185\n", - "\n", - "90.0\n", + "\n", + "\n", + "08a23ed1-f55c-4b63-b6a5-722a76260dcd\n", + "\n", + "90.0\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SimulationCellAngle->83d85f7d-2b24-487a-aa3e-7aa74a68c185\n", - "\n", - "\n", - "cmso.hasAngle_gamma\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SimulationCellAngle->08a23ed1-f55c-4b63-b6a5-722a76260dcd\n", + "\n", + "\n", + "cmso.hasAngle_gamma\n", "\n", - "\n", - "\n", - "5de41e87-6809-4971-a8b5-0d2d1fada4c9\n", - "\n", - "90.0\n", + "\n", + "\n", + "8adf89a0-d8f2-4686-bd46-130eb57fc978\n", + "\n", + "90.0\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SimulationCellAngle->5de41e87-6809-4971-a8b5-0d2d1fada4c9\n", - "\n", - "\n", - "cmso.hasAngle_beta\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SimulationCellAngle->8adf89a0-d8f2-4686-bd46-130eb57fc978\n", + "\n", + "\n", + "cmso.hasAngle_beta\n", "\n", - "\n", + "\n", "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0\n", - "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0->sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_Species\n", - "\n", - "\n", - "cmso.hasAttribute\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_LatticeAngle\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_LatticeAngle\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_Material\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_Material\n", + "\n", + "\n", + "87e04a85-459c-4c14-9239-45b86ed60281\n", + "\n", + "90.0\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0->sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_Material\n", - "\n", - "\n", - "cmso.hasMaterial\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_LatticeAngle->87e04a85-459c-4c14-9239-45b86ed60281\n", + "\n", + "\n", + "cmso.hasAngle_alpha\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_Position\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_Position\n", + "\n", + "\n", + "b9f21d1d-f535-4520-b209-7f97e37e8084\n", + "\n", + "90.0\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0->sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_Position\n", - "\n", - "\n", - "cmso.hasAttribute\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_LatticeAngle->b9f21d1d-f535-4520-b209-7f97e37e8084\n", + "\n", + "\n", + "cmso.hasAngle_beta\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SimulationCell\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SimulationCell\n", + "\n", + "\n", + "a7b9e1b0-0070-4f49-a01a-2cedd86c6c17\n", + "\n", + "90.0\n", "\n", - "\n", + "\n", "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0->sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SimulationCell\n", - "\n", - "\n", - "cmso.hasSimulationCell\n", - "\n", - "\n", - "\n", - "2743cac4-3727-4ca0-95d6-de8642b46570\n", - "\n", - "4\n", - "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0->2743cac4-3727-4ca0-95d6-de8642b46570\n", - "\n", - "\n", - "cmso.hasNumberOfAtoms\n", - "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_ChemicalSpecies\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_ChemicalSpecies\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_LatticeAngle->a7b9e1b0-0070-4f49-a01a-2cedd86c6c17\n", + "\n", + "\n", + "cmso.hasAngle_gamma\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0->sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_ChemicalSpecies\n", - "\n", - "\n", - "cmso.hasSpecies\n", - "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellVector_1\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellVector_1\n", - "\n", - "\n", + "\n", "\n", - "87c7d16d-326d-4c1f-af72-fbc4dc984ddd\n", - "\n", - "2.87\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_UnitCell\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_UnitCell\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellVector_1->87c7d16d-326d-4c1f-af72-fbc4dc984ddd\n", - "\n", - "\n", - "cmso.hasComponent_x\n", + "\n", + "\n", + "wiki.Q3006714\n", + "\n", + "wiki.Q3006714\n", "\n", - "\n", - "\n", - "d6efbd99-c954-4d96-a9fe-f913195a26bf\n", - "\n", - "0.0\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_UnitCell->wiki.Q3006714\n", + "\n", + "\n", + "cmso.hasBravaisLattice\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellVector_1->d6efbd99-c954-4d96-a9fe-f913195a26bf\n", - "\n", - "\n", - "cmso.hasComponent_y\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_LatticeAngle\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_LatticeAngle\n", "\n", - "\n", - "\n", - "255c83ee-1a68-4032-886e-c90404b16c84\n", - "\n", - "0.0\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_UnitCell->sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_LatticeAngle\n", + "\n", + "\n", + "cmso.hasAngle\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellVector_1->255c83ee-1a68-4032-886e-c90404b16c84\n", - "\n", - "\n", - "cmso.hasComponent_z\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_LatticeParameter\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_LatticeParameter\n", "\n", - "\n", - "\n", - "CHEBI.18248\n", - "\n", - "CHEBI.18248\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_UnitCell->sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_LatticeParameter\n", + "\n", + "\n", + "cmso.hasLatticeParameter\n", "\n", - "\n", + "\n", "\n", - "e58301e0-74e5-45a4-8b45-30a7022669e8\n", - "\n", - "Fe\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_Position\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_Position\n", "\n", - "\n", + "\n", + "\n", + "22ada0fd-9679-4a93-bf3e-2cc9dddc99fe\n", + "\n", + "8Bc122Bf-D66D-4868-Adce-4E933078A807\n", + "\n", + "\n", "\n", - "CHEBI.18248->e58301e0-74e5-45a4-8b45-30a7022669e8\n", - "\n", - "\n", - "cmso.hasChemicalSymbol\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_Position->22ada0fd-9679-4a93-bf3e-2cc9dddc99fe\n", + "\n", + "\n", + "cmso.hasIdentifier\n", "\n", - "\n", - "\n", - "db605a49-8528-4a38-8231-66c6d731e265\n", - "\n", - "1.0\n", + "\n", + "\n", + "ced4d5c5-cff9-4595-9592-8166b68a328f\n", + "\n", + "Rdf_Structure_Store/Ba7B1Ac6-E72C-4B07-Abd2-4B1Db132D563.Json\n", "\n", - "\n", - "\n", - "CHEBI.18248->db605a49-8528-4a38-8231-66c6d731e265\n", - "\n", - "\n", - "cmso.hasElementRatio\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_Position->ced4d5c5-cff9-4595-9592-8166b68a328f\n", + "\n", + "\n", + "cmso.hasPath\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_CrystalStructure\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_CrystalStructure\n", + "\n", + "\n", + "78859406-dd8c-415a-9e7a-dc70a99cce90\n", + "\n", + "Position\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_Material->sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_CrystalStructure\n", - "\n", - "\n", - "cmso.hasStructure\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_Position->78859406-dd8c-415a-9e7a-dc70a99cce90\n", + "\n", + "\n", + "cmso.hasName\n", "\n", - "\n", + "\n", "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellLength\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellLength\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_Species\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_Species\n", "\n", - "\n", + "\n", "\n", - "2d193b02-06b7-4426-a353-89ead4434444\n", - "\n", - "2.87\n", + "1be290a4-0464-4152-8c5b-9114bfbb3a24\n", + "\n", + "Species\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellLength->2d193b02-06b7-4426-a353-89ead4434444\n", - "\n", - "\n", - "cmso.hasLength_x\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_Species->1be290a4-0464-4152-8c5b-9114bfbb3a24\n", + "\n", + "\n", + "cmso.hasName\n", "\n", - "\n", - "\n", - "072f817f-5f03-43bf-8915-8538f2ef51ea\n", - "\n", - "2.87\n", + "\n", + "\n", + "1553060c-4fa2-4f08-b8f1-bee0dce649ab\n", + "\n", + "Rdf_Structure_Store/92F0563E-9D7A-4A39-9C15-D909318Feaf3.Json\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellLength->072f817f-5f03-43bf-8915-8538f2ef51ea\n", - "\n", - "\n", - "cmso.hasLength_z\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_Species->1553060c-4fa2-4f08-b8f1-bee0dce649ab\n", + "\n", + "\n", + "cmso.hasPath\n", "\n", - "\n", - "\n", - "fbb89426-6f76-4151-82a4-d42c870e0521\n", - "\n", - "2.87\n", + "\n", + "\n", + "1d0d5e3b-954c-48aa-888e-5968062bc489\n", + "\n", + "353B471B-4F1E-44Ae-Aa82-D40Ef74282F9\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellLength->fbb89426-6f76-4151-82a4-d42c870e0521\n", - "\n", - "\n", - "cmso.hasLength_y\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_Species->1d0d5e3b-954c-48aa-888e-5968062bc489\n", + "\n", + "\n", + "cmso.hasIdentifier\n", "\n", - "\n", + "\n", "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SimulationCellVector_2\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SimulationCellVector_2\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_SimulationCell\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_SimulationCell\n", "\n", - "\n", + "\n", "\n", - "a32f8107-39d1-42e7-8a55-d86131742478\n", - "\n", - "0.0\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_SimulationCellVector_1\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_SimulationCellVector_1\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SimulationCellVector_2->a32f8107-39d1-42e7-8a55-d86131742478\n", - "\n", - "\n", - "cmso.hasComponent_x\n", - "\n", - "\n", - "\n", - "89afd5cd-1c1c-4707-8ce8-0d65996fb695\n", - "\n", - "0.0\n", - "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SimulationCellVector_2->89afd5cd-1c1c-4707-8ce8-0d65996fb695\n", - "\n", - "\n", - "cmso.hasComponent_z\n", - "\n", - "\n", - "\n", - "41b3609b-3092-41ce-9132-b1c66b57d8a4\n", - "\n", - "3.57\n", - "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SimulationCellVector_2->41b3609b-3092-41ce-9132-b1c66b57d8a4\n", - "\n", - "\n", - "cmso.hasComponent_y\n", - "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SpaceGroup\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SpaceGroup\n", - "\n", - "\n", - "\n", - "1102516c-ea2e-4364-b98f-50a24bbed9f3\n", - "\n", - "221\n", - "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SpaceGroup->1102516c-ea2e-4364-b98f-50a24bbed9f3\n", - "\n", - "\n", - "cmso.hasSpaceGroupNumber\n", - "\n", - "\n", - "\n", - "6a941401-5a48-42d8-aa3a-f4ea34791010\n", - "\n", - "Pm-3M\n", - "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SpaceGroup->6a941401-5a48-42d8-aa3a-f4ea34791010\n", - "\n", - "\n", - "cmso.hasSpaceGroupSymbol\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_SimulationCell->sample_08b4ced3-f682-4804-abb2-53b441995321_SimulationCellVector_1\n", + "\n", + "\n", + "cmso.hasVector\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_UnitCell\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_UnitCell\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_SimulationCellAngle\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_SimulationCellAngle\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_LatticeParameter\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_LatticeParameter\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_SimulationCell->sample_08b4ced3-f682-4804-abb2-53b441995321_SimulationCellAngle\n", + "\n", + "\n", + "cmso.hasAngle\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_UnitCell->sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_LatticeParameter\n", - "\n", - "\n", - "cmso.hasLatticeParameter\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_SimulationCellVector_2\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_SimulationCellVector_2\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_LatticeAngle\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_LatticeAngle\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_SimulationCell->sample_08b4ced3-f682-4804-abb2-53b441995321_SimulationCellVector_2\n", + "\n", + "\n", + "cmso.hasVector\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_UnitCell->sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_LatticeAngle\n", - "\n", - "\n", - "cmso.hasAngle\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_SimulationCellVector_3\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_SimulationCellVector_3\n", "\n", - "\n", - "\n", - "wiki.Q3006714\n", - "\n", - "wiki.Q3006714\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_SimulationCell->sample_08b4ced3-f682-4804-abb2-53b441995321_SimulationCellVector_3\n", + "\n", + "\n", + "cmso.hasVector\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_UnitCell->wiki.Q3006714\n", - "\n", - "\n", - "cmso.hasBravaisLattice\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_SimulationCellLength\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_SimulationCellLength\n", "\n", - "\n", - "\n", - "ef68c405-ff7d-4622-b206-e38011e9c377\n", - "\n", - "3.57\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_SimulationCell->sample_08b4ced3-f682-4804-abb2-53b441995321_SimulationCellLength\n", + "\n", + "\n", + "cmso.hasLength\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_LatticeParameter->ef68c405-ff7d-4622-b206-e38011e9c377\n", - "\n", - "\n", - "cmso.hasLength_x\n", + "\n", + "\n", + "ab6a6dec-07ee-4cf8-a03b-8fbc69df02d5\n", + "\n", + "160.1\n", "\n", - "\n", - "\n", - "5168c57a-8b55-4828-a186-84c3c1ef8294\n", - "\n", - "3.57\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_SimulationCell->ab6a6dec-07ee-4cf8-a03b-8fbc69df02d5\n", + "\n", + "\n", + "cmso.hasVolume\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_LatticeParameter->5168c57a-8b55-4828-a186-84c3c1ef8294\n", - "\n", - "\n", - "cmso.hasLength_z\n", + "\n", + "\n", + "5286d12f-b21e-43a5-b0aa-fff139371207\n", + "\n", + "0.0\n", "\n", - "\n", - "\n", - "8b1b4d1a-3c71-4244-9f15-2d897694e3c9\n", - "\n", - "3.57\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_SimulationCellVector_1->5286d12f-b21e-43a5-b0aa-fff139371207\n", + "\n", + "\n", + "cmso.hasComponent_y\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_LatticeParameter->8b1b4d1a-3c71-4244-9f15-2d897694e3c9\n", - "\n", - "\n", - "cmso.hasLength_y\n", + "\n", + "\n", + "a588b9f4-5f3d-4135-bed1-7e99828614a7\n", + "\n", + "5.43\n", "\n", - "\n", - "\n", - "ce45bb29-9424-4dbb-b0ab-f0faf61f3986\n", - "\n", - "Rdf_Structure_Store/4E73Fc35-0B29-4588-8Bc8-C94E93B57Ee0.Json\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_SimulationCellVector_1->a588b9f4-5f3d-4135-bed1-7e99828614a7\n", + "\n", + "\n", + "cmso.hasComponent_x\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_Position->ce45bb29-9424-4dbb-b0ab-f0faf61f3986\n", - "\n", - "\n", - "cmso.hasPath\n", + "\n", + "\n", + "2931a174-2e9b-41b9-92b6-af480c3d2e6b\n", + "\n", + "0.0\n", "\n", - "\n", - "\n", - "2636b9b6-0490-4c38-ab2d-e56e7d570f12\n", - "\n", - "Position\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_SimulationCellVector_1->2931a174-2e9b-41b9-92b6-af480c3d2e6b\n", + "\n", + "\n", + "cmso.hasComponent_z\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_Position->2636b9b6-0490-4c38-ab2d-e56e7d570f12\n", - "\n", - "\n", - "cmso.hasName\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_LatticeAngle\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_LatticeAngle\n", "\n", - "\n", - "\n", - "05960069-72ee-41be-89e0-9e0245a5ea54\n", - "\n", - "Fed754F6-A804-419B-874C-9F3F454Ed02B\n", + "\n", + "\n", + "a014eb71-30fa-45da-a0ca-3522a85139d0\n", + "\n", + "90.0\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_Position->05960069-72ee-41be-89e0-9e0245a5ea54\n", - "\n", - "\n", - "cmso.hasIdentifier\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_LatticeAngle->a014eb71-30fa-45da-a0ca-3522a85139d0\n", + "\n", + "\n", + "cmso.hasAngle_beta\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCell->sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellVector_2\n", - "\n", - "\n", - "cmso.hasVector\n", + "\n", + "\n", + "b1912114-4e95-4b00-88bd-46591beff547\n", + "\n", + "90.0\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCell->sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellVector_1\n", - "\n", - "\n", - "cmso.hasVector\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_LatticeAngle->b1912114-4e95-4b00-88bd-46591beff547\n", + "\n", + "\n", + "cmso.hasAngle_gamma\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCell->sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellLength\n", - "\n", - "\n", - "cmso.hasLength\n", + "\n", + "\n", + "07c7390c-dbb4-4512-bc21-3ef342ae3135\n", + "\n", + "90.0\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellAngle\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellAngle\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_LatticeAngle->07c7390c-dbb4-4512-bc21-3ef342ae3135\n", + "\n", + "\n", + "cmso.hasAngle_alpha\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCell->sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellAngle\n", - "\n", - "\n", - "cmso.hasAngle\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563\n", "\n", - "\n", - "\n", - "8fa99d50-c1e0-4d3a-a336-3d65ae4c5ed0\n", - "\n", - "23.64\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563->sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_Position\n", + "\n", + "\n", + "cmso.hasAttribute\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCell->8fa99d50-c1e0-4d3a-a336-3d65ae4c5ed0\n", - "\n", - "\n", - "cmso.hasVolume\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCell\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCell\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellVector_3\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellVector_3\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563->sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCell\n", + "\n", + "\n", + "cmso.hasSimulationCell\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCell->sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellVector_3\n", - "\n", - "\n", - "cmso.hasVector\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_Species\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_Species\n", "\n", - "\n", - "\n", - "4c3a6e5b-c10b-424a-abd2-36212fd37ad4\n", - "\n", - "90.0\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563->sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_Species\n", + "\n", + "\n", + "cmso.hasAttribute\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellAngle->4c3a6e5b-c10b-424a-abd2-36212fd37ad4\n", - "\n", - "\n", - "cmso.hasAngle_beta\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_Material\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_Material\n", "\n", - "\n", - "\n", - "22f35d1c-3636-42d0-9e94-277c472e8f65\n", - "\n", - "90.0\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563->sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_Material\n", + "\n", + "\n", + "cmso.hasMaterial\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellAngle->22f35d1c-3636-42d0-9e94-277c472e8f65\n", - "\n", - "\n", - "cmso.hasAngle_alpha\n", + "\n", + "\n", + "bee6ca45-ceb1-4a99-bc97-4cca3a5dc0e7\n", + "\n", + "2\n", "\n", - "\n", - "\n", - "03c37553-c4ff-4a40-8976-b5f36e7d26cf\n", - "\n", - "90.0\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563->bee6ca45-ceb1-4a99-bc97-4cca3a5dc0e7\n", + "\n", + "\n", + "cmso.hasNumberOfAtoms\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellAngle->03c37553-c4ff-4a40-8976-b5f36e7d26cf\n", - "\n", - "\n", - "cmso.hasAngle_gamma\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_ChemicalSpecies\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_ChemicalSpecies\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SimulationCell->sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SimulationCellAngle\n", - "\n", - "\n", - "cmso.hasAngle\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563->sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_ChemicalSpecies\n", + "\n", + "\n", + "cmso.hasSpecies\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SimulationCell->sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SimulationCellVector_2\n", - "\n", - "\n", - "cmso.hasVector\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellVector_3\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellVector_3\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SimulationCellLength\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SimulationCellLength\n", + "\n", + "\n", + "194561a7-c894-45cb-9082-fe980cfc9507\n", + "\n", + "0.0\n", "\n", - "\n", + "\n", "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SimulationCell->sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SimulationCellLength\n", - "\n", - "\n", - "cmso.hasLength\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellVector_3->194561a7-c894-45cb-9082-fe980cfc9507\n", + "\n", + "\n", + "cmso.hasComponent_y\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SimulationCellVector_3\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SimulationCellVector_3\n", - "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SimulationCell->sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SimulationCellVector_3\n", - "\n", - "\n", - "cmso.hasVector\n", - "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SimulationCellVector_1\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SimulationCellVector_1\n", + "\n", + "\n", + "74b147d2-bf34-415c-b68c-f00603bdf6e0\n", + "\n", + "2.87\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SimulationCell->sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SimulationCellVector_1\n", - "\n", - "\n", - "cmso.hasVector\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellVector_3->74b147d2-bf34-415c-b68c-f00603bdf6e0\n", + "\n", + "\n", + "cmso.hasComponent_z\n", "\n", - "\n", - "\n", - "888ffe0d-55e0-499f-bd83-c71d739f4cae\n", - "\n", - "45.5\n", + "\n", + "\n", + "f0f03c87-56dd-447a-beb6-bf3b07495eaa\n", + "\n", + "0.0\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SimulationCell->888ffe0d-55e0-499f-bd83-c71d739f4cae\n", - "\n", - "\n", - "cmso.hasVolume\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellVector_3->f0f03c87-56dd-447a-beb6-bf3b07495eaa\n", + "\n", + "\n", + "cmso.hasComponent_x\n", "\n", - "\n", - "\n", - "a98234cd-ab16-474b-a388-9f66a5e442ae\n", - "\n", - "3.57\n", + "\n", + "\n", + "2ba08fa1-cbc0-42dc-9bc8-750a3da60747\n", + "\n", + "90.0\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SimulationCellLength->a98234cd-ab16-474b-a388-9f66a5e442ae\n", - "\n", - "\n", - "cmso.hasLength_y\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_SimulationCellAngle->2ba08fa1-cbc0-42dc-9bc8-750a3da60747\n", + "\n", + "\n", + "cmso.hasAngle_alpha\n", "\n", - "\n", - "\n", - "e77b21a7-0375-4590-89dc-97ae7db8fd38\n", - "\n", - "3.57\n", + "\n", + "\n", + "2d37eb2d-e134-43b3-b3cb-6577cef834c9\n", + "\n", + "90.0\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SimulationCellLength->e77b21a7-0375-4590-89dc-97ae7db8fd38\n", - "\n", - "\n", - "cmso.hasLength_z\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_SimulationCellAngle->2d37eb2d-e134-43b3-b3cb-6577cef834c9\n", + "\n", + "\n", + "cmso.hasAngle_gamma\n", "\n", - "\n", - "\n", - "b10e72c5-ddc7-4a08-9802-cc16b910aded\n", - "\n", - "3.57\n", + "\n", + "\n", + "eb5ad941-0040-4da8-a74b-9aa7d935a369\n", + "\n", + "90.0\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SimulationCellLength->b10e72c5-ddc7-4a08-9802-cc16b910aded\n", - "\n", - "\n", - "cmso.hasLength_x\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_SimulationCellAngle->eb5ad941-0040-4da8-a74b-9aa7d935a369\n", + "\n", + "\n", + "cmso.hasAngle_beta\n", "\n", - "\n", + "\n", "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SimulationCellVector_1\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SimulationCellVector_1\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellVector_2\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellVector_2\n", "\n", - "\n", + "\n", "\n", - "22aef04c-767c-4051-8a25-81e47f76e1ed\n", - "\n", - "0.0\n", + "c27c81dc-f5c0-439c-a5ae-bc48d4faaeab\n", + "\n", + "0.0\n", "\n", - "\n", + "\n", "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SimulationCellVector_1->22aef04c-767c-4051-8a25-81e47f76e1ed\n", - "\n", - "\n", - "cmso.hasComponent_z\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellVector_2->c27c81dc-f5c0-439c-a5ae-bc48d4faaeab\n", + "\n", + "\n", + "cmso.hasComponent_z\n", "\n", - "\n", - "\n", - "c882f54d-ff7f-47f1-9a0b-4e92f068b276\n", - "\n", - "5.43\n", + "\n", + "\n", + "ae257184-4070-479c-9518-c92a7ca2465d\n", + "\n", + "0.0\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SimulationCellVector_1->c882f54d-ff7f-47f1-9a0b-4e92f068b276\n", - "\n", - "\n", - "cmso.hasComponent_x\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellVector_2->ae257184-4070-479c-9518-c92a7ca2465d\n", + "\n", + "\n", + "cmso.hasComponent_x\n", "\n", - "\n", - "\n", - "61378cd1-0931-4888-be23-59aa6d4206ec\n", - "\n", - "0.0\n", + "\n", + "\n", + "2668f3df-cb1a-43b6-a550-e8d123c79f61\n", + "\n", + "2.87\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SimulationCellVector_1->61378cd1-0931-4888-be23-59aa6d4206ec\n", - "\n", - "\n", - "cmso.hasComponent_y\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellVector_2->2668f3df-cb1a-43b6-a550-e8d123c79f61\n", + "\n", + "\n", + "cmso.hasComponent_y\n", "\n", - "\n", + "\n", "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_CrystalStructure\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_CrystalStructure\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_UnitCell\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_UnitCell\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SpaceGroup\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SpaceGroup\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_UnitCell->wiki.Q3006714\n", + "\n", + "\n", + "cmso.hasBravaisLattice\n", "\n", - "\n", + "\n", "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_CrystalStructure->sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SpaceGroup\n", - "\n", - "\n", - "cmso.hasSpaceGroup\n", - "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_UnitCell\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_UnitCell\n", - "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_CrystalStructure->sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_UnitCell\n", - "\n", - "\n", - "cmso.hasUnitCell\n", - "\n", - "\n", - "\n", - "8b7dbbbb-7dfa-4cdc-976d-54693fec5a82\n", - "\n", - "Bcc\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_UnitCell->sample_08b4ced3-f682-4804-abb2-53b441995321_LatticeAngle\n", + "\n", + "\n", + "cmso.hasAngle\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_CrystalStructure->8b7dbbbb-7dfa-4cdc-976d-54693fec5a82\n", - "\n", - "\n", - "cmso.hasAltName\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_LatticeParameter\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_LatticeParameter\n", "\n", - "\n", - "\n", - "ccbd831b-eaa9-462d-828d-26c48c7ea53a\n", - "\n", - "Im-3M\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_UnitCell->sample_08b4ced3-f682-4804-abb2-53b441995321_LatticeParameter\n", + "\n", + "\n", + "cmso.hasLatticeParameter\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SpaceGroup->ccbd831b-eaa9-462d-828d-26c48c7ea53a\n", - "\n", - "\n", - "cmso.hasSpaceGroupSymbol\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCell->sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellLength\n", + "\n", + "\n", + "cmso.hasLength\n", "\n", - "\n", - "\n", - "fe2fc614-3077-414d-a1aa-63643aa00018\n", - "\n", - "229\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCell->sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellVector_3\n", + "\n", + "\n", + "cmso.hasVector\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SpaceGroup->fe2fc614-3077-414d-a1aa-63643aa00018\n", - "\n", - "\n", - "cmso.hasSpaceGroupNumber\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCell->sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellVector_2\n", + "\n", + "\n", + "cmso.hasVector\n", "\n", - "\n", + "\n", "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_CrystalStructure\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_CrystalStructure\n", - "\n", - "\n", - "\n", - "7380ba62-f2c5-4922-949b-7faa4091d381\n", - "\n", - "Diamond\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellAngle\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellAngle\n", "\n", - "\n", + "\n", "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_CrystalStructure->7380ba62-f2c5-4922-949b-7faa4091d381\n", - "\n", - "\n", - "cmso.hasAltName\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCell->sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellAngle\n", + "\n", + "\n", + "cmso.hasAngle\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_UnitCell\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_UnitCell\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellVector_1\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellVector_1\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_CrystalStructure->sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_UnitCell\n", - "\n", - "\n", - "cmso.hasUnitCell\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCell->sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellVector_1\n", + "\n", + "\n", + "cmso.hasVector\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SpaceGroup\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SpaceGroup\n", + "\n", + "\n", + "85d46b3b-f3d1-4444-b301-d63b3b5e9f6a\n", + "\n", + "23.64\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_CrystalStructure->sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SpaceGroup\n", - "\n", - "\n", - "cmso.hasSpaceGroup\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCell->85d46b3b-f3d1-4444-b301-d63b3b5e9f6a\n", + "\n", + "\n", + "cmso.hasVolume\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_LatticeParameter\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_LatticeParameter\n", + "\n", + "\n", + "dc4a8625-6431-4ad7-bfe3-88ebb21333a3\n", + "\n", + "90.0\n", "\n", - "\n", - "\n", - "e130308e-72cc-408e-86db-23cdb33cf4df\n", - "\n", - "2.87\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellAngle->dc4a8625-6431-4ad7-bfe3-88ebb21333a3\n", + "\n", + "\n", + "cmso.hasAngle_beta\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_LatticeParameter->e130308e-72cc-408e-86db-23cdb33cf4df\n", - "\n", - "\n", - "cmso.hasLength_y\n", + "\n", + "\n", + "ad9543e1-7cdf-4c06-b12c-2af252651794\n", + "\n", + "90.0\n", "\n", - "\n", - "\n", - "dbbd03e3-195d-4a98-b3b1-7ddb76e9772a\n", - "\n", - "2.87\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellAngle->ad9543e1-7cdf-4c06-b12c-2af252651794\n", + "\n", + "\n", + "cmso.hasAngle_gamma\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_LatticeParameter->dbbd03e3-195d-4a98-b3b1-7ddb76e9772a\n", - "\n", - "\n", - "cmso.hasLength_x\n", + "\n", + "\n", + "eb3e8706-0c36-4704-9544-9879d934b1c4\n", + "\n", + "90.0\n", "\n", - "\n", - "\n", - "1cdadb0f-85d3-4110-8977-116c52155cc3\n", - "\n", - "2.87\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellAngle->eb3e8706-0c36-4704-9544-9879d934b1c4\n", + "\n", + "\n", + "cmso.hasAngle_alpha\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_LatticeParameter->1cdadb0f-85d3-4110-8977-116c52155cc3\n", - "\n", - "\n", - "cmso.hasLength_z\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_SpaceGroup\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_SpaceGroup\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_LatticeParameter\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_LatticeParameter\n", + "\n", + "\n", + "a0cec20a-ddb1-4581-ae12-090beadd29cd\n", + "\n", + "227\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_UnitCell->sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_LatticeParameter\n", - "\n", - "\n", - "cmso.hasLatticeParameter\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_SpaceGroup->a0cec20a-ddb1-4581-ae12-090beadd29cd\n", + "\n", + "\n", + "cmso.hasSpaceGroupNumber\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_LatticeAngle\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_LatticeAngle\n", + "\n", + "\n", + "d6df5d5f-40f9-446e-b38a-e7cfdd1ab5ee\n", + "\n", + "Fd-3M\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_UnitCell->sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_LatticeAngle\n", - "\n", - "\n", - "cmso.hasAngle\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_SpaceGroup->d6df5d5f-40f9-446e-b38a-e7cfdd1ab5ee\n", + "\n", + "\n", + "cmso.hasSpaceGroupSymbol\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_UnitCell->wiki.Q3006714\n", - "\n", - "\n", - "cmso.hasBravaisLattice\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3\n", "\n", - "\n", - "\n", - "21a6b164-1e71-44bd-a6d1-5f2a89d252b8\n", - "\n", - "5.43\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3->sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_Position\n", + "\n", + "\n", + "cmso.hasAttribute\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_LatticeParameter->21a6b164-1e71-44bd-a6d1-5f2a89d252b8\n", - "\n", - "\n", - "cmso.hasLength_x\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3->sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SimulationCell\n", + "\n", + "\n", + "cmso.hasSimulationCell\n", "\n", - "\n", - "\n", - "6ac744e2-6f6e-4b1b-8217-1a62799e655a\n", - "\n", - "5.43\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3->sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_Species\n", + "\n", + "\n", + "cmso.hasAttribute\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_LatticeParameter->6ac744e2-6f6e-4b1b-8217-1a62799e655a\n", - "\n", - "\n", - "cmso.hasLength_y\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_Material\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_Material\n", "\n", - "\n", - "\n", - "aa7341f5-cc52-44aa-9f4c-38e783128832\n", - "\n", - "5.43\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3->sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_Material\n", + "\n", + "\n", + "cmso.hasMaterial\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_LatticeParameter->aa7341f5-cc52-44aa-9f4c-38e783128832\n", - "\n", - "\n", - "cmso.hasLength_z\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_ChemicalSpecies\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_ChemicalSpecies\n", "\n", - "\n", - "\n", - "db4592e4-3c7c-4c64-97a3-c578b84f5dc1\n", - "\n", - "90.0\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3->sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_ChemicalSpecies\n", + "\n", + "\n", + "cmso.hasSpecies\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_LatticeAngle->db4592e4-3c7c-4c64-97a3-c578b84f5dc1\n", - "\n", - "\n", - "cmso.hasAngle_beta\n", + "\n", + "\n", + "dc848f68-40dc-4f5a-b4fb-c84d1f960948\n", + "\n", + "4\n", "\n", - "\n", - "\n", - "4c1d545d-67b9-4a6b-8378-3213f07f9bee\n", - "\n", - "90.0\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3->dc848f68-40dc-4f5a-b4fb-c84d1f960948\n", + "\n", + "\n", + "cmso.hasNumberOfAtoms\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_LatticeAngle->4c1d545d-67b9-4a6b-8378-3213f07f9bee\n", - "\n", - "\n", - "cmso.hasAngle_alpha\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_CrystalStructure\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_CrystalStructure\n", "\n", - "\n", - "\n", - "6ffc247a-5918-43d0-a31b-c63bd84e8bca\n", - "\n", - "90.0\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_Material->sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_CrystalStructure\n", + "\n", + "\n", + "cmso.hasStructure\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_LatticeAngle->6ffc247a-5918-43d0-a31b-c63bd84e8bca\n", - "\n", - "\n", - "cmso.hasAngle_gamma\n", + "\n", + "\n", + "CHEBI.28984\n", + "\n", + "CHEBI.28984\n", "\n", - "\n", - "\n", - "a64a9983-4f28-4b3e-be3a-51744c38452c\n", - "\n", - "0.0\n", + "\n", + "\n", + "4593d07b-3467-4569-990b-47abb7dda099\n", + "\n", + "0.25\n", "\n", - "\n", + "\n", "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SimulationCellVector_3->a64a9983-4f28-4b3e-be3a-51744c38452c\n", - "\n", - "\n", - "cmso.hasComponent_y\n", + "CHEBI.28984->4593d07b-3467-4569-990b-47abb7dda099\n", + "\n", + "\n", + "cmso.hasElementRatio\n", "\n", - "\n", - "\n", - "f6b5a750-489b-4264-b5ef-480389f32115\n", - "\n", - "0.0\n", + "\n", + "\n", + "ac1b02c1-9abd-4a32-916a-bcf54d038741\n", + "\n", + "Al\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SimulationCellVector_3->f6b5a750-489b-4264-b5ef-480389f32115\n", - "\n", - "\n", - "cmso.hasComponent_x\n", + "\n", + "\n", + "CHEBI.28984->ac1b02c1-9abd-4a32-916a-bcf54d038741\n", + "\n", + "\n", + "cmso.hasChemicalSymbol\n", "\n", - "\n", - "\n", - "f39b721d-d53d-45a9-9738-06dbaf1ca767\n", - "\n", - "3.57\n", + "\n", + "\n", + "e862a7c1-5180-4ccf-b85b-746bb681dbc8\n", + "\n", + "C1Afc46E-F7F2-4F82-A8Ab-74A06A4536Ca\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SimulationCellVector_3->f39b721d-d53d-45a9-9738-06dbaf1ca767\n", - "\n", - "\n", - "cmso.hasComponent_z\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_Species->e862a7c1-5180-4ccf-b85b-746bb681dbc8\n", + "\n", + "\n", + "cmso.hasIdentifier\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SimulationCellVector_3\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SimulationCellVector_3\n", + "\n", + "\n", + "36dcfc0f-901f-4786-882a-29b8e5351fb4\n", + "\n", + "Species\n", "\n", - "\n", - "\n", - "c9207753-e0ce-46e3-a3ff-bd30a3e2d744\n", - "\n", - "0.0\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_Species->36dcfc0f-901f-4786-882a-29b8e5351fb4\n", + "\n", + "\n", + "cmso.hasName\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SimulationCellVector_3->c9207753-e0ce-46e3-a3ff-bd30a3e2d744\n", - "\n", - "\n", - "cmso.hasComponent_y\n", + "\n", + "\n", + "6a317d11-3b78-4bfe-9681-a9c984d002b1\n", + "\n", + "Rdf_Structure_Store/Ba7B1Ac6-E72C-4B07-Abd2-4B1Db132D563.Json\n", "\n", - "\n", - "\n", - "fb9fff20-5a2a-4ee9-a702-1851793f01c4\n", - "\n", - "5.43\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_Species->6a317d11-3b78-4bfe-9681-a9c984d002b1\n", + "\n", + "\n", + "cmso.hasPath\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SimulationCellVector_3->fb9fff20-5a2a-4ee9-a702-1851793f01c4\n", - "\n", - "\n", - "cmso.hasComponent_z\n", + "\n", + "\n", + "ab4bf17d-6ecf-49d9-b2be-ad461a34cd40\n", + "\n", + "0.0\n", "\n", - "\n", - "\n", - "5deee0c6-2376-40f7-94ac-13283053f213\n", - "\n", - "0.0\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SimulationCellVector_2->ab4bf17d-6ecf-49d9-b2be-ad461a34cd40\n", + "\n", + "\n", + "cmso.hasComponent_x\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SimulationCellVector_3->5deee0c6-2376-40f7-94ac-13283053f213\n", - "\n", - "\n", - "cmso.hasComponent_x\n", + "\n", + "\n", + "8750f789-bdd7-4007-8919-c9356a541fca\n", + "\n", + "3.57\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_Material\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_Material\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SimulationCellVector_2->8750f789-bdd7-4007-8919-c9356a541fca\n", + "\n", + "\n", + "cmso.hasComponent_y\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_Material->sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_CrystalStructure\n", - "\n", - "\n", - "cmso.hasStructure\n", + "\n", + "\n", + "b7c49eba-51c4-4ff1-817f-8eeee6670bd2\n", + "\n", + "0.0\n", "\n", - "\n", - "\n", - "aa976c04-771c-4fab-9d1a-3ed927c8e57c\n", - "\n", - "90.0\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SimulationCellVector_2->b7c49eba-51c4-4ff1-817f-8eeee6670bd2\n", + "\n", + "\n", + "cmso.hasComponent_z\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_LatticeAngle->aa976c04-771c-4fab-9d1a-3ed927c8e57c\n", - "\n", - "\n", - "cmso.hasAngle_gamma\n", + "\n", + "\n", + "e1a781d8-d908-4101-aa55-46d8279ec5b5\n", + "\n", + "90.0\n", "\n", - "\n", - "\n", - "50a5aac4-c1ab-424d-86a9-85106aa76f09\n", - "\n", - "90.0\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_LatticeAngle->e1a781d8-d908-4101-aa55-46d8279ec5b5\n", + "\n", + "\n", + "cmso.hasAngle_alpha\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_LatticeAngle->50a5aac4-c1ab-424d-86a9-85106aa76f09\n", - "\n", - "\n", - "cmso.hasAngle_beta\n", + "\n", + "\n", + "d031926e-05b5-4682-93b4-f03cec82d5ec\n", + "\n", + "90.0\n", "\n", - "\n", - "\n", - "5ac936cc-a2e5-4c20-b329-b9d1b6fed51d\n", - "\n", - "90.0\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_LatticeAngle->d031926e-05b5-4682-93b4-f03cec82d5ec\n", + "\n", + "\n", + "cmso.hasAngle_beta\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_LatticeAngle->5ac936cc-a2e5-4c20-b329-b9d1b6fed51d\n", - "\n", - "\n", - "cmso.hasAngle_alpha\n", + "\n", + "\n", + "91a0d8c5-09fb-48dc-b2e5-5a49a3f66248\n", + "\n", + "90.0\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_LatticeAngle->91a0d8c5-09fb-48dc-b2e5-5a49a3f66248\n", + "\n", + "\n", + "cmso.hasAngle_gamma\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952->sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_Material\n", - "\n", - "\n", - "cmso.hasMaterial\n", + "\n", + "\n", + "5a701504-0e3b-4a30-9cc9-2de6b2024026\n", + "\n", + "0.0\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_Position\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_Position\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellVector_1->5a701504-0e3b-4a30-9cc9-2de6b2024026\n", + "\n", + "\n", + "cmso.hasComponent_z\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952->sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_Position\n", - "\n", - "\n", - "cmso.hasAttribute\n", + "\n", + "\n", + "80ee4373-c45f-4d5e-8b85-786312f9ad8a\n", + "\n", + "0.0\n", "\n", - "\n", - "\n", - "da13b1d9-8ae1-45c7-9958-481968963778\n", - "\n", - "8\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellVector_1->80ee4373-c45f-4d5e-8b85-786312f9ad8a\n", + "\n", + "\n", + "cmso.hasComponent_y\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952->da13b1d9-8ae1-45c7-9958-481968963778\n", - "\n", - "\n", - "cmso.hasNumberOfAtoms\n", + "\n", + "\n", + "0f11d8c9-9bcd-484a-a087-d11a6b909305\n", + "\n", + "2.87\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SimulationCell\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SimulationCell\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SimulationCellVector_1->0f11d8c9-9bcd-484a-a087-d11a6b909305\n", + "\n", + "\n", + "cmso.hasComponent_x\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952->sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SimulationCell\n", - "\n", - "\n", - "cmso.hasSimulationCell\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_CrystalStructure\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_CrystalStructure\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_Species\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_Species\n", + "\n", + "\n", + "247c7b82-ae09-4b58-b97e-1b3533048e03\n", + "\n", + "Bcc\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952->sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_Species\n", - "\n", - "\n", - "cmso.hasAttribute\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_CrystalStructure->247c7b82-ae09-4b58-b97e-1b3533048e03\n", + "\n", + "\n", + "cmso.hasAltName\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_ChemicalSpecies\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_ChemicalSpecies\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_UnitCell\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_UnitCell\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952->sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_ChemicalSpecies\n", - "\n", - "\n", - "cmso.hasSpecies\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_CrystalStructure->sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_UnitCell\n", + "\n", + "\n", + "cmso.hasUnitCell\n", "\n", - "\n", - "\n", - "d3bd5019-9952-4262-8e06-f48503dbe9fe\n", - "\n", - "771D939A-694B-4F4C-A17F-950E7443Bb73\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SpaceGroup\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SpaceGroup\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_Position->d3bd5019-9952-4262-8e06-f48503dbe9fe\n", - "\n", - "\n", - "cmso.hasIdentifier\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_CrystalStructure->sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SpaceGroup\n", + "\n", + "\n", + "cmso.hasSpaceGroup\n", "\n", - "\n", - "\n", - "5fc5cc82-2ece-42ad-9aed-d57a828d84b0\n", - "\n", - "Position\n", + "\n", + "\n", + "be6b0ee0-544c-42ee-979b-897e94fb55a0\n", + "\n", + "0.0\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_Position->5fc5cc82-2ece-42ad-9aed-d57a828d84b0\n", - "\n", - "\n", - "cmso.hasName\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_SimulationCellVector_2->be6b0ee0-544c-42ee-979b-897e94fb55a0\n", + "\n", + "\n", + "cmso.hasComponent_x\n", "\n", - "\n", - "\n", - "17375638-a39e-4a41-bccf-b08a837ae3a0\n", - "\n", - "Rdf_Structure_Store/2C1336A0-2Fe0-4868-A5Fd-5Bc6365Bb952.Json\n", + "\n", + "\n", + "8a6cd669-7314-4871-8bf9-a41a19d48702\n", + "\n", + "0.0\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_Position->17375638-a39e-4a41-bccf-b08a837ae3a0\n", - "\n", - "\n", - "cmso.hasPath\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_SimulationCellVector_2->8a6cd669-7314-4871-8bf9-a41a19d48702\n", + "\n", + "\n", + "cmso.hasComponent_z\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SimulationCellAngle\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SimulationCellAngle\n", + "\n", + "\n", + "374a998a-f825-4ea7-b966-588f8d926e4e\n", + "\n", + "5.43\n", "\n", - "\n", - "\n", - "a203c319-ed7c-43ad-9981-01d05a7ee00d\n", - "\n", - "90.0\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_SimulationCellVector_2->374a998a-f825-4ea7-b966-588f8d926e4e\n", + "\n", + "\n", + "cmso.hasComponent_y\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SimulationCellAngle->a203c319-ed7c-43ad-9981-01d05a7ee00d\n", - "\n", - "\n", - "cmso.hasAngle_gamma\n", + "\n", + "\n", + "d5296ab6-a04e-4cdd-bd33-ad2c425b4f25\n", + "\n", + "0.0\n", "\n", - "\n", - "\n", - "21559692-85d5-4fd3-adeb-9399cee0f07f\n", - "\n", - "90.0\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_SimulationCellVector_3->d5296ab6-a04e-4cdd-bd33-ad2c425b4f25\n", + "\n", + "\n", + "cmso.hasComponent_x\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SimulationCellAngle->21559692-85d5-4fd3-adeb-9399cee0f07f\n", - "\n", - "\n", - "cmso.hasAngle_alpha\n", + "\n", + "\n", + "8a16b5df-aee2-43b8-a425-dbc867483de3\n", + "\n", + "5.43\n", "\n", - "\n", - "\n", - "582fb3af-c48f-4cea-850c-fcad2248fcea\n", - "\n", - "90.0\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_SimulationCellVector_3->8a16b5df-aee2-43b8-a425-dbc867483de3\n", + "\n", + "\n", + "cmso.hasComponent_z\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SimulationCellAngle->582fb3af-c48f-4cea-850c-fcad2248fcea\n", - "\n", - "\n", - "cmso.hasAngle_beta\n", + "\n", + "\n", + "8c9e4f8a-0539-4b42-9975-81b61c247559\n", + "\n", + "0.0\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SimulationCellVector_2\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SimulationCellVector_2\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_SimulationCellVector_3->8c9e4f8a-0539-4b42-9975-81b61c247559\n", + "\n", + "\n", + "cmso.hasComponent_y\n", "\n", - "\n", - "\n", - "6cb78316-e2ea-4a9c-ae34-9535633b4b4f\n", - "\n", - "0.0\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_CrystalStructure\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_CrystalStructure\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SimulationCellVector_2->6cb78316-e2ea-4a9c-ae34-9535633b4b4f\n", - "\n", - "\n", - "cmso.hasComponent_z\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_CrystalStructure->sample_08b4ced3-f682-4804-abb2-53b441995321_UnitCell\n", + "\n", + "\n", + "cmso.hasUnitCell\n", "\n", - "\n", - "\n", - "6991c5e5-d6e8-4647-9799-1a9cb077ba90\n", - "\n", - "5.43\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_CrystalStructure->sample_08b4ced3-f682-4804-abb2-53b441995321_SpaceGroup\n", + "\n", + "\n", + "cmso.hasSpaceGroup\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SimulationCellVector_2->6991c5e5-d6e8-4647-9799-1a9cb077ba90\n", - "\n", - "\n", - "cmso.hasComponent_y\n", + "\n", + "\n", + "619e1fa1-bd34-47fd-b656-ca944fb2ad61\n", + "\n", + "Diamond\n", "\n", - "\n", - "\n", - "88e2d616-f61d-452d-9d53-6c5d5099a2d0\n", - "\n", - "0.0\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_CrystalStructure->619e1fa1-bd34-47fd-b656-ca944fb2ad61\n", + "\n", + "\n", + "cmso.hasAltName\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SimulationCellVector_2->88e2d616-f61d-452d-9d53-6c5d5099a2d0\n", - "\n", - "\n", - "cmso.hasComponent_x\n", + "\n", + "\n", + "b64435e7-7634-4dfb-8203-67b08e978d60\n", + "\n", + "5.43\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_CrystalStructure->sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SpaceGroup\n", - "\n", - "\n", - "cmso.hasSpaceGroup\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_LatticeParameter->b64435e7-7634-4dfb-8203-67b08e978d60\n", + "\n", + "\n", + "cmso.hasLength_x\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_CrystalStructure->sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_UnitCell\n", - "\n", - "\n", - "cmso.hasUnitCell\n", + "\n", + "\n", + "dd0e6575-56e8-4da8-9ba1-00252dfb6b0e\n", + "\n", + "5.43\n", "\n", - "\n", - "\n", - "e68be54b-0e55-48dd-b9ca-5a49908fb727\n", - "\n", - "L12\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_LatticeParameter->dd0e6575-56e8-4da8-9ba1-00252dfb6b0e\n", + "\n", + "\n", + "cmso.hasLength_y\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_CrystalStructure->e68be54b-0e55-48dd-b9ca-5a49908fb727\n", - "\n", - "\n", - "cmso.hasAltName\n", + "\n", + "\n", + "180c4dfd-dc73-4f7b-8e4d-1781e63aaddd\n", + "\n", + "5.43\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_UnitCell->sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_LatticeParameter\n", - "\n", - "\n", - "cmso.hasLatticeParameter\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_LatticeParameter->180c4dfd-dc73-4f7b-8e4d-1781e63aaddd\n", + "\n", + "\n", + "cmso.hasLength_z\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_LatticeAngle\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_LatticeAngle\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_UnitCell->sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_LatticeParameter\n", + "\n", + "\n", + "cmso.hasLatticeParameter\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_UnitCell->sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_LatticeAngle\n", - "\n", - "\n", - "cmso.hasAngle\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_UnitCell->sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_LatticeAngle\n", + "\n", + "\n", + "cmso.hasAngle\n", "\n", "\n", - "\n", + "\n", "wiki.Q851536\n", - "\n", - "wiki.Q851536\n", + "\n", + "wiki.Q851536\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_UnitCell->wiki.Q851536\n", - "\n", - "\n", - "cmso.hasBravaisLattice\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_UnitCell->wiki.Q851536\n", + "\n", + "\n", + "cmso.hasBravaisLattice\n", "\n", - "\n", + "\n", "\n", - "CHEBI.28112\n", - "\n", - "CHEBI.28112\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_Material\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_Material\n", "\n", - "\n", - "\n", - "cae040a0-b9eb-4a2e-b9e3-2116c0b38a7b\n", - "\n", - "0.75\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_Material->sample_08b4ced3-f682-4804-abb2-53b441995321_CrystalStructure\n", + "\n", + "\n", + "cmso.hasStructure\n", "\n", - "\n", - "\n", - "CHEBI.28112->cae040a0-b9eb-4a2e-b9e3-2116c0b38a7b\n", - "\n", - "\n", - "cmso.hasElementRatio\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_Species\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_Species\n", + "\n", + "\n", + "\n", + "0daf4bd8-dad7-4b50-9bef-12af77c2bf51\n", + "\n", + "Species\n", + "\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_Species->0daf4bd8-dad7-4b50-9bef-12af77c2bf51\n", + "\n", + "\n", + "cmso.hasName\n", + "\n", + "\n", + "\n", + "bfe690eb-070f-445b-9ec8-c63b0020952e\n", + "\n", + "Rdf_Structure_Store/08B4Ced3-F682-4804-Abb2-53B441995321.Json\n", + "\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_Species->bfe690eb-070f-445b-9ec8-c63b0020952e\n", + "\n", + "\n", + "cmso.hasPath\n", "\n", - "\n", + "\n", "\n", - "4d14331c-43cc-4f8e-9476-370a064eca6a\n", - "\n", - "Ni\n", + "f546fa44-8521-420e-b324-ddc68f3928dc\n", + "\n", + "356Eb7C3-F54A-471D-9677-9F431Ac99Bd6\n", "\n", - "\n", - "\n", - "CHEBI.28112->4d14331c-43cc-4f8e-9476-370a064eca6a\n", - "\n", - "\n", - "cmso.hasChemicalSymbol\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_Species->f546fa44-8521-420e-b324-ddc68f3928dc\n", + "\n", + "\n", + "cmso.hasIdentifier\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SimulationCell->sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SimulationCellVector_1\n", - "\n", - "\n", - "cmso.hasVector\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321\n", "\n", - "\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321->sample_08b4ced3-f682-4804-abb2-53b441995321_Position\n", + "\n", + "\n", + "cmso.hasAttribute\n", + "\n", + "\n", "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SimulationCell->sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SimulationCellVector_3\n", - "\n", - "\n", - "cmso.hasVector\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321->sample_08b4ced3-f682-4804-abb2-53b441995321_SimulationCell\n", + "\n", + "\n", + "cmso.hasSimulationCell\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SimulationCell->sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SimulationCellAngle\n", - "\n", - "\n", - "cmso.hasAngle\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321->sample_08b4ced3-f682-4804-abb2-53b441995321_Material\n", + "\n", + "\n", + "cmso.hasMaterial\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SimulationCell->sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SimulationCellVector_2\n", - "\n", - "\n", - "cmso.hasVector\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321->sample_08b4ced3-f682-4804-abb2-53b441995321_Species\n", + "\n", + "\n", + "cmso.hasAttribute\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SimulationCellLength\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SimulationCellLength\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_ChemicalSpecies\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_ChemicalSpecies\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SimulationCell->sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SimulationCellLength\n", - "\n", - "\n", - "cmso.hasLength\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321->sample_08b4ced3-f682-4804-abb2-53b441995321_ChemicalSpecies\n", + "\n", + "\n", + "cmso.hasSpecies\n", "\n", - "\n", - "\n", - "49ec2be5-b857-41f1-afb4-21c2adf9a635\n", - "\n", - "160.1\n", + "\n", + "\n", + "c46da539-06e3-4fdc-91ac-4b21b8463c77\n", + "\n", + "8\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SimulationCell->49ec2be5-b857-41f1-afb4-21c2adf9a635\n", - "\n", - "\n", - "cmso.hasVolume\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321->c46da539-06e3-4fdc-91ac-4b21b8463c77\n", + "\n", + "\n", + "cmso.hasNumberOfAtoms\n", "\n", - "\n", - "\n", - "d2f6a803-f0d7-43b9-a1de-acdf72c4755f\n", - "\n", - "5.43\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SpaceGroup\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SpaceGroup\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SimulationCellLength->d2f6a803-f0d7-43b9-a1de-acdf72c4755f\n", - "\n", - "\n", - "cmso.hasLength_x\n", + "\n", + "\n", + "7a6d4b48-f460-46ae-80e2-b9fe127db17e\n", + "\n", + "221\n", "\n", - "\n", - "\n", - "484a10b9-5f82-4a42-ba7f-1c5eb411d79e\n", - "\n", - "5.43\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SpaceGroup->7a6d4b48-f460-46ae-80e2-b9fe127db17e\n", + "\n", + "\n", + "cmso.hasSpaceGroupNumber\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SimulationCellLength->484a10b9-5f82-4a42-ba7f-1c5eb411d79e\n", - "\n", - "\n", - "cmso.hasLength_y\n", + "\n", + "\n", + "c05fd7de-50eb-4c9b-aa2e-aac41676cacb\n", + "\n", + "Pm-3M\n", "\n", - "\n", - "\n", - "53545457-0574-450e-844b-79e740d422e6\n", - "\n", - "5.43\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SpaceGroup->c05fd7de-50eb-4c9b-aa2e-aac41676cacb\n", + "\n", + "\n", + "cmso.hasSpaceGroupSymbol\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SimulationCellLength->53545457-0574-450e-844b-79e740d422e6\n", - "\n", - "\n", - "cmso.hasLength_z\n", + "\n", + "\n", + "f9b65715-e6d3-40a9-a440-138c916f863c\n", + "\n", + "5.43\n", "\n", - "\n", - "\n", - "fc01be2b-831a-4d27-8f8b-5b864c0b1431\n", - "\n", - "03882Cdc-690B-4Fed-84A9-5D39B735D3B0\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_SimulationCellLength->f9b65715-e6d3-40a9-a440-138c916f863c\n", + "\n", + "\n", + "cmso.hasLength_y\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_Position->fc01be2b-831a-4d27-8f8b-5b864c0b1431\n", - "\n", - "\n", - "cmso.hasIdentifier\n", + "\n", + "\n", + "aa58d1b0-8f70-4e5b-9cf3-01bf9bbc42fd\n", + "\n", + "5.43\n", "\n", - "\n", - "\n", - "aa6faa60-f435-457e-bfdd-83d2e5a940d9\n", - "\n", - "Position\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_SimulationCellLength->aa58d1b0-8f70-4e5b-9cf3-01bf9bbc42fd\n", + "\n", + "\n", + "cmso.hasLength_z\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_Position->aa6faa60-f435-457e-bfdd-83d2e5a940d9\n", - "\n", - "\n", - "cmso.hasName\n", + "\n", + "\n", + "802803d4-ac46-40e2-ab5b-ef3d8797ad70\n", + "\n", + "5.43\n", "\n", - "\n", - "\n", - "2f714549-446c-4709-8b8b-4aeb257030a5\n", - "\n", - "Rdf_Structure_Store/C91A3F03-A2A6-4C4A-Ae4B-D89B8Ae9427C.Json\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_SimulationCellLength->802803d4-ac46-40e2-ab5b-ef3d8797ad70\n", + "\n", + "\n", + "cmso.hasLength_x\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_Position->2f714549-446c-4709-8b8b-4aeb257030a5\n", - "\n", - "\n", - "cmso.hasPath\n", + "\n", + "\n", + "CHEBI.18248\n", + "\n", + "CHEBI.18248\n", + "\n", + "\n", + "\n", + "c2e33ef8-5a05-4564-9d17-534a66f06509\n", + "\n", + "Fe\n", + "\n", + "\n", + "\n", + "CHEBI.18248->c2e33ef8-5a05-4564-9d17-534a66f06509\n", + "\n", + "\n", + "cmso.hasChemicalSymbol\n", + "\n", + "\n", + "\n", + "29a79fb4-4cb8-4b19-b2c0-70740ce931d7\n", + "\n", + "1.0\n", + "\n", + "\n", + "\n", + "CHEBI.18248->29a79fb4-4cb8-4b19-b2c0-70740ce931d7\n", + "\n", + "\n", + "cmso.hasElementRatio\n", + "\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_ChemicalSpecies->CHEBI.28984\n", + "\n", + "\n", + "cmso.hasElement\n", + "\n", + "\n", + "\n", + "CHEBI.28112\n", + "\n", + "CHEBI.28112\n", + "\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_ChemicalSpecies->CHEBI.28112\n", + "\n", + "\n", + "cmso.hasElement\n", + "\n", + "\n", + "\n", + "652df65a-f778-419c-99a5-b75e6aa9e843\n", + "\n", + "3.57\n", + "\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_LatticeParameter->652df65a-f778-419c-99a5-b75e6aa9e843\n", + "\n", + "\n", + "cmso.hasLength_z\n", + "\n", + "\n", + "\n", + "c1bd8924-f800-4aaf-8cf6-2017d1e7b128\n", + "\n", + "3.57\n", + "\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_LatticeParameter->c1bd8924-f800-4aaf-8cf6-2017d1e7b128\n", + "\n", + "\n", + "cmso.hasLength_x\n", + "\n", + "\n", + "\n", + "c6b0c91c-4cb5-4958-885e-7511e731213c\n", + "\n", + "3.57\n", + "\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_LatticeParameter->c6b0c91c-4cb5-4958-885e-7511e731213c\n", + "\n", + "\n", + "cmso.hasLength_y\n", "\n", "\n", - "\n", + "\n", "CHEBI.27573\n", - "\n", - "CHEBI.27573\n", + "\n", + "CHEBI.27573\n", "\n", - "\n", - "\n", - "25633acc-c1ed-48d3-824f-09e6cbb17405\n", - "\n", - "Si\n", + "\n", + "\n", + "sample_08b4ced3-f682-4804-abb2-53b441995321_ChemicalSpecies->CHEBI.27573\n", + "\n", + "\n", + "cmso.hasElement\n", "\n", - "\n", - "\n", - "CHEBI.27573->25633acc-c1ed-48d3-824f-09e6cbb17405\n", - "\n", - "\n", - "cmso.hasChemicalSymbol\n", + "\n", + "\n", + "8475d7a2-cdd9-4b9b-868b-08630854dd99\n", + "\n", + "0.0\n", "\n", - "\n", - "\n", - "d7493e1c-7b4a-4339-af3b-d2c35bf4f26e\n", - "\n", - "1.0\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SimulationCellVector_1->8475d7a2-cdd9-4b9b-868b-08630854dd99\n", + "\n", + "\n", + "cmso.hasComponent_y\n", "\n", - "\n", - "\n", - "CHEBI.27573->d7493e1c-7b4a-4339-af3b-d2c35bf4f26e\n", - "\n", - "\n", - "cmso.hasElementRatio\n", + "\n", + "\n", + "8524ae85-6411-45ec-be66-6e5d8f5f9dd3\n", + "\n", + "0.0\n", "\n", - "\n", - "\n", - "c7b3a055-9196-4135-824b-f163a3b4d581\n", - "\n", - "0.0\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SimulationCellVector_1->8524ae85-6411-45ec-be66-6e5d8f5f9dd3\n", + "\n", + "\n", + "cmso.hasComponent_z\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellVector_3->c7b3a055-9196-4135-824b-f163a3b4d581\n", - "\n", - "\n", - "cmso.hasComponent_x\n", + "\n", + "\n", + "e13dcc5d-cfe7-4d14-a41b-b6adc4cb037a\n", + "\n", + "3.57\n", "\n", - "\n", - "\n", - "9a6813b6-2a9e-4e56-8783-1d48f8878a46\n", - "\n", - "0.0\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SimulationCellVector_1->e13dcc5d-cfe7-4d14-a41b-b6adc4cb037a\n", + "\n", + "\n", + "cmso.hasComponent_x\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellVector_3->9a6813b6-2a9e-4e56-8783-1d48f8878a46\n", - "\n", - "\n", - "cmso.hasComponent_y\n", + "\n", + "\n", + "391d8ffc-34be-483e-9a24-9b5364a4bc1e\n", + "\n", + "1.0\n", "\n", - "\n", - "\n", - "8cce2030-5ef5-4889-aa4a-85fb6851dc8a\n", - "\n", - "2.87\n", + "\n", + "\n", + "CHEBI.27573->391d8ffc-34be-483e-9a24-9b5364a4bc1e\n", + "\n", + "\n", + "cmso.hasElementRatio\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_SimulationCellVector_3->8cce2030-5ef5-4889-aa4a-85fb6851dc8a\n", - "\n", - "\n", - "cmso.hasComponent_z\n", + "\n", + "\n", + "d7671157-d5d6-4e77-92be-801596d6c4e5\n", + "\n", + "Si\n", "\n", - "\n", - "\n", - "40de8e71-2d27-4a85-81d9-f1919a742899\n", - "\n", - "90.0\n", + "\n", + "\n", + "CHEBI.27573->d7671157-d5d6-4e77-92be-801596d6c4e5\n", + "\n", + "\n", + "cmso.hasChemicalSymbol\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_LatticeAngle->40de8e71-2d27-4a85-81d9-f1919a742899\n", - "\n", - "\n", - "cmso.hasAngle_beta\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_Material->sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_CrystalStructure\n", + "\n", + "\n", + "cmso.hasStructure\n", "\n", - "\n", - "\n", - "ccbf5dfb-d747-40ec-9799-2a270ab8fd6e\n", - "\n", - "90.0\n", + "\n", + "\n", + "e6e0fcc4-0ce3-4999-8b11-263311916afe\n", + "\n", + "Im-3M\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_LatticeAngle->ccbf5dfb-d747-40ec-9799-2a270ab8fd6e\n", - "\n", - "\n", - "cmso.hasAngle_alpha\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SpaceGroup->e6e0fcc4-0ce3-4999-8b11-263311916afe\n", + "\n", + "\n", + "cmso.hasSpaceGroupSymbol\n", "\n", - "\n", - "\n", - "1faa5dcb-6f86-43a6-b930-bf9cd6de416c\n", - "\n", - "90.0\n", + "\n", + "\n", + "c68193f2-fe60-435f-8d10-5b104f3eb02a\n", + "\n", + "229\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_LatticeAngle->1faa5dcb-6f86-43a6-b930-bf9cd6de416c\n", - "\n", - "\n", - "cmso.hasAngle_gamma\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_SpaceGroup->c68193f2-fe60-435f-8d10-5b104f3eb02a\n", + "\n", + "\n", + "cmso.hasSpaceGroupNumber\n", "\n", - "\n", - "\n", - "851f9bc8-ea76-4d72-af48-0e7a20963828\n", - "\n", - "3.57\n", + "\n", + "\n", + "455a790d-1d0d-40fc-a2a3-d46d9aad29ec\n", + "\n", + "0.0\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SimulationCellVector_1->851f9bc8-ea76-4d72-af48-0e7a20963828\n", - "\n", - "\n", - "cmso.hasComponent_x\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SimulationCellVector_3->455a790d-1d0d-40fc-a2a3-d46d9aad29ec\n", + "\n", + "\n", + "cmso.hasComponent_x\n", "\n", - "\n", - "\n", - "b6dec154-d25f-42de-9d40-4f2ecb4675e0\n", - "\n", - "0.0\n", + "\n", + "\n", + "328eb493-e965-41a4-b80f-f3fff78a08fb\n", + "\n", + "0.0\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SimulationCellVector_1->b6dec154-d25f-42de-9d40-4f2ecb4675e0\n", - "\n", - "\n", - "cmso.hasComponent_y\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SimulationCellVector_3->328eb493-e965-41a4-b80f-f3fff78a08fb\n", + "\n", + "\n", + "cmso.hasComponent_y\n", "\n", - "\n", - "\n", - "58ad1444-4587-4434-9785-6baae96f49ef\n", - "\n", - "0.0\n", + "\n", + "\n", + "b1f275df-a5c6-46db-90a8-c810d216044e\n", + "\n", + "3.57\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_SimulationCellVector_1->58ad1444-4587-4434-9785-6baae96f49ef\n", - "\n", - "\n", - "cmso.hasComponent_z\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SimulationCellVector_3->b1f275df-a5c6-46db-90a8-c810d216044e\n", + "\n", + "\n", + "cmso.hasComponent_z\n", "\n", - "\n", - "\n", - "96dac703-9378-47da-a387-4ff53b67b799\n", - "\n", - "Fd-3M\n", + "\n", + "\n", + "d77ed71c-ea19-4d17-9928-e5abf49ac605\n", + "\n", + "Ni\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SpaceGroup->96dac703-9378-47da-a387-4ff53b67b799\n", - "\n", - "\n", - "cmso.hasSpaceGroupSymbol\n", + "\n", + "\n", + "CHEBI.28112->d77ed71c-ea19-4d17-9928-e5abf49ac605\n", + "\n", + "\n", + "cmso.hasChemicalSymbol\n", "\n", - "\n", - "\n", - "0fb65695-72b4-4eb5-b5a3-19c8b10e52de\n", - "\n", - "227\n", + "\n", + "\n", + "b3aa0f5b-bce9-4ac9-ada8-f63fd0537a21\n", + "\n", + "0.75\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_SpaceGroup->0fb65695-72b4-4eb5-b5a3-19c8b10e52de\n", - "\n", - "\n", - "cmso.hasSpaceGroupNumber\n", + "\n", + "\n", + "CHEBI.28112->b3aa0f5b-bce9-4ac9-ada8-f63fd0537a21\n", + "\n", + "\n", + "cmso.hasElementRatio\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_Material->sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_CrystalStructure\n", - "\n", - "\n", - "cmso.hasStructure\n", + "\n", + "\n", + "8b4c3111-2527-4626-840d-776860183489\n", + "\n", + "3.57\n", "\n", - "\n", - "\n", - "39bfcb8e-f78a-4800-bbf3-10a9de7462cb\n", - "\n", - "Rdf_Structure_Store/2C1336A0-2Fe0-4868-A5Fd-5Bc6365Bb952.Json\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SimulationCellLength->8b4c3111-2527-4626-840d-776860183489\n", + "\n", + "\n", + "cmso.hasLength_y\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_Species->39bfcb8e-f78a-4800-bbf3-10a9de7462cb\n", - "\n", - "\n", - "cmso.hasPath\n", + "\n", + "\n", + "5e74cc4a-e588-427e-915e-aed3f83f64db\n", + "\n", + "3.57\n", "\n", - "\n", - "\n", - "9be02d17-80f5-4fe8-8c9d-ef116830a0f1\n", - "\n", - "Species\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SimulationCellLength->5e74cc4a-e588-427e-915e-aed3f83f64db\n", + "\n", + "\n", + "cmso.hasLength_z\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_Species->9be02d17-80f5-4fe8-8c9d-ef116830a0f1\n", - "\n", - "\n", - "cmso.hasName\n", + "\n", + "\n", + "daa4206b-2e48-45b4-a4ca-05c17d671a32\n", + "\n", + "3.57\n", "\n", - "\n", - "\n", - "f72a3b47-5ab8-403c-8410-77b6cf1aa144\n", - "\n", - "C2Bc3D20-8995-4Be8-A7A7-9828A6C746A8\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SimulationCellLength->daa4206b-2e48-45b4-a4ca-05c17d671a32\n", + "\n", + "\n", + "cmso.hasLength_x\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_Species->f72a3b47-5ab8-403c-8410-77b6cf1aa144\n", - "\n", - "\n", - "cmso.hasIdentifier\n", + "\n", + "\n", + "sample_ba7b1ac6-e72c-4b07-abd2-4b1db132d563_ChemicalSpecies->CHEBI.18248\n", + "\n", + "\n", + "cmso.hasElement\n", "\n", - "\n", - "\n", - "sample_c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c_ChemicalSpecies->CHEBI.18248\n", - "\n", - "\n", - "cmso.hasElement\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_CrystalStructure->sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_UnitCell\n", + "\n", + "\n", + "cmso.hasUnitCell\n", "\n", - "\n", - "\n", - "sample_2c1336a0-2fe0-4868-a5fd-5bc6365bb952_ChemicalSpecies->CHEBI.27573\n", - "\n", - "\n", - "cmso.hasElement\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_CrystalStructure->sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_SpaceGroup\n", + "\n", + "\n", + "cmso.hasSpaceGroup\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_ChemicalSpecies->CHEBI.28984\n", - "\n", - "\n", - "cmso.hasElement\n", + "\n", + "\n", + "63fceb82-b1e4-480c-a0e7-f3f448f612bb\n", + "\n", + "L12\n", "\n", - "\n", - "\n", - "sample_4e73fc35-0b29-4588-8bc8-c94e93b57ee0_ChemicalSpecies->CHEBI.28112\n", - "\n", - "\n", - "cmso.hasElement\n", + "\n", + "\n", + "sample_92f0563e-9d7a-4a39-9c15-d909318feaf3_CrystalStructure->63fceb82-b1e4-480c-a0e7-f3f448f612bb\n", + "\n", + "\n", + "cmso.hasAltName\n", "\n", "\n", "\n" ], "text/plain": [ - "" + "" ] }, "execution_count": 7, @@ -3141,7 +3141,7 @@ "
\n", " 0\n", " bcc\n", - " sample:c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c\n", + " sample:ba7b1ac6-e72c-4b07-abd2-4b1db132d563\n", "
\n", " \n", "\n", @@ -3149,7 +3149,7 @@ ], "text/plain": [ " hasAltNamevalue AtomicScaleSample\n", - "0 bcc sample:c91a3f03-a2a6-4c4a-ae4b-d89b8ae9427c" + "0 bcc sample:ba7b1ac6-e72c-4b07-abd2-4b1db132d563" ] }, "execution_count": 14, diff --git a/examples/02_grain_boundaries.ipynb b/examples/02_grain_boundaries.ipynb index 10b5aaa..f6f810f 100644 --- a/examples/02_grain_boundaries.ipynb +++ b/examples/02_grain_boundaries.ipynb @@ -48,7 +48,9 @@ "cell_type": "code", "execution_count": 3, "id": "39d31155-30e2-4b02-91a6-35a25b04c8d4", - "metadata": {}, + "metadata": { + "scrolled": true + }, "outputs": [], "source": [ "struct_gb_1 = System.create.defect.grain_boundary(axis=[0,0,1], \n", @@ -1300,10 +1302,11 @@ "width": 700 } }, + "image/png": "iVBORw0KGgoAAAANSUhEUgAAApEAAAFoCAYAAAAPXqCHAAAAAXNSR0IArs4c6QAAIABJREFUeF7sfQl4TWfX9kqJIVMHCWKKNoSo1hBDXyUoWi2pokW0CUqlRE0xpCihqCmoCqXaSlJjK76KqUSRtlokMbQVQlRMkaKDSNTU/P/asdMz7HP2fM7e+6x9Xa73+5pnWM+9nnPOvdfoVlJSUgL0EAKEACFACBAChAAhQAgQAiIQcCMSKQItGkoIEAKEACFACBAChAAhwCBAJJIuAiFACBAChAAhQAgQAoSAaASIRIqGjCYQAoQAIUAIEAKEACFACBCJpDtACBAChAAhQAgQAoQAISAaASKRoiGjCYQAIUAIEAKEACFACBACRCLpDhAChAAhQAgQAoQAIUAIiEaASKRoyGgCIUAIEAKEACFACBAChACRSLoDhAAhQAgQAoQAIUAIEAKiESASKRoymkAIEAKEACFACBAChAAhQCSS7gAhQAgQAoQAIUAIEAKEgGgEiESKhowmEAKEACFACBAChAAhQAgQiaQ7QAgQAoQAIUAIEAKEACEgGgEikaIhowmEACFACBAChAAhQAgQAkQi6Q4QAoQAIUAIEAKEACFACIhGgEikaMhoAiFACBAChAAhQAgQAoQAkUi6A4QAIUAIEAKEACFACBACohEgEikaMppACBAChAAhQAgQAoQAIUAkku4AIUAIEAKEgKEQuFlUzJzHy9PDUOeiwxACWkOASKTWNELyEAKEACFACMhCIDfvAhRcvQ5tWjSVtQ5NJgQIAfsIEImkG0IIEAKEACGgOwSOZ5+Cp4MbcMq9K/0ANGkUBNV8fXV3LhKYENATAkQi9aQtkpUQIAQIAUKAQWBX+g/wfOiznGgkb9oCEb1fJqQIAUJAZQSIRKoMMC1PCBAChAAhoDwC9ogikUjl8aYVCQEuBIhE0r0gBAgBQoAQ0BUCRcXF8EPGUXg+tA2n3EmbtkAkWSJ1pVMSVp8IEInUp95IakKAECAEXBYBTJzBJzCgNicGy5PXw7CIfrLwKSkpATc3N1lr0GRCwOgIEIk0uobpfIQAIUAIGAwBe4kzBdeuwbETOTatlEKhIBIpFCka58oIEIl0Ze3T2QkBQoAQ0BkCFy/nw8Lln8DRI0fgUv4VaBhUH1q3aA7BQUHQMqQZnL9cANX8qti0UursuCQuIaBpBIhEalo9JBwhQAgQAoQAEsc9+9IhJXUbFBbehIoentCudQjcKLwJvcK6QfapHMjOOQ2HMrIgv6AAWoU0h+dC20JwgyBoGFQPfLy9nQYiWTSdBj1t7AAEiEQ6AGTaghAgBAgBQkAcAkgcD2ceYYjjpcv50KpFc+jZ/SXG6ojZ1xfOnYWa/v4woH9fs4U/+iwZavlVgeycHDiYkcXMRTIZ3KA+Y63s1KGdQ0klkUhxeqfR+kKASKS+9EXSEgKEACFgWATsEUfTQ6fsTINDP/0ErUOaQ8+wl8zwsCzvc6OwEE7mnGGslYcysxhiiZZJJKXBQfWhVUgzhmTSQwgQAuIRIBIpHjOaQQgQAoQAIaAQAqbEEYle547toXOHUOYf18OW90lY/jHMiZtiRQCF1Ihk9+SyVqIrvFXzZuDj4zwXuELQ0jKEgOoIEIlUHWLagBAgBAgBQsAUAbQO7tn3HaTt2w9p+9IZwtgzrJtN4mg6F7Ovc89dhJEx4+HbrSlmrmkkmJi53bNrZ1GAs9ZKtFKitRLJLFkrRUFIg10UASKRLqp4OjYhQAgQAo5GYHPqdjPi2LlDe9ExigcyjkKlCuVg6DtjIWP/brMjYP1I/GerCLmY85a6v4+UJewg0US3N1oqMS5TSMIOxUOKQZzG6hEBIpF61BrJTAgQAoSAThBASyPzb+9+hoRhNjWW4qlVw1/SCTbvTIOGj9eB2LiZ8PW6JLM17NWPlLSZySQkkUgqSy2VpxlrZc0a/mblhSzPRCRSLuo0X+sIEInUuoZIPkKAECAEdIYAuoU3b93OlNxBoiWXOJoeH2MevSqUh4OZWUxMpOmDBBOtkJ4eHg5BjMtaiVZKtFay2eDe3l4OkYU2IQScgQCRSGegTnsSAoQAIWAwBNQkjqZQ7Ur/ATIOH2ZiFkcMHWyGopCkGjVhZ2M9MWFHqLVSTXlobUJAbQSIRKqNMK1PCBAChIBBETAljmhxQ4tjpw6hkl3VQmASU95HyHqWY5R0QWMx9JM5pa5vrvJCWiiGLgUjmkMIsAgQiaS7QAgQAoQAISAYASRE6KpO25vOzMFi32oTR1Ph0GW9OjGJs7xP0qYtENn7ZcFn4RqoFIm0tY6t8kKIo62yRrIORJMJARURIBKpIri0NCFACBACRkAAiU/Sug1lxLFzx1Cme4yji3TbK+9zs7gYdkso76OWfvjIKEsmP1qxihEBi59bxniqJRutSwgohQCRSKWQpHUIAUKAEDAQApb9qpHkDAjv43DiaAoplvfxq/IIhA98i7O8T8HV69CmRVNNawFxXbryU9icuo2pjYmYJq7byHTPsWzhqOmDkHCEAAAQiaRrQAgQAoQAIcAgwFrHVq9dD4WFN836VWsBImeV91Hi7Fgjk+0D/k7UELMyRz3CIznd80rsS2sQAmoiQCRSTXRpbUKAECAENI6A0H7VWjgGJtW43b3DWd7H2ZnZXPiw1tzEtRvKSh1Z9vrGjO7nuveysqxqAW+SgRDgQ4BIJB9C9HdCgBAgBAyGAFe/aoxxxBqHWn6wvE/OyZOMiJblfbSUVHPiVA4krdtY5rJGWW0VV8cC5hgXmbwyQcvQk2yEACcCRCLpYhAChAAh4AIIsDUM0aWK5WbYXtV6yghGa+OvPx+H1iHNwdKip4Qlki8Zhu+a/OeyvgzvRL0lqDMPWikv5efDpJjRfMvT3wkBzSFAJFJzKiGBCAFCgBAQhgAf6WGJY9q+/UzrQSSMUvpVC5NG/VG2yvsgDru/OwDPhz6rvhAWO5hmrmN3HiS3WC9T6BMdM5HRiSUpFjqfxhECzkSASKQz0ae9CQFCgBCQgYAtEsnVr7pTh3ZMlxe9PublfTaDj0k7QfzblavXoUlwA0BM8HFzc1P1qGyhdewJ3rlje8a9LqUfOMZDJq1MkDRX1QPS4oSAAASIRAoAiYYQAoQAIaBFBExJpCmpwfqNSvar1sLZj504BR6VKkL4IOvyPlj6p5pfFQgMqG0lKp+1VuzZ0GXNZq9bZlmLXQutmK+ER1JSjVjgaLxmECASqRlVkCCEACFACIhD4GBGJmzeugMOZWSVZf+2DGlmSKvWgYwj8Ki3F8TGvQ9fr0syAwrd3F1C24CXhwcvgLZIpT2yydZ2RJyDG9Qviyfl2kwMaUWLMdaLTIifyys3DSAEtIgAkUgtaoVkIgQIAULABgKW/aoH9u8nKIFD74CqVd7HHukzxRqLrQtxWYshkbPjF0NNf38qMq73y+nC8hOJdGHl09EJAUJAHwhgv2rsaoKWMG9vL8ZV7ch+1VpACUv43Lh+lREFydyVq9cAO9Tgsysdk2raMO5sL09+a6Q9CyKSQOwNvnTFpwBQwmRZqxVPGjE0GtAl3iqkmRYgJhkIAdEIEIkUDRlNIAQIAUJAfQSQOCKZSdubzmyG/aojw/sa0lUtBM2UHbvh0MGDEFCnDhTdvQ+pZ76GfyvfNpv60K2K0KLKMzCsX3+oV7eOkGXLxly6nA8frfyUIepodewV9hK0CmnOJOqolaTTon0X+HZriq4TnkSBTIMNhwCRSMOplA5ECBACekXAtMMJnkEL/aq1giVaG9d8mQLnKp2BW4EXrQgkK6fb3XJQObcWhDeKgGERfXnFL3VZb4NDGUcYvPlc1kqRSnxJiI6JZUgkPYSAXhEgEqlXzZHchAAhYAgEWOKIRcC12K9aCyAXXLsO0xYmwM+VvoPbAVcEiVT+Dx8Y4DuSk0iy9TOxUww+I6IGi6rtaCqAKakUQzAxy/tgZhbTM5seQkCvCBCJ1KvmSG5CgBDQLQJ66letBZCTU1Jh5dFljAVSzFMxrzq83XgkRPQKY6aZZlmj1ZFt9SiG/PHtL3St2LiZEBxUn5Jq+AClv2saASKRmlYPCUcIEAJGQUCv/aqdjf/NomIInz4c8p/MlCRKg+zO0KfdC7Dr272Qfeo0p8taKPETK4C9wuc9wiMZKyTW9KSHENArAkQi9ao5kpsQIAQ0jwAXcSxtPRiqedm1ImDyplRIOD8H7j12Q5RI/95wg/sXy8HtgxWg1sO1IXrIm05vLciSyps3i6Bj955UZFyURmmwFhEgEqlFrZBMhAAhoFsEbPWrpt7I0lQaNXUqZAZuFjwZySMSx3u55aF84D1wD74Hncr1g/jYWMFrqD0Qk3mWrvwUklYsZbZSK/tb7XPQ+oQAkUi6A4QAIUAIKIAA268aO5CUWhvbq1ZfUAFxdbEE1oLsO28IFDXO5ZX37onycDfbHZBEInms0PQuPORT2kfb+3Aj2Lt0A+8acgaIcYknrt0Al/LzYVLMaLMtxawhR1aaSwgohQCRSKWQpHUIAULA5RBgiWPa3v1MbJvR+lU7W6Fnzp2HQZ9F2UyoMXVZI2F0D74L7o3uWYntcTIANo5dDdX9fFU7khgCGB0zkXnJIOu0auqghR2EAJFIBwFN2xAChIAxEDBthVezhj8RRxXViiTyzRXDobhhntkuZS7rbHcoH3yXsTqW8/vXpiReR4Jg66xkzm42YsifUkd9rnsvSFqZ4LKF45XCkdZxPgJEIp2vA5KAECAENI4AEUfnKAgzs/vNjoIrQUcZAUxd1kgc0W3NuqztSYgZ2mvmLOIc4mgSiclWr4RHUlKNc64U7aowAkQiFQaUliMECAFjIGBKHF21X7UWNDl62mzY+8+XTLKMPZe1LVmxg023G29B3NhoLRwHMAQC42YT4udqQh4SghCQgwCRSDno0VxCgBAwFAKW/ap7hnVj4tZq1fDX3DkdbUFzNACoi8R1GxnCVbHuQ1C+Q6Egq6OlnJXO1IJl/T+Ep4PVq8coRhez4xdDTX9/KjLu6AtF+6mCAJFIVWClRQkBQkAvCKB7MWndBkjbm86I3LljKNPJROtFoMUQF73oAuXEdoDYAvLS5Xx4J2oIXLx6HX7KyYLTdb+z2S/bnhUy9Jr65X3E6CJiaDRzrlYhzfSkFpKVEOBEgEgkXQxCgBBwOQSM0K9aDHHRuoJZfWDpGzZZic1cTtmxG7KysiD9bAYUh54UfBR0Y9c7FwqfvDuHM6FG8EIKD2zRvgt8uzUFfLy9FV6ZliMEHI8AkUjHY047EgKEgBMQMFq/aiOQSDbuFF3WGDowYuhgq9CBlJ1pkJiYBEPfHAgf706Cgid+4bVIPnSrIgRebAOLRk21W9bH0Riiiz46JpYhkfQQAkZAgEikEbRIZyAECAFOBLRCHHelH4Dj2aesZHw+9FnJsXqOJkBKXjF0Wa9eux4KC28yrt2WIc04406Liovhh4yjMGfeAqYkTnl3d5j/6So4WLQfbgfkQ4n7fTOxkDxWzq0FYfV6wBu9wnjrQjoaQzz3wcwspmc2PYSAERAgEmkELdIZCAFCoAwBLfWrTk5JhZ2HvoXffI7BnZpXGRnRzep2rzzzf1e45AetPdvD+MFDeAmP3lVsGnuKLusB/fvy9hDPzbsAhYWFMCR6lFlJnOPZObA8eT1UqlIO3B4Aw7ivaz4OPbt2ciiWYohobNxMCA6qT0k1er/MJH8ZAkQi6TIQAoSA7hGw7FeNrtHS1oOhTjsbWsw2F6wtI4+2BEHrWbWzjeGd7kPh+dA2TpNXrY1ZlzV29encsT2ny9rW3mjBrVDODWZ8MN/KBZy8aQtE9H5ZLbEFryuGRPYIj2SskFpP2hJ8eBro8ggQiXT5K0AAEALqIyDmh1aMNOgeTNu3n6m9p6V+1Uggvyr+BO77FAs+DrphE8LVLUVjKgz2pT57/iJ4Vq5c9p89PSpDvbp1BMtsbyDq5qMVq5gh6LLu1KGd6GQSJJFFf//F6NiyrqJWSKRQsPBFBzvVZOzfLXQKjSMENI8AkUjNq4gEJAQIAVMEuPpVSyEoaqG6eWcazPt5Btyt+qfoLex1VhG9mI0Jx06cApRxb/5uuPvoDbNRaBVF9/qAHr0kxWqiy3rpyk/hUEYWBDeoD5HhfaF1i+aSRUei+O/tW3ApPx8mxYw2W0dvJPJQ5hGGVCevTJCMB00kBLSGAJFIrWmE5CEECAErBExdougK7BXWzWYyhjPhwzZ94dOHQ/6TmZLEwBjJYQ3HQESvMEnz+SYtT94A604kwz8BV2xmOGNsIVpFwxtFwLCIvnxLMn837e7TqkVzUS5rexvsSv8Bvv12L7QOac4UfTd95JJItazjts6D5Yu4yLAggGkQIaBRBIhEalQxJBYh4OoI6LFfNVr4FhyaC7cDrkhWn1rWSEzyWX5yEW+MJit4+T98oLfPICbpx9Zj6bK2JHqW89CFjkkxppnqnh4eUN2vCnRp18aqniNb3gfd4abxrQXXrsGxEzmyYkgdTSKjYyZC5w7trciw5ItCEwkBDSBAJFIDSiARCAFCoBQBy37VA/v306TF0Za+YubMgXTf9ValZ8To1/OXQNg44VOo5ldFzDS7Y8USSHYx998fheGB480so6Yua7Q6YncfPpc1Wmg//mIDbPt5J9wKvGhlBUU3ul9+fejTujdE9P7PCosxkWx5H9PWkwcyjjL4BAbUVgwjKQuJIaIYD4llirTYQlPK2WkOIYAIEImke0AIEAJORYDtkYxxdPhg6ZdOHUJ1+WPbf8pIyKm/Vxae6NJe8PxCaNOiqax12MlI4MImDoLClickred9uBGsm5YAeXnnmfaQ2adOgxiXNVofY+JnCWpbiKT16cIOMP2dkeDmBnDk52yYEjfDKhkFLb6YyY5WTD08SLxfCY+kpBo9KItkFIUAkUhRcNFgQoAQUAIBJI6bt27XXb9qvrN3HNFXMllj10YSOb3tTOiiULmf5E2pkHB+Dtx7zDyJhu8s+PeS2wD//uoJtw9WgOq+vkyWNZ/L2nRdMQSSnYdWyfrn2sGAl14D30e8YdykaVblfbAVYq8Xuwg5gibGYDIYduWxzDDXhHAkBCEgAwEikTLAo6mEACEgHIFLl/OZUjwpqduYTiVozRoQ3sdQNfOUsER6nAyAz6KWKVZq55Vh0XDxmXThigKAf2+4McTxXm55KB94D4K9W8JXy5eLWgMHj42fBd97buZtU2i5cLkbHlDjeGuIfv1VTvKVtGkLRMqoESnGDS360BwTZscvhpr+pQXW6SEEjIQAkUgjaZPOQghoDAG2ewzb4k5oDJ3GjiFYnLiFCbDd43PRpMl0A68jQbB1VrJVkolgIUwGoiWw77whUNQ4V9D0u7nl4O7RCgyJRPJYoeldeMinBNClnTr3c1EyYQLN8LWj4J96FwXtbTkIY0O71X4e7t29o3h5H0eTyIih0YwVt1VIM0lY0CRCQKsIEInUqmZILkJApwhw9avuFfYStAqRXi9QL1BgIkjc91MEZ0BbngvL64Re6wfxsbGKHPnMufMwYv1ouOZ/2uZ6SBjvXyzHWB7dKpYwxNG90T2z8VKso+NmLoD91b+QnGSE1siSrdXh3RFRZi507KeNOPfs2lkRjKQuIoaItmjfhXHJ+3h7S92O5hECmkSASKQm1UJCEQL6QoCrX7WQrF19nZJfWkximfrxQvBp/Q8U3rkB+y+IS7KpdKYWLOuvXNcatET2WTgQihvmWQlf5rLOdofywXfBPfgelK91n/OQYq2jcpN5WCEqbQ2GuOgRZuV9cvPOw83iW9AkuAG/QjQwAuN/o2NireI6NSAaiUAIyEaASKRsCGkBQsA1EWD7VWOMI/5QYl9kZ/er1oImkEB9/+tPkHB+LuQXXRYsEiaUtPvrVUFWSDFWMMtkn7snysPdbHfGZY1WR3Rbo8va3iO2diV2xUELKJbzkfOgG/2LSYuhZg3/smVw7cCAWkxmthumcGv8wVqaBzOzmJ7Z9BACRkOASKTRNErnIQRURIAljpb9qoVk7IohPioewSFLY13GlUeXCSZRbEZyfMxkqO7nyyujGCzRrbzXYy3cKyhhXNZIGN3R8mjhsra1KbrYu914C+LGRvPKxQ44kHkUxn0zVrJbn13HIzMQts9ZC14mpXywvI+lK1sMHoIPodDA2LiZEBxUn5JqFMKTltEWAkQitaUPkoYQ0CQCbL9qLFOCsY3YdlBL/aq1CBqSnUX7FzNEssSd202McmNJn8dvNAGhBBLnCCVNGGbw3qy5cOCng4zLGi2P5fz+FQWXFBe7UpZILgsoX7tDPmz4/i4KHAGDe4RHMlZIbNdJDyFgNASIRBpNo3QeQkAhBFjimLZ3P/MDKLdftaN/vBWCQdYyZ/MuQMK6NXD47+/hnnex2Vpu98pB3eLGTD1ELJwt5uHDEl2oGGaAZZUwK3j9vu3wW/2fRGeNS030USIm0pYFlI9EmuKIOOFj6vbmw06MHvjGouUeO9Vk7N/NN5T+TgjoEgEikbpUGwlNCKiDgJr9qh35460OOtJXxSzp36//AUVF/xHJan6+8HSwctYptDru2ZcOiWs3MDGESPrZMAO26HdOvb2Cs6WRxNU7FwqLRk0V5GK3REdudjb27o54LBqiB/Q3W1oMibSUiYtUStcq/8xDmUfgoxWrIHllAv9gGkEI6BABIpE6VBqJTAgoiYDe+1UriYUe12LbRmKoQc+wbjBi6GDOlpFiuseIjdHkwg3L8EzfNw1uB1yRBKvnTw1gSId+ENH31bL5N4uLYbdC5X0c8VKDhP5Sfr5VnUtJgNAkQkCDCBCJ1KBSSCRCQG0ELIljaYyjPvtVq42VVte3dFm3DGnG228c3czTPlrCuNfvVP3TqhUiksfKubUgrF4PeKNXmCQLpCleuNcO9yTRbnS0Qnqk14ZJo4ZblPe5AAVXryvWV5yVVS1CGR0zETp3aC+qVaRW7xvJRQhwIUAkku4FIeAiCHD1q44M78tLPFwEHl0cE13WSWs3AGbH16xRw8xlLeYA2E3mh4wjkJt3oWxadb8qgC72Lu3+J5s8sosiaY16fzKcrvudYCKJiUa9qkTA9tRUSFqZYHY/0brZpFEQVPPlz2AXg4fpWCUJJcZDWp5Bqlw0jxDQIgJEIrWoFZKJEFAIAdM4OVyyc8dQwCLglCmqEMAOWoa1HGOSE9bixGQZ09qJDhJD0jYFV6/BvE9XwYFy2+Fu1T9troFW0IqX/aB//QHQJLghDIoaBqcyfzQbLyceEhcSSxC5xgtdAz97r4RHUlKNpFtDk/SCAJFIvWiK5CQEBCLAEkfMzi0svAlG71ctEBZdDkOXNdt3HImjEJe1Vg+KJY8++/YL+MPrEty3yFR3/9MHWj7cFrq27AiBAbXh77//gnGTpll1eUnZsRt6vdhF8hGFEkCuDdikHPybkCLnWN0A41QT4udKlpcmEgJaR4BIpNY1RPIRAgIQ4OpX7YptBwVApfkhqMulKz+FQxlZENygPpMsg9ZHIzzo3j5+MscsSx3PVdW3CjRpVNrGEF3Wt27egF179loRsKRNWyCy98uagIKPkM6OXww1/f2pyLgmtEVCqIUAkUi1kKV1CQGVESDiqDLADl7eNNkJrce2sqwdLJbDt0vZmQaFf1znzGqW685W6zBchDJiaDQTdtAqpJla29K6hIDTESAS6XQVkACEgHAETIkj9au2jRuflUg44uqPRJc11hLEB0mHq3cCStm5G07++quVFa/g2jU4diJHdGF29TVovgN791q078K44328vR0tAu1HCDgMASKRDoOaNiIEpCHA1a/aSC5Oaajoe5apy5piVs11iXGPe9LSrNz4BzKOQjW/KkzMpLMeoS8n2TmnIXrsRNiTuklQ/KSzzkP7EgJyESASKRdBmk8IqIQAWqiwlAsG6GNMHNabc3UrlUpQO2xZclnzQ40xkXPmLbAqjYOJOdge0tPDg38RjhFCCaC9xYWugZ/dg5lZTM9s9hE6V9LhaBIh4CQEiEQ6CXjalhDgQkDpftWEsvMRYC3Jpi5rth2h86XTlgRFxcXwQ8ZReGdMjNPL+8hBJjZuJgQH1aekGjkg0lxdIEAkUhdqIiGNjICa/aq1hpsrWWPIZS3+9mHx80uX8yFu1hyr8j5aTarhOmWP8EjGCkn1WMXfAZqhLwSIROpLXyStQRBwJeJoEJUJPgZbHzD71GmmRqerZlkLBsxkoL3yPnohkWh5xk41Gft3S4GA5hACukKASKSu1EXC6hkB6lctvmOIXvTNZs2jy9rb2wsG9u+nWr9kI1tzMe7xBkd5H3RzI8Hs2bWz066EUNwPZR5hsu2TVyY4TVbamBBwFAJEIh2FNO3jkghY9qse0L8vdOoQ6rL9qoX+EOvlsrAua6YdYcf2TEvJ1i2aqyq+0TA0BQszs0+e0GZ5H6G4J67dwFnjUtVLQYsTAk5CgEikk4CnbY2LABKLpHUbIG1vOnNI6ldtPF1j9i22lcT4PdRvZHhfh70YCCUzekQda0Tu2c1d3iewbi2o5usr6ViOxCw6ZiJTSYGSpySpiibpDAEikTpTGImrTQS4+lUPCO9DgfXaVJckqUxd1jVr+EOvsG5OIQqOJESSgJIxCd3ZHy1dpsnyPkKPhfGQSSsTHPZSIVQuGkcIqIEAkUg1UKU1XQIBllSsXrseCgtvMkkUjnBn6hlcPRIg1mW9OXUbUwCbXg7UuYFqlvdRR2LrVfGuvBIeSUk1jgKc9nE6AkQina4CEkBPCFC/aj1pS56spi5rV49llYeksNlaLu8j9OWHzcxPiJ8r7NA0ihDQOQJEInWuQBJffQS4+lWTxVF93J2xg1Zc1s44u7P3tFfeJ2nTFojs/bLTRBRKImfHL7bq+e00oWljQsABCBCJdADItIX+EGC7jGDyBGZYY+ZtaevBUE0f5srVa/BFSips+3kn/Fv5dpmsD92qCM1rNYO2TVs4tUyKVsFDHSeu2wisy5pqOzqTyl+PAAAgAElEQVReU0gi8y9eAOw7bdouUGp5H/wsnD1/EQpvFsFDbm7Mgar6lvbe9vKU1jqRD5WIodHwTtQQaBXSjG8o/Z0QMAQCRCINoUY6hBIIsMRRr/2qk1NSYdWPn8I/dfLhvk+xFSRud8uB+++PwVP/tIWJg9+CJwJqKwGbrtcwdVnjj3/LkGaUEKGyRpEsHs8+ZbUL9sT+8/d8K0seurkLrl6HNi2aCpKMfZHKuHIYLridhpLy983mVfmrDvRp3Rt6du2kOJls0b4L02nHx9tbkKw0iBDQOwJEIvWuQZJfNgJc/ao7dWinqx8CJJDLTy6COzWv8uKBZLLab0/BkqGzXZJIspn0WM/PmVnWvIpSYQBLsHIKzpgRKO8K3tC0fiPo0q6N4sSKPQZmXn+1bxv85nOs7J6ihZx9KlzyA59LNWDC4Legw7PPlP13JJ1NGgUJKu9zNu8CjFw5Ca75noV7j92wiWD5P3wgsKAVxMdMhup+0soGWS6O9ypyaLRVu0YV1EhLEgKaQYBIpGZUQYI4EgG2ewwWicb+tliuRa9WKDEE0hTjeufaweLhMxT7EXWk/qTsxepcTZc1krQfM4/C0dMn4GZRMbjdK8+I6uVRGZo0aqAqSbOHCcqC92T98XVwu8ZVK4KFLxbl//SBun83hXdfHwFPBwdJgdjmnPmfroLNBWt5X3JQjuo5TeGd7kPh+dA2zHopO9Kg14v8nWqQQI74bAL8/sQvgmTHvfwuBMPSN+fZfZkSGg+JVu2DmVlmrnhBgtAgQkDHCBCJ1LHySHRxCBixX/Xx7BwYvnYU/FPvojgwAACtQH3comFc1CDRc/U0AX/c2TJMarqslydvgO0/74Drj5y3IktsKEFAcWNVSBofgRwbPwuOVv3GLE7W1pxKZ2pBVLPhENErTBE1Iy6r/1rIGWJha4PKubUgIfxDhswK6ZmN5H3MhzPgTN10KHE3d1/zHaJBdme7FkmhJJKSaviQpr8bEQEikUbUKp2pDAHLftXY01ivFkcutcYtTIBtPp+I/uFk1/L8JRA2TFhlOGukadcgdFljiR41k6LQ0pbyRxLcrfon76dPaZKmJIFk10ISN7SpfCKJLuz5WbN5LZBcZ0Byt+K9WYBrRPBkZsv5HLj//igMDxwvmzT3CI9krJDo2aCHEHAVBIhEuoqmXeicbKbtoYws8Pb2YlzVRuxXjS7K8OnDIf/JTMnaxdiw6IBY2T+gYgQQatkRsyY71vSlAYu/OyLLGgnkV8WfiLa0jW0To3qmfPKmVEg4P8dufKAtnL0PN4J10xIkv2DIvZ8YI/l2g9GMePbK+8jdB9fHs6bO/VxyPCgm5WGnmoz9u6VcW5pDCOgWASKRulUdCW6KABLHzVu3m/WrdmQ/Y2doY3f6AZj2/RRJVh5WXnSzdrvxFsSNjXbGERTbE13WH61YxayHLmtHJUYhSVt2dr4gC6TlYdW2AsslV3LDHQ5kHoXx28bD7YArkvWMcbuzBr4LT9SpBW4PyvRYLoaWynk/z5CkA3atinnVYdmrS5m4VSnPocwjzP1LXpkgZTrNIQR0iwCRSN2qjgQ3zbJFNDp3DGXaDrqKOwlJ5HuZ4yVZmUxvT/O8l2Hl1FkOu1BKWSLZdoRocQ5uUB/wpaF1i+YOOwdu9PLYIXC5yUFJe8olaXybynEls2v7/xoCqfNW823F+feYOXMg3Xe95FALXNTjZAB8FBkPTYL/I3eW92fBis9hQ7kPZe1jyyIv9K5ipv+l/HyYFFNqOaWHEHAVBIhEuoqmDXJOljhiEXBX71eNJGFu9jTZJDIktyesmDHDYTdE6A+zLYGc4bLmkkVOUhO7nteRINg2OxmwRqLSj1Ik7rOoZVCvbh3R4r0eOwZOBaeJnmc6AV3aC15YCG1CuGtE4l0aP2sB7KudJGsfJPSDPMfDsIi+ZusIvauxcTOhdUhz6Bn2kiw5aDIhoDcEiETqTWMuKC/1q+ZWuhLuQrWtYUpeV0uXtbN/sOUkc7C4YALL0vDFZpY2pTBTgsRh0kn8c0tskjh7soZNGCgrXhfXRhI5ve1M6PKg3A/XfqiHrVU+lgUbnnPCU1Mlx6hiPGTSygQqVC9LCzRZjwgQidSj1gwgM98bPvWr5lcyljXpNysKbjbL4R9sY4TcH0/JGwucaOqyxkQZLfUsHzpjMmQFbBF4Eu5h6EadGDxdMHnh+9yY7oJJV6frfidLPiEkztYGSuCD7mw+S6iUEkKWMmNM5Pxu8yWRZUqqkXXFaLLOESASqXMFGkl8LuKoh37VztQBuiy/e+QrQfX/uOREd+rWWcmSs1LVOju6rJPWbYDsU6fBUVnWYs+iBEkSS+LFkMioqVMhM3Cz2GOZjRdC4mxtgLGKG0sSJN9NXBeTj7bFrbV7P4+dOAXDvxohK4EHz7lx7GpJmejY8QoL2CfEz5WFNU0mBPSIAJFIPWrNQDLb6lftbFelXiDGH9CJW96Fa/6nRYuMVrABviOt4sBEL6TQBPYumGZZa/kejJuJsXiJsk4v1gImhkQqQeLkvGRgu8I4GdUDsHJA6LV+EB8by4uxHNc9hnS0++tVq32EYk1FxnnVQwMMjACRSAMrV8tHY/pV793PlOUptTa2d1hZFi3jIkU2KZYY/OEMvNgGPnl3jtOtkKzLGu9D547tNeWytqcPdKMmXlsiK7FJbJkfocQG5ZYbMyuGxNnCSQ65w6LsU7u8V9b+0J4ukLC+n/Y+3AoU37kJdfD5iI+sWh8KxTpiaDRTVqpVSDMpH1+aQwjoGgEikbpWn76EZ4jjA/KIZXjQytQqpDkFoyugxmXr1sCa06sFufSQQNY/185uqzcFROJdAu8CUxrlcj5TnklvdT2RvI/8fCIUNc7lPSvXACRpzc+/rGpmPJK4nHp7JZW/QRK3rH9p60Gpz4GMo4ylXCy5wzta41hrxjoYGFBb0PZSesgznXmaDOPtiGNPgBbtu8C3W1PAx9tbkJw0iBAwEgJEIo2kTQ2exYj9qjUIMyMSlvxZvGcp3K5xldM6hj/M+KPZ0b8LvB3RV1L8l9yzo9XxUGYWLF2xCry9vQHbUGrZZc13XiRpmLzyb+XbfEOt/i7G0iZ68QcTMPlqyOIxcCXoqKglbLl4RS3yYDCSu5VHlwkmkuxLTtsnn4HI3mGiyh+hdXjt6dW8e+EeFS/7yW7tiPc5cmg0QyLpIQRcEQEika6odZXPTMRRZYDtLI+kYXf6j/DlD19D4Z1Cs5Eh1Vsy7Q2lduWQcyrWZY0JCD3DukGvB1ZoOWtqYW7Btevw5qLRUOBEksaHA7q1Y7+aAsUN8/iGMn9HgtX09xdgYcxkzlAHdB1/cyCduV9enqX1Lds+2RoKrl5nspu57hf7glPc4Jxdqyhmgz9+owljJcdi+nw9s7kOhPJ9tvcLuOB2Gu7UuGq2H0se69xpCANeeo3TVY5ubPax1SWH/TuWnTqYmcX0zKaHEHBFBIhEuqLWVTizKXE0cr9qFaAz9JL4I4uF4dFlPaB/X9V7mCOJ3rxzD+TmXTDDtbpfFXg+9FlZrllbimJJGrpsS9zv8+rTGeEEWBj9gzVL4bcqmTZjOFlLdVi9HvD2G32tCCSuMTdxOfzmc4xZA62v/p41IK7tTDj1x0n4cM9ScP/9MXg9aCDzssISTBaQs3kXIGHdGsi4/hPcffSGGU5u98pB3eLGZsRuV/oPjM6kPNjycfd3B+DK1etQVFxctgQWdUf3+PN26k7iYDYeki8ukpJqpGiH5hgJASKRRtKmg89i2a8aLUzomqxVw9/BktB2WkKALdWEWdY1a/hDrwf3Qk0ZkTR8/MUGSD3zNac7H+MPK+b5Q2vP9jB+8BDFXflCSBqeHy1tje/9D2YMGyNbBjwzEli0hpo+1XyrMBZBSxLHWqk3HtwEf1UqMJuDBLLlw21tWqotE1eQPA5tOgy8K/hA/KG5kF90uWy9cjc84ImC1rBo1FTOM6IcP2eX1ja9WVwMp8+eg7379sGOjV+YyZS8aYskS6QpCZR657jII9d/6xEeyVghXaXVqlQ8aZ5xESASaVzdqnIyJAhYvy9tbzqzvqv1q1YFVIMsaumyHhDexyE/rkhKYuJnCYpNRLJU7WxjmDVokuJWSSR1GP+3/ecdViQNVWzPhSrmCrD7fP/rT4xV8L53EbjdK/8fiSv0gMdu1oQ3n3uDs4g5zkfMiopvMXOq+VVh/re6ny+nGEiQRySNZdzhLHnE0Ijp30+BzIIMzjlCra3Hsk/Bn3/8AYuWLoev1/3XuhCth0hce3btLAYah4xlyeSNwpvwXPeekLF/t0P2pU0IAS0iQCRSi1rRmEzUr1pjCtGYOKYuayx10jKkGa81ms9NKPSISIjGxs+Co1W/EZXcUvVsY1j65jyrsi5C97U3DmWydKfjeCViUVnCnFvtEG9pIaxB+UyFTjD9nZGSyzjhWbDzTf6TmUwWM5JHtPZuzf2aFyq0SL5W4W0YFzXI5lgkikV//2UVV4j4MTGWLbh7ZvNu7oABmCCG1vbklcscsBttQQhoEwEikdrUi9OlcmS/aqUIhdNBcyEB2BcLLNEjxWWtlM6lduxB93bQmY6wZs4iwVpDwoP/TB+MtcQYuy7t2kgmaoIFAIC5iR/DplurBBNmNklm5dRZYrYpG5u8KRXyKmTDiy07CiaPphvx1cFM2ZkGJ3/9hSmPM2Lo4LKpiHOTRkFQzZfbOirpMApPYspT5efDpJjRzMpK3WmFxaTlCAFVESASqSq8+lrckcRRX8iQtCwCGAebuG4j0+YNY2Dxh19KDKwSP7imblYpGsL4REwK4UuyQEKTuP1LxnV8p+ZVs62QjFa47AdV/gqA2NdHSOq9LFT2AxlHYNc/mwRZAU3XxHMOaziGiXcU+6AlEkvmoPXRNO5R6Dp8vcEPZGTBlq3boXVIc7NSTxgWIEVeoXLZGyf0bsbGzbSSm8ikEhqgNfSEAJFIPWlLBVmpX7UKoD5YUuiPkXoSKLeyFJe1Ej/U9tZAK1nC+Tm8bl17a3S78Rbj7rX1IJn5+Jclgoq4Y93HqKbDIaK3eLLGpykkzOjK3lT8ic04RHtr1DvXDhYPnyEqmQddyhO/fhfOPXyMTzybf0eS3f7KG7BgyjjOMSk70iAxKckqOUVOUo1kYUV+bp/r3guSViZIeomSKyPNJwS0ggCRSK1owoFyWParRotSaevBUAdKQVtpHQHTJCopLmu1z/fy2CFwuclBWdt4H24Ee5du4FxDDIFkF5Bj9bN3EOzT3eHVhpB6bpMkEokWweiAWFHWPazTOE1G72v2PEGnO8LamUs4j4dW3knvTbPq+OJMEinkQuF3KJJISqoRghaNMTICRCKNrF2Ls6E1KW3ffqb1IPWrdiHFizwqW/OT7WUt1WUtcltRw9HN2i2uv+SWg+xmHicDYOPY1VYWOiQ3M3fMFlyg21R4vjhAUQfFMjhFxRA2cRBMmxAF8YfnQv7N/8rpiFmrw4UBNi2CXOsgiZx6MBbuVv1TzDZWYxtkd+aMPcUM7G1p+2Fe/EIrMqZ1EonfoRjSkRA/VxY2NJkQ0DsCRCL1rkEe+S37VWPNvk4d2lGfV4PrXcrx8CVj9dr1UFh4E4RmWUvZR4k56NrtO2+IIiTys6hlUK9uHTOxMGEn3Xe9oOLhlufBZJaXigdB3NhoJY4K2KN7+FcjYMnQ2RD3wxTJJNL/1xBInbdasExYg3L8tvGCXPm2FkV3NoYMcGGB7vILFy9alffB2pHYc5svVlXwQVQYSEXGVQCVltQlAkQidak2+0KbWpKwCC4SRyFlVwwIBR2JBwG2tuOhjCwIblAfIsP7QusWzXWBW8cRfaGw5QlZsnodCYKts5LNMqvlJuygQEpaI5HMjftmLHz+9jKI+uZNuGnRzlIoAHjWfYs3CR3OxGD2mxUFN5uVFgaX8iChHuQ5HoZF9LWajtbegvzL8Gv2SbO2gUgukUg2CW4gZUtZc4TGMUcMjWZetFqFNJO1H00mBPSOAJFIvWvwgfzUr9oginTQMUzvS6sWzSVnWTtIXM5ths6YDFkBW2SJwOVqXZ68ARKvLZGVsIOxkQteWKhItjZaIkesHw0bJqyClzd1lXxeW25lewuiRXa//xrJe2Ky0bL+H3IWdkcSmXMym1lbqfI+QkmgrQMJnd+ifRerOE7JINFEQkDHCBCJ1LHyLPtVD+zfT9cWR6Ff4DpWmdNFR5c1FkjGBy0peg5tkJudbctKFrcwAbZW+ViWrrDQ9sBHxnJa4MQuzFoEV0ydBa+nviZ2OjPenlvZ3oJI9KbvmybJpY17hl7rB/GxsZxbpOzcDYd+Omhd3seJ7Q6FgIvW+8ih0QyJpIcQcHUEiETq7AawdfrQ/ejt7cW4qjt1CKUyEwrq0Whk1tRljVbHnt1f0o3L2p5a5bpbMTN73bQEq6QazITeVztR1o2y58aVsjBaBGNGREi2RPLVa7QnE1pmV/+1EO77FIsSHZOWlkYutNleEguNJyZqq7yPkAPii9jBzCwzF7yQeTSGEDAiAkQidaBVJI6bt26nftU60JWWRDSCy5oPT8ziXXlsOdwKvMg31OzvSKoG+I7ktBQiafrs9geSkmrYTdCdPb3tTOgS2kaUXLYGo0WwcfMAySQSk2rWTVsmuasOhg4cezRNMJGsnFsL3uv8nt3kGL2W96GkGkWuNC1iEASIRGpUkVz9qgeE9wFMlKGHELCFAFsD1NRl3TPsJUMDhhatBVmzrbrJ2Do0uppf9XgLxg8ewjlk8840mPfzDFmlbbBv9fLXEmxa4aQo5Mhvx5nEmn8r3xY1nakRWSdWVhF0LDOEdTPX5KyG2wH5Ngk2kuc6dxvCyO5D7caDYnmfHXu/hznz5luV98EC5L1e7CzqjEoMFuqB6BEeaVUcXYn9aQ1CQI8IEInUkNbY7jFsmRUjuR41BLMhRTGqy1qospD4Ldq/mLFIlrjf55yGLma0kPVt/hoMD3/d5tJKlA+Sa/njEq7g6jUYGz8LcurtFWwl5SPMQvFlx2Gm+KbdO+Hw399byVDnTkPo2uo56NLuf7ydcTADOzsnBz75LBG+XpdUJkbBtWtw7ESOU8r7CCGRVGRc7I2h8UZHgEikkzVM/aqdrACdb88WPc4+dRr0mmWtlAqwNE/i1ymQeeUw3LEokO3+pw+0fLgt07GlSSP+0jELVnwOG0sSRFv98CxKWP5sYYIEd+ryRXDcex9v9jhaBd94fLBdwiwVe5Sj4Or1sunV/KqAl4eHYHd5aXmfS/Br9imz2MIfMo4wBDQwoLZo0YSQQNGLWkw4lHmESUxLXpkgdymaTwgYAgEikU5QI1e/aqMkOzgBTpfbkr0/+GOGyVWYla9Hl7VaP/roekVLl+UjhDyyc5AkjflwBpyuv1fU/cKM5HrnQuGTd+cIJlSiNnjQwWbzzj2w4eAmuO53FkrKm1te0eL6+I0mMOCl15xi0RNyHlvlfdDS+b/mTcDNzU3IMmZj1LpPppskrt0Al/LzYVLMaNHy0QRCwIgIEIl0kFbZWLWU1G2AiTKdO7anftUOwt4o27Aua7Ydod5fPBzxoy9H92fzLsCIzybA1drZgtzHLIFcNGoqrztXjlzsXCzI/WPGUbhy7T+LIP4NrXhtQpoqsYVqa2Ac66GffmKKdWOFCfaxbHeotTsSGzfTqiSRaiDRwoSADhAgEqmikljiaNmvWo9WIxVhUmxprf3gKHUwLCmCLx+XLudD546hTFeZWjX8lVreaevoQV/oIp+buBxyqx2y6z5G1zFa/+JjJjuEQDpNaQptjG7refGLrBJUbPXMVvuuCF3/ue69IGllgiE+fwqpkpZxcQSIRKpwAdh+1ZtTtz2wNrbXdVFnFSCiJXkQMHVZ16zhz1hrjPbyIfSH29mXhc1M3v7zDvjD65KZ+9jtXjmoW9xY065jZ+PHtT/2xh4ZM96q64stEmm6hhr3RsialFSjxZtEMjkbASKRCmmAJY7oaqR+1QqB6oLLsC5rfAHpGdYNqKyTdi4BkkmMlSwqvmUmlJhYS+2cxnmSII4791mX98GyPxgr2bOrsPI+Qoifkqdkk9gS4ucquSytRQjoGgEikTLUR/2qZYDHM9XRPxDqnUTYyqYu6wH9+7pEFyJX07Gwm2D8UVjG53DWMfjkc+vyPrnnLkKbFtqM58Qi495e3vBO1GDjK4lOSAgIRIBIpECg2GFEHEUCRsNtIuAKLmtSPyFgiQC6snNzT1uV90ErZJNGQVDN11c0aOwLiZovJhFDowFf8Dp3CBUtH00gBIyKAJFIAZo1JY7Ur1oAYDTELgJs/3PWZT1i6GAK1Kc74zII2CrvgwXjhbqy+cASQyaFjm3RvotVDCefHPR3QsDoCBCJtKFhrn7VRsmKNfql1ur5TF3W70QNgZYhzYg8alVZJJdqCOxK/wG+/XavVakcIUk1agglhESi1yByaDRDIukhBAiB/xAgEmlyG9h+1VhQFh8sp4K1+KhftbofGSFf4upKoN7qpnfKqFnW6qFHKxsRgQMZWTA3frHg8j5KYSDnewZfAA9mZpl111FKLlqHENAzAi5PItkfeazDV1h4k2kdp/ciznq+kEaRnQ2BIJe1UTRK51AKASw0PvuDufB/65LMLPGOskRKIZOYVFPT35+JiaSHECAEXNwSSf2q6SOgFgJosVi9dj3zQkIua7VQdr11pRAfraL01bZdMGfefMjYv7tMRK7yPlhOafd3P1odo0lwA3g6OKjsv8vFRsj8HuGRVpZTreJLchECjkTAZSyRRBwdea1cay+8W0nrNkDa3nRAlzVlcLqW/h1xWiFExxFyyN3DVnkf7HVecPU6U94HyeMXKamQeuZruF3jKvxb+TZgS0m3e+WZ7cv/4QNPurWE6PA3GDIpBxshWd1skXGMh/Tx9pYLAc0nBAyFgKFJpClxpH7V+ry3Un8g8IcIW9ZtStsJng9XLDs8/hg1rf8k9OzaCbw8PWSBYpq1j2EQlGUtC06abAcBqZ8DrYF6IPMoHDt2HPLOnzeLL2TL+xQV3YKRKyfB77WzGfJo68HPceXcWjCm/WhZGd1CcD2UeQRmLVgEX69L0hqcJA8h4HQEDEciLftVY9cPrOtFtb2cftccJsDy5A2ALequP3Ie7tS8arUvWjL88uvDm8+9IekHCF3WH61YxayLLutOHdqRhcJh2qWN9IwAW94Hv6cnxYwuOwrGQ3YJbQNvzR8H+U9mCj4i9iwf1mA0RPR+WfAcoQNZgomJlpfy883kFboGjSMEjI6AYUgk/rCn7dsP2JqqlDRSv2qjX16u883/dBWk/JEEd6v+yXv8innV4fX6A2F4+Ou8Y9l2hIcysiC4QX3Ack+tWzTnnUcD7CMgxBJEGBoHAUyqOfTTT5zlfbYfSYMzddOhxP2+qAOjRfK9zu/B86FtRM0TOjh22vtMwiX2r6eHECAEzBHQPYnErLmULduoX7UTbrbWCEBySiosP7mI0/poC55yNzxg4CNjYVgEd9Yluay5kWOTHgquXjMbEBhQG7q0ayM4VEBrd8gJHyPdbXnm3Hn47fxFM7k9PT3g6YZBvHrHGpEJy1dYJam8/e4MOFr1G7j32A3ReDx0qyLUP9cO1sxZJHqukAnPde8FySsTmHhneggBQsBgJBI/4FjP0dQ1Qkp2PQSw28X8rNmiCCSLkucvgbBk0Fxo0qhBGXCWLuueYS+5HqgcJ75ZVAwLVnwOe/N3w63Ai1ZxaxgqgJahPq17QUSvMF5SQSRSP9cK4xlTdqTB4b+/ZxJeTB8kclX+qgN9Wve2G2+MlsilS5dB0soEs/I+L48dApebHJQMBnoV5nebD21ChPfdFnL32KQa00xyFFLIXMmHoYmEgI4Q0L0lEn/sY+PeZ0gk1fBS7+Zp/UszaupUyAzcLAkA/AFsW9QTxoa/CUtXfgrosqZ6odZQns27ICjpAWcimQwsaAXxMZOhup/tXshav1eSLpQBJ6GVf03O5/DHI+ftJrzw6X3n3u9gStwMs/I+x7NPwfC1o+GfeubWTTEw4r7RAbHMi4vQR8jdw/AorPWaED9X6LI0jhBwKQR0TyJRW2iNxMDnPakp1EbOpa5v6WExC3v42lGSf4TuXSwHJd9WgSqVH2bII2VZW18idF+P+XCGqJg11s244r1ZvBZJF7y2ujkyEsiPf1kCtwOuCJIZM6frnQuFRaOmmr1AFFy7Dlt37YEtqVvNMp1x/YS8OZJc2aYCdbgwABZMGSdIRqGDMFzK28sb3okaLHQKjSMEXAoBQ5BItB6tXrOeyZC1dJO4lDZd9LCYjb36r4Vw36dYMAIltwHu5ZaH2wcrMHM8gyrBR1EfinKHCd5M5wPRhT1myXQ46veN6KQHtBAN8B1pM+ZU59AYXnzMpn4/7X0mdEHMwxWnaKu8D5LIpZdmivr8cskSktsTVsyYIUZM3rERQ6Op7isvSjTAlREwBInEzNlOYb0Ay/mgK/L/1iVSyRUXutVxCxNga5WPBZ343xtuDHFEAlk+8B64B9+D8rXuA1+CjaDFDToI403n/TxDUMY7FwReR4Jg/eQVdt3aBoVO98cKmzBQVMkd0wNjbOzQpsMBX0KwmLinR2Uo/PM65JzJhQ4dOsDzoc8yxcKXJ6+HxGsfybJEImnt4xYN46IGKYp5i/ZdgIqMKwopLWYwBAxBIlEnsXEzGdX4eHsx/0uJNga7qXaOM27mAthXO9Huge/mloO7RysAkkgkjxWa3oWHfErK5hCJtA1fzJw5kO67XrQVkl1RSrya69xe8SfF0ALs7mL6IEGrV7eO+MXszMAwkWFfRgt2Y3Mt5fPjU1DcII8hiG1uh8Ghn36EW35/QYX6JVAxzx9ae7aH4hu34ZjXfklJceye7r8/ChOemiq47quQeEg0TkQOjWZIJD2EACHAjYBhSCT7gUd3dnTMRFLt2dYAACAASURBVOjSsT0T20aPNQJCvkD1hBtmC28o96EVyUHCeP9iOcby6FaxhCGO7o3ucR4NixZPbzuTKXhMz38IIGHps3AgFDfMkwWLGvFqsgTS4WS2HeC2n3eWZUe73SsHD90rz7QFDHZvDr07d1WsXqLclweEGK3QRY1zmc9mZJV3YPlHq6BC6zvgHlhaCxItiFXPNoai4ltQ2PKEZK1UOlMLlvX/0Kyntr3FhHwHYtLmwcwss846kgWkiYSAQREwDIlE/aA1snVIc2gZ0ox5g8RsbcrYNs7NtfXFj3Fb0w7Glrlby1zW2e5QPvhumcvaHhLoevv8zRWKW3P0jj7GsY37ZqwsKxFiUONYa9iysLTLDz3iEcA7Pit1HmdZJdPVsNTNMxU6wfjBQ2SHD/SfMhJy6u8VL6zJDPxc3X30BmOJHPDwGEhYvAI8et8y8wKwZBNfVOy1OrQlCBLo0Gv9ID42VpaslpMxqaamvz/9hiiKKi1mNAQMRSJN3Q+mlslaLlwkVsgbt94vNVpo+s4bAn89lAd3s90ZlzVaHdFtbeqytnfOer+1g1XjF1AWsQVIRCKd/+kQm9yiVFZ8xxF9ZVkHETm08ONTpYE7BPzeFHYn7Qfvt4usQEWZPU4GlFktxaCO85ZGLhRshRS6do/wSKui6ELn0jhCwFUQMBSJRKWhKxtbHmJxaKzxNXvBYsrYNvBtxpeFw5lH4INFS6Co0t9Q/ql/bLqsbcFQ2n93DET0Fl5jzsCQmh3t2IlTMPyrEbLi4nBBNTJnXUEHSOInfv2upOzo19yiYTxPoom9+Eo5STWsbpDgYWHy+tXqwc2TACe/PQNeg7irKKAVtXyhJ0MkhT5s8o6Y+pBC1maLjFNSjRC0aIwrI2A4Eolt6t6Nm1kWDI3lf3bv3W9Wl8yVFW6Us7O9rLEQMGbl9+7RHRZvSIScentFJYAoZbUxCq6W50CS0W9WFNxsliP5iGplzkoWSEcTXxkWDRefSZckMVcnJnYhfDnArHvsPITuZvYp909FJr6y5cNtAes6nnxqp6S92UlsTCSud+e0G/x45Ceo3P0fm2sGZ3WDe97FkFvrgF3XNt4pJJBD/jdYVIFxoYc5lHkEZi1YRL8bQgGjcS6LgOFIJGoSa3v1CuvGWCPxwdgWfChjW//3PCV1G2DA+6XL+fBO1BAm/pUNV0DCM/SDWMhvlCGISLIEkq+riv5Rk3cCTLDY779G8iJoYRrXaqLgzFnJGxlsotwi+ni/X7wbCdPfGWmGDNZVXX98nd34SiSSHqfqMlZEKf2s2Q19DjwFN9r8DN5uj8D1rCL4t9ANKoXesakp78ONoE/rnnDsRA6cKvwV/gnIh5LypUk47FPxsh+0fPhZiOj1slmrUqHqFxLik7h2A9PAgn4zhKJK41wVAUOSSCQZq9euN3uLxK42vV7uRhnbOrzpaHXcsy8d8Iu9Zo3qjOURXxK4HiSSMfGzILfaIbs/fujCfvxGE962fDqES3GRMSYv7vspkpJrkIwEnekIa+YsUlwuoy+I9U+3+Xwi6IXIFhZIyvYu3VD2ZyzsvfzkIkG6ZK19YtzLZmQvrzrz/1YJqgCXb5+HW1srwUO+/0LFZ2yTSHR/f/72cjiQcQSuXL0ORcXFEGhSusjLozL8L6QpVPOtAm5ubqpdATZJkzVEqLYRLUwI6BwBQ5JI1AmSxg/ipkDrFs0ZFbGJNpPGjYbOHUJ1qTYhb9COPhi6xXZ/d8Bq28CA2tClXRtZiSrZp3Igcd1GpnctEkeh7QixuDHKlPj1ZvjjkTyrH+E6dxrCgJdeU6wUiqMxV2I/JIZYABp/pE2fNi2awdMNg6z0Nu2jJbDDPUl09iySgjmvzrTbCUhr9/rMufOw+7sfrbCp5usLPbt2knWnxeju9dgxcCo4TcwUq7Ho8l3abzFjsRNDINmFcP497yLRhebx5aHG8dbwWKOH4N8bD8Hh7w8zCW9sohuW+cEi/5YP3peNY1eXZZbjPcUXw6aNGsDTwQ1kYSFmMv5+UPczMYjRWFdFwLAkEq2Rafv2Q0L83DLdUsa2ctccA/4TvkyE8xVOMi4v09Ic+ANS/k8f8L36BLz53Bui3ZioO3Rbc7msxZ7ANHGgml8V8PLwcBgJECurI8bjj3Li9i/hN59jVtYo1FuFy35Qt7gxTBwwzCzbFYl51PuT4XTd7wQTSaFJD1ohkXinU3akweG/v+d09WLRdDzTyO5vib7TUnSrRGILW/8UrXfd4vqLSlphZcbYyn/q5AtuS4j3yDujETSt1wj+LiyA73cdhgrN7kLF1qUWSOxVf+dBu1F3LMFlUrsVYyi3zkq2+owezz4F+MKKZFhtMskm1WTs3y1FbTSHEHApBAxLIlGLXG+T6BLFf1p/y9TKDyvXp0FMyRGMh3ulZl+mbp29Bwl+0roNkLY3HWrW8DeLaXWpT6SKh0VL1Me/LOHNtEYSgGTprZZRZkkLSCTRIvnjv7vsukNZN+joTiMEkS0t3PWzeRdgxGcT4Jr/aV6SjN1R2tx/iYk19PL0UE1jSpBItv7pj5nHIOH8HEnxjWx8JFokbwdcsXte1L3X0SB4zNcD/jx7jXkR5KoLaUom0UKJBBPJZIPsznZDH5BMFhaVWs+fbdFMFeyxqgd6P0wNEKpsRIsSAgZAwNAk0lbHAcrYln5zxRBIdhdsKfiqx1ucRBKz6Tdv3Q5pe/dD5wddhly5rqd0zdifKZRAmq6CLwBvNx5plf2Kd2DZujVwzfesFeFy/9MHwur1gDd6hQkudu1sEskSyN+f+EUw/EiW2hb1hIUxkwXPsTWQ7URz5LfjZkOQtF9qYR0qImZDtCJui1sL6BqXu1bDn7vC3w9dhT+8Llm5t5FoVjrvD2itfTzwYfh+1yGGFLLWR3sys5bJ+1cfgtDWoRD//nvg4+1t95jHsk/Brv0/QGBAHXihfRvw9BBG5oXcNUzE9PbyhneiqOOZmLtGY10TAUOTSHvua8rYFn/hMVt0RNJYSS3wkJBM6zC9LA6RTX4qLLxplWUtXjKaYQ8BdNPGfjVFkt6QhGyYsIqTEOJ9KLh6rWxrT08PeKJOLcHkUQtaQ6IWPn045D+ZKVocdBXHtZ0pObYWyeOCFattus8xPvBO1T8lWQ/Zw6BlD6sPKNG60v/XEFg3bRkTb4zxtOxTzc+XIXRP1n8c9h5Og7y88zatj/ZAfuzHxlDt38cAY6EH9O8HA/r34SSTpkQQ7x++1ODdeyFUOJm0JwdW98BOZ3qNnRd9kWkCISADAUOTSMQFs+zwmRM3xQwmjHt5JXwAZWyLuDxYGuTzovm87j5bSwYebw+Pe1eHQxlZENygPkSG9y1LfBIhBg0ViYCcHshGr/GYvClVspsX1cCStOp+vqK0wlYRsBdjKjc7Gq2C0XVimdjWEetHiy5YbnkgrhcKrCWJBPLm33/Blyn/B4H16sGJx44wbu+WPs/Ctd/+gd+qWBN0rwre8EK5vnDibhZceOg0/HPFjZEVC/6zCXXoneAik1zWREwQ++b/VxHARy6ZbNG+C1NnmM8aKkrhNJgQMCgChieRaI3sFNYL9qSmlNUTZHVphIxtR91LORYbdFfdzS4PJWc8oFO7tjBxzDtWunDUOVxtHznWYxYre9ZIveMpp5g3nl2KNVIIgWRxRWvkPwFXJL241cxsA2s+WMRkNw/6LEo2iURLZOq81WUqRwsgxjyeOpnNvBiycebJm7bA4Ws/QYn7PTjncwzyiy5zXhMkkk9CS6hzJxjc7pWDCYPfMhtnGieN1RlsWSZNJ7FksqioGJ5v/yxTCkjMY9o6V8w8GksIuCoChieRqFi0RmKcHZaIsXxO5pyGN94aDv+3LomIjZ1PAXa3mJ81W1B9OXaZuyfKw+0HWZgYG1XpUQ8YERSrSocJV/0A850brceJ15bIcoliKML8bvPtlunhk0OLf5dbzBvPJMVSi5bh7x75ipMYhge/AeuyvyiDC2MNvY42YLKqTSsg8OHJlFbqPRPatGgK+ALYfXKErK5DuB/butLS+mhafxf/lrRpCzQJbgAzd8xmiGuJu3UpHxY7TPx5s90AaFa/kc3sa/QaYTIkhsB07hjKeDD44qaRTGKmfQmAqPJAtuLo+fCmvxMCroqAS5BIvrdLvWRsO/OSCnVlY6YlEsf7F8tBuVr3wT34Xlk9OPxB7HbjLYgbG+3Mo7jU3liwemuVj2WdGROjBj4yFoZF9JW1jtYm704/AFMPxoqugWh5juZ5L8PKqbMEHQ9rUL65YrhVfGr72h0hptVE2Hrma1h5bLnZWkhUWYskX/cYHFv1QjAsGTobngioXbaO3K5D+Nl9s+K7gPVfuayPuBFaJm8WF0Ovrp2ZfZGkJ36dwsR8YitD0wcTsLAVIva8xrI97GOvlE8pmdwIiWvXM0l4A8L7QHCDIF7c2VqTKBdfNj3Gytf092diIukhBAgBfgRcgkQiDHwdCChj2/5l4SORrMuaJY9oeWQLC5uu3P3624qRSCGZlvwfAWOPwJI82PVEzoPEZJDneMORSMxYT8iTVvbGFE++sjSmYy1jMP09a8DQpsOYISuPLrfp+mXLLqEu0L1tSSbZ+EkkZuOiBlolN8npOoSyVTpTCzo/2h2qPeLNxD5aWh8xLtKW+9i0VqspFqbk0fJ+IplEwo3F7y3jTU3JJJJIbH/aKoS/3A/WmcR17dWa7BEeycTPCyGncj5TNJcQMAoCLkMi+ayRqNDomIlMjULql2p9vbl+cEtuA9zLNXdZmxYOtlzFqGREy18GSrTOYwtWdwlto+WjipYNQzTm/TxDliVSrHV96IzJkBWwhZEVXdcd6jwHqWe+hq25XwuSn3Vvh1RvaTYe2wH27NrZbi9pLPMjplg8uwF+bp848SzUfczPLPYR/47kFJ/nVbobQi2TYsgkrnn0xCmGnJrKzRYZp6QaQVeRBhECDAIuQyLxsFi6AXsu2+qHShnbtj8VWCZm3DdjmZhIey5re58ro5IRLX+XIFGamz1NVkwkW7C6nkkPYy2fmU82tmvP3+WuQeGdQkldXNg9xLr6O4zuDd5tb8KKrp9xuq75ZMe/Y4zqsleX2iWMXOugRXDMhzPgdP29QrZhxjAWzgP14GrOZRj+5oCyuHI2LlJK8orgzU0G8pHJPfu+g49WrGKMAEItkyyZxA7cvV7sDL9mn4JZCxbB1+uSpIhIcwgBl0TApUgkFrZ+N24mU77B1kMZ29zIYHB+56F9oPBOAWBRYIx3tOWytoWtkbN8tfrtgS7BUZ9PhAIRhbQtz8LWB+SLJ9MqBqxcWFT8veULzVo+eh9uBIUtT0gWHd28y/p/aNYi0t5i3xxIh4q17kH8obk2Xdd8wiCJTIz8FKSQesRg9IfT4UrQUd5EHZZAViwsgc8SFpcls5RaH0vg+dBn+URV/O8smcTalFzWT7ZlKm4slEyyhPjI0aPg+4gPeaIU1xotaGQEXIpEoiKxFSJ+udiyRuIYytj+78ojqT6ceYR5yy/+5zbcfvI6lGteJPozgT9Iodf6wYIp40TPpQnyELCXDcy3MltrEOv36flBK9xb88dZFRVHQlZS/r6oqgMsDuhaxjsdHxsrGJql//cZrP57keDxXAPZLjRSST1isXz9Wtjz+w64W/UPq57YbHwlluWK6P0yDBsUyYiB8zAZyVHWR3sgscTPFpk89OA7C9fA73r0QPE9GDd/rwSgzf+ekV1rkm8v+jshYBQEXI5Esm+qySsT7OqwNGN7PSSvXMa4SFztQfKIyUZsO8Ke3V+CgIA6EBM/S1JcFVp81k1L0FU3E6PoHH/8hywew1ifxDxIkuqdC4VP3p3Dm9UqZl1Hj2XduGfqpnOWm0FShqVoxJTQwTP4nQ+Gua/OFGyFxDnjZi6A/dW/sFn2Rgg2NY61hi0LVwkZancMZk9j+0BMOMEHrXxVHvaB3347Cz6VKlhZH9EbgW5fLT0smURCjZZJy/aHhzKz4KMVnzIZ5Wg86NShnc0i4mhgwFqXjz7yMFO4nKk1GdoGkKjSQwgQAtwIuByJRBjwy+KDuCm83VLQ+oZvtHyE00iXiyXZ+KXLVZON7weZC4uqZxvD0jfnmZUcMRJmejgLxrS+v302XK2TLUhclkAuGjXVIcRfzUx7vo49aHlDIimmFiPGiY5tE8Mks4h55GZJq2HRZy2MbNcZ08xrJI4oM7rOsfONVh++jjWsZdJWS0U2qSZj/+6yI+KaeHaxOtYqRiQXIaAGAi5JIsUUlMWMbcz84ypUroZCnLGmqcsara72ko9QPrbjRm61Q3YTNtAVijXrFo+aRgTSGYq12BMtTx+sWQpnqx20cmGaDsUEqMdvNGF6Lott5yf1mGqRSKEde4TWYmRdvZPDJkjOSMYs6VPBaZKgUtqib6vrTKllMocps4PWOKmuc0mHlDEJ61TmnrvA9PZ+oT2XZbI0NMeSTKbtS4fNqdsgIX6ujN1pKiHgegi4JIkstUb2FOSqNnLGNuuyxi9Ppq2YwOK9iB9aKDbv3AMbD26CP7wuMXFlpk/Fy37Q7amu8EavMNWJiFoExIhfB/gCgHrb/vMOuP7IebMjYuu5usWNYcBLr0kmSFIxU0uHYjv2YKIMFsK+++gNK/c2/vewej1k32kkZ9HrRoluQ4gvZQN8RypSr1OI9ZF1EUvVqTPn8VkmLftzX8rPZ4qMvxNl3dXMmeegvQkBrSPgsiQSYx6zc04zhWX5HjZje8709wQVteVbz9l/N3VZY5xQy5BmvG3EbMmMZPL4yRwmfoh9qvpWgWp+VVQnj87GUc/729KbvQLQap5XLRIp1eqHpXvKFXoyR67w+6Pwbs+x8GyLZopZ5LD00sID8YKJJFqHI2pHKUIg7Vkf2RhDrAnqKCu0mveKj0zid/sH8YsBLZEY/y6kaLma8tLahIDeEHBZEolfHq+ERwrumY0Z28PHTmQCr/n6tmrxEoh1WWvxDCQTISAWgbAJA60yssWugQRu+SvLRddl5NsH41Q/2LAYrvqfthkWwrrPh/xvsOye85bWR4x5Nm2ssCv9Bywd7HArNB9OSvzdFplkv9dN40CV2I/WIARcBQGXJZGoYCzpgI8QaySOY3ts/9+6RJsZflq7OKzbhnVZY2ynHkmw1nAlefSBQMcRfWXVgcRTYhmg5a8lqJJYghZh7AaF4QV/VSowAxUJpBLuc1zU0vpo6lVxdOFwZ94cUzJ5Ke8coFfGKB4mZ+JKe7suAi5NIlk3tRjrIpa9QWKm9QBsJV3WrvvxoJPrHQHTNoNSzyK3LqOQfZFMYlKI6ePl4SHbfc5lfcQXSR9vb2YrtdsWCjm7o8dgnPucRR/BT4cOw/NdX4RB/XpDNd8qjhaD9iMEDIGAS5NI1hoZHFQfBvTvK1ihWs3YRlK8Z186YzEVkmUt+MA0kBDQKQILVnwOG0sSRNeAND2uUnUZHQ0hWR+tEWcNB6aufMSp4Oo1TRRRd/Qdof0IAbkIuDyJZL9U7LVCtASZzdhG4imGfMpVlq352M5x89btZYXByWWtFtK0rt4QwLjD2K+mQHHDPEmi67FjD1kfuVWNyTOzFyxmvrO18L0t6ULSJEJAYwi4PIlkrZGtQ5rbbYVoqTeWfC5bOBcaBtV3ilrRZb167XooLLzJdGOQk2XtlAPQpoSAAxBAl/bRqt9IskZW/zUE1sctA3Qt6+FBqxq+5OaczIa0velm8X4Y+5i0aQtE9n7Z5dy3GIaUsmUbOPP7Wg/3h2QkBMQioCsSqVYZELTkvRs3E8RYIxFo7IIQO+19h2ZsI3lNWreB+YFAlzW+UXfuECpW74Ycj/cDHzc3N0Oejw4lDQG2OH5Ovb2i2g1K7UojTUp5s1jr48OelWHx0uVMtynL2EdMKnG17itsCR/8X4xjp6RCefeMZhMClgjoikSqqb6IodG8nVq49mffcNXO2GZd1ocysqBVi+bMDwR9Iap5I2htIyGAJOut+eOg4IlfBFkkkUAObTpcdlkdR2BI1kdulFlvEZXvccQtpD1cFQEikQ80j65hbIcl1hqJ09XM2Gblwn3QZd2pQzvdlBdy1Q8VnVs8AsezT0Hhgy5IXh6Vy7KSAwNqQ5d2yrTdQyI57aMl8Ev5H+FOjaucVkm25WP0awOgTUhT8Qdx4AxL66PlyyUWNEfbfC+R/b0deATVtmLLsVH8o2oQ08KEAIMAkUiTi/Bc917wQdwUaN2iuejrgZZMnKdEj222HSFaHYMb1IfI8L6SZBJ9CB1NsBXaoFbIg46g0ZWoaEVL3P4lPNroIRj0fD+I+ubNMvnd7paDCpf9oM6dYHin55uKkTpMttm0eyfk/HESbhbfAiStnp4e4OP2KLzaoZsuim1bWh/xBbNn2EsMdq5U95HrsrPeITGl23T1oSFhCQENIUAk0kQZbG3F5JUJolXEuk7kvPmSy1o07DRBxwhgke2Pf1kCtwOugL9XDYh7dqYZiTQ9Gva0jmqmD/eymirhsz66Yt1HFm/8Dsbyaxjm827MaAr3UfMi0tqEwAMEiERaXAW0Rkp9g2VbKX7xyTJRGduWLmvWokC3lBAwKgKmBBLP6FXBG1a88Bm8nvqazSOjq3lYwzG6iFNUQ29kfbSNKrUvVOPG0ZqEAD8CRCItMEJCdzAzS3ArREuI2VpkfETU1GWNsUw9u79ELmv++0ojDIAAkqGZO2Zb1W7c0nsnvLypq90TYveYDRNWQXU/XwMgIewIrPWxdnU/mPHBfKvEulLrYwk8H/qssAUNNoqNf5w0bjRVqjCYbuk42keASCSHjuRYI3E5exnb6LLGEj3Zp05TlrX2Px+KScgQge9+ZNar/qDFGsbhPd0wSHZrO8WEdNBCMXPmQLrveqvElr3hP0DHdfaJEPaT7uMWDeOiBjlIWuduw7qnse4j1jmk2EdzfcyOX8yUO+N7aXeuFml3QsC4CBCJ5NAtkkC0FM6JmyJZ8/jldulBbTIs/rtn33dM9jc+pj8EkjegibpA4NiJU4Cu28N/fw+3a1w1k9ntXjnwvfoEvPTUi4yL1stTHwWt5QB/PDsHRiSN5ewgI8QSiXu7gjUSXzpy8y5A5QruMG7SVEWtj7g26uGbA+lw5a+CMnV6enhAs8efhmdbNIOng4PkqFn1uabtC03rYaq+MW1ACBAC5r9jJWyFZgKmDAH8guoU1gv2pKbICs7uER7JlOPJPpUDnTu2J5e1i90xJI8rjy5jyOO/lW/bPD221gssaAXvDxsLTwTUNjRKy5M3QOK1JXDvsRtW58S4yJt3CnnPj7GRC15YqFi2Nu+GDh7AWh9PZZ8ADK8xfelkXdtNGjWURPTwTm7P2g15Hr/AnZrmLzV4TLyLFS/7Qb+nwzX7YsM2eaD6jw6+mLQdIcCBAFkibVyL2LiZ4OPtBZNiRku+OCwZTVqRQPGOklHU50SWQN4KvCjoAFjOpt65UFg0aqqh4/3iFibANp9PRHWOsQSw3A0PGPjIWBgW0VcQtnoZxBLEJ+s/UWp9DGkGI6KGlL3IovXwzLnzTAkiKVZry2Qme7iwLzYr3pslaS+1MKf2hWohS+sSAtIQIBJpAzfWXSI31kYJMipNta49y5n1ItGS9H7a+yCUQLKaQiIZdKYjrJmzyLDKGzdzAeyrnSjrfBgXOchzvKFIJFfs4yvdX2RaeN4sKgb8OxJHJJBSHjEEkl0fcW76+wuwcuosKVsqOgdDgmbHf8h4dah9oaLQ0mKEgCwEiETagQ8JYOuQ5mVFfKUgzZJRKZ1wpOxHc5yPwCvDouHiM+mSBEFXbVzbmZLJgqRNHThpwYrPYUO5D2VZIt1/fxRmtJ4DXSQSKgcel3crK+ujRUvTm8XFsHlHGnNWqRnp9uJQ+QTUwn00jX+U4xniOyv9nRAgBMQjQCTSDmZKEUCpfbnFq5NmOBsB/MEevnYU/FNPmBubS94G2Z0Na43EVnzzfp4Bd6v+KVlVFfOqw/LXEiTFBEreVIWJ9jKvcbtd6T+Al6cn/K95E8YiKfWxlQ0vdD1n3keMCZ21YBETF4qNHOghBAgBbSFAJJJHH0oQQLZ2JFkjtXX51ZBGCUubkbOP0fI2eOk7UPDEL5Lh9/81BNZNW6apWD0xh+GzPirZthBd4WETB0FhyxNiRDQbi6R9frf5Dk9kovaFklVGEwkBhyFAJJIHaqzr+G7cTJBLAOX05eYSkS3TcTz7lNmfsUyHHkp0OOyGO3ij12PHwKngNFm7OutHW5bQIiYj0d5YkmA3Y93WcpjwEV0nFiJ6h4nYUTtDhVgfAdwUC2fA/aYdjJVl+WUwD4h1WKcg9AB9EL8YbhTehA/ipsiqkKEdzZMkhIAxESASKUCvWKpnYP9+smIj5XbCYcVEy8LHX2yAjCuH4bz7SaZMByZkuN0rzwzBYPgKvz8KLR9uC+MHD5EcRyUAFhrCgUDYhIGQ/2SmLGww5m/CU1OhZ9fOstbR6mR8ARrz4Qw4XX+vKBFLM9jbwSeT5oKXh75qaiptfRSaOIYllT4vmi+JsJsqp8OFAbBgyjhR+pIymA0hovI9UtCjOYSA4xEgEikAcySAKanbIHllgoDR3EMwu/CV8AGyOisggRwbPwuOe+/jrLNnujOSyWpnG8OH0e8bvvagZKWoMFEpS6QRYv7swXs27wKM+GwCXK2dLSjJhiWQi0fFQTW/KipoTr0l+a2P2LYQFLM+mp5ECRKJ2He78RbEjY1WDyQAwPaF2JBh8rgxsl7YVRWSFicECAEzBIhECrwQSrijMdsbH6mdcIbOmAxHq34jyqpQPacprBq9iCySAvUsdxiWsNlf/QtBxMjWXkaOiTQ9MyYhfbBmKfxWJdPuSxFmCD9+ownEx0zW1T3msz5iKMqy5A3wbEjTsnM9XqcW1KtbR+41LJuPpX0S8ubwvnTa29ARdTkp/lExldNChIBDESASKRButEamzWKFgwAAIABJREFU7dvP1CiT+sjJ9p7/6Sr4qvgTuO9TLGp7tEjWP9fOsNm+osBwwGAlYtBqHGsNWxaWtsg0+oPWdaaLys874A+vS1BS/n7ZkbEtZEBxYxj40muqWOnUxNaW9RHPeyDzKCRu/xLOefxidl6Up3yhB3T0fx4G9Ogp2oPA5eI+ln0Khn85Am4HXJF8XCTx09vOVKWkEn4nRsdMhOAGQTApZhTT4YseQoAQ0A8CRCJF6AqtkUoUHxdbexJ/eLpPjoCbzXJESPvfUC3UepMkuA4nofXprfnjJMdFYjzk8CfG6zZxhFUZY4X77kcouHrNTIuBAbWhSzvrjit4x3PPXwQoKfmPRLoBPB3cQFe3wJ71Ef82dfki+KX8j5wtB9mDovsYrdGjug6THBdrSij7TR8OZ+p+JxlHtbLhT+achuFjJwLFP0pWDU0kBJyOAJFIESpQIjlGSrZ38qZUSDgvzyXVPv91iI+NFXFaGioVASndQdi9sCbfiqmzdJc4wsrPJn5tzd4K/wRcsQq9QMt45dxa8GbHN6Bn1066LdPDdTfsxT4iLlHvT4bTdb8THI6CWfpvNx4pOysa7+Pyk4vsEldbd12tbHjWfT1p3Gjo3CFU6keN5hEChICTESASKUIBSrVCFBtfKacDCns878ONYO/SDSJOa5yhQjNZlTwxJjQkXlsiOBYNrU/VfnsKPhw6G9Bap8eHzbrOrXWAlyghOXm6sAPMGDZGV3GOXHrhi33Euo/vLVsoOp4Z90LC/V7n9yS78/HuFxXfYhLyxMZTs/3cP3l3jmJkHxMMkUCm7U2X7dXR42eEZCYEjIYAkUiRGpWbHIPbiY2v7DC6t2RXNns8j5MB8FFEPDRppC/3oEj1aGq4UIskWucCL7aBRaOm6pZQIZGKiZ8lytLGxusujJlSlnHtDMIv59KYWh9Xr1lv1VkF/46dZ378d5ekuESlYppRP/OSPobvPf+Pl+AjHiyBVPJOUvtCOTeN5hIC2kSASKRIveAXYaewXrAnNUVWEVyh8ZXoBusW1x+KGueKlNR8OFo0Pn9zhaKZn7IEcpHJ2Obv813r4fojeVYFn/GHutJ5fwir1wPe6BWmWwKJqkRL1/eemwURFFPVI0nq4xYN46IG6epGWFofa9bwNyuMbdp1Zt6qTyDdd73kjH2MaV7wwkJFOsZ8fzQDFqcvhjxM6nH/L4nJFHw1suHZrl0U/6ira07CEgK8CBCJ5IXIegBaI2vV8IcRQwdLmF06RYxFs+OIvrLaluF+GKi/LW6tYm4pyQd30YlYzgYtUp4elUvjHR/0Qu7S7n+6Jo+oTrn9wvVW0kiI9RGgBJ4PfRaQbPZZOBCKG+ZJvvlKl9jBF9NNad/Apz99akYk8aWmdkl9GKBwNjwb/7hs4VxoGFRfMg40kRAgBLSHAJFICTqRU6qH3U5MfGXU1KmQGbhZgqT/TXGlsjFcQOnNTSpL2Q6eLLc2ptIkSa3ji7E+VvMtLYi+G9sOfj9FUlKL6TnUSIxDMonxkiXwX0Z8dT9fxeDD+EdsGYvfdVgaDV+86SEECAFjIUAkUqI+0ZIotlSP5VZC1xCbpGG5D1oYXiweBDNGjpJ4WppGCHAjgEQkfPpwySWN2FXVIElK6kyM9dF0XwxnmJs9TXCClS2Zg053hLUzlyh5JFXXovaFqsJLixMCmkGASKREVWSfyoHomFj4dmuKxBUAhJb7QQtI33lDJMdFMkk1kfHQRGc19yQDSxMdhsCZc+dh0GdRcCvwoqw9tVo9wNT6OP2DeUwx7A/ippRZ1di/N2nUEJ4ODrLCAC2RUw/GWsXDigVLbZKtpKUeEwexfeGA/n2Zf/QQAoSAcREgEilDtxFDo6FXWDdZfV57hEcyGZ18tdKEZvpaHgcTF14qHqR631sZMNJUHSOA3VfGbxsvKfPY9NheR4Jg66xkTcXsstbH/IsXmL7OlqQIz37l92tM+R0vTw9OLR47cQqGfyWvYwx+hgd5jodhEeoSMiWIJLUv1PGHmUQnBCQgQCRSAmjsFKGWRHtb4Ft7Suo2SF6ZwCuJWLc2/vg0/f0FWBgzWVM/zrwHdeAA/JG3fLBOoy1S4EDRdLEV4jdi/WjZlkgssr5mziJNnNnU+rho6XK4dDnfrKYhuvCRYFav6isoYzpswkBZ7n7sYjThqamSu9c4AlR0X2P8o4+3F7wbM5riHx0BOu1BCGgAASKRMpWApXrkdl0QWu4HRUUiue5EMvOjbatEB47DMh3PVOwEM94eQ4TIQsdsS76dh7616l+M/Zofu1kT+rTubbiOKjKvOud0JFRhEwfJqh6AMbvdbrylCWt5qfWxBPIvXmRcsgNf72dWhQEz0Y+dOMn0kRaahLJgxeewsSRBdPkjFnC12g7y3QehlkmKf+RDkv5OCBgXASKRMnUrxpJoayt0lWXnnIY5cVMESYM/ZIlfp8Dhv7+He97FZnOQBNUtbqx4mQ5BgulgUG7eBRjz4XT4vXa23WQH7KgSWNAK4mMmCyYLOji+KiLKzc5Wq7WemMPyWR9xLSzRBOAmunsMrv3eqvlwpMZ2MSIxY/FlcFiDMZrtpY7fXUi250x/jzckR/ThaQIhQAhoHgEikQqoSGwbQ8stpRYwR0J0Nu+C2XJVfatQVxobOsUf8yHzx8GVJzMFaZ1tRbhq9CIiknYQQ+vd+2nvS3ZpO8vSxh6Jz/poWjicLd0j6AKZDMLP6cCPh4mqF4mljwb4joTh4a+L3c4h42fHL6b2hQ5BmjYhBLSLAJFIBXSD1siDmVmCLYlcWwot96OAuC65BNvX+UzddFGdQ5BIBp3pqJl4Pa0qb9pHS2CHe5Joly1a2sY3n+SUeD81rY9cejqQcRQ+2LgYrgQd5b2DiEvPav1h/OAhmlI5urgv518BTCps1aI5TIoZxWSs00MIEAKuiQCRSIX0LiaukWtLJQqYK3QUQy4TtzABtvl8wvvjzXX4UpfiaIjo/bIhsVHiUBgbGfX+ZFG9sxlcG46BiF5hskRAMvhFSirk/1nA6BcTyvDx8qjMWOW7tLPOnnaE9ZHrUCjr/E9XwcGi/UwB8n8r32b6VLvdK88MR9f+4zeaaDYc5VDmEYidNgN6hnVjqkrQQwgQAq6NAJFIhfSPpS2QCAqNa+TaVomSQQodx1DLKFEQu/7pDvDJu3MpScnOzUCc0SL547+77HZoQZJX8bIfDG06nJNACk3owP2w9NWGzI3wT8AVqxhXJGcVLvsxMcITBwxj6jiaWh83pvwfHMrIMsu8xuOxpX2wdI9aD8Y1/5CRxXSMMX2eDm4gOuZSLRkt12XL92D8Y6uQZo7alvYhBAgBDSNAJFIh5UiNazTdvjRJZyskr1ymkFS0DCKAXUPm/TxDVsHnyrm1YGm/xRRvKuBKId6rt38J1x8+zxA7TPZyu1tqaXP/0+f/tXcm4FUU2R4/GQaZLDAuIAQQZCBh0SeyCA5oQI08BYMSmEF0AggOCEEIBARClIAsYQmLGBRkVBJlUQgQFpGJiGHMe/hY1YGQiI9FQAQVWeIgMrx3Gjvem9zkdld19+2+/e/v89Pvo+pU1a+K+M+pU+fQXb+/RxGP7CX09WkRkSwgR2VMpb03v+/3Cp3FJO9fnxYJ1Lhhfbr4ww/KY5D47t28Xl5z7GPW6lzq27M7icY+asDjuCZcvnBaxnyfgttxi8GEQQAEDCUAEWkgTo5r5E/GG3n/Iz0oc85Mah4dZeDM3G2KU6ysrDJf6CpbJcfXjGObTwpI7J5Td4+9badOn/GavpaHX1pEZHJ6Om2/fpVfAek5OAvJlj/fTfs/3VfO+5izOY9CiLC/ZQ6bGmYTe18MpSQnOfUoYt4gAAImEYCINBCs+gM3a3GmcLJdIx7pGLikoDDFKWi23bJUai18BfvnkEQaPfgpKTvoLE8ge/V6evnEFLpSwzu9lRbLkZ/cTa+lTS99bc/ex1eyVtCQvo/D+1gGYN62fBo38UUl9hHlC7WcLrQBAfcRgIg0eM9lX1kbcS1u8JIcb84IEemEqiGO3ygNC5CNb2WPMqfN4RKCfO1+lYjiH4rVMLK7mqB8obv2G6sFAVECEJGi5CroZ8Qraxai9etGesVrGTxNV5njKj9vnp0j5LlSQVU7UodmdZulqcydq+BavFgj4lubHL6X2tS5C7GPPvaOf35Nz5hH585foOlpqcI3KhYfCwwHAiAQIAIQkSaAN8Ib2XdQIm3dkGPC7Nxnkus7D101jC41/Fp48Td/eTu9PmwBko4LEzSmI8dC5tdcIRXfGlbYkF4fvJCa3NrAmEkFiRWULwySjcQyQMBCAhCRJsDesXM3jU+bIiUCke7H2I15ctxIOtg8T8gox0Pee7YXZYwbJ9QfnYwj8ETqcCqK+rCcQd4jzrl4+VAVqtr4SqUDcmhCxv0vwavsQYnLF/I/HP/YI66rcRsGSyAAAkFNACLSpO1NGDRUScgbH9dNaAQOauc0JOuWZwn1RydvAgU799DY3BSh0nzhnzemBQNmKnkG8QWWQNxz/emkR9lKFo89QwfSlyGf0T+2fEJXvqpC4U+UUMi1fOM+P05yPumeKfSgiXkgA0tJ3+iIf9THC61BAAR+JQARacJp4BQlazdsogWL/ibljZStyW3C0hxtkhNTLzw0S1e+SE4LU1FSbLvC+OLwUfqssIgiwsK8pvjHNnc6Pln6oMkTaHfDXGVdt/7Qkh5p/Cit2P0mHf7gDFVt8TNVa/+T323BdfY1RHx9nZg8Vol75PhHlC/0e3TQAARAoAwBiEgTj4SsCES6H+M3h3NGrjm1TFN8pNMEJFdaWbrpXTp6XSFdvuGcF7wq58Poxgv16NlHBtm2IoqW3eb9W1WyhHrc+Bf6V8S39M6atYr3Maznj/SbGvzW2v8XsSeaNkzNdryg9r/SilsUFhXT0FFjyyVcl7GJviAAAu4jABFp4p5fq0CzkbIXZwqNwpUiHuvTr1xiZCFj6FRKgF/4rtyRQ0fCPqefbzhX7pEGX3fauX6xr61cuPxteut//1ZpuUHux2v742+60KRnhztSRPHe/XDle93eR5UZV6+JOfO4q+Nb1evrlNFJFNs5Bj8ZQAAEQECYAESkMDptHdkbKZN83IgqONpm6q5WnG/w79sL6Isjx+jU6W9LFx8RFkod2rZylLeuomv6iOuq04WfzpfbWI4jjDp8L2UkT3DMa3PPmtcDR4+iH3/6QZf3UYXwuy/q08In5rsyvpV/KWUBmfdhvtTPJHf9pMBqQQAEKiMAEWny+ZC9kjYi76TJS4T5ABJgAflK4dxyHshBLYcouRAHvz/A5+ycVIGHr+mJrpbWvO7ywH206Zv3qaTZEV3k3fzK3rN84bBBAxH/qOvkoDEIgEBFBCAiTT4bRlxJy+adNHmJMB8gAuxNjRv7FJ2/a3/pDPihyaA7h9CGL9bRsgNv+fREqo351fnK55bY1hvp6X18J2ctfbJzd6kHja+15xRkUKPGkXQspJjOXz1b6S6wgLzzm/+kOckTHHmNL3PEONPDtNnzEP8oAxF9QQAEfBKAiLTgYEz7pQJEelqq0GhG5J0UGhidbE2Aa0hnHk2nn288R5HhdRXxGH1jMxq9dQSdvHjC79zt7I1kAfnpgYOl3sf47t28KjixgGYhubd4P+27IY/O/u5UhR7Xaidq0SNNHqXEnn1dJyDV+MeFc2ZQs+gov2cCDUAABEBADwGISD20BNsaUQ9b9qW34NTRzcYEBr/wAu1qvIb46rpTg/tp+f63aMOhdbpmXHdfe8qds0RXHzMbq97HFk0a0btr1inex/RJz1O7Nq1Khz115lva8tHH1KVTR+J0Wms2f0CbPnuvnJBkkcxX+v0e7kUtWzQ1c9q2s803INMy5tOBg0WUmTED5Qttt0OYEAgEBwGISIv2UbYeNsdW5m37SPkfAj4QYE9c0sIXaPKQkbTr6/+hxXtf0eR9LEvOTlfa3rGPr1HsfZ0U76Nn/sIt+R8TUUi5h0/MgwXoxZIfS5cYHhbqytKGKF+Inw8gAAJWEYCItIi0+oN97fKlwkHtsi+9LVoqhrGIwIkLx2nw5gFC4lGdIufCfGPAooCKLV+xj+mTUqldm9Y+vY+1a95kEWHnDcO/bE6dPVcpX9jvid7OWwBmDAIg4CgCEJEWbpfsAxmk+7Fws2w+1MWSEuqWkkAXWhVJzZQ9kRvTlgUsVrDsy+vY+2J8eh8Ldu6lxrc28FprnZo3UTBU4ZHaQI/OKF9oFEnYAQEQ0EoAIlIrKQPayabrUfvL5J00YBlBaYJj60JCQhy1tj6pw6k46kOpOUcX30fLprwkZUOks+p9bFivDm3avMVn7CO3SZu7kIpPfaHUPOcHRBznqH5qFZ4B9/+FejwUKzKNoOjDPxfGp02hGtUjaHxyEuIfg2JXsQgQcAYBiEiL9ylhUCLFx3WjHnFdhUaW9WYKDYpOtiTAJQDfuZpJ/w69JDQ/rt7S9ccBSvUaKz/2PnIM4/XhoTRlZgb58j5mr86lNzetUsTjT/VOVzo9tQrPmIFP2zZdkVl8Ef9oFlnYBQEQ0EIAIlILJQPbyKbrke1v4FJgKsAE9u0/SMPfGEsXbz8kNBOrq7eo3sdGt9Sj/O3blcopvl5eL8xaQXsPf0onW+zSLJDVKjxvp88VYuHETkuXraQFi5bQhNEjhX8pdeK6MWcQAAH7EICIDMBe8AMZDnwX9UY+2qev0h91bwOweTYb8pXslfTGxVmaxZY6faurt5T1PrZr25pSkkd4PTLjvI/sofzixP/Se1Wzhdb055BEGj34KZvtkvHT4dyzKF9oPFdYBAEQ0EcAIlIfL0Na8wvKnPUbKXtxppA92f5CgxrciVO1vF+wna5WvVJquW5EXapdsyb1eOiBgD30MHiZpptj0TUqYyrtvfl9zaJL9doten6q6Zx9eR/L/gLFeR+zVudS357dlTrmw7JG6S5pqIK2U8oiMzafr68Tk8dS86bR5US4GePBJgiAAAhURgAiMkDnQzZ5uFPT/bB4fP3Dt+lo1UKfsW6//a4G1ToZRW5/LKHnWLJQm/W3JVRQZRNdvvn7Srsy38an2lFG8gTT4wd9eR8572P9upGlc2Tv41Uiiv/lYQx7VpeeeUl5RCPy2bkKj8h6PPsUFhXT0FFjUb5QFiT6gwAIGEYAItIwlPoMsTdxx67dJFoKkeOhDhQVC/fXN1tjWrPQyfkuy6/Q4dGqHalDz9w+nBLi44wZ3AVWuAziOztW05laX9KV6iVeK2Zxdeu5ltTtPx6mB+/9o6kCUqv3Ua06o+Z9ZK9qn0lD6eRtu6R2q82hHrRo8mQpG3brrKbvKRtDard5Yj4gAALuIgARGcD9lvEmGlFK0cqli3iY+NXtkGYjISR1bBQLsf/atZf2HTio9AoPC1OurFmo3dE82lTxyONp8T6quSG7xHT0WhmLzz/P6S98la0aq/4/LWj9jDdMv6rXsS3CTbl8IQtIxD8KI0RHEAABEwlARJoI159pWW+kU9L98JXlrN3T/KZq8cXL6hg3J+aL9HfOrPhz1fvYskUz5eV1Tu7Gco/HPGte+6o6w6/Nh61IUtL6yHyBTqAuM3fPvmr6Hk6BlJKcZJRZ2AEBEAABwwhARBqGUr8h2eThssnL9c9YrMdjQxLpq7vzhToHc4ybEBAbdlK9j7c1aURDRo4hfnldNvaxIu+j53K+OHyUBiwaKu2JrLuvPeXOWWJDUtqnlLctn6bNnqeULkT5Qu3c0BIEQMBaAhCR1vIuN5psKUPZ5OVmL//TA0U0dNkI+lcTce+S1d5Is5kEi3093kf2UPJ1ur8v7rn+ro+JVOMfF86ZQc2io/whw5+DAAiAQMAIQEQGDP21gWVjG+2e7oerqqysMt8rlY9e5PzIZla3WdShzZ16u6K9SQS0eh85RrNLTAfN8YlpczJpY43XhM9LlXNh1P/6kTQk4XGTVm6eWf5ZMD1jnvIzITNjBsoXmocalkEABAwiABFpEEgZM+yN5LQnfAUo8sk80BEZT0+f0VNm07ZblurpUq4tp6XpV3M4DUnoLWUHneUJaPE+erbR4n30nFXBrr00dt144bhIflSzfGKm6Q+I5El6W0D5QqOJwh4IgIAVBCAiraDsZwzZ2EbZBzpmIkhOT6ePIt+WGoK9S8PqpeKVthRF+c5avI8cvrBvfyF16dRReREu8k1c8BK9VzVLc/J0dQz+ZSOxwThK6OmstFCcrov/QfyjyGlBHxAAgUASgIgMJH2PsWVeWsteiZuJgK8nN9z0qtQQnOpn0j1T6MGYDlJ20FmMgBbvI19bs8jkdEJ8fS3zsa3BL06g4lu3axaS/ADrzm/+k+YkTyh3dW7nF/dq/GPW4kxcX8scGvQFARAICAGIyIBgLz/ojp27aXzaFNq6IUdoRixCm0dH2e4lJ6f3mXFgonAFEoYRVtiQXh+8kJrc2kCIjd07sUjj3I6HjhwrnWrtWjUpIiyUHrxXezyhGevU4n3keRfs3CPlfSw7d7UKz8fV1vs9O/xLxoPVH6MxA57WHHtpBis9NtXyhRzGMj45CQJSDzy0BQEQsA0BiEjbbAWRzEtr2StxszBw2paBmcPp4u2HhIdoeiCWrKjzLDxBwY7scXv1rZW08bPNSgzgv0MveVlSq8z0bh9PPX4pCyg4lO5uqmeRhXtFeR/ZKJexJAqR9j5WNEG1Cs93Ecd9VuFpdK4l9ev6J9PG1w1OQweUL9QACU1AAAQcQQAi0kbbpOaGE/VGyohQMzHwC+13rmZqvpr0nAt7mca0TrFcRJnJg22zp23k/Ml0qH6BXy5Vv7mBulTrRUP6PGHJgxGOa2TxX1neR3+Jw43kx4L279sLiP+tfCEhyr845lLk6jyQ19tq/GPK6CSK7RxjJCbYAgEQAAHLCUBEWo688gH5pfX0tFRq37a17pmxCF2waAmtW56lu6+ZHfh//n+dPo6Koz7UNQx74lqd6Bp0dZBZQCZnTDUs5k8X1Eoa28X7aNR67GZnWsY8lC+026ZgPiAAAlIEICKl8BnfWTbvo4wINX41v1r88sgxeurlZ6mk6WFNOQBZQEYdvpcykidY4n3ztXazPFaDJk+gvTe/79cDWXZOZqY60up9zFqVS317dRd+eW3mGbOrbc/yhZzGq0b16nadKuYFAiAAAroIQETqwmVNYxaCmRnp1Lyp/wofZWdk53Q/LCSff2UOHar9SaWPJfgKm2PdAikgzdppFmtD3k2kSw2/FhoiYk80rZiwyDBhrdX7mLM5j/gS2erYTCFINur0ya49NG7iixTfvZtwHlgbLQdTAQEQAAEvAhCRNjwQMkLw3Pnz9FiffmTXlCEsWtZs/oDe2bGazv7ulBf98LBQuulsQ8c9lNBzhDhvZn7NFZq8sb7sKjkz66YakgtRs/dxdS717Qnvo5595rYoX6iXGNqDAAg4jQBEpE13TKYKjWw9bquQ8OONiyU/eg3XskVTq4a3fBwW0I9MSKALrYqkxu58rB/NTh0tbEOr9zF7da4yRkLP7sJjOa2jESEM/IvctIz5dOBgEcoXOu0AYL4gAAK6CEBE6sJlXWP2YnAsVXpaqu5B7ZruR/dCbNDBCFGhLmPf/oM0dNUw4ats1U7kP9vQ+plvCtGB91EIm+ZOnvGPKclJmvuhIQiAAAg4kQBEpE13TbYKzbUKOK2oR1w3m67QfdPiutCj3x9FP9U7LbX4OkV30oap2bpslPU+vvn2CpoweiT1iOvqZYeTw18loniL81LqWowFjUV+eeAwlKmz59Kzg5+2XdJ/C5BhCBAAARcSgIi08abLXEtfq4DzIm3dsMbGK3TX1NgTOWxFkpJYXObj5Otvp8/VbKKs97Fe3UgljRRXS1E/zvuIl9eakZZriPKF4uzQEwRAwLkEICJtvHfq1ZjoIxm7pvuxMXJTp2ZETGTI5SrU+8oIGj34Kb9z9eV99OUl49KGRFepS0xHvzbd1sCfR5L/jnK5Uv7KCnO3scJ6QQAE3EcAItLme37tWrp1uWtHLdOWeeWtxb5b2vgTEno48OvsjyLf1tPFqy3nikxsMM7v62yt3sctH31saM1r4YU5sKP6Sx7S9zhw8zBlEAABQwhARBqC0TwjWh7JVCZyZF55m7cq91pmr1/aP1KF4yL5Uc3yiQspIjzMJ0TV+8h/XlR4gDj2Ed5H488bly/k6lC+4kqNHw0WQQAEQMCeBCAi7bkvXrNKTB5LsZ07CXkjZeIqHYDGkVMclTGV/hG+RnfFmmpH6tAztw2v0AvJ3sd9+wupRZNGNGbCRKoo9pG9jx3atqLGDW+xlJ+RHl1LJ15mMBaP7OUXDTMJ5NwxNgiAAAgYSQAi0kiaJtm69khmCm3dkKN7BNWTuXb5UpRb003PnA4itbO5is+QZiMpIT6u3KQ8vY8nvzpG7CXr90Tvci+E2QvKbbvEdKjQk2nOioPDKv9d4l/ouJJUSvII/H0Kjm3FKkAABCQIQERKwLOya8KgoUq6nniBlD0ycZVWrtFNY7GQnPW3JfRxtfWVloDkGuLVTtSiQXcO9SkgPb2P8zJfVRD6ennN3seWLZrRHc31l9J0075UtNbComIaOmqsV/nCYPGsYn9BAARAQJQARKQoOYv75azfqHiY1i3P0j2yjCdT92DooItA9ur1SgnI7yKO05XqJV59q35fg+76/T3U7+FeVLaST1nvI1+x9n/y8XL1mTk35aHDR/F4RteueDdW0/ekjE6i2M4xEpbQFQRAAASCiwBEpIP2UyZlz6N9+ioPLPA/QfttOAvCTwuL6OJFbxF5c82byolHnn1Z7+PxEyfLxed5iky+vsannwCXL2QBmfdhPuIf9eNDDxAAARcQgIh00CZzMD97JLMXZ+qetUxf3YOhgykEtHofVZHZpVNHql3zJlPmEuxGUb4w2HcY6wMBEDCCAESkERThjiKaAAAUQ0lEQVQttCGTskemr4VLxFA+CGjxPnK3LfkfE1GI8ngGnxiBvG35NG32PK/4RzFL6AUCIAACwU0AItJh+yuTQJxjKg8UFVN6WqrDVu3e6Wr1PnLZQiQOlz8navzjwjkzqFl0lLxBWAABEACBICYAEemwzZUphch9H4iLpw/W53jVTXYYAtdMF95H67aa/25Mz5hH/O/MjBn4+2EdeowEAiDgYAIQkQ7cPJkE4kj3U37D9+0/SH/fXkC7j+2hkJ+rlDaoc31tujPqNurx0AOleRWtSOvi6X28+MNZpTKKr9J67H3MeS+P4h+OReyjxN9jlC+UgIeuIAACriYAEenA7ZfxKGopo+hAJEJTVnM17vz2v+nHxl/5rCDDtaobfduGxj85zJIci57ex3fXrKNPdu72+TKYxWNICFGPh2KF1o5O1whweAiLdF/J2cEIBEAABECgcgIQkQ49IexRrF83slxeQC3LSRiUqCQt7xHXVUvzoGzDAnLk/Ml0qH6BpvKDYYUN6a93DfaZ8NsIQHq8j1mrc6lvz+7wPkqCV+MfUb5QEiS6gwAIuJYARKRDt17Go+j2dD8iZQf5mIQeqk/Pxz5v+Mtn1ft4W9Qf6J2ctRV6H7NX5yqnNaFnd4eeWntMm//ucBnRGtUjaHxyEuIf7bEtmAUIgIADCUBEOnDT1CnLxDe6Od1Pcno6bb9+lSYPZNnj0fRALGUkT6A6tWpKnxw93sdZr75BY555Ct5HSeqIf5QEiO4gAAIg4EEAItLBx0HWG7lj127Xpfv54vBRGrBoKJU0OyK089cdr0VDmiZJewO1eh/XbM6jq/9fpSYesY9C++XZiVNccfxj+qTnUblJmiYMgAAIgAARRKTDT4FofKPM4xwnI+Na1ZlH0+nnG88JLyOquDMtn7JAqL8e72PWqlzq28t9sY9mvICfljEP5QuFTiw6gQAIgEDFBCAiHX46duzcrcR3bd2Qo3slfB3ePDpKeZnqlu+J1OFUFPWh1HIj9kTThqnZpWl/tBrT6n3ckl9ARFepS0xHrabRrgICqre+XdvWlJI8gmpUrw5WIAACIAACBhGAiDQIZCDNcHzjs4Of1v3aWuY6PJDrlRm7c1JPutCqSMYEVTtSh2Z2nUkd27bSZEeP99HsqjP8qOjLo1/RxYslpXMPDw+jO5pF6xbFmhYfwEaf7NpD4ya+iPKFAdwDDA0CIBDcBCAig2B/ZV5bi16HOxWbESKSX2m/OXAxNW54i18MdvE+qgnV13+xji7VPa0kVQ+5/Ftl/vzfN1yoR73bxyt5JyPCw/yuy+4N1PQ9HP/Yro02sW/3NWF+IAACIGA3AhCRdtsRwfmwN3J6Wiq1b9tal4W8bfnKY4N1y7N09XNq47jn+tPJ23ZJTT/888a0adJyCg8LrdCOnbyP2TnracW+ZXQ6srjSF+mcWL3xqXaGvT6XgizY+dz58zQtY36FaZIEzaIbCIAACICADwIQkUFyLNgbKfraWlSAOhFd2pxM2hT2hlB6H3W9dfe1p9w5Sypcvh7vI4vNLjEdTPP+sYBcvHehUpFHyxdyuQo1ORxDc0e8YEgaIy1jGtVGDc+IvS+GUpKTjDILOyAAAiAAAhUQgIgMoqMhmvtRRoA6DR8/Wkn7Ryr9VO+00NR/82M1eip8DA1JKP8YSa/3sWWLZqaWUizYuZfG5o7XLCBVILzGqMP30tvpc4UYBaITe9Q5/pFjg930UCwQrDEmCIAACKgEICKD6CxwHrwDRcW6cz/yFeBjffr5rNEcRHhKl/LkuJF0sHme0NIi/9mGXhszu5yXTo/38dTpM9SlU0fTE4c/NiSRvro7X2idnA8z7Z4phlfnEZqMn04oX2gGVdgEARAAAf8EICL9M3JMC77Oe6xPX1q7PEt3KTdO98NfelqqIes1I9efIRMjoi+PHKP+rw7RnXCchdWY1inK4xP1u1BSQls+KlCuoy/+cFaJL43v3q1cTXNPLyVfX5v9sagdumwE/auJtmtsX/Ph6jx29kbyeZ+eMY/Onb+gxANzLXl8IAACIAAC1hGAiLSOtSUjiYpBt6X74Uowcz+ap1lIKpVqmo2khPi40n1kocZi+crPlyutea16Ka3wPqqTm73oDVpZZT5drXpF+NyJ5sMUHlBHR5Qv1AELTUEABEDAJAIQkSaBDZRZWW9k+zatdeebDNRaZcdlcZf62kz65pYDFVaw4fhATunz9B8HlgpIT6/ihR++p5cXLaHY+zop3kfPZNZWex89echc2at2OB/mwl4vU8sWTWVRG9qfwzb4H5HcqIZOBMZAAARAwOUEICKD8ACIVqKRqX7jZIxcCvGdHavp3NWzXsuofl116tzgfvpLfFxpDGT52MddSi3mdm28UyudOvMtmZ04vDLmRqQyqvrNDTS5fTo9aMH1u9bzg/hHraTQDgRAAATMJwARaT5jy0eQuZp2U7ofz41hryHHN3p+EWFhpal3fL285lQyZb2P3H9L/secwjugj1L6pA6nYsnyjuyJfOVPmaa+INf6l4PPdGLyWCXukeMfUb5QKzm0AwEQAAHzCEBEmsc2oJbZGylyNe2mdD9aN8jXy2vPSijqI6JAex891zN6ymzadstSrUv02Y6Tqm9MW2ZaDkutkyssKqaho8aifKFWYGgHAiAAAhYRgIi0CLTVw8hcTYvmm7R6jWaPp8f7yGUFT505Q11iOpo9LU32+eHQzM8m0+Wbv9fU3lcjf0nVhQ3r6KheX6eMTqLYzjE6eqIpCIAACICA2QQgIs0mHED7onWxRV94B3Cphg+teh/vbt2S3s1ZQ3kf5v8S++hdh5m9j1mrcqlvz+5Uu9ZNhs9D1ODXp89Q75lP08XbDwmZ4BKIiQ3GUULPX1+jCxkS7MS5S1lAMvesxZlI3yPIEd1AAARAwEwCEJFm0g2wbb6a5ryFWzfk6JqJGlO5dvlS18WeeXofrw8PVaqgVBT7mL06V+Ga0LO7Lr5WNeaSh68UzhWqzsM5Ihc9PzUgV9me5Qt9xZxaxQ/jgAAIgAAIVE4AIjLIT4joQxn2RrZr04ri47oFOaFfl+fL++grjQx7H2e9+gaNeeYp06vOyMKfuOAl2kxv05Ua3o+GKrN785e308sDZtIfGt4iO7zu/ly+cNrseYh/1E0OHUAABEDAegIQkdYzt3RE9kbmrN9I2YszdY0rE1OpayAbNPblfWzXtrXy8rpsFRSONeT2/ryPdqnYw3N9ZcUyWnt8JV1q+HWltDkn5s3HmtNLg6YFRECq8Y8L58ygZtFRNjgZmAIIgAAIgEBlBCAiXXA+RB/KPNqnr5LQOZgfNPzqfbyD3s1Zq8TgVeR9VGIfe3W3vffR15Fm8fv61rfou4jj5R7bhFyuQr87GklxTR71yolp1V8Njn8cnzaF+Bo7M2MG4h+tAo9xQAAEQECSAESkJEAndBdN2yPqxXQCE73ex6tXieIf/rVmthPWWHaOvOa/by+gQ0eOef1ReFgY9XjogdKE6lauDeULraSNsUAABEDAWAIQkcbytK01UW+kaD/bgiAiPd7HQFadsTNDI+bGv6RMnT1X8fz2e6K3ESZhAwRAAARAwEICEJEWwg7kUBxvxl6f9LTU0mloidvz1S+Q65AZ29P72KJJI+o7KJEqin3ckl9ARFdtk/dRZt127IvyhXbcFcwJBEAABPQRgIjUx8uxrVlAPhAXr6T7qRcZqXkdar8P1uc4OlZN9T526dRRiX3Myd1YYewjvI+aj4fuhnyeOP6xRvUIGp+c5OgzpXvx6AACIAACQUYAIjLINrSy5YxLe5Gda0rSbD2faAlFPWOY1Vav95Hbd4npYEp+RC2eX7M42MEu4h/tsAuYAwiAAAgYRwAi0jiWtrd0/MRJ4io2eiuAHDhYRInJ43QnLQ80EL3ex5YtmtEdzaMDPe2gHH/pspVK4vsJo0dSj7iuQblGLAoEQAAE3EYAItJlOy7qVRQtoRgIvHq9j6dOnyG+5q5d0z5lCwPBzawxp2XMQ/lCs+DCLgiAAAgEkABEZADhB2Jo9UpRbylEp6T70et9rF2rpnJ9jc94AupZ48dLKckjXFdC03iisAgCIAAC9iIAEWmv/bBkNqJeRbun+9mS/zERhZC/l9eeQhPeR3OOXGFRMQ0dNRblC83BC6sgAAIgYAsCEJG22AZrJyFa0lA0abne1X19+gx9c+Y7ulBSQuGhoUr38LBQJRl2RHhYOXNcy1p9UV3Zy2vPa254H/Xuivb2avoefsDF9dfxgQAIgAAIBCcBiMjg3Fe/q+KShv2feFzXIwez0/2weHwrZz1t/GwzXap72msNIT9XoRsv1KM/t+9JCT3jSv9Mq/fRU2jayfvIL7b5CwkJ8btndm/A5QtZQHLpSL2Pt+y+NswPBEAABECgPAGISJeeCtEYR36Y0zw6yvAKI5zce/4HC+h0ZDH9O/RShbvy2+9qUMvvH6DnBv6VCnbuUR7EVOZ9ZEOq0IT3kcisNENq/GPsfTGUkpzk0r9VWDYIgAAIuIsARKS79ttrtRzjOD0tldq3ba2ZgujDnMoG4BjFYVmjqKTZEU3zCLlchSL3t6WJ/UbQmAkTK6w6Y1fvo6ZFOqhR3rZ8mjZ7nvKLBcoXOmjjMFUQAAEQkCQAESkJMBDdjfImsTcyb9tHlJkxQ9cyRB/m+BrkyyPHaNjrz9E3f/hc1xx+82M1Ci1oQkl/6uvzSj7nvTziG+IeD8XqsovG+gio8Y8L58ygZtFR+jqjNQiAAAiAgKMJQEQ6evvkJy/y4po9T5w4et3yLOkJJKenU37NFXS16hXdtq47XovS7pnilaKHvY9Zq3Kpb6/uyPuom6j2DuyRnp4xT6nHzr+E1K+rvZSm9lHQEgRAAARAwM4EICLtvDsWzE30xbXIVXjZ5ei9xvaFo/WR7rT4hanKH2WvzlVeb8P7aO7BQflCc/nCOgiAAAg4hQBEpFN2yqR5qoJA72taUfHpuYzs1esp82g6/XzjOeHVhX/emKb3TqOczXk05pmngsb7aFTIgjDYCjpy+UL+B/GPRpOFPRAAARBwHgGISOftmeEz5hfX/KWnpWq2LSo+PQcY/MILtKvxGs1j+mrIV9oJtwymIQm9peygs38Cavyj3l84/FtGCxAAARAAAScSgIh04q4ZPGfR/I8i4tNz6k+OG0kHm+dJrYZT/oxtPglX2FIUK+/M5yMxeawS9zg+OQnxjyayhmkQAAEQcBIBiEgn7ZaJc2VByCJh2KCBmkeRTfczaPIE2t0wV/N4FXkiJ90zhR5E/WspjhV1RvlCU7DCKAiAAAgEBQGIyKDYRvlFiApC9lDFdu6kq/KNOtu0OZm0scZrQi+zVRthhQ3pnVFvKiUR8RlLQI1/TBmdRLGdY4w1DmsgAAIgAAKOJwAR6fgtNG4B7I1s36a1LkEoWoebZ71mcx7N2j2NfqrnXeJQz4oi/9mG1s98U08XtNVAYFrGPJQv1MAJTUAABEDAzQQgIt28+2XWfuBgESUmj6OtG3J0URFJ98OlCC+W/EjzN79CF1oV6RpPbczxkIkNxnnV0hYy5JBOVtTZ9ixfyKENNapXdwgdTBMEQAAEQMBqAhCRVhO3+Xgi1Wj0pPvxLEXINa+zVufSbzudF/JGshdy+cSFSm5IfPIEPtm1h8ZNfJHiu3fTFRsrPzIsgAAIgAAIOJEARKQTd83EOYteT2upfMPeR6IQatGkEY3/Ja0Q1+5+bfW79F7VLPp36CXNKws9VJ9mPDqdOrS5U3MfNKyYAMoX4nSAAAiAAAjoJQARqZeYC9qzINT7mKKydD+e3sfNW/KUkonPDn5aSVjN34WLJTRxwUv03z99QJcafl0pYa6ZXe1ELXo+9nmvcocu2BZTlnju/HmaljGfOJQB5QtNQQyjIAACIBC0BCAig3ZrxRfG19M56zdS9uJMzUbUWLq1y5d6xdGV9T4eP3GSfCWrZqE569XX6eC5f9LpyOJyVWxU8XjX7++hoT0TqMmtDTTPDQ19E/CMf0xJTgImEAABEAABENBFACJSFy73NBZ5LOP5utuX97H/k4/7jLUr2LWHDh0+Rl06daTw0FBas/kDOnXmDH19+luqU+umUugP3tuBWrZo6p5N0LBS0fKI/IvC1NlzvTzCGoZDExAAARAAARAoJQARicPgk4CexzKqATWectxzyV6xjxV5H/kae0t+gfIwpguShQufRL1CEuULhVGjIwiAAAiAgAcBiEgchwoJaHks49mZvY9PDhyseLfOnv1BiX2syPv46YEi2re/UPE+1q75q7cR22EeAb6+9nzQxBWK8IEACIAACICAKAGISFFyLujHHisWHulpqX5Xq8Y+nvzqGHGi6nqRkT5jH9mQ2hbeR79YDWugxj8ifY9hSGEIBEAABFxPACLS9UegYgAsPB6Ii6cP1ucodbV9fZ6xjwX/tUOJs+Nv7fKscn0828L7aN3B4/KF7BWeMHqkrmpE1s0QI4EACIAACDiRAESkE3fNwjlXlrrH8+U1ey0/2blb8T6u3bCpnAcz5708Cgkh6vFQrIWzx1AoX4gzAAIgAAIgYBYBiEizyAaJXfUa1DMtT1nvI3u5PK9JPT2YVa+7jrJW5VLfXt0R+2jRmeCHNsdPfk2JyWOpedNoSkkegfKFFrHHMCAAAiDgJgIQkW7abawVBEAABEAABEAABAwiABFpEEiYAQEQAAEQAAEQAAE3EYCIdNNuY60gAAIgAAIgAAIgYBABiEiDQMIMCIAACIAACIAACLiJAESkm3YbawUBEAABEAABEAABgwhARBoEEmZAAARAAARAAARAwE0EICLdtNtYKwiAAAiAAAiAAAgYRAAi0iCQMAMCIAACIAACIAACbiIAEemm3cZaQQAEQAAEQAAEQMAgAhCRBoGEGRAAARAAARAAARBwE4H/A4QBGj0swyEuAAAAAElFTkSuQmCC", "text/html": [ - "
\n", + " " + ] + }, + "metadata": {}, + "output_type": "display_data" + }, + { + "data": { + "application/vnd.plotly.v1+json": { + "config": { + "plotlyServerURL": "https://plot.ly" + }, + "data": [ + { + "line": { + "color": "#263238", + "width": 2 + }, + "mode": "lines", + "name": "lines", + "showlegend": false, + "type": "scatter3d", + "x": [ + 0, + 2.87, + 2.87, + 0, + 0 + ], + "y": [ + 0, + 0, + 2.87, + 2.87, + 0 + ], + "z": [ + 0, + 0, + 0, + 0, + 0 + ] + }, + { + "line": { + "color": "#263238", + "width": 2 + }, + "mode": "lines", + "name": "lines", + "showlegend": false, + "type": "scatter3d", + "x": [ + 0, + 2.87, + 2.87, + 0, + 0 + ], + "y": [ + 0, + 0, + 2.87, + 2.87, + 0 + ], + "z": [ + 2.87, + 2.87, + 2.87, + 2.87, + 2.87 + ] + }, + { + "line": { + "color": "#263238", + "width": 2 + }, + "mode": "lines", + "name": "lines", + "showlegend": false, + "type": "scatter3d", + "x": [ + 0, + 2.87, + 2.87, + 0, + 0 + ], + "y": [ + 0, + 0, + 0, + 0, + 0 + ], + "z": [ + 0, + 0, + 2.87, + 2.87, + 0 + ] + }, + { + "line": { + "color": "#263238", + "width": 2 + }, + "mode": "lines", + "name": "lines", + "showlegend": false, + "type": "scatter3d", + "x": [ + 0, + 2.87, + 2.87, + 0, + 0 + ], + "y": [ + 2.87, + 2.87, + 2.87, + 2.87, + 2.87 + ], + "z": [ + 0, + 0, + 2.87, + 2.87, + 0 + ] + }, + { + "line": { + "color": "#263238", + "width": 2 + }, + "mode": "lines", + "name": "lines", + "showlegend": false, + "type": "scatter3d", + "x": [ + 0, + 0, + 0, + 0, + 0 + ], + "y": [ + 0, + 2.87, + 2.87, + 0, + 0 + ], + "z": [ + 0, + 0, + 2.87, + 2.87, + 0 + ] + }, + { + "line": { + "color": "#263238", + "width": 2 + }, + "mode": "lines", + "name": "lines", + "showlegend": false, + "type": "scatter3d", + "x": [ + 2.87, + 2.87, + 2.87, + 2.87, + 2.87 + ], + "y": [ + 0, + 2.87, + 2.87, + 0, + 0 + ], + "z": [ + 0, + 0, + 2.87, + 2.87, + 0 + ] + }, + { + "marker": { + "color": "#33a02c", + "line": { + "color": "#455A64", + "width": 0.5 + }, + "opacity": 1, + "size": 10, + "sizemode": "diameter", + "sizeref": 750 + }, + "mode": "markers", + "opacity": 1, + "type": "scatter3d", + "x": [ + 0, + 1.435 + ], + "y": [ + 0, + 1.435 + ], + "z": [ + 0, + 1.435 + ] + }, + { + "marker": { + "color": "#fb9a99", + "line": { + "color": "#455A64", + "width": 0.5 + }, + "opacity": 1, + "size": 10, + "sizemode": "diameter", + "sizeref": 750 + }, + "mode": "markers", + "opacity": 1, + "type": "scatter3d", + "x": [ + 0.7174999999999994 + ], + "y": [ + 2.87 + ], + "z": [ + 1.435 + ] + }, + { + "marker": { + "color": "#e31a1c", + "line": { + "color": "#455A64", + "width": 0.5 + }, + "opacity": 1, + "size": 10, + "sizemode": "diameter", + "sizeref": 750 + }, + "mode": "markers", + "opacity": 1, + "type": "scatter3d", + "x": [ + 1.435 + ], + "y": [ + 0.7174999999999996 + ], + "z": [ + 2.87 + ] + } + ], + "layout": { + "height": 360, + "margin": { + "b": 10, + "l": 10, + "r": 10, + "t": 10 + }, + "scene": { + "aspectmode": "data", + "aspectratio": { + "x": 1, + "y": 1, + "z": 1 + }, + "xaxis": { + "showbackground": false, + "showticklabels": false, + "title": { + "text": "" + }, + "type": "linear", + "zerolinecolor": "#455A64" + }, + "yaxis": { + "showbackground": false, + "showticklabels": false, + "title": { + "text": "" + }, + "type": "linear", + "zerolinecolor": "#455A64" + }, + "zaxis": { + "showbackground": false, + "showticklabels": false, + "title": { + "text": "" + }, + "type": "linear", + "zerolinecolor": "#455A64" + } + }, + "showlegend": false, + "template": { + "data": { + "bar": [ + { + "error_x": { + "color": "#2a3f5f" + }, + "error_y": { + "color": "#2a3f5f" + }, + "marker": { + "line": { + "color": "#E5ECF6", + "width": 0.5 + }, + "pattern": { + "fillmode": "overlay", + "size": 10, + "solidity": 0.2 + } + }, + "type": "bar" + } + ], + "barpolar": [ + { + "marker": { + "line": { + "color": "#E5ECF6", + "width": 0.5 + }, + "pattern": { + "fillmode": "overlay", + "size": 10, + "solidity": 0.2 + } + }, + "type": "barpolar" + } + ], + "carpet": [ + { + "aaxis": { + "endlinecolor": "#2a3f5f", + "gridcolor": "white", + "linecolor": "white", + "minorgridcolor": "white", + "startlinecolor": "#2a3f5f" + }, + "baxis": { + "endlinecolor": "#2a3f5f", + "gridcolor": "white", + "linecolor": "white", + "minorgridcolor": "white", + "startlinecolor": "#2a3f5f" + }, + "type": "carpet" + } + ], + "choropleth": [ + { + "colorbar": { + "outlinewidth": 0, + "ticks": "" + }, + "type": "choropleth" + } + ], + "contour": [ + { + "colorbar": { + "outlinewidth": 0, + "ticks": "" + }, + "colorscale": [ + [ + 0, + "#0d0887" + ], + [ + 0.1111111111111111, + "#46039f" + ], + [ + 0.2222222222222222, + "#7201a8" + ], + [ + 0.3333333333333333, + "#9c179e" + ], + [ + 0.4444444444444444, + "#bd3786" + ], + [ + 0.5555555555555556, + "#d8576b" + ], + [ + 0.6666666666666666, + "#ed7953" + ], + [ + 0.7777777777777778, + "#fb9f3a" + ], + [ + 0.8888888888888888, + "#fdca26" + ], + [ + 1, + "#f0f921" + ] + ], + "type": "contour" + } + ], + "contourcarpet": [ + { + "colorbar": { + "outlinewidth": 0, + "ticks": "" + }, + "type": "contourcarpet" + } + ], + "heatmap": [ + { + "colorbar": { + "outlinewidth": 0, + "ticks": "" + }, + "colorscale": [ + [ + 0, + "#0d0887" + ], + [ + 0.1111111111111111, + "#46039f" + ], + [ + 0.2222222222222222, + "#7201a8" + ], + [ + 0.3333333333333333, + "#9c179e" + ], + [ + 0.4444444444444444, + "#bd3786" + ], + [ + 0.5555555555555556, + "#d8576b" + ], + [ + 0.6666666666666666, + "#ed7953" + ], + [ + 0.7777777777777778, + "#fb9f3a" + ], + [ + 0.8888888888888888, + "#fdca26" + ], + [ + 1, + "#f0f921" + ] + ], + "type": "heatmap" + } + ], + "heatmapgl": [ + { + "colorbar": { + "outlinewidth": 0, + "ticks": "" + }, + "colorscale": [ + [ + 0, + "#0d0887" + ], + [ + 0.1111111111111111, + "#46039f" + ], + [ + 0.2222222222222222, + "#7201a8" + ], + [ + 0.3333333333333333, + "#9c179e" + ], + [ + 0.4444444444444444, + "#bd3786" + ], + [ + 0.5555555555555556, + "#d8576b" + ], + [ + 0.6666666666666666, + "#ed7953" + ], + [ + 0.7777777777777778, + "#fb9f3a" + ], + [ + 0.8888888888888888, + "#fdca26" + ], + [ + 1, + "#f0f921" + ] + ], + "type": "heatmapgl" + } + ], + "histogram": [ + { + "marker": { + "pattern": { + "fillmode": "overlay", + "size": 10, + "solidity": 0.2 + } + }, + "type": "histogram" + } + ], + "histogram2d": [ + { + "colorbar": { + "outlinewidth": 0, + "ticks": "" + }, + "colorscale": [ + [ + 0, + "#0d0887" + ], + [ + 0.1111111111111111, + "#46039f" + ], + [ + 0.2222222222222222, + "#7201a8" + ], + [ + 0.3333333333333333, + "#9c179e" + ], + [ + 0.4444444444444444, + "#bd3786" + ], + [ + 0.5555555555555556, + "#d8576b" + ], + [ + 0.6666666666666666, + "#ed7953" + ], + [ + 0.7777777777777778, + "#fb9f3a" + ], + [ + 0.8888888888888888, + "#fdca26" + ], + [ + 1, + "#f0f921" + ] + ], + "type": "histogram2d" + } + ], + "histogram2dcontour": [ + { + "colorbar": { + "outlinewidth": 0, + "ticks": "" + }, + "colorscale": [ + [ + 0, + "#0d0887" + ], + [ + 0.1111111111111111, + "#46039f" + ], + [ + 0.2222222222222222, + "#7201a8" + ], + [ + 0.3333333333333333, + "#9c179e" + ], + [ + 0.4444444444444444, + "#bd3786" + ], + [ + 0.5555555555555556, + "#d8576b" + ], + [ + 0.6666666666666666, + "#ed7953" + ], + [ + 0.7777777777777778, + "#fb9f3a" + ], + [ + 0.8888888888888888, + "#fdca26" + ], + [ + 1, + "#f0f921" + ] + ], + "type": "histogram2dcontour" + } + ], + "mesh3d": [ + { + "colorbar": { + "outlinewidth": 0, + "ticks": "" + }, + "type": "mesh3d" + } + ], + "parcoords": [ + { + "line": { + "colorbar": { + "outlinewidth": 0, + "ticks": "" + } + }, + "type": "parcoords" + } + ], + "pie": [ + { + "automargin": true, + "type": "pie" + } + ], + "scatter": [ + { + "fillpattern": { + "fillmode": "overlay", + "size": 10, + "solidity": 0.2 + }, + "type": "scatter" + } + ], + "scatter3d": [ + { + "line": { + "colorbar": { + "outlinewidth": 0, + "ticks": "" + } + }, + "marker": { + "colorbar": { + "outlinewidth": 0, + "ticks": "" + } + }, + "type": "scatter3d" + } + ], + "scattercarpet": [ + { + "marker": { + "colorbar": { + "outlinewidth": 0, + "ticks": "" + } + }, + "type": "scattercarpet" + } + ], + "scattergeo": [ + { + "marker": { + "colorbar": { + "outlinewidth": 0, + "ticks": "" + } + }, + "type": "scattergeo" + } + ], + "scattergl": [ + { + "marker": { + "colorbar": { + "outlinewidth": 0, + "ticks": "" + } + }, + "type": "scattergl" + } + ], + "scattermapbox": [ + { + "marker": { + "colorbar": { + "outlinewidth": 0, + "ticks": "" + } + }, + "type": "scattermapbox" + } + ], + "scatterpolar": [ + { + "marker": { + "colorbar": { + "outlinewidth": 0, + "ticks": "" + } + }, + "type": "scatterpolar" + } + ], + "scatterpolargl": [ + { + "marker": { + "colorbar": { + "outlinewidth": 0, + "ticks": "" + } + }, + "type": "scatterpolargl" + } + ], + "scatterternary": [ + { + "marker": { + "colorbar": { + "outlinewidth": 0, + "ticks": "" + } + }, + "type": "scatterternary" + } + ], + "surface": [ + { + "colorbar": { + "outlinewidth": 0, + "ticks": "" + }, + "colorscale": [ + [ + 0, + "#0d0887" + ], + [ + 0.1111111111111111, + "#46039f" + ], + [ + 0.2222222222222222, + "#7201a8" + ], + [ + 0.3333333333333333, + "#9c179e" + ], + [ + 0.4444444444444444, + "#bd3786" + ], + [ + 0.5555555555555556, + "#d8576b" + ], + [ + 0.6666666666666666, + "#ed7953" + ], + [ + 0.7777777777777778, + "#fb9f3a" + ], + [ + 0.8888888888888888, + "#fdca26" + ], + [ + 1, + "#f0f921" + ] + ], + "type": "surface" + } + ], + "table": [ + { + "cells": { + "fill": { + "color": "#EBF0F8" + }, + "line": { + "color": "white" + } + }, + "header": { + "fill": { + "color": "#C8D4E3" + }, + "line": { + "color": "white" + } + }, + "type": "table" + } + ] + }, + "layout": { + "annotationdefaults": { + "arrowcolor": "#2a3f5f", + "arrowhead": 0, + "arrowwidth": 1 + }, + "autotypenumbers": "strict", + "coloraxis": { + "colorbar": { + "outlinewidth": 0, + "ticks": "" + } + }, + "colorscale": { + "diverging": [ + [ + 0, + "#8e0152" + ], + [ + 0.1, + "#c51b7d" + ], + [ + 0.2, + "#de77ae" + ], + [ + 0.3, + "#f1b6da" + ], + [ + 0.4, + "#fde0ef" + ], + [ + 0.5, + "#f7f7f7" + ], + [ + 0.6, + "#e6f5d0" + ], + [ + 0.7, + "#b8e186" + ], + [ + 0.8, + "#7fbc41" + ], + [ + 0.9, + "#4d9221" + ], + [ + 1, + "#276419" + ] + ], + "sequential": [ + [ + 0, + "#0d0887" + ], + [ + 0.1111111111111111, + "#46039f" + ], + [ + 0.2222222222222222, + "#7201a8" + ], + [ + 0.3333333333333333, + "#9c179e" + ], + [ + 0.4444444444444444, + "#bd3786" + ], + [ + 0.5555555555555556, + "#d8576b" + ], + [ + 0.6666666666666666, + "#ed7953" + ], + [ + 0.7777777777777778, + "#fb9f3a" + ], + [ + 0.8888888888888888, + "#fdca26" + ], + [ + 1, + "#f0f921" + ] + ], + "sequentialminus": [ + [ + 0, + "#0d0887" + ], + [ + 0.1111111111111111, + "#46039f" + ], + [ + 0.2222222222222222, + "#7201a8" + ], + [ + 0.3333333333333333, + "#9c179e" + ], + [ + 0.4444444444444444, + "#bd3786" + ], + [ + 0.5555555555555556, + "#d8576b" + ], + [ + 0.6666666666666666, + "#ed7953" + ], + [ + 0.7777777777777778, + "#fb9f3a" + ], + [ + 0.8888888888888888, + "#fdca26" + ], + [ + 1, + "#f0f921" + ] + ] + }, + "colorway": [ + "#636efa", + "#EF553B", + "#00cc96", + "#ab63fa", + "#FFA15A", + "#19d3f3", + "#FF6692", + "#B6E880", + "#FF97FF", + "#FECB52" + ], + "font": { + "color": "#2a3f5f" + }, + "geo": { + "bgcolor": "white", + "lakecolor": "white", + "landcolor": "#E5ECF6", + "showlakes": true, + "showland": true, + "subunitcolor": "white" + }, + "hoverlabel": { + "align": "left" + }, + "hovermode": "closest", + "mapbox": { + "style": "light" + }, + "paper_bgcolor": "white", + "plot_bgcolor": "#E5ECF6", + "polar": { + "angularaxis": { + "gridcolor": "white", + "linecolor": "white", + "ticks": "" + }, + "bgcolor": "#E5ECF6", + "radialaxis": { + "gridcolor": "white", + "linecolor": "white", + "ticks": "" + } + }, + "scene": { + "xaxis": { + "backgroundcolor": "#E5ECF6", + "gridcolor": "white", + "gridwidth": 2, + "linecolor": "white", + "showbackground": true, + "ticks": "", + "zerolinecolor": "white" + }, + "yaxis": { + "backgroundcolor": "#E5ECF6", + "gridcolor": "white", + "gridwidth": 2, + "linecolor": "white", + "showbackground": true, + "ticks": "", + "zerolinecolor": "white" + }, + "zaxis": { + "backgroundcolor": "#E5ECF6", + "gridcolor": "white", + "gridwidth": 2, + "linecolor": "white", + "showbackground": true, + "ticks": "", + "zerolinecolor": "white" + } + }, + "shapedefaults": { + "line": { + "color": "#2a3f5f" + } + }, + "ternary": { + "aaxis": { + "gridcolor": "white", + "linecolor": "white", + "ticks": "" + }, + "baxis": { + "gridcolor": "white", + "linecolor": "white", + "ticks": "" + }, + "bgcolor": "#E5ECF6", + "caxis": { + "gridcolor": "white", + "linecolor": "white", + "ticks": "" + } + }, + "title": { + "x": 0.05 + }, + "xaxis": { + "automargin": true, + "gridcolor": "white", + "linecolor": "white", + "ticks": "", + "title": { + "standoff": 15 + }, + "zerolinecolor": "white", + "zerolinewidth": 2 + }, + "yaxis": { + "automargin": true, + "gridcolor": "white", + "linecolor": "white", + "ticks": "", + "title": { + "standoff": 15 + }, + "zerolinecolor": "white", + "zerolinewidth": 2 + } + } + }, + "width": 700 + } + }, + "text/html": [ + "
" + ] + }, + "metadata": {}, + "output_type": "display_data" + } + ], + "source": [ + "updated_sys.show.all()" + ] + }, + { + "cell_type": "code", + "execution_count": 6, + "id": "ae40fc70-d9d3-45e0-b316-94db37440204", + "metadata": {}, + "outputs": [], + "source": [ + "sys = System.create.element.Fe(graph=kg)" + ] + }, + { + "cell_type": "code", + "execution_count": 7, + "id": "e61053f1-d06d-4519-bbaa-e1b9b4d84d0d", + "metadata": {}, + "outputs": [], + "source": [ + "updated_sys = sys.add_interstitial_impurities(['H', 'C'], void_type='octahedral')" + ] + }, + { + "cell_type": "code", + "execution_count": 8, + "id": "64749f3f-2d4e-4498-a581-7552f5e45560", + "metadata": {}, + "outputs": [ + { + "data": { + "application/vnd.plotly.v1+json": { + "config": { + "plotlyServerURL": "https://plot.ly" + }, + "data": [ + { + "line": { + "color": "#263238", + "width": 2 + }, + "mode": "lines", + "name": "lines", + "showlegend": false, + "type": "scatter3d", + "x": [ + 0, + 2.87, + 2.87, + 0, + 0 + ], + "y": [ + 0, + 0, + 2.87, + 2.87, + 0 + ], + "z": [ + 0, + 0, + 0, + 0, + 0 + ] + }, + { + "line": { + "color": "#263238", + "width": 2 + }, + "mode": "lines", + "name": "lines", + "showlegend": false, + "type": "scatter3d", + "x": [ + 0, + 2.87, + 2.87, + 0, + 0 + ], + "y": [ + 0, + 0, + 2.87, + 2.87, + 0 + ], + "z": [ + 2.87, + 2.87, + 2.87, + 2.87, + 2.87 + ] + }, + { + "line": { + "color": "#263238", + "width": 2 + }, + "mode": "lines", + "name": "lines", + "showlegend": false, + "type": "scatter3d", + "x": [ + 0, + 2.87, + 2.87, + 0, + 0 + ], + "y": [ + 0, + 0, + 0, + 0, + 0 + ], + "z": [ + 0, + 0, + 2.87, + 2.87, + 0 + ] + }, + { + "line": { + "color": "#263238", + "width": 2 + }, + "mode": "lines", + "name": "lines", + "showlegend": false, + "type": "scatter3d", + "x": [ + 0, + 2.87, + 2.87, + 0, + 0 + ], + "y": [ + 2.87, + 2.87, + 2.87, + 2.87, + 2.87 + ], + "z": [ + 0, + 0, + 2.87, + 2.87, + 0 + ] + }, + { + "line": { + "color": "#263238", + "width": 2 + }, + "mode": "lines", + "name": "lines", + "showlegend": false, + "type": "scatter3d", + "x": [ + 0, + 0, + 0, + 0, + 0 + ], + "y": [ + 0, + 2.87, + 2.87, + 0, + 0 + ], + "z": [ + 0, + 0, + 2.87, + 2.87, + 0 + ] + }, + { + "line": { + "color": "#263238", + "width": 2 + }, + "mode": "lines", + "name": "lines", + "showlegend": false, + "type": "scatter3d", + "x": [ + 2.87, + 2.87, + 2.87, + 2.87, + 2.87 + ], + "y": [ + 0, + 2.87, + 2.87, + 0, + 0 + ], + "z": [ + 0, + 0, + 2.87, + 2.87, + 0 + ] + }, + { + "marker": { + "color": "#33a02c", + "line": { + "color": "#455A64", + "width": 0.5 + }, + "opacity": 1, + "size": 10, + "sizemode": "diameter", + "sizeref": 750 + }, + "mode": "markers", + "opacity": 1, + "type": "scatter3d", + "x": [ + 0, + 1.435 + ], + "y": [ + 0, + 1.435 + ], + "z": [ + 0, + 1.435 + ] + }, + { + "marker": { + "color": "#fb9a99", + "line": { + "color": "#455A64", + "width": 0.5 + }, + "opacity": 1, + "size": 10, + "sizemode": "diameter", + "sizeref": 750 + }, + "mode": "markers", + "opacity": 1, + "type": "scatter3d", + "x": [ + 1.4350000000000005 + ], + "y": [ + 0 + ], + "z": [ + 0 + ] + }, + { + "marker": { + "color": "#e31a1c", + "line": { + "color": "#455A64", + "width": 0.5 + }, + "opacity": 1, + "size": 10, + "sizemode": "diameter", + "sizeref": 750 + }, + "mode": "markers", + "opacity": 1, + "type": "scatter3d", + "x": [ + 1.435 + ], + "y": [ + 1.435 + ], + "z": [ + 4.440892098500626e-16 + ] + } + ], + "layout": { + "height": 360, + "margin": { + "b": 10, + "l": 10, + "r": 10, + "t": 10 + }, + "scene": { + "aspectmode": "data", + "aspectratio": { + "x": 1, + "y": 1, + "z": 1 + }, + "xaxis": { + "showbackground": false, + "showticklabels": false, + "title": { + "text": "" + }, + "type": "linear", + "zerolinecolor": "#455A64" + }, + "yaxis": { + "showbackground": false, + "showticklabels": false, + "title": { + "text": "" + }, + "type": "linear", + "zerolinecolor": "#455A64" + }, + "zaxis": { + "showbackground": false, + "showticklabels": false, + "title": { + "text": "" + }, + "type": "linear", + "zerolinecolor": "#455A64" + } + }, + "showlegend": false, + "template": { + "data": { + "bar": [ + { + "error_x": { + "color": "#2a3f5f" + }, + "error_y": { + "color": "#2a3f5f" + }, + "marker": { + "line": { + "color": "#E5ECF6", + "width": 0.5 + }, + "pattern": { + "fillmode": "overlay", + "size": 10, + "solidity": 0.2 + } + }, + "type": "bar" + } + ], + "barpolar": [ + { + "marker": { + "line": { + "color": "#E5ECF6", + "width": 0.5 + }, + "pattern": { + "fillmode": "overlay", + "size": 10, + "solidity": 0.2 + } + }, + "type": "barpolar" + } + ], + "carpet": [ + { + "aaxis": { + "endlinecolor": "#2a3f5f", + "gridcolor": "white", + "linecolor": "white", + "minorgridcolor": "white", + "startlinecolor": "#2a3f5f" + }, + "baxis": { + "endlinecolor": "#2a3f5f", + "gridcolor": "white", + "linecolor": "white", + "minorgridcolor": "white", + "startlinecolor": "#2a3f5f" + }, + "type": "carpet" + } + ], + "choropleth": [ + { + "colorbar": { + "outlinewidth": 0, + "ticks": "" + }, + "type": "choropleth" + } + ], + "contour": [ + { + "colorbar": { + "outlinewidth": 0, + "ticks": "" + }, + "colorscale": [ + [ + 0, + "#0d0887" + ], + [ + 0.1111111111111111, + "#46039f" + ], + [ + 0.2222222222222222, + "#7201a8" + ], + [ + 0.3333333333333333, + "#9c179e" + ], + [ + 0.4444444444444444, + "#bd3786" + ], + [ + 0.5555555555555556, + "#d8576b" + ], + [ + 0.6666666666666666, + "#ed7953" + ], + [ + 0.7777777777777778, + "#fb9f3a" + ], + [ + 0.8888888888888888, + "#fdca26" + ], + [ + 1, + "#f0f921" + ] + ], + "type": "contour" + } + ], + "contourcarpet": [ + { + "colorbar": { + "outlinewidth": 0, + "ticks": "" + }, + "type": "contourcarpet" + } + ], + "heatmap": [ + { + "colorbar": { + "outlinewidth": 0, + "ticks": "" + }, + "colorscale": [ + [ + 0, + "#0d0887" + ], + [ + 0.1111111111111111, + "#46039f" + ], + [ + 0.2222222222222222, + "#7201a8" + ], + [ + 0.3333333333333333, + "#9c179e" + ], + [ + 0.4444444444444444, + "#bd3786" + ], + [ + 0.5555555555555556, + "#d8576b" + ], + [ + 0.6666666666666666, + "#ed7953" + ], + [ + 0.7777777777777778, + "#fb9f3a" + ], + [ + 0.8888888888888888, + "#fdca26" + ], + [ + 1, + "#f0f921" + ] + ], + "type": "heatmap" + } + ], + "heatmapgl": [ + { + "colorbar": { + "outlinewidth": 0, + "ticks": "" + }, + "colorscale": [ + [ + 0, + "#0d0887" + ], + [ + 0.1111111111111111, + "#46039f" + ], + [ + 0.2222222222222222, + "#7201a8" + ], + [ + 0.3333333333333333, + "#9c179e" + ], + [ + 0.4444444444444444, + "#bd3786" + ], + [ + 0.5555555555555556, + "#d8576b" + ], + [ + 0.6666666666666666, + "#ed7953" + ], + [ + 0.7777777777777778, + "#fb9f3a" + ], + [ + 0.8888888888888888, + "#fdca26" + ], + [ + 1, + "#f0f921" + ] + ], + "type": "heatmapgl" + } + ], + "histogram": [ + { + "marker": { + "pattern": { + "fillmode": "overlay", + "size": 10, + "solidity": 0.2 + } + }, + "type": "histogram" + } + ], + "histogram2d": [ + { + "colorbar": { + "outlinewidth": 0, + "ticks": "" + }, + "colorscale": [ + [ + 0, + "#0d0887" + ], + [ + 0.1111111111111111, + "#46039f" + ], + [ + 0.2222222222222222, + "#7201a8" + ], + [ + 0.3333333333333333, + "#9c179e" + ], + [ + 0.4444444444444444, + "#bd3786" + ], + [ + 0.5555555555555556, + "#d8576b" + ], + [ + 0.6666666666666666, + "#ed7953" + ], + [ + 0.7777777777777778, + "#fb9f3a" + ], + [ + 0.8888888888888888, + "#fdca26" + ], + [ + 1, + "#f0f921" + ] + ], + "type": "histogram2d" + } + ], + "histogram2dcontour": [ + { + "colorbar": { + "outlinewidth": 0, + "ticks": "" + }, + "colorscale": [ + [ + 0, + "#0d0887" + ], + [ + 0.1111111111111111, + "#46039f" + ], + [ + 0.2222222222222222, + "#7201a8" + ], + [ + 0.3333333333333333, + "#9c179e" + ], + [ + 0.4444444444444444, + "#bd3786" + ], + [ + 0.5555555555555556, + "#d8576b" + ], + [ + 0.6666666666666666, + "#ed7953" + ], + [ + 0.7777777777777778, + "#fb9f3a" + ], + [ + 0.8888888888888888, + "#fdca26" + ], + [ + 1, + "#f0f921" + ] + ], + "type": "histogram2dcontour" + } + ], + "mesh3d": [ + { + "colorbar": { + "outlinewidth": 0, + "ticks": "" + }, + "type": "mesh3d" + } + ], + "parcoords": [ + { + "line": { + "colorbar": { + "outlinewidth": 0, + "ticks": "" + } + }, + "type": "parcoords" + } + ], + "pie": [ + { + "automargin": true, + "type": "pie" + } + ], + "scatter": [ + { + "fillpattern": { + "fillmode": "overlay", + "size": 10, + "solidity": 0.2 + }, + "type": "scatter" + } + ], + "scatter3d": [ + { + "line": { + "colorbar": { + "outlinewidth": 0, + "ticks": "" + } + }, + "marker": { + "colorbar": { + "outlinewidth": 0, + "ticks": "" + } + }, + "type": "scatter3d" + } + ], + "scattercarpet": [ + { + "marker": { + "colorbar": { + "outlinewidth": 0, + "ticks": "" + } + }, + "type": "scattercarpet" + } + ], + "scattergeo": [ + { + "marker": { + "colorbar": { + "outlinewidth": 0, + "ticks": "" + } + }, + "type": "scattergeo" + } + ], + "scattergl": [ + { + "marker": { + "colorbar": { + "outlinewidth": 0, + "ticks": "" + } + }, + "type": "scattergl" + } + ], + "scattermapbox": [ + { + "marker": { + "colorbar": { + "outlinewidth": 0, + "ticks": "" + } + }, + "type": "scattermapbox" + } + ], + "scatterpolar": [ + { + "marker": { + "colorbar": { + "outlinewidth": 0, + "ticks": "" + } + }, + "type": "scatterpolar" + } + ], + "scatterpolargl": [ + { + "marker": { + "colorbar": { + "outlinewidth": 0, + "ticks": "" + } + }, + "type": "scatterpolargl" + } + ], + "scatterternary": [ + { + "marker": { + "colorbar": { + "outlinewidth": 0, + "ticks": "" + } + }, + "type": "scatterternary" + } + ], + "surface": [ + { + "colorbar": { + "outlinewidth": 0, + "ticks": "" + }, + "colorscale": [ + [ + 0, + "#0d0887" + ], + [ + 0.1111111111111111, + "#46039f" + ], + [ + 0.2222222222222222, + "#7201a8" + ], + [ + 0.3333333333333333, + "#9c179e" + ], + [ + 0.4444444444444444, + "#bd3786" + ], + [ + 0.5555555555555556, + "#d8576b" + ], + [ + 0.6666666666666666, + "#ed7953" + ], + [ + 0.7777777777777778, + "#fb9f3a" + ], + [ + 0.8888888888888888, + "#fdca26" + ], + [ + 1, + "#f0f921" + ] + ], + "type": "surface" + } + ], + "table": [ + { + "cells": { + "fill": { + "color": "#EBF0F8" + }, + "line": { + "color": "white" + } + }, + "header": { + "fill": { + "color": "#C8D4E3" + }, + "line": { + "color": "white" + } + }, + "type": "table" + } + ] + }, + "layout": { + "annotationdefaults": { + "arrowcolor": "#2a3f5f", + "arrowhead": 0, + "arrowwidth": 1 + }, + "autotypenumbers": "strict", + "coloraxis": { + "colorbar": { + "outlinewidth": 0, + "ticks": "" + } + }, + "colorscale": { + "diverging": [ + [ + 0, + "#8e0152" + ], + [ + 0.1, + "#c51b7d" + ], + [ + 0.2, + "#de77ae" + ], + [ + 0.3, + "#f1b6da" + ], + [ + 0.4, + "#fde0ef" + ], + [ + 0.5, + "#f7f7f7" + ], + [ + 0.6, + "#e6f5d0" + ], + [ + 0.7, + "#b8e186" + ], + [ + 0.8, + "#7fbc41" + ], + [ + 0.9, + "#4d9221" + ], + [ + 1, + "#276419" + ] + ], + "sequential": [ + [ + 0, + "#0d0887" + ], + [ + 0.1111111111111111, + "#46039f" + ], + [ + 0.2222222222222222, + "#7201a8" + ], + [ + 0.3333333333333333, + "#9c179e" + ], + [ + 0.4444444444444444, + "#bd3786" + ], + [ + 0.5555555555555556, + "#d8576b" + ], + [ + 0.6666666666666666, + "#ed7953" + ], + [ + 0.7777777777777778, + "#fb9f3a" + ], + [ + 0.8888888888888888, + "#fdca26" + ], + [ + 1, + "#f0f921" + ] + ], + "sequentialminus": [ + [ + 0, + "#0d0887" + ], + [ + 0.1111111111111111, + "#46039f" + ], + [ + 0.2222222222222222, + "#7201a8" + ], + [ + 0.3333333333333333, + "#9c179e" + ], + [ + 0.4444444444444444, + "#bd3786" + ], + [ + 0.5555555555555556, + "#d8576b" + ], + [ + 0.6666666666666666, + "#ed7953" + ], + [ + 0.7777777777777778, + "#fb9f3a" + ], + [ + 0.8888888888888888, + "#fdca26" + ], + [ + 1, + "#f0f921" + ] + ] + }, + "colorway": [ + "#636efa", + "#EF553B", + "#00cc96", + "#ab63fa", + "#FFA15A", + "#19d3f3", + "#FF6692", + "#B6E880", + "#FF97FF", + "#FECB52" + ], + "font": { + "color": "#2a3f5f" + }, + "geo": { + "bgcolor": "white", + "lakecolor": "white", + "landcolor": "#E5ECF6", + "showlakes": true, + "showland": true, + "subunitcolor": "white" + }, + "hoverlabel": { + "align": "left" + }, + "hovermode": "closest", + "mapbox": { + "style": "light" + }, + "paper_bgcolor": "white", + "plot_bgcolor": "#E5ECF6", + "polar": { + "angularaxis": { + "gridcolor": "white", + "linecolor": "white", + "ticks": "" + }, + "bgcolor": "#E5ECF6", + "radialaxis": { + "gridcolor": "white", + "linecolor": "white", + "ticks": "" + } + }, + "scene": { + "xaxis": { + "backgroundcolor": "#E5ECF6", + "gridcolor": "white", + "gridwidth": 2, + "linecolor": "white", + "showbackground": true, + "ticks": "", + "zerolinecolor": "white" + }, + "yaxis": { + "backgroundcolor": "#E5ECF6", + "gridcolor": "white", + "gridwidth": 2, + "linecolor": "white", + "showbackground": true, + "ticks": "", + "zerolinecolor": "white" + }, + "zaxis": { + "backgroundcolor": "#E5ECF6", + "gridcolor": "white", + "gridwidth": 2, + "linecolor": "white", + "showbackground": true, + "ticks": "", + "zerolinecolor": "white" + } + }, + "shapedefaults": { + "line": { + "color": "#2a3f5f" + } + }, + "ternary": { + "aaxis": { + "gridcolor": "white", + "linecolor": "white", + "ticks": "" + }, + "baxis": { + "gridcolor": "white", + "linecolor": "white", + "ticks": "" + }, + "bgcolor": "#E5ECF6", + "caxis": { + "gridcolor": "white", + "linecolor": "white", + "ticks": "" + } + }, + "title": { + "x": 0.05 + }, + "xaxis": { + "automargin": true, + "gridcolor": "white", + "linecolor": "white", + "ticks": "", + "title": { + "standoff": 15 + }, + "zerolinecolor": "white", + "zerolinewidth": 2 + }, + "yaxis": { + "automargin": true, + "gridcolor": "white", + "linecolor": "white", + "ticks": "", + "title": { + "standoff": 15 + }, + "zerolinecolor": "white", + "zerolinewidth": 2 + } + } + }, + "width": 700 + } + }, + "text/html": [ + "
" + ] + }, + "metadata": {}, + "output_type": "display_data" + } + ], + "source": [ + "updated_sys.show.all()" + ] + } + ], + "metadata": { + "kernelspec": { + "display_name": "Python 3 (ipykernel)", + "language": "python", + "name": "python3" + }, + "language_info": { + "codemirror_mode": { + "name": "ipython", + "version": 3 + }, + "file_extension": ".py", + "mimetype": "text/x-python", + "name": "python", + "nbconvert_exporter": "python", + "pygments_lexer": "ipython3", + "version": "3.11.8" + } + }, + "nbformat": 4, + "nbformat_minor": 5 +}