Coordinates of Gauss points

Hello,

Is it possible to obtain the coordinates of the Gauss points for each subspace?


from fenics import *
from fenics_adjoint import *
import ufl
from mshr import *
import matplotlib.pyplot as plt
import numpy as np
%matplotlib notebook

Length = 1.  
Radius = 0.1 
mesh_density = 50

domain = Rectangle(Point(0., 0.), Point(Length, Length))
mesh   = generate_mesh(domain, mesh_density)
dimens = mesh.geometry().dim() 

Vue = VectorElement('CG', mesh.ufl_cell(), 2) # displacement finite element
Vte = FiniteElement('CG', mesh.ufl_cell(), 1) # temperature finite element
V   = FunctionSpace(mesh, MixedElement([Vue, Vte]))

coord_all = V.tabulate_dof_coordinates()
V.sub(0).collapse().tabulate_dof_coordinates()
V.sub(1).collapse().tabulate_dof_coordinates()

Also, after solving the problem, I like to evaluate the temperature at the Gauss points. Is that possible?

It seems that it can be done using the following:

    el_u  = FiniteElement("Quadrature", mesh.ufl_cell(),  degree=2, quad_scheme="default")
    el_T  = FiniteElement("Quadrature", mesh.ufl_cell(),  degree=1, quad_scheme="default")
    V_g_u = FunctionSpace(mesh, el_u)
    V_g_T = FunctionSpace(mesh, el_T)
    coord_g_u = V_g_u.tabulate_dof_coordinates()
    coord_g_T = V_g_T.tabulate_dof_coordinates()