예제 #1
0
    def draw_faces(self, keys=None, colors=None):

        self.clear_faces()
        self.clear_facelabels()

        keys = keys or list(self.datastructure.faces())
        objects = [0] * len(keys)

        if colors is None:
            colors = {key: self.defaults['color.face'] for key in keys}

        for c, key in enumerate(keys):

            vertices = [
                self.datastructure.vertex_coordinates(i)
                for i in self.datastructure.face[key]
            ]
            faces = [list(range(len(self.datastructure.face[key])))]
            name = 'F{0}'.format(key)
            objects[c] = xdraw_mesh(vertices=vertices,
                                    layer=self.layer,
                                    faces=faces,
                                    color=colors[key],
                                    name=name)

        self.face_objects = objects
예제 #2
0
def update(dofs, network, tol, plot, Xt, ds):
    x1, z1, r1, x2, z2, r2 = dofs
    dx1 = ds * cos(r1)
    dx2 = ds * cos(r2)
    dz1 = ds * sin(r1)
    dz2 = ds * sin(r2)
    sp, ep = network.leaves()
    network.set_vertex_attributes(sp, {'x': x1, 'z': z1})
    network.set_vertex_attributes(ep, {'x': x2, 'z': z2})
    network.set_vertex_attributes(sp + 1, {'x': dx1 + x1, 'z': dz1 + z1})
    network.set_vertex_attributes(ep - 1, {'x': dx2 + x2, 'z': dz2 + z2})
    X, f, l = drx_numba(network=network, factor=1, tol=tol)
    if plot:
        ind = argmin(cdist(X, Xt), axis=1)
        vertices = vstack([X, Xt[ind, :]])
        n = X.shape[0]
        edges = [[i, i + n] for i in range(n)] + list(network.edges())
        xdraw_mesh(name='norms', vertices=vertices, edges=edges)
    return X
예제 #3
0
def weld_meshes_from_layer(layer_input, layer_output):
    """
    Grab meshes on an input layer and weld them onto an output layer.

    Parameters
    ----------
    layer_input : str
        Layer containing the Blender meshes to weld.
    layer_output : str
        Layer to plot single welded mesh.

    Returns
    -------
    None

    """

    print('Welding meshes on layer:{0}'.format(layer_input))

    S = Structure(path=' ')

    add_nodes_elements_from_layers(S,
                                   mesh_type='ShellElement',
                                   layers=layer_input)

    faces = []

    for element in S.elements.values():
        faces.append(element.nodes)

    try:
        clear_layer(layer_output)
    except:
        create_layer(layer_output)

    vertices = S.nodes_xyz()

    xdraw_mesh(name='welded_mesh',
               vertices=vertices,
               faces=faces,
               layer=layer_output)
예제 #4
0
def discretise_mesh(structure, mesh, layer, target, min_angle=15, factor=1):
    """
    Discretise a mesh from an input triangulated coarse mesh into small denser meshes.

    Parameters
    ----------
    structure : obj
        Structure object.
    mesh : obj
        The object of the Blender input mesh.
    layer : str
        Layer name to draw results.
    target : float
        Target length of each triangle.
    min_angle : float
        Minimum internal angle of triangles.
    factor : float
        Factor on the maximum area of each triangle.

    Returns
    -------
    None

    """

    blendermesh = BlenderMesh(mesh)
    vertices = list(blendermesh.get_vertices_coordinates().values())
    faces = list(blendermesh.get_faces_vertex_indices().values())

    try:

        points, tris = discretise_faces(vertices=vertices,
                                        faces=faces,
                                        target=target,
                                        min_angle=min_angle,
                                        factor=factor)

        for pts, tri in zip(points, tris):
            bmesh = xdraw_mesh(name='face',
                               vertices=pts,
                               faces=tri,
                               layer=layer)
            add_nodes_elements_from_bmesh(structure=structure,
                                          bmesh=bmesh,
                                          mesh_type='ShellElement')

    except:

        print('***** Error using MeshPy (Triangle) or drawing faces *****')
예제 #5
0
def plot_data(structure,
              step,
              field='um',
              layer=None,
              scale=1.0,
              radius=0.05,
              cbar=[None, None],
              iptype='mean',
              nodal='mean',
              mode='',
              cbar_size=1):
    """
    Plots analysis results on the deformed shape of the Structure.

    Parameters
    ----------
    structure : obj
        Structure object.
    step : str
        Name of the Step.
    field : str
        Field to plot, e.g. 'um', 'sxx', 'sm1'.
    layer : str
        Layer name for plotting.
    scale : float
        Scale on displacements for the deformed plot.
    radius : float
        Radius of the pipe visualisation meshes.
    cbar : list
        Minimum and maximum limits on the colorbar.
    iptype : str
        'mean', 'max' or 'min' of an element's integration point data.
    nodal : str
        'mean', 'max' or 'min' for nodal values.
    mode : int
        Mode or frequency number to plot, for modal, harmonic or buckling analysis.
    cbar_size : float
        Scale on the size of the colorbar.

    Returns
    -------
    None

    Notes
    -----
    - Pipe visualisation of line elements is not based on the element section.

    """

    if field in ['smaxp', 'smises']:
        nodal = 'max'
        iptype = 'max'

    elif field in ['sminp']:
        nodal = 'min'
        iptype = 'min'

    # Create and clear Blender layer

    if not layer:
        layer = '{0}-{1}{2}'.format(step, field, mode)

    try:
        clear_layer(layer)
    except:
        create_layer(layer)

    # Node and element data

    nodes = structure.nodes_xyz()
    elements = [
        structure.elements[i].nodes
        for i in sorted(structure.elements, key=int)
    ]
    nodal_data = structure.results[step]['nodal']
    nkeys = sorted(structure.nodes, key=int)

    ux = [nodal_data['ux{0}'.format(mode)][i] for i in nkeys]
    uy = [nodal_data['uy{0}'.format(mode)][i] for i in nkeys]
    uz = [nodal_data['uz{0}'.format(mode)][i] for i in nkeys]

    try:
        data = [nodal_data['{0}{1}'.format(field, mode)][i] for i in nkeys]
        dtype = 'nodal'

    except (Exception):
        data = structure.results[step]['element'][field]
        dtype = 'element'

    # Postprocess

    result = postprocess(nodes, elements, ux, uy, uz, data, dtype, scale, cbar,
                         1, iptype, nodal)

    try:
        toc, U, cnodes, fabs, fscaled, celements, eabs = result
        U = array(U)
        print('\n***** Data processed : {0} s *****'.format(toc))

    except:
        print(
            '\n***** Error encountered during data processing or plotting *****'
        )

    # Plot meshes

    npts = 8
    mesh_faces = []
    block_faces = [[0, 1, 2, 3], [4, 5, 6, 7], [0, 1, 5, 4], [1, 2, 6, 5],
                   [2, 3, 7, 6], [3, 0, 4, 7]]
    tet_faces = [[0, 2, 1], [1, 2, 3], [1, 3, 0], [0, 3, 2]]
    pipes = []
    mesh_add = []

    for element, nodes in enumerate(elements):

        n = len(nodes)

        if n == 2:

            u, v = nodes
            pipe = draw_cylinder(start=U[u],
                                 end=U[v],
                                 radius=radius,
                                 div=npts,
                                 layer=layer)
            pipes.append(pipe)

            if dtype == 'element':
                col1 = col2 = celements[element]

            elif dtype == 'nodal':
                col1 = cnodes[u]
                col2 = cnodes[v]

            try:
                blendermesh = BlenderMesh(object=pipe)
                blendermesh.set_vertices_colors(
                    {i: col1
                     for i in range(0, 2 * npts, 2)})
                blendermesh.set_vertices_colors(
                    {i: col2
                     for i in range(1, 2 * npts, 2)})
            except:
                pass

        elif n in [3, 4]:

            if structure.elements[element].__name__ in [
                    'ShellElement', 'MembraneElement'
            ]:
                mesh_faces.append(nodes)
            else:
                for face in tet_faces:
                    mesh_faces.append([nodes[i] for i in face])

        elif n == 8:

            for block in block_faces:
                mesh_faces.append([nodes[i] for i in block])

    if mesh_faces:

        bmesh = xdraw_mesh(name='bmesh',
                           vertices=U,
                           faces=mesh_faces,
                           layer=layer)
        blendermesh = BlenderMesh(bmesh)
        blendermesh.set_vertices_colors(
            {i: col
             for i, col in enumerate(cnodes)})
        mesh_add = [bmesh]

    # Plot colourbar

    xr, yr, _ = structure.node_bounds()
    yran = yr[1] - yr[0] if yr[1] - yr[0] else 1
    s = yran * 0.1 * cbar_size
    xmin = xr[1] + 3 * s
    ymin = yr[0]

    cmesh = draw_plane(name='colorbar',
                       Lx=s,
                       dx=s,
                       Ly=10 * s,
                       dy=s,
                       layer=layer)
    set_objects_coordinates(objects=[cmesh], coords=[[xmin, ymin, 0]])
    blendermesh = BlenderMesh(object=cmesh)
    vertices = blendermesh.get_vertices_coordinates().values()

    y = array(list(vertices))[:, 1]
    yn = yran * cbar_size
    colors = colorbar(((y - ymin - 0.5 * yn) * 2 / yn)[:, newaxis],
                      input='array',
                      type=1)
    blendermesh.set_vertices_colors(
        {i: j
         for i, j in zip(range(len(vertices)), colors)})

    set_deselect()
    set_select(objects=pipes + mesh_add + [cmesh])
    bpy.context.view_layer.objects.active = cmesh
    bpy.ops.object.join()

    h = 0.6 * s

    for i in range(5):

        x0 = xmin + 1.2 * s
        yu = ymin + (5.8 + i) * s
        yl = ymin + (3.8 - i) * s
        vu = +max([eabs, fabs]) * (i + 1) / 5.
        vl = -max([eabs, fabs]) * (i + 1) / 5.

        draw_text(radius=h,
                  pos=[x0, yu, 0],
                  text='{0:.3g}'.format(vu),
                  layer=layer)
        draw_text(radius=h,
                  pos=[x0, yl, 0],
                  text='{0:.3g}'.format(vl),
                  layer=layer)

    draw_text(radius=h, pos=[x0, ymin + 4.8 * s, 0], text='0', layer=layer)
    draw_text(radius=h,
              pos=[xmin, ymin + 12 * s, 0],
              text='Step:{0}   Field:{1}'.format(step, field),
              layer=layer)
예제 #6
0
def add_tets_from_mesh(structure,
                       name,
                       mesh,
                       draw_tets=False,
                       volume=None,
                       thermal=False):
    """
    Adds tetrahedron elements from a mesh to the Structure object.

    Parameters
    ----------
    structure : obj
        Structure object to update.
    name : str
        Name for the element set of tetrahedrons.
    mesh : obj
        The Blender mesh representing the outer surface.
    draw_tets : bool
        Layer to draw tetrahedrons on.
    volume : float
        Maximum volume for tets.
    thermal : bool
        Thermal properties on or off.

    Returns
    -------
    None

    """

    blendermesh = BlenderMesh(mesh)
    vertices = blendermesh.get_vertices_coordinates().values()
    faces = blendermesh.get_faces_vertex_indices().values()

    try:

        tets_points, tets_elements = tets_from_vertices_faces(
            vertices=vertices, faces=faces, volume=volume)

        for point in tets_points:
            structure.add_node(point)

        ekeys = []

        for element in tets_elements:

            nodes = [
                structure.check_node_exists(tets_points[i]) for i in element
            ]
            ekey = structure.add_element(nodes=nodes,
                                         type='TetrahedronElement',
                                         thermal=thermal)
            ekeys.append(ekey)

        structure.add_set(name=name, type='element', selection=ekeys)

        if draw_tets:

            tet_faces = [[0, 1, 2], [1, 3, 2], [1, 3, 0], [0, 2, 3]]

            for i, points in enumerate(tets_elements):

                xyz = [tets_points[j] for j in points]
                xdraw_mesh(name=str(i),
                           vertices=xyz,
                           faces=tet_faces,
                           layer=draw_tets)

        print('***** MeshPy (TetGen) successfull *****')

    except:

        print('***** Error using MeshPy (TetGen) or drawing Tets *****')
예제 #7
0
        # Step

        xv_all[n, :3] += dt * xv_all[n, 3:]
        xv_all[n, 3] += dt * Fx / rocket_mass
        xv_all[n, 4] += dt * Fy / rocket_mass
        xv_all[n, 5] += dt * Fz / rocket_mass

    return xv_all


# Loop

xv_all = vstack([xv_planets, xv_rocket])

for i in range(duration // day):

    # Update day

    xv_all = simulation(n, x_sun, xv_all, k, dt, planets_mass, rocket_mass,
                        day, m, p)

    # Plot

    if i % refresh == 0:
        locations = [list(loc) for loc in list(xv_all[:, :3] / giga)]
        set_objects_location(objects=planets, locations=locations[:8])
        set_objects_location(objects=[rocket], locations=[locations[8]])
        mesh = xdraw_mesh(name='path', vertices=[locations[8]])
        bpy.ops.wm.redraw_timer(type='DRAW_WIN_SWAP', iterations=1)
예제 #8
0
__license__ = 'MIT License'
__email__ = '*****@*****.**'

clear_layer(layer=1)

# Structure

mdl = Structure(name='mesh_tris', path='/home/al/temp/')

# Discretise

blendermesh = BlenderMesh(get_objects(layer=0)[0])
pts = blendermesh.get_vertex_coordinates()
fcs = blendermesh.get_face_vertex_indices()

vertices, faces = functions.discretise_faces(vertices=pts,
                                             faces=fcs,
                                             target=0.1,
                                             min_angle=15,
                                             factor=1,
                                             iterations=50)
for pts, fc in zip(vertices, faces):
    bmesh = xdraw_mesh(name='face', vertices=pts, faces=fc, layer=1, wire=True)
    blender.add_nodes_elements_from_bmesh(mdl,
                                          bmesh=bmesh,
                                          mesh_type='ShellElement')

# Summary

mdl.summary()
예제 #9
0
# Structure

mdl = Structure(name='beam_simple', path='/home/al/temp/')

# Clear

clear_layers(layers=[0, 1, 2, 3])

# Lines

L = 1.0
m = 100
x = [i * L / m for i in range(m + 1)]
vertices = [[xi, 0, 0] for xi in x]
edges = [[i, i + 1] for i in range(m)]
bmesh = xdraw_mesh(name='beam', vertices=vertices, edges=edges, layer=0)

# Points

n = 5
xdraw_spheres([{'pos': [0, 0, 0], 'layer': 1, 'radius': 0.01},
               {'pos': [L, 0, 0], 'layer': 2, 'radius': 0.01}])
xdraw_spheres([{'pos': [i, 0, 0], 'layer': 3, 'radius': 0.005} for i in x[n::n]])

# Elements

network = network_from_bmesh(bmesh=bmesh)
mdl.add_nodes_elements_from_network(network=network, element_type='BeamElement', 
                                    elset='elset_lines', axes={'ex': [0, -1, 0]})

# Sets
예제 #10
0
def plot_data(structure,
              step,
              field,
              layer,
              scale=1.0,
              radius=0.05,
              cbar=[None, None],
              iptype='mean',
              nodal='mean',
              mode='',
              colorbar_size=1):
    """ Plots analysis results on the deformed shape of the Structure.

    Parameters
    ----------
    structure : obj
        Structure object.
    step : str
        Name of the Step.
    field : str
        Field to plot, e.g. 'um', 'sxx', 'sm1'.
    layer : int
        Layer number for plotting.
    scale : float
        Scale on displacements for the deformed plot.
    radius : float
        Radius of the pipe visualisation meshes.
    cbar : list
        Minimum and maximum limits on the colorbar.
    iptype : str
        'mean', 'max' or 'min' of an element's integration point data.
    nodal : str
        'mean', 'max' or 'min' for nodal values.
    mode : int
        Mode or frequency number to plot, for modal, harmonic or buckling analysis.
    colorbar_size : float
        Scale on the size of the colorbar.

    Returns
    -------
    None

    Notes
    -----
    - Pipe visualisation of line elements is not based on the element section.

    """

    clear_layer(layer=layer)

    # Node and element data

    nodes = structure.nodes_xyz()
    elements = [
        structure.elements[i].nodes
        for i in sorted(structure.elements, key=int)
    ]
    nodal_data = structure.results[step]['nodal']
    nkeys = sorted(structure.nodes, key=int)
    ux = [nodal_data['ux{0}'.format(mode)][i] for i in nkeys]
    uy = [nodal_data['uy{0}'.format(mode)][i] for i in nkeys]
    uz = [nodal_data['uz{0}'.format(mode)][i] for i in nkeys]

    try:
        data = [nodal_data['{0}{1}'.format(field, mode)][i] for i in nkeys]
        dtype = 'nodal'
    except (Exception):
        data = structure.results[step]['element'][field]
        dtype = 'element'

    # Postprocess

    result = postprocess(nodes, elements, ux, uy, uz, data, dtype, scale, cbar,
                         1, iptype, nodal)

    try:
        toc, U, cnodes, fabs, fscaled, celements, eabs = result
        U = array(U)
        print('\n***** Data processed : {0:.3f} s *****'.format(toc))

    except:
        print(
            '\n***** Error encountered during data processing or plotting *****'
        )

    # Plot meshes

    npts = 8
    mesh_faces = []

    for element, nodes in enumerate(elements):
        n = len(nodes)

        if n == 2:
            u, v = nodes
            pipe = draw_pipes(start=[U[u]],
                              end=[U[v]],
                              radius=radius,
                              layer=layer)[0]
            if dtype == 'element':
                col1 = col2 = [celements[element]] * npts
            elif dtype == 'nodal':
                col1 = [cnodes[u]] * npts
                col2 = [cnodes[v]] * npts
            blendermesh = BlenderMesh(pipe)
            blendermesh.set_vertex_colors(vertices=range(0, 2 * npts, 2),
                                          colors=col1)
            blendermesh.set_vertex_colors(vertices=range(1, 2 * npts, 2),
                                          colors=col2)

        elif n in [3, 4]:
            mesh_faces.append(nodes)

    if mesh_faces:
        bmesh = xdraw_mesh(name='bmesh',
                           vertices=U,
                           faces=mesh_faces,
                           layer=layer)
        blendermesh = BlenderMesh(bmesh)
        blendermesh.set_vertex_colors(vertices=range(U.shape[0]),
                                      colors=cnodes)

    # Plot colourbar

    xr, yr, _ = structure.node_bounds()
    yran = yr[1] - yr[0] if yr[1] - yr[0] else 1
    s = yran * 0.1 * colorbar_size
    xmin = xr[1] + 3 * s
    ymin = yr[0]

    cmesh = draw_plane(name='colorbar',
                       Lx=s,
                       dx=s,
                       Ly=10 * s,
                       dy=s,
                       layer=layer)
    set_object_location(object=cmesh, location=[xmin, ymin, 0])
    blendermesh = BlenderMesh(cmesh)
    verts = blendermesh.get_vertex_coordinates()

    y = array(verts)[:, 1]
    yn = yran * colorbar_size
    colors = colorbar(((y - ymin - 0.5 * yn) * 2 / yn)[:, newaxis],
                      input='array',
                      type=1)
    blendermesh.set_vertex_colors(vertices=range(len(verts)), colors=colors)

    h = 0.6 * s
    texts = []
    for i in range(5):
        x0 = xmin + 1.2 * s
        yu = ymin + (5.8 + i) * s
        yl = ymin + (3.8 - i) * s
        vu = float(+max(eabs, fabs) * (i + 1) / 5.)
        vl = float(-max(eabs, fabs) * (i + 1) / 5.)
        texts.extend([{
            'radius': h,
            'pos': [x0, yu, 0],
            'text': '{0:.3g}'.format(vu),
            'layer': layer
        }, {
            'radius': h,
            'pos': [x0, yl, 0],
            'text': '{0:.3g}'.format(vl),
            'layer': layer
        }])
    texts.extend([{
        'radius': h,
        'pos': [x0, ymin + 4.8 * s, 0],
        'text': '0',
        'layer': layer
    }, {
        'radius': h,
        'pos': [xmin, ymin + 12 * s, 0],
        'text': 'Step:{0}   Field:{1}'.format(step, field),
        'layer': layer
    }])

    xdraw_texts(texts)
예제 #11
0
def add_tets_from_bmesh(structure,
                        name,
                        bmesh,
                        draw_tets=False,
                        volume=None,
                        layer=19,
                        acoustic=False,
                        thermal=False):
    """ Adds tetrahedron elements from a Blender mesh to the Structure object.

    Parameters
    ----------
    structure : obj
        Structure object to update.
    name : str
        Name for the element set of tetrahedrons.
    bmesh : obj
        The Blender mesh representing the outer surface.
    draw_tets : bool
        Draw the generated tetrahedrons.
    volume : float
        Maximum volume for tets.
    layer : int
        Layer to draw tetrahedrons if draw_tets=True.
    acoustic : bool
        Acoustic properties on or off.
    thermal : bool
        Thermal properties on or off.

    Returns
    -------
    None

    """

    blendermesh = BlenderMesh(bmesh)
    vertices = blendermesh.get_vertex_coordinates()
    faces = blendermesh.get_face_vertex_indices()

    tets_points, tets_elements = tets_from_vertices_faces(vertices=vertices,
                                                          faces=faces,
                                                          volume=volume)

    for point in tets_points:
        structure.add_node(point)

    ekeys = []
    for element in tets_elements:
        nodes = [structure.check_node_exists(tets_points[i]) for i in element]
        ekey = structure.add_element(nodes=nodes,
                                     type='TetrahedronElement',
                                     acoustic=acoustic,
                                     thermal=thermal)
        ekeys.append(ekey)
    structure.add_set(name=name, type='element', selection=ekeys)

    if draw_tets:
        tet_faces = [[0, 1, 2], [1, 3, 2], [1, 3, 0], [0, 2, 3]]
        for i, points in enumerate(tets_elements):
            xyz = [tets_points[j] for j in points]
            xdraw_mesh(name=str(i), vertices=xyz, faces=tet_faces, layer=layer)